diff --git a/.dockerignore b/.dockerignore new file mode 100644 index 0000000..cd78447 --- /dev/null +++ b/.dockerignore @@ -0,0 +1 @@ +temp/ \ No newline at end of file diff --git a/.gitignore b/.gitignore new file mode 100644 index 0000000..cd78447 --- /dev/null +++ b/.gitignore @@ -0,0 +1 @@ +temp/ \ No newline at end of file diff --git a/Dockerfile b/Dockerfile index d592a48..0a2f71b 100644 --- a/Dockerfile +++ b/Dockerfile @@ -64,12 +64,11 @@ ENV PATH="/usr/midas/MIDAS-1.3.2/scripts:${PATH}" # Add the run script to the PATH ADD run.py /usr/midas -ADD helpers /usr/midas/helpers +ADD lib /usr/midas/lib RUN cd /usr/midas && \ chmod +x run.py && \ ln -s /usr/midas/run.py /usr/bin/ - # Run tests and then remove the folder ADD tests /usr/midas/tests RUN bats /usr/midas/tests/ && rm -r /usr/midas/tests/ diff --git a/helpers/__init__.py b/__init__.py similarity index 100% rename from helpers/__init__.py rename to __init__.py diff --git a/helpers/fastq_utils.py b/helpers/fastq_utils.py deleted file mode 100644 index 6604591..0000000 --- a/helpers/fastq_utils.py +++ /dev/null @@ -1,90 +0,0 @@ -#!/usr/bin/python - -import gzip -import logging -from Bio.SeqIO.QualityIO import FastqGeneralIterator -from Bio.SeqIO.FastaIO import SimpleFastaParser - - -def count_fasta_reads(fp): - n = 0 - if fp.endswith(".gz"): - with gzip.open(fp, "rt") as f: - for record in SimpleFastaParser(f): - n += 1 - else: - with open(fp, "rt") as f: - for record in SimpleFastaParser(f): - n += 1 - - return n - - -def count_fastq_reads(fp): - n = 0 - if fp.endswith(".gz"): - with gzip.open(fp, "rt") as f: - for record in FastqGeneralIterator(f): - n += 1 - else: - with open(fp, "rt") as f: - for record in FastqGeneralIterator(f): - n += 1 - - # If no reads were found, try counting it as a FASTA - if n == 0: - logging.info("No FASTQ reads found, trying to read as FASTA") - n = count_fasta_reads(fp) - - return n - - -def clean_fastq_headers(fp_in, fp_out): - """Read in a FASTQ file and write out a copy with unique headers.""" - - # Constraints - # 1. Headers start with '@' - # 2. Headers are stripped to the first whitespace - # 3. Headers are unique - # 4. Sequence lines are not empty - # 5. Spacer lines match the header line - # 6. Quality lines are not empty - - with open(fp_in, "rt") as f_in: - with open(fp_out, "wt") as f_out: - # Keep track of the line number - for ix, line in enumerate(f_in): - # Get the line position 0-3 - mod = ix % 4 - - if mod == 0: - # Skip lines that are blank (at the end of the file) - if len(line) == 1: - continue - # 1. Headers start with '@' - assert line[0] == '@', "Header lacks '@' ({})".format(line) - - # 2. Strip to the first whitespace - line = line.rstrip("\n").split(" ")[0].split("\t")[0] - - # 3. Add a unique line number and the newline - line = "{}-r{}\n".format(line, 1 + (ix / 4)) - - # Save the header to use for the spacer line - header = line[1:] - - elif mod == 1: - # 4. Sequence lines are not empty - assert len(line) > 1 - - elif mod == 2: - # 5. Spacer lines start with '+' and match the header - assert line[0] == "+" - line = "+" + header - - elif mod == 3: - # 6. Quality lines are not empty - assert len(line) > 1 - - # Write out the line - f_out.write(line) diff --git a/lib/__init__.py b/lib/__init__.py new file mode 100644 index 0000000..e69de29 diff --git a/lib/exec_helpers.py b/lib/exec_helpers.py new file mode 100644 index 0000000..2bc9694 --- /dev/null +++ b/lib/exec_helpers.py @@ -0,0 +1,130 @@ +#!/usr/bin/python +"""Functions to help with execution of system commands.""" + +import os +import sys +import json +import shutil +import logging +import traceback +import subprocess + + +def align_reads(read_fp, # FASTQ file path + db_fp, # Local path to DB + temp_folder, # Folder for results + evalue=0.0001, + query_gencode=11, + threads=1): + """Align a set of reads with Paladin.""" + pass + + +def run_cmds(commands, retry=0, catchExcept=False): + """Run commands and write out the log, combining STDOUT & STDERR.""" + logging.info("Commands:") + logging.info(' '.join(commands)) + p = subprocess.Popen(commands, + stdout=subprocess.PIPE, + stderr=subprocess.STDOUT) + stdout, stderr = p.communicate() + exitcode = p.wait() + if stdout: + logging.info("Standard output of subprocess:") + for line in stdout.split('\n'): + logging.info(line) + if stderr: + logging.info("Standard error of subprocess:") + for line in stderr.split('\n'): + logging.info(line) + + # Check the exit code + if exitcode != 0 and retry > 0: + msg = "Exit code {}, retrying {} more times".format(exitcode, retry) + logging.info(msg) + run_cmds(commands, retry=retry - 1) + elif exitcode != 0 and catchExcept: + msg = "Exit code was {}, but we will continue anyway" + logging.info(msg.format(exitcode)) + else: + assert exitcode == 0, "Exit code {}".format(exitcode) + + +def get_reference_database(ref_db, temp_folder): + """Get a reference database folder.""" + + # Get files from AWS S3 + if ref_db.startswith('s3://'): + logging.info("Getting reference database from S3: " + ref_db) + + # Save the database to the local temp folder + local_fp = os.path.join(temp_folder, ref_db.split('/')[-1] + "/") + + assert os.path.exists(local_fp) is False + + logging.info("Saving database to " + local_fp) + run_cmds([ + 'aws', + 's3', + 'sync', + '--quiet', + '--sse', + 'AES256', + ref_db, + local_fp + ]) + + return local_fp + + else: + # Treat the input as a local path + logging.info("Getting reference database from local path: " + ref_db) + assert os.path.exists(ref_db) + + return ref_db + + +def return_results(out, read_prefix, output_folder, temp_folder): + """Write out the final results as a JSON object.""" + # Make a temporary file + temp_fp = os.path.join(temp_folder, read_prefix + '.json') + with open(temp_fp, 'wt') as fo: + json.dump(out, fo) + + # Compress the output + run_cmds(['gzip', temp_fp]) + temp_fp = temp_fp + '.gz' + + if output_folder.startswith('s3://'): + # Copy to S3 + run_cmds([ + 'aws', + 's3', + 'cp', + '--quiet', + '--sse', + 'AES256', + temp_fp, + output_folder]) + os.unlink(temp_fp) + else: + # Copy to local folder + run_cmds(['mv', temp_fp, output_folder]) + + +def exit_and_clean_up(temp_folder): + """Log the error messages and delete the temporary folder.""" + # Capture the traceback + logging.info("There was an unexpected failure") + exc_type, exc_value, exc_traceback = sys.exc_info() + for line in traceback.format_tb(exc_traceback): + logging.info(line) + + # Delete any files that were created for this sample + logging.info("Removing temporary folder: " + temp_folder) + shutil.rmtree(temp_folder) + + # Exit + logging.info("Exit type: {}".format(exc_type)) + logging.info("Exit code: {}".format(exc_value)) + sys.exit(exc_value) diff --git a/lib/fastq_helpers.py b/lib/fastq_helpers.py new file mode 100644 index 0000000..cd8d9b5 --- /dev/null +++ b/lib/fastq_helpers.py @@ -0,0 +1,206 @@ +#!/usr/bin/python +"""Functions to help working with FASTQ files.""" + +import os +import gzip +import uuid +import logging +import subprocess +from Bio.SeqIO.QualityIO import FastqGeneralIterator +from Bio.SeqIO.FastaIO import SimpleFastaParser +from lib.exec_helpers import run_cmds + + +def get_reads_from_url(input_str, temp_folder, random_string=uuid.uuid4()): + """Get a set of reads from a URL -- return the downloaded filepath.""" + logging.info("Getting reads from {}".format(input_str)) + + filename = input_str.split('/')[-1] + local_path = os.path.join(temp_folder, filename) + + logging.info("Filename: " + filename) + logging.info("Local path: " + local_path) + + if not input_str.startswith(('s3://', 'sra://', 'ftp://')): + logging.info("Treating as local path") + msg = "Input file does not exist ({})".format(input_str) + assert os.path.exists(input_str), msg + logging.info("Copying to temporary folder, cleaning up headers") + + # Add a random string to the filename + local_path = local_path.split('/') + if local_path[-1].endswith(".gz"): + local_path[-1] = local_path[-1].replace(".gz", "") + local_path[-1] = "{}-{}".format(random_string, local_path[-1]) + local_path = '/'.join(local_path) + + # Make the FASTQ headers unique + clean_fastq_headers(input_str, local_path) + + return local_path + + # Get files from AWS S3 + if input_str.startswith('s3://'): + logging.info("Getting reads from S3") + run_cmds([ + 'aws', 's3', 'cp', '--quiet', '--sse', + 'AES256', input_str, temp_folder + ]) + + # Get files from an FTP server + elif input_str.startswith('ftp://'): + logging.info("Getting reads from FTP") + run_cmds(['wget', '-P', temp_folder, input_str]) + + # Get files from SRA + elif input_str.startswith('sra://'): + accession = filename + logging.info("Getting reads from SRA: " + accession) + local_path = get_sra(accession, temp_folder) + + else: + raise Exception("Did not recognize prefix for input: " + input_str) + + # Add a random string to the filename + new_path = local_path.split('/') + if new_path[-1].endswith(".gz"): + new_path[-1] = new_path[-1].replace(".gz", "") + new_path[-1] = "{}-{}".format(random_string, new_path[-1]) + new_path = '/'.join(new_path) + logging.info( + "Copying {} to {}, cleaning up FASTQ headers".format( + local_path, new_path + ) + ) + clean_fastq_headers(local_path, new_path) + logging.info("Deleting old file: {}".format(local_path)) + os.unlink(local_path) + return new_path + + +def get_sra(accession, temp_folder): + """Get the FASTQ for an SRA accession.""" + local_path = os.path.join(temp_folder, accession + ".fastq") + + logging.info("Downloading {} from SRA".format(accession)) + run_cmds([ + "fastq-dump", + "--split-files", + "--outdir", + temp_folder, accession + ]) + + # Combine any multiple files that were found + logging.info("Concatenating output files") + with open(local_path + ".temp", "wt") as fo: + cmd = "cat {}/{}*fastq".format(temp_folder, accession) + cat = subprocess.Popen(cmd, shell=True, stdout=fo) + cat.wait() + + # Clean up the FASTQ headers for the downloaded file + if os.path.exists(local_path + ".temp"): + run_cmds(["mv", local_path + ".temp", local_path]) + + # Check to see if the file was downloaded + msg = "File could not be downloaded from SRA: {}".format(accession) + assert os.path.exists(local_path), msg + + # Return the path to the file + logging.info("Done fetching " + accession) + return local_path + + +def count_fasta_reads(fp): + n = 0 + if fp.endswith(".gz"): + with gzip.open(fp, "rt") as f: + for record in SimpleFastaParser(f): + n += 1 + else: + with open(fp, "rt") as f: + for record in SimpleFastaParser(f): + n += 1 + + return n + + +def count_fastq_reads(fp): + n = 0 + if fp.endswith(".gz"): + with gzip.open(fp, "rt") as f: + for record in FastqGeneralIterator(f): + n += 1 + else: + with open(fp, "rt") as f: + for record in FastqGeneralIterator(f): + n += 1 + + # If no reads were found, try counting it as a FASTA + if n == 0: + logging.info("No FASTQ reads found, trying to read as FASTA") + n = count_fasta_reads(fp) + + return n + + +def clean_fastq_headers(fp_in, fp_out): + """Read in a FASTQ file and write out a copy with unique headers.""" + + # Constraints + # 1. Headers start with '@' + # 2. Headers are stripped to the first whitespace + # 3. Headers are unique + # 4. Sequence lines are not empty + # 5. Spacer lines match the header line + # 6. Quality lines are not empty + + if fp_in.endswith(".gz"): + f_in = gzip.open(fp_in, "rt") + else: + f_in = open(fp_in, "rt") + + if fp_out.endswith(".gz"): + f_out = gzip.open(fp_out, "wt") + else: + f_out = open(fp_out, "wt") + + # Keep track of the line number + for ix, line in enumerate(f_in): + # Get the line position 0-3 + mod = ix % 4 + + if mod == 0: + # Skip lines that are blank (at the end of the file) + if len(line) == 1: + continue + # 1. Headers start with '@' + assert line[0] == '@', "Header lacks '@' ({})".format(line) + + # 2. Strip to the first whitespace + line = line.rstrip("\n").split(" ")[0].split("\t")[0] + + # 3. Add a unique line number and the newline + line = "{}-r{}\n".format(line, 1 + (ix / 4)) + + # Save the header to use for the spacer line + header = line[1:] + + elif mod == 1: + # 4. Sequence lines are not empty + assert len(line) > 1 + + elif mod == 2: + # 5. Spacer lines start with '+' and match the header + assert line[0] == "+" + line = "+" + header + + elif mod == 3: + # 6. Quality lines are not empty + assert len(line) > 1 + + # Write out the line + f_out.write(line) + + # Close the input and output file handles + f_in.close() + f_out.close() diff --git a/lib/midas_helpers.py b/lib/midas_helpers.py new file mode 100644 index 0000000..d2bd44c --- /dev/null +++ b/lib/midas_helpers.py @@ -0,0 +1,218 @@ +#!/usr/bin/python + +import os +import gzip +import logging +from collections import defaultdict +from exec_helpers import run_cmds + + +def parse_table_to_json(fp, sep="\t", nrows=0): + """Parse a TSV into JSON format.""" + output = [] + + if fp.endswith(".gz"): + with gzip.open(fp, "rt") as f: + header = f.readline() + header = header.rstrip("\n").split(sep) + + f = gzip.open(fp, "rt") + else: + with open(fp, "rt") as f: + header = f.readline() + header = header.rstrip("\n").split(sep) + + f = open(fp, "rt") + + for ix, values in enumerate(f): + # Skip the header line + if ix == 0: + continue + if nrows > 0 and ix == nrows: + break + # Parse the line + values = values.rstrip("\n").split(sep) + # Add to the output + if len(values) == len(header): + output.append(set_variable_type(header, values)) + + f.close() + + return output + + +def set_variable_type( + header, + values, + types={ + "species_id": str, + "relative_abundance": float, + "count_reads": int, + "coverage": float, + "copy_number": float, + "pangenome_size": int, + "covered_genes": int, + "fraction_covered": float, + "mean_coverage": float, + "marker_coverage": float, + "aligned_reads": int, + "mapped_reads": int, + "covered_bases": int, + "genome_length": int, + "count_a": int, + "count_t": int, + "count_c": int, + "count_g": int, + "depth": int, + "ref_pos": int, + } +): + """Make a dict, but set the variable type as appropriate.""" + return { + k: types.get(k, str)(v) + for k, v in zip(header, values) + } + + +def run_midas( + read_fp, # FASTQ file path + db_fp, # Local path to DB + temp_folder, # Folder for results + threads=1 +): + logging.info("Running MIDAS on {}".format(read_fp)) + logging.info("Reference database: {}".format(db_fp)) + logging.info("Threads: {}".format(threads)) + + assert os.path.exists(read_fp) + + # Make the output folder in the temp folder, based on the read name + output_folder = os.path.join( + temp_folder, + "{}.midas".format(read_fp.split('/')[-1]) + ) + + # Run the species abundance summary + logging.info("Running species summary") + run_cmds([ + "run_midas.py", + "species", + output_folder, + "-1", read_fp, + "-t", str(threads), + "--remove_temp", + "-d", db_fp + ]) + assert os.path.exists( + os.path.join(output_folder, "species") + ) + + # Run the gene abundance summary + logging.info("Running gene summary") + run_cmds([ + "run_midas.py", + "genes", + output_folder, + "-1", read_fp, + "-t", str(threads), + "--remove_temp", + "-d", db_fp + ]) + assert os.path.exists( + os.path.join(output_folder, "genes") + ) + + logging.info("Done running MIDAS") + + return output_folder + + +def annotate_gene_results(gene_results, species_name, ref_db): + """Annotate a set of gene results.""" + pan_genome_file = os.path.join( + ref_db, "pan_genomes", species_name, "centroid_functions.txt.gz" + ) + + annotations = { + d["gene_id"]: defaultdict(list) + for d in gene_results + } + + if os.path.exists(pan_genome_file): + with gzip.open(pan_genome_file) as f: + for line in f: + line = line.rstrip("\n").split("\t") + if len(line) != 3: + continue + if line[0] in annotations: + annotations[line[0]][line[2]].append(line[1]) + + for d in gene_results: + d["annot"] = annotations[d["gene_id"]] + + return gene_results + + +def parse_midas_output(output_folder, ref_db=None): + """Parse the output from MIDAS.""" + + # Make sure the input exists + assert os.path.exists(output_folder) + + output = {} + + # Parse the species information + logging.info("Parsing the species abundance information") + species_fp = os.path.join(output_folder, "species", "species_profile.txt") + assert os.path.exists(species_fp) + output["species"] = parse_table_to_json(species_fp) + + # Filter down to the species with >0 reads + output["species"] = [d for d in output["species"] if d["count_reads"] > 0] + + # Read in the genes results, if present + genes_folder = os.path.join(output_folder, "genes") + if os.path.exists(genes_folder): + + output["genes"] = parse_table_to_json( + os.path.join(genes_folder, "summary.txt") + ) + + for species in output["genes"]: + species_details_fp = os.path.join( + genes_folder, + "output", + species["species_id"] + ".genes.gz" + ) + + if os.path.exists(species_details_fp): + logging.info( + "Parsing gene output for {}".format(species["species_id"]) + ) + + # Read in the genes that were detected + gene_results = parse_table_to_json( + os.path.join(species_details_fp) + ) + + # Filter to the genes with >0 count_reads + gene_results = [ + d + for d in gene_results + if d["count_reads"] > 0 + ] + + # Annotate the gene results with the gene functions + if ref_db is not None: + logging.info("Adding gene annotations") + gene_results = annotate_gene_results( + gene_results, + species["species_id"], + ref_db + ) + + species["genes"] = gene_results + else: + logging.info("No gene abundance information found") + + return output diff --git a/lib/test_parse_midas_output.py b/lib/test_parse_midas_output.py new file mode 100644 index 0000000..7dab98b --- /dev/null +++ b/lib/test_parse_midas_output.py @@ -0,0 +1,59 @@ +#!/usr/bin/python +"""Test the function to parse a set of inputs from MIDAS.""" + +import json +from midas_helpers import parse_midas_output + +out = parse_midas_output( + "/usr/midas/tests/example_output", + ref_db="/usr/midas/tests/example_output/ref_db" +) + +assert "genes" in out +assert "species" in out + +assert len(out["species"]) == 5 +assert json.dumps(out["species"]) == json.dumps([ + { + "species_id": "Salmonella_enterica_58156", + "count_reads": int(147), + "coverage": float(3.13765227021), + "relative_abundance": float(0.815123262907) + }, + + { + "species_id": "Salmonella_enterica_58266", + "count_reads": int(27), + "coverage": float(0.558183718058), + "relative_abundance": float(0.145009228041) + }, + + { + "species_id": "Salmonella_enterica_53987", + "count_reads": int(7), + "coverage": float(0.139110604333), + "relative_abundance": float(0.0361392149109) + }, + + { + "species_id": "Klebsiella_oxytoca_56762", + "count_reads": int(1), + "coverage": float(0.00539967216276), + "relative_abundance": float(0.00140276806124) + }, + + { + "species_id": "Xanthomonas_campestris_57487", + "count_reads": int(1), + "coverage": float(0.00895164267257), + "relative_abundance": float(0.00232552607978)} +]) + +assert len(out["genes"]) == 1 +assert out["genes"][0]["species_id"] == "Salmonella_enterica_58156" +assert len(out["genes"][0]["genes"]) == 22927 + +assert out["genes"][0]["genes"][0]["gene_id"] == "1003185.3.peg.1459" +assert out["genes"][0]["genes"][0]["annot"] == {"figfam": ["FIG00626808"]} + +print("Passed all tests") diff --git a/run.py b/run.py index fdb4689..b209245 100644 --- a/run.py +++ b/run.py @@ -1,343 +1,24 @@ #!/usr/bin/python -"""Analyze a set of reads with MIDAS, and save the results.""" +"""Wrapper script to run FAMLI on one or more FASTQ files.""" import os -import sys -import time -import json import uuid -import boto3 +import time import shutil import logging import argparse -import traceback -import subprocess -from helpers.fastq_utils import count_fastq_reads -from helpers.fastq_utils import clean_fastq_headers - - -def run_cmds(commands, retry=0, catchExcept=False): - """Run commands and write out the log, combining STDOUT & STDERR.""" - logging.info("Commands:") - logging.info(' '.join(commands)) - p = subprocess.Popen(commands, - stdout=subprocess.PIPE, - stderr=subprocess.STDOUT) - stdout, stderr = p.communicate() - exitcode = p.wait() - if stdout: - logging.info("Standard output of subprocess:") - for line in stdout.split('\n'): - logging.info(line) - if stderr: - logging.info("Standard error of subprocess:") - for line in stderr.split('\n'): - logging.info(line) - - # Check the exit code - if exitcode != 0 and retry > 0: - msg = "Exit code {}, retrying {} more times".format(exitcode, retry) - logging.info(msg) - run_cmds(commands, retry=retry - 1) - elif exitcode != 0 and catchExcept: - msg = "Exit code was {}, but we will continue anyway" - logging.info(msg.format(exitcode)) - else: - assert exitcode == 0, "Exit code {}".format(exitcode) - - -def midas(input_str, - db_fp, - db_url, - output_folder, - threads=16, - temp_folder='/mnt/temp', - random_string=uuid.uuid4(), - overwrite=False): - """Align a set of reads against a reference database.""" - - # Record the start time - start_time = time.time() - - # Use the read prefix to name the output and temporary files - read_prefix = input_str.split('/')[-1] - - # Define the location of temporary file used for DIAMOND output - blast_fp = os.path.join( - temp_folder, - '{}-{}.blast'.format(random_string, read_prefix)) - - # Make sure that the temporary file does not already exist - assert os.path.exists(blast_fp) is False, "Alignment file already exists" - - # Check to see if the output already exists, if so, skip this sample - output_fp = output_folder.rstrip('/') + '/' + read_prefix + '.json.gz' - if output_fp.startswith('s3://'): - # Check S3 - logging.info("Making sure that the output path doesn't already exist on S3") - bucket = output_fp[5:].split('/')[0] - prefix = '/'.join(output_fp[5:].split('/')[1:]) - client = boto3.client('s3') - results = client.list_objects(Bucket=bucket, Prefix=prefix) - if 'Contents' in results: - if overwrite: - logging.info("Overwriting output ({})".format(output_fp)) - else: - logging.info("Output already exists, skipping ({})".format(output_fp)) - return - else: - # Check local filesystem - if os.path.exists(output_fp): - if overwrite: - logging.info("Overwriting output ({})".format(output_fp)) - else: - logging.info("Output already exists, skipping ({})".format(output_fp)) - return - - # Get the reads - read_fp = get_reads_from_url( - input_str, - temp_folder, - random_string=random_string - ) - - # Align the reads against the reference database - logging.info("Aligning reads") - align_reads(read_fp, - db_fp, - blast_fp, - threads=threads, - evalue=evalue, - blocks=blocks, - query_gencode=query_gencode, - align_mode=align_mode) - - # Parse the alignment to get the abundance summary statistics - logging.info("Parsing the output") - parser = BlastParser(blast_fp, logging=logging) - parser.parse() - aligned_reads, abund_summary = parser.make_summary() - - # Count the total number of reads - logging.info("Counting the total number of reads") - n_reads = count_fastq_reads(read_fp) - logging.info("Reads in input file: {}".format(n_reads)) - - os.unlink(blast_fp) - os.unlink(read_fp) - - # Read in the logs - logging.info("Reading in the logs") - logs = open(log_fp, 'rt').readlines() - - # Make an object with all of the results - out = { - "input_path": input_str, - "input": read_prefix, - "output_folder": output_folder, - "logs": logs, - "ref_db": db_fp, - "ref_db_url": db_url, - "results": abund_summary, - "aligned_reads": aligned_reads, - "total_reads": n_reads, - "time_elapsed": time.time() - start_time - } - - # Write out the final results as a JSON object and write them to the output folder - return_results(out, read_prefix, output_folder, temp_folder) - - # Delete any temporary files that might be hanging around - for fp in os.listdir(temp_folder): - if fp.startswith(read_prefix): - if fp.endswith(".json.gz"): - continue - fp = os.path.join(temp_folder, fp) - logging.info("Removing temporary file: {}".format(fp)) - os.unlink(fp) - - -def get_sra(accession, temp_folder): - """Get the FASTQ for an SRA accession via ENA.""" - local_path = os.path.join(temp_folder, accession + ".fastq") - # Download from ENA via FTP - # See https://www.ebi.ac.uk/ena/browse/read-download for URL format - url = "ftp://ftp.sra.ebi.ac.uk/vol1/fastq" - folder1 = accession[:6] - url = "{}/{}".format(url, folder1) - if len(accession) > 9: - if len(accession) == 10: - folder2 = "00" + accession[-1] - elif len(accession) == 11: - folder2 = "0" + accession[-2:] - elif len(accession) == 12: - folder2 = accession[-3:] - else: - logging.info("This accession is too long: " + accession) - assert len(accession) <= 12 - url = "{}/{}".format(url, folder2) - # Add the accession to the URL - url = "{}/{}/{}".format(url, accession, accession) - logging.info("Base info for downloading from ENA: " + url) - # There are three possible file endings - file_endings = ["_1.fastq.gz", "_2.fastq.gz", ".fastq.gz"] - # Try to download each file - for end in file_endings: - run_cmds(["curl", - "-o", os.path.join(temp_folder, accession + end), - url + end], catchExcept=True) - # If none of those URLs downloaded, fall back to trying NCBI - if any([os.path.exists("{}/{}{}".format(temp_folder, accession, end)) - for end in file_endings]): - # Combine them all into a single file - logging.info("Combining into a single FASTQ file") - with open(local_path, "wt") as fo: - cmd = "gunzip -c {}/{}*fastq.gz".format(temp_folder, accession) - gunzip = subprocess.Popen(cmd, shell=True, stdout=fo) - gunzip.wait() - - # Clean up the temporary files - logging.info("Cleaning up temporary files") - for end in file_endings: - fp = "{}/{}{}".format(temp_folder, accession, end) - if os.path.exists(fp): - os.unlink(fp) - else: - logging.info("No files found on ENA, trying SRA") - run_cmds([ - "fastq-dump", - "--split-files", - "--outdir", - temp_folder, accession]) - - # Combine any multiple files that were found - with open(local_path + ".temp", "wt") as fo: - cmd = "cat {}/{}*fastq".format(temp_folder, accession) - cat = subprocess.Popen(cmd, shell=True, stdout=fo) - cat.wait() - - if os.path.exists(local_path + ".temp"): - run_cmds(["mv", local_path + ".temp", local_path]) - - # Check to see if the file was downloaded - msg = "File could not be downloaded from SRA: {}".format(accession) - assert os.path.exists(local_path), msg - - # Return the path to the file - logging.info("Done fetching " + accession) - return local_path - - -def get_reads_from_url(input_str, temp_folder, random_string=uuid.uuid4()): - """Get a set of reads from a URL -- return the downloaded filepath.""" - logging.info("Getting reads from {}".format(input_str)) - - filename = input_str.split('/')[-1] - local_path = os.path.join(temp_folder, filename) - - logging.info("Filename: " + filename) - logging.info("Local path: " + local_path) - - if not input_str.startswith(('s3://', 'sra://', 'ftp://')): - logging.info("Treating as local path") - msg = "Input file does not exist ({})".format(input_str) - assert os.path.exists(input_str), msg - logging.info("Copying to temporary folder, cleaning up headers") - - # Add a random string to the filename - local_path = local_path.split('/') - local_path[-1] = "{}-{}".format(random_string, local_path[-1]) - local_path = '/'.join(local_path) - - # Make the FASTQ headers unique - clean_fastq_headers(input_str, local_path) - - return local_path - - # Get files from AWS S3 - if input_str.startswith('s3://'): - logging.info("Getting reads from S3") - run_cmds([ - 'aws', 's3', 'cp', '--quiet', '--sse', - 'AES256', input_str, temp_folder - ]) - - # Get files from an FTP server - elif input_str.startswith('ftp://'): - logging.info("Getting reads from FTP") - run_cmds(['wget', '-P', temp_folder, input_str]) - - # Get files from SRA - elif input_str.startswith('sra://'): - accession = filename - logging.info("Getting reads from SRA: " + accession) - local_path = get_sra(accession, temp_folder) - - else: - raise Exception("Did not recognize prefix to fetch reads: " + input_str) - - # Add a random string to the filename - new_path = local_path.split('/') - new_path[-1] = "{}-{}".format(random_string, new_path[-1]) - new_path = '/'.join(new_path) - logging.info( - "Copying {} to {}, cleaning up FASTQ headers".format( - local_path, new_path - ) - ) - clean_fastq_headers(local_path, new_path) - logging.info("Deleting old file: {}".format(local_path)) - os.unlink(local_path) - return new_path - - -def get_reference_database(ref_db, temp_folder, random_string=uuid.uuid4()): - """Get a reference database.""" - - # Get files from AWS S3 - if ref_db.startswith('s3://'): - logging.info("Getting reference database from S3: " + ref_db) - - # Save the database to a local path with a random string prefix, to avoid collision - local_fp = os.path.join(temp_folder, "{}.{}".format(random_string, ref_db.split('/')[-1])) - - assert os.path.exists(local_fp) is False - - logging.info("Saving database to " + local_fp) - run_cmds(['aws', 's3', 'cp', '--quiet', '--sse', 'AES256', ref_db, local_fp]) - - return local_fp[:-5] - - else: - # Treat the input as a local path - logging.info("Getting reference database from local path: " + ref_db) - assert os.path.exists(ref_db) - - return ref_db - - -def return_results(out, read_prefix, output_folder, temp_folder): - """Write out the final results as a JSON object and write them to the output folder.""" - # Make a temporary file - temp_fp = os.path.join(temp_folder, read_prefix + '.json') - with open(temp_fp, 'wt') as fo: - json.dump(out, fo) - # Compress the output - run_cmds(['gzip', temp_fp]) - temp_fp = temp_fp + '.gz' - - if output_folder.startswith('s3://'): - # Copy to S3 - run_cmds(['aws', 's3', 'cp', '--quiet', '--sse', 'AES256', temp_fp, output_folder]) - os.unlink(temp_fp) - else: - # Copy to local folder - run_cmds(['mv', temp_fp, output_folder]) +from lib.midas_helpers import run_midas +from lib.midas_helpers import parse_midas_output +from lib.exec_helpers import get_reference_database +from lib.exec_helpers import return_results +from lib.exec_helpers import exit_and_clean_up +from lib.fastq_helpers import get_reads_from_url +from lib.fastq_helpers import count_fastq_reads if __name__ == "__main__": parser = argparse.ArgumentParser(description=""" - Analyze a set of reads with MIDAS and save the results. + Analyze a set of reads with MIDAS. """) parser.add_argument("--input", @@ -352,9 +33,6 @@ def return_results(out, read_prefix, output_folder, temp_folder): type=str, help="""Folder to place results. (Supported: s3://, or local path).""") - parser.add_argument("--overwrite", - action="store_true", - help="""Overwrite output files. Off by default.""") parser.add_argument("--threads", type=int, default=16, @@ -362,16 +40,20 @@ def return_results(out, read_prefix, output_folder, temp_folder): parser.add_argument("--temp-folder", type=str, default='/share', - help="Folder used for temporary files (and ramdisk, if specified).") + help="Folder used for temporary files.") args = parser.parse_args() - # Set a random string, which will be appended to all temporary files - random_string = uuid.uuid4() + # Make a temporary folder for all files to be placed in + temp_folder = os.path.join(args.temp_folder, str(uuid.uuid4())) + assert os.path.exists(temp_folder) is False + os.mkdir(temp_folder) # Set up logging - log_fp = '{}-log.txt'.format(random_string) - logFormatter = logging.Formatter('%(asctime)s %(levelname)-8s [run.py] %(message)s') + log_fp = os.path.join(temp_folder, "log.txt") + logFormatter = logging.Formatter( + '%(asctime)s %(levelname)-8s [MIDAS] %(message)s' + ) rootLogger = logging.getLogger() rootLogger.setLevel(logging.INFO) @@ -385,63 +67,81 @@ def return_results(out, read_prefix, output_folder, temp_folder): rootLogger.addHandler(consoleHandler) # Get the reference database - db_fp = get_reference_database( - args.ref_db, - args.temp_folder, - random_string=random_string - ) + try: + db_fp = get_reference_database( + args.ref_db, + temp_folder + ) + except: + exit_and_clean_up(temp_folder) + logging.info("Reference database: " + db_fp) # Align each of the inputs and calculate the overall abundance for input_str in args.input.split(','): - logging.info("Processing input argument: " + input_str) - - # Make a temporary folder for all of the files for this sample - sample_temp_folder = os.path.join(args.temp_folder, str(uuid.uuid4())) - - # Don't use a folder that already exists - assert os.path.exists(sample_temp_folder) is False + # Keep track of the time elapsed to process each sample + start_time = time.time() - # Make the folder - os.mkdir(sample_temp_folder) + logging.info("Processing input argument: " + input_str) - # Capture in a try statement + # Capture each command in a try statement + # Get the input reads try: - midas(input_str, # ID for single sample to process - db_fp, # Local path to DB - args.ref_db, # URL of ref DB, used for logging - args.output_folder, # Place to put results - threads=args.threads, - temp_folder=sample_temp_folder, - random_string=random_string, - overwrite=args.overwrite) + read_fp = get_reads_from_url(input_str, temp_folder) except: - # There was some error - # Capture the traceback - logging.info("There was an unexpected failure") - exc_type, exc_value, exc_traceback = sys.exc_info() - for line in traceback.format_tb(exc_traceback): - logging.info(line) + exit_and_clean_up(temp_folder) - # Delete any files that were created for this sample - logging.info("Removing temporary folder: " + sample_temp_folder) - shutil.rmtree(sample_temp_folder) + # Run MIDAS + try: + output_folder = run_midas( + read_fp, # FASTQ file path + db_fp, # Local path to DB + temp_folder, # Folder for results + threads=args.threads, + ) + except: + exit_and_clean_up(temp_folder) - # Exit - logging.info("Exit type: {}".format(exc_type)) - logging.info("Exit code: {}".format(exc_value)) - sys.exit(exc_value) + # Parse the output + try: + midas_summary = parse_midas_output( + output_folder, + ref_db=db_fp, + ) + except: + exit_and_clean_up(temp_folder) + + # Name the output file based on the input file + # Ultimately adding ".json.gz" to the input file name + output_prefix = input_str.split("/")[-1] + + # Count the total number of reads + logging.info("Counting the total number of reads") + n_reads = count_fastq_reads(read_fp) + logging.info("Reads in input file: {}".format(n_reads)) + + # Read in the logs + logging.info("Reading in the logs") + logs = open(log_fp, 'rt').readlines() + + # Wrap up all of the results into a single JSON + # and write it to the output folder + output = { + "input_path": input_str, + "input": output_prefix, + "output_folder": args.output_folder, + "logs": logs, + "ref_db": db_fp, + "ref_db_url": args.ref_db, + "results": midas_summary, + "total_reads": n_reads, + "time_elapsed": time.time() - start_time + } + return_results(output, output_prefix, args.output_folder, temp_folder) # Delete any files that were created for this sample - logging.info("Removing temporary folder: " + sample_temp_folder) - shutil.rmtree(sample_temp_folder) - - # Delete any other files that were created in this process - # This should only be the reference database, if it was downloaded - for fp in os.listdir(args.temp_folder): - if fp.startswith(str(random_string)): - logging.info("Deleting temporary file {}".format(fp)) - os.unlink(os.path.join(args.temp_folder, fp)) + logging.info("Removing temporary folder: " + temp_folder) + shutil.rmtree(temp_folder) # Stop logging logging.info("Done") diff --git a/test_image.sh b/test_image.sh new file mode 100644 index 0000000..daf501f --- /dev/null +++ b/test_image.sh @@ -0,0 +1,25 @@ +#!/bin/bash + +set -e + +test_image(){ + + img_tag=$1 + + [[ "${#img_tag}" == "0" ]] && echo "Please specify image" && return + + [[ "$(docker run $img_tag echo True)" != "True" ]] && echo "Tag not found ($img_tag)" && return + + docker run \ + -v $PWD/temp:/share \ + --rm \ + $img_tag \ + run.py \ + --input /share/SRR1297187_1.100k.fastq.gz \ + --ref-db /share/midas_db_v1.2/ \ + --output-folder /share/ \ + --temp-folder /share +} + +test_image $1 + diff --git a/tests/example_output/genes/log.txt b/tests/example_output/genes/log.txt new file mode 100644 index 0000000..7901fbc --- /dev/null +++ b/tests/example_output/genes/log.txt @@ -0,0 +1,39 @@ + +MIDAS: Metagenomic Intra-species Diversity Analysis System +version 1.3.0; github.com/snayfach/MIDAS +Copyright (C) 2015-2016 Stephen Nayfach +Freely distributed under the GNU General Public License (GPLv3) + +===========Parameters=========== +Command: /usr/midas/MIDAS-1.3.2/scripts/run_midas.py genes /share/SRR1297187_1.midas -1 /share/SRR1297187_1.fastq.gz -n 100000 -t 4 --remove_temp -d /share/midas_db_v1.2 +Script: run_midas.py genes +Database: /share/midas_db_v1.2 +Output directory: /share/SRR1297187_1.midas +Remove temporary files: True +Pipeline options: + build bowtie2 database of pangenomes + align reads to bowtie2 pangenome database + quantify coverage of pangenomes genes +Database options: + include all species with >=3.0X genome coverage +Read alignment options: + input reads (unpaired): /share/SRR1297187_1.fastq.gz + alignment speed/sensitivity: very-sensitive + alignment mode: local + number of reads to use from input: 100000 + number of threads for database search: 4 +Gene coverage options: + minimum alignment percent identity: 94.0 + minimum alignment coverage of reads: 0.75 + minimum read quality score: 20 + minimum mapping quality score: 0 + trim 0 base-pairs from 3'/right end of read +================================ + +Building pangenome database +command: /usr/midas/MIDAS-1.3.2/bin/Linux/bowtie2-build --threads 4 /share/SRR1297187_1.midas/genes/temp/pangenomes.fa /share/SRR1297187_1.midas/genes/temp/pangenomes + +Aligning reads to pangenomes +command: /usr/midas/MIDAS-1.3.2/bin/Linux/bowtie2 --no-unal -x /share/SRR1297187_1.midas/genes/temp/pangenomes -u 100000 --very-sensitive-local --threads 4 -q -U /share/SRR1297187_1.fastq.gz | /usr/midas/MIDAS-1.3.2/bin/Linux/samtools view --threads 4 -b - > /share/SRR1297187_1.midas/genes/temp/pangenomes.bam + +Computing coverage of pangenomes diff --git a/tests/example_output/genes/output/Salmonella_enterica_58156.genes.gz b/tests/example_output/genes/output/Salmonella_enterica_58156.genes.gz new file mode 100644 index 0000000..3fd666d Binary files /dev/null and b/tests/example_output/genes/output/Salmonella_enterica_58156.genes.gz differ diff --git a/tests/example_output/genes/readme.txt b/tests/example_output/genes/readme.txt new file mode 100644 index 0000000..e28684c --- /dev/null +++ b/tests/example_output/genes/readme.txt @@ -0,0 +1,40 @@ + +Description of output files and file formats from 'run_midas.py genes' + +Output files +############ +output + directory of per-species output files + files are tab-delimited, gzip-compressed, with header + naming convention of each file is: {SPECIES_ID}.genes.gz +species.txt + list of species_ids included in local database +summary.txt + tab-delimited with header + summarizes alignment results per-species +log.txt + log file containing parameters used +temp + directory of intermediate files + run with `--remove_temp` to remove these files + +Output formats +############ +output/{SPECIES_ID}.genes.gz + gene_id: id of non-redundant gene used for read mapping; 'peg' and 'rna' indicate coding & RNA genes respectively + count_reads: number of aligned reads to gene_id after quality filtering + coverage: average read-depth of gene_id based on aligned reads (# aligned bp / gene length in bp) + copy_number: estimated copy-number of gene_id based on aligned reads (coverage of gene_id / median coverage of 15 universal single copy genes) + +summary.txt + species_id: species id + pangenome_size: number of non-redundant genes in reference pan-genome + covered_genes: number of genes with at least 1 mapped read + fraction_covered: proportion of genes with at least 1 mapped read + mean_coverage: average read-depth across genes with at least 1 mapped read + marker_coverage: median read-depth across 15 universal single copy genes + aligned_reads: number of aligned reads BEFORE quality filtering + mapped_reads: number of aligned reads AFTER quality filtering + +Additional information for each species can be found in the reference database: + /share/midas_db_v1.2/pan_genomes diff --git a/tests/example_output/genes/species.txt b/tests/example_output/genes/species.txt new file mode 100644 index 0000000..ddb360a --- /dev/null +++ b/tests/example_output/genes/species.txt @@ -0,0 +1 @@ +Salmonella_enterica_58156 diff --git a/tests/example_output/genes/summary.txt b/tests/example_output/genes/summary.txt new file mode 100644 index 0000000..787f340 --- /dev/null +++ b/tests/example_output/genes/summary.txt @@ -0,0 +1,2 @@ +species_id pangenome_size covered_genes fraction_covered mean_coverage marker_coverage aligned_reads mapped_reads +Salmonella_enterica_58156 108616 22927 0.211083081682 0.760715436302 3.26449275362 97933 80722 diff --git a/tests/example_output/ref_db/ontologies/ec.txt b/tests/example_output/ref_db/ontologies/ec.txt new file mode 100644 index 0000000..47348ba --- /dev/null +++ b/tests/example_output/ref_db/ontologies/ec.txt @@ -0,0 +1,1818 @@ +1.-.-.- Oxidoreductases. +1.1.-.- Acting on the CH-OH group of donors. +1.1.1.- With NAD(+) or NADP(+) as acceptor. +1.1.1.1 Alcohol dehydrogenase +1.1.1.10 L-xylulose reductase +1.1.1.100 3-oxoacyl-[acyl-carrier-protein] reductase +1.1.1.103 L-threonine 3-dehydrogenase +1.1.1.107 Pyridoxal 4-dehydrogenase +1.1.1.108 Carnitine 3-dehydrogenase +1.1.1.11 D-arabinitol 4-dehydrogenase +1.1.1.122 D-threo-aldose 1-dehydrogenase +1.1.1.125 2-deoxy-D-gluconate 3-dehydrogenase +1.1.1.127 2-dehydro-3-deoxy-D-gluconate 5-dehydrogenase +1.1.1.130 3-dehydro-L-gulonate 2-dehydrogenase +1.1.1.132 GDP-mannose 6-dehydrogenase +1.1.1.133 dTDP-4-dehydrorhamnose reductase +1.1.1.14 L-iditol 2-dehydrogenase +1.1.1.140 Sorbitol-6-phosphate 2-dehydrogenase +1.1.1.145 3-beta-hydroxy-Delta(5)-steroid dehydrogenase +1.1.1.146 11-beta-hydroxysteroid dehydrogenase +1.1.1.153 Sepiapterin reductase (L-erythro-7,8-dihydrobiopterin forming) +1.1.1.154 Ureidoglycolate dehydrogenase +1.1.1.157 3-hydroxybutyryl-CoA dehydrogenase +1.1.1.158 UDP-N-acetylmuramate dehydrogenase +1.1.1.159 7-alpha-hydroxysteroid dehydrogenase +1.1.1.163 Cyclopentanol dehydrogenase +1.1.1.169 2-dehydropantoate 2-reductase +1.1.1.17 Mannitol-1-phosphate 5-dehydrogenase +1.1.1.170 3-beta-hydroxysteroid-4-alpha-carboxylate 3-dehydrogenase(decarboxylating) +1.1.1.175 D-xylose 1-dehydrogenase +1.1.1.18 Inositol 2-dehydrogenase +1.1.1.193 5-amino-6-(5-phosphoribosylamino)uracil reductase +1.1.1.195 Cinnamyl-alcohol dehydrogenase +1.1.1.202 1,3-propanediol dehydrogenase +1.1.1.203 Uronate dehydrogenase +1.1.1.205 IMP dehydrogenase +1.1.1.215 Gluconate 2-dehydrogenase +1.1.1.219 Dihydrokaempferol 4-reductase +1.1.1.22 UDP-glucose 6-dehydrogenase +1.1.1.23 Histidinol dehydrogenase +1.1.1.243 Carveol dehydrogenase +1.1.1.25 Shikimate dehydrogenase +1.1.1.250 D-arabinitol 2-dehydrogenase +1.1.1.251 Galactitol-1-phosphate 5-dehydrogenase +1.1.1.26 Glyoxylate reductase +1.1.1.261 sn-glycerol-1-phosphate dehydrogenase +1.1.1.262 4-hydroxythreonine-4-phosphate dehydrogenase +1.1.1.264 L-idonate 5-dehydrogenase +1.1.1.267 1-deoxy-D-xylulose-5-phosphate reductoisomerase +1.1.1.27 L-lactate dehydrogenase +1.1.1.271 GDP-L-fucose synthase +1.1.1.272 (R)-2-hydroxyacid dehydrogenase +1.1.1.274 2,5-didehydrogluconate reductase +1.1.1.276 Serine 3-dehydrogenase +1.1.1.28 D-lactate dehydrogenase +1.1.1.282 Quinate/shikimate dehydrogenase +1.1.1.284 S-(hydroxymethyl)glutathione dehydrogenase +1.1.1.29 Glycerate dehydrogenase +1.1.1.290 4-phosphoerythronate dehydrogenase +1.1.1.298 3-hydroxypropionate dehydrogenase (NADP(+)) +1.1.1.3 Homoserine dehydrogenase +1.1.1.30 3-hydroxybutyrate dehydrogenase +1.1.1.304 Diacetyl reductase ((S)-acetoin forming) +1.1.1.305 UDP-glucuronic acid oxidase (UDP-4-keto-hexauronic acid decarboxylating) +1.1.1.31 3-hydroxyisobutyrate dehydrogenase +1.1.1.34 Hydroxymethylglutaryl-CoA reductase (NADPH) +1.1.1.35 3-hydroxyacyl-CoA dehydrogenase +1.1.1.36 Acetoacetyl-CoA reductase +1.1.1.37 Malate dehydrogenase +1.1.1.38 Malate dehydrogenase (oxaloacetate-decarboxylating) +1.1.1.4 (R,R)-butanediol dehydrogenase +1.1.1.40 Malate dehydrogenase (oxaloacetate-decarboxylating) (NADP(+)) +1.1.1.41 Isocitrate dehydrogenase (NAD(+)) +1.1.1.42 Isocitrate dehydrogenase (NADP(+)) +1.1.1.43 Phosphogluconate 2-dehydrogenase +1.1.1.44 Phosphogluconate dehydrogenase (decarboxylating) +1.1.1.46 L-arabinose 1-dehydrogenase +1.1.1.47 Glucose 1-dehydrogenase +1.1.1.48 D-galactose 1-dehydrogenase +1.1.1.49 Glucose-6-phosphate dehydrogenase +1.1.1.5 Transferred entry: 1.1.1.303 and 1.1.1.304 +1.1.1.50 3-alpha-hydroxysteroid 3-dehydrogenase (B-specific) +1.1.1.53 3-alpha-(or 20-beta)-hydroxysteroid dehydrogenase +1.1.1.56 Ribitol 2-dehydrogenase +1.1.1.57 Fructuronate reductase +1.1.1.58 Tagaturonate reductase +1.1.1.6 Glycerol dehydrogenase +1.1.1.60 2-hydroxy-3-oxopropionate reductase +1.1.1.61 4-hydroxybutyrate dehydrogenase +1.1.1.65 Pyridoxine 4-dehydrogenase +1.1.1.69 Gluconate 5-dehydrogenase +1.1.1.76 (S,S)-butanediol dehydrogenase +1.1.1.77 Lactaldehyde reductase +1.1.1.79 Glyoxylate reductase (NADP(+)) +1.1.1.81 Hydroxypyruvate reductase +1.1.1.83 D-malate dehydrogenase (decarboxylating) +1.1.1.85 3-isopropylmalate dehydrogenase +1.1.1.86 Ketol-acid reductoisomerase +1.1.1.87 Homoisocitrate dehydrogenase +1.1.1.9 D-xylulose reductase +1.1.1.90 Aryl-alcohol dehydrogenase +1.1.1.91 Aryl-alcohol dehydrogenase (NADP(+)) +1.1.1.93 Tartrate dehydrogenase +1.1.1.94 Glycerol-3-phosphate dehydrogenase (NAD(P)(+)) +1.1.1.95 Phosphoglycerate dehydrogenase +1.1.2.3 L-lactate dehydrogenase (cytochrome) +1.1.2.4 D-lactate dehydrogenase (cytochrome) +1.1.2.5 D-lactate dehydrogenase (cytochrome c-553) +1.1.3.12 Pyridoxine 4-oxidase +1.1.3.15 (S)-2-hydroxy-acid oxidase +1.1.3.21 Glycerol-3-phosphate oxidase +1.1.3.41 Alditol oxidase +1.1.3.6 Cholesterol oxidase +1.1.3.8 L-gulonolactone oxidase +1.1.3.9 Galactose oxidase +1.1.5.- With a quinone or similar compound as acceptor. +1.1.5.2 Quinoprotein glucose dehydrogenase +1.1.5.3 Glycerol-3-phosphate dehydrogenase +1.1.5.4 Malate dehydrogenase (quinone) +1.1.99.- With other acceptors. +1.1.99.1 Choline dehydrogenase +1.1.99.10 Glucose dehydrogenase (acceptor) +1.1.99.14 Glycolate dehydrogenase +1.1.99.16 Transferred entry: 1.1.5.4 +1.1.99.2 2-hydroxyglutarate dehydrogenase +1.1.99.20 Alkan-1-ol dehydrogenase (acceptor) +1.1.99.22 Glycerol dehydrogenase (acceptor) +1.1.99.23 Transferred entry: 1.1.2.6 +1.1.99.25 Transferred entry: 1.1.5.8 +1.1.99.28 Glucose-fructose oxidoreductase +1.1.99.3 Gluconate 2-dehydrogenase (acceptor) +1.1.99.4 Dehydrogluconate dehydrogenase +1.1.99.5 Transferred entry: 1.1.5.3 +1.1.99.8 Transferred entry: 1.1.2.7 and 1.1.2.8 +1.10.2.2 Ubiquinol--cytochrome-c reductase +1.10.3.- With oxygen as acceptor. +1.10.3.11 Ubiquinol oxidase +1.10.3.2 Laccase +1.11.1.- Peroxidases. +1.11.1.1 NADH peroxidase +1.11.1.10 Chloride peroxidase +1.11.1.15 Peroxiredoxin +1.11.1.5 Cytochrome-c peroxidase +1.11.1.6 Catalase +1.11.1.7 Peroxidase +1.11.1.9 Glutathione peroxidase +1.12.1.2 Hydrogen dehydrogenase +1.12.1.4 Hydrogenase (NAD(+), ferredoxin) +1.12.5.1 Hydrogen:quinone oxidoreductase +1.12.7.2 Ferredoxin hydrogenase +1.12.98.1 Coenzyme F420 hydrogenase +1.12.98.3 Methanosarcina-phenazine hydrogenase +1.12.99.6 Hydrogenase (acceptor) +1.13.11.- With incorporation of two atoms of oxygen. +1.13.11.1 Catechol 1,2-dioxygenase +1.13.11.11 Tryptophan 2,3-dioxygenase +1.13.11.15 3,4-dihydroxyphenylacetate 2,3-dioxygenase +1.13.11.16 3-carboxyethylcatechol 2,3-dioxygenase +1.13.11.2 Catechol 2,3-dioxygenase +1.13.11.20 Cysteine dioxygenase +1.13.11.24 Quercetin 2,3-dioxygenase +1.13.11.27 4-hydroxyphenylpyruvate dioxygenase +1.13.11.3 Protocatechuate 3,4-dioxygenase +1.13.11.32 Transferred entry: 1.13.12.16 +1.13.11.33 Arachidonate 15-lipoxygenase +1.13.11.39 Biphenyl-2,3-diol 1,2-dioxygenase +1.13.11.4 Gentisate 1,2-dioxygenase +1.13.11.41 2,4'-dihydroxyacetophenone dioxygenase +1.13.11.5 Homogentisate 1,2-dioxygenase +1.13.11.50 Acetylacetone-cleaving enzyme +1.13.11.52 Indoleamine 2,3-dioxygenase +1.13.11.54 Acireductone dioxygenase (Fe(2+)-requiring) +1.13.11.6 3-hydroxyanthranilate 3,4-dioxygenase +1.13.11.8 Protocatechuate 4,5-dioxygenase +1.13.12.- With incorporation of one atom of oxygen. +1.13.12.2 Lysine 2-monooxygenase +1.13.12.3 Tryptophan 2-monooxygenase +1.13.12.4 Lactate 2-monooxygenase +1.13.99.1 Inositol oxygenase +1.14.-.- Acting on paired donors, with incorporation or reduction of molecular oxygen. +1.14.1.- MISSING: INFERRED FROM CHILD +1.14.11.- With 2-oxoglutarate as one donor, and incorporation of one atom each of oxygen into both donors. +1.14.11.1 Gamma-butyrobetaine dioxygenase +1.14.11.13 Gibberellin 2-beta-dioxygenase +1.14.11.16 Peptide-aspartate beta-dioxygenase +1.14.11.17 Taurine dioxygenase +1.14.11.18 Phytanoyl-CoA dioxygenase +1.14.11.2 Procollagen-proline dioxygenase +1.14.11.21 Clavaminate synthase +1.14.12.- With NADH or NADPH as one donor, and incorporation of two atoms of oxygen into one donor. +1.14.12.10 Benzoate 1,2-dioxygenase +1.14.12.13 2-halobenzoate 1,2-dioxygenase +1.14.12.17 Nitric oxide dioxygenase +1.14.12.18 Biphenyl 2,3-dioxygenase +1.14.12.19 3-phenylpropanoate dioxygenase +1.14.12.20 Pheophorbide a oxygenase +1.14.12.3 Benzene 1,2-dioxygenase +1.14.12.7 Phthalate 4,5-dioxygenase +1.14.13.- With NADH or NADPH as one donor, and incorporation of one atom of oxygen. +1.14.13.1 Salicylate 1-monooxygenase +1.14.13.2 4-hydroxybenzoate 3-monooxygenase +1.14.13.20 2,4-dichlorophenol 6-monooxygenase +1.14.13.22 Cyclohexanone monooxygenase +1.14.13.25 Methane monooxygenase (soluble) +1.14.13.3 Transferred entry: 1.14.14.9 +1.14.13.39 Nitric-oxide synthase (NADPH dependent) +1.14.13.40 Anthraniloyl-CoA monooxygenase +1.14.13.50 Pentachlorophenol monooxygenase +1.14.13.59 L-lysine N(6)-monooxygenase (NADPH) +1.14.13.7 Phenol 2-monooxygenase +1.14.13.70 Sterol 14-demethylase +1.14.13.8 Flavin-containing monooxygenase +1.14.13.81 Magnesium-protoporphyrin IX monomethyl ester (oxidative) cyclase +1.14.13.82 Vanillate monooxygenase +1.14.13.9 Kynurenine 3-monooxygenase +1.14.14.1 Unspecific monooxygenase +1.14.14.3 Alkanal monooxygenase (FMN-linked) +1.14.14.5 Alkanesulfonate monooxygenase +1.14.15.1 Camphor 5-monooxygenase +1.14.15.3 Alkane 1-monooxygenase +1.14.15.7 Choline monooxygenase +1.14.16.1 Phenylalanine 4-monooxygenase +1.14.17.3 Peptidylglycine monooxygenase +1.14.18.1 Tyrosinase +1.14.19.1 Stearoyl-CoA 9-desaturase +1.14.19.2 Acyl-[acyl-carrier-protein] desaturase +1.14.19.3 Linoleoyl-CoA desaturase +1.14.99.- Miscellaneous (requires further characterization). +1.14.99.3 Heme oxygenase +1.15.1.1 Superoxide dismutase +1.15.1.2 Superoxide reductase +1.16.1.1 Mercury(II) reductase +1.16.1.3 Aquacobalamin reductase +1.16.3.- With oxygen as acceptor. +1.16.3.1 Ferroxidase +1.16.5.1 Ascorbate ferrireductase (transmembrane) +1.17.-.- Acting on CH or CH(2) groups. +1.17.1.- With NAD(+) or NADP(+) as acceptor. +1.17.1.2 4-hydroxy-3-methylbut-2-enyl diphosphate reductase +1.17.1.4 Xanthine dehydrogenase +1.17.3.2 Xanthine oxidase +1.17.4.1 Ribonucleoside-diphosphate reductase +1.17.4.2 Ribonucleoside-triphosphate reductase +1.17.7.1 (E)-4-hydroxy-3-methylbut-2-enyl-diphosphate synthase +1.17.99.1 4-methylphenol dehydrogenase (hydroxylating) +1.17.99.2 Ethylbenzene hydroxylase +1.18.-.- Acting on iron-sulfur proteins as donors. +1.18.1.- With NAD(+) or NADP(+) as acceptor. +1.18.1.1 Rubredoxin--NAD(+) reductase +1.18.1.2 Ferredoxin--NADP(+) reductase +1.18.1.3 Ferredoxin--NAD(+) reductase +1.18.6.1 Nitrogenase +1.2.1.- With NAD(+) or NADP(+) as acceptor. +1.2.1.1 Transferred entry: 1.1.1.284 and 4.4.1.22 +1.2.1.10 Acetaldehyde dehydrogenase (acetylating) +1.2.1.11 Aspartate-semialdehyde dehydrogenase +1.2.1.12 Glyceraldehyde-3-phosphate dehydrogenase (phosphorylating) +1.2.1.13 Glyceraldehyde-3-phosphate dehydrogenase (NADP(+)) (phosphorylating) +1.2.1.16 Succinate-semialdehyde dehydrogenase (NAD(P)(+)) +1.2.1.19 Aminobutyraldehyde dehydrogenase +1.2.1.2 Formate dehydrogenase +1.2.1.20 Glutarate-semialdehyde dehydrogenase +1.2.1.21 Glycolaldehyde dehydrogenase +1.2.1.22 Lactaldehyde dehydrogenase +1.2.1.24 Succinate-semialdehyde dehydrogenase (NAD(+)) +1.2.1.26 2,5-dioxovalerate dehydrogenase +1.2.1.27 Methylmalonate-semialdehyde dehydrogenase (acylating) +1.2.1.28 Benzaldehyde dehydrogenase (NAD(+)) +1.2.1.3 Aldehyde dehydrogenase (NAD(+)) +1.2.1.31 L-aminoadipate-semialdehyde dehydrogenase +1.2.1.32 Aminomuconate-semialdehyde dehydrogenase +1.2.1.38 N-acetyl-gamma-glutamyl-phosphate reductase +1.2.1.39 Phenylacetaldehyde dehydrogenase +1.2.1.41 Glutamate-5-semialdehyde dehydrogenase +1.2.1.44 Cinnamoyl-CoA reductase +1.2.1.5 Aldehyde dehydrogenase (NAD(P)(+)) +1.2.1.50 Long-chain-fatty-acyl-CoA reductase +1.2.1.59 Glyceraldehyde-3-phosphate dehydrogenase (NAD(P)(+)) (phosphorylating) +1.2.1.60 5-carboxymethyl-2-hydroxymuconic-semialdehyde dehydrogenase +1.2.1.65 Salicylaldehyde dehydrogenase +1.2.1.66 Transferred entry: 1.1.1.306 +1.2.1.68 Coniferyl-aldehyde dehydrogenase +1.2.1.70 Glutamyl-tRNA reductase +1.2.1.71 Succinylglutamate-semialdehyde dehydrogenase +1.2.1.72 Erythrose-4-phosphate dehydrogenase +1.2.1.8 Betaine-aldehyde dehydrogenase +1.2.1.9 Glyceraldehyde-3-phosphate dehydrogenase (NADP(+)) +1.2.2.2 Deleted entry +1.2.3.3 Pyruvate oxidase +1.2.4.- With a disulfide as acceptor. +1.2.4.1 Pyruvate dehydrogenase (acetyl-transferring) +1.2.4.2 Oxoglutarate dehydrogenase (succinyl-transferring) +1.2.4.4 3-methyl-2-oxobutanoate dehydrogenase (2-methylpropanoyl-transferring) +1.2.7.- With an iron-sulfur protein as acceptor. +1.2.7.1 Pyruvate synthase +1.2.7.3 2-oxoglutarate synthase +1.2.7.5 Aldehyde ferredoxin oxidoreductase +1.2.7.6 Glyceraldehyde-3-phosphate dehydrogenase (ferredoxin) +1.2.7.7 3-methyl-2-oxobutanoate dehydrogenase (ferredoxin) +1.2.7.8 Indolepyruvate ferredoxin oxidoreductase +1.2.99.2 Carbon-monoxide dehydrogenase (acceptor) +1.2.99.5 Formylmethanofuran dehydrogenase +1.20.1.1 Phosphonate dehydrogenase +1.20.4.1 Arsenate reductase (glutaredoxin) +1.20.98.1 Transferred entry: 1.20.9.1 +1.20.99.1 Arsenate reductase (donor) +1.21.4.1 D-proline reductase (dithiol) +1.21.4.2 Glycine reductase +1.21.4.4 Betaine reductase +1.3.-.- Acting on the CH-CH group of donors. +1.3.1.- With NAD(+) or NADP(+) as acceptor. +1.3.1.10 Enoyl-[acyl-carrier-protein] reductase (NADPH, B-specific) +1.3.1.12 Prephenate dehydrogenase +1.3.1.2 Dihydropyrimidine dehydrogenase (NADP(+)) +1.3.1.21 7-dehydrocholesterol reductase +1.3.1.24 Biliverdin reductase +1.3.1.25 1,6-dihydroxycyclohexa-2,4-diene-1-carboxylate dehydrogenase +1.3.1.26 Dihydrodipicolinate reductase +1.3.1.28 2,3-dihydro-2,3-dihydroxybenzoate dehydrogenase +1.3.1.32 Maleylacetate reductase +1.3.1.33 Protochlorophyllide reductase +1.3.1.34 2,4-dienoyl-CoA reductase (NADPH) +1.3.1.43 Arogenate dehydrogenase +1.3.1.54 Precorrin-6A reductase +1.3.1.56 Cis-2,3-dihydrobiphenyl-2,3-diol dehydrogenase +1.3.1.70 Delta(14)-sterol reductase +1.3.1.71 Delta(24(24(1)))-sterol reductase +1.3.1.75 Divinyl chlorophyllide a 8-vinyl-reductase +1.3.1.76 Precorrin-2 dehydrogenase +1.3.1.83 Geranylgeranyl diphosphate reductase +1.3.1.9 Enoyl-[acyl-carrier-protein] reductase (NADH) +1.3.3.1 Transferred entry: 1.3.98.1 +1.3.3.11 Pyrroloquinoline-quinone synthase +1.3.3.3 Coproporphyrinogen oxidase +1.3.3.4 Protoporphyrinogen oxidase +1.3.3.6 Acyl-CoA oxidase +1.3.7.2 15,16-dihydrobiliverdin:ferredoxin oxidoreductase +1.3.7.3 Phycoerythrobilin:ferredoxin oxidoreductase +1.3.7.5 Phycocyanobilin:ferredoxin oxidoreductase +1.3.8.1 Short-chain acyl-CoA dehydrogenase +1.3.8.4 Isovaleryl-CoA dehydrogenase +1.3.8.7 Medium-chain acyl-CoA dehydrogenase +1.3.99.- With other acceptors. +1.3.99.1 Succinate dehydrogenase +1.3.99.10 Transferred entry: 1.3.8.4 +1.3.99.12 2-methylacyl-CoA dehydrogenase +1.3.99.13 Transferred entry: 1.3.8.8 +1.3.99.15 Transferred entry: 1.3.7.8 +1.3.99.16 Isoquinoline 1-oxidoreductase +1.3.99.2 Transferred entry: 1.3.8.1 +1.3.99.20 Transferred entry: 1.3.7.9 +1.3.99.22 Coproporphyrinogen dehydrogenase +1.3.99.3 Transferred entry: 1.3.8.7, 1.3.8.8 and 1.3.8.9 +1.3.99.4 3-oxosteroid 1-dehydrogenase +1.3.99.7 Transferred entry: 1.3.8.6 +1.4.-.- Acting on the CH-NH(2) group of donors. +1.4.1.- With NAD(+) or NADP(+) as acceptor. +1.4.1.1 Alanine dehydrogenase +1.4.1.11 L-erythro-3,5-diaminohexanoate dehydrogenase +1.4.1.12 2,4-diaminopentanoate dehydrogenase +1.4.1.13 Glutamate synthase (NADPH) +1.4.1.16 Diaminopimelate dehydrogenase +1.4.1.2 Glutamate dehydrogenase +1.4.1.21 Aspartate dehydrogenase +1.4.1.3 Glutamate dehydrogenase (NAD(P)(+)) +1.4.1.4 Glutamate dehydrogenase (NADP(+)) +1.4.1.9 Leucine dehydrogenase +1.4.3.10 Putrescine oxidase +1.4.3.16 L-aspartate oxidase +1.4.3.19 Glycine oxidase +1.4.3.2 L-amino-acid oxidase +1.4.3.20 L-lysine 6-oxidase +1.4.3.3 D-amino-acid oxidase +1.4.3.4 Monoamine oxidase +1.4.3.5 Pyridoxal 5'-phosphate synthase +1.4.4.2 Glycine dehydrogenase (decarboxylating) +1.4.7.1 Glutamate synthase (ferredoxin) +1.4.99.- With other acceptors. +1.4.99.1 D-amino-acid dehydrogenase +1.4.99.3 Transferred entry: 1.4.9.1 +1.5.1.1 Pyrroline-2-carboxylate reductase +1.5.1.10 Saccharopine dehydrogenase (NADP(+), L-glutamate-forming) +1.5.1.11 D-octopine dehydrogenase +1.5.1.12 1-pyrroline-5-carboxylate dehydrogenase +1.5.1.19 D-nopaline dehydrogenase +1.5.1.2 Pyrroline-5-carboxylate reductase +1.5.1.20 Methylenetetrahydrofolate reductase (NAD(P)H) +1.5.1.21 Delta(1)-piperideine-2-carboxylate reductase +1.5.1.28 Opine dehydrogenase +1.5.1.29 Transferred entry: 1.5.1.38, 1.5.1.39 and 1.5.1.41 +1.5.1.3 Dihydrofolate reductase +1.5.1.30 Flavin reductase (NADPH) +1.5.1.34 6,7-dihydropteridine reductase +1.5.1.5 Methylenetetrahydrofolate dehydrogenase (NADP(+)) +1.5.1.7 Saccharopine dehydrogenase (NAD(+), L-lysine-forming) +1.5.1.8 Saccharopine dehydrogenase (NADP(+), L-lysine-forming) +1.5.1.9 Saccharopine dehydrogenase (NAD(+), L-glutamate-forming) +1.5.3.- With oxygen as acceptor. +1.5.3.1 Sarcosine oxidase +1.5.3.2 N-methyl-L-amino-acid oxidase +1.5.5.- With a quinone or similar compound as acceptor. +1.5.5.1 Electron-transferring-flavoprotein dehydrogenase +1.5.99.1 Transferred entry: 1.5.8.3 +1.5.99.11 5,10-methylenetetrahydromethanopterin reductase +1.5.99.2 Transferred entry: 1.5.8.4 +1.5.99.3 L-pipecolate dehydrogenase +1.5.99.8 Proline dehydrogenase +1.5.99.9 Methylenetetrahydromethanopterin dehydrogenase +1.6.-.- Acting on NADH or NADPH. +1.6.1.1 NAD(P)(+) transhydrogenase (B-specific) +1.6.1.2 NAD(P)(+) transhydrogenase (AB-specific) +1.6.2.4 NADPH--hemoprotein reductase +1.6.4.- MISSING: INFERRED FROM CHILD +1.6.5.- With a quinone or similar compound as acceptor. +1.6.5.2 NAD(P)H dehydrogenase (quinone) +1.6.5.3 NADH:ubiquinone reductase (H(+)-translocating) +1.6.5.5 NADPH:quinone reductase +1.6.6.9 Trimethylamine-N-oxide reductase +1.6.8.- MISSING: INFERRED FROM CHILD +1.6.99.- With other acceptors. +1.6.99.1 NADPH dehydrogenase +1.6.99.3 NADH dehydrogenase +1.6.99.5 NADH dehydrogenase (quinone) +1.6.99.7 Transferred entry: 1.5.1.34 +1.7.-.- Acting on other nitrogenous compounds as donors. +1.7.1.- With NAD(+) or NADP(+) as acceptor. +1.7.1.1 Nitrate reductase (NADH) +1.7.1.13 PreQ(1) synthase +1.7.1.4 Nitrite reductase (NAD(P)H) +1.7.1.7 GMP reductase +1.7.2.1 Nitrite reductase (NO-forming) +1.7.2.2 Nitrite reductase (cytochrome, ammonia-forming) +1.7.2.3 Trimethylamine-N-oxide reductase (cytochrome c) +1.7.3.3 Factor independent urate hydroxylase +1.7.3.4 Transferred entry: 1.7.2.6 +1.7.7.1 Ferredoxin--nitrite reductase +1.7.99.4 Nitrate reductase +1.7.99.6 Transferred entry: 1.7.2.4 +1.7.99.7 Transferred entry: 1.7.2.5 +1.8.-.- Acting on a sulfur group of donors. +1.8.1.- With NAD(+) or NADP(+) as acceptor. +1.8.1.14 CoA-disulfide reductase +1.8.1.2 Sulfite reductase (NADPH) +1.8.1.4 Dihydrolipoyl dehydrogenase +1.8.1.7 Glutathione-disulfide reductase +1.8.1.8 Protein-disulfide reductase +1.8.1.9 Thioredoxin-disulfide reductase +1.8.2.- With a cytochrome as acceptor. +1.8.3.1 Sulfite oxidase +1.8.4.- With a disulfide as acceptor. +1.8.4.10 Adenylyl-sulfate reductase (thioredoxin) +1.8.4.11 Peptide-methionine (S)-S-oxide reductase +1.8.4.12 Peptide-methionine (R)-S-oxide reductase +1.8.4.8 Phosphoadenylyl-sulfate reductase (thioredoxin) +1.8.5.3 Dimethylsulfoxide reductase +1.8.7.1 Sulfite reductase (ferredoxin) +1.8.98.- With other, known, acceptors. +1.8.98.1 CoB--CoM heterodisulfide reductase +1.8.99.- With other acceptors. +1.8.99.1 Sulfite reductase +1.8.99.2 Adenylyl-sulfate reductase +1.8.99.3 Hydrogensulfite reductase +1.9.3.1 Cytochrome-c oxidase +1.97.1.10 Thyroxine 5'-deiodinase +1.97.1.4 [Formate-C-acetyltransferase]-activating enzyme +1.97.1.8 Tetrachloroethene reductive dehalogenase +2.-.-.- Transferases. +2.1.-.- Transferring one-carbon groups. +2.1.1.- Methyltransferases. +2.1.1.10 Homocysteine S-methyltransferase +2.1.1.100 Protein-S-isoprenylcysteine O-methyltransferase +2.1.1.101 Macrocin O-methyltransferase +2.1.1.104 Caffeoyl-CoA O-methyltransferase +2.1.1.107 Uroporphyrinogen-III C-methyltransferase +2.1.1.11 Magnesium protoporphyrin IX methyltransferase +2.1.1.113 Site-specific DNA-methyltransferase (cytosine-N(4)-specific) +2.1.1.13 Methionine synthase +2.1.1.130 Precorrin-2 C(20)-methyltransferase +2.1.1.133 Precorrin-4 C(11)-methyltransferase +2.1.1.14 5-methyltetrahydropteroyltriglutamate--homocysteine S-methyltransferase +2.1.1.144 Trans-aconitate 2-methyltransferase +2.1.1.152 Precorrin-6A synthase (deacetylating) +2.1.1.163 Demethylmenaquinone methyltransferase +2.1.1.17 Phosphatidylethanolamine N-methyltransferase +2.1.1.171 16S rRNA (guanine(966)-N(2))-methyltransferase +2.1.1.176 16S rRNA (cytosine(967)-C(5))-methyltransferase +2.1.1.182 16S rRNA (adenine(1518)-N(6)/adenine(1519)-N(6))-dimethyltransferase +2.1.1.20 Glycine N-methyltransferase +2.1.1.207 tRNA (cytidine(34)-2'-O)-methyltransferase +2.1.1.210 Demethylspheroidene O-methyltransferase +2.1.1.223 tRNA(1)(Val) (adenine(37)-N(6))-methyltransferase +2.1.1.31 Transferred entry: 2.1.1.221 and 2.1.1.228 +2.1.1.32 Transferred entry: 2.1.1.213, 2.1.1.214, 2.1.1.215 and 2.1.1.216 +2.1.1.33 tRNA (guanine(46)-N(7))-methyltransferase +2.1.1.34 tRNA (guanosine(18)-2'-O)-methyltransferase +2.1.1.35 tRNA (uracil(54)-C(5))-methyltransferase +2.1.1.36 Transferred entry: 2.1.1.217, 2.1.1.218, 2.1.1.219 and 2.1.1.220 +2.1.1.37 DNA (cytosine-5-)-methyltransferase +2.1.1.38 O-demethylpuromycin O-methyltransferase +2.1.1.4 Acetylserotonin O-methyltransferase +2.1.1.43 Histone-lysine N-methyltransferase +2.1.1.44 Dimethylhistidine N-methyltransferase +2.1.1.45 Thymidylate synthase +2.1.1.48 Transferred entry: 2.1.1.181, 2.1.1.182, 2.1.1.183 and 2.1.1.184 +2.1.1.5 Betaine--homocysteine S-methyltransferase +2.1.1.51 Transferred entry: 2.1.1.187 and 2.1.1.188 +2.1.1.52 Transferred entry: 2.1.1.171, 2.1.1.172, 2.1.1.173 and 2.1.1.174 +2.1.1.6 Catechol O-methyltransferase +2.1.1.61 tRNA (5-methylaminomethyl-2-thiouridylate)-methyltransferase +2.1.1.63 Methylated-DNA--[protein]-cysteine S-methyltransferase +2.1.1.64 3-demethylubiquinol 3-O-methyltransferase +2.1.1.67 Thiopurine S-methyltransferase +2.1.1.68 Caffeate O-methyltransferase +2.1.1.71 Phosphatidyl-N-methylethanolamine N-methyltransferase +2.1.1.72 Site-specific DNA-methyltransferase (adenine-specific) +2.1.1.77 Protein-L-isoaspartate(D-aspartate) O-methyltransferase +2.1.1.79 Cyclopropane-fatty-acyl-phospholipid synthase +2.1.1.80 Protein-glutamate O-methyltransferase +2.1.1.86 Tetrahydromethanopterin S-methyltransferase +2.1.1.95 Tocopherol O-methyltransferase +2.1.1.98 Diphthine synthase +2.1.2.- Hydroxymethyl-, formyl- and related transferases. +2.1.2.1 Glycine hydroxymethyltransferase +2.1.2.10 Aminomethyltransferase +2.1.2.11 3-methyl-2-oxobutanoate hydroxymethyltransferase +2.1.2.13 UDP-4-amino-4-deoxy-L-arabinose formyltransferase +2.1.2.2 Phosphoribosylglycinamide formyltransferase +2.1.2.3 Phosphoribosylaminoimidazolecarboxamide formyltransferase +2.1.2.5 Glutamate formimidoyltransferase +2.1.2.8 Deoxycytidylate 5-hydroxymethyltransferase +2.1.2.9 Methionyl-tRNA formyltransferase +2.1.3.- Carboxyl- and carbamoyltransferases. +2.1.3.1 Methylmalonyl-CoA carboxytransferase +2.1.3.2 Aspartate carbamoyltransferase +2.1.3.3 Ornithine carbamoyltransferase +2.1.3.6 Putrescine carbamoyltransferase +2.1.3.9 N-acetylornithine carbamoyltransferase +2.1.4.1 Glycine amidinotransferase +2.1.4.2 Scyllo-inosamine-4-phosphate amidinotransferase +2.2.1.1 Transketolase +2.2.1.2 Transaldolase +2.2.1.6 Acetolactate synthase +2.2.1.7 1-deoxy-D-xylulose-5-phosphate synthase +2.2.1.9 2-succinyl-5-enolpyruvyl-6-hydroxy-3-cyclohexene-1-carboxylic-acidsynthase +2.3.-.- Acyltransferases. +2.3.1.- Transferring groups other than amino-acyl groups. +2.3.1.1 Amino-acid N-acetyltransferase +2.3.1.101 Formylmethanofuran--tetrahydromethanopterin N-formyltransferase +2.3.1.102 N(6)-hydroxylysine O-acetyltransferase +2.3.1.109 Arginine N-succinyltransferase +2.3.1.117 2,3,4,5-tetrahydropyridine-2,6-dicarboxylate N-succinyltransferase +2.3.1.118 N-hydroxyarylamine O-acetyltransferase +2.3.1.12 Dihydrolipoyllysine-residue acetyltransferase +2.3.1.128 Ribosomal-protein-alanine N-acetyltransferase +2.3.1.129 Acyl-[acyl-carrier-protein]--UDP-N-acetylglucosamine O-acyltransferase +2.3.1.135 Phosphatidylcholine--retinol O-acyltransferase +2.3.1.15 Glycerol-3-phosphate 1-O-acyltransferase +2.3.1.157 Glucosamine-1-phosphate N-acetyltransferase +2.3.1.16 Acetyl-CoA C-acyltransferase +2.3.1.164 Isopenicillin-N N-acyltransferase +2.3.1.168 Dihydrolipoyllysine-residue (2-methylpropanoyl)transferase +2.3.1.169 CO-methylating acetyl-CoA synthase +2.3.1.17 Aspartate N-acetyltransferase +2.3.1.176 Propanoyl-CoA C-acyltransferase +2.3.1.179 Beta-ketoacyl-[acyl-carrier-protein] synthase II +2.3.1.18 Galactoside O-acetyltransferase +2.3.1.180 Beta-ketoacyl-[acyl-carrier-protein] synthase III +2.3.1.182 (R)-citramalate synthase +2.3.1.19 Phosphate butyryltransferase +2.3.1.191 UDP-3-O-(3-hydroxymyristoyl)glucosamine N-acyltransferase +2.3.1.20 Diacylglycerol O-acyltransferase +2.3.1.21 Carnitine O-palmitoyltransferase +2.3.1.28 Chloramphenicol O-acetyltransferase +2.3.1.29 Glycine C-acetyltransferase +2.3.1.30 Serine O-acetyltransferase +2.3.1.31 Homoserine O-acetyltransferase +2.3.1.35 Glutamate N-acetyltransferase +2.3.1.37 5-aminolevulinate synthase +2.3.1.38 [Acyl-carrier-protein] S-acetyltransferase +2.3.1.39 [Acyl-carrier-protein] S-malonyltransferase +2.3.1.4 Glucosamine-phosphate N-acetyltransferase +2.3.1.40 Acyl-[acyl-carrier-protein]--phospholipid O-acyltransferase +2.3.1.41 Beta-ketoacyl-[acyl-carrier-protein] synthase I +2.3.1.43 Phosphatidylcholine--sterol O-acyltransferase +2.3.1.46 Homoserine O-succinyltransferase +2.3.1.47 8-amino-7-oxononanoate synthase +2.3.1.5 Arylamine N-acetyltransferase +2.3.1.50 Serine C-palmitoyltransferase +2.3.1.51 1-acylglycerol-3-phosphate O-acyltransferase +2.3.1.54 Formate C-acetyltransferase +2.3.1.57 Diamine N-acetyltransferase +2.3.1.6 Choline O-acetyltransferase +2.3.1.61 Dihydrolipoyllysine-residue succinyltransferase +2.3.1.74 Naringenin-chalcone synthase +2.3.1.79 Maltose O-acetyltransferase +2.3.1.8 Phosphate acetyltransferase +2.3.1.81 Aminoglycoside N(3')-acetyltransferase +2.3.1.82 Aminoglycoside N(6')-acetyltransferase +2.3.1.89 Tetrahydrodipicolinate N-acetyltransferase +2.3.1.9 Acetyl-CoA C-acetyltransferase +2.3.2.- Aminoacyltransferases. +2.3.2.10 UDP-N-acetylmuramoylpentapeptide-lysine N(6)-alanyltransferase +2.3.2.11 Alanylphosphatidylglycerol synthase +2.3.2.13 Protein-glutamine gamma-glutamyltransferase +2.3.2.15 Glutathione gamma-glutamylcysteinyltransferase +2.3.2.2 Gamma-glutamyltransferase +2.3.2.3 Lysyltransferase +2.3.2.4 Gamma-glutamylcyclotransferase +2.3.2.5 Glutaminyl-peptide cyclotransferase +2.3.2.6 Leucyltransferase +2.3.2.8 Arginyltransferase +2.3.3.1 Citrate (Si)-synthase +2.3.3.10 Hydroxymethylglutaryl-CoA synthase +2.3.3.13 2-isopropylmalate synthase +2.3.3.14 Homocitrate synthase +2.3.3.15 Sulfoacetaldehyde acetyltransferase +2.3.3.3 Citrate (Re)-synthase +2.3.3.5 2-methylcitrate synthase +2.3.3.8 ATP citrate synthase +2.3.3.9 Malate synthase +2.4.-.- Glycosyltransferases. +2.4.1.- Hexosyltransferases. +2.4.1.1 Phosphorylase +2.4.1.10 Levansucrase +2.4.1.109 Dolichyl-phosphate-mannose-protein mannosyltransferase +2.4.1.11 Glycogen(starch) synthase +2.4.1.117 Dolichyl-phosphate beta-glucosyltransferase +2.4.1.119 Transferred entry: 2.4.99.18 +2.4.1.12 Cellulose synthase (UDP-forming) +2.4.1.129 Peptidoglycan glycosyltransferase +2.4.1.14 Sucrose-phosphate synthase +2.4.1.15 Alpha,alpha-trehalose-phosphate synthase (UDP-forming) +2.4.1.157 1,2-diacylglycerol 3-glucosyltransferase +2.4.1.175 Glucuronosyl-N-acetylgalactosaminyl-proteoglycan 4-beta-N-acetylgalactosaminyltransferase +2.4.1.18 1,4-alpha-glucan branching enzyme +2.4.1.182 Lipid-A-disaccharide synthase +2.4.1.186 Glycogenin glucosyltransferase +2.4.1.187 N-acetylglucosaminyldiphosphoundecaprenol N-acetyl-beta-D-mannosaminyltransferase +2.4.1.19 Cyclomaltodextrin glucanotransferase +2.4.1.21 Starch synthase +2.4.1.211 1,3-beta-galactosyl-N-acetylhexosamine phosphorylase +2.4.1.212 Hyaluronan synthase +2.4.1.216 Trehalose 6-phosphate phosphorylase +2.4.1.217 Mannosyl-3-phosphoglycerate synthase +2.4.1.226 N-acetylgalactosaminyl-proteoglycan 3-beta-glucuronosyltransferase +2.4.1.227 Undecaprenyldiphospho-muramoylpentapeptide beta-N-acetylglucosaminyltransferase +2.4.1.230 Kojibiose phosphorylase +2.4.1.25 4-alpha-glucanotransferase +2.4.1.266 Glucosyl-3-phosphoglycerate synthase +2.4.1.41 Polypeptide N-acetylgalactosaminyltransferase +2.4.1.46 Monogalactosyldiacylglycerol synthase +2.4.1.49 Cellodextrin phosphorylase +2.4.1.5 Dextransucrase +2.4.1.52 Poly(glycerol-phosphate) alpha-glucosyltransferase +2.4.1.56 Lipopolysaccharide N-acetylglucosaminyltransferase +2.4.1.57 Phosphatidylinositol alpha-mannosyltransferase +2.4.1.58 Lipopolysaccharide glucosyltransferase I +2.4.1.64 Alpha,alpha-trehalose phosphorylase +2.4.1.65 3-galactosyl-N-acetylglucosaminide 4-alpha-L-fucosyltransferase +2.4.1.69 Galactoside 2-alpha-L-fucosyltransferase +2.4.1.7 Sucrose phosphorylase +2.4.1.8 Maltose phosphorylase +2.4.1.80 Ceramide glucosyltransferase +2.4.1.83 Dolichyl-phosphate beta-D-mannosyltransferase +2.4.1.92 (N-acetylneuraminyl)-galactosylglucosylceramideN-acetylgalactosaminyltransferase +2.4.2.- Pentosyltransferases. +2.4.2.1 Purine-nucleoside phosphorylase +2.4.2.10 Orotate phosphoribosyltransferase +2.4.2.11 Nicotinate phosphoribosyltransferase +2.4.2.12 Nicotinamide phosphoribosyltransferase +2.4.2.14 Amidophosphoribosyltransferase +2.4.2.17 ATP phosphoribosyltransferase +2.4.2.18 Anthranilate phosphoribosyltransferase +2.4.2.19 Nicotinate-nucleotide diphosphorylase (carboxylating) +2.4.2.2 Pyrimidine-nucleoside phosphorylase +2.4.2.21 Nicotinate-nucleotide--dimethylbenzimidazole phosphoribosyltransferase +2.4.2.22 Xanthine phosphoribosyltransferase +2.4.2.26 Protein xylosyltransferase +2.4.2.28 S-methyl-5'-thioadenosine phosphorylase +2.4.2.29 tRNA-guanine(34) transglycosylase +2.4.2.3 Uridine phosphorylase +2.4.2.30 NAD(+) ADP-ribosyltransferase +2.4.2.36 NAD(+)--diphthamide ADP-ribosyltransferase +2.4.2.37 NAD(+)--dinitrogen-reductase ADP-D-ribosyltransferase +2.4.2.4 Thymidine phosphorylase +2.4.2.6 Nucleoside deoxyribosyltransferase +2.4.2.7 Adenine phosphoribosyltransferase +2.4.2.8 Hypoxanthine phosphoribosyltransferase +2.4.2.9 Uracil phosphoribosyltransferase +2.4.99.- Transferring other glycosyl groups. +2.4.99.12 Lipid IV(A) 3-deoxy-D-manno-octulosonic acid transferase +2.4.99.13 (KDO)-lipid IV(A) 3-deoxy-D-manno-octulosonic acid transferase +2.5.1.- Transferring alkyl or aryl groups, other than methyl groups. +2.5.1.1 Dimethylallyltranstransferase +2.5.1.10 (2E,6E)-farnesyl diphosphate synthase +2.5.1.11 Transferred entry: 2.5.1.84 and 2.5.1.85 +2.5.1.15 Dihydropteroate synthase +2.5.1.16 Spermidine synthase +2.5.1.17 Cob(I)yrinic acid a,c-diamide adenosyltransferase +2.5.1.18 Glutathione transferase +2.5.1.19 3-phosphoshikimate 1-carboxyvinyltransferase +2.5.1.2 Thiamine pyridinylase +2.5.1.21 Squalene synthase +2.5.1.26 Alkylglycerone-phosphate synthase +2.5.1.29 Geranylgeranyl diphosphate synthase +2.5.1.3 Thiamine-phosphate diphosphorylase +2.5.1.30 Heptaprenyl diphosphate synthase +2.5.1.31 Ditrans,polycis-undecaprenyl-diphosphate synthase ((2E,6E)-farnesyl-diphosphate specific) +2.5.1.32 15-cis-phytoene synthase +2.5.1.39 4-hydroxybenzoate polyprenyltransferase +2.5.1.43 Nicotianamine synthase +2.5.1.44 Homospermidine synthase +2.5.1.46 Deoxyhypusine synthase +2.5.1.47 Cysteine synthase +2.5.1.48 Cystathionine gamma-synthase +2.5.1.49 O-acetylhomoserine aminocarboxypropyltransferase +2.5.1.54 3-deoxy-7-phosphoheptulonate synthase +2.5.1.55 3-deoxy-8-phosphooctulonate synthase +2.5.1.56 N-acetylneuraminate synthase +2.5.1.58 Protein farnesyltransferase +2.5.1.6 Methionine adenosyltransferase +2.5.1.61 Hydroxymethylbilane synthase +2.5.1.62 Chlorophyll synthase +2.5.1.68 (2Z,6E)-farnesyl diphosphate synthase +2.5.1.7 UDP-N-acetylglucosamine 1-carboxyvinyltransferase +2.5.1.72 Quinolinate synthase +2.5.1.74 1,4-dihydroxy-2-naphthoate polyprenyltransferase +2.5.1.75 tRNA dimethylallyltransferase +2.5.1.78 6,7-dimethyl-8-ribityllumazine synthase +2.5.1.8 Transferred entry: 2.5.1.75 +2.5.1.86 Trans,polycis-decaprenyl diphosphate synthase +2.5.1.9 Riboflavin synthase +2.5.1.90 All-trans-octaprenyl-diphosphate synthase +2.5.1.91 All-trans-decaprenyl-diphosphate synthase +2.5.1.96 4,4'-diapophytoene synthase +2.6.1.- Transaminases (aminotransferases). +2.6.1.1 Aspartate transaminase +2.6.1.11 Acetylornithine transaminase +2.6.1.13 Ornithine aminotransferase +2.6.1.16 Glutamine--fructose-6-phosphate transaminase (isomerizing) +2.6.1.17 Succinyldiaminopimelate transaminase +2.6.1.18 Beta-alanine--pyruvate transaminase +2.6.1.19 4-aminobutyrate--2-oxoglutarate transaminase +2.6.1.2 Alanine transaminase +2.6.1.21 D-amino-acid transaminase +2.6.1.30 Pyridoxamine--pyruvate transaminase +2.6.1.36 L-lysine 6-transaminase +2.6.1.37 2-aminoethylphosphonate--pyruvate transaminase +2.6.1.39 2-aminoadipate transaminase +2.6.1.40 (R)-3-amino-2-methylpropionate--pyruvate transaminase +2.6.1.42 Branched-chain-amino-acid transaminase +2.6.1.44 Alanine--glyoxylate transaminase +2.6.1.45 Serine--glyoxylate transaminase +2.6.1.46 Diaminobutyrate--pyruvate transaminase +2.6.1.48 5-aminovalerate transaminase +2.6.1.50 Glutamine--scyllo-inositol transaminase +2.6.1.51 Serine--pyruvate transaminase +2.6.1.52 Phosphoserine transaminase +2.6.1.57 Aromatic-amino-acid transaminase +2.6.1.62 Adenosylmethionine--8-amino-7-oxononanoate transaminase +2.6.1.66 Valine--pyruvate transaminase +2.6.1.7 Kynurenine--oxoglutarate transaminase +2.6.1.76 Diaminobutyrate--2-oxoglutarate transaminase +2.6.1.77 Taurine--pyruvate aminotransferase +2.6.1.81 Succinylornithine transaminase +2.6.1.82 Putrescine aminotransferase +2.6.1.83 LL-diaminopimelate aminotransferase +2.6.1.85 Aminodeoxychorismate synthase +2.6.1.9 Histidinol-phosphate transaminase +2.6.99.2 Pyridoxine 5'-phosphate synthase +2.7.-.- Transferring phosphorous-containing groups. +2.7.1.- Phosphotransferases with an alcohol group as acceptor. +2.7.1.1 Hexokinase +2.7.1.100 S-methyl-5-thioribose kinase +2.7.1.103 Viomycin kinase +2.7.1.105 6-phosphofructo-2-kinase +2.7.1.107 Diacylglycerol kinase +2.7.1.11 6-phosphofructokinase +2.7.1.112 Transferred entry: 2.7.10.1 and 2.7.10.2 +2.7.1.113 Deoxyguanosine kinase +2.7.1.117 Transferred entry: 2.7.11.18 +2.7.1.12 Gluconokinase +2.7.1.121 Phosphoenolpyruvate--glycerone phosphotransferase +2.7.1.123 Transferred entry: 2.7.11.17 +2.7.1.13 Dehydrogluconokinase +2.7.1.130 Tetraacyldisaccharide 4'-kinase +2.7.1.144 Tagatose-6-phosphate kinase +2.7.1.146 ADP-specific phosphofructokinase +2.7.1.147 ADP-specific glucokinase +2.7.1.148 4-(cytidine 5'-diphospho)-2-C-methyl-D-erythritol kinase +2.7.1.15 Ribokinase +2.7.1.156 Adenosylcobinamide kinase +2.7.1.157 N-acetylgalactosamine kinase +2.7.1.16 Ribulokinase +2.7.1.165 Glycerate 2-kinase +2.7.1.17 Xylulokinase +2.7.1.19 Phosphoribulokinase +2.7.1.2 Glucokinase +2.7.1.20 Adenosine kinase +2.7.1.21 Thymidine kinase +2.7.1.22 Ribosylnicotinamide kinase +2.7.1.23 NAD(+) kinase +2.7.1.24 Dephospho-CoA kinase +2.7.1.25 Adenylyl-sulfate kinase +2.7.1.26 Riboflavin kinase +2.7.1.27 Erythritol kinase +2.7.1.29 Glycerone kinase +2.7.1.3 Ketohexokinase +2.7.1.30 Glycerol kinase +2.7.1.31 Glycerate 3-kinase +2.7.1.32 Choline kinase +2.7.1.33 Pantothenate kinase +2.7.1.35 Pyridoxal kinase +2.7.1.36 Mevalonate kinase +2.7.1.37 2.7.11.12, 2.7.11.13, 2.7.11.21, 2.7.11.22, 2.7.11.24, 2.7.11.25,2.7.11.30 and 2.7.12.1 +2.7.1.39 Homoserine kinase +2.7.1.4 Fructokinase +2.7.1.40 Pyruvate kinase +2.7.1.41 Glucose-1-phosphate phosphodismutase +2.7.1.45 2-dehydro-3-deoxygluconokinase +2.7.1.47 D-ribulokinase +2.7.1.48 Uridine kinase +2.7.1.49 Hydroxymethylpyrimidine kinase +2.7.1.5 Rhamnulokinase +2.7.1.50 Hydroxyethylthiazole kinase +2.7.1.51 L-fuculokinase +2.7.1.52 Fucokinase +2.7.1.53 L-xylulokinase +2.7.1.55 Allose kinase +2.7.1.56 1-phosphofructokinase +2.7.1.58 2-dehydro-3-deoxygalactonokinase +2.7.1.59 N-acetylglucosamine kinase +2.7.1.6 Galactokinase +2.7.1.60 N-acylmannosamine kinase +2.7.1.63 Polyphosphate--glucose phosphotransferase +2.7.1.68 1-phosphatidylinositol-4-phosphate 5-kinase +2.7.1.69 Protein-N(pi)-phosphohistidine--sugar phosphotransferase +2.7.1.71 Shikimate kinase +2.7.1.72 Streptomycin 6-kinase +2.7.1.73 Inosine kinase +2.7.1.76 Deoxyadenosine kinase +2.7.1.78 Polynucleotide 5'-hydroxyl-kinase +2.7.1.8 Glucosamine kinase +2.7.1.83 Pseudouridine kinase +2.7.1.87 Streptomycin 3''-kinase +2.7.1.89 Thiamine kinase +2.7.1.90 Diphosphate--fructose-6-phosphate 1-phosphotransferase +2.7.1.92 5-dehydro-2-deoxygluconokinase +2.7.1.95 Kanamycin kinase +2.7.10.2 Non-specific protein-tyrosine kinase +2.7.11.1 Non-specific serine/threonine protein kinase +2.7.11.17 Calcium/calmodulin-dependent protein kinase +2.7.11.5 [Isocitrate dehydrogenase (NADP(+))] kinase +2.7.11.7 [Myosin heavy-chain] kinase +2.7.13.3 Histidine kinase +2.7.2.- Phosphotransferases with a carboxyl group as acceptor. +2.7.2.1 Acetate kinase +2.7.2.11 Glutamate 5-kinase +2.7.2.15 Propionate kinase +2.7.2.2 Carbamate kinase +2.7.2.3 Phosphoglycerate kinase +2.7.2.4 Aspartate kinase +2.7.2.7 Butyrate kinase +2.7.2.8 Acetylglutamate kinase +2.7.3.- Phosphotransferases with a nitrogenous group as acceptor. +2.7.3.9 Phosphoenolpyruvate--protein phosphotransferase +2.7.4.- Phosphotransferases with a phosphate group as acceptor. +2.7.4.1 Polyphosphate kinase +2.7.4.13 (Deoxy)nucleoside-phosphate kinase +2.7.4.14 UMP/CMP kinase +2.7.4.16 Thiamine-phosphate kinase +2.7.4.2 Phosphomevalonate kinase +2.7.4.22 UMP kinase +2.7.4.25 (d)CMP kinase +2.7.4.3 Adenylate kinase +2.7.4.6 Nucleoside-diphosphate kinase +2.7.4.7 Phosphomethylpyrimidine kinase +2.7.4.8 Guanylate kinase +2.7.4.9 dTMP kinase +2.7.6.1 Ribose-phosphate diphosphokinase +2.7.6.2 Thiamine diphosphokinase +2.7.6.3 2-amino-4-hydroxy-6-hydroxymethyldihydropteridine diphosphokinase +2.7.6.5 GTP diphosphokinase +2.7.7.- Nucleotidyltransferases. +2.7.7.1 Nicotinamide-nucleotide adenylyltransferase +2.7.7.10 UTP--hexose-1-phosphate uridylyltransferase +2.7.7.12 UDP-glucose--hexose-1-phosphate uridylyltransferase +2.7.7.13 Mannose-1-phosphate guanylyltransferase +2.7.7.15 Choline-phosphate cytidylyltransferase +2.7.7.18 Nicotinate-nucleotide adenylyltransferase +2.7.7.19 Polynucleotide adenylyltransferase +2.7.7.2 FAD synthetase +2.7.7.21 Transferred entry: 2.7.7.72 +2.7.7.22 Mannose-1-phosphate guanylyltransferase (GDP) +2.7.7.23 UDP-N-acetylglucosamine diphosphorylase +2.7.7.24 Glucose-1-phosphate thymidylyltransferase +2.7.7.25 Transferred entry: 2.7.7.72 +2.7.7.27 Glucose-1-phosphate adenylyltransferase +2.7.7.3 Pantetheine-phosphate adenylyltransferase +2.7.7.33 Glucose-1-phosphate cytidylyltransferase +2.7.7.38 3-deoxy-manno-octulosonate cytidylyltransferase +2.7.7.39 Glycerol-3-phosphate cytidylyltransferase +2.7.7.4 Sulfate adenylyltransferase +2.7.7.40 D-ribitol-5-phosphate cytidylyltransferase +2.7.7.41 Phosphatidate cytidylyltransferase +2.7.7.42 [Glutamate--ammonia-ligase] adenylyltransferase +2.7.7.43 N-acylneuraminate cytidylyltransferase +2.7.7.47 Streptomycin 3''-adenylyltransferase +2.7.7.49 RNA-directed DNA polymerase +2.7.7.53 ATP adenylyltransferase +2.7.7.56 tRNA nucleotidyltransferase +2.7.7.58 (2,3-dihydroxybenzoyl)adenylate synthase +2.7.7.59 [Protein-PII] uridylyltransferase +2.7.7.6 DNA-directed RNA polymerase +2.7.7.60 2-C-methyl-D-erythritol 4-phosphate cytidylyltransferase +2.7.7.61 Citrate lyase holo-[acyl-carrier-protein] synthase +2.7.7.62 Adenosylcobinamide-phosphate guanylyltransferase +2.7.7.65 Diguanylate cyclase +2.7.7.68 2-phospho-L-lactate guanylyltransferase +2.7.7.7 DNA-directed DNA polymerase +2.7.7.8 Polyribonucleotide nucleotidyltransferase +2.7.7.9 UTP--glucose-1-phosphate uridylyltransferase +2.7.8.- Transferases for other substituted phosphate groups. +2.7.8.12 CDP-glycerol glycerophosphotransferase +2.7.8.13 Phospho-N-acetylmuramoyl-pentapeptide-transferase +2.7.8.20 Phosphatidylglycerol--membrane-oligosaccharide glycerophosphotransferase +2.7.8.23 Carboxyvinyl-carboxyphosphonate phosphorylmutase +2.7.8.24 Phosphatidylcholine synthase +2.7.8.25 Triphosphoribosyl-dephospho-CoA synthase +2.7.8.26 Adenosylcobinamide-GDP ribazoletransferase +2.7.8.5 CDP-diacylglycerol--glycerol-3-phosphate 3-phosphatidyltransferase +2.7.8.6 Undecaprenyl-phosphate galactose phosphotransferase +2.7.8.7 Holo-[acyl-carrier-protein] synthase +2.7.8.8 CDP-diacylglycerol--serine O-phosphatidyltransferase +2.7.9.1 Pyruvate, phosphate dikinase +2.7.9.2 Pyruvate, water dikinase +2.7.9.3 Selenide, water dikinase +2.8.1.- Sulfurtransferases. +2.8.1.1 Thiosulfate sulfurtransferase +2.8.1.2 3-mercaptopyruvate sulfurtransferase +2.8.1.6 Biotin synthase +2.8.1.7 Cysteine desulfurase +2.8.2.- Sulfotransferases. +2.8.2.2 Alcohol sulfotransferase +2.8.2.20 Protein-tyrosine sulfotransferase +2.8.2.22 Aryl-sulfate sulfotransferase +2.8.2.4 Estrone sulfotransferase +2.8.3.- CoA-transferases. +2.8.3.1 Propionate CoA-transferase +2.8.3.12 Glutaconate CoA-transferase +2.8.3.15 Succinyl-CoA:(R)-benzylsuccinate CoA-transferase +2.8.3.16 Formyl-CoA transferase +2.8.3.5 3-oxoacid CoA-transferase +2.8.3.6 3-oxoadipate CoA-transferase +2.8.3.8 Acetate CoA-transferase +2.8.3.9 Butyrate--acetoacetate CoA-transferase +2.8.4.1 Coenzyme-B sulfoethylthiotransferase +2.9.1.1 L-seryl-tRNA(Sec) selenium transferase +3.-.-.- Hydrolases. +3.1.-.- Acting on ester bonds. +3.1.1.- Carboxylic ester hydrolases. +3.1.1.1 Carboxylesterase +3.1.1.11 Pectinesterase +3.1.1.15 L-arabinonolactonase +3.1.1.17 Gluconolactonase +3.1.1.2 Arylesterase +3.1.1.22 Hydroxybutyrate-dimer hydrolase +3.1.1.23 Acylglycerol lipase +3.1.1.24 3-oxoadipate enol-lactonase +3.1.1.25 1,4-lactonase +3.1.1.27 4-pyridoxolactonase +3.1.1.29 Aminoacyl-tRNA hydrolase +3.1.1.3 Triacylglycerol lipase +3.1.1.31 6-phosphogluconolactonase +3.1.1.32 Phospholipase A(1) +3.1.1.4 Phospholipase A(2) +3.1.1.41 Cephalosporin-C deacetylase +3.1.1.45 Carboxymethylenebutenolidase +3.1.1.47 1-alkyl-2-acetylglycerophosphocholine esterase +3.1.1.5 Lysophospholipase +3.1.1.6 Acetylesterase +3.1.1.61 Protein-glutamate methylesterase +3.1.1.68 Xylono-1,4-lactonase +3.1.1.73 Feruloyl esterase +3.1.1.74 Cutinase +3.1.1.75 Poly(3-hydroxybutyrate) depolymerase +3.1.11.- Exodeoxyribonucleases producing 5'-phosphomonoesters. +3.1.11.1 Exodeoxyribonuclease I +3.1.11.2 Exodeoxyribonuclease III +3.1.11.3 Exodeoxyribonuclease (lambda-induced) +3.1.11.5 Exodeoxyribonuclease V +3.1.11.6 Exodeoxyribonuclease VII +3.1.13.- Exoribonucleases producing 5'-phosphomonoesters. +3.1.13.1 Exoribonuclease II +3.1.2.- Thiolester hydrolases. +3.1.2.1 Acetyl-CoA hydrolase +3.1.2.12 S-formylglutathione hydrolase +3.1.2.14 Oleoyl-[acyl-carrier-protein] hydrolase +3.1.2.2 Palmitoyl-CoA hydrolase +3.1.2.20 Acyl-CoA hydrolase +3.1.2.23 4-hydroxybenzoyl-CoA thioesterase +3.1.2.28 1,4-dihydroxy-2-naphthoyl-CoA hydrolase +3.1.2.4 3-hydroxyisobutyryl-CoA hydrolase +3.1.2.6 Hydroxyacylglutathione hydrolase +3.1.21.- Endodeoxyribonucleases producing 5'-phosphomonoesters. +3.1.21.1 Deoxyribonuclease I +3.1.21.2 Deoxyribonuclease IV (phage-T(4)-induced) +3.1.21.3 Type I site-specific deoxyribonuclease +3.1.21.4 Type II site-specific deoxyribonuclease +3.1.21.5 Type III site-specific deoxyribonuclease +3.1.21.7 Deoxyribonuclease V +3.1.22.- Endodeoxyribonucleases producing other than 5'-phosphomonoesters. +3.1.22.1 Deoxyribonuclease II +3.1.22.4 Crossover junction endodeoxyribonuclease +3.1.25.1 Deoxyribonuclease (pyrimidine dimer) +3.1.26.11 Ribonuclease Z +3.1.26.12 Ribonuclease E +3.1.26.3 Ribonuclease III +3.1.26.4 Ribonuclease H +3.1.26.5 Ribonuclease P +3.1.26.8 Ribonuclease M5 +3.1.27.- Endoribonucleases producing other than 5'-phosphomonoesters. +3.1.27.3 Ribonuclease T(1) +3.1.27.6 Enterobacter ribonuclease +3.1.27.9 tRNA-intron endonuclease +3.1.3.- Phosphoric monoester hydrolases. +3.1.3.1 Alkaline phosphatase +3.1.3.10 Glucose-1-phosphatase +3.1.3.11 Fructose-bisphosphatase +3.1.3.12 Trehalose-phosphatase +3.1.3.15 Histidinol-phosphatase +3.1.3.16 Phosphoprotein phosphatase +3.1.3.18 Phosphoglycolate phosphatase +3.1.3.2 Acid phosphatase +3.1.3.24 Sucrose-phosphate phosphatase +3.1.3.25 Inositol-phosphate phosphatase +3.1.3.26 4-phytase +3.1.3.27 Phosphatidylglycerophosphatase +3.1.3.3 Phosphoserine phosphatase +3.1.3.37 Sedoheptulose-bisphosphatase +3.1.3.41 4-nitrophenylphosphatase +3.1.3.45 3-deoxy-manno-octulosonate-8-phosphatase +3.1.3.46 Fructose-2,6-bisphosphate 2-phosphatase +3.1.3.48 Protein-tyrosine-phosphatase +3.1.3.5 5'-nucleotidase +3.1.3.68 2-deoxyglucose-6-phosphatase +3.1.3.69 Glucosylglycerol 3-phosphatase +3.1.3.7 3'(2'),5'-bisphosphate nucleotidase +3.1.3.70 Mannosyl-3-phosphoglycerate phosphatase +3.1.3.71 2-phosphosulfolactate phosphatase +3.1.3.73 Adenosylcobalamin/alpha-ribazole phosphatase +3.1.3.74 Pyridoxal phosphatase +3.1.3.77 Acireductone synthase +3.1.3.8 3-phytase +3.1.3.85 Glucosyl-3-phosphoglycerate phosphatase +3.1.3.87 2-hydroxy-3-keto-5-methylthiopentenyl-1-phosphate phosphatase +3.1.30.- Endoribonucleases active with either ribo- or deoxyribonucleic acid and producing 5'-phosphomonoesters. +3.1.30.1 Aspergillus nuclease S(1) +3.1.30.2 Serratia marcescens nuclease +3.1.31.1 Micrococcal nuclease +3.1.4.- Phosphoric diester hydrolases. +3.1.4.1 Phosphodiesterase I +3.1.4.12 Sphingomyelin phosphodiesterase +3.1.4.14 [Acyl-carrier-protein] phosphodiesterase +3.1.4.16 2',3'-cyclic-nucleotide 2'-phosphodiesterase +3.1.4.17 3',5'-cyclic-nucleotide phosphodiesterase +3.1.4.3 Phospholipase C +3.1.4.37 2',3'-cyclic-nucleotide 3'-phosphodiesterase +3.1.4.4 Phospholipase D +3.1.4.46 Glycerophosphodiester phosphodiesterase +3.1.5.1 dGTPase +3.1.6.- Sulfuric ester hydrolases. +3.1.6.1 Arylsulfatase +3.1.6.13 Iduronate-2-sulfatase +3.1.6.14 N-acetylglucosamine-6-sulfatase +3.1.6.2 Steryl-sulfatase +3.1.6.6 Choline-sulfatase +3.1.7.2 Guanosine-3',5'-bis(diphosphate) 3'-diphosphatase +3.1.8.1 Aryldialkylphosphatase +3.11.1.1 Phosphonoacetaldehyde hydrolase +3.11.1.2 Phosphonoacetate hydrolase +3.11.1.3 Phosphonopyruvate hydrolase +3.13.1.1 UDP-sulfoquinovose synthase +3.2.-.- Glycosylases. +3.2.1.- Glycosidases, i.e. enzymes hydrolyzing O- and S-glycosyl compounds. +3.2.1.1 Alpha-amylase +3.2.1.10 Oligo-1,6-glucosidase +3.2.1.11 Dextranase +3.2.1.122 Maltose-6'-phosphate glucosidase +3.2.1.123 Endoglycosylceramidase +3.2.1.132 Chitosanase +3.2.1.133 Glucan 1,4-alpha-maltohydrolase +3.2.1.135 Neopullulanase +3.2.1.139 Alpha-glucuronidase +3.2.1.14 Chitinase +3.2.1.141 4-alpha-D-((1->4)-alpha-D-glucano)trehalose trehalohydrolase +3.2.1.15 Polygalacturonase +3.2.1.17 Lysozyme +3.2.1.18 Exo-alpha-sialidase +3.2.1.2 Beta-amylase +3.2.1.20 Alpha-glucosidase +3.2.1.21 Beta-glucosidase +3.2.1.22 Alpha-galactosidase +3.2.1.23 Beta-galactosidase +3.2.1.24 Alpha-mannosidase +3.2.1.25 Beta-mannosidase +3.2.1.26 Beta-fructofuranosidase +3.2.1.28 Alpha,alpha-trehalase +3.2.1.3 Glucan 1,4-alpha-glucosidase +3.2.1.31 Beta-glucuronidase +3.2.1.35 Hyaluronoglucosaminidase +3.2.1.37 Xylan 1,4-beta-xylosidase +3.2.1.38 Beta-D-fucosidase +3.2.1.39 Glucan endo-1,3-beta-D-glucosidase +3.2.1.4 Cellulase +3.2.1.40 Alpha-L-rhamnosidase +3.2.1.41 Pullulanase +3.2.1.46 Galactosylceramidase +3.2.1.49 Alpha-N-acetylgalactosaminidase +3.2.1.50 Alpha-N-acetylglucosaminidase +3.2.1.51 Alpha-L-fucosidase +3.2.1.52 Beta-N-acetylhexosaminidase +3.2.1.55 Alpha-N-arabinofuranosidase +3.2.1.58 Glucan 1,3-beta-glucosidase +3.2.1.6 Endo-1,3(4)-beta-glucanase +3.2.1.61 Mycodextranase +3.2.1.65 Levanase +3.2.1.70 Glucan 1,6-alpha-glucosidase +3.2.1.73 Licheninase +3.2.1.76 L-iduronidase +3.2.1.78 Mannan endo-1,4-beta-mannosidase +3.2.1.8 Endo-1,4-beta-xylanase +3.2.1.80 Fructan beta-fructosidase +3.2.1.81 Beta-agarase +3.2.1.82 Exo-poly-alpha-galacturonosidase +3.2.1.85 6-phospho-beta-galactosidase +3.2.1.86 6-phospho-beta-glucosidase +3.2.1.89 Arabinogalactan endo-beta-1,4-galactanase +3.2.1.91 Cellulose 1,4-beta-cellobiosidase (non-reducing end) +3.2.1.93 Alpha,alpha-phosphotrehalase +3.2.1.94 Glucan 1,6-alpha-isomaltosidase +3.2.1.96 Mannosyl-glycoprotein endo-beta-N-acetylglucosaminidase +3.2.1.99 Arabinan endo-1,5-alpha-L-arabinosidase +3.2.2.- Hydrolyzing N-glycosyl compounds. +3.2.2.1 Purine nucleosidase +3.2.2.16 Methylthioadenosine nucleosidase +3.2.2.20 DNA-3-methyladenine glycosylase I +3.2.2.21 DNA-3-methyladenine glycosylase II +3.2.2.22 rRNA N-glycosylase +3.2.2.23 DNA-formamidopyrimidine glycosylase +3.2.2.24 ADP-ribosyl-[dinitrogen reductase] hydrolase +3.2.2.4 AMP nucleosidase +3.2.2.5 NAD(+) nucleosidase +3.2.2.9 Adenosylhomocysteine nucleosidase +3.3.1.1 Adenosylhomocysteinase +3.3.2.1 Isochorismatase +3.3.2.10 Soluble epoxide hydrolase +3.3.2.3 Transferred entry: 3.3.2.9 and 3.3.2.10 +3.3.2.8 Limonene-1,2-epoxide hydrolase +3.3.2.9 Microsomal epoxide hydrolase +3.4.-.- Acting on peptide bonds (peptide hydrolases). +3.4.11.- Aminopeptidases. +3.4.11.1 Leucyl aminopeptidase +3.4.11.10 Bacterial leucyl aminopeptidase +3.4.11.14 Cytosol alanyl aminopeptidase +3.4.11.15 Aminopeptidase Y +3.4.11.18 Methionyl aminopeptidase +3.4.11.19 D-stereospecific aminopeptidase +3.4.11.2 Membrane alanyl aminopeptidase +3.4.11.21 Aspartyl aminopeptidase +3.4.11.23 PepB aminopeptidase +3.4.11.24 Aminopeptidase S +3.4.11.25 Beta-peptidyl aminopeptidase +3.4.11.4 Tripeptide aminopeptidase +3.4.11.5 Prolyl aminopeptidase +3.4.11.7 Glutamyl aminopeptidase +3.4.11.9 Xaa-Pro aminopeptidase +3.4.13.- Dipeptidases. +3.4.13.19 Membrane dipeptidase +3.4.13.21 Dipeptidase E +3.4.13.22 D-Ala-D-Ala dipeptidase +3.4.13.3 Transferred entry: 3.4.13.18 and 3.4.13.20 +3.4.13.9 Xaa-Pro dipeptidase +3.4.14.10 Tripeptidyl-peptidase II +3.4.14.11 Xaa-Pro dipeptidyl-peptidase +3.4.14.4 Dipeptidyl-peptidase III +3.4.15.1 Peptidyl-dipeptidase A +3.4.15.5 Peptidyl-dipeptidase Dcp +3.4.15.6 Cyanophycinase +3.4.16.4 Serine-type D-Ala-D-Ala carboxypeptidase +3.4.17.- Metallocarboxypeptidases. +3.4.17.1 Carboxypeptidase A +3.4.17.11 Glutamate carboxypeptidase +3.4.17.13 Muramoyltetrapeptide carboxypeptidase +3.4.17.14 Zinc D-Ala-D-Ala carboxypeptidase +3.4.17.18 Carboxypeptidase T +3.4.17.19 Carboxypeptidase Taq +3.4.17.2 Carboxypeptidase B +3.4.17.21 Glutamate carboxypeptidase II +3.4.19.- Omega peptidases. +3.4.19.1 Acylaminoacyl-peptidase +3.4.19.11 Gamma-D-glutamyl-meso-diaminopimelate peptidase +3.4.19.3 Pyroglutamyl-peptidase I +3.4.19.5 Beta-aspartyl-peptidase +3.4.21.- Serine endopeptidases. +3.4.21.1 Chymotrypsin +3.4.21.101 Xanthomonalisin +3.4.21.102 C-terminal processing peptidase +3.4.21.12 Alpha-lytic endopeptidase +3.4.21.19 Glutamyl endopeptidase +3.4.21.22 Coagulation factor IXa +3.4.21.26 Prolyl oligopeptidase +3.4.21.4 Trypsin +3.4.21.50 Lysyl endopeptidase +3.4.21.53 Endopeptidase La +3.4.21.62 Subtilisin +3.4.21.75 Furin +3.4.21.82 Glutamyl endopeptidase II +3.4.21.83 Oligopeptidase B +3.4.21.88 Repressor lexA +3.4.21.89 Signal peptidase I +3.4.21.92 Endopeptidase Clp +3.4.21.96 Lactocepin +3.4.22.- Cysteine endopeptidases. +3.4.22.10 Streptopain +3.4.22.40 Bleomycin hydrolase +3.4.22.48 Staphopain +3.4.22.8 Clostripain +3.4.23.1 Pepsin A +3.4.23.19 Aspergillopepsin II +3.4.23.36 Signal peptidase II +3.4.23.42 Thermopsin +3.4.23.43 Prepilin peptidase +3.4.23.49 Omptin +3.4.24.- Metalloendopeptidases. +3.4.24.13 IgA-specific metalloendopeptidase +3.4.24.15 Thimet oligopeptidase +3.4.24.23 Matrilysin +3.4.24.25 Vibriolysin +3.4.24.26 Pseudolysin +3.4.24.27 Thermolysin +3.4.24.28 Bacillolysin +3.4.24.29 Aureolysin +3.4.24.3 Microbial collagenase +3.4.24.32 Beta-lytic metalloendopeptidase +3.4.24.36 Leishmanolysin +3.4.24.55 Pitrilysin +3.4.24.64 Mitochondrial processing peptidase +3.4.24.69 Bontoxilysin +3.4.24.70 Oligopeptidase A +3.4.24.71 Endothelin-converting enzyme 1 +3.4.24.75 Lysostaphin +3.4.24.77 Snapalysin +3.4.24.78 GPR endopeptidase +3.4.24.84 Ste24 endopeptidase +3.4.25.- Threonine endopeptidases. +3.4.25.1 Proteasome endopeptidase complex +3.4.99.- Endopeptidases of unknown catalytic mechanism. +3.5.-.- Acting on carbon-nitrogen bonds, other than peptide bonds. +3.5.1.- In linear amides. +3.5.1.1 Asparaginase +3.5.1.10 Formyltetrahydrofolate deformylase +3.5.1.108 UDP-3-O-acyl-N-acetylglucosamine deacetylase +3.5.1.11 Penicillin amidase +3.5.1.14 Aminoacylase +3.5.1.15 Aspartoacylase +3.5.1.16 Acetylornithine deacetylase +3.5.1.18 Succinyl-diaminopimelate desuccinylase +3.5.1.19 Nicotinamidase +3.5.1.2 Glutaminase +3.5.1.24 Choloylglycine hydrolase +3.5.1.25 N-acetylglucosamine-6-phosphate deacetylase +3.5.1.26 N(4)-(beta-N-acetylglucosaminyl)-L-asparaginase +3.5.1.28 N-acetylmuramoyl-L-alanine amidase +3.5.1.29 2-(acetamidomethylene)succinate hydrolase +3.5.1.30 5-aminopentanamidase +3.5.1.32 Hippurate hydrolase +3.5.1.4 Amidase +3.5.1.41 Chitin deacetylase +3.5.1.46 6-aminohexanoate-dimer hydrolase +3.5.1.47 N-acetyldiaminopimelate deacetylase +3.5.1.48 Acetylspermidine deacetylase +3.5.1.49 Formamidase +3.5.1.5 Urease +3.5.1.53 N-carbamoylputrescine amidase +3.5.1.54 Allophanate hydrolase +3.5.1.59 N-carbamoylsarcosine amidase +3.5.1.6 Beta-ureidopropionase +3.5.1.68 N-formylglutamate deformylase +3.5.1.7 Ureidosuccinase +3.5.1.77 N-carbamoyl-D-amino-acid hydrolase +3.5.1.78 Glutathionylspermidine amidase +3.5.1.81 N-acyl-D-amino-acid deacylase +3.5.1.83 N-acyl-D-aspartate deacylase +3.5.1.87 N-carbamoyl-L-amino-acid hydrolase +3.5.1.88 Peptide deformylase +3.5.1.9 Arylformamidase +3.5.1.90 Adenosylcobinamide hydrolase +3.5.1.93 Glutaryl-7-aminocephalosporanic-acid acylase +3.5.1.94 Gamma-glutamyl-gamma-aminobutyrate hydrolase +3.5.1.96 Succinylglutamate desuccinylase +3.5.2.- In cyclic amides. +3.5.2.1 Barbiturase +3.5.2.10 Creatininase +3.5.2.12 6-aminohexanoate-cyclic-dimer hydrolase +3.5.2.14 N-methylhydantoinase (ATP-hydrolyzing) +3.5.2.15 Cyanuric acid amidohydrolase +3.5.2.17 Hydroxyisourate hydrolase +3.5.2.2 Dihydropyrimidinase +3.5.2.3 Dihydroorotase +3.5.2.5 Allantoinase +3.5.2.6 Beta-lactamase +3.5.2.7 Imidazolonepropionase +3.5.2.9 5-oxoprolinase (ATP-hydrolyzing) +3.5.3.- In linear amidines. +3.5.3.1 Arginase +3.5.3.11 Agmatinase +3.5.3.12 Agmatine deiminase +3.5.3.13 Formimidoylglutamate deiminase +3.5.3.15 Protein-arginine deiminase +3.5.3.18 Dimethylargininase +3.5.3.19 Ureidoglycolate hydrolase +3.5.3.23 N-succinylarginine dihydrolase +3.5.3.3 Creatinase +3.5.3.4 Allantoicase +3.5.3.6 Arginine deiminase +3.5.3.7 Guanidinobutyrase +3.5.3.8 Formimidoylglutamase +3.5.3.9 Allantoate deiminase +3.5.4.- In cyclic amidines. +3.5.4.1 Cytosine deaminase +3.5.4.10 IMP cyclohydrolase +3.5.4.12 dCMP deaminase +3.5.4.13 dCTP deaminase +3.5.4.16 GTP cyclohydrolase I +3.5.4.19 Phosphoribosyl-AMP cyclohydrolase +3.5.4.2 Adenine deaminase +3.5.4.22 1-pyrroline-4-hydroxy-2-carboxylate deaminase +3.5.4.25 GTP cyclohydrolase II +3.5.4.26 Diaminohydroxyphosphoribosylaminopyrimidine deaminase +3.5.4.27 Methenyltetrahydromethanopterin cyclohydrolase +3.5.4.28 S-adenosylhomocysteine deaminase +3.5.4.29 GTP cyclohydrolase IIa +3.5.4.3 Guanine deaminase +3.5.4.30 dCTP deaminase (dUMP-forming) +3.5.4.4 Adenosine deaminase +3.5.4.5 Cytidine deaminase +3.5.4.9 Methenyltetrahydrofolate cyclohydrolase +3.5.5.1 Nitrilase +3.5.5.7 Aliphatic nitrilase +3.5.5.8 Thiocyanate hydrolase +3.5.99.2 Aminopyrimidine aminohydrolase +3.5.99.3 Hydroxydechloroatrazine ethylaminohydrolase +3.5.99.5 2-aminomuconate deaminase +3.5.99.6 Glucosamine-6-phosphate deaminase +3.5.99.7 1-aminocyclopropane-1-carboxylate deaminase +3.6.-.- Acting on acid anhydrides. +3.6.1.- In phosphorous-containing anhydrides. +3.6.1.1 Inorganic diphosphatase +3.6.1.11 Exopolyphosphatase +3.6.1.13 ADP-ribose diphosphatase +3.6.1.15 Nucleoside-triphosphatase +3.6.1.17 Bis(5'-nucleosyl)-tetraphosphatase (asymmetrical) +3.6.1.18 FAD diphosphatase +3.6.1.22 NAD(+) diphosphatase +3.6.1.23 dUTP diphosphatase +3.6.1.26 CDP-diacylglycerol diphosphatase +3.6.1.27 Undecaprenyl-diphosphate phosphatase +3.6.1.3 Adenosinetriphosphatase +3.6.1.31 Phosphoribosyl-ATP diphosphatase +3.6.1.40 Guanosine-5'-triphosphate,3'-diphosphate diphosphatase +3.6.1.41 Bis(5'-nucleosyl)-tetraphosphatase (symmetrical) +3.6.1.45 UDP-sugar diphosphatase +3.6.1.5 Apyrase +3.6.1.54 UDP-2,3-diacylglucosamine diphosphatase +3.6.1.7 Acylphosphatase +3.6.1.8 ATP diphosphatase +3.6.1.9 Nucleotide diphosphatase +3.6.3.- Acting on acid anhydrides, catalyzing transmembrane movement of substances. +3.6.3.12 Potassium-transporting ATPase +3.6.3.14 H(+)-transporting two-sector ATPase +3.6.3.16 Arsenite-transporting ATPase +3.6.3.17 Monosaccharide-transporting ATPase +3.6.3.19 Maltose-transporting ATPase +3.6.3.2 Magnesium-importing ATPase +3.6.3.25 Sulfate-transporting ATPase +3.6.3.27 Phosphate-transporting ATPase +3.6.3.3 Cadmium-exporting ATPase +3.6.3.30 Fe(3+)-transporting ATPase +3.6.3.32 Quaternary-amine-transporting ATPase +3.6.3.38 Capsular-polysaccharide-transporting ATPase +3.6.3.4 Copper-exporting ATPase +3.6.3.40 Teichoic-acid-transporting ATPase +3.6.3.42 Beta-glucan-transporting ATPase +3.6.3.44 Xenobiotic-transporting ATPase +3.6.3.5 Zinc-exporting ATPase +3.6.3.6 Proton-exporting ATPase +3.6.3.8 Calcium-transporting ATPase +3.6.4.12 DNA helicase +3.6.4.13 RNA helicase +3.6.4.6 Vesicle-fusing ATPase +3.7.1.- In ketonic substances. +3.7.1.2 Fumarylacetoacetase +3.7.1.3 Kynureninase +3.7.1.5 Acylpyruvate hydrolase +3.7.1.9 2-hydroxymuconate-semialdehyde hydrolase +3.8.1.- In C-halide compounds. +3.8.1.1 Alkylhalidase +3.8.1.2 (S)-2-haloacid dehalogenase +3.8.1.3 Haloacetate dehalogenase +3.8.1.5 Haloalkane dehalogenase +4.-.-.- Lyases. +4.1.1.- Carboxy-lyases. +4.1.1.1 Pyruvate decarboxylase +4.1.1.11 Aspartate 1-decarboxylase +4.1.1.12 Aspartate 4-decarboxylase +4.1.1.15 Glutamate decarboxylase +4.1.1.17 Ornithine decarboxylase +4.1.1.18 Lysine decarboxylase +4.1.1.19 Arginine decarboxylase +4.1.1.2 Oxalate decarboxylase +4.1.1.20 Diaminopimelate decarboxylase +4.1.1.21 Phosphoribosylaminoimidazole carboxylase +4.1.1.22 Histidine decarboxylase +4.1.1.23 Orotidine-5'-phosphate decarboxylase +4.1.1.25 Tyrosine decarboxylase +4.1.1.28 Aromatic-L-amino-acid decarboxylase +4.1.1.3 Oxaloacetate decarboxylase +4.1.1.31 Phosphoenolpyruvate carboxylase +4.1.1.32 Phosphoenolpyruvate carboxykinase (GTP) +4.1.1.33 Diphosphomevalonate decarboxylase +4.1.1.35 UDP-glucuronate decarboxylase +4.1.1.36 Phosphopantothenoylcysteine decarboxylase +4.1.1.37 Uroporphyrinogen decarboxylase +4.1.1.39 Ribulose-bisphosphate carboxylase +4.1.1.4 Acetoacetate decarboxylase +4.1.1.41 Methylmalonyl-CoA decarboxylase +4.1.1.44 4-carboxymuconolactone decarboxylase +4.1.1.45 Aminocarboxymuconate-semialdehyde decarboxylase +4.1.1.47 Tartronate-semialdehyde synthase +4.1.1.48 Indole-3-glycerol-phosphate synthase +4.1.1.49 Phosphoenolpyruvate carboxykinase (ATP) +4.1.1.5 Acetolactate decarboxylase +4.1.1.50 Adenosylmethionine decarboxylase +4.1.1.51 3-hydroxy-2-methylpyridine-4,5-dicarboxylate 4-decarboxylase +4.1.1.55 4,5-dihydroxyphthalate decarboxylase +4.1.1.65 Phosphatidylserine decarboxylase +4.1.1.68 5-oxopent-3-ene-1,2,5-tricarboxylate decarboxylase +4.1.1.7 Benzoylformate decarboxylase +4.1.1.70 Glutaconyl-CoA decarboxylase +4.1.1.73 Tartrate decarboxylase +4.1.1.74 Indolepyruvate decarboxylase +4.1.1.76 Arylmalonate decarboxylase +4.1.1.77 2-oxo-3-hexenedioate decarboxylase +4.1.1.79 Sulfopyruvate decarboxylase +4.1.1.8 Oxalyl-CoA decarboxylase +4.1.1.81 Threonine-phosphate decarboxylase +4.1.1.82 Phosphonopyruvate decarboxylase +4.1.1.85 3-dehydro-L-gulonate-6-phosphate decarboxylase +4.1.1.86 Diaminobutyrate decarboxylase +4.1.1.9 Malonyl-CoA decarboxylase +4.1.1.96 Carboxynorspermidine decarboxylase +4.1.2.- Aldehyde-lyases. +4.1.2.13 Fructose-bisphosphate aldolase +4.1.2.14 2-dehydro-3-deoxy-phosphogluconate aldolase +4.1.2.17 L-fuculose-phosphate aldolase +4.1.2.19 Rhamnulose-1-phosphate aldolase +4.1.2.20 2-dehydro-3-deoxyglucarate aldolase +4.1.2.21 2-dehydro-3-deoxy-6-phosphogalactonate aldolase +4.1.2.22 Fructose-6-phosphate phosphoketolase +4.1.2.25 Dihydroneopterin aldolase +4.1.2.27 Sphinganine-1-phosphate aldolase +4.1.2.29 5-dehydro-2-deoxyphosphogluconate aldolase +4.1.2.4 Deoxyribose-phosphate aldolase +4.1.2.40 Tagatose-bisphosphate aldolase +4.1.2.43 3-hexulose-6-phosphate synthase +4.1.2.48 Low-specificity L-threonine aldolase +4.1.2.49 L-allo-threonine aldolase +4.1.2.5 L-threonine aldolase +4.1.2.50 6-carboxytetrahydropterin synthase +4.1.2.9 Phosphoketolase +4.1.3.- Oxo-acid-lyases. +4.1.3.1 Isocitrate lyase +4.1.3.16 4-hydroxy-2-oxoglutarate aldolase +4.1.3.17 4-hydroxy-4-methyl-2-oxoglutarate aldolase +4.1.3.24 Malyl-CoA lyase +4.1.3.27 Anthranilate synthase +4.1.3.3 N-acetylneuraminate lyase +4.1.3.30 Methylisocitrate lyase +4.1.3.36 1,4-dihydroxy-2-naphthoyl-CoA synthase +4.1.3.38 Aminodeoxychorismate lyase +4.1.3.39 4-hydroxy-2-oxovalerate aldolase +4.1.3.4 Hydroxymethylglutaryl-CoA lyase +4.1.3.40 Chorismate lyase +4.1.3.6 Citrate (pro-3S)-lyase +4.1.99.- Other carbon-carbon lyases. +4.1.99.1 Tryptophanase +4.1.99.11 Benzylsuccinate synthase +4.1.99.12 3,4-dihydroxy-2-butanone-4-phosphate synthase +4.1.99.17 Phosphomethylpyrimidine synthase +4.1.99.19 2-iminoacetate synthase +4.1.99.3 Deoxyribodipyrimidine photo-lyase +4.1.99.5 Octadecanal decarbonylase +4.2.-.- Carbon-oxygen lyases. +4.2.1.- Hydro-lyases. +4.2.1.1 Carbonate dehydratase +4.2.1.10 3-dehydroquinate dehydratase +4.2.1.104 Cyanase +4.2.1.106 Bile-acid 7-alpha-dehydratase +4.2.1.109 Methylthioribulose 1-phosphate dehydratase +4.2.1.11 Phosphopyruvate hydratase +4.2.1.113 o-succinylbenzoate synthase +4.2.1.115 UDP-N-acetylglucosamine 4,6-dehydratase (inverting) +4.2.1.12 Phosphogluconate dehydratase +4.2.1.17 Enoyl-CoA hydratase +4.2.1.18 Methylglutaconyl-CoA hydratase +4.2.1.19 Imidazoleglycerol-phosphate dehydratase +4.2.1.2 Fumarate hydratase +4.2.1.20 Tryptophan synthase +4.2.1.22 Cystathionine beta-synthase +4.2.1.24 Porphobilinogen synthase +4.2.1.25 L-arabinonate dehydratase +4.2.1.28 Propanediol dehydratase +4.2.1.3 Aconitate hydratase +4.2.1.30 Glycerol dehydratase +4.2.1.32 L(+)-tartrate dehydratase +4.2.1.33 3-isopropylmalate dehydratase +4.2.1.36 Homoaconitate hydratase +4.2.1.39 Gluconate dehydratase +4.2.1.40 Glucarate dehydratase +4.2.1.41 5-dehydro-4-deoxyglucarate dehydratase +4.2.1.42 Galactarate dehydratase +4.2.1.43 2-dehydro-3-deoxy-L-arabinonate dehydratase +4.2.1.44 Myo-inosose-2 dehydratase +4.2.1.45 CDP-glucose 4,6-dehydratase +4.2.1.46 dTDP-glucose 4,6-dehydratase +4.2.1.47 GDP-mannose 4,6-dehydratase +4.2.1.49 Urocanate hydratase +4.2.1.5 Arabinonate dehydratase +4.2.1.51 Prephenate dehydratase +4.2.1.52 Transferred entry: 4.3.3.7 +4.2.1.53 Oleate hydratase +4.2.1.55 3-hydroxybutyryl-CoA dehydratase +4.2.1.59 3-hydroxyacyl-[acyl-carrier-protein] dehydratase +4.2.1.6 Galactonate dehydratase +4.2.1.60 Transferred entry: 4.2.1.59 +4.2.1.61 Transferred entry: 4.2.1.59 +4.2.1.68 L-fuconate dehydratase +4.2.1.7 Altronate dehydratase +4.2.1.70 Pseudouridylate synthase +4.2.1.75 Uroporphyrinogen-III synthase +4.2.1.79 2-methylcitrate dehydratase +4.2.1.8 Mannonate dehydratase +4.2.1.80 2-oxopent-4-enoate hydratase +4.2.1.82 Xylonate dehydratase +4.2.1.83 4-oxalmesaconate hydratase +4.2.1.84 Nitrile hydratase +4.2.1.9 Dihydroxy-acid dehydratase +4.2.1.90 L-rhamnonate dehydratase +4.2.1.91 Arogenate dehydratase +4.2.1.96 4a-hydroxytetrahydrobiopterin dehydratase +4.2.1.99 2-methylisocitrate dehydratase +4.2.2.- Acting on polysaccharides. +4.2.2.1 Hyaluronate lyase +4.2.2.10 Pectin lyase +4.2.2.11 Poly(alpha-L-guluronate) lyase +4.2.2.17 Inulin fructotransferase (DFA-I-forming) +4.2.2.2 Pectate lyase +4.2.2.3 Poly(beta-D-mannuronate) lyase +4.2.2.5 Chondroitin AC lyase +4.2.2.6 Oligogalacturonide lyase +4.2.2.7 Heparin lyase +4.2.2.9 Pectate disaccharide-lyase +4.2.3.- Acting on phosphates. +4.2.3.1 Threonine synthase +4.2.3.12 6-pyruvoyltetrahydropterin synthase +4.2.3.130 Tetraprenyl-beta-curcumene synthase +4.2.3.22 Germacradienol synthase +4.2.3.3 Methylglyoxal synthase +4.2.3.4 3-dehydroquinate synthase +4.2.3.5 Chorismate synthase +4.2.3.7 Pentalenene synthase +4.2.99.18 DNA-(apurinic or apyrimidinic site) lyase +4.2.99.20 2-succinyl-6-hydroxy-2,4-cyclohexadiene-1-carboxylate synthase +4.3.1.- Ammonia-lyases. +4.3.1.1 Aspartate ammonia-lyase +4.3.1.12 Ornithine cyclodeaminase +4.3.1.14 3-aminobutyryl-CoA ammonia-lyase +4.3.1.15 Diaminopropionate ammonia-lyase +4.3.1.17 L-serine ammonia-lyase +4.3.1.18 D-serine ammonia-lyase +4.3.1.19 Threonine ammonia-lyase +4.3.1.2 Methylaspartate ammonia-lyase +4.3.1.3 Histidine ammonia-lyase +4.3.1.4 Formimidoyltetrahydrofolate cyclodeaminase +4.3.1.7 Ethanolamine ammonia-lyase +4.3.2.1 Argininosuccinate lyase +4.3.2.2 Adenylosuccinate lyase +4.3.3.2 Strictosidine synthase +4.3.3.7 4-hydroxy-tetrahydrodipicolinate synthase +4.4.1.1 Cystathionine gamma-lyase +4.4.1.11 Methionine gamma-lyase +4.4.1.15 D-cysteine desulfhydrase +4.4.1.19 Phosphosulfolactate synthase +4.4.1.2 Homocysteine desulfhydrase +4.4.1.21 S-ribosylhomocysteine lyase +4.4.1.22 S-(hydroxymethyl)glutathione synthase +4.4.1.5 Lactoylglutathione lyase +4.4.1.8 Cystathionine beta-lyase +4.6.1.- Phosphorus-oxygen lyases. +4.6.1.1 Adenylate cyclase +4.6.1.12 2-C-methyl-D-erythritol 2,4-cyclodiphosphate synthase +4.6.1.13 Phosphatidylinositol diacylglycerol-lyase +4.6.1.2 Guanylate cyclase +4.99.1.1 Ferrochelatase +4.99.1.2 Alkylmercury lyase +4.99.1.3 Sirohydrochlorin cobaltochelatase +4.99.1.4 Sirohydrochlorin ferrochelatase +4.99.1.7 Phenylacetaldoxime dehydratase +5.-.-.- Isomerases. +5.1.1.- Acting on amino acids and derivatives. +5.1.1.1 Alanine racemase +5.1.1.11 Phenylalanine racemase (ATP-hydrolyzing) +5.1.1.12 Ornithine racemase +5.1.1.13 Aspartate racemase +5.1.1.17 Isopenicillin-N epimerase +5.1.1.18 Serine racemase +5.1.1.3 Glutamate racemase +5.1.1.4 Proline racemase +5.1.1.7 Diaminopimelate epimerase +5.1.1.8 4-hydroxyproline epimerase +5.1.2.2 Mandelate racemase +5.1.2.3 3-hydroxybutyryl-CoA epimerase +5.1.3.- Acting on carbohydrates and derivatives. +5.1.3.1 Ribulose-phosphate 3-epimerase +5.1.3.12 UDP-glucuronate 5'-epimerase +5.1.3.13 dTDP-4-dehydrorhamnose 3,5-epimerase +5.1.3.14 UDP-N-acetylglucosamine 2-epimerase (non-hydrolyzing) +5.1.3.2 UDP-glucose 4-epimerase +5.1.3.20 ADP-glyceromanno-heptose 6-epimerase +5.1.3.22 L-ribulose-5-phosphate 3-epimerase +5.1.3.3 Aldose 1-epimerase +5.1.3.4 L-ribulose-5-phosphate 4-epimerase +5.1.3.7 UDP-N-acetylglucosamine 4-epimerase +5.1.3.8 N-acylglucosamine 2-epimerase +5.1.3.9 N-acylglucosamine-6-phosphate 2-epimerase +5.1.99.- Acting on other compounds. +5.1.99.1 Methylmalonyl-CoA epimerase +5.1.99.3 Allantoin racemase +5.1.99.4 Alpha-methylacyl-CoA racemase +5.2.-.- Cis-trans-isomerases. +5.2.1.1 Maleate isomerase +5.2.1.2 Maleylacetoacetate isomerase +5.2.1.4 Maleylpyruvate isomerase +5.2.1.8 Peptidylprolyl isomerase +5.3.1.- Interconverting aldoses and ketoses, and related compounds. +5.3.1.1 Triose-phosphate isomerase +5.3.1.12 Glucuronate isomerase +5.3.1.13 Arabinose-5-phosphate isomerase +5.3.1.14 L-rhamnose isomerase +5.3.1.15 D-lyxose ketol-isomerase +5.3.1.16 ((5-phosphoribosylamino)methylideneamino)imidazole-4-carboxamideisomerase +5.3.1.17 5-dehydro-4-deoxy-D-glucuronate isomerase +5.3.1.22 Hydroxypyruvate isomerase +5.3.1.23 S-methyl-5-thioribose-1-phosphate isomerase +5.3.1.24 Phosphoribosylanthranilate isomerase +5.3.1.25 L-fucose isomerase +5.3.1.26 Galactose-6-phosphate isomerase +5.3.1.4 L-arabinose isomerase +5.3.1.5 Xylose isomerase +5.3.1.6 Ribose-5-phosphate isomerase +5.3.1.7 Mannose isomerase +5.3.1.8 Mannose-6-phosphate isomerase +5.3.1.9 Glucose-6-phosphate isomerase +5.3.2.- Interconverting keto- and enol- groups. +5.3.2.5 2,3-diketo-5-methylthiopentyl-1-phosphate enolase +5.3.3.- Transposing C==C bonds. +5.3.3.1 Steroid Delta-isomerase +5.3.3.10 5-carboxymethyl-2-hydroxymuconate Delta-isomerase +5.3.3.2 Isopentenyl-diphosphate Delta-isomerase +5.3.3.3 Vinylacetyl-CoA Delta-isomerase +5.3.3.4 Muconolactone Delta-isomerase +5.3.3.8 Dodecenoyl-CoA isomerase +5.3.4.1 Protein disulfide-isomerase +5.3.99.- Other intramolecular oxidoreductases. +5.4.1.2 Precorrin-8X methylmutase +5.4.2.1 Phosphoglycerate mutase +5.4.2.10 Phosphoglucosamine mutase +5.4.2.2 Phosphoglucomutase +5.4.2.3 Phosphoacetylglucosamine mutase +5.4.2.6 Beta-phosphoglucomutase +5.4.2.7 Phosphopentomutase +5.4.2.8 Phosphomannomutase +5.4.2.9 Phosphoenolpyruvate mutase +5.4.3.2 Lysine 2,3-aminomutase +5.4.3.3 Beta-lysine 5,6-aminomutase +5.4.3.5 D-ornithine 4,5-aminomutase +5.4.3.8 Glutamate-1-semialdehyde 2,1-aminomutase +5.4.4.2 Isochorismate synthase +5.4.99.- Transferring other groups. +5.4.99.1 Methylaspartate mutase +5.4.99.12 tRNA pseudouridine(38-40) synthase +5.4.99.15 (1->4)-alpha-D-glucan 1-alpha-D-glucosylmutase +5.4.99.16 Maltose alpha-D-glucosyltransferase +5.4.99.17 Squalene--hopene cyclase +5.4.99.2 Methylmalonyl-CoA mutase +5.4.99.5 Chorismate mutase +5.4.99.9 UDP-galactopyranose mutase +5.5.1.1 Muconate cycloisomerase +5.5.1.2 3-carboxy-cis,cis-muconate cycloisomerase +5.5.1.4 Inositol-3-phosphate synthase +5.99.1.- Sole sub-subclass for isomerases that do not belong in the other subclasses. +5.99.1.2 DNA topoisomerase +5.99.1.3 DNA topoisomerase (ATP-hydrolyzing) +6.-.-.- Ligases. +6.1.1.1 Tyrosine--tRNA ligase +6.1.1.10 Methionine--tRNA ligase +6.1.1.11 Serine--tRNA ligase +6.1.1.12 Aspartate--tRNA ligase +6.1.1.13 D-alanine--poly(phosphoribitol) ligase +6.1.1.14 Glycine--tRNA ligase +6.1.1.15 Proline--tRNA ligase +6.1.1.16 Cysteine--tRNA ligase +6.1.1.17 Glutamate--tRNA ligase +6.1.1.18 Glutamine--tRNA ligase +6.1.1.19 Arginine--tRNA ligase +6.1.1.2 Tryptophan--tRNA ligase +6.1.1.20 Phenylalanine--tRNA ligase +6.1.1.21 Histidine--tRNA ligase +6.1.1.22 Asparagine--tRNA ligase +6.1.1.23 Aspartate--tRNA(Asn) ligase +6.1.1.24 Glutamate--tRNA(Gln) ligase +6.1.1.26 Pyrrolysine--tRNA(Pyl) ligase +6.1.1.3 Threonine--tRNA ligase +6.1.1.4 Leucine--tRNA ligase +6.1.1.5 Isoleucine--tRNA ligase +6.1.1.6 Lysine--tRNA ligase +6.1.1.7 Alanine--tRNA ligase +6.1.1.9 Valine--tRNA ligase +6.1.2.1 D-alanine--(R)-lactate ligase +6.2.1.- Acid--thiol ligases. +6.2.1.1 Acetate--CoA ligase +6.2.1.12 4-coumarate--CoA ligase +6.2.1.13 Acetate--CoA ligase (ADP-forming) +6.2.1.14 6-carboxyhexanoate--CoA ligase +6.2.1.16 Acetoacetate--CoA ligase +6.2.1.17 Propionate--CoA ligase +6.2.1.19 Long-chain-fatty-acid--luciferin-component ligase +6.2.1.20 Long-chain-fatty-acid--[acyl-carrier-protein] ligase +6.2.1.22 [Citrate (pro-3S)-lyase] ligase +6.2.1.25 Benzoate--CoA ligase +6.2.1.26 o-succinylbenzoate--CoA ligase +6.2.1.3 Long-chain-fatty-acid--CoA ligase +6.2.1.30 Phenylacetate--CoA ligase +6.2.1.32 Anthranilate--CoA ligase +6.2.1.34 Trans-feruloyl-CoA synthase +6.2.1.5 Succinate--CoA ligase (ADP-forming) +6.3.-.- Forming carbon-nitrogen bonds. +6.3.1.- Acid--ammonia (or amide) ligases (amide synthases). +6.3.1.1 Aspartate--ammonia ligase +6.3.1.10 Adenosylcobinamide-phosphate synthase +6.3.1.11 Glutamate--putrescine ligase +6.3.1.12 D-aspartate ligase +6.3.1.2 Glutamate--ammonia ligase +6.3.1.5 NAD(+) synthase +6.3.1.8 Glutathionylspermidine synthase +6.3.2.- Acid--D-amino-acid ligases (peptide synthases). +6.3.2.1 Pantoate--beta-alanine ligase +6.3.2.10 UDP-N-acetylmuramoyl-tripeptide--D-alanyl-D-alanine ligase +6.3.2.12 Dihydrofolate synthase +6.3.2.13 UDP-N-acetylmuramoyl-L-alanyl-D-glutamate--2,6-diaminopimelate ligase +6.3.2.17 Tetrahydrofolate synthase +6.3.2.2 Glutamate--cysteine ligase +6.3.2.26 N-(5-amino-5-carboxypentanoyl)-L-cysteinyl-D-valine synthase +6.3.2.27 Transferred entry: 6.3.2.38 and 6.3.2.39 +6.3.2.29 Cyanophycin synthase (L-aspartate-adding) +6.3.2.3 Glutathione synthase +6.3.2.30 Cyanophycin synthase (L-arginine-adding) +6.3.2.38 N(2)-citryl-N(6)-acetyl-N(6)-hydroxylysine synthase +6.3.2.39 Aerobactin synthase +6.3.2.4 D-alanine--D-alanine ligase +6.3.2.5 Phosphopantothenate--cysteine ligase +6.3.2.6 Phosphoribosylaminoimidazolesuccinocarboxamide synthase +6.3.2.7 UDP-N-acetylmuramoyl-L-alanyl-D-glutamate--L-lysine ligase +6.3.2.8 UDP-N-acetylmuramate--L-alanine ligase +6.3.2.9 UDP-N-acetylmuramoyl-L-alanine--D-glutamate ligase +6.3.3.1 Phosphoribosylformylglycinamidine cyclo-ligase +6.3.3.2 5-formyltetrahydrofolate cyclo-ligase +6.3.3.3 Dethiobiotin synthase +6.3.4.13 Phosphoribosylamine--glycine ligase +6.3.4.14 Biotin carboxylase +6.3.4.15 Biotin--[acetyl-CoA-carboxylase] ligase +6.3.4.19 tRNA(Ile)-lysidine synthetase +6.3.4.2 CTP synthase +6.3.4.3 Formate--tetrahydrofolate ligase +6.3.4.4 Adenylosuccinate synthase +6.3.4.5 Argininosuccinate synthase +6.3.4.6 Urea carboxylase +6.3.5.10 Adenosylcobyric acid synthase (glutamine-hydrolyzing) +6.3.5.2 GMP synthase (glutamine-hydrolyzing) +6.3.5.3 Phosphoribosylformylglycinamidine synthase +6.3.5.4 Asparagine synthase (glutamine-hydrolyzing) +6.3.5.5 Carbamoyl-phosphate synthase (glutamine-hydrolyzing) +6.3.5.6 Asparaginyl-tRNA synthase (glutamine-hydrolyzing) +6.3.5.7 Glutaminyl-tRNA synthase (glutamine-hydrolyzing) +6.3.5.8 Transferred entry: 2.6.1.85 +6.4.-.- Forming carbon-carbon bonds. +6.4.1.1 Pyruvate carboxylase +6.4.1.2 Acetyl-CoA carboxylase +6.4.1.3 Propionyl-CoA carboxylase +6.4.1.4 Methylcrotonoyl-CoA carboxylase +6.4.1.6 Acetone carboxylase +6.5.1.- Ligases that form phosphoric-ester bonds. +6.5.1.1 DNA ligase (ATP) +6.5.1.2 DNA ligase (NAD(+)) +6.5.1.4 RNA-3'-phosphate cyclase +6.6.1.1 Magnesium chelatase +6.6.1.2 Cobaltochelatase diff --git a/tests/example_output/ref_db/ontologies/figfam.txt b/tests/example_output/ref_db/ontologies/figfam.txt new file mode 100644 index 0000000..d2df202 --- /dev/null +++ b/tests/example_output/ref_db/ontologies/figfam.txt @@ -0,0 +1,172119 @@ + Hydroxyethylthiazole kinase (EC 2.7.1.50) +FIG00000001 Cysteine desulfurase (EC 2.8.1.7) +FIG00000004 3-ketoacyl-CoA thiolase (EC 2.3.1.16) @ Acetyl-CoA acetyltransferase (EC 2.3.1.9) +FIG00000011 Multimodular transpeptidase-transglycosylase (EC 2.4.1.129) (EC 3.4.-.-) +FIG00000013 Hydroxyacylglutathione hydrolase (EC 3.1.2.6) +FIG00000015 Signal peptidase I (EC 3.4.21.89) +FIG00000017 Peptide deformylase (EC 3.5.1.88) +FIG00000019 Octaprenyl diphosphate synthase (EC 2.5.1.90) / Dimethylallyltransferase (EC 2.5.1.1) / (2E,6E)-farnesyl diphosphate synthase (EC 2.5.1.10) / Geranylgeranyl pyrophosphate synthetase (EC 2.5.1.29) +FIG00000022 Shikimate 5-dehydrogenase I alpha (EC 1.1.1.25) +FIG00000023 Transaldolase (EC 2.2.1.2) +FIG00000025 Cell division protein FtsW +FIG00000028 ATP-dependent Clp protease proteolytic subunit (EC 3.4.21.92) +FIG00000032 Dihydroorotase (EC 3.5.2.3) +FIG00000036 Methionine aminopeptidase (EC 3.4.11.18) +FIG00000038 Glucosamine--fructose-6-phosphate aminotransferase [isomerizing] (EC 2.6.1.16) +FIG00000039 Translation elongation factor Tu +FIG00000040 Serine hydroxymethyltransferase (EC 2.1.2.1) +FIG00000043 Pyruvate kinase (EC 2.7.1.40) +FIG00000047 Ribulose-phosphate 3-epimerase (EC 5.1.3.1) +FIG00000048 Dihydrofolate reductase (EC 1.5.1.3) +FIG00000053 LSU ribosomal protein L33p @ LSU ribosomal protein L33p, zinc-independent +FIG00000055 Tryptophanyl-tRNA synthetase (EC 6.1.1.2) +FIG00000056 Heat shock protein 60 family chaperone GroEL +FIG00000065 Exodeoxyribonuclease III (EC 3.1.11.2) +FIG00000066 SSU ribosomal protein S14p (S29e) @ SSU ribosomal protein S14p (S29e), zinc-independent +FIG00000069 Prolyl-tRNA synthetase (EC 6.1.1.15), bacterial type +FIG00000070 Chaperone protein DnaJ +FIG00000075 NAD kinase (EC 2.7.1.23) +FIG00000076 Triosephosphate isomerase (EC 5.3.1.1) +FIG00000080 DNA gyrase subunit A (EC 5.99.1.3) +FIG00000081 Lipoprotein signal peptidase (EC 3.4.23.36) +FIG00000082 ATP synthase alpha chain (EC 3.6.3.14) +FIG00000084 Ornithine carbamoyltransferase (EC 2.1.3.3) +FIG00000085 Isoleucyl-tRNA synthetase (EC 6.1.1.5) +FIG00000086 Cysteinyl-tRNA synthetase (EC 6.1.1.16) +FIG00000087 Histidyl-tRNA synthetase (EC 6.1.1.21) +FIG00000088 Arginyl-tRNA synthetase (EC 6.1.1.19) +FIG00000089 Adenylate kinase (EC 2.7.4.3) +FIG00000092 LSU ribosomal protein L31p @ LSU ribosomal protein L31p, zinc-independent +FIG00000093 tRNA pseudouridine synthase A (EC 4.2.1.70) +FIG00000095 Signal recognition particle receptor protein FtsY (=alpha subunit) (TC 3.A.5.1.1) +FIG00000097 Phosphatidate cytidylyltransferase (EC 2.7.7.41) +FIG00000098 Phenylalanyl-tRNA synthetase alpha chain (EC 6.1.1.20) +FIG00000101 Threonyl-tRNA synthetase (EC 6.1.1.3) +FIG00000102 Translation initiation factor 2 +FIG00000103 Heat shock protein GrpE +FIG00000105 Methylenetetrahydrofolate dehydrogenase (NADP+) (EC 1.5.1.5) / Methenyltetrahydrofolate cyclohydrolase (EC 3.5.4.9) +FIG00000106 Dihydrofolate synthase (EC 6.3.2.12) @ Folylpolyglutamate synthase (EC 6.3.2.17) +FIG00000107 Adenylosuccinate synthetase (EC 6.3.4.4) +FIG00000108 UTP--glucose-1-phosphate uridylyltransferase (EC 2.7.7.9) +FIG00000110 Undecaprenyl diphosphate synthase (EC 2.5.1.31) +FIG00000111 Carbamoyl-phosphate synthase large chain (EC 6.3.5.5) +FIG00000112 Methionyl-tRNA formyltransferase (EC 2.1.2.9) +FIG00000113 Signal recognition particle, subunit Ffh SRP54 (TC 3.A.5.1.1) +FIG00000114 Leucyl-tRNA synthetase (EC 6.1.1.4) +FIG00000116 Phenylalanyl-tRNA synthetase beta chain (EC 6.1.1.20) +FIG00000117 Adenylosuccinate lyase (EC 4.3.2.2) +FIG00000118 Enolase (EC 4.2.1.11) +FIG00000121 Seryl-tRNA synthetase (EC 6.1.1.11) +FIG00000122 Aspartate carbamoyltransferase (EC 2.1.3.2) +FIG00000124 Ribosomal large subunit pseudouridine synthase D (EC 4.2.1.70) +FIG00000126 Ribonuclease HII (EC 3.1.26.4) +FIG00000127 SSU ribosomal protein S18p @ SSU ribosomal protein S18p, zinc-independent +FIG00000128 Serine acetyltransferase (EC 2.3.1.30) +FIG00000129 Valyl-tRNA synthetase (EC 6.1.1.9) +FIG00000130 Carbamoyl-phosphate synthase small chain (EC 6.3.5.5) +FIG00000131 Guanylate kinase (EC 2.7.4.8) +FIG00000132 Aspartokinase (EC 2.7.2.4) +FIG00000134 Threonine synthase (EC 4.2.3.1) +FIG00000138 ATP synthase F0 sector subunit a +FIG00000139 Alanyl-tRNA synthetase (EC 6.1.1.7) +FIG00000140 DNA-directed RNA polymerase alpha subunit (EC 2.7.7.6) +FIG00000141 LSU ribosomal protein L7/L12 (P1/P2) +FIG00000143 Translation initiation factor 1 +FIG00000144 SSU ribosomal protein S15p (S13e) +FIG00000145 Cell division protein FtsZ (EC 3.4.24.-) +FIG00000146 Excinuclease ABC subunit B +FIG00000147 Excinuclease ABC subunit A +FIG00000148 SSU ribosomal protein S4p (S9e) +FIG00000149 Phosphoserine phosphatase (EC 3.1.3.3) +FIG00000151 Peptidyl-tRNA hydrolase (EC 3.1.1.29) +FIG00000153 SSU ribosomal protein S8p (S15Ae) +FIG00000154 LSU ribosomal protein L17p +FIG00000155 SSU ribosomal protein S5p (S2e) +FIG00000156 DNA-directed RNA polymerase beta subunit (EC 2.7.7.6) +FIG00000157 2-isopropylmalate synthase (EC 2.3.3.13) +FIG00000159 LSU ribosomal protein L10p (P0) +FIG00000160 SSU ribosomal protein S13p (S18e) +FIG00000163 UDP-N-acetylenolpyruvoylglucosamine reductase (EC 1.1.1.158) +FIG00000164 Ribosome-binding factor A +FIG00000165 Translation elongation factor LepA +FIG00000166 LSU ribosomal protein L15p (L27Ae) +FIG00000168 Transcription termination protein NusA +FIG00000169 GTP-binding protein Obg +FIG00000170 SSU ribosomal protein S6p +FIG00000171 2-amino-4-hydroxy-6-hydroxymethyldihydropteridine pyrophosphokinase (EC 2.7.6.3) +FIG00000172 rRNA small subunit methyltransferase H +FIG00000173 Orotidine 5'-phosphate decarboxylase (EC 4.1.1.23) +FIG00000174 LSU ribosomal protein L5p (L11e) +FIG00000175 Thymidylate kinase (EC 2.7.4.9) +FIG00000176 CTP synthase (EC 6.3.4.2) +FIG00000177 Translation elongation factor P +FIG00000178 SSU ribosomal protein S21p +FIG00000179 Amidophosphoribosyltransferase (EC 2.4.2.14) +FIG00000181 SSU ribosomal protein S17p (S11e) +FIG00000182 LSU ribosomal protein L11p (L12e) +FIG00000184 Putative deoxyribonuclease YcfH +FIG00000185 Excinuclease ABC subunit C +FIG00000186 ATP synthase F0 sector subunit b +FIG00000187 Glucose-1-phosphate thymidylyltransferase (EC 2.7.7.24) +FIG00000188 Peptide chain release factor 1 +FIG00000189 LSU ribosomal protein L27p +FIG00000190 Recombination protein RecR +FIG00000191 Translation elongation factor Ts +FIG00000193 SSU ribosomal protein S16p +FIG00000194 tmRNA-binding protein SmpB +FIG00000195 Phosphoribosylaminoimidazole-succinocarboxamide synthase (EC 6.3.2.6) +FIG00000196 tRNA dimethylallyltransferase (EC 2.5.1.75) +FIG00000198 LSU ribosomal protein L24p (L26e) +FIG00000199 SSU ribosomal protein S19p (S15e) +FIG00000200 LSU ribosomal protein L18p (L5e) +FIG00000202 Ribosome recycling factor +FIG00000203 SSU ribosomal protein S12p (S23e) +FIG00000204 DNA topoisomerase I (EC 5.99.1.2) +FIG00000205 LSU ribosomal protein L9p +FIG00000206 Translation initiation factor 3 +FIG00000207 Cobalt-zinc-cadmium resistance protein +FIG00000208 Ribonuclease III (EC 3.1.26.3) +FIG00000209 SSU ribosomal protein S7p (S5e) +FIG00000210 SSU ribosomal protein S1p +FIG00000211 LSU ribosomal protein L13p (L13Ae) +FIG00000212 Chorismate synthase (EC 4.2.3.5) +FIG00000213 SSU ribosomal protein S20p +FIG00000214 LSU ribosomal protein L19p +FIG00000216 LSU ribosomal protein L20p +FIG00000218 SSU ribosomal protein S3p (S3e) +FIG00000219 LSU ribosomal protein L22p (L17e) +FIG00000220 Riboflavin kinase (EC 2.7.1.26) / FMN adenylyltransferase (EC 2.7.7.2) +FIG00000221 Phospho-N-acetylmuramoyl-pentapeptide-transferase (EC 2.7.8.13) +FIG00000222 Phosphoribosylformylglycinamidine cyclo-ligase (EC 6.3.3.1) +FIG00000223 LSU ribosomal protein L2p (L8e) +FIG00000224 3-dehydroquinate synthase (EC 4.2.3.4) +FIG00000225 SSU rRNA (adenine(1518)-N(6)/adenine(1519)-N(6))-dimethyltransferase (EC 2.1.1.182) +FIG00000226 GTP cyclohydrolase I (EC 3.5.4.16) type 1 +FIG00000227 Phosphoribosylaminoimidazole carboxylase catalytic subunit (EC 4.1.1.21) +FIG00000228 TsaE protein, required for threonylcarbamoyladenosine t(6)A37 formation in tRNA +FIG00000229 LSU ribosomal protein L36p +FIG00000230 tRNA (Guanine37-N1) -methyltransferase (EC 2.1.1.31) +FIG00000231 6,7-dimethyl-8-ribityllumazine synthase (EC 2.5.1.78) +FIG00000233 Metal-dependent hydrolase YbeY, involved in rRNA and/or ribosome maturation and assembly +FIG00000234 RecA protein +FIG00000235 Phosphoribosylamine--glycine ligase (EC 6.3.4.13) +FIG00000241 ATP-dependent Clp protease ATP-binding subunit ClpX +FIG00000242 DNA-directed RNA polymerase beta' subunit (EC 2.7.7.6) +FIG00000243 UDP-N-acetylmuramoylalanyl-D-glutamate--2,6-diaminopimelate ligase (EC 6.3.2.13) +FIG00000244 Ketol-acid reductoisomerase (EC 1.1.1.86) +FIG00000245 Glucose-6-phosphate isomerase (EC 5.3.1.9) +FIG00000247 TsaB protein, required for threonylcarbamoyladenosine (t(6)A) formation in tRNA +FIG00000248 Ribosomal RNA small subunit methyltransferase E (EC 2.1.1.-) +FIG00000249 ATP synthase epsilon chain (EC 3.6.3.14) +FIG00000250 L-lysine permease +FIG00000251 Nucleoside diphosphate kinase (EC 2.7.4.6) +FIG00000252 5-formyltetrahydrofolate cyclo-ligase (EC 6.3.3.2) +FIG00000253 Phosphoribosylglycinamide formyltransferase (EC 2.1.2.2) +FIG00000256 Shikimate kinase I (EC 2.7.1.71) +FIG00000257 tRNA(Ile)-lysidine synthetase (EC 6.3.4.19) +FIG00000258 Imidazole glycerol phosphate synthase cyclase subunit (EC 4.1.3.-) +FIG00000259 LSU ribosomal protein L35p +FIG00000260 rRNA small subunit methyltransferase I +FIG00000261 Phosphopantetheine adenylyltransferase (EC 2.7.7.3) +FIG00000262 ATP synthase delta chain (EC 3.6.3.14) +FIG00000263 LSU ribosomal protein L4p (L1e) +FIG00000264 LSU ribosomal protein L1p (L10Ae) +FIG00000266 LSU ribosomal protein L28p @ LSU ribosomal protein L28p, zinc-independent +FIG00000267 Dephospho-CoA kinase (EC 2.7.1.24) +FIG00000268 GTP-binding protein TypA/BipA +FIG00000269 Transcription antitermination protein NusG +FIG00000271 LSU ribosomal protein L23p (L23Ae) +FIG00000273 Riboflavin synthase eubacterial/eukaryotic (EC 2.5.1.9) +FIG00000274 tRNA-guanine transglycosylase (EC 2.4.2.29) +FIG00000275 IMP cyclohydrolase (EC 3.5.4.10) / Phosphoribosylaminoimidazolecarboxamide formyltransferase (EC 2.1.2.3) +FIG00000276 LSU ribosomal protein L21p +FIG00000277 Adenine phosphoribosyltransferase (EC 2.4.2.7) +FIG00000279 GTPase and tRNA-U34 5-formylation enzyme TrmE +FIG00000280 3-isopropylmalate dehydratase large subunit (EC 4.2.1.33) +FIG00000282 3-isopropylmalate dehydratase small subunit (EC 4.2.1.33) +FIG00000283 DNA repair protein RadA +FIG00000286 Cell division trigger factor (EC 5.2.1.8) +FIG00000287 Cell division protein FtsK +FIG00000288 Transcription elongation factor GreA +FIG00000289 tRNA nucleotidyltransferase (EC 2.7.7.21) (EC 2.7.7.25) +FIG00000290 Endonuclease III (EC 4.2.99.18) +FIG00000291 tRNA-specific adenosine-34 deaminase (EC 3.5.4.-) +FIG00000293 Ribosomal RNA large subunit methyltransferase N (EC 2.1.1.-) +FIG00000296 Glycine cleavage system H protein +FIG00000298 GTP-binding protein EngB +FIG00000300 Lysyl-tRNA synthetase (class II) (EC 6.1.1.6) +FIG00000301 Argininosuccinate synthase (EC 6.3.4.5) +FIG00000303 Histidinol dehydrogenase (EC 1.1.1.23) +FIG00000304 GTP-binding protein HflX +FIG00000306 Putative iron-sulfur cluster assembly scaffold protein for SUF system, SufE2 +FIG00000307 Dihydropteroate synthase (EC 2.5.1.15) +FIG00000308 3'-to-5' exoribonuclease RNase R +FIG00000309 Glycerol-3-phosphate dehydrogenase [NAD(P)+] (EC 1.1.1.94) +FIG00000312 16S rRNA processing protein RimM +FIG00000313 Catalase (EC 1.11.1.6) +FIG00000314 Holliday junction DNA helicase RuvA +FIG00000315 DNA recombination and repair protein RecO +FIG00000317 DNA repair protein RecN +FIG00000319 Malonyl CoA-acyl carrier protein transacylase (EC 2.3.1.39) +FIG00000320 Ubiquinone biosynthesis monooxygenase UbiB +FIG00000323 Exodeoxyribonuclease VII large subunit (EC 3.1.11.6) +FIG00000325 FIG000325: clustered with transcription termination protein NusA +FIG00000328 Methylated-DNA--protein-cysteine methyltransferase (EC 2.1.1.63) +FIG00000329 S-adenosylmethionine synthetase (EC 2.5.1.6) +FIG00000330 Phosphopantothenoylcysteine decarboxylase (EC 4.1.1.36) / Phosphopantothenoylcysteine synthetase (EC 6.3.2.5) +FIG00000332 Glucose-6-phosphate 1-dehydrogenase (EC 1.1.1.49) +FIG00000333 Argininosuccinate lyase (EC 4.3.2.1) +FIG00000334 S-adenosylmethionine:tRNA ribosyltransferase-isomerase (EC 5.-.-.-) +FIG00000335 Twin-arginine translocation protein TatC +FIG00000336 Cytosol aminopeptidase PepA (EC 3.4.11.1) +FIG00000337 Succinyl-CoA ligase [ADP-forming] beta chain (EC 6.2.1.5) +FIG00000338 Glutamate-1-semialdehyde aminotransferase (EC 5.4.3.8) +FIG00000340 Fumarate hydratase class II (EC 4.2.1.2) +FIG00000341 3-isopropylmalate dehydrogenase (EC 1.1.1.85) +FIG00000343 1-deoxy-D-xylulose 5-phosphate synthase (EC 2.2.1.7) +FIG00000345 Ferrochelatase, protoheme ferro-lyase (EC 4.99.1.1) +FIG00000346 Ribosomal protein L11 methyltransferase (EC 2.1.1.-) +FIG00000347 4-hydroxy-tetrahydrodipicolinate reductase (EC 1.17.1.8) +FIG00000348 Porphobilinogen synthase (EC 4.2.1.24) +FIG00000350 D-alanine--D-alanine ligase (EC 6.3.2.4) +FIG00000351 Glutamate 5-kinase (EC 2.7.2.11) / RNA-binding C-terminal domain PUA +FIG00000352 Holliday junction DNA helicase RuvB +FIG00000353 N-acetylglucosamine-1-phosphate uridyltransferase (EC 2.7.7.23) / Glucosamine-1-phosphate N-acetyltransferase (EC 2.3.1.157) +FIG00000355 Hypoxanthine-guanine phosphoribosyltransferase (EC 2.4.2.8) +FIG00000356 DNA mismatch repair protein MutS +FIG00000358 N-acetyl-gamma-glutamyl-phosphate reductase (EC 1.2.1.38) +FIG00000359 Aspartyl-tRNA(Asn) amidotransferase subunit A (EC 6.3.5.6) @ Glutamyl-tRNA(Gln) amidotransferase subunit A (EC 6.3.5.7) +FIG00000362 Lipoate synthase +FIG00000363 Porphobilinogen deaminase (EC 2.5.1.61) +FIG00000364 3-methyl-2-oxobutanoate hydroxymethyltransferase (EC 2.1.2.11) +FIG00000365 Gamma-glutamyl phosphate reductase (EC 1.2.1.41) +FIG00000367 ADP-ribose pyrophosphatase (EC 3.6.1.13) +FIG00000368 dTDP-4-dehydrorhamnose reductase (EC 1.1.1.133) +FIG00000370 Fructose-bisphosphate aldolase class II (EC 4.1.2.13) +FIG00000372 ATP-dependent DNA helicase UvrD/PcrA +FIG00000373 Dihydroneopterin aldolase (EC 4.1.2.25) +FIG00000375 Phosphoribosylaminoimidazole carboxylase ATPase subunit (EC 4.1.1.21) +FIG00000376 L-asparaginase (EC 3.5.1.1) +FIG00000377 4-diphosphocytidyl-2-C-methyl-D-erythritol kinase (EC 2.7.1.148) +FIG00000378 3,4-dihydroxy-2-butanone 4-phosphate synthase (EC 4.1.99.12) / GTP cyclohydrolase II (EC 3.5.4.25) +FIG00000380 DNA mismatch repair protein MutL +FIG00000381 4-hydroxy-3-methylbut-2-enyl diphosphate reductase (EC 1.17.1.2) +FIG00000382 Ribonucleotide reductase transcriptional regulator NrdR +FIG00000383 Acetylglutamate kinase (EC 2.7.2.8) +FIG00000384 Diaminohydroxyphosphoribosylaminopyrimidine deaminase (EC 3.5.4.26) / 5-amino-6-(5-phosphoribosylamino)uracil reductase (EC 1.1.1.193) +FIG00000385 Cell division protein FtsA +FIG00000387 Nicotinate phosphoribosyltransferase (EC 2.4.2.11) +FIG00000388 Deoxyuridine 5'-triphosphate nucleotidohydrolase (EC 3.6.1.23) +FIG00000390 Cytochrome d ubiquinol oxidase subunit II (EC 1.10.3.-) +FIG00000391 Polyribonucleotide nucleotidyltransferase (EC 2.7.7.8) +FIG00000392 Transcription termination factor Rho +FIG00000393 3-hydroxyacyl-[acyl-carrier-protein] dehydratase, FabZ form (EC 4.2.1.59) +FIG00000394 DNA-directed RNA polymerase omega subunit (EC 2.7.7.6) +FIG00000395 A/G-specific adenine glycosylase (EC 3.2.2.-) +FIG00000396 Uracil phosphoribosyltransferase (EC 2.4.2.9) +FIG00000397 Glutamate racemase (EC 5.1.1.3) +FIG00000398 Thymidylate synthase (EC 2.1.1.45) +FIG00000399 Aspartyl-tRNA(Asn) amidotransferase subunit B (EC 6.3.5.6) @ Glutamyl-tRNA(Gln) amidotransferase subunit B (EC 6.3.5.7) +FIG00000401 1-deoxy-D-xylulose 5-phosphate reductoisomerase (EC 1.1.1.267) +FIG00000402 Multi antimicrobial extrusion protein (Na(+)/drug antiporter), MATE family of MDR efflux pumps +FIG00000404 DNA polymerase I (EC 2.7.7.7) +FIG00000405 6-phosphogluconate dehydrogenase, decarboxylating (EC 1.1.1.44) +FIG00000407 Thiamin-phosphate pyrophosphorylase (EC 2.5.1.3) +FIG00000408 dTDP-4-dehydrorhamnose 3,5-epimerase (EC 5.1.3.13) +FIG00000409 LSU ribosomal protein L30p (L7e) +FIG00000411 Biotin carboxyl carrier protein of acetyl-CoA carboxylase +FIG00000412 DNA recombination and repair protein RecF +FIG00000413 Quinolinate phosphoribosyltransferase [decarboxylating] (EC 2.4.2.19) +FIG00000414 DNA polymerase III subunits gamma and tau (EC 2.7.7.7) +FIG00000415 Ribose 5-phosphate isomerase A (EC 5.3.1.6) +FIG00000417 O-acetylhomoserine sulfhydrylase (EC 2.5.1.49) / O-succinylhomoserine sulfhydrylase (EC 2.5.1.48) +FIG00000420 Biotin carboxylase of acetyl-CoA carboxylase (EC 6.3.4.14) +FIG00000421 Diaminopimelate epimerase (EC 5.1.1.7) +FIG00000422 ATP-dependent DNA helicase RecQ +FIG00000423 Dethiobiotin synthetase (EC 6.3.3.3) +FIG00000425 Topoisomerase IV subunit A (EC 5.99.1.-) +FIG00000426 Chemotaxis regulator - transmits chemoreceptor signals to flagelllar motor components CheY +FIG00000428 Uroporphyrinogen III decarboxylase (EC 4.1.1.37) +FIG00000429 Inorganic pyrophosphatase (EC 3.6.1.1) +FIG00000430 3-dehydroquinate dehydratase II (EC 4.2.1.10) +FIG00000432 Aspartyl-tRNA(Asn) amidotransferase subunit C (EC 6.3.5.6) @ Glutamyl-tRNA(Gln) amidotransferase subunit C (EC 6.3.5.7) +FIG00000433 Acetolactate synthase small subunit (EC 2.2.1.6) +FIG00000434 Homoserine dehydrogenase (EC 1.1.1.3) +FIG00000435 Exodeoxyribonuclease VII small subunit (EC 3.1.11.6) +FIG00000437 Acetyl-coenzyme A carboxyl transferase beta chain (EC 6.4.1.2) +FIG00000438 Flagellar motor rotation protein MotA +FIG00000439 Topoisomerase IV subunit B (EC 5.99.1.-) +FIG00000440 Pantoate--beta-alanine ligase (EC 6.3.2.1) +FIG00000441 Chromosomal replication initiator protein DnaA +FIG00000442 Acetyl-coenzyme A carboxyl transferase alpha chain (EC 6.4.1.2) +FIG00000443 5'-methylthioadenosine nucleosidase (EC 3.2.2.16) @ S-adenosylhomocysteine nucleosidase (EC 3.2.2.9) +FIG00000445 Phosphoserine aminotransferase (EC 2.6.1.52) +FIG00000446 Phosphate:acyl-ACP acyltransferase PlsX +FIG00000448 Glycyl-tRNA synthetase beta chain (EC 6.1.1.14) +FIG00000449 1-hydroxy-2-methyl-2-(E)-butenyl 4-diphosphate synthase (EC 1.17.7.1) +FIG00000450 Deoxyribose-phosphate aldolase (EC 4.1.2.4) +FIG00000451 Iron-sulfur cluster assembly protein SufB +FIG00000452 Chemotaxis protein methyltransferase CheR (EC 2.1.1.80) +FIG00000453 5,10-methylenetetrahydrofolate reductase (EC 1.5.1.20) +FIG00000455 Malate dehydrogenase (EC 1.1.1.37) +FIG00000456 Glycerate kinase (EC 2.7.1.31) +FIG00000458 Glycyl-tRNA synthetase alpha chain (EC 6.1.1.14) +FIG00000459 Acyl-phosphate:glycerol-3-phosphate O-acyltransferase PlsY +FIG00000460 Rod shape-determining protein MreC +FIG00000463 Quinolinate synthetase (EC 2.5.1.72) +FIG00000464 Ribosome small subunit-stimulated GTPase EngC +FIG00000465 Lipoate-protein ligase A +FIG00000467 Biotin synthase (EC 2.8.1.6) +FIG00000468 Protein-export membrane protein SecF (TC 3.A.5.1.1) +FIG00000471 LSU ribosomal protein L34p +FIG00000473 D-tyrosyl-tRNA(Tyr) deacylase (EC 3.6.1.n1) +FIG00000474 Histidinol-phosphate aminotransferase (EC 2.6.1.9) +FIG00000475 Dihydroorotate dehydrogenase (EC 1.3.3.1) +FIG00000476 Glycogen phosphorylase (EC 2.4.1.1) +FIG00000477 Type I restriction-modification system, DNA-methyltransferase subunit M (EC 2.1.1.72) +FIG00000479 Zinc uptake regulation protein ZUR +FIG00000480 5-nucleotidase SurE (EC 3.1.3.5) +FIG00000482 UDP-N-acetylglucosamine 2-epimerase (EC 5.1.3.14) +FIG00000487 ATP-dependent protease HslV (EC 3.4.25.-) +FIG00000490 Queuosine Biosynthesis QueE Radical SAM +FIG00000491 Queuosine Biosynthesis QueC ATPase +FIG00000494 Type I restriction-modification system, specificity subunit S (EC 3.1.21.3) +FIG00000497 Heme O synthase, protoheme IX farnesyltransferase (EC 2.5.1.-) COX10-CtaB +FIG00000499 4-hydroxybenzoate polyprenyltransferase (EC 2.5.1.39) +FIG00000502 probable iron binding protein from the HesB_IscA_SufA family +FIG00000503 Cobalt-zinc-cadmium resistance protein CzcD +FIG00000504 Polyphosphate kinase (EC 2.7.4.1) +FIG00000505 ATP-dependent hsl protease ATP-binding subunit HslU +FIG00000507 Formyltetrahydrofolate deformylase (EC 3.5.1.10) +FIG00000508 Acyl-[acyl-carrier-protein]--UDP-N-acetylglucosamine O-acyltransferase (EC 2.3.1.129) +FIG00000510 SOS-response repressor and protease LexA (EC 3.4.21.88) +FIG00000512 NADH-ubiquinone oxidoreductase chain N (EC 1.6.5.3) +FIG00000517 Epoxyqueuosine (oQ) reductase QueG +FIG00000518 Large-conductance mechanosensitive channel +FIG00000519 Septum site-determining protein MinD +FIG00000520 4-hydroxythreonine-4-phosphate dehydrogenase (EC 1.1.1.262) +FIG00000521 rRNA small subunit 7-methylguanosine (m7G) methyltransferase GidB +FIG00000522 Phosphate acetyltransferase (EC 2.3.1.8) +FIG00000524 Enoyl-[acyl-carrier-protein] reductase [NADH] (EC 1.3.1.9) +FIG00000527 Inosine-uridine preferring nucleoside hydrolase (EC 3.2.2.1) +FIG00000528 Octanoate-[acyl-carrier-protein]-protein-N-octanoyltransferase +FIG00000529 Formate dehydrogenase chain D (EC 1.2.1.2) +FIG00000530 Cobyric acid synthase (EC 6.3.5.10) +FIG00000531 Putative stomatin/prohibitin-family membrane protease subunit YbbK +FIG00000532 UDP-glucose dehydrogenase (EC 1.1.1.22) +FIG00000538 Uracil-DNA glycosylase, family 1 +FIG00000539 Glutamate synthase [NADPH] large chain (EC 1.4.1.13) +FIG00000540 Holo-[acyl-carrier protein] synthase (EC 2.7.8.7) +FIG00000541 2-oxoglutarate dehydrogenase E1 component (EC 1.2.4.2) +FIG00000542 Ribonuclease HI (EC 3.1.26.4) +FIG00000544 Heat-inducible transcription repressor HrcA +FIG00000545 Lipid A biosynthesis lauroyl acyltransferase (EC 2.3.1.-) +FIG00000547 Cell division protein MraZ +FIG00000548 3-polyprenyl-4-hydroxybenzoate carboxy-lyase (EC 4.1.1.-) +FIG00000551 L-serine dehydratase, beta subunit (EC 4.3.1.17) / L-serine dehydratase, alpha subunit (EC 4.3.1.17) +FIG00000552 Cell division protein FtsX +FIG00000555 Undecaprenyl-diphosphatase (EC 3.6.1.27) +FIG00000556 2-Keto-3-deoxy-D-manno-octulosonate-8-phosphate synthase (EC 2.5.1.55) +FIG00000557 FIG000557: hypothetical protein co-occurring with RecR +FIG00000558 NADH ubiquinone oxidoreductase chain A (EC 1.6.5.3) +FIG00000559 NADH-ubiquinone oxidoreductase chain K (EC 1.6.5.3) +FIG00000560 Peptide chain release factor 3 +FIG00000563 Thiazole biosynthesis protein ThiG +FIG00000569 NADH-ubiquinone oxidoreductase chain J (EC 1.6.5.3) +FIG00000570 Thiamine-monophosphate kinase (EC 2.7.4.16) +FIG00000571 Signal transduction histidine kinase CheA (EC 2.7.3.-) +FIG00000573 3-polyprenyl-4-hydroxybenzoate carboxy-lyase UbiX (EC 4.1.1.-) +FIG00000575 L-aspartate oxidase (EC 1.4.3.16) +FIG00000576 tRNA uridine 5-carboxymethylaminomethyl modification enzyme GidA +FIG00000578 DNA topoisomerase III (EC 5.99.1.2) +FIG00000580 tRNA dihydrouridine synthase B (EC 1.-.-.-) +FIG00000581 Thiamin biosynthesis protein ThiC +FIG00000582 Homoserine kinase (EC 2.7.1.39) +FIG00000583 RNA-binding protein Hfq +FIG00000584 Nucleoside 5-triphosphatase RdgB (dHAPTP, dITP, XTP-specific) (EC 3.6.1.15) +FIG00000585 Ribonucleotide reductase of class Ia (aerobic), beta subunit (EC 1.17.4.1) +FIG00000586 Flagellar biosynthesis protein FliR +FIG00000587 Flagellar basal-body rod protein FlgC +FIG00000590 NAD synthetase (EC 6.3.1.5) +FIG00000591 4-Hydroxy-2-oxoglutarate aldolase (EC 4.1.3.16) @ 2-dehydro-3-deoxyphosphogluconate aldolase (EC 4.1.2.14) +FIG00000592 NAD(P)HX epimerase / NAD(P)HX dehydratase +FIG00000594 Chaperone protein HtpG +FIG00000595 DNA recombination protein RmuC +FIG00000600 Isocitrate dehydrogenase [NADP] (EC 1.1.1.42) +FIG00000601 Imidazoleglycerol-phosphate dehydratase (EC 4.2.1.19) +FIG00000603 3-deoxy-manno-octulosonate cytidylyltransferase (EC 2.7.7.38) +FIG00000605 FIG000605: protein co-occurring with transport systems (COG1739) +FIG00000606 Ribonucleotide reductase of class Ia (aerobic), alpha subunit (EC 1.17.4.1) +FIG00000610 Flagellar motor switch protein FliG +FIG00000611 Lipid-A-disaccharide synthase (EC 2.4.1.182) +FIG00000614 Ornithine cyclodeaminase (EC 4.3.1.12) +FIG00000615 UDP-3-O-[3-hydroxymyristoyl] N-acetylglucosamine deacetylase (EC 3.5.1.108) +FIG00000616 Lipid IVA 3-deoxy-D-manno-octulosonic acid transferase (EC 2.4.99.12) [often with (EC 2.4.99.13) also] +FIG00000620 Phosphoheptose isomerase (EC 5.3.1.-) +FIG00000621 Iron-sulfur cluster regulator IscR +FIG00000622 Enoyl-CoA hydratase (EC 4.2.1.17) / Delta(3)-cis-delta(2)-trans-enoyl-CoA isomerase (EC 5.3.3.8) / 3-hydroxyacyl-CoA dehydrogenase (EC 1.1.1.35) / 3-hydroxybutyryl-CoA epimerase (EC 5.1.2.3) +FIG00000624 2,3-bisphosphoglycerate-independent phosphoglycerate mutase (EC 5.4.2.1) +FIG00000626 tRNA-specific 2-thiouridylase MnmA +FIG00000629 NAD(P) transhydrogenase subunit beta (EC 1.6.1.2) +FIG00000630 Glutamate N-acetyltransferase (EC 2.3.1.35) / N-acetylglutamate synthase (EC 2.3.1.1) +FIG00000633 Deoxyribodipyrimidine photolyase (EC 4.1.99.3) +FIG00000635 MG(2+) CHELATASE FAMILY PROTEIN / ComM-related protein +FIG00000636 Asparaginyl-tRNA synthetase (EC 6.1.1.22) +FIG00000640 Cytochrome c oxidase polypeptide III (EC 1.9.3.1) +FIG00000641 Cob(I)alamin adenosyltransferase (EC 2.5.1.17) +FIG00000642 Spermidine synthase (EC 2.5.1.16) +FIG00000645 Glucosamine-6-phosphate deaminase (EC 3.5.99.6) +FIG00000646 Flagellar basal-body rod modification protein FlgD +FIG00000648 tRNA (adenine37-N(6))-methyltransferase TrmN6 (EC 2.1.1.223) +FIG00000650 Flagellar hook-associated protein FlgK +FIG00000652 Positive regulator of CheA protein activity (CheW) +FIG00000654 tolB protein precursor, periplasmic protein involved in the tonb-independent uptake of group A colicins +FIG00000655 Thymidine kinase (EC 2.7.1.21) +FIG00000656 Aspartyl-tRNA synthetase (EC 6.1.1.12) @ Aspartyl-tRNA(Asn) synthetase (EC 6.1.1.23) +FIG00000659 Purine nucleoside phosphorylase (EC 2.4.2.1) +FIG00000660 Cystathionine gamma-synthase (EC 2.5.1.48) +FIG00000663 Pyridoxine 5'-phosphate synthase (EC 2.6.99.2) +FIG00000664 Ferredoxin, 2Fe-2S +FIG00000667 Outer membrane protein assembly factor YaeT precursor +FIG00000668 Flagellar hook-associated protein FliD +FIG00000670 Twin-arginine translocation protein TatB +FIG00000672 5-methyltetrahydrofolate--homocysteine methyltransferase (EC 2.1.1.13) +FIG00000673 DNA-3-methyladenine glycosylase (EC 3.2.2.20) +FIG00000677 Uracil phosphoribosyltransferase (EC 2.4.2.9) / Pyrimidine operon regulatory protein PyrR +FIG00000679 Low-specificity L-threonine aldolase (EC 4.1.2.48) +FIG00000680 DinG family ATP-dependent helicase YoaA +FIG00000681 Beta-lactamase class C and other penicillin binding proteins +FIG00000683 5-methyltetrahydropteroyltriglutamate--homocysteine methyltransferase (EC 2.1.1.14) +FIG00000684 2-octaprenyl-3-methyl-6-methoxy-1,4-benzoquinol hydroxylase (EC 1.14.13.-) +FIG00000686 Glutamyl-tRNA synthetase (EC 6.1.1.17) @ Glutamyl-tRNA(Gln) synthetase (EC 6.1.1.24) +FIG00000687 Adenosine deaminase (EC 3.5.4.4) +FIG00000689 Adenosylcobinamide-phosphate synthase (EC 6.3.1.10) +FIG00000692 Biotin--protein ligase (EC 6.3.4.9, EC 6.3.4.10, EC 6.3.4.11, EC 6.3.4.15) / Biotin operon repressor +FIG00000695 Pantothenate kinase type III, CoaX-like (EC 2.7.1.33) +FIG00000700 Glycine dehydrogenase [decarboxylating] (glycine cleavage system P protein) (EC 1.4.4.2) +FIG00000704 PTS system, cellobiose-specific IIB component (EC 2.7.1.69) +FIG00000705 NADH-ubiquinone oxidoreductase chain E (EC 1.6.5.3) +FIG00000708 Aminodeoxychorismate lyase (EC 4.1.3.38) +FIG00000709 Cytochrome c-type biogenesis protein DsbD, protein-disulfide reductase (EC 1.8.1.8) +FIG00000710 Alkyl hydroperoxide reductase protein C (EC 1.6.4.-) +FIG00000711 Phosphoenolpyruvate carboxylase (EC 4.1.1.31) +FIG00000712 RNA polymerase sigma factor RpoH +FIG00000714 Membrane alanine aminopeptidase N (EC 3.4.11.2) +FIG00000716 Homoserine O-acetyltransferase (EC 2.3.1.31) +FIG00000717 Glucose-1-phosphate adenylyltransferase (EC 2.7.7.27) +FIG00000718 tRNA S(4)U 4-thiouridine synthase (former ThiI) / Rhodanese-like domain required for thiamine synthesis +FIG00000720 Cytidine deaminase (EC 3.5.4.5) +FIG00000721 Pyruvate formate-lyase activating enzyme (EC 1.97.1.4) +FIG00000722 Glutathione synthetase (EC 6.3.2.3) +FIG00000728 Sulfate adenylyltransferase subunit 2 (EC 2.7.7.4) +FIG00000732 Fructose-1,6-bisphosphatase, type I (EC 3.1.3.11) +FIG00000735 Adenosine (5')-pentaphospho-(5'')-adenosine pyrophosphohydrolase (EC 3.6.1.-) +FIG00000736 Potassium uptake protein TrkH +FIG00000737 Two-component system response regulator QseB +FIG00000738 Phosphopentomutase (EC 5.4.2.7) +FIG00000741 2-amino-3-ketobutyrate coenzyme A ligase (EC 2.3.1.29) +FIG00000742 3-deoxy-D-manno-octulosonate 8-phosphate phosphatase (EC 3.1.3.45) +FIG00000743 Arabinose 5-phosphate isomerase (EC 5.3.1.13) +FIG00000747 Beta-lactamase (EC 3.5.2.6) +FIG00000748 Leucyl/phenylalanyl-tRNA--protein transferase (EC 2.3.2.6) +FIG00000750 Aspartyl-tRNA synthetase (EC 6.1.1.12) +FIG00000751 Flagellar P-ring protein FlgI +FIG00000754 Ubiquinol--cytochrome c reductase, cytochrome B subunit (EC 1.10.2.2) +FIG00000756 Ribosomal-protein-S5p-alanine acetyltransferase +FIG00000760 Sulfite reductase [NADPH] hemoprotein beta-component (EC 1.8.1.2) +FIG00000762 Carbamate kinase (EC 2.7.2.2) +FIG00000763 FKBP-type peptidyl-prolyl cis-trans isomerase SlyD (EC 5.2.1.8) +FIG00000764 Adenosylcobinamide-phosphate guanylyltransferase (EC 2.7.7.62) +FIG00000766 Alkaline phosphatase (EC 3.1.3.1) +FIG00000767 Flagellar basal-body rod protein FlgF +FIG00000769 Periplasmic thiol:disulfide oxidoreductase DsbB, required for DsbA reoxidation +FIG00000770 Arsenate reductase (EC 1.20.4.1) +FIG00000771 Lipoprotein releasing system ATP-binding protein LolD +FIG00000772 2-octaprenyl-6-methoxyphenol hydroxylase (EC 1.14.13.-) +FIG00000773 Glutamyl-tRNA synthetase (EC 6.1.1.17) +FIG00000775 CDP-diacylglycerol--serine O-phosphatidyltransferase (EC 2.7.8.8) +FIG00000776 6-phosphogluconolactonase (EC 3.1.1.31), eukaryotic type +FIG00000777 NADP-dependent malic enzyme (EC 1.1.1.40) +FIG00000778 Coproporphyrinogen III oxidase, aerobic (EC 1.3.3.3) +FIG00000780 Flagellar L-ring protein FlgH +FIG00000782 Exonuclease SbcD +FIG00000784 Flagellar biosynthesis protein FliS +FIG00000785 NADH-ubiquinone oxidoreductase chain C (EC 1.6.5.3) +FIG00000788 tRNA:Cm32/Um32 methyltransferase +FIG00000789 Phosphoenolpyruvate synthase (EC 2.7.9.2) +FIG00000793 Xylulose kinase (EC 2.7.1.17) +FIG00000797 Ubiquinol-cytochrome C reductase iron-sulfur subunit (EC 1.10.2.2) +FIG00000800 Succinate dehydrogenase cytochrome b-556 subunit +FIG00000802 Heme A synthase, cytochrome oxidase biogenesis protein Cox15-CtaA +FIG00000803 Rod shape-determining protein RodA +FIG00000804 Ribonuclease D (EC 3.1.26.3) +FIG00000807 Succinate dehydrogenase hydrophobic membrane anchor protein +FIG00000809 Phosphocarrier protein of PTS system +FIG00000810 18K peptidoglycan-associated outer membrane lipoprotein; Peptidoglycan-associated lipoprotein precursor; Outer membrane protein P6; OmpA/MotB precursor +FIG00000811 ATP phosphoribosyltransferase (EC 2.4.2.17) +FIG00000812 L-lactate dehydrogenase (EC 1.1.1.27) +FIG00000815 Cytochrome c-type biogenesis protein CcmC, putative heme lyase for CcmE +FIG00000816 Flagellin protein FlaA +FIG00000818 Isocitrate lyase (EC 4.1.3.1) +FIG00000819 3-hydroxybutyryl-CoA dehydrogenase (EC 1.1.1.157); 3-hydroxyacyl-CoA dehydrogenase (EC 1.1.1.35) +FIG00000820 Phosphoribosylformylglycinamidine synthase, synthetase subunit (EC 6.3.5.3) / Phosphoribosylformylglycinamidine synthase, glutamine amidotransferase subunit (EC 6.3.5.3) +FIG00000821 Adenylylsulfate kinase (EC 2.7.1.25) +FIG00000822 LrgA-associated membrane protein LrgB +FIG00000824 Nicotinate-nucleotide--dimethylbenzimidazole phosphoribosyltransferase (EC 2.4.2.21) +FIG00000825 Glutaminyl-tRNA synthetase (EC 6.1.1.18) +FIG00000827 Cell division topological specificity factor MinE +FIG00000828 Ribonuclease Z (EC 3.1.26.11) +FIG00000831 Na+/H+ antiporter NhaA type +FIG00000832 Antiholin-like protein LrgA +FIG00000834 Phosphoenolpyruvate carboxykinase [ATP] (EC 4.1.1.49) +FIG00000835 NAD-dependent malic enzyme (EC 1.1.1.38) +FIG00000838 Trk system potassium uptake protein TrkA +FIG00000840 50S ribosomal subunit maturation GTPase RbgA (B. subtilis YlqF) +FIG00000841 Glutathione reductase (EC 1.8.1.7) +FIG00000842 D-lactate dehydrogenase (EC 1.1.1.28) +FIG00000843 Kup system potassium uptake protein +FIG00000845 S-ribosylhomocysteine lyase (EC 4.4.1.21) / Autoinducer-2 production protein LuxS +FIG00000846 Osmosensitive K+ channel histidine kinase KdpD (EC 2.7.3.-) +FIG00000847 Allophanate hydrolase 2 subunit 1 (EC 3.5.1.54) +FIG00000848 Manganese superoxide dismutase (EC 1.15.1.1) +FIG00000850 Flagellar assembly protein FliH +FIG00000853 Sensor protein basS/pmrB (EC 2.7.3.-) +FIG00000856 Cytoplasmic copper homeostasis protein CutC +FIG00000858 Adenosylhomocysteinase (EC 3.3.1.1) +FIG00000859 FIG000859: hypothetical protein YebC +FIG00000860 O-succinylbenzoic acid--CoA ligase (EC 6.2.1.26) +FIG00000861 Gluconokinase (EC 2.7.1.12) +FIG00000862 Phosphoribosyl-AMP cyclohydrolase (EC 3.5.4.19) / Phosphoribosyl-ATP pyrophosphatase (EC 3.6.1.31) +FIG00000863 L-threonine 3-O-phosphate decarboxylase (EC 4.1.1.81) +FIG00000865 ATP phosphoribosyltransferase regulatory subunit (EC 2.4.2.17) +FIG00000866 2-succinyl-5-enolpyruvyl-6-hydroxy-3-cyclohexene-1-carboxylic-acid synthase (EC 2.2.1.9) +FIG00000868 Uncharacterized protein EC-HemY, likely associated with heme metabolism based on gene clustering with hemC, hemD in Proteobacteria (unrelated to HemY-type PPO in GramPositives) +FIG00000869 Phosphoribosylformylglycinamidine synthase, PurS subunit (EC 6.3.5.3) +FIG00000871 Phosphoribosyl-ATP pyrophosphatase (EC 3.6.1.31) +FIG00000872 Nitrite-sensitive transcriptional repressor NsrR +FIG00000873 Nitrite reductase [NAD(P)H] large subunit (EC 1.7.1.4) +FIG00000875 FIG000875: Thioredoxin domain-containing protein EC-YbbN +FIG00000877 Formate--tetrahydrofolate ligase (EC 6.3.4.3) +FIG00000880 Periplasmic divalent cation tolerance protein CutA +FIG00000882 glutamyl-Q-tRNA synthetase +FIG00000884 Ribonuclease E inhibitor RraA +FIG00000892 Mutator mutT protein (7,8-dihydro-8-oxoguanine-triphosphatase) (EC 3.6.1.-) +FIG00000895 Alanine dehydrogenase (EC 1.4.1.1) +FIG00000897 Ribonucleotide reductase of class III (anaerobic), activating protein (EC 1.97.1.4) +FIG00000899 Endonuclease IV (EC 3.1.21.2) +FIG00000901 Phosphoglucomutase (EC 5.4.2.2) +FIG00000902 Molybdopterin-guanine dinucleotide biosynthesis protein MobA +FIG00000906 FIG000906: Predicted Permease +FIG00000907 Catalase (EC 1.11.1.6) / Peroxidase (EC 1.11.1.7) +FIG00000908 2,3,4,5-tetrahydropyridine-2,6-dicarboxylate N-succinyltransferase (EC 2.3.1.117) +FIG00000909 Phosphoribosylglycinamide formyltransferase 2 (EC 2.1.2.-) +FIG00000911 NADH pyrophosphatase (EC 3.6.1.22) +FIG00000912 Outer membrane vitamin B12 receptor BtuB +FIG00000913 Ribonuclease E (EC 3.1.26.12) +FIG00000914 NAD synthetase (EC 6.3.1.5) / Glutamine amidotransferase chain of NAD synthetase +FIG00000915 Hypothetical protein YaeJ with similarity to translation release factor +FIG00000919 Thiol:disulfide interchange protein DsbC +FIG00000924 PTS system, mannose-specific IID component +FIG00000926 Predicted L-lactate dehydrogenase, Fe-S oxidoreductase subunit YkgE +FIG00000927 Methylmalonyl-CoA mutase (EC 5.4.99.2) +FIG00000928 Phytoene synthase (EC 2.5.1.32) +FIG00000933 Cobalt-precorrin-4 C11-methyltransferase (EC 2.1.1.133) +FIG00000936 Pantothenate kinase (EC 2.7.1.33) +FIG00000938 Deoxyadenosine kinase (EC 2.7.1.76) / Deoxyguanosine kinase (EC 2.7.1.113) +FIG00000940 Isoquinoline 1-oxidoreductase beta subunit (EC 1.3.99.16) +FIG00000941 Isoquinoline 1-oxidoreductase alpha subunit (EC 1.3.99.16) +FIG00000943 UDP-2,3-diacylglucosamine diphosphatase (EC 3.6.1.54) +FIG00000946 Carboxyl-terminal protease (EC 3.4.21.102) +FIG00000948 Poly(A) polymerase (EC 2.7.7.19) +FIG00000949 Anaerobic dimethyl sulfoxide reductase chain A (EC 1.8.5.3) +FIG00000950 Flagellar biosynthesis protein FlhF +FIG00000951 Proline iminopeptidase (EC 3.4.11.5) +FIG00000957 Hydroxyethylthiazole kinase (EC 2.7.1.50) +FIG00000959 Sulfate and thiosulfate import ATP-binding protein CysA (EC 3.6.3.25) +FIG00000960 Ribonucleotide reductase of class Ib (aerobic), beta subunit (EC 1.17.4.1) +FIG00000962 Xanthine dehydrogenase, molybdenum binding subunit (EC 1.17.1.4) +FIG00000963 Hydroxymethylglutaryl-CoA lyase (EC 4.1.3.4) +FIG00000964 Branched-chain alpha-keto acid dehydrogenase, E1 component, alpha subunit (EC 1.2.4.4) +FIG00000967 Methylglyoxal synthase (EC 4.2.3.3) +FIG00000968 Alkylphosphonate utilization operon protein PhnA +FIG00000969 GTP cyclohydrolase II (EC 3.5.4.25) +FIG00000970 Polyhydroxyalkanoic acid synthase +FIG00000972 Biotin--protein ligase (EC 6.3.4.9, EC 6.3.4.10, EC 6.3.4.11, EC 6.3.4.15) +FIG00000973 RNA polymerase sigma factor RpoE +FIG00000976 Transcription elongation factor GreB +FIG00000978 Malate:quinone oxidoreductase (EC 1.1.5.4) +FIG00000979 Alpha-ribazole-5'-phosphate phosphatase (EC 3.1.3.73) +FIG00000982 Phosphatidylglycerophosphatase A (EC 3.1.3.27) +FIG00000983 Flavohemoprotein (Hemoglobin-like protein) (Flavohemoglobin) (Nitric oxide dioxygenase) (EC 1.14.12.17) +FIG00000985 Prolipoprotein diacylglyceryl transferase (EC 2.4.99.-) +FIG00000986 L-ribulose-5-phosphate 4-epimerase (EC 5.1.3.4) +FIG00000987 ATP-dependent DNA helicase Rep +FIG00000988 FIG000988: Predicted permease +FIG00000990 Recombination inhibitory protein MutS2 +FIG00000991 Polysaccharide export lipoprotein Wza +FIG00000995 Uridine kinase (EC 2.7.1.48) +FIG00000997 Protein RtcB +FIG00000999 Peptidyl-prolyl cis-trans isomerase PpiB (EC 5.2.1.8) +FIG00001000 Sulfate and thiosulfate binding protein CysP +FIG00001001 Urease accessory protein UreG +FIG00001002 Sulfur carrier protein adenylyltransferase ThiF +FIG00001004 Threonine dehydratase biosynthetic (EC 4.3.1.19) +FIG00001005 ABC-type multidrug transport system, ATPase component +FIG00001006 Apolipoprotein N-acyltransferase (EC 2.3.1.-) / Copper homeostasis protein CutE +FIG00001011 Beta-glucoside bgl operon antiterminator, BglG family +FIG00001017 Glycine oxidase ThiO (EC 1.4.3.19) +FIG00001018 Long-chain-acyl-CoA dehydrogenase (EC 1.3.99.13) +FIG00001019 Protoporphyrinogen IX oxidase, novel form, HemJ (EC 1.3.-.-) +FIG00001020 Pyridoxal kinase (EC 2.7.1.35) +FIG00001021 Integration host factor beta subunit +FIG00001022 Phosphomannomutase (EC 5.4.2.8) +FIG00001024 Rod shape-determining protein MreD +FIG00001025 Urease accessory protein UreF +FIG00001026 Phosphogluconate dehydratase (EC 4.2.1.12) +FIG00001028 Ribosomal large subunit pseudouridine synthase A (EC 4.2.1.70) +FIG00001029 Alkyl hydroperoxide reductase protein F (EC 1.6.4.-) +FIG00001030 2-methylcitrate synthase (EC 2.3.3.5) +FIG00001032 NADPH dependent preQ0 reductase (EC 1.7.1.13) +FIG00001035 Respiratory nitrate reductase beta chain (EC 1.7.99.4) +FIG00001036 Type II/IV secretion system ATP hydrolase TadA/VirB11/CpaF, TadA subfamily +FIG00001037 Anaerobic dimethyl sulfoxide reductase chain B (EC 1.8.5.3) +FIG00001039 Ribonucleotide reduction protein NrdI +FIG00001040 Nitrate/nitrite sensor protein (EC 2.7.3.-) +FIG00001042 Urease beta subunit (EC 3.5.1.5) +FIG00001043 Lysophospholipase (EC 3.1.1.5); Monoglyceride lipase (EC 3.1.1.23); putative +FIG00001044 Respiratory nitrate reductase alpha chain (EC 1.7.99.4) +FIG00001045 ATP:Cob(I)alamin adenosyltransferase (EC 2.5.1.17) +FIG00001046 Mlr7403 protein +FIG00001049 23S rRNA (guanosine-2'-O-) -methyltransferase rlmB (EC 2.1.1.-) +FIG00001050 Chaperone protein HscB +FIG00001052 ADP-L-glycero-D-manno-heptose-6-epimerase (EC 5.1.3.20) +FIG00001054 Dihydroorotate dehydrogenase, catalytic subunit (EC 1.3.3.1) +FIG00001056 Cytochrome O ubiquinol oxidase subunit III (EC 1.10.3.-) +FIG00001059 TolA protein +FIG00001060 Cell division protein FtsL +FIG00001061 ADA regulatory protein / Methylated-DNA--protein-cysteine methyltransferase (EC 2.1.1.63) +FIG00001062 Agmatine deiminase (EC 3.5.3.12) +FIG00001063 Cytochrome O ubiquinol oxidase subunit IV (EC 1.10.3.-) +FIG00001065 Glucokinase (EC 2.7.1.2) +FIG00001067 Rubrerythrin +FIG00001069 Ribonucleotide reductase of class Ib (aerobic), alpha subunit (EC 1.17.4.1) +FIG00001074 Flagellar hook-length control protein FliK +FIG00001075 Chaperone protein HscA +FIG00001076 Pyruvate,phosphate dikinase (EC 2.7.9.1) +FIG00001077 Cytochrome O ubiquinol oxidase subunit I (EC 1.10.3.-) +FIG00001079 Respiratory nitrate reductase gamma chain (EC 1.7.99.4) +FIG00001080 Membrane fusion component of tripartite multidrug resistance system +FIG00001086 Potassium voltage-gated channel subfamily KQT; possible potassium channel, VIC family +FIG00001088 Beta-hexosaminidase (EC 3.2.1.52) +FIG00001093 Electron transfer flavoprotein-ubiquinone oxidoreductase (EC 1.5.5.1) +FIG00001094 Phenylacetate-coenzyme A ligase (EC 6.2.1.30) +FIG00001095 Cytochrome O ubiquinol oxidase subunit II (EC 1.10.3.-) +FIG00001097 3'-to-5' oligoribonuclease (orn) +FIG00001098 Outer membrane lipoprotein carrier protein LolA +FIG00001099 S-(hydroxymethyl)glutathione dehydrogenase (EC 1.1.1.284) +FIG00001100 Alpha,alpha-trehalose-phosphate synthase [UDP-forming] (EC 2.4.1.15) +FIG00001101 Proline dehydrogenase (EC 1.5.99.8) (Proline oxidase) / Delta-1-pyrroline-5-carboxylate dehydrogenase (EC 1.5.1.12) +FIG00001102 ubiquinol cytochrome C oxidoreductase, cytochrome C1 subunit +FIG00001103 N-acetylmuramic acid 6-phosphate etherase +FIG00001104 Arginine deiminase (EC 3.5.3.6) +FIG00001105 tRNA (cytidine(34)-2'-O)-methyltransferase (EC 2.1.1.207) +FIG00001106 Homoserine O-succinyltransferase (EC 2.3.1.46) +FIG00001107 SSU ribosomal protein S10p (S20e) +FIG00001108 Cytochrome c oxidase subunit CcoO (EC 1.9.3.1) +FIG00001109 4-hydroxyphenylpyruvate dioxygenase (EC 1.13.11.27) +FIG00001110 SSU ribosomal protein S9p (S16e) +FIG00001113 Urease accessory protein UreD +FIG00001119 Glycerol-3-phosphate regulon repressor, DeoR family +FIG00001120 Isopentenyl-diphosphate delta-isomerase, FMN-dependent (EC 5.3.3.2) +FIG00001121 Colicin V production protein +FIG00001124 Cystine ABC transporter, periplasmic cystine-binding protein FliY +FIG00001125 RNA binding methyltransferase FtsJ like +FIG00001129 Cobalt-precorrin-6 synthase, anaerobic +FIG00001131 Thymidine phosphorylase (EC 2.4.2.4) +FIG00001132 LSU ribosomal protein L16p (L10e) +FIG00001133 COG2740: Predicted nucleic-acid-binding protein implicated in transcription termination +FIG00001134 DNA-3-methyladenine glycosylase II (EC 3.2.2.21) +FIG00001136 Urease accessory protein UreE +FIG00001138 Respiratory nitrate reductase delta chain (EC 1.7.99.4) +FIG00001139 Cytochrome c oxidase subunit CcoP (EC 1.9.3.1) +FIG00001140 Anaerobic dimethyl sulfoxide reductase chain C (EC 1.8.5.3) +FIG00001142 ApaG protein +FIG00001143 NAD(P) transhydrogenase alpha subunit (EC 1.6.1.2) +FIG00001145 N-acetylmannosamine-6-phosphate 2-epimerase (EC 5.1.3.9) +FIG00001146 GTP cyclohydrolase I (EC 3.5.4.16) type 2 +FIG00001147 Flagellar protein FliJ +FIG00001155 Flagellar synthesis regulator FleN +FIG00001157 General secretion pathway protein G +FIG00001158 Chorismate--pyruvate lyase (EC 4.1.3.40) +FIG00001163 Isocitrate dehydrogenase [NADP] (EC 1.1.1.42); Monomeric isocitrate dehydrogenase [NADP] (EC 1.1.1.42) +FIG00001166 Arginine/ornithine antiporter ArcD +FIG00001168 Acetylornithine aminotransferase (EC 2.6.1.11) +FIG00001170 3-dehydroquinate dehydratase I (EC 4.2.1.10) +FIG00001171 Glutamate Aspartate periplasmic binding protein precursor GltI (TC 3.A.1.3.4) +FIG00001172 Homogentisate 1,2-dioxygenase (EC 1.13.11.5) +FIG00001173 Nitrate/nitrite response regulator protein +FIG00001174 Glutaminase (EC 3.5.1.2) +FIG00001175 Thiamin pyrophosphokinase (EC 2.7.6.2) +FIG00001178 NnrS protein involved in response to NO +FIG00001179 Macrolide-specific efflux protein MacA +FIG00001180 Ribosomal protein S6 glutaminyl transferase +FIG00001181 Superoxide dismutase [Cu-Zn] precursor (EC 1.15.1.1) +FIG00001182 [NiFe] hydrogenase nickel incorporation protein HypA +FIG00001186 Murein-DD-endopeptidase (EC 3.4.99.-) +FIG00001188 Aminoacyl-histidine dipeptidase (Peptidase D) (EC 3.4.13.3) +FIG00001189 Glycyl-tRNA synthetase (EC 6.1.1.14) +FIG00001190 PTS system, glucose-specific IIA component (EC 2.7.1.69) +FIG00001192 Paraquat-inducible protein B +FIG00001193 Flagellar protein FlgJ [peptidoglycan hydrolase] (EC 3.2.1.-) +FIG00001194 Rrf2 family transcriptional regulator, group III +FIG00001197 RNA polymerase sigma factor RpoS +FIG00001198 Choline-sulfatase (EC 3.1.6.6) +FIG00001201 Peptidase B (EC 3.4.11.23) +FIG00001202 Sigma factor RpoE negative regulatory protein RseB precursor +FIG00001203 Pyridoxine biosynthesis glutamine amidotransferase, glutaminase subunit (EC 2.4.2.-) +FIG00001204 Proposed peptidoglycan lipid II flippase MurJ +FIG00001206 N-acetylglutamate synthase (EC 2.3.1.1) +FIG00001208 [NiFe] hydrogenase metallocenter assembly protein HypD +FIG00001209 [NiFe] hydrogenase metallocenter assembly protein HypF +FIG00001210 [NiFe] hydrogenase nickel incorporation-associated protein HypB +FIG00001214 DNA recombination-dependent growth factor C +FIG00001215 Putative formate dehydrogenase oxidoreductase protein +FIG00001217 Malate synthase (EC 2.3.3.9) +FIG00001219 Preprotein translocase subunit SecE (TC 3.A.5.1.1) +FIG00001220 Glycolate dehydrogenase (EC 1.1.99.14), subunit GlcD +FIG00001221 Alkanesulfonates-binding protein +FIG00001224 Frataxin homolog CyaY, facilitates iron supply for heme A synthesis or Fe-S cluster assembly +FIG00001225 3-hydroxyacyl-[acyl-carrier-protein] dehydratase, FabA form (EC 4.2.1.59) +FIG00001229 Ribosome hibernation protein YhbH +FIG00001230 Molybdopterin biosynthesis protein MoeB +FIG00001231 Manganese-dependent inorganic pyrophosphatase (EC 3.6.1.1) +FIG00001232 AMP nucleosidase (EC 3.2.2.4) +FIG00001234 PTS system, fructose-specific IIA component (EC 2.7.1.69) / PTS system, fructose-specific IIB component (EC 2.7.1.69) / PTS system, fructose-specific IIC component (EC 2.7.1.69) +FIG00001235 D-glycero-D-manno-heptose 1,7-bisphosphate phosphatase (EC 3.1.1.-) +FIG00001237 Redox-sensitive transcriptional regulator (AT-rich DNA-binding protein) +FIG00001238 Sigma factor RpoE negative regulatory protein RseA +FIG00001244 Type IV fimbrial assembly protein PilC +FIG00001245 Hemoglobin-like protein HbO +FIG00001246 Cytochrome c-type biogenesis protein CcsA/ResC +FIG00001247 Transcriptional regulatory protein RstA +FIG00001248 Cytochrome oxidase biogenesis protein Cox11-CtaG, copper delivery to Cox1 +FIG00001253 G:T/U mismatch-specific uracil/thymine DNA-glycosylase +FIG00001255 Regulator of nucleoside diphosphate kinase +FIG00001256 Cobalt-precorrin-6y C5-methyltransferase (EC 2.1.1.-) / Cobalt-precorrin-6y C15-methyltransferase [decarboxylating] (EC 2.1.1.-) +FIG00001257 Leader peptidase (Prepilin peptidase) (EC 3.4.23.43) / N-methyltransferase (EC 2.1.1.-) +FIG00001259 Phage portal protein +FIG00001264 Phosphatidylserine decarboxylase (EC 4.1.1.65) +FIG00001265 2-iminoacetate synthase (ThiH) (EC 4.1.99.19) +FIG00001268 Selenophosphate-dependent tRNA 2-selenouridine synthase +FIG00001269 Pyruvate-flavodoxin oxidoreductase (EC 1.2.7.-) +FIG00001273 Putative inner membrane protein YjeT (clustered with HflC) +FIG00001276 Flavodoxin reductases (ferredoxin-NADPH reductases) family 1; Vanillate O-demethylase oxidoreductase (EC 1.14.13.-) +FIG00001277 3-oxoacyl-[acyl-carrier-protein] synthase, KASI (EC 2.3.1.41) +FIG00001278 GMP reductase (EC 1.7.1.7) +FIG00001279 CopG protein +FIG00001280 Selenocysteine-specific translation elongation factor +FIG00001285 RsbR, positive regulator of sigma-B +FIG00001287 2-methylcitrate dehydratase (EC 4.2.1.79) +FIG00001289 Na(+)-translocating NADH-quinone reductase subunit E (EC 1.6.5.-) +FIG00001292 D-alanine aminotransferase (EC 2.6.1.21) +FIG00001294 Adenylate cyclase (EC 4.6.1.1) +FIG00001298 COG1939: Ribonuclease III family protein +FIG00001302 Histidinol-phosphatase (EC 3.1.3.15) / Imidazoleglycerol-phosphate dehydratase (EC 4.2.1.19) +FIG00001304 Maltoporin (maltose/maltodextrin high-affinity receptor, phage lambda receptor protein) +FIG00001306 Ribosomal subunit interface protein +FIG00001307 PTS system, galactitol-specific IIC component (EC 2.7.1.69) +FIG00001308 Pyruvate carboxylase (EC 6.4.1.1) +FIG00001311 N-Acetylneuraminate cytidylyltransferase (EC 2.7.7.43) +FIG00001312 Ribonuclease T (EC 3.1.13.-) +FIG00001315 Putative stomatin/prohibitin-family membrane protease subunit aq_911 +FIG00001316 Ribonuclease J2 (endoribonuclease in RNA processing) +FIG00001318 Sulfite reductase [NADPH] flavoprotein alpha-component (EC 1.8.1.2) +FIG00001322 Acyl-CoA dehydrogenase; probable dibenzothiophene desulfurization enzyme +FIG00001323 Molybdopterin-guanine dinucleotide biosynthesis protein MobB +FIG00001326 Type IV fimbrial assembly, ATPase PilB +FIG00001327 Glycerol-3-phosphate acyltransferase (EC 2.3.1.15) +FIG00001328 Glycine dehydrogenase [decarboxylating] (glycine cleavage system P2 protein) (EC 1.4.4.2) +FIG00001331 PTS system, galactitol-specific IIA component (EC 2.7.1.69) +FIG00001332 Spore germination protein GerKB +FIG00001333 Glycolate dehydrogenase (EC 1.1.99.14), iron-sulfur subunit GlcF +FIG00001336 Tartrate dehydrogenase (EC 1.1.1.93) @ Tartrate decarboxylase (EC 4.1.1.73) @ D-malic enzyme (EC 1.1.1.83) +FIG00001337 Na(+)-translocating NADH-quinone reductase subunit A (EC 1.6.5.-) +FIG00001338 Malto-oligosyltrehalose trehalohydrolase (EC 3.2.1.141) +FIG00001339 Phospholipase A1 precursor (EC 3.1.1.32, EC 3.1.1.4); Outer membrane phospholipase A +FIG00001341 FIG001341: Probable Fe(2+)-trafficking protein YggX +FIG00001345 Putative acyl-CoA dehydrogenase oxidoreductase (EC 1.3.99.3), may be related to NAD-dependent histone acetylation +FIG00001346 Cystathionine gamma-lyase (EC 4.4.1.1) +FIG00001347 Chitinase (EC 3.2.1.14) +FIG00001348 Thymidylate synthase thyX (EC 2.1.1.-) +FIG00001349 Trehalose-6-phosphate phosphatase (EC 3.1.3.12) +FIG00001350 Omega-amino acid--pyruvate aminotransferase (EC 2.6.1.18) +FIG00001353 FIG001353: Acetyltransferase +FIG00001354 Hydroxylamine reductase (EC 1.7.-.-) +FIG00001355 Spermidine N1-acetyltransferase (EC 2.3.1.57) +FIG00001357 Inosose dehydratase (EC 4.2.1.44) +FIG00001358 Error-prone, lesion bypass DNA polymerase V (UmuC) +FIG00001360 Ser-tRNA(Ala) deacylase; Gly-tRNA(Ala) deacylase +FIG00001361 Selenide,water dikinase (EC 2.7.9.3) +FIG00001364 Glycine dehydrogenase [decarboxylating] (glycine cleavage system P1 protein) (EC 1.4.4.2) +FIG00001366 1-phosphofructokinase (EC 2.7.1.56) +FIG00001368 N-succinyl-L,L-diaminopimelate aminotransferase alternative (EC 2.6.1.17) +FIG00001370 Type cbb3 cytochrome oxidase biogenesis protein CcoI; Copper-translocating P-type ATPase (EC 3.6.3.4) +FIG00001372 LppC putative lipoprotein +FIG00001373 Na(+)-translocating NADH-quinone reductase subunit F (EC 1.6.5.-) +FIG00001377 Pyruvate oxidase [ubiquinone, cytochrome] (EC 1.2.2.2) +FIG00001378 N-carbamoylputrescine amidase (3.5.1.53) +FIG00001379 Polymyxin resistance protein ArnT, undecaprenyl phosphate-alpha-L-Ara4N transferase; Melittin resistance protein PqaB +FIG00001381 DEAD-box ATP-dependent RNA helicase CshA (EC 3.6.4.13) +FIG00001383 PTS system, fructose-specific IIB component (EC 2.7.1.69) / PTS system, fructose-specific IIC component (EC 2.7.1.69) +FIG00001384 Catalyzes the cleavage of p-aminobenzoyl-glutamate to p-aminobenzoate and glutamate, subunit A +FIG00001385 N-acetylmuramoyl-L-alanine amidase (EC 3.5.1.28) +FIG00001387 Dna binding response regulator PrrA (RegA) +FIG00001388 Sugar/maltose fermentation stimulation protein homolog +FIG00001391 Alpha-ketoglutarate-dependent taurine dioxygenase (EC 1.14.11.17) +FIG00001392 ADP compounds hydrolase NudE (EC 3.6.1.-) +FIG00001393 Sensor histidine kinase PrrB (RegB) (EC 2.7.3.-) +FIG00001394 Ureidoglycolate hydrolase (EC 3.5.3.19) +FIG00001395 CobN component of cobalt chelatase involved in B12 biosynthesis +FIG00001396 Alpha-acetolactate decarboxylase (EC 4.1.1.5) +FIG00001397 Para-aminobenzoate synthase, aminase component (EC 2.6.1.85) / Aminodeoxychorismate lyase (EC 4.1.3.38) +FIG00001398 Na(+) H(+) antiporter subunit C +FIG00001400 Copper metallochaperone, bacterial analog of Cox17 protein +FIG00001401 Gluconate dehydratase (EC 4.2.1.39) +FIG00001402 Helicase loader DnaI +FIG00001404 Cell division protein ZipA +FIG00001405 Formate dehydrogenase O beta subunit (EC 1.2.1.2) +FIG00001406 Aspartate--ammonia ligase (EC 6.3.1.1) +FIG00001407 FKBP-type peptidyl-prolyl cis-trans isomerase FklB (EC 5.2.1.8) +FIG00001408 Rrf2 family transcriptional regulator +FIG00001409 5-deoxy-glucuronate isomerase (EC 5.3.1.-) +FIG00001411 Uronate isomerase (EC 5.3.1.12) +FIG00001414 Cell division initiation protein DivIVA +FIG00001415 tRNA-dihydrouridine synthase C (EC 1.-.-.-) +FIG00001417 Altronate dehydratase (EC 4.2.1.7) +FIG00001420 Channel-forming transporter/cytolysins activator of TpsB family +FIG00001422 Error-prone repair protein UmuD +FIG00001423 Transcriptional regulator PhnF +FIG00001427 Mannitol-1-phosphate 5-dehydrogenase (EC 1.1.1.17) +FIG00001428 YciL protein +FIG00001430 Beta-glucosidase (EC 3.2.1.21); 6-phospho-beta-glucosidase (EC 3.2.1.86) +FIG00001431 ATP synthase protein I +FIG00001433 Malate synthase G (EC 2.3.3.9) +FIG00001434 BarA-associated response regulator UvrY (= GacA = SirA) +FIG00001436 GlpG protein (membrane protein of glp regulon) +FIG00001437 Stringent starvation protein A +FIG00001440 L-serine dehydratase, alpha subunit (EC 4.3.1.17) +FIG00001443 Na(+) H(+) antiporter subunit D +FIG00001448 Phosphoadenylyl-sulfate reductase [thioredoxin] (EC 1.8.4.8) +FIG00001449 Xanthine phosphoribosyltransferase (EC 2.4.2.22) +FIG00001450 Hydroxymethylglutaryl-CoA reductase (EC 1.1.1.34) +FIG00001451 Na(+) H(+) antiporter subunit E +FIG00001452 Transcriptional repressor of the fructose operon, DeoR family +FIG00001454 FIG001454: Transglutaminase-like enzymes, putative cysteine proteases +FIG00001457 PTS system, galactitol-specific IIB component (EC 2.7.1.69) +FIG00001459 tRNA 5-methylaminomethyl-2-thiouridine synthase TusD +FIG00001460 ATPase provides energy for both assembly of type IV secretion complex and secretion of T-DNA complex (VirB4) +FIG00001462 Putative membrane protein, clustering with ActP +FIG00001463 FKBP-type peptidyl-prolyl cis-trans isomerase FkpA precursor (EC 5.2.1.8) +FIG00001465 Ferredoxin-type protein NapF (periplasmic nitrate reductase) +FIG00001466 Na(+) H(+) antiporter subunit F +FIG00001467 tRNA 5-methylaminomethyl-2-thiouridine synthase TusA +FIG00001469 Beta-glucosidase (EC 3.2.1.21) +FIG00001470 Signal recognition particle associated protein +FIG00001471 4-hydroxyphenylacetate 3-monooxygenase, reductase component (EC 1.6.8.-) +FIG00001472 Nitric oxide-dependent regulator DnrN or NorA +FIG00001473 CidA-associated membrane protein CidB +FIG00001474 Ribonuclease HIII (EC 3.1.26.4) +FIG00001475 RNA polymerase associated protein RapA (EC 3.6.1.-) +FIG00001476 Dihydroneopterin triphosphate pyrophosphohydolase type 2 +FIG00001477 Ribonuclease M5 (EC 3.1.26.8) +FIG00001478 HTH-type transcriptional regulator BetI +FIG00001480 Holin-like protein CidA +FIG00001482 Soluble pyridine nucleotide transhydrogenase (EC 1.6.1.1) +FIG00001484 Isoaspartyl aminopeptidase (EC 3.4.19.5) @ Asp-X dipeptidase +FIG00001486 ; Probable coniferyl aldehyde dehydrogenase (EC 1.2.1.68) +FIG00001487 PTS system, fructose-specific IIA component (EC 2.7.1.69) +FIG00001488 Probable electron transfer flavoprotein-quinone oxidoreductase FixC (EC 1.5.5.-) +FIG00001489 ribosomal protein L7Ae family protein +FIG00001491 Peroxide stress regulator PerR, FUR family +FIG00001492 Scaffold protein for [4Fe-4S] cluster assembly ApbC, MRP-like +FIG00001493 Protein of unknown function Smg +FIG00001494 Methylthioribose-1-phosphate isomerase (EC 5.3.1.23) +FIG00001495 Glutaredoxin-related protein +FIG00001497 Ribosome-associated heat shock protein implicated in the recycling of the 50S subunit (S4 paralog) +FIG00001498 Chorismate mutase I (EC 5.4.99.5) +FIG00001499 GTP-binding protein YqeH, required for biogenesis of 30S ribosome subunit +FIG00001501 4'-phosphopantetheinyl transferase (EC 2.7.8.-) +FIG00001503 Exodeoxyribonuclease I (EC 3.1.11.1) +FIG00001504 Serine--glyoxylate aminotransferase (EC 2.6.1.45) +FIG00001505 Electron transport complex protein RnfA +FIG00001508 tRNA (5-methoxyuridine) 34 synthase +FIG00001509 LysR family transcriptional regulator QseA +FIG00001516 D-mannonate oxidoreductase (EC 1.1.1.57) +FIG00001517 Forms the bulk of type IV secretion complex that spans outer membrane and periplasm (VirB9) +FIG00001518 Xanthine and CO dehydrogenases maturation factor, XdhC/CoxF family +FIG00001519 Sigma factor RpoE regulatory protein RseC +FIG00001520 Aconitate hydratase 2 (EC 4.2.1.3) +FIG00001522 Adenine deaminase (EC 3.5.4.2) +FIG00001524 Kynurenine formamidase, bacterial (EC 3.5.1.9) +FIG00001525 tRNA 5-methylaminomethyl-2-thiouridine synthase TusC +FIG00001527 Copper-sensing two-component system response regulator CpxR +FIG00001528 Cobalt-precorrin-3b C17-methyltransferase +FIG00001529 Putative FMN hydrolase (EC 3.1.3.-); 5-Amino-6-(5'-phosphoribitylamino)uracil phosphatase +FIG00001530 Deblocking aminopeptidase (EC 3.4.11.-) +FIG00001531 D-alanyl transfer protein DltB +FIG00001532 Biosynthetic Aromatic amino acid aminotransferase beta (EC 2.6.1.57) @ Histidinol-phosphate aminotransferase (EC 2.6.1.9) +FIG00001537 Cytochrome c552 precursor (EC 1.7.2.2) +FIG00001540 3',5'-cyclic-nucleotide phosphodiesterase (EC 3.1.4.17) +FIG00001543 DNA-directed RNA polymerase delta subunit (EC 2.7.7.6) +FIG00001544 Membrane-associated protein containing RNA-binding TRAM domain and ribonuclease PIN-domain, YacL B.subtilis ortholog +FIG00001546 Poly(glycerophosphate chain) D-alanine transfer protein DltD +FIG00001547 ATP-dependent nuclease, subunit A +FIG00001548 Beta-galactosidase (EC 3.2.1.23) +FIG00001549 Hypothetical protein DUF901, similar to C-terminal domain of ribosome protection-type Tc-resistance proteins +FIG00001550 CDP-diacylglycerol--glycerol-3-phosphate 3-phosphatidyltransferase (EC 2.7.8.5) +FIG00001551 iron-chelator utilization protein +FIG00001552 S-adenosylmethionine decarboxylase proenzyme (EC 4.1.1.50), prokaryotic class 1B +FIG00001553 FIG001553: Hydrolase, HAD subfamily IIIA +FIG00001555 Cyclopropane-fatty-acyl-phospholipid synthase (EC 2.1.1.79) +FIG00001556 Copper resistance protein D +FIG00001558 3-hydroxyacyl-CoA dehydrogenase (EC 1.1.1.35) +FIG00001559 N-formylglutamate deformylase (EC 3.5.1.68) +FIG00001561 Probable GTPase related to EngC +FIG00001562 Methyl-directed repair DNA adenine methylase (EC 2.1.1.72) +FIG00001563 Preprotein translocase subunit SecG (TC 3.A.5.1.1) +FIG00001565 FIG01055109: hypothetical protein +FIG00001567 Inner membrane protein forms channel for type IV secretion of T-DNA complex (VirB10) +FIG00001569 LysR family regulatory protein CidR +FIG00001571 FIG001571: Hypothetical protein +FIG00001572 Galactitol-1-phosphate 5-dehydrogenase (EC 1.1.1.251) +FIG00001574 Alkylated DNA repair protein AlkB +FIG00001576 Lysyl-tRNA synthetase (class I) (EC 6.1.1.6) +FIG00001577 LSU ribosomal protein L6p (L9e) +FIG00001578 Glycine cleavage system transcriptional antiactivator GcvR +FIG00001579 D-alanine--poly(phosphoribitol) ligase subunit 1 (EC 6.1.1.13) +FIG00001580 Fumarate and nitrate reduction regulatory protein +FIG00001582 Putative Nudix hydrolase YfcD (EC 3.6.-.-) +FIG00001583 FIG001583: hypothetical protein, contains S4-like RNA binding domain +FIG00001584 5-keto-D-gluconate 5-reductase (EC 1.1.1.69) +FIG00001585 Kynureninase (EC 3.7.1.3) +FIG00001587 FIG001587: exported protein +FIG00001589 Oxidoreductase probably involved in sulfite reduction +FIG00001592 Phosphoenolpyruvate-protein phosphotransferase, nitrogen regulation associated +FIG00001594 Periplasmic nitrate reductase component NapD +FIG00001596 Fumarylacetoacetase (EC 3.7.1.2) +FIG00001597 PF00070 family, FAD-dependent NAD(P)-disulphide oxidoreductase +FIG00001598 ATP-dependent helicase DinG/Rad3 +FIG00001604 Ornithine decarboxylase (EC 4.1.1.17) +FIG00001605 RecU Holliday junction resolvase +FIG00001606 Malto-oligosyltrehalose synthase (EC 5.4.99.15) +FIG00001607 Cobalamin biosynthesis protein BluB @ 5,6-dimethylbenzimidazole synthase, flavin destructase family +FIG00001608 Non-phosphorylating glyceraldehyde-3-phosphate dehydrogenase (NADP) (EC 1.2.1.9) +FIG00001609 Hydantoin racemase (EC 5.1.99.-) +FIG00001610 Periplasmic hemin-binding protein +FIG00001611 Protein of unknown function DUF1447 +FIG00001613 Hydrolase, alpha/beta fold family functionally coupled to Phosphoribulokinase +FIG00001614 FIG001614: Membrane protein +FIG00001616 Isopentenyl-diphosphate delta-isomerase (EC 5.3.3.2) +FIG00001617 Protein-export membrane protein SecD (TC 3.A.5.1.1) +FIG00001618 Oxaloacetate decarboxylase alpha chain (EC 4.1.1.3) +FIG00001621 FIG001621: Zinc protease +FIG00001622 Tryptophan 2,3-dioxygenase (EC 1.13.11.11) +FIG00001628 Putative membrane-bound ClpP-class protease associated with aq_911 +FIG00001629 Glucose-methanol-choline (GMC) oxidoreductase:NAD binding site +FIG00001630 Alpha-aspartyl dipeptidase Peptidase E (EC 3.4.13.21) +FIG00001631 Sensory histidine kinase in two-component regulatory system with RstA +FIG00001632 Glucans biosynthesis glucosyltransferase H (EC 2.4.1.-) +FIG00001634 DNA-binding protein Fis +FIG00001635 Translation elongation factor G-related protein +FIG00001636 Maltose O-acetyltransferase (EC 2.3.1.79) +FIG00001637 Two-component response regulator SA14-24 +FIG00001642 Alanine racemase (EC 5.1.1.1) +FIG00001643 Phosphoenolpyruvate carboxykinase [GTP] (EC 4.1.1.32) +FIG00001644 L,D-transpeptidase YcbB +FIG00001646 Transcription regulator [contains diacylglycerol kinase catalytic domain] +FIG00001647 Maltodextrin glucosidase (EC 3.2.1.20) +FIG00001648 Chorismate mutase I (EC 5.4.99.5) / Cyclohexadienyl dehydrogenase (EC 1.3.1.12)(EC 1.3.1.43) +FIG00001649 N-methylhydantoinase A (EC 3.5.2.14) +FIG00001650 Histone acetyltransferase HPA2 and related acetyltransferases +FIG00001652 PhnJ protein +FIG00001653 Fructokinase (EC 2.7.1.4) +FIG00001656 RNA-binding protein Jag +FIG00001659 2-dehydro-3-deoxygalactonokinase (EC 2.7.1.58) +FIG00001662 Trimethylamine-N-oxide reductase (EC 1.6.6.9) +FIG00001663 GTP-sensing transcriptional pleiotropic repressor codY +FIG00001666 LemA protein +FIG00001667 Macrolide export ATP-binding/permease protein MacB (EC 3.6.3.-) +FIG00001668 DNA-binding heavy metal response regulator +FIG00001670 Adenine-specific methyltransferase (EC 2.1.1.72) +FIG00001672 N-acetylglucosamine kinase of eukaryotic type (EC 2.7.1.59) +FIG00001673 carbon monoxide dehydrogenase G protein +FIG00001674 FIG001674: hypothetical protein +FIG00001675 Oxaloacetate decarboxylase beta chain (EC 4.1.1.3) +FIG00001676 Ferredoxin +FIG00001681 Protocatechuate 3,4-dioxygenase beta chain (EC 1.13.11.3) +FIG00001682 Inosine-guanosine kinase (EC 2.7.1.73) +FIG00001684 soluble [2Fe-2S] ferredoxin +FIG00001685 Putative esterase, FIGfam005057 +FIG00001686 PhnH protein +FIG00001687 Sarcosine oxidase alpha subunit (EC 1.5.3.1) +FIG00001690 High-affinity choline uptake protein BetT +FIG00001691 2-methylcitrate dehydratase FeS dependent (EC 4.2.1.79) +FIG00001695 D-serine dehydratase (EC 4.3.1.18) +FIG00001699 LptA, protein essential for LPS transport across the periplasm +FIG00001701 Aerobic respiration control protein arcA +FIG00001706 Copper sensory histidine kinase CpxA +FIG00001707 Inner membrane protein forms channel for type IV secretion of T-DNA complex (VirB8) +FIG00001709 LPS-assembly lipoprotein RlpB precursor (Rare lipoprotein B) +FIG00001710 ATPase, AFG1 family +FIG00001712 Transcription accessory protein (S1 RNA-binding domain) +FIG00001713 Deoxyribonuclease TatD +FIG00001714 Histidine kinase of the competence regulon ComD +FIG00001719 Co-activator of prophage gene expression IbrB +FIG00001721 FIG001721: Predicted N6-adenine-specific DNA methylase +FIG00001722 3,4-dihydroxyphenylacetate 2,3-dioxygenase (EC 1.13.11.15) +FIG00001724 C-terminal domain of CinA paralog, YdeJ +FIG00001725 4-hydroxy-2-oxovalerate aldolase (EC 4.1.3.39) +FIG00001726 Cell division protein GpsB, coordinates the switch between cylindrical and septal cell wall synthesis by re-localization of PBP1 +FIG00001732 Aminopeptidase C (EC 3.4.22.40) +FIG00001735 Salicylate hydroxylase (EC 1.14.13.1) +FIG00001736 cytosolic long-chain acyl-CoA thioester hydrolase family protein +FIG00001739 Type IV pilus biogenesis protein PilM +FIG00001743 Similar to ribosomal large subunit pseudouridine synthase D, Bacillus subtilis YhcT type +FIG00001745 3'(2'),5'-bisphosphate nucleotidase (EC 3.1.3.7) +FIG00001747 Putative metallopeptidase (Zinc) SprT family +FIG00001748 Histidinol-phosphatase [alternative form] (EC 3.1.3.15) +FIG00001750 Carbon starvation protein A +FIG00001753 Dihydrolipoamide acetyltransferase component (E2) of acetoin dehydrogenase complex (EC 2.3.1.-) +FIG00001754 Ku domain protein +FIG00001755 Uridine kinase (EC 2.7.1.48) [C1] +FIG00001756 5-methyl-dCTP pyrophosphohydrolase (EC 3.6.1.-) +FIG00001757 Serine--pyruvate aminotransferase (EC 2.6.1.51) / L-alanine:glyoxylate aminotransferase (EC 2.6.1.44) +FIG00001758 Late competence protein ComGB, access of DNA to ComEA +FIG00001759 Pole remodelling regulatory diguanylate cyclase +FIG00001761 SAM-dependent methyltransferase, MraW methylase family (EC 2.1.1.-) +FIG00001765 Phage shock protein C +FIG00001766 Citrate lyase alpha chain (EC 4.1.3.6) +FIG00001767 L-rhamnose operon transcriptional activator RhaR +FIG00001769 COG1683: Uncharacterized conserved protein / FIG143828: Hypothetical protein YbgA +FIG00001770 DNA mismatch repair endonuclease MutH +FIG00001771 Nickel responsive regulator NikR +FIG00001774 Late competence protein ComGA, access of DNA to ComEA +FIG00001777 3-carboxy-cis,cis-muconate cycloisomerase (EC 5.5.1.2) +FIG00001778 Thiosulfate sulfurtransferase GlpE (EC 2.8.1.1) +FIG00001779 Tail-specific protease precursor (EC 3.4.21.102) +FIG00001781 Chromosome replication initiation protein DnaD +FIG00001783 Diphosphomevalonate decarboxylase (EC 4.1.1.33) +FIG00001785 ABC-type multidrug transport system, permease component +FIG00001792 Phenylalanine-4-hydroxylase (EC 1.14.16.1) +FIG00001793 D-Lactate dehydrogenase (EC 1.1.2.5) +FIG00001794 Deacetylases, including yeast histone deacetylase and acetoin utilization protein +FIG00001795 PhnG protein +FIG00001796 Type IV pilus biogenesis protein PilO +FIG00001798 Co-activator of prophage gene expression IbrA +FIG00001799 2-oxo-hepta-3-ene-1,7-dioic acid hydratase (EC 4.2.-.-) +FIG00001800 Succinylglutamate desuccinylase (EC 3.5.1.96) +FIG00001801 Glutathione-regulated potassium-efflux system ancillary protein KefG +FIG00001802 FIG001802: Putative alkaline-shock protein +FIG00001803 Polyferredoxin NapH (periplasmic nitrate reductase) +FIG00001807 Indigoidine synthase A-like protein, uncharacterized enzyme involved in pigment biosynthesis +FIG00001808 PTS system, maltose and glucose-specific IIC component (EC 2.7.1.69) / PTS system, maltose and glucose-specific IIB component (EC 2.7.1.69) +FIG00001809 S-formylglutathione hydrolase (EC 3.1.2.12) +FIG00001810 General secretion pathway protein D +FIG00001811 PTS system, mannitol-specific IIA component +FIG00001813 Gluconate utilization system Gnt-I transcriptional repressor +FIG00001814 Functional role page for Anaerobic nitric oxide reductase transcription regulator NorR +FIG00001818 LSU ribosomal protein L3p (L3e) +FIG00001819 Uridine monophosphate kinase (EC 2.7.4.22) +FIG00001820 Isocitrate dehydrogenase phosphatase (EC 2.7.11.5)/kinase (EC 3.1.3.-) +FIG00001821 2,3,4,5-tetrahydropyridine-2,6-dicarboxylate N-acetyltransferase (EC 2.3.1.89) +FIG00001822 Pantothenate:Na+ symporter (TC 2.A.21.1.1) +FIG00001824 Teichoic acid export ATP-binding protein TagH (EC 3.6.3.40) +FIG00001825 Phenylacetate-CoA oxygenase, PaaI subunit +FIG00001826 FIG001826: putative inner membrane protein +FIG00001828 Tagatose 1,6-diphosphate aldolase (EC 4.1.2.40) +FIG00001830 dCMP deaminase (EC 3.5.4.12); Late competence protein ComEB +FIG00001833 DedD protein +FIG00001834 N-acetylmannosaminyltransferase (EC 2.4.1.187) +FIG00001836 Endonuclease V (EC 3.1.21.7) +FIG00001838 [Citrate [pro-3S]-lyase] ligase (EC 6.2.1.22) +FIG00001841 Nucleoid-associated protein NdpA +FIG00001843 Phage tail sheath monomer +FIG00001846 D-erythrose-4-phosphate dehydrogenase (EC 1.2.1.72) +FIG00001850 alternate gene name: yzbB +FIG00001853 Phage shock protein B +FIG00001855 Glycine cleavage system transcriptional activator GcvA +FIG00001859 NAD(P)HX dehydratase +FIG00001862 L-rhamnose mutarotase +FIG00001863 YlxP-like protein +FIG00001865 Rhamnulokinase (EC 2.7.1.5) +FIG00001867 COG1242: Predicted Fe-S oxidoreductase +FIG00001869 Exoribonuclease II (EC 3.1.13.1) +FIG00001871 Glycerol-3-phosphate ABC transporter, permease protein UgpE (TC 3.A.1.1.3) +FIG00001872 COG1720: Uncharacterized conserved protein +FIG00001876 Allantoicase (EC 3.5.3.4) +FIG00001878 TonB-dependent hemin , ferrichrome receptor +FIG00001879 FIG004454: RNA binding protein +FIG00001880 CobW GTPase involved in cobalt insertion for B12 biosynthesis +FIG00001881 FIG001881: hydrolase of alkaline phosphatase superfamily +FIG00001882 6-phospho-beta-glucosidase (EC 3.2.1.86) +FIG00001885 PTS system, mannitol-specific IIB component (EC 2.7.1.69) / PTS system, mannitol-specific IIC component (EC 2.7.1.69) +FIG00001887 Bacterioferritin +FIG00001888 5-aminolevulinate synthase (EC 2.3.1.37) +FIG00001892 YihE protein, a ser/thr kinase implicated in LPS synthesis and Cpx signalling +FIG00001893 Inosose isomerase (EC 5.3.99.-) +FIG00001895 Type IV pilus biogenesis protein PilP +FIG00001896 LSU ribosomal protein L25p +FIG00001898 Na(+) H(+) antiporter subunit A; Na(+) H(+) antiporter subunit B +FIG00001899 Flagellar transcriptional activator FlhD +FIG00001902 V-type ATP synthase subunit A (EC 3.6.3.14) +FIG00001903 Protein export cytoplasm chaperone protein (SecB, maintains protein to be exported in unfolded state) +FIG00001904 Outer surface protein of unknown function, cellobiose operon +FIG00001906 Sensor kinase CitA, DpiB (EC 2.7.3.-) +FIG00001907 Glycerol uptake operon antiterminator regulatory protein +FIG00001908 UDP-sugar hydrolase (EC 3.6.1.45); 5'-nucleotidase (EC 3.1.3.5) +FIG00001909 Flagellar biosynthesis protein FliT +FIG00001910 Acyl carrier protein phosphodiesterase (EC 3.1.4.14) +FIG00001912 Transcriptional repressor of PutA and PutP / Proline dehydrogenase (EC 1.5.99.8) (Proline oxidase) / Delta-1-pyrroline-5-carboxylate dehydrogenase (EC 1.5.1.12) +FIG00001914 Metallo-beta-lactamase superfamily protein PA0057 +FIG00001915 Anaerobic glycerol-3-phosphate dehydrogenase subunit A (EC 1.1.5.3) +FIG00001917 ATP-dependent RNA helicase RhlB +FIG00001920 DNA-binding response regulator GltR, controls specific porins for the entry of glucose +FIG00001925 Predicted P-loop ATPase fused to an acetyltransferase COG1444 +FIG00001926 tRNA (Uracil54-C5-)-methyltransferase (EC 2.1.1.35) +FIG00001928 Cold shock protein CspC +FIG00001930 Cell division protein DivIC (FtsB), stabilizes FtsL against RasP cleavage +FIG00001932 Probable Co/Zn/Cd efflux system membrane fusion protein +FIG00001940 Hypothetical protein, ydbS homolog +FIG00001943 FIG001943: hypothetical protein YajQ +FIG00001946 Soluble cytochrome b562 +FIG00001950 tRNA (uridine-5-oxyacetic acid methyl ester) 34 synthase +FIG00001952 Origin of replication recognition protein @ Cell division control protein 6 +FIG00001953 PTS system, glucitol/sorbitol-specific IIC component +FIG00001955 Glutathione-regulated potassium-efflux system ATP-binding protein +FIG00001957 FIG001957: putative hydrolase +FIG00001960 FIG001960: FtsZ-interacting protein related to cell division +FIG00001963 Uncharacterized protein ImpF +FIG00001964 Hypothetical transmembrane protein coupled to NADH-ubiquinone oxidoreductase chain 5 homolog +FIG00001965 Inner membrane protein YrbG, predicted calcium/sodium:proton antiporter +FIG00001968 PTS system, mannose-specific IIB component (EC 2.7.1.69) +FIG00001969 Hypothetical flavoprotein YqcA (clustered with tRNA pseudouridine synthase C) +FIG00001971 2-C-methyl-D-erythritol 4-phosphate cytidylyltransferase (EC 2.7.7.60) / 2-C-methyl-D-erythritol 2,4-cyclodiphosphate synthase (EC 4.6.1.12) +FIG00001976 Glutamyl-tRNA(Gln) synthetase (EC 6.1.1.24) +FIG00001980 Very-short-patch mismatch repair endonuclease (G-T specific) +FIG00001981 Chromosome partition protein MukF +FIG00001984 Protein yihD +FIG00001987 CBS domain protein, lmo1865 homolog +FIG00001990 PTS system, glucitol/sorbitol-specific IIB component and second of two IIC components (EC 2.7.1.69) +FIG00001992 Phosphohistidine phosphatase SixA +FIG00001997 Methionine gamma-lyase (EC 4.4.1.11) +FIG00001998 Pyruvate decarboxylase (EC 4.1.1.1); Alpha-keto-acid decarboxylase (EC 4.1.1.-) +FIG00002002 Ascorbate-specific PTS system, EIIC component +FIG00002008 Allantoinase (EC 3.5.2.5) +FIG00002009 Hypothetical protein, ydbT homolog +FIG00002010 Copper resistance protein B +FIG00002011 Ferric iron ABC transporter, iron-binding protein +FIG00002012 Inner membrane protein forms channel for type IV secretion of T-DNA complex (VirB3) +FIG00002013 N-methylhydantoinase B (EC 3.5.2.14) +FIG00002016 Minor fimbrial subunit StfF +FIG00002018 Molybdenum cofactor biosynthesis protein MoaA +FIG00002020 Alpha-galactosidase (EC 3.2.1.22) +FIG00002022 Nucleotide excision repair protein, with UvrB/UvrC motif +FIG00002024 Formate dehydrogenase related protein +FIG00002026 Nucleotidase YfbR, HD superfamily +FIG00002027 Chromosome partition protein MukB +FIG00002029 tRNA-t(6)A37 methylthiotransferase +FIG00002034 CRISPR-associated helicase Cas3 +FIG00002035 Protein involved in catabolism of external DNA +FIG00002036 Chorismate mutase II (EC 5.4.99.5) +FIG00002037 Cobalt-precorrin-6y C15-methyltransferase [decarboxylating] (EC 2.1.1.-) +FIG00002039 Predicted aminoglycoside phosphotransferase +FIG00002041 Flagellar motor switch protein FliN +FIG00002047 Gamma-glutamyl-putrescine oxidase (EC1.4.3.-) +FIG00002048 Cell division inhibitor +FIG00002049 Oligopeptide transport ATP-binding protein OppD (TC 3.A.1.5.1) +FIG00002050 Urease alpha subunit (EC 3.5.1.5) +FIG00002052 Cobalamin biosynthesis protein CbiG / Cobalt-precorrin-3b C17-methyltransferase +FIG00002053 Na(+)-translocating NADH-quinone reductase subunit D (EC 1.6.5.-) +FIG00002057 Autoinducer 2 (AI-2) ABC transport system, periplasmic AI-2 binding protein LsrB +FIG00002060 FIG002060: uncharacterized protein YggL +FIG00002065 Glyoxylate carboligase (EC 4.1.1.47) +FIG00002066 Cytoplasmic alpha-amylase (EC 3.2.1.1) +FIG00002070 Arabinose-proton symporter +FIG00002075 Sulfate-binding protein Sbp +FIG00002081 Alkaline phosphodiesterase I (EC 3.1.4.1) / Nucleotide pyrophosphatase (EC 3.6.1.9) +FIG00002084 Taurine-binding periplasmic protein TauA +FIG00002085 diguanylate cyclase (GGDEF domain) with PAS/PAC sensor +FIG00002086 TPR domain protein, putative component of TonB system +FIG00002090 Stage V sporulation protein B +FIG00002093 Sarcosine oxidase beta subunit (EC 1.5.3.1) +FIG00002094 3-oxoadipate CoA-transferase subunit A (EC 2.8.3.6) +FIG00002095 FIG002095: hypothetical protein +FIG00002099 Acetyl-coenzyme A carboxyl transferase alpha chain (EC 6.4.1.2) / Acetyl-coenzyme A carboxyl transferase beta chain (EC 6.4.1.2); Propionyl-CoA carboxylase beta chain (EC 6.4.1.3) +FIG00002100 Hypothetical protein PA2244 (similar to DNA topoisomerase IB, but possibly involved in glycosyl-transfer) +FIG00002102 3-oxoadipate CoA-transferase subunit B (EC 2.8.3.6) +FIG00002104 Cobalamin biosynthesis protein CobG +FIG00002107 1,2-dihydroxy-3-keto-5-methylthiopentene dioxygenase (EC 1.13.11.54) +FIG00002110 2-keto-3-deoxy-D-arabino-heptulosonate-7-phosphate synthase I alpha (EC 2.5.1.54) +FIG00002113 HMP-PP hydrolase (pyridoxal phosphatase) Cof, detected in genetic screen for thiamin metabolic genes (PMID:15292217) +FIG00002117 L-arabinose isomerase (EC 5.3.1.4) +FIG00002119 RNA 3'-terminal phosphate cyclase (EC 6.5.1.4) +FIG00002120 Ferric reductase (1.6.99.14) +FIG00002122 Bona fide RidA/YjgF/TdcF/RutC subgroup +FIG00002123 Maltose operon periplasmic protein MalM +FIG00002124 NADH dehydrogenase, subunit 5 +FIG00002126 Transcriptional regulator RutR of pyrimidine catabolism (TetR family) +FIG00002129 Threonine kinase in B12 biosynthesis +FIG00002130 Glycerol-3-phosphate ABC transporter, periplasmic glycerol-3-phosphate-binding protein (TC 3.A.1.1.3) +FIG00002133 Two-component sensor histidine kinase, malate (EC 2.7.3.-) +FIG00002137 Phenylacetate-CoA oxygenase, PaaH subunit +FIG00002138 Transcription initiation factor B +FIG00002141 Competence protein CoiA +FIG00002142 FIG001886: Cytoplasmic hypothetical protein +FIG00002143 Methylglyoxal reductase, acetol producing (EC 1.1.1.-) / 2,5-diketo-D-gluconic acid reductase B (EC 1.1.1.274) +FIG00002146 YrbA protein +FIG00002148 Aspartate carbamoyltransferase regulatory chain (PyrI) +FIG00002150 Aerobic respiration control sensor protein arcB (EC 2.7.3.-) +FIG00002153 Putative regulator of the mannose operon, ManO +FIG00002156 NG,NG-dimethylarginine dimethylaminohydrolase 1 (EC 3.5.3.18) +FIG00002158 UPF0246 protein YaaA +FIG00002159 PTS system, N-acetylgalactosamine-specific IIB component (EC 2.7.1.69) +FIG00002161 MotA/TolQ/ExbB proton channel family protein +FIG00002162 Hypothetical protein YrhD +FIG00002163 Rhamnulose-1-phosphate aldolase (EC 4.1.2.19) +FIG00002164 S-adenosylmethionine-dependent methyltransferase Functionally Coupled to the MukBEF Chromosome Partitioning Mechanism +FIG00002166 Cytochrome c oxidase subunit CcoQ (EC 1.9.3.1) +FIG00002170 Outer membrane lipoprotein LolB +FIG00002174 Catechol 1,2-dioxygenase (EC 1.13.11.1) +FIG00002176 Methylthioribulose-1-phosphate dehydratase (EC 4.2.1.109) +FIG00002177 N-acetylglucosamine-6P-responsive transcriptional repressor NagC, ROK family +FIG00002178 D-amino-acid oxidase (EC 1.4.3.3) +FIG00002186 CO dehydrogenase accessory protein CooC (nickel insertion) +FIG00002187 Protein SlyX +FIG00002188 FIG002188: hypothetical protein +FIG00002191 Universal stress protein A +FIG00002192 Universal stress protein B +FIG00002193 Plasmid replication protein RepB +FIG00002194 FIG146085: 3'-to-5' oligoribonuclease A, Bacillus type +FIG00002195 Formate dehydrogenase O alpha subunit (EC 1.2.1.2) @ selenocysteine-containing +FIG00002196 Serine-protein kinase RsbW (EC 2.7.11.1) +FIG00002198 Cobalt-precorrin-6y C5-methyltransferase (EC 2.1.1.-) +FIG00002199 Peptide methionine sulfoxide reductase MsrA (EC 1.8.4.11) +FIG00002204 Phosphoethanolamine transferase EptA specific for the 1 phosphate group of core-lipid A +FIG00002205 DNA helicase IV +FIG00002208 FIG002208: Acetyltransferase (EC 2.3.1.-) +FIG00002212 PTS system, mannose-specific IIA component (EC 2.7.1.69) / PTS system, mannose-specific IIB component (EC 2.7.1.69) +FIG00002214 Xylose activator XylR (AraC family) +FIG00002216 Oligopeptidase A (EC 3.4.24.70) +FIG00002217 Acyl-CoA thioesterase II (EC 3.1.2.-) +FIG00002218 PTS system, N-acetylglucosamine-specific IIB component (EC 2.7.1.69) / PTS system, N-acetylglucosamine-specific IIC component +FIG00002221 Putative analog of CcoH, COG3198 +FIG00002223 Flavodoxin 1 +FIG00002224 protein from nitrogen regulatory protein P-II (GLNB) family, ortholog YAAQ B. subtilis +FIG00002225 Peroxide stress regulator; Ferric uptake regulation protein; Fe2+/Zn2+ uptake regulation proteins +FIG00002228 YcfP protein: probably an esterase that is part of a salvage cluster +FIG00002231 Membrane-bound lytic murein transglycosylase A precursor (EC 3.2.1.-) +FIG00002236 PTS system, mannose-specific IIA component +FIG00002239 Glycerophosphoryl diester phosphodiesterase (EC 3.1.4.46) +FIG00002240 Transcriptional regulatory protein CitB, DpiA +FIG00002241 Integral inner membrane protein of type IV secretion complex (VirB6) +FIG00002242 Propionate catabolism operon regulatory protein PrpR +FIG00002244 YjbH outer membrane lipoprotein +FIG00002245 Glycerophosphoryl diester phosphodiesterase, periplasmic (EC 3.1.4.46) +FIG00002246 3-oxoacyl-[acyl-carrier-protein] synthase, KASII (EC 2.3.1.179) +FIG00002250 Predicted galactitol operon regulator (Transcriptional antiterminator), BglG family / PTS system, mannitol/fructose-specific IIA component (EC 2.7.1.69) +FIG00002251 Galactose/methyl galactoside ABC transport system, permease protein MglC (TC 3.A.1.2.3) +FIG00002252 Galactose/methyl galactoside ABC transport system, D-galactose-binding periplasmic protein MglB (TC 3.A.1.2.3) +FIG00002255 3-hydroxybutyryl-CoA dehydratase (EC 4.2.1.55) +FIG00002260 5-amino-6-(5-phosphoribosylamino)uracil reductase (EC 1.1.1.193) +FIG00002265 Maltose/maltodextrin ABC transporter, substrate binding periplasmic protein MalE +FIG00002266 Acyl-CoA dehydrogenase (EC 1.3.8.7) +FIG00002267 Inosine/xanthosine triphosphatase (EC 3.6.1.-) +FIG00002268 ATP-dependent DNA ligase (EC 6.5.1.1) clustered with Ku protein, LigD +FIG00002272 Predicted transcriptional regulator of the myo-inositol catabolic operon +FIG00002273 N-methylhydantoinase (ATP-hydrolyzing) (EC 3.5.2.14) +FIG00002275 Primosomal replication protein N prime prime +FIG00002278 NrfC protein +FIG00002283 FIG002283: Isochorismatase family protein +FIG00002284 Mannitol operon repressor +FIG00002285 Flavodoxin 2 +FIG00002286 Intracellular septation protein IspA +FIG00002288 Arginine decarboxylase (EC 4.1.1.19) / Lysine decarboxylase (EC 4.1.1.18) +FIG00002289 Soluble lytic murein transglycosylase precursor (EC 3.2.1.-) +FIG00002291 Hemolysin activation/secretion protein associated with VreARI signalling system +FIG00002293 tRNA (guanosine(18)-2'-O)-methyltransferase (EC 2.1.1.34) +FIG00002297 Putative TEGT family carrier/transport protein +FIG00002298 Membrane protein, distant similarity to thiosulphate:quinone oxidoreductase DoxD +FIG00002299 Ascorbate-specific PTS system, EIIB component (EC 2.7.1.69) +FIG00002300 Ribulokinase (EC 2.7.1.16) +FIG00002301 Proposed lipoate regulatory protein YbeD +FIG00002303 Regulatory protein AsnC +FIG00002304 Putative sugar isomerase involved in processing of exogenous sialic acid +FIG00002307 tRNA 5-methylaminomethyl-2-thiouridine synthase TusB +FIG00002309 PTS system, N-acetylgalactosamine-specific IID component (EC 2.7.1.69) +FIG00002311 Septation ring formation regulator EzrA +FIG00002320 Dihydropyrimidinase (EC 3.5.2.2) +FIG00002321 Galactose-6-phosphate isomerase, LacA subunit (EC 5.3.1.26) +FIG00002327 Response regulator for an arabinose sensor +FIG00002328 Acyl carrier protein +FIG00002329 Aldose 1-epimerase family protein YeaD +FIG00002330 Uncharacterized ABC transporter, auxiliary component YrbC +FIG00002331 Acyl-CoA thioesterase YciA, involved in membrane biogenesis +FIG00002332 Inositol-1-monophosphatase (EC 3.1.3.25) +FIG00002333 Putative Dihydrolipoamide dehydrogenase (EC 1.8.1.4); Mercuric ion reductase (EC 1.16.1.1); PF00070 family, FAD-dependent NAD(P)-disulphide oxidoreductase +FIG00002336 Putative phosphatase YfbT +FIG00002338 Ethanolamine utilization polyhedral-body-like protein EutL +FIG00002340 Chromosome partition protein MukE +FIG00002342 Muconolactone isomerase (EC 5.3.3.4) +FIG00002343 FIG002343: hypothetical protein +FIG00002344 FIG002344: Hydrolase (HAD superfamily) +FIG00002351 Predicted membrane fusion protein (MFP) component of efflux pump, membrane anchor protein YbhG +FIG00002352 Phytochrome, two-component sensor histidine kinase (EC 2.7.3.-) +FIG00002353 Ethanolamine utilization protein EutA +FIG00002354 Lipopolysaccharide biosynthesis protein RffA +FIG00002355 Phage tail assembly protein +FIG00002360 4-aminobutyraldehyde dehydrogenase (EC 1.2.1.19) +FIG00002364 Membrane Protein Functionally coupled to the MukBEF Chromosome Partitioning Mechanism +FIG00002365 Unsaturated fatty acid biosythesis repressor FabR, TetR family +FIG00002367 Archaeal S-adenosylmethionine synthetase (EC 2.5.1.6) +FIG00002368 Protein of unknown function DUF81 +FIG00002372 Malonate decarboxylase delta subunit +FIG00002373 Nitrous oxide reductase maturation protein NosD +FIG00002374 Malonate decarboxylase alpha subunit +FIG00002376 Galactose-6-phosphate isomerase, LacB subunit (EC 5.3.1.26) +FIG00002377 Phosphomannomutase (EC 5.4.2.8) / Phosphoglucosamine mutase (EC 5.4.2.10) +FIG00002379 FIG002379: metal-dependent hydrolase +FIG00002380 anti-sigma B factor RsbT +FIG00002381 Siroheme synthase / Precorrin-2 oxidase (EC 1.3.1.76) +FIG00002384 Ethanolamine utilization protein EutJ +FIG00002385 NPQTN specific sortase B +FIG00002386 Sialic acid-induced transmembrane protein YjhT(NanM), possible mutarotase +FIG00002387 Phosphatidylglycerophosphatase B (EC 3.1.3.27) +FIG00002389 Oxaloacetate decarboxylase gamma chain (EC 4.1.1.3) +FIG00002390 General secretion pathway protein E +FIG00002391 Glycine cleavage system transcriptional activator +FIG00002392 Motility accessory factor +FIG00002394 Nitrous oxide reductase maturation protein NosF (ATPase) +FIG00002395 Cysteinyl-tRNA synthetase related protein +FIG00002401 Low G+C gram positive nudix hydrolase YtkD (EC 3.6.-.-) +FIG00002402 6 kDa early secretory antigenic target ESAT-6 (EsxA) +FIG00002403 Anaerobic dimethyl sulfoxide reductase chain A (EC 1.8.5.3) +FIG00002404 Transcriptional regulator YbiH, TetR family +FIG00002405 Malonate decarboxylase beta subunit +FIG00002410 Recombinational DNA repair protein RecT (prophage associated) +FIG00002411 YjbH-like, GTP pyrophosphokinase domain +FIG00002412 DNA-binding protein HBsu +FIG00002414 Sirohydrochlorin cobaltochelatase CbiK (EC 4.99.1.3) +FIG00002416 DinG family ATP-dependent helicase CPE1197 +FIG00002417 Dihydroneopterin triphosphate epimerase +FIG00002418 Bacterial luciferase family protein YtmO, in cluster with L-cystine ABC transporter +FIG00002420 Cytochrome c-type protein NrfB precursor +FIG00002423 UDP-glucuronic acid oxidase (UDP-4-keto-hexauronic acid decarboxylating) (EC 1.1.1.305) / UDP-4-amino-4-deoxy-L-arabinose formyltransferase (EC 2.1.2.13) +FIG00002427 Polymyxin resistance protein PmrJ, predicted deacetylase +FIG00002428 FIG005590: DegV family protein +FIG00002429 Putative acetyl esterase YjcH (EC 3.1.1.-) +FIG00002431 Succinate dehydrogenase cytochrome b subunit +FIG00002432 NADH oxidoreductase hcr (EC 1.-.-.-) +FIG00002434 FIG002434: Uncharacterized protein YtpQ +FIG00002436 RecA/RadA recombinase +FIG00002438 Coenzyme F420-dependent N5,N10-methylene tetrahydromethanopterin reductase and related flavin-dependent oxidoreductases; sulfonate monooxygenase +FIG00002441 Transcriptional regulator, FUR family +FIG00002442 HspR, transcriptional repressor of DnaK operon +FIG00002444 Chaperone protein TorD +FIG00002448 MSHA pilin protein MshA +FIG00002449 Manganese-dependent protein-tyrosine phosphatase (EC 3.1.3.48) +FIG00002451 CDP-diacylglycerol pyrophosphatase (EC 3.6.1.26) +FIG00002453 Carbon storage regulator +FIG00002455 Uncharacterized protein YfiR precursor +FIG00002456 Polymyxin resistance protein PmrL, sucrose-6 phosphate hydrolase +FIG00002457 FIG111991: hypothetical protein +FIG00002458 Type IV pilin PilA +FIG00002459 CRISPR-associated protein, Cse4 family +FIG00002460 V-type ATP synthase subunit D (EC 3.6.3.14) +FIG00002462 Inner membrane protein YfiN +FIG00002463 Alpha-D-GlcNAc alpha-1,2-L-rhamnosyltransferase (EC 2.4.1.-) +FIG00002464 NAD-dependent formate dehydrogenase beta subunit +FIG00002465 FIG002465: BNR repeat protein +FIG00002470 Probable poly(beta-D-mannuronate) O-acetylase (EC 2.3.1.-) +FIG00002473 FIG002473: Protein YcaR in KDO2-Lipid A biosynthesis cluster +FIG00002474 Transcriptional regulator, PadR family +FIG00002483 GGDEF and EAL domain proteins +FIG00002486 L-fuculose phosphate aldolase (EC 4.1.2.17) +FIG00002487 Heptaprenyl diphosphate synthase component II (EC 2.5.1.30) +FIG00002488 Dihydroxyacetone kinase, ATP-dependent (EC 2.7.1.29) +FIG00002489 Spore germination protein GerKA +FIG00002490 Transcriptional regulator in cluster with unspecified monosaccharide ABC transport system +FIG00002491 Periplasmic alpha-amylase (EC 3.2.1.1) +FIG00002492 UDP-N-acetylmuramate:L-alanyl-gamma-D-glutamyl-meso-diaminopimelate ligase (EC 6.3.2.-) +FIG00002494 Leucine-, isoleucine-, valine-, threonine-, and alanine-binding protein +FIG00002495 Acetaldehyde dehydrogenase, acetylating, (EC 1.2.1.10) in gene cluster for degradation of phenols, cresols, catechol +FIG00002496 Triphosphoribosyl-dephospho-CoA synthetase (EC 2.7.8.25) +FIG00002497 Putative lipase in cluster with Phosphatidate cytidylyltransferase +FIG00002500 Stage V sporulation protein AD (SpoVAD) +FIG00002503 Malonate decarboxylase gamma subunit +FIG00002504 DNA-damage-inducible protein J +FIG00002505 Chaperone-modulator protein CbpM +FIG00002507 Nitrous oxide reductase maturation protein, outer-membrane lipoprotein NosL +FIG00002508 Membrane protein containing HD superfamily hydrolase domain, YQFF ortholog +FIG00002509 Glutathione S-transferase, omega (EC 2.5.1.18) +FIG00002511 Ni/Fe-hydrogenase 2 B-type cytochrome subunit +FIG00002512 Sensor protein torS (EC 2.7.3.-) +FIG00002515 4-hydroxybenzoyl-CoA thioesterase family active site +FIG00002517 Exoenzymes regulatory protein AepA precursor +FIG00002518 Cystine ABC transporter, permease protein +FIG00002519 6-phospho-3-hexuloisomerase +FIG00002522 Enoyl-CoA hydratase [isoleucine degradation] (EC 4.2.1.17) / 3-hydroxyacyl-CoA dehydrogenase (EC 1.1.1.35) +FIG00002523 Proteasome subunit alpha (EC 3.4.25.1), archaeal +FIG00002526 Malonyl CoA acyl carrier protein transacylase (EC 2.3.1.39) +FIG00002534 General secretion pathway protein C +FIG00002535 COG2740: Predicted nucleic-acid-binding protein implicated in transcription termination / ribosomal protein L7Ae family protein +FIG00002538 Negative regulator of flagellin synthesis FlgM +FIG00002541 Pyruvate formate-lyase (EC 2.3.1.54) +FIG00002546 Conjugative transfer protein TrbJ +FIG00002550 Nitrogenase (molybdenum-iron) alpha chain (EC 1.18.6.1) +FIG00002553 Starvation sensing protein RspA +FIG00002554 Putative lipoprotein SAV1865 +FIG00002555 Ortholog of S. aureus MRSA252 (BX571856) SAR1694 +FIG00002556 RsbS, negative regulator of sigma-B +FIG00002557 TorCAD operon transcriptional regulatory protein TorR +FIG00002559 PTS system, N-acetylgalactosamine- and galactosamine-specific IIA component (EC 2.7.1.69) +FIG00002560 V-type ATP synthase subunit C (EC 3.6.3.14) +FIG00002561 RNA polymerase sporulation specific sigma factor SigH +FIG00002562 Uncharacterized protein UPF0344 +FIG00002563 Stage V sporulation protein AC (SpoVAC) +FIG00002564 Polyphosphate glucokinase (EC 2.7.1.63) +FIG00002566 Biofilm PGA synthesis deacetylase PgaB (EC 3.-) +FIG00002567 Protoporphyrin IX Mg-chelatase subunit H (EC 6.6.1.1) +FIG00002568 Phosphoglucosamine mutase (EC 5.4.2.10) / Phosphomannomutase (EC 5.4.2.8) +FIG00002570 Proline dehydrogenase (EC 1.5.99.8) (Proline oxidase) +FIG00002571 FIG002571: 4-hydroxybenzoyl-CoA thioesterase domain protein +FIG00002572 Enterobactin synthetase component F, serine activating enzyme (EC 2.7.7.-) +FIG00002573 Pyruvate carboxylase subunit A (EC 6.4.1.1) +FIG00002574 2-aminoethylphosphonate:pyruvate aminotransferase (EC 2.6.1.37) +FIG00002575 Thiol:disulfide interchange protein DsbG precursor +FIG00002580 Nucleoside-diphosphate sugar epimerase/dehydratase +FIG00002581 Archease +FIG00002582 Phytoene desaturase, pro-zeta-carotene producing (EC 1.-.-.-) +FIG00002587 Ferrous iron transport permease EfeU +FIG00002588 Formiminotetrahydrofolate cyclodeaminase (EC 4.3.1.4) +FIG00002592 DNA-damage-inducible protein I +FIG00002596 Nitrogenase (molybdenum-iron) beta chain (EC 1.18.6.1) +FIG00002600 MoxR-like ATPase in aerotolerance operon +FIG00002602 Conjugative transfer protein TrbI +FIG00002604 Acetyl-CoA acetyltransferase (EC 2.3.1.9) +FIG00002606 Putative formate dehydrogenase-specific chaperone +FIG00002607 Inner membrane protein YqjE +FIG00002608 Iron-regulated protein A precursor +FIG00002609 Transcriptional activator RfaH +FIG00002610 21 kDa hemolysin precursor +FIG00002611 Glucans biosynthesis protein G precursor +FIG00002614 Chitin binding protein +FIG00002615 YjbG polysaccharide synthesis-related protein +FIG00002617 Conjugative transfer protein TrbE +FIG00002619 Histidine ABC transporter, ATP-binding protein HisP (TC 3.A.1.3.1) +FIG00002620 Tyrosine-protein kinase transmembrane modulator EpsC +FIG00002621 CRISPR-associated protein, Csd2/Csh2 family +FIG00002623 Putative phosphatidylglycerophosphate synthase +FIG00002628 Altronate oxidoreductase (EC 1.1.1.58) +FIG00002630 Peptide transport system ATP-binding protein SapD +FIG00002634 Tetrathionate reductase subunit A +FIG00002635 Chlorophyll a synthase ChlG (EC 2.5.1.62) +FIG00002637 Uncharacterized membrane protein YqjD +FIG00002638 Membrane protein YciC, linked to IspA +FIG00002640 Bores hole in peptidoglycan layer allowing type IV secretion complex assembly to occur (VirB1) +FIG00002641 Conjugative transfer protein TrbG +FIG00002645 Probable VANILLIN dehydrogenase oxidoreductase protein (EC 1.-.-.-) +FIG00002646 Transcriptional activator of acetoin dehydrogenase operon AcoR +FIG00002647 L-2,4-diaminobutyric acid acetyltransferase (EC 2.3.1.-) +FIG00002650 3-oxoadipate CoA-transferase subunit A (EC 2.8.3.6); Glutaconate CoA-transferase subunit A (EC 2.8.3.12) +FIG00002651 ClpXP protease specificity-enhancing factor / Stringent starvation protein B +FIG00002652 CDP-glycerol: N-acetyl-beta-D-mannosaminyl-1,4-N-acetyl-D-glucosaminyldiphosphoundecaprenyl glycerophosphotransferase +FIG00002653 Fumarate reductase subunit C +FIG00002656 Pyruvate carboxylase subunit B (biotin-containing) (EC 6.4.1.1) +FIG00002659 Uncharacterized protein, homolog of B.subtilis yhgC +FIG00002660 1,2-dihydroxycyclohexa-3,5-diene-1-carboxylate dehydrogenase (EC 1.3.1.25) +FIG00002661 TldE protein, part of TldE/TldD proteolytic complex +FIG00002665 Ascorbate utilization transcriptional regulator UlaR, HTH-type +FIG00002666 Transcriptional regulatory protein PhoP +FIG00002671 Protease III precursor (EC 3.4.24.55) +FIG00002672 Free methionine-(R)-sulfoxide reductase, contains GAF domain +FIG00002674 TldD protein, part of TldE/TldD proteolytic complex +FIG00002677 Tetrathionate reductase sensory transduction histidine kinase +FIG00002678 Succinyl-CoA synthetase, alpha subunit-related enzymes +FIG00002680 Uncharacterized protein YrbK clustered with lipopolysaccharide transporters +FIG00002681 FtsK/SpoIIIE family protein, putative EssC component of Type VII secretion system +FIG00002682 NAD(P)H-flavin reductase (EC 1.5.1.29) (EC 1.16.1.3) +FIG00002685 Cyanoglobin; Hemoglobin-like protein HbN +FIG00002686 Phosphoribulokinase (EC 2.7.1.19) homolog, function unknown +FIG00002687 Transcription repressor of tripartite multidrug resistance system +FIG00002689 Electron transport complex protein RnfG +FIG00002695 Biosynthetic arginine decarboxylase (EC 4.1.1.19) +FIG00002698 2-dehydro-3-deoxyglucarate aldolase (EC 4.1.2.20) +FIG00002702 Nitrogen regulation protein NtrB (EC 2.7.13.3) +FIG00002705 Hypothetical protein YfkK +FIG00002706 NadR transcriptional regulator / Nicotinamide-nucleotide adenylyltransferase, NadR family (EC 2.7.7.1) / Ribosylnicotinamide kinase (EC 2.7.1.22) +FIG00002708 FIG002708: Protein SirB1 +FIG00002713 FIG011065: hypothetical protein +FIG00002715 Nudix-like NDP and NTP phosphohydrolase YmfB +FIG00002716 Ribosomal small subunit pseudouridine synthase A (EC 4.2.1.70) +FIG00002718 Molybdenum transport system permease protein ModB (TC 3.A.1.8.1) +FIG00002719 Peptide chain release factor homolog +FIG00002720 Lipopolysaccharide ABC transporter, ATP-binding protein LptB +FIG00002723 Ribonuclease E inhibitor RraB +FIG00002724 PutR, transcriptional activator of PutA and PutP +FIG00002725 Inner membrane protein YqjF +FIG00002729 PTS system nitrogen-specific IIA component, PtsN +FIG00002732 Arginine ABC transporter, permease protein ArtQ +FIG00002733 tRNA (guanine46-N7-)-methyltransferase (EC 2.1.1.33) +FIG00002735 Cytochrome C553 (soluble cytochrome f) +FIG00002739 Fumarate reductase subunit D +FIG00002741 Arginine ABC transporter, ATP-binding protein ArtP +FIG00002742 Molybdenum transport ATP-binding protein ModC (TC 3.A.1.8.1) +FIG00002744 Glycogen branching enzyme, GH-57-type, archaeal (EC 2.4.1.18) +FIG00002745 Flagellar biosynthesis protein FliZ +FIG00002746 Chromosome (plasmid) partitioning protein ParB +FIG00002747 Arginine ABC transporter, permease protein ArtM +FIG00002748 33 kDa chaperonin (Heat shock protein 33) (HSP33) +FIG00002754 Probable component of the lipoprotein assembly complex (forms a complex with YaeT, YfgL, and NlpB) +FIG00002756 Isoaspartyl dipeptidase (EC 3.4.19.5) @ Asp-X dipeptidase +FIG00002758 Polymyxin resistance protein PmrM +FIG00002759 Similarity with glutathionylspermidine synthase (EC 6.3.1.8), group 1 +FIG00002761 DedA protein +FIG00002762 TATA-box binding protein +FIG00002765 Aerobic cobaltochelatase CobS subunit (EC 6.6.1.2) +FIG00002770 Transcriptional repressor protein TrpR +FIG00002771 Conjugative transfer protein TrbL +FIG00002772 Phosphopantothenoylcysteine synthetase (EC 6.3.2.5) +FIG00002773 Mercuric ion reductase (EC 1.16.1.1) +FIG00002774 regulator of length of O-antigen component of lipopolysaccharide chains +FIG00002775 Membrane-bound lytic murein transglycosylase C precursor (EC 3.2.1.-) +FIG00002776 FIG002776: hypothetical protein +FIG00002781 FIG002781: Alpha-L-glutamate ligase family protein +FIG00002786 DNA polymerase III theta subunit (EC 2.7.7.7) +FIG00002789 Pirin-like protein YhaK +FIG00002791 Cytoplasmic protein YaiE +FIG00002792 Putative preQ0 transporter +FIG00002793 S-adenosylmethionine decarboxylase proenzyme (EC 4.1.1.50), prokaryotic class 1A +FIG00002794 Sulfate transporter, CysZ-type +FIG00002795 Biofilm PGA outer membrane secretin PgaA +FIG00002798 PTS system, mannose-specific IIA component / PTS system, mannose-specific IIB component (EC 2.7.1.69) +FIG00002799 Phosphoheptose isomerase 1 (EC 5.3.1.-) +FIG00002801 L-fuconolactone hydrolase +FIG00002802 Methionine repressor MetJ +FIG00002803 Membrane-associated zinc metalloprotease +FIG00002804 Homocysteine S-methyltransferase (EC 2.1.1.10) +FIG00002805 Transcriptional regulatory protein RtcR +FIG00002806 Uncharacterized ABC transporter, periplasmic component YrbD +FIG00002811 Predicted chaperone lipoprotein YacC, potentially involved in protein secretion +FIG00002813 FIG002813: LPPG:FO 2-phospho-L-lactate transferase like, CofD-like +FIG00002818 Inner membrane protein translocase component YidC, long form +FIG00002819 Low-affinity inorganic phosphate transporter +FIG00002823 L-proline glycine betaine binding ABC transporter protein ProX (TC 3.A.1.12.1) +FIG00002824 Crotonobetaine carnitine-CoA ligase (EC 6.3.2.-) +FIG00002827 Two-component response regulator, malate (EC 2.7.3.-) +FIG00002831 Nitrogenase FeMo-cofactor scaffold and assembly protein NifN +FIG00002835 Thioredoxin-like protein clustered with PA0057 +FIG00002837 Universal stress protein E +FIG00002839 MutS-related protein, family 1 +FIG00002840 Conserved uncharacterized protein CreA +FIG00002842 FIG002842: hypothetical protein +FIG00002845 Ser/Thr and Tyr protein phosphatase (dual specificity) +FIG00002847 HflK protein +FIG00002848 Nicotinamide phosphoribosyltransferase (EC 2.4.2.12) +FIG00002849 Putative predicted metal-dependent hydrolase +FIG00002853 ATP-dependent RNA helicase YejH +FIG00002855 Flagellar protein FlhE +FIG00002857 Thiol peroxidase, Tpx-type (EC 1.11.1.15) +FIG00002860 Ribulosamine/erythrulosamine 3-kinase potentially involved in protein deglycation +FIG00002864 [Protein-PII] uridylyltransferase (EC 2.7.7.59) +FIG00002866 NAD-dependent formate dehydrogenase delta subunit +FIG00002867 Rho-specific inhibitor of transcription termination (YaeO) +FIG00002868 Transcriptional activator protein LysR +FIG00002870 L-fucose isomerase (EC 5.3.1.25) +FIG00002871 L-ectoine synthase (EC 4.2.1.-) +FIG00002872 D-galactarate dehydratase (EC 4.2.1.42) +FIG00002877 Biotin carboxylase of acetyl-CoA carboxylase (EC 6.3.4.14) / Biotin carboxyl carrier protein of acetyl-CoA carboxylase +FIG00002884 MFS superfamily export protein YceL +FIG00002888 LSU rRNA 2'-O-methyl-C2498 methyltransferase RlmM +FIG00002890 Arabinose operon regulatory protein +FIG00002891 Lactose phosphotransferase system repressor +FIG00002895 Chromosome initiation inhibitor +FIG00002896 Conjugative transfer protein TrbB +FIG00002903 FIG002903: a protein of unknown function perhaps involved in purine metabolism +FIG00002904 DnaJ-like protein DjlA +FIG00002908 Squalene--hopene cyclase (EC 5.4.99.17) +FIG00002912 Phage tail length tape-measure protein 1 +FIG00002913 Type III secretion inner membrane protein (YscU,SpaS,EscU,HrcU,SsaU, homologous to flagellar export components) +FIG00002914 Cell division transporter, ATP-binding protein FtsE (TC 3.A.5.1.1) +FIG00002915 Pca regulon regulatory protein PcaR +FIG00002920 2-keto-3-deoxy-D-arabino-heptulosonate-7-phosphate synthase I beta (EC 2.5.1.54) +FIG00002922 Blue copper oxidase CueO precursor +FIG00002924 Nucleoside-diphosphate-sugar epimerases +FIG00002925 Uncharacterized protein YeaC +FIG00002926 Copper homeostasis protein CutF precursor / Lipoprotein NlpE involeved in surface adhesion +FIG00002927 FIG002927: hypothetical protein +FIG00002931 Anhydro-N-acetylmuramic acid kinase (EC 2.7.1.-) +FIG00002938 Iron-responsive regulator Irr +FIG00002944 Glycogen biosynthesis protein GlgD, glucose-1-phosphate adenylyltransferase family +FIG00002947 Chemotaxis protein CheC -- inhibitor of MCP methylation +FIG00002950 UPF0319 protein YccT precursor +FIG00002951 Molybdopterin biosynthesis molybdochelatase MogA +FIG00002954 Phosphonopyruvate decarboxylase (EC 4.1.1.82) +FIG00002956 Protein of unknown function DUF541 +FIG00002958 FIG002958: hypothetical protein +FIG00002960 Potassium-transporting ATPase A chain (EC 3.6.3.12) (TC 3.A.3.7.1) +FIG00002962 Lysophospholipid transporter LplT +FIG00002963 Protein of unknown function DUF484 +FIG00002967 DJ-1/YajL/PfpI superfamily, includes chaperone protein YajL (former ThiJ), parkinsonism-associated protein DJ-1, peptidases PfpI, Hsp31 +FIG00002968 Undecaprenyl-phosphate galactosephosphotransferase (EC 2.7.8.6) +FIG00002974 Nucleoside triphosphate pyrophosphohydrolase MazG (EC 3.6.1.8) +FIG00002976 Benzoylformate decarboxylase (EC 4.1.1.7) +FIG00002977 LysR-family transcriptional regulator YdhB +FIG00002980 SeqA protein, negative modulator of initiation of replication +FIG00002982 Quinone oxidoreductase (EC 1.6.5.5) +FIG00002985 Enoyl-CoA hydratase (EC 4.2.1.17) / 3,2-trans-enoyl-CoA isomerase (EC 5.3.3.8) / 3-hydroxyacyl-CoA dehydrogenase (EC 1.1.1.35) +FIG00002992 L-fuculokinase (EC 2.7.1.51) +FIG00002994 FIG002994: Putative transcriptional regulator +FIG00002997 Inner membrane protein YccF +FIG00003002 HtrA protease/chaperone protein +FIG00003012 His repressor +FIG00003013 Lysine-specific permease +FIG00003015 Nitrous-oxide reductase (EC 1.7.99.6) +FIG00003021 FIG003021: Membrane protein +FIG00003022 L-threonine 3-dehydrogenase (EC 1.1.1.103) +FIG00003023 Transcriptional regulatory protein basR/pmrA +FIG00003024 ATP:Cob(I)alamin adenosyltransferase (EC 2.5.1.17) @ ATP:Cob(I)alamin adenosyltransferase (EC 2.5.1.17), ethanolamine utilization +FIG00003025 Sensory histidine kinase QseC +FIG00003026 23S rRNA (guanine-N-2-) -methyltransferase rlmG (EC 2.1.1.-) +FIG00003027 FIG067310: hypothetical protein +FIG00003029 Tryptophanase (EC 4.1.99.1) +FIG00003033 FIG003033: Helicase domain protein +FIG00003036 Glutamate synthase [NADPH] putative GlxC chain (EC 1.4.1.13) +FIG00003037 ChlI component of cobalt chelatase involved in B12 biosynthesis +FIG00003039 Right origin-binding protein +FIG00003049 Sensor protein DegS +FIG00003050 Cys-tRNA(Pro) deacylase YbaK +FIG00003053 PTS system, chitobiose-specific IIB component (EC 2.7.1.69) +FIG00003055 Organosulfonate utilization protein SsuF +FIG00003069 Cytochrome c-type biogenesis protein CcmE, heme chaperone +FIG00003070 Type IV fimbrial biogenesis protein PilW +FIG00003073 Starvation lipoprotein Slp paralog +FIG00003076 Lactam utilization protein LamB +FIG00003086 Beta-xylosidase (EC 3.2.1.37) +FIG00003087 Murein endopeptidase +FIG00003088 Arsenical pump-driving ATPase (EC 3.6.3.16) +FIG00003090 cAMP-binding proteins - catabolite gene activator and regulatory subunit of cAMP-dependent protein kinases +FIG00003100 YpfJ protein, zinc metalloprotease superfamily +FIG00003110 Outer membrane lipoprotein SmpA, a component of the essential YaeT outer-membrane protein assembly complex +FIG00003111 Transcriptional regulator ArcR essential for anaerobic expression of the ADI pathway, Crp/Fnr family +FIG00003112 Arginine exporter protein ArgO +FIG00003116 Nitrite transporter NirC +FIG00003117 LysR family transcriptional regulator lrhA +FIG00003123 Putative efflux (PET) family inner membrane protein YccS +FIG00003124 Vitamin B12 ABC transporter, permease component BtuC +FIG00003125 hemimethylated DNA binding protein YccV +FIG00003126 LysR-family transcriptional regulator YhaJ +FIG00003127 Transcriptional repressor of aga operon +FIG00003129 Galactose operon repressor, GalR-LacI family of transcriptional regulators +FIG00003132 Uncharacterized protein ImpA +FIG00003135 IncF plasmid conjugative transfer pilus assembly protein TraB +FIG00003138 Aerobactin siderophore receptor IutA +FIG00003139 Putative hydrolase YcdX (EC 3.1.-.-) +FIG00003142 benzoate dioxygenase, ferredoxin reductase component +FIG00003147 Fructose-specific phosphocarrier protein HPr (EC 2.7.1.69) / PTS system, fructose-specific IIA component (EC 2.7.1.69) +FIG00003151 Flagellar transcriptional activator FlhC +FIG00003152 AA3-600 quinol oxidase subunit IIII +FIG00003159 CRISPR-associated RecB family exonuclease Cas4 +FIG00003160 MSHA biogenesis protein MshJ +FIG00003161 MSHA biogenesis protein MshE +FIG00003164 ProQ: influences osmotic activation of compatible solute ProP +FIG00003166 Beta N-acetyl-glucosaminidase (EC 3.2.1.52) +FIG00003168 Osmotically inducible protein OsmY +FIG00003174 Alpha-xylosidase (EC 3.2.1.-) +FIG00003175 Pyruvate:ferredoxin oxidoreductase, beta subunit (EC 1.2.7.1) +FIG00003176 Pyruvate:ferredoxin oxidoreductase, gamma subunit (EC 1.2.7.1) +FIG00003178 Bacteriophage tail sheath protein +FIG00003186 AA3-600 quinol oxidase subunit IV +FIG00003187 Galactonate dehydratase (EC 4.2.1.6) +FIG00003190 BH1670 unknown conserved protein in B. subtilis +FIG00003191 Gamma-D-Glutamyl-meso-Diaminopimelate Amidase +FIG00003192 Hypothetical lipoprotein YajG precursor +FIG00003193 hypothetical protein SA_21 +FIG00003195 L-idonate 5-dehydrogenase (EC 1.1.1.264) +FIG00003200 Phage baseplate assembly protein +FIG00003201 Fumarate reductase cytochrome b subunit +FIG00003203 SgrR, sugar-phosphate stress, transcriptional activator of SgrS small RNA +FIG00003207 Hydrogenase-4 component F +FIG00003209 NAD-specific glutamate dehydrogenase (EC 1.4.1.2), large form +FIG00003211 Phosphoribosyl-dephospho-CoA transferase (EC 2.7.7.-) +FIG00003212 D-glycero-D-manno-heptose 1-phosphate guanosyltransferase +FIG00003217 Protein-N(5)-glutamine methyltransferase PrmC, methylates polypeptide chain release factors RF1 and RF2 +FIG00003218 D-cysteine desulfhydrase (EC 4.4.1.15) +FIG00003219 Protein yjbR +FIG00003223 FIG023911: putative membrane protein +FIG00003224 tRNA nucleotidyltransferase, CC-adding (EC 2.7.7.21) +FIG00003226 Succinylarginine dihydrolase (EC 3.5.3.23) +FIG00003227 4-deoxy-L-threo-5-hexosulose-uronate ketol-isomerase (EC 5.3.1.17) +FIG00003230 Hemerythrin-like iron-binding protein +FIG00003231 Mediator of hyperadherence YidE +FIG00003232 Glutamine-dependent 2-keto-4-methylthiobutyrate transaminase +FIG00003237 Lysine decarboxylase, inducible (EC 4.1.1.18) +FIG00003239 Thiamin ABC transporter, ATPase component / Thiamine transport ATP-binding protein thiQ +FIG00003240 Phycoerythrin linker protein CpeS homolog +FIG00003243 Ferric hydroxamate ABC transporter (TC 3.A.1.14.3), permease component FhuB +FIG00003245 Iron-sulfur cluster regulator SufR +FIG00003247 Ribosomal RNA small subunit methyltransferase F (EC 2.1.1.-) +FIG00003251 Uracil permease +FIG00003252 IncF plasmid conjugative transfer pilus assembly protein TraH +FIG00003256 Transcriptional regulator, LysR family, in formaldehyde detoxification operon +FIG00003263 Phage shock protein D +FIG00003265 2-deoxyglucose-6-phosphate hydrolase YniC +FIG00003269 FIG003269: Prophage tail protein +FIG00003270 Arginine pathway regulatory protein ArgR, repressor of arg regulon +FIG00003272 Phage tail assembly protein I +FIG00003276 FIG003276: zinc-binding protein +FIG00003277 Putative sensor-like histidine kinase YfhK +FIG00003283 Phosphonates transport ATP-binding protein PhnK +FIG00003284 Colicin I receptor precursor +FIG00003285 tRNA-dependent lipid II-Gly--glycine ligase @ tRNA-dependent lipid II-GlyGly--glycine ligase @ FemA, factor essential for methicillin resistance +FIG00003287 Nitric oxide synthase oxygenase (EC 1.-.-.-) +FIG00003289 Glucitol operon repressor +FIG00003291 Glutaredoxin-like protein NrdH, required for reduction of Ribonucleotide reductase class Ib +FIG00003292 Putative secretion accessory protein EsaB/YukD +FIG00003293 Adenosine deaminase (EC 3.5.4.4), alternative form +FIG00003299 L-arabinose-binding periplasmic protein precursor AraF (TC 3.A.1.2.2) +FIG00003300 Tetrathionate reductase subunit B +FIG00003301 Flp pilus assembly protein RcpC/CpaB +FIG00003302 Cob(III)alamin reductase @ Cob(II)alamin reductase +FIG00003303 MSHA biogenesis protein MshN +FIG00003304 invasion plasmid antigen / internalin, putative +FIG00003307 FIG003307: hypothetical protein +FIG00003310 Periplasmic/membrane protein associated with DUF414 +FIG00003311 Integral membrane sensor signal transduction histidine kinase (EC 2.7.13.3), glucose catabolism cluster +FIG00003317 Ribosome modulation factor +FIG00003322 Arginine decarboxylase, catabolic (EC 4.1.1.19) +FIG00003329 Phosphopantothenoylcysteine decarboxylase (EC 4.1.1.36) +FIG00003330 MSHA biogenesis protein MshO +FIG00003334 DNA-cytosine methyltransferase (EC 2.1.1.37) +FIG00003337 FIG004684: SpoVR-like protein +FIG00003339 Probable transcriptional activator for leuABCD operon +FIG00003340 Propanediol utilization polyhedral body protein PduB +FIG00003341 AA3-600 quinol oxidase subunit II +FIG00003342 Sigma-fimbriae tip adhesin +FIG00003346 Similar to eukaryotic Peptidyl prolyl 4-hydroxylase, alpha subunit (EC 1.14.11.2) +FIG00003353 AA3-600 quinol oxidase subunit I +FIG00003363 Uncharacterized protein YidR +FIG00003369 Autoinducer 2 (AI-2) aldolase LsrF (EC 4.2.1.-) +FIG00003370 COG1496: Uncharacterized conserved protein +FIG00003371 N-acetylglucosamine-regulated outer membrane porin +FIG00003372 Mannose-1-phosphate guanylyltransferase (GDP) (EC 2.7.7.22) / Mannose-6-phosphate isomerase (EC 5.3.1.8) +FIG00003375 Ethanolamine ammonia-lyase heavy chain (EC 4.3.1.7) +FIG00003377 Propanediol utilization protein PduL +FIG00003378 [NiFe] hydrogenase metallocenter assembly protein HypE +FIG00003379 Chitobiose-specific regulator ChbR, AraC family +FIG00003381 L-cystine uptake protein TcyP +FIG00003384 Chlorophyll a(b) binding protein, photosystem II CP43 protein (PsbC) homolog +FIG00003386 Gluconate 2-dehydrogenase (EC 1.1.99.3), membrane-bound, flavoprotein +FIG00003387 ABC transporter multidrug efflux pump, fused ATP-binding domains +FIG00003391 Cystathionine beta-lyase (EC 4.4.1.8) (CBL) (Beta-cystathionase) (Cysteine lyase) / Maltose regulon modulator +FIG00003393 Conserved ATP-binding protein YghS +FIG00003394 5'-nucleotidase (EC 3.1.3.5) +FIG00003403 Melibiose operon regulatory protein +FIG00003405 Transcriptional activator of maltose regulon, MalT +FIG00003406 AmpG permease +FIG00003409 Ribosome hibernation protein YfiA +FIG00003410 Tagatose-6-phosphate kinase AgaZ (EC 2.7.1.144) +FIG00003411 Sirohydrochlorin cobaltochelatase (EC 4.99.1.3) +FIG00003413 Protoporphyrin IX Mg-chelatase subunit D (EC 6.6.1.1) +FIG00003416 Tetrathionate reductase subunit C +FIG00003420 Phage FluMu protein gp47 +FIG00003422 Deoxyribose operon repressor, DeoR family +FIG00003423 PTS system, glucose-specific IIB component (EC 2.7.1.69) / PTS system, glucose-specific IIC component (EC 2.7.1.69) +FIG00003424 Propanediol utilization polyhedral body protein PduT +FIG00003425 DNA-directed RNA polymerase specialized sigma subunit, sigma24-like +FIG00003427 Proline dipeptidase (EC 3.4.13.9) +FIG00003428 Formate hydrogenlyase subunit 7 +FIG00003429 Excinuclease cho (excinuclease ABC alternative C subunit) +FIG00003431 Phosphatase NagD predicted to act in N-acetylglucosamine utilization subsystem +FIG00003433 Vancomycin B-type resistance protein VanW +FIG00003434 Esterase ybfF (EC 3.1.-.-) +FIG00003435 High-affinity branched-chain amino acid transport system permease protein LivH (TC 3.A.1.4.1) +FIG00003437 FIG003437: hypothetical with DnaJ-like domain +FIG00003438 IncF plasmid conjugative transfer pilus assembly protein TraE +FIG00003439 Spore maturation protein A +FIG00003443 PspA/IM30 family protein +FIG00003444 IncF plasmid conjugative transfer pilus assembly protein TraF +FIG00003446 Aldehyde dehydrogenase A (EC 1.2.1.22) +FIG00003447 Acetyltransferase AcuA, acetyl-CoA synthetase inhibitor +FIG00003448 Anaerobic nitric oxide reductase flavorubredoxin +FIG00003449 ADP-ribosylglycohydrolase YegU (EC 3.2.-.-) +FIG00003451 Mg protoporphyrin IX monomethyl ester oxidative cyclase (aerobic) (EC 1.14.13.81) +FIG00003460 Transcriptional regulator, MerR family +FIG00003462 FIG003462: membrane protein +FIG00003463 Putrescine importer +FIG00003464 MotA/TolQ/ExbB proton channel family protein, probably associated with flagella +FIG00003465 Outer membrane protein A precursor +FIG00003466 Ethanolamine permease +FIG00003468 POTASSIUM/PROTON ANTIPORTER ROSB +FIG00003472 UDP-galactopyranose mutase (EC 5.4.99.9) +FIG00003474 Nucleoside permease NupC +FIG00003476 Flagellar biosynthesis protein FlhB +FIG00003477 Indoleacetamide hydrolase (EC 3.5.1.-) +FIG00003480 Light-independent protochlorophyllide reductase subunit B (EC 1.18.-.-) +FIG00003484 Lactaldehyde reductase (EC 1.1.1.77) +FIG00003486 Methylisocitrate lyase (EC 4.1.3.30) +FIG00003488 ChlD component of cobalt chelatase involved in B12 biosynthesis +FIG00003489 Sulfatase modifying factor 1 precursor (C-alpha-formyglycine- generating enzyme 1) +FIG00003495 Rhodanese-like domain protein +FIG00003500 Mg-protoporphyrin O-methyltransferase (EC 2.1.1.11) +FIG00003506 Cytosine/purine/uracil/thiamine/allantoin permease family protein +FIG00003507 6-phospho-beta-galactosidase (EC 3.2.1.85) +FIG00003513 Oxidoreductase, aldo/keto reductase family +FIG00003520 Phage tail fiber protein +FIG00003525 Tryptophan 2-monooxygenase (EC 1.13.12.3) +FIG00003526 Iron-sulfur cluster assembly scaffold protein NifU +FIG00003528 GALNS arylsulfatase regulator (Fe-S oxidoreductase) +FIG00003530 Sucrose operon repressor ScrR, LacI family +FIG00003535 Hydrolase (HAD superfamily) in cluster with DUF1447 +FIG00003536 Light-independent protochlorophyllide reductase iron-sulfur ATP-binding protein ChlL (EC 1.18.-.-) +FIG00003539 IncF plasmid conjugative transfer protein TraG +FIG00003542 Cyanophycin synthase (EC 6.3.2.29)(EC 6.3.2.30) +FIG00003543 N-acetylglucosamine-regulated TonB-dependent outer membrane receptor +FIG00003546 Nitrogen regulation protein NR(I) +FIG00003547 Transcriptional regulator in cluster with Zn-dependent hydrolase +FIG00003549 Glutathione-regulated potassium-efflux system ancillary protein KefF +FIG00003550 Multidrug transporter MdtD +FIG00003553 Protoporphyrin IX Mg-chelatase subunit I (EC 6.6.1.1) +FIG00003555 Phosphoglycolate phosphatase (EC 3.1.3.18) +FIG00003556 Phosphatidylinositol-specific phospholipase C (EC 4.6.1.13) +FIG00003557 2H phosphoesterase superfamily protein Bsu1186 (yjcG) +FIG00003560 IncF plasmid conjugative transfer pilus assembly protein TraW +FIG00003563 Geranylgeranyl hydrogenase BchP; Geranylgeranyl reductase (EC 1.3.1.83) +FIG00003566 Virulence factor MviM +FIG00003568 ACT domain protein +FIG00003569 Biotin synthesis protein BioG +FIG00003570 Cytochrome c-type heme lyase subunit nrfE, nitrite reductase complex assembly +FIG00003573 FIG003573: hypothetical protein +FIG00003577 LysR family transcriptional regulator YneJ +FIG00003580 Lipopolysaccharide cholinephosphotransferase LicD1 (EC 2.7.8.-) +FIG00003581 Nitrogenase FeMo-cofactor carrier protein NifX +FIG00003587 Radical SAM domain heme biosynthesis protein +FIG00003589 LysR family transcriptional regulator YafC +FIG00003590 Streptothricin acetyltransferase, Streptomyces lavendulae type +FIG00003591 Propanediol dehydratase small subunit (EC 4.2.1.28) +FIG00003592 Propanediol utilization protein PduM +FIG00003593 Nitrogenase FeMo-cofactor synthesis FeS core scaffold and assembly protein NifB +FIG00003594 Outer membrane porin protein 32 precursor; putative 3-hydroxyphenylpropionic acid porine +FIG00003596 RNA polymerase sporulation specific sigma factor SigF +FIG00003600 Uncharacterized protein ybfE +FIG00003601 Replication factor C small subunit +FIG00003603 FIG003603: membrane protein, putative +FIG00003605 CoA-acylating propionaldehyde dehydrogenase +FIG00003610 Putative n-hydroxybenzoate hydroxylase +FIG00003613 Lipoprotein YcfM, part of a salvage pathway of unknown substrate +FIG00003614 Autoinducer 2 (AI-2) modifying protein LsrG +FIG00003617 NADH dehydrogenase subunit 4, Involved in CO2 fixation +FIG00003620 FIG003620: Proteophosphoglycan precursor (Fragment) +FIG00003623 3-hydroxydecanoyl-[ACP] dehydratase (EC 4.2.1.60) +FIG00003629 Hemoprotein HemQ, essential component of heme biosynthetic pathway in Gram-positive bacteria +FIG00003631 Glutamate--cysteine ligase (EC 6.3.2.2) +FIG00003638 D-glycerate 3-kinase (EC 2.7.1.31), plant type +FIG00003639 Chromate transport protein ChrA +FIG00003640 tRNA-binding protein YgjH +FIG00003645 2,3-diketo-5-methylthiopentyl-1-phosphate enolase (EC 5.3.2.5) +FIG00003646 Carotenoid cis-trans isomerase (EC 5.2.-.-) +FIG00003652 General secretion pathway protein N +FIG00003653 Phenylacetate degradation enoyl-CoA hydratase PaaA (EC 4.2.1.17) +FIG00003654 Stage IV sporulation protein A +FIG00003655 PTS system, lactose-specific IIA component (EC 2.7.1.69) +FIG00003657 Transcriptional regulator containing an amidase domain and an AraC-type DNA-binding HTH domain +FIG00003666 Putative secretion accessory protein EsaA/YueB +FIG00003668 Flagellin +FIG00003671 FIG003671: Metal-dependent hydrolase +FIG00003672 Stage III sporulation protein AA +FIG00003678 Mannitol operon activator, BglG family +FIG00003681 Precorrin-6A synthase (EC 2.1.1.152) +FIG00003682 Stage 0 sporulation two-component response regulator (Spo0A) +FIG00003684 Propanediol dehydratase large subunit (EC 4.2.1.28) +FIG00003692 Ccs1/ResB-related putative cytochrome C-type biogenesis protein +FIG00003695 Transcriptional activator of cad operon +FIG00003696 ChlI component of cobalt chelatase involved in B12 biosynthesis / ChlD component of cobalt chelatase involved in B12 biosynthesis +FIG00003699 2-ketogluconate kinase (EC 2.7.1.13) +FIG00003701 LysR family transcriptional regulator YeiE +FIG00003703 Pro-zeta-carotene desaturase, prolycopene producing (EC 1.-.-.-) +FIG00003704 Xanthine-guanine phosphoribosyltransferase (EC 2.4.2.22) +FIG00003706 Citrate lyase gamma chain, acyl carrier protein (EC 4.1.3.6) +FIG00003707 Transcription regulator CDS_ID OB0894 +FIG00003711 Glutamate Aspartate transport ATP-binding protein GltL (TC 3.A.1.3.4) +FIG00003712 Fe-S-cluster-containing hydrogenase components 1 +FIG00003715 UDP-N-acetylglucosamine 4,6-dehydratase (EC 4.2.1.-) +FIG00003717 Ortho-halobenzoate 1,2-dioxygenase beta-ISP protein OhbA +FIG00003718 photosystem II protein D2 (PsbD) +FIG00003720 Alkylhydroperoxidase protein D +FIG00003722 Type I secretion system ATPase, LssB family LapB +FIG00003728 Uncharacterized N-acetyltransferase BT9727_3663 (EC 2.3.1.-) +FIG00003729 Hypothetical protein YhfZ +FIG00003732 Pyrophosphate-dependent fructose 6-phosphate-1-kinase (EC 2.7.1.90) +FIG00003735 Propanediol dehydratase reactivation factor small subunit +FIG00003737 FIG003737: Predicted deacylase +FIG00003739 Type cbb3 cytochrome oxidase biogenesis protein CcoH +FIG00003740 2-oxoglutarate oxidoreductase, delta subunit, putative (EC 1.2.7.3) +FIG00003750 2-(5''-triphosphoribosyl)-3'-dephosphocoenzyme-A synthase (EC 2.7.8.25) +FIG00003751 Chaperonin (heat shock protein 33) +FIG00003752 Epimerase KguE +FIG00003756 Maltose-6'-phosphate glucosidase (EC 3.2.1.122) +FIG00003757 L-arabinose transport ATP-binding protein AraG (TC 3.A.1.2.2) +FIG00003765 Low-affinity gluconate/H+ symporter GntU +FIG00003767 Cytochrome c-type heme lyase subunit nrfG, nitrite reductase complex assembly +FIG00003769 Stage III sporulation protein AE +FIG00003776 Ynd +FIG00003780 2-hydroxy-6-oxo-6-phenylhexa-2,4-dienoate hydrolase (EC 3.7.1.-) +FIG00003784 Cytochrome c nitrite reductase, small subunit NrfH +FIG00003788 Glycosyl transferase, group 2 family protein +FIG00003791 Propanediol dehydratase medium subunit (EC 4.2.1.28) +FIG00003792 Aromatic-L-amino-acid decarboxylase (EC 4.1.1.28) +FIG00003795 Broad-substrate range phospholipase C (EC 3.1.4.3) +FIG00003800 Leucine-responsive regulatory protein, regulator for leucine (or lrp) regulon and high-affinity branched-chain amino acid transport system +FIG00003801 type 1 fimbrae adaptor subunit FimF +FIG00003802 GNAT family acetyltransferase YjcF +FIG00003808 Two-component system response regulator +FIG00003809 Formate hydrogenlyase regulatory protein HycA +FIG00003810 Arginase (EC 3.5.3.1) +FIG00003814 Light-dependent protochlorophyllide reductase (EC 1.3.1.33) +FIG00003818 Cytochrome c heme lyase subunit CcmL / Cytochrome c heme lyase subunit CcmH +FIG00003820 Autoinducer 2 (AI-2) ABC transport system, membrane channel protein LsrC +FIG00003821 Flagellar protein FlgP +FIG00003824 Maltodextrose utilization protein MalA +FIG00003825 ATP-utilizing enzyme of the PP-loop superfamily +FIG00003827 Cytochrome c-type heme lyase subunit nrfF, nitrite reductase complex assembly +FIG00003839 Molybdenum cofactor biosynthesis protein MoaD +FIG00003841 Putative sugar ABC transport system, periplasmic binding protein YtfQ precursor +FIG00003842 DNA-directed RNA polymerase subunit D (EC 2.7.7.6) +FIG00003843 SSU ribosomal protein S19e +FIG00003844 Cell envelope-associated transcriptional attenuator LytR-CpsA-Psr, subfamily F2 (as in PMID19099556) +FIG00003845 Transcriptional regulator, ArsR family +FIG00003846 FIG003846: hypothetical protein +FIG00003849 LSU ribosomal protein L7e (L30p) +FIG00003850 Ferrous iron-sensisng transcriptional regulator FeoC +FIG00003851 SSU ribosomal protein S5e (S7p) +FIG00003852 DedA family inner membrane protein YohD +FIG00003853 LSU ribosomal protein L3e (L3p) +FIG00003854 LSU ribosomal protein L18e +FIG00003856 Glutamyl-tRNA(Gln) amidotransferase asparaginase subunit (EC 6.3.5.7) +FIG00003857 Type III secretion outermembrane contact sensing protein (YopN,Yop4b,LcrE) +FIG00003860 SSU ribosomal protein S20e (S10p) +FIG00003861 SSU ribosomal protein S14e (S11p) +FIG00003862 Glutamate formiminotransferase (EC 2.1.2.5) @ Glutamate formyltransferase +FIG00003863 Translation elongation factor 1 beta subunit +FIG00003867 Hydrogenase-4 component C +FIG00003871 Periplasmic nitrate reductase component NapE +FIG00003872 LSU ribosomal protein L12a (P1/P2) +FIG00003874 GDP-L-fucose synthetase (EC 1.1.1.271) +FIG00003879 FIG003879: Predicted amidohydrolase +FIG00003880 Nitric-oxide reductase subunit B (EC 1.7.99.7) +FIG00003881 RNA polymerase sporulation specific sigma factor SigG +FIG00003882 Nicotinamide-nucleotide adenylyltransferase, NadM family (EC 2.7.7.1) / ADP-ribose pyrophosphatase (EC 3.6.1.13) +FIG00003884 Uncharacterized protein ynbE; probable lipoprotein STY1424 +FIG00003889 2-Oxobutyrate oxidase, putative +FIG00003890 Enterobactin esterase +FIG00003892 LSU ribosomal protein L1e (L4p) +FIG00003894 Spermidine Putrescine ABC transporter permease component potC (TC_3.A.1.11.1) +FIG00003897 Lipolytic enzyme +FIG00003899 D-Lactate dehydrogenase, cytochrome c-dependent (EC 1.1.2.4) +FIG00003900 Fibrillarin +FIG00003901 LSU ribosomal protein L15e +FIG00003904 Nitric-oxide reductase subunit C (EC 1.7.99.7) +FIG00003908 [NiFe] hydrogenase metallocenter assembly protein HypC +FIG00003912 Arsenical resistance operon trans-acting repressor ArsD +FIG00003925 Pyrimidine deoxynucleoside triphosphate (dYTP) pyrophosphohydrolase YfoO +FIG00003926 SSU ribosomal protein SAe (S2p) +FIG00003927 Phycobilisome rod-core linker polypeptide, phycocyanin-associated +FIG00003928 Uroporphyrinogen-III synthase (EC 4.2.1.75) / Homolog of E. coli HemX protein +FIG00003929 Protein YaiA +FIG00003931 DNA-directed RNA polymerase subunit E' (EC 2.7.7.6) +FIG00003938 LSU ribosomal protein L5e (L18p) +FIG00003939 Transthyretin family protein +FIG00003942 Quinone-reactive Ni/Fe-hydrogenase small chain precursor (EC 1.12.5.1) +FIG00003945 DNA-directed RNA polymerase subunit E'' +FIG00003949 Fucose permease +FIG00003951 SSU ribosomal protein S2e (S5p) +FIG00003953 Methylmalonyl-CoA epimerase (EC 5.1.99.1) +FIG00003954 SSU ribosomal protein S8e +FIG00003955 Hypothetical protein YggS, proline synthase co-transcribed bacterial homolog PROSC +FIG00003962 Membrane protein, suppressor for copper-sensitivity ScsD +FIG00003963 SSU ribosomal protein S15Ae (S8p) +FIG00003965 L-rhamnose operon regulatory protein RhaS +FIG00003966 AroM protein +FIG00003968 LSU ribosomal protein L9e (L6p) +FIG00003972 FIGfam003972: membrane protein +FIG00003977 Protein SseB +FIG00003979 Putative sugar ABC transport system, ATP-binding protein YtfR (EC 3.6.3.17) +FIG00003984 D-serine/D-alanine/glycine transporter +FIG00003995 Na(+) H(+) antiporter subunit B (TC 2.A.63.1.3) +FIG00003997 Protein with similarity to RtcB +FIG00003998 V-type ATP synthase subunit K (EC 3.6.3.14) +FIG00004000 Beta-glucuronidase (EC 3.2.1.31) +FIG00004001 Protein YhjJ, putative peptidase +FIG00004003 Osmoprotectant ABC transporter inner membrane protein YehW +FIG00004007 Glutaredoxin 2 +FIG00004009 2,3-dihydroxybiphenyl 1,2-dioxygenase +FIG00004012 ATP-dependent DNA helicase UvrD/PcrA, actinomycete paralog +FIG00004014 RNA polymerase sporulation specific sigma factor SigE +FIG00004017 DNA-directed RNA polymerase subunit K (EC 2.7.7.6) +FIG00004020 Maltose regulon regulatory protein MalI (repressor for malXY) +FIG00004021 RNA polymerase sporulation specific sigma factor SigK +FIG00004026 Tellurite resistance protein TehB +FIG00004027 CoB--CoM heterodisulfide reductase subunit B (EC 1.8.98.1) +FIG00004028 Glucans biosynthesis protein D precursor +FIG00004032 Protein often found in Actinomycetes clustered with signal peptidase and/or RNaseHII +FIG00004033 SSU ribosomal protein S3e (S3p) +FIG00004036 Putative oxidoreductase YeaE, aldo/keto reductase family +FIG00004037 Spermidine Putrescine ABC transporter permease component PotB (TC 3.A.1.11.1) +FIG00004038 LSU ribosomal protein L17e (L22p) +FIG00004040 Nitrogen regulation protein NtrB (EC 2.7.13.3) +FIG00004042 Multiple antibiotic resistance protein MarR +FIG00004043 SSU ribosomal protein S13e (S15p) +FIG00004044 SSU ribosomal protein S15e (S19p) +FIG00004045 Carnitine operon protein CaiE +FIG00004047 Fumarate respiration transcriptional regulator DcuR +FIG00004048 LSU ribosomal protein L8e (L2p) +FIG00004050 Inner membrane protein YcdZ +FIG00004056 Hypothetical lipoprotein ygdR precursor +FIG00004058 Aminopeptidase Y (Arg, Lys, Leu preference) (EC 3.4.11.15) +FIG00004062 LSU ribosomal protein L37Ae +FIG00004065 Glutathione S-transferase (EC 2.5.1.18) +FIG00004066 Universal stress protein G +FIG00004068 LSU ribosomal protein L13Ae (L13p) +FIG00004070 N-3-oxohexanoyl-L-homoserine lactone quorum-sensing transcriptional activator @ N-3-oxooctanoyl-L-homoserine lactone quorum-sensing transcriptional activator +FIG00004071 FIG028220: hypothetical protein co-occurring with HEAT repeat protein +FIG00004074 Ferredoxin-type protein NapG (periplasmic nitrate reductase) +FIG00004077 IgaA: a membrane protein that prevents overactivation of the Rcs regulatory system +FIG00004078 Alpha-1,2-mannosidase +FIG00004080 Stage II sporulation serine phosphatase for sigma-F activation (SpoIIE) +FIG00004081 YjbF outer membrane lipoprotein +FIG00004085 Multiple antibiotic resistance protein MarA +FIG00004095 Colanic acid biosysnthesis glycosyl transferase WcaI +FIG00004099 Regulatory protein RecX +FIG00004100 Cold shock protein CspA +FIG00004103 LSU ribosomal protein L27Ae (L15p) +FIG00004104 Putative succinate dehydrogenase cytochrome b subunit +FIG00004105 Periplasmic thiol:disulfide interchange protein, DsbA-like +FIG00004106 Uncharacterized protein YqjB +FIG00004109 L-arabinose transport system permease protein (TC 3.A.1.2.2) +FIG00004114 Proofreading thioesterase in enterobactin biosynthesis EntH +FIG00004115 LSU ribosomal protein L10Ae (L1p) +FIG00004117 YcfL protein: an outer membrane lipoprotein that is part of a salvage cluster +FIG00004121 tRNA-(ms[2]io[6]A)-hydroxylase (EC 1.-.-.-) +FIG00004122 LSU ribosomal protein L11e (L5p) +FIG00004126 SSU ribosomal protein S16e (S9p) +FIG00004128 Protein YigP (COG3165) clustered with ubiquinone biosynthetic genes +FIG00004134 COG1180: Radical SAM, Pyruvate-formate lyase-activating enzyme like +FIG00004136 FIG004136: Prepilin peptidase dependent protein C precursor +FIG00004139 Glutamate--cysteine ligase (EC 6.3.2.2), divergent, of Alpha- and Beta-proteobacteria type +FIG00004144 Outer membrane lipoprotein YidQ +FIG00004148 Osmoprotectant ABC transporter ATP-binding subunit YehX +FIG00004149 Sialic acid transporter (permease) NanT +FIG00004153 DNA-binding capsular synthesis response regulator RcsB +FIG00004160 Inner membrane protein YhaH +FIG00004161 Predicted regulator PutR for proline utilization, GntR family +FIG00004167 N6-hydroxylysine O-acetyltransferase (EC 2.3.1.102), aerobactin biosynthesis protein IucB @ Siderophore synthetase small component, acetyltransferase +FIG00004169 Putative deoxyribose-specific ABC transporter, permease protein +FIG00004170 HPr kinase/phosphorylase (EC 2.7.1.-) (EC 2.7.4.-) +FIG00004172 Response regulator of zinc sigma-54-dependent two-component system +FIG00004176 Putative tail or base plate protein gp18 [Bacteriophage A118] +FIG00004178 Flagellin protein FlaB +FIG00004180 Magnesium and cobalt transport protein CorA +FIG00004183 Crotonobetainyl-CoA:carnitine CoA-transferase (EC 2.8.3.-) +FIG00004188 Multiple antibiotic resistance protein MarC +FIG00004189 Outer membrane receptor for ferric coprogen and ferric-rhodotorulic acid +FIG00004190 Threonine catabolic operon transcriptional activator TdcA +FIG00004191 C3-degrading proteinase +FIG00004195 Immunogenic secreted protein +FIG00004207 Nitric oxide reductase FlRd-NAD(+) reductase (EC 1.18.1.-) +FIG00004208 Two-component sensor protein RcsC (EC 2.7.3.-) +FIG00004209 Lipopolysaccharide core biosynthesis protein WaaP (EC 2.7.-.-), heptosyl-I-kinase +FIG00004210 ATP-dependent RNA helicase SrmB +FIG00004213 Penicillin-binding protein AmpH +FIG00004218 Evolved beta-D-galactosidase transcriptional repressor +FIG00004220 Dipeptidyl carboxypeptidase Dcp (EC 3.4.15.5) +FIG00004221 COG2110, Macro domain, possibly ADP-ribose binding module +FIG00004229 Heptaprenyl diphosphate synthase component I (EC 2.5.1.30) +FIG00004231 Hydrogenase 3 maturation protease +FIG00004232 Chitobiose-specific 6-phospho-beta-glucosidase ChbF (EC 3.2.1.86) +FIG00004233 DamX, an inner membrane protein involved in bile resistance +FIG00004237 Ferritin-like protein 2 +FIG00004241 hypothetical tRNA/rRNA methyltransferase yfiF [EC:2.1.1.-] +FIG00004244 Propionyl-CoA carboxylase biotin-containing subunit (EC 6.4.1.3) +FIG00004245 Periplasmic protein YqjC +FIG00004249 Lysophospholipase (EC 3.1.1.5) +FIG00004252 twitching motility protein PilH +FIG00004255 Redox-sensitive transcriptional activator SoxR +FIG00004257 Inner membrane protein YqjK +FIG00004258 Transcriptional regulator in cluster with beta-lactamase, GntR family +FIG00004261 2'-5' RNA ligase +FIG00004266 Redox-sensing transcriptional regulator QorR +FIG00004269 Twin-arginine translocation protein TatE +FIG00004271 Cell division protein DivIC +FIG00004272 L,D-transpeptidase YbiS +FIG00004273 Propanediol utilization polyhedral body protein PduN +FIG00004275 Inner membrane metabolite transport protein YhjE +FIG00004276 Putative sulfate permease +FIG00004282 NfuA Fe-S protein maturation +FIG00004283 Propanediol utilization polyhedral body protein PduK +FIG00004284 Carnitine racemase (EC 5.-.-.-) / Carnitinyl-CoA dehydratase (EC 4.2.1.-) +FIG00004286 Copper tolerance protein +FIG00004287 Glutamyl-tRNA(Gln) amidotransferase transferase subunit (EC 6.3.5.7) +FIG00004289 SSU ribosomal protein S28e +FIG00004290 Quinone-reactive Ni/Fe hydrogenase, cytochrome b subunit +FIG00004294 Polymyxin resistance protein PmrG; Ais protein +FIG00004295 DNA primase small subunit (EC 2.7.7.-) +FIG00004296 Amino acid-binding ACT +FIG00004305 Outer membrane component of tripartite multidrug resistance system +FIG00004308 N-acetylglucosamine related transporter, NagX +FIG00004309 GGDEF/EAL domain protein YhjH +FIG00004310 Tellurite resistance protein TehA +FIG00004311 Phenylacetate-coenzyme A ligase (EC 6.2.1.30); Coenzyme F390 synthetase +FIG00004320 FIG021952: putative membrane protein +FIG00004321 B12 binding domain of Methylmalonyl-CoA mutase (EC 5.4.99.2) +FIG00004322 L,D-transpeptidase YcfS +FIG00004325 Putative sensory histidine kinase YfhA +FIG00004328 Ferric enterobactin transport system permease protein FepG (TC 3.A.1.14.2) +FIG00004329 Hypothetical protein YqcC (clustered with tRNA pseudouridine synthase C) +FIG00004330 DedA family inner membrane protein YabI +FIG00004332 Ethanolamine utilization protein similar to PduL +FIG00004334 CRISPR-associated protein Cas2 +FIG00004335 Membrane-bound lytic murein transglycosylase B precursor (EC 3.2.1.-) +FIG00004336 Transcriptional regulator of catabolic arginine decarboxylase (adiA) +FIG00004341 Phage shock protein E precursor +FIG00004345 ATP-dependent RNA helicase RhlE +FIG00004348 Possible divergent polysaccharide deacetylase +FIG00004359 2-aminoethylphosphonate uptake and metabolism regulator +FIG00004361 Osmoprotectant ABC transporter permease protein YehY +FIG00004370 Glutathionylspermidine synthase (EC 6.3.1.8) / Glutathionylspermidine amidohydrolase (EC 3.5.1.78) +FIG00004371 Inner membrane protein YhjD +FIG00004373 Putative membrane protein YeiH +FIG00004389 YgfY COG2938 +FIG00004392 2-oxoglutarate decarboxylase (EC 4.1.1.71) +FIG00004395 TcuA: flavoprotein used to oxidize tricarballylate to cis-aconitate +FIG00004402 Zinc carboxypeptidase domain protein +FIG00004406 Uncharacterized HTH-type transcriptional regulator YegW +FIG00004410 Aspartate racemase (EC 5.1.1.13) +FIG00004413 Pantothenate kinase type II, eukaryotic (EC 2.7.1.33) +FIG00004415 tRNA (5-methylaminomethyl-2-thiouridylate)-methyltransferase (EC 2.1.1.61) +FIG00004418 L-fucose operon activator +FIG00004419 Ferric enterobactin transport system permease protein FepD (TC 3.A.1.14.2) +FIG00004422 Galactitol utilization operon repressor +FIG00004423 Dibenzothiophene desulfurization enzyme B +FIG00004424 Enterobactin exporter EntS +FIG00004428 6-phosphofructokinase class II (EC 2.7.1.11) +FIG00004440 Competence protein F homolog, phosphoribosyltransferase domain; protein YhgH required for utilization of DNA as sole source of carbon and energy +FIG00004443 4-hydroxycinnamoyl CoA hydratase/lyase (Enoyl-CoA hydratase/lyase) (EC 4.2.1.17) +FIG00004453 FIG004453: protein YceG like +FIG00004455 Outer membrane protein NlpB, lipoprotein component of the protein assembly complex (forms a complex with YaeT, YfiO, and YfgL); Lipoprotein-34 precursor +FIG00004459 Photosystem II 13 kDa protein Psb28 (similar to PsbW) +FIG00004460 Possible hydrolase or acyltransferase RutD in novel pyrimidine catabolism pathway +FIG00004463 Stage IV sporulation protein B +FIG00004470 VapB protein (antitoxin to VapC) +FIG00004472 SSU ribosomal protein S11e (S17p) +FIG00004479 Hypothetical transcriptional regulator yeeY +FIG00004481 Vitamin B12 ABC transporter, ATPase component BtuD +FIG00004484 Tyrosine-specific transport protein +FIG00004487 Thiosulfate sulfurtransferase, rhodanese (EC 2.8.1.1) +FIG00004488 Putative uncharacterized protein ydbL, may be related to amine metabolism +FIG00004494 Glutamate Aspartate transport system permease protein GltJ (TC 3.A.1.3.4) +FIG00004499 Uncharacterized lipoprotein YgeR precursor +FIG00004502 5'-nucleotidase YjjG (EC 3.1.3.5) +FIG00004504 TetR family regulatory protein of MDR cluster +FIG00004506 Lactate-responsive regulator LldR in Enterobacteria, GntR family +FIG00004515 Putative capsular polysaccharide transport protein YegH +FIG00004516 Acetyltransferase YpeA +FIG00004517 Mannose-1-phosphate guanylyltransferase (EC 2.7.7.13 ) / Phosphomannomutase (EC 5.4.2.8) +FIG00004518 tRNA nucleotidyltransferase, A-adding (EC 2.7.7.25) +FIG00004520 Curli production assembly/transport component CsgE +FIG00004528 Di-/tripeptide transporter +FIG00004529 N-acetylneuraminic acid outer membrane channel protein NanC +FIG00004538 RNA methyltransferase, TrmA family +FIG00004540 DNA-directed RNA polymerase subunit L (EC 2.7.7.6) +FIG00004542 gliding motility protein GldF +FIG00004543 L-carnitine/gamma-butyrobetaine antiporter +FIG00004545 Stage II sporulation protein M (SpoIIM) +FIG00004554 TsgA protein homolog +FIG00004556 FIG004556: membrane metalloprotease +FIG00004558 Universal stress protein C +FIG00004560 Glucans biosynthesis protein C (EC 2.1.-.-) +FIG00004562 Selenoprotein O and cysteine-containing homologs +FIG00004564 DNA topoisomerase VI subunit A (EC 5.99.1.3) +FIG00004567 Formate hydrogenlyase subunit 3/Multisubunit Na+/H+ antiporter, MnhD subunit +FIG00004568 ABC-type nitrate/sulfonate/bicarbonate transport systems, periplasmic components +FIG00004573 Ethanolamine utilization polyhedral-body-like protein EutK +FIG00004578 Putative uncharacterized protein ydbH +FIG00004579 Ribulose-5-phosphate 4-epimerase and related epimerases and aldolases +FIG00004580 Inner membrane protein YfeZ +FIG00004581 Endonuclease VIII +FIG00004587 PhnO protein +FIG00004588 Glutathione S-transferase family protein +FIG00004589 Putative deoxyribose-specific ABC transporter, ATP-binding protein +FIG00004592 Two-component sensor protein RcsD (EC 2.7.3.-) +FIG00004593 Protein containing an Alanine Racemase Domain +FIG00004596 Protein with ParB-like nuclease domain in PFGI-1-like cluster +FIG00004599 FIG004599: Hypothetical protein +FIG00004608 Probable glutathione S-transferase (EC 2.5.1.18), YfcF homolog +FIG00004612 LSU m5C1962 methyltransferase RlmI +FIG00004620 N-acetylglucosamine-1-phosphate uridyltransferase eukaryotic (EC 2.7.7.23) +FIG00004622 Putative nucleoside transporter YegT +FIG00004628 Predicted signal transduction protein +FIG00004629 Phosphoglycerol transferase I (EC 2.7.8.20) +FIG00004630 RNA polymerase sigma factor RpoH-related protein +FIG00004631 UPF0141 membrane protein YijP possibly required for phosphoethanolamine modification of lipopolysaccharide +FIG00004636 Archaeal transcription factor E +FIG00004640 Phage tail/DNA circulation protein +FIG00004642 toluenesulfonate zinc-independent alcohol dehydrogenase +FIG00004649 Secretion monitor precursor +FIG00004650 Capsular polysaccharide export system inner membrane protein KpsE +FIG00004651 Dipicolinate synthase subunit A (EC 4.2.1.52) +FIG00004655 Polysaccharide deacetylase +FIG00004661 DNA-binding response regulator ChvI +FIG00004668 Multidrug resistance protein [function not yet clear] +FIG00004671 Maleylacetoacetate isomerase (EC 5.2.1.2) @ Glutathione S-transferase, zeta (EC 2.5.1.18) +FIG00004674 LSU ribosomal protein L31e +FIG00004678 BarA sensory histidine kinase (= VarS = GacS) +FIG00004682 Uncharacterized protein Q1 colocalized with Q +FIG00004688 Hypothetical, related to broad specificity phosphatases COG0406 +FIG00004689 Uncharacterized protein YhjG +FIG00004693 Carbonic anhydrase, gamma class (EC 4.2.1.1) +FIG00004697 Predicted amidohydrolase RutB in novel pyrimidine catabolism pathway +FIG00004704 Colanic acid biosynthesis acetyltransferase WcaB (EC 2.3.1.-) +FIG00004707 Cytochrome c-type protein NapC +FIG00004708 Transcriptional regulator CsgD for 2nd curli operon +FIG00004715 PTS system, glucitol/sorbitol-specific IIA component (EC 2.7.1.69) +FIG00004717 2-octaprenyl-6-methoxyphenol hydroxylase (EC 1.14.13.-); 2-octaprenyl-3-methyl-6-methoxy-1,4-benzoquinol hydroxylase (EC 1.14.13.-) +FIG00004718 LSU ribosomal protein L39e +FIG00004719 Ethanolamine utilization polyhedral-body-like protein EutS +FIG00004721 Putative heat shock protein YegD +FIG00004722 Multiple antibiotic resistance (MarC) -related proteins +FIG00004727 Nudix hydrolase family protein PA3470 +FIG00004730 YbbM seven transmembrane helix protein +FIG00004734 Uncharacterized protein ImpC +FIG00004738 Flagella-related protein FlaI +FIG00004739 Uncharacterized protein YfaZ precursor +FIG00004741 Protein of unknown function DUF414 +FIG00004743 Lactoylglutathione lyase (EC 4.4.1.5) +FIG00004744 Rare lipoprotein A precursor +FIG00004755 MltA-interacting protein MipA +FIG00004761 Formate dehydrogenase O gamma subunit (EC 1.2.1.2) +FIG00004763 Alpha-amylase (EC 3.2.1.1) +FIG00004764 Ammonium transporter +FIG00004779 Alkaline phosphatase isozyme conversion protein precursor (EC 3.4.11.-) +FIG00004780 FIG004780: hypothetical protein in PFGI-1-like cluster +FIG00004782 NTP pyrophosphohydrolases including oxidative damage repair enzymes +FIG00004783 FIG018329: 1-acyl-sn-glycerol-3-phosphate acyltransferase +FIG00004784 Predicted outer membrane lipoprotein YfeY +FIG00004786 Adenylate cyclase (EC 4.6.1.1) / Guanylate cyclase (EC 4.6.1.2) +FIG00004788 Muramoyltetrapeptide carboxypeptidase (EC 3.4.17.13) +FIG00004789 Glucitol operon activator protein +FIG00004791 Haloalkane dehalogenase-like protein +FIG00004795 Glutamyl-tRNA reductase (EC 1.2.1.70) +FIG00004798 FIG004798: Putative cytoplasmic protein +FIG00004799 C4-dicarboxylate transporter DcuC (TC 2.A.61.1.1) +FIG00004802 Streptococcal lipoprotein rotamase A; Peptidyl-prolyl cis-trans isomerase (EC 5.2.1.8) +FIG00004804 HTH-type transcriptional regulator hdfR +FIG00004809 Putative benzaldehyde dehydrogenase oxidoreductase protein (EC 1.2.1.28) +FIG00004810 Circadian phase modifier +FIG00004816 Predicted monooxygenase RutA in novel pyrimidine catabolism pathway +FIG00004817 Ethanolamine utilization protein EutP +FIG00004819 FIG004819: Prepilin peptidase dependent protein B precursor +FIG00004821 Hexose phosphate uptake regulatory protein UhpC +FIG00004824 Formate hydrogenlyase complex 3 iron-sulfur protein; Formate hydrogenlyase subunit 6; Ni,Fe-hydrogenase III medium subunit +FIG00004826 L-rhamnose-proton symporter +FIG00004828 Integral membrane protein LafC, accessory function in glycolipid and LTA synthesis +FIG00004829 Ferredoxin-like protein FixX +FIG00004833 LSU ribosomal protein L24e +FIG00004841 Stage III sporulation protein AG +FIG00004843 Protein YidD +FIG00004844 Malate synthase-related protein +FIG00004846 Chorismate mutase (EC 5.4.99.5) +FIG00004851 identified by similarity to GB:AAK22812.1; match to protein family HMM PF06676 +FIG00004870 L-xylulose 5-phosphate 3-epimerase (EC 5.1.3.22) +FIG00004876 Acetaldehyde dehydrogenase, ethanolamine utilization cluster (EC 1.2.1.10) +FIG00004879 Curli production assembly/transport component CsgF +FIG00004881 Colanic acid biosynthesis glycosyl transferase WcaC +FIG00004884 repetative hypothetical protein , fig|282458.1.peg.574 homolog +FIG00004885 Chitodextrinase precursor (EC 3.2.1.14) +FIG00004895 Flagellar assembly factor FliW +FIG00004900 Putative deoxyribonuclease similar to YcfH, type 3 +FIG00004912 C4-dicarboxylate transporter DcuB +FIG00004914 D-arabitol dehydrogenase (EC 1.1.1.250) +FIG00004917 Protein AraJ precursor +FIG00004921 hypothetical protein +FIG00004927 Colanic acid biosynthesis glycosyl transferase WcaA +FIG00004933 Pterin-4-alpha-carbinolamine dehydratase (EC 4.2.1.96) +FIG00004938 Lipid A acylation protein PagP, palmitoyltransferase +FIG00004950 LSU ribosomal protein L32e +FIG00004951 Nitrogenase (molybdenum-iron)-specific transcriptional regulator NifA +FIG00004957 Evolved beta-D-galactosidase, beta subunit +FIG00004965 Periplasmic molybdate-binding domain +FIG00004977 NifX-associated protein +FIG00004978 COG5591: Uncharacterized conserved protein +FIG00004986 Ribosomal RNA large subunit methyltransferase A (EC 2.1.1.51) +FIG00004998 Menaquinone-cytochrome c reductase, cytochrome B subunit +FIG00005022 ABC transporter, periplasmic spermidine putrescine-binding protein PotD (TC 3.A.1.11.1) +FIG00005023 Methyl-accepting chemotaxis protein II (aspartate chemoreceptor protein) +FIG00005027 Putative oxidoreductase YncB +FIG00005032 FIG005032: Putative cytoplasmic protein YbdZ in enterobactin biosynthesis operon +FIG00005042 Evolved beta-D-galactosidase, alpha subunit +FIG00005049 Manganese superoxide dismutase (EC 1.15.1.1); Superoxide dismutase [Fe] (EC 1.15.1.1) +FIG00005055 Phosphomannomutase (EC 5.4.2.8) / Phosphoglucomutase (EC 5.4.2.2) / Phosphoglucosamine mutase (EC 5.4.2.10) +FIG00005061 Membrane protein, suppressor for copper-sensitivity ScsB +FIG00005067 NADH dehydrogenase-like protein / Selenide,water dikinase (EC 2.7.9.3) +FIG00005069 FIG005069: Hypothetical protein +FIG00005073 Uricase (urate oxidase) (EC 1.7.3.3) +FIG00005080 FIG005080: Possible exported protein +FIG00005081 Predicted transcriptional regulator LiuQ of leucine degradation pathway, TetR family +FIG00005087 DeoR-type transcriptional regulator YihW +FIG00005089 Spore cortex-lytic enzyme, lytic transglycosylase SleB +FIG00005102 ATP-dependent RNA helicase NGO0650 +FIG00005103 LysR family transcriptional regulator YfiE +FIG00005106 Prepilin peptidase dependent protein A precursor +FIG00005107 FIG005107: hypothetical protein +FIG00005111 Nitrogen regulatory protein P-II +FIG00005112 Trehalose synthase (EC 5.4.99.16) +FIG00005113 Zinc ABC transporter, inner membrane permease protein ZnuB +FIG00005116 Peptidyl-prolyl cis-trans isomerase +FIG00005117 NAD-dependent epimerase/dehydratase +FIG00005121 FIG005121: SAM-dependent methyltransferase (EC 2.1.1.-) +FIG00005127 2-ketogluconate 6-phosphate reductase (EC 1.1.1.43) +FIG00005129 RNA-binding protein Hfq / domain of unknown function +FIG00005131 Cell envelope-associated transcriptional attenuator LytR-CpsA-Psr, subfamily F1 (as in PMID19099556) +FIG00005135 ATP-dependent protease domain protein (EC 3.4.21.-) +FIG00005148 Xanthine transporter,putative +FIG00005149 Beta-1,3-galactosyltransferase / Beta-1,4-galactosyltransferase +FIG00005159 ATP-dependent 23S rRNA helicase DbpA +FIG00005160 DNA primase large subunit (EC 2.7.7.-) +FIG00005161 Fumarate respiration sensor kinase protein DcuS +FIG00005163 Low-affinity CO2 hydration protein CphX +FIG00005165 Uncharacterized protein ImpB +FIG00005170 Domain often clustered or fused with uracil-DNA glycosylase +FIG00005172 Branched-chain amino acid transport system permease protein LivM (TC 3.A.1.4.1) +FIG00005173 Periplasmic protein p19 involved in high-affinity Fe2+ transport +FIG00005179 FIGfam005179 +FIG00005186 Intracellular PHB depolymerase (EC 3.1.1.-) +FIG00005189 FIG005189: putative transferase clustered with tellurite resistance proteins TehA/TehB +FIG00005192 NMN phosphatase (EC 3.1.3.5); Class B acid phosphatase precursor (EC 3.1.3.2) +FIG00005194 Flagellar protein FlgO +FIG00005195 Thiazole biosynthetic enzyme Thi4 / Ribose 1,5-bisphosphate or 5-ribose-1,2-cyclic phosphate dehydrogenase +FIG00005199 Negative regulator of allantoin and glyoxylate utilization operons +FIG00005204 Inner membrane component of tripartite multidrug resistance system +FIG00005208 Ectoine hydroxylase (EC 1.17.-.-) +FIG00005210 Cytochrome b6-f complex subunit, cytochrome b6 +FIG00005216 Sulfate permease +FIG00005232 Ethanolamine utilization polyhedral-body-like protein EutM +FIG00005237 GTP pyrophosphokinase (EC 2.7.6.5), (p)ppGpp synthetase I +FIG00005242 Colanic acid capsular biosynthesis activation accesory protein RcsA, co-regulator with RcsB +FIG00005243 1-acyl-sn-glycerol-3-phosphate acyltransferase (EC 2.3.1.51) +FIG00005250 Curli production assembly/transport component CsgG +FIG00005259 Flagellin protein FlaD +FIG00005272 PTS system, maltose and glucose-specific IIC component (EC 2.7.1.69) / PTS system, maltose and glucose-specific IIB component (EC 2.7.1.69) / PTS system, maltose and glucose-specific IIA component (EC 2.7.1.69) +FIG00005277 UDP-4-amino-4-deoxy-L-arabinose formyltransferase (EC 2.1.2.13) +FIG00005283 Putative DNA-binding protein in cluster with Type I restriction-modification system +FIG00005288 Ethanolamine utilization protein EutG +FIG00005303 Malonate transporter, MadM subunit +FIG00005308 Catabolite repression HPr-like protein Crh +FIG00005312 Phosphate acetyltransferase (EC 2.3.1.8), ethanolamine utilization-specific +FIG00005319 Putative bacterial haemoglobin +FIG00005326 COG2833: uncharacterized protein +FIG00005329 V-type ATP synthase subunit F (EC 3.6.3.14) +FIG00005336 Cytochrome c-type biogenesis protein Ccs1/ResB +FIG00005339 ABC-type sugar transport system, permease component +FIG00005340 Aldehyde dehydrogenase A (EC 1.2.1.22) / Glycolaldehyde dehydrogenase (EC 1.2.1.21) +FIG00005350 LysR-family transcriptional regulator YbeF +FIG00005352 MSHA biogenesis protein MshH +FIG00005369 UDP-glucuronic acid oxidase (UDP-4-keto-hexauronic acid decarboxylating) (EC 1.1.1.305) +FIG00005378 Transcriptional repressor of the lac operon +FIG00005379 Tagatose-6-phosphate kinase GatZ (EC 2.7.1.144) +FIG00005383 Glucokinase (EC 2.7.1.2) / HTH-type transcriptional regulator (HexR?) +FIG00005386 DNA transformation protein TfoX +FIG00005389 Fap protein with C39 domain +FIG00005393 Phosphoribosylformylglycinamidine synthase, PurS subunit (EC 6.3.5.3) / Phosphoribosylformylglycinamidine synthase, synthetase subunit (EC 6.3.5.3) +FIG00005398 Uncharacterized protein ImpD +FIG00005402 Uncharacterized protein YrbB +FIG00005415 Biotin carboxyl carrier protein +FIG00005416 ABC-type Fe3+ transport system, periplasmic component +FIG00005426 FIG005426: hypothetical protein +FIG00005427 UPF0265 protein YeeX +FIG00005431 PH adaptation potassium efflux system protein C; sodium- potassium/hydrogen antiporter subunit C +FIG00005434 Phosphonoacetate hydrolase (EC 3.11.1.2) +FIG00005436 Phosphoenolpyruvate-dihydroxyacetone phosphotransferase (EC 2.7.1.121), subunit DhaM; DHA-specific IIA component / DHA-specific phosphocarrier protein HPr / DHA-specific EI component +FIG00005443 Inner membrane protein CreD +FIG00005453 FIG005453: Putative DeoR-family transcriptional regulator +FIG00005454 Ribosomal RNA large subunit methyltransferase F (EC 2.1.1.51) +FIG00005455 Major curlin subunit precursor CsgA +FIG00005461 Predicted Lactate-responsive regulator, LysR family +FIG00005462 ABC-type spermidine/putrescine transport systems, ATPase components +FIG00005464 Ascorbate-specific PTS system, EIIA component (EC 2.7.1.-) +FIG00005469 Glucose dehydrogenase (EC 1.1.99.10), membrane-bound, flavoprotein +FIG00005470 PTS system, arbutin-, cellobiose-, and salicin-specific IIBC component (EC 2.7.1.69) +FIG00005478 FIG005478: Porin, Gram-negative type +FIG00005479 Transcriptional repressor for NAD biosynthesis in gram-positives +FIG00005482 D-2-hydroxyglutarate dehydrogenase +FIG00005487 Glutamine amidotransferase, class-II +FIG00005489 Ethanolamine utilization protein EutQ +FIG00005495 FIG005495: hypothetical protein +FIG00005497 General secretion pathway protein M +FIG00005510 RND efflux system, outer membrane lipoprotein, NodT family +FIG00005514 Fructose-bisphosphate aldolase, archaeal class I (EC 4.1.2.13) +FIG00005520 Transcriptional regulator, GntR family domain / Aspartate aminotransferase (EC 2.6.1.1) +FIG00005525 surface localized decaheme cytochrome c lipoprotein, MtrC +FIG00005527 Catechol 2,3-dioxygenase (EC 1.13.11.2) +FIG00005529 Nitrate/nitrite transporter +FIG00005531 2-aminoethylphosphonate ABC transporter permease protein II (TC 3.A.1.9.1) +FIG00005540 UPF0225 protein YchJ +FIG00005547 Ribosomal RNA small subunit methyltransferase D (EC 2.1.1.-) +FIG00005548 FIG005548: transport protein +FIG00005550 Glucose dehydrogenase (EC 1.1.99.10), membrane-bound, gamma subunit +FIG00005559 L-proline glycine betaine ABC transport system permease protein ProW (TC 3.A.1.12.1) +FIG00005567 Acetone carboxylase, beta subunit (EC 6.4.1.6) / N-methylhydantoinase A (EC 3.5.2.14) +FIG00005568 D-Galactonate repressor DgoR +FIG00005569 Type III secretion thermoregulatory protein (LcrF,VirF,transcription regulation of virulence plasmid) +FIG00005571 Heat shock protein HtpX (EC 3.4.24.-) +FIG00005587 Transcriptional regulator of rhamnose utilization, AraC family +FIG00005590 Hypothetical protein DUF194, DegV family +FIG00005592 Cryptochrome +FIG00005595 Copper chaperone +FIG00005598 ATP-dependent RNA helicase Bcep18194_A5658 +FIG00005603 conserved protein with predicted RNA binding PUA domain +FIG00005628 KH domain RNA binding protein YlqC +FIG00005643 FIG016425: Soluble lytic murein transglycosylase and related regulatory proteins (some contain LysM/invasin domains) +FIG00005647 Chemotaxis protein CheD +FIG00005650 PTS system, sucrose-specific IIB component (EC 2.7.1.69) / PTS system, sucrose-specific IIC component (EC 2.7.1.69) / PTS system, sucrose-specific IIA component (EC 2.7.1.69) +FIG00005657 Phosphatidylinositol alpha-mannosyltransferase (EC 2.4.1.57) +FIG00005662 D-mannose isomerase (EC 5.3.1.7) +FIG00005666 FIG005666: putative helicase +FIG00005668 DNA helicase (Rad25 homolog) +FIG00005677 Citrate Succinate antiporter (TC 2.A.47.3.2) +FIG00005686 FIG005686: hypothetical protein +FIG00005698 Acetyl-CoA:acetoacetyl-CoA transferase, alpha subunit (EC 2.8.3.8) +FIG00005705 Ferric iron ABC transporter, ATP-binding protein +FIG00005710 Beta-lactamase class A +FIG00005711 LysR family transcriptional regulator YdcI +FIG00005723 Benzoate transport protein +FIG00005727 Type III restriction-modification system methylation subunit (EC 2.1.1.72) +FIG00005728 Methyl-accepting chemotaxis protein I (serine chemoreceptor protein) +FIG00005729 Glutamine amidotransferase protein GlxB (EC 2.4.2.-) +FIG00005731 FIG027190: Putative transmembrane protein +FIG00005739 Multiple polyol-specific dehydrogenase (EC 1.1.1.-) +FIG00005741 Transcriptional activator of 4-hydroxyphenylacetate 3-monooxygenase operon, XylS/AraC family +FIG00005770 Hydantoinase +FIG00005771 Transcriptional regulator of fatty acid biosynthesis FabT +FIG00005773 FIG005773: conserved membrane protein ML1361 +FIG00005774 Two-component system histidine kinase +FIG00005775 6-phospho-beta-glucosidase ascB (EC 3.2.1.86) +FIG00005787 3-keto-L-gulonate 6-phosphate decarboxylase +FIG00005791 L-pipecolate oxidase (1.5.3.7) +FIG00005797 Lipoteichoic acid synthase LtaS Type IIc +FIG00005801 OpgC protein +FIG00005813 Negative regulator of genetic competence MecA +FIG00005825 Colanic acid biosynthsis UDP-glucose lipid carrier transferase WcaJ +FIG00005836 COG0488: ATPase components of ABC transporters with duplicated ATPase domains +FIG00005840 Phosphoglycerate mutase (EC 5.4.2.1) +FIG00005849 Phosphomethylpyrimidine kinase (EC 2.7.4.7) / Thiamin-phosphate synthase ThiN (EC 2.5.1.3) +FIG00005860 SusD, outer membrane protein +FIG00005864 TRAP transporter solute receptor, unknown substrate 5 +FIG00005873 PTS system, galactose-specific IIC component (EC 2.7.1.69) +FIG00005881 NAD(P)H-plastoquinone oxidoreductase (EC 1.6.5.-) subunit I, NDHI +FIG00005884 Stationary-phase-induced ribosome-associated protein +FIG00005887 Putative haemolysin/cytolysin secreted via TPS pathway +FIG00005889 FIG009886: phosphoesterase +FIG00005890 Heme oxygenase HemO, associated with heme uptake +FIG00005893 ATPase component STY3233 of energizing module of queuosine-regulated ECF transporter +FIG00005895 Protein containing plastocyanin/azurin family domain +FIG00005898 Integral membrane protein YggT, involved in response to extracytoplasmic stress (osmotic shock) +FIG00005903 Ferredoxin--sulfite reductase, actinobacterial type (EC 1.8.7.1) +FIG00005904 NAD(P)H-plastoquinone oxidoreductase (EC 1.6.5.-) subunit H, NDHH +FIG00005907 2-aminoethylphosphonate ABC transporter permease protein I (TC 3.A.1.9.1) +FIG00005912 CRISPR-associated protein, Csd1 family +FIG00005917 Cytochrome c oxidase, subunit IV (EC 1.9.3.1) +FIG00005919 Urea ABC transporter, permease protein UrtC +FIG00005924 Excinuclease ABC subunit A paralog in greater Bacteroides group +FIG00005929 D-amino acid dehydrogenase (EC 1.4.99.1) family protein in hydroxy-L-proline catabolic cluster +FIG00005935 FIG005935: membrane protein +FIG00005937 Ethanolamine utilization protein similar to PduT +FIG00005952 Predicted L-lactate dehydrogenase, hypothetical protein subunit SO1518 +FIG00005953 Colanic acid polymerase WcaD +FIG00005959 Predicted reductase RutE in novel pyrimidine catabolism pathway +FIG00005961 Putative cytoplasmic protein clustered with trehalase +FIG00005968 ABC transporter, ATP-binding protein EcsA +FIG00005969 Acetoin catabolism protein X +FIG00005977 Hypothetical ATP-binding protein, containing DUF265 domain +FIG00005983 CRISPR-associated protein, Cse3 family +FIG00005985 Enoyl-[acyl-carrier-protein] reductase [FMN] (EC 1.3.1.9), inferred for PFA pathway +FIG00005986 FIG005986: HD family hydrolase +FIG00005992 Gamma-glutamyltranspeptidase (EC 2.3.2.2) +FIG00005994 DNA-binding transcriptional activator of the allD operon +FIG00005998 Putative GntR-family regulatory protein and aminotransferase near polyamine transporter +FIG00006002 Phenylalanyl-tRNA synthetase domain protein (Bsu YtpR) +FIG00006006 Spore germination protein GerYA +FIG00006008 salicylate esterase +FIG00006009 CRISPR-associated protein, Cse1 family +FIG00006021 Hydrogenase-4 component D +FIG00006026 Chlorogenate esterase +FIG00006030 D-xylose 1-dehydrogenase (EC 1.1.1.175) +FIG00006031 Fe-S OXIDOREDUCTASE (1.8.-.-) Wyeosine biosynthesis +FIG00006032 Cobalamin synthase +FIG00006046 CRISPR-associated RAMP Csm3 +FIG00006047 Phytochrome, two-component sensor histidine kinase (EC 2.7.3.-); Cyanobacterial phytochrome B +FIG00006064 3-keto-L-gulonate 6-phosphate decarboxylase (EC 4.1.1.85) +FIG00006069 FIG128630: Hypothetical protein +FIG00006073 Glutamyl aminopeptidase (EC 3.4.11.7) +FIG00006075 PTS system, galactose-specific IIB component (EC 2.7.1.69) +FIG00006080 photosystem I P700 chlorophyll a apoprotein subunit Ia (PsaA) +FIG00006081 MFS family multidrug efflux protein in Burkholderiaceae, unknown substrate +FIG00006084 Ferric enterobactin uptake protein FepE +FIG00006086 Serine--pyruvate aminotransferase (EC 2.6.1.51) +FIG00006092 RNA polymerase sigma-54 factor RpoN +FIG00006093 Flagella-related protein FlaJ +FIG00006104 Legionaminic acid biosynthesis protein PtmA +FIG00006109 NifU-like domain protein +FIG00006110 Phosphotriesterase like protein +FIG00006115 PTS system, trehalose-specific IIB component (EC 2.7.1.69) / PTS system, trehalose-specific IIC component (EC 2.7.1.69) / PTS system, trehalose-specific IIA component (EC 2.7.1.69) +FIG00006117 Agmatine/putrescine antiporter, associated with agmatine catabolism +FIG00006126 FIG006126: DNA helicase, restriction/modification system component YeeB +FIG00006127 Carbon monoxide dehydrogenase F protein +FIG00006128 Dipeptide-binding ABC transporter, periplasmic substrate-binding component (TC 3.A.1.5.2) +FIG00006149 Predicted trehalose permease, MFS family +FIG00006150 Nondeblocking aminopeptidase YpdE (X-X-[^PR]- specific) +FIG00006151 Methionine ABC transporter ATP-binding protein +FIG00006152 Putrescine carbamoyltransferase (EC 2.1.3.6) +FIG00006160 Cytochrome b6-f complex subunit IV (PetD) +FIG00006161 Archaeal seryl-tRNA synthetase-related sequence +FIG00006163 FIG006163: hypothetical protein +FIG00006165 Uracil-DNA glycosylase, family 4 +FIG00006167 Clostridial MutS2-related protein +FIG00006169 YoeB toxin protein +FIG00006170 photosystem I iron-sulfur center subunit VII (PsaC) +FIG00006176 NAD(P)H-plastoquinone oxidoreductase (EC 1.6.5.-) chain 1, NDHA +FIG00006183 Transcriptional activatory protein CaiF +FIG00006187 IncF plasmid conjugative transfer protein TraD +FIG00006188 photosystem I subunit X (PsaK, PsaK1) +FIG00006196 Uncharacterized membrane lipoprotein clustered with tellurite resistance proteins TehA/TehB +FIG00006198 Sensor histidine protein kinase SaeS (EC 2.7.13.3) (exoprotein expression protein S) +FIG00006211 Alkaline phosphatase like protein +FIG00006215 DNA-directed RNA polymerase delta (= beta'') subunit (EC 2.7.7.6) +FIG00006220 Hypothetical MbtH-like protein, PA2412 homolog +FIG00006232 photosystem I assembly related protein Ycf4 +FIG00006234 Flagellar biosynthesis protein FlgN +FIG00006235 RND efflux system, outer membrane lipoprotein CmeC +FIG00006237 Membrane transporter HdeD, H-NS repressed +FIG00006238 FIG006238: AzlC family protein +FIG00006248 Aspartate aminotransferase (EC 2.6.1.1) @ Biosynthetic Aromatic amino acid aminotransferase beta (EC 2.6.1.57) +FIG00006252 Cold shock protein CspB +FIG00006253 photosystem I assembly related protein Ycf37 +FIG00006254 3-dehydro-L-gulonate 2-dehydrogenase (EC 1.1.1.130) +FIG00006256 photosystem I subunit IV (PsaE) +FIG00006264 Stage II sporulation protein required for processing of pro-sigma-E (SpoIIR) +FIG00006267 Phosphoanhydride phosphohydrolase (EC 3.1.3.2) (pH 2.5 acid phosphatase) (AP) / 4- phytase (EC 3.1.3.26) +FIG00006269 Hypothetical protein i Rubrerythrin cluster +FIG00006270 FIG006270: hypothetical protein +FIG00006275 IncF plasmid conjugative transfer pilus assembly protein TraL +FIG00006277 Phycocyanobilin:ferredoxin oxidoreductase PcyA (EC 1.3.7.5) +FIG00006278 Glutamate-ammonia-ligase adenylyltransferase (EC 2.7.7.42) +FIG00006279 LysR family transcriptional regulator YhjC +FIG00006282 Capsular polysaccharide synthesis enzyme CpsB +FIG00006285 FIG006285: ICC-like protein phosphoesterase +FIG00006286 Ni2+-binding GTPase involved in regulation of expression and maturation of hydrogenase +FIG00006288 Putative OMR family iron-siderophore receptor precursor +FIG00006297 GbcA Glycine betaine demethylase subunit A +FIG00006300 Membrane-bound lysozyme inhibitor of c-type lysozyme +FIG00006302 Colanic acid biosynthesis glycosyl transferase WcaL +FIG00006306 Dissimilatory sulfite reductase, alpha subunit (EC 1.8.99.3) +FIG00006307 Uncharacterized fimbrial chaperone YehC precursor +FIG00006310 Diadenylate cyclase spyDAC; Bacterial checkpoint controller DisA with nucleotide-binding domain +FIG00006322 Urea ABC transporter, permease protein UrtB +FIG00006323 Glucose dehydrogenase (EC 1.1.99.10), membrane-bound, cytochrome c +FIG00006326 DedA family inner membrane protein YdjX +FIG00006330 Inner membrane transport protein YbaT +FIG00006332 Transcriptional antiterminator with PTS regulation domain, SPy0181 ortholog +FIG00006336 Transcriptional antiterminator of lichenan operon, BglG family +FIG00006338 YefM protein (antitoxin to YoeB) +FIG00006340 Transcriptional repressor UidR +FIG00006348 Cytochrome b6-f complex iron-sulfur subunit PetC1 (Rieske iron sulfur protein EC 1.10.9.1) +FIG00006350 Endo-1,4-beta-xylanase B ( EC 3.2.1.8 ) +FIG00006351 ABC transporter, predicted N-acetylneuraminate transport system permease protein 1 +FIG00006358 Chaperone HdeB +FIG00006361 2-ketogluconate transporter +FIG00006368 Transmembrane protein MT2276, clustered with lipoate gene +FIG00006369 Universal stress protein D +FIG00006375 Uncharacterized protein YhaL +FIG00006378 Ync +FIG00006380 Transcriptional activator GadE +FIG00006384 dicarboxylic acid transporter PcaT +FIG00006386 Phage minor tail protein +FIG00006387 Methyl-accepting chemotaxis protein III (ribose and galactose chemoreceptor protein) +FIG00006390 bacteriophytochrome heme oxygenase BphO +FIG00006395 Superoxide dismutase [Cu-Zn] (EC 1.15.1.1) +FIG00006396 Transport ATP-binding protein CydCD +FIG00006408 Domain often clustered or fused with uracil-DNA glycosylase / Uracil-DNA glycosylase, putative family 6 +FIG00006416 Late competence protein ComGC, access of DNA to ComEA, FIG007487 +FIG00006417 2-oxoglutarate/malate translocator +FIG00006418 ABC transporter, predicted N-acetylneuraminate transport system permease protein 2 +FIG00006419 tungsten-containing formate dehydrogenase alpha subunit +FIG00006424 ADA regulatory protein +FIG00006425 2-hydroxy-3-keto-5-methylthiopentenyl-1-phosphate phosphatase (EC 3.1.3.87) +FIG00006427 FIG006427: Putative transport system permease protein +FIG00006429 Neurosporene desaturase (EC 1.-.-.-) +FIG00006434 Lipoate synthase, cyanobacterial paralog +FIG00006435 Cytolethal distending toxin subunit B +FIG00006437 Outer spore coat protein E +FIG00006438 FIG006438: hypothetical protein +FIG00006461 Chromosome (plasmid) partitioning protein ParA +FIG00006463 TRAP-type C4-dicarboxylate transport system, large permease component +FIG00006465 Nickel transport ATP-binding protein NikD (TC 3.A.1.5.3) +FIG00006467 hypothetical protein that often co-occurs with aconitase +FIG00006469 D-allose-6-phosphate isomerase (EC 5.3.1.-) / Ribose 5-phosphate isomerase B (EC 5.3.1.6) +FIG00006474 PTS system, galactose-specific IIA component (EC 2.7.1.69) +FIG00006482 Allophycocyanin alpha chain +FIG00006483 LysR family transcriptional regulator YnfL +FIG00006488 Fimbriae-like adhesin SfmH +FIG00006496 Transcriptional regulator of rhamnose utilization, DeoR family +FIG00006500 Hybrid sensory histidine kinase in two-component regulatory system with EvgA +FIG00006507 Putative SAM-dependent methyltransferase Bucepa02006346 +FIG00006512 DNA internalization-related competence protein ComEC/Rec2 +FIG00006534 Unsaturated glucuronyl hydrolase (EC 3.2.1.-) +FIG00006535 Uncharacterized protein ImpH/VasB +FIG00006537 Light dependent period modulator LdpA +FIG00006542 FIG006542: Phosphoesterase +FIG00006551 Branched-chain amino acid transport ATP-binding protein LivF (TC 3.A.1.4.1) +FIG00006554 6-phosphofructokinase (EC 2.7.1.11) +FIG00006555 Multiple antibiotic resistance protein MarB +FIG00006558 tungsten-containing formate dehydrogenase beta subunit +FIG00006565 Putative two-component response regulator and GGDEF family protein YeaJ +FIG00006567 Lauroyl/myristoyl acyltransferase involved in lipid A biosynthesis (Lauroyl/myristoyl acyltransferase) +FIG00006578 Formylmethanofuran dehydrogenase subunit A (EC 1.2.99.5) +FIG00006579 L,D-transpeptidase YnhG +FIG00006580 D-serine permease DsdX +FIG00006581 FIG006581: hypothetical protein +FIG00006586 Positive transcription regulator EvgA +FIG00006592 Photosystem II protein Psb27 +FIG00006594 FIG092679: Fe-S oxidoreductase +FIG00006595 Antiphagocytic M protein +FIG00006599 Inhibitor of vertebrate lysozyme precursor +FIG00006600 ABC transporter (iron.B12.siderophore.hemin) , periplasmic substrate-binding component +FIG00006602 Enoyl-CoA hydratase (EC 4.2.1.17) / Enoyl-CoA hydratase [valine degradation] (EC 4.2.1.17) / 3-hydroxyacyl-CoA dehydrogenase (EC 1.1.1.35) +FIG00006609 Nickel transport ATP-binding protein NikE (TC 3.A.1.5.3) +FIG00006611 FIG006611: nucleotidyltransferase +FIG00006621 Mycothiol S-conjugate amidase Mca +FIG00006625 Putative two component system histidine kinase YedV +FIG00006626 DNA-directed RNA polymerase gamma subunit (EC 2.7.7.6) +FIG00006632 LSU ribosomal protein L32p @ LSU ribosomal protein L32p, zinc-independent +FIG00006643 Ferredoxin-NADP(+) reductase (EC 1.18.1.2) +FIG00006649 Glutathione biosynthesis bifunctional protein gshF (EC 6.3.2.2)(EC 6.3.2.3) +FIG00006652 Transcriptional regulator SpxA1 +FIG00006658 Probable pyrimidine nucleoside transport protein associated with pseudouridine catabolism +FIG00006661 Potassium channel protein +FIG00006663 DNA replication intiation control protein YabA +FIG00006676 FIG022979: MoxR-like ATPases +FIG00006678 Nickel transport system permease protein NikC (TC 3.A.1.5.3) +FIG00006680 Menaquinone-cytochrome C oxidoreductase, cytochrome C subunit +FIG00006682 Stage V sporulation protein required for dehydratation of the spore core and assembly of the coat (SpoVS) +FIG00006688 PqqC-like protein +FIG00006689 Hemin uptake protein HemP +FIG00006691 Dipeptide transport system permease protein DppC (TC 3.A.1.5.2) +FIG00006698 Photosystem II manganese-stabilizing protein (PsbO) +FIG00006699 CRISPR-associated protein, Csm1 family +FIG00006700 RNA binding protein, contains ribosomal protein S1 domain +FIG00006702 Conserved protein YqhG +FIG00006706 Protein of unknown function identified by role in sporulation (SpoVG) +FIG00006709 Dissimilatory sulfite reductase, beta subunit (EC 1.8.99.3) +FIG00006715 2-keto-3-deoxygluconate permease (KDG permease) +FIG00006724 Glycosyl hydrolase YegX, family 25 +FIG00006725 2,3-dihydroxy-2,3-dihydro-phenylpropionate dehydrogenase (EC 1.3.1.-) +FIG00006734 4-amino-6-deoxy-N-Acetyl-D-hexosaminyl-(Lipid carrier) acetyltrasferase +FIG00006742 Chaperone HdeA +FIG00006756 Malolactic enzyme (EC 1.-.-.-) +FIG00006762 FIG006762: Phosphoglycerate mutase family +FIG00006763 tRNA pseudouridine 55 synthase Archaea +FIG00006764 Rhamnogalacturonides degradation protein RhiN +FIG00006765 Photosystem II protein PsbV, cytochrome c550 +FIG00006766 Hydroxyaromatic non-oxidative decarboxylase protein D (EC 4.1.1.-) +FIG00006767 Gamma-aminobutyrate:alpha-ketoglutarate aminotransferase (EC 2.6.1.19) +FIG00006772 Uncharacterized oxidoreductase YjgI (EC 1.-.-.-) +FIG00006773 Heme efflux system ATPase HrtA +FIG00006775 LSU ribosomal protein L18Ae +FIG00006777 Fosfomycin resistance protein FosX +FIG00006781 ABC transporter, ATP-binding protein YnjD +FIG00006784 6-pyruvoyl tetrahydrobiopterin synthase (EC 4.2.3.12) +FIG00006794 Stage III sporulation protein AF +FIG00006797 Putative two-component response regulator +FIG00006800 Biotin carboxylase of methylcrotonyl-CoA carboxylase (EC 6.3.4.14) +FIG00006803 DinG family ATP-dependent helicase YpvA +FIG00006806 Formate dehydrogenase H (EC 1.2.1.2) @ selenocysteine-containing +FIG00006808 Polymyxin resistance protein PmrD +FIG00006814 Sarcosine oxidase gamma subunit (EC 1.5.3.1) +FIG00006820 Protein YaiI +FIG00006825 Nickel transport system permease protein nikC2 (TC 3.A.1.5.3) +FIG00006830 photosystem I subunit XI (PsaL) +FIG00006835 Phosphoserine aminotransferase, putative (EC 2.6.1.52) +FIG00006842 Inner membrane ABC transporter permease protein YcjO +FIG00006846 Conjugative transfer protein TrbD +FIG00006851 Ubiquinone/menaquinone biosynthesis methyltransferase UbiE (EC 2.1.1.-) @ 2-heptaprenyl-1,4-naphthoquinone methyltransferase MenG (EC 2.1.1.163) +FIG00006853 Phage shock protein A +FIG00006858 NusA protein homolog, archaeal +FIG00006859 FIG015094: hypothetical protein +FIG00006868 hypothetical protein BH3604 +FIG00006874 Aromatic hydrocarbon utilization transcriptional regulator CatR (LysR family) +FIG00006876 Ferredoxin-like protein YgcO +FIG00006887 ABC transporter, predicted N-acetylneuraminate-binding protein +FIG00006889 L-rhamnose isomerase (EC 5.3.1.14) +FIG00006898 Aspartate-proton symporter +FIG00006903 CblZ, a non-orthologous displasment for Alpha-ribazole-5'-phosphate phosphatase +FIG00006905 Hypothetical protein in Cyanoglobin locus +FIG00006932 Capsular polysaccharide synthesis enzyme CpsC, polysaccharide export +FIG00006933 Alpha-1,4-N-acetylgalactosamine transferase PglH (EC 2.4.1.-) +FIG00006938 FIG00545367: hypothetical protein +FIG00006940 Sugar phosphate isomerases/epimerases family protein YcjR +FIG00006945 Anaerobic sulfite reductase subunit B +FIG00006953 Heteropolysaccharide repeat unit export protein +FIG00006955 Tyrosine-protein kinase Wzc (EC 2.7.10.2) +FIG00006956 Propanediol utilization polyhedral body protein PduU +FIG00006962 NAD-reducing hydrogenase subunit HoxY (EC 1.12.1.2) +FIG00006964 conserved protein associated with acetyl-CoA C-acyltransferase +FIG00006970 Nickel transport system permease protein NikB (TC 3.A.1.5.3) +FIG00006972 FIG006972: hypothetical protein +FIG00006988 FIG006988: Lipase/Acylhydrolase with GDSL-like motif +FIG00006993 Trans-2,cis-3-Decenoyl-ACP isomerase +FIG00006994 Nitrogenase stabilizing/protective protein NifW +FIG00006995 Nicotinamidase family protein YcaC +FIG00006997 Ferric iron ABC transporter, permease protein +FIG00007003 Cold shock protein CspH +FIG00007010 Clock-associated two-component sensor histidine kinase SasA +FIG00007013 FIG007013: polysaccharide deacetylase, putative +FIG00007025 Multiple sugar ABC transporter, ATP-binding protein +FIG00007031 2-amino-3,7-dideoxy-D-threo-hept-6-ulosonate synthase (EC 2.5.1.-) +FIG00007035 Biotin carboxyl carrier protein of methylcrotonyl-CoA carboxylase +FIG00007036 benABC operon transcriptional activator BenR +FIG00007039 Multiple sugar ABC transporter, membrane-spanning permease protein MsmG +FIG00007041 Chemotaxis protein CheV (EC 2.7.3.-) +FIG00007042 FIG007042: hypothetical protein +FIG00007049 Nickel transport system permease protein nikB2 (TC 3.A.1.5.3) +FIG00007054 Alpha-glucosyltransferase YihQ +FIG00007058 Sodium/glycine symporter GlyP +FIG00007059 Acriflavin resistance protein +FIG00007061 Colanic acid biosysnthesis protein WcaK +FIG00007067 Putative ATP:guanido phosphotransferase YacI (EC 2.7.3.-) +FIG00007073 Exopolysaccharide biosynthesis glycosyltransferase EpsF (EC 2.4.1.-) +FIG00007079 FIG007079: UPF0348 protein family +FIG00007086 Substrate-specific component CbiM of cobalt ECF transporter +FIG00007096 Putative transport protein YdjK, MFS superfamily +FIG00007097 predicted 4-deoxy-L-threo-5-hexosulose-uronate ketol-isomerase (EC 5.3.1.17) +FIG00007100 Periplasmic aromatic amino acid aminotransferase beta precursor (EC 2.6.1.57) +FIG00007102 Phosphoenolpyruvate carboxylase, archaeal (EC 4.1.1.31) +FIG00007112 IcmF-related protein +FIG00007123 2,3-diketo-L-gulonate TRAP transporter small permease protein yiaM +FIG00007125 3-hydroxyphenylpropionic acid transporter +FIG00007126 Multimodular transpeptidase-transglycosylase (EC 2.4.1.129) (EC 3.4.-.-) / Penicillin-binding protein 1A/1B (PBP1) +FIG00007127 Universal stress protein family 5 +FIG00007132 Xaa-Pro dipeptidyl-peptidase (EC 3.4.14.11) +FIG00007134 FMN reductase (EC 1.5.1.29) +FIG00007137 Multiple sugar ABC transporter, substrate-binding protein +FIG00007147 Glycosyltransferase LafB, responsible for the formation of Gal-Glc-DAG +FIG00007149 D-galactarate permease @ D-glucarate permease +FIG00007157 Alpha-N-arabinofuranosidase (EC 3.2.1.55) +FIG00007160 Glycine betaine ABC transport system, glycine betaine-binding protein OpuAC +FIG00007166 Putative secretion system component EssA +FIG00007171 Catechol 1,2-dioxygenase 1 (EC 1.13.11.1) +FIG00007172 Transcription repressor of multidrug efflux pump acrAB operon, TetR (AcrR) family +FIG00007180 Stage V sporulation protein AE (SpoVAE) +FIG00007181 PvcB protein, related to amino acid oxidizing enzymes +FIG00007182 Photosystem II protein PsbI +FIG00007185 Solanesyl diphosphate synthase (EC 2.5.1.11) +FIG00007189 Various polyols ABC transporter, periplasmic substrate-binding protein +FIG00007195 2-hydroxychromene-2-carboxylate isomerase/DsbA-like thioredoxin domain +FIG00007202 Cytosine permease +FIG00007205 Transcriptional regulator DegU, LuxR family +FIG00007207 Aspartokinase (EC 2.7.2.4) associated with ectoine biosynthesis +FIG00007212 GDP-mannose 6-dehydrogenase (EC 1.1.1.132) +FIG00007214 archaeosine tRNA-ribosyltransferase (EC 2.4.2.-) type 2 +FIG00007224 Hypothetical protein, Slr0957 homolog +FIG00007232 virulence cluster protein B VclB +FIG00007237 Hypothetical oxidoreductase YdjG (EC 1.-.-.-) +FIG00007242 Putative nitroreductase family protein SACOL0874 +FIG00007247 IncF plasmid conjugative transfer fertility inhibition protein FinO +FIG00007251 Protein YkiA +FIG00007256 FIG139598: Potential ribosomal protein +FIG00007257 Bacitracin export ATP-binding protein BceA +FIG00007280 PUA-PAPS reductase like fusion +FIG00007289 Divinyl protochlorophyllide a 8-vinyl-reductase (EC 1.3.1.75) +FIG00007291 Allantoin permease +FIG00007296 DEAD-box ATP-dependent RNA helicase CshB (EC 3.6.4.13) +FIG00007297 NAD-reducing hydrogenase subunit HoxH (EC 1.12.1.2) +FIG00007299 N-linked glycosylation glycosyltransferase PglG +FIG00007303 FIG007303: uncharacterized protein +FIG00007304 Dipicolinate synthase subunit B +FIG00007315 Transporter associated with VraSR +FIG00007316 Glycerol-3-phosphate ABC transporter, permease protein UgpA (TC 3.A.1.1.3) +FIG00007317 FIG007317: Chromosome segregation protein SMC-like +FIG00007324 Two-component sensor histidine kinase PleC +FIG00007327 DUF1801 domain-containing protein +FIG00007328 Sortase A, LPXTG specific +FIG00007339 transcriptional regulator, Crp/Fnr family +FIG00007362 carboxysome shell protein CsoS3 +FIG00007369 Sporulation initiation phosphotransferase (Spo0F) +FIG00007373 Two-component response regulator yesN, associated with MetSO reductase +FIG00007374 Ethanolamine two-component response regulator +FIG00007376 Para-aminobenzoate synthase, amidotransferase component (EC 2.6.1.85) / Para-aminobenzoate synthase, aminase component (EC 2.6.1.85) +FIG00007379 Capsular polysaccharide biosynthesis fatty acid synthase WcbR +FIG00007383 Lysine biosynthesis protein LysX +FIG00007389 Sporulation sigma-E factor processing peptidase (SpoIIGA) +FIG00007395 Cation efflux system protein CusF precursor +FIG00007410 Putative membrane transporter ATPase,YhiD +FIG00007414 AscBF operon repressor +FIG00007415 Hypothetical NagD-like phosphatase +FIG00007417 Outer membrane sugar transport protein YshA +FIG00007419 DNA-directed RNA polymerase subunit B' (EC 2.7.7.6) +FIG00007421 FIG007421: forespore shell protein +FIG00007429 Putative thiosulfate sulfurtransferase ynjE (EC 2.8.1.1) +FIG00007431 Nickel ABC transporter, periplasmic nickel-binding protein nikA2 (TC 3.A.1.5.3) +FIG00007435 3-hydroxyanthranilate 3,4-dioxygenase (EC 1.13.11.6) +FIG00007442 SsnA protein +FIG00007446 3,7-dideoxy-D-threo-hepto-2, 6-diulosonate synthase (EC 4.2.3.-) +FIG00007448 Protein containing PTS-regulatory domain +FIG00007459 Starvation lipoprotein Slp +FIG00007471 Uncharacterized GST-like protein yncG +FIG00007476 Periplasmic fimbrial chaperone StfD +FIG00007478 Aldose 1-epimerase family protein YphB +FIG00007479 Type IV fimbrial biogenesis protein PilY1 +FIG00007481 FIG007481: hypothetical protein +FIG00007493 Uncharacterized protein YadU in stf fimbrial cluster +FIG00007495 Spore maturation protein B +FIG00007496 Lactaldehyde dehydrogenase involved in fucose or rhamnose utilization (EC 1.2.1.22) +FIG00007507 Potassium-transporting ATPase C chain (EC 3.6.3.12) (TC 3.A.3.7.1) +FIG00007508 Nitrite reductase probable [NAD(P)H] subunit (EC 1.7.1.4) +FIG00007514 Putrescine transport ATP-binding protein PotA (TC 3.A.1.11.1) +FIG00007519 Uncharacterized lipoprotein YmcC precursor +FIG00007527 4-hydroxyphenylacetate symporter, major facilitator superfamily (MFS) +FIG00007535 Cytochrome cd1 nitrite reductase (EC:1.7.2.1) +FIG00007538 Stage V sporulation protein T, AbrB family transcriptional regulator (SpoVT) +FIG00007545 Urea channel UreI +FIG00007547 Outer membrane usher protein SfmD +FIG00007556 Coproporphyrinogen III oxidase, oxygen-independent (EC 1.3.99.22) +FIG00007559 metal-dependent phosphohydrolase +FIG00007563 PTS system, beta-glucoside-specific IIB component (EC 2.7.1.69) / PTS system, beta-glucoside-specific IIC component / PTS system, beta-glucoside-specific IIA component +FIG00007567 SAM-dependent methlytransferase YrrT +FIG00007574 Predicted nucleoside phosphatase +FIG00007578 (S)-3-O-geranylgeranylglyceryl phosphate synthase +FIG00007586 Multiple sugar ABC transporter, membrane-spanning permease protein MsmF +FIG00007587 Internalin-like protein (LPXTG motif) Lmo0514 homolog +FIG00007600 Gamma-glutamyl-GABA hydrolase (EC 3.5.1.94) +FIG00007603 L-Cystine ABC transporter, periplasmic cystine-binding protein TcyK +FIG00007605 Uncharacterized protein YgfM +FIG00007616 L-rhamnonate utilization transcriptional regulator (predicted by genome context) +FIG00007633 ABC transporter, periplasmic substrate-binding protein YnjB +FIG00007635 L-Cystine ABC transporter, permease protein TcyL +FIG00007638 CTP:molybdopterin cytidylyltransferase +FIG00007641 Enoyl-[acyl-carrier-protein] reductase [FMN] (EC 1.3.1.9) +FIG00007643 ABC transporter, permease protein YnjC +FIG00007652 Aldolase YihT +FIG00007658 Fumarylacetoacetate hydrolase family protein +FIG00007661 Integral membrane protein YfiB +FIG00007664 Internalin-like protein Lmo2445 homolog +FIG00007678 Chitobiose phosphorylase (EC 2.4.1.-) +FIG00007680 Phycocyanin alpha chain +FIG00007690 Na(+) H(+) antiporter subunit G +FIG00007694 Butyrate kinase (EC 2.7.2.7) +FIG00007697 FIG007697: hypothetical protein +FIG00007714 Maltose/maltodextrin ABC transporter, permease protein MalG +FIG00007717 Major facilitator superfamily (MFS) transporter +FIG00007722 Cation efflux system protein CusC precursor +FIG00007729 Glycine betaine ABC transport system, ATP-binding protein OpuAA (EC 3.6.3.32) +FIG00007749 Membrane component of multidrug resistance system +FIG00007751 Late competence protein ComC, processing protease +FIG00007753 Transition state regulatory protein AbrB +FIG00007754 Glucuronide transport protein YihO +FIG00007766 Inner membrane protein YeaI +FIG00007775 Urease beta subunit (EC 3.5.1.5) / Urease gamma subunit (EC 3.5.1.5) +FIG00007781 ATP-dependent DNA helicase UvrD/PcrA/Rep, epsilon proteobacterial type 2 +FIG00007785 FIG007785: exported protein +FIG00007793 Membrane-attached cytochrome c550 +FIG00007797 mannose-specific adhesin FimH +FIG00007798 LytH protein involved in methicillin resistance / N-acetylmuramoyl-L-alanine amidase (EC 3.5.1.28) domain +FIG00007801 Fimbriae usher protein StcC +FIG00007803 Aspartate aminotransferase family +FIG00007809 TldE/PmbA family protein, Beta/Gamma-proteobacterial subgroup +FIG00007812 ABC-type sugar transport system, periplasmic binding protein YcjN +FIG00007816 Thiamin ABC transporter, transmembrane component +FIG00007822 FIG036672: Nucleoside-diphosphate-sugar epimerase +FIG00007826 Sigma-fimbriae usher protein +FIG00007828 Cold shock protein CspG +FIG00007830 Acetophenone carboxylase subunit Apc4 (EC 6.4.1.8) +FIG00007833 Internalin-like protein (LPXTG motif) Lmo0327 homolog / murein-hydrolysing domain +FIG00007834 3-phenylpropionate dioxygenase ferredoxin subunit +FIG00007843 gliding motility protein GldG +FIG00007853 Diaminopropionate ammonia-lyase (EC 4.3.1.15) +FIG00007854 Phosphoethanolamine transferase specific for the outer Kdo residue of lipopolysaccharide +FIG00007858 Hydrogenase-4 component I +FIG00007861 L-rhamnonate dehydratase (EC 4.2.1.90) +FIG00007866 ABC-type Fe3+-siderophore transport system, permease 2 component +FIG00007873 Streptolysin S biosynthesis protein B (SagB) +FIG00007876 Lactate 2-monooxygenase (EC 1.13.12.4) +FIG00007881 Cytochrome c551 peroxidase (EC 1.11.1.5) +FIG00007901 rhamnose-containing polysacharide translocation permease +FIG00007906 Xanthosine phosphorylase (EC 2.4.2.1) +FIG00007910 TldD family protein, Beta/Gamma-proteobacterial subgroup +FIG00007915 Glyoxalase family protein +FIG00007916 Signal peptidase-like protein +FIG00007920 Late competence protein ComGG, FIG007920 +FIG00007922 Flp pilus assembly protein CpaD +FIG00007923 ABC transporter ATP-binding protein YvcR +FIG00007928 SinR, regulator of post-exponential-phase responses genes (competence and sporulation) +FIG00007932 Predicted sugar ABC transport system, periplasmic binding protein YphF precursor +FIG00007938 TcuR: regulates tcuABC genes used in utilization of tricarballylate +FIG00007941 ABC transporter ATP-binding protein uup +FIG00007948 ABC-transporter (ATP-binding protein) -possibly involved in cell wall localization and side chain formation of rhamnose-glucose polysaccharide +FIG00007957 Glutamate synthase [NADPH] small chain (EC 1.4.1.13) +FIG00007959 FIG007959: peptidase, M16 family +FIG00007960 Glycosyltransferase +FIG00007966 YgfD: protein that forms a complex with the methylmalonyl-CoA mutase in a pathway for conversion of succinyl-CoA to propionyl-CoA +FIG00007984 Heme transporter IsdDEF, permease component IsdF +FIG00007987 Glucuronide transport protein YihP, homologous to YihO +FIG00007989 Guanine deaminase (EC 3.5.4.3); Hydroxydechloroatrazine ethylaminohydrolase (EC 3.5.99.3) +FIG00007997 Beta-lactamase repressor BlaI +FIG00007998 Ribosome protection-type tetracycline resistance related proteins +FIG00008010 ATP-dependent RNA helicase YfmL +FIG00008026 virulence cluster protein A VclA +FIG00008028 Uncharacterized protein in putrescine utilization cluster +FIG00008049 [FeFe]-hydrogenase maturation protein HydF +FIG00008051 Chromate resistance protein ChrB +FIG00008055 Proton/glutamate symport protein @ Sodium/glutamate symport protein +FIG00008072 Flagellar sensory histidine kinase FlgS +FIG00008077 Putative pheromone cAM373 precursor lipoprotein CamS +FIG00008080 YafQ toxin protein +FIG00008083 unknown domain / Nucleoside 5-triphosphatase RdgB (dHAPTP, dITP, XTP-specific) (EC 3.6.1.15) +FIG00008096 Protein clustered with ethanolamine utilization +FIG00008099 Unknown pentose isomerase TM0951 +FIG00008102 Uridine diphosphate glucose pyrophosphatase (EC 3.6.1.45) +FIG00008104 Hypothetical zinc-type alcohol dehydrogenase-like protein YphC +FIG00008107 Transcriptional regulator of fructoselysine utilization operon FrlR +FIG00008115 Streptolysin S biosynthesis protein C (SagC) +FIG00008117 Positive regulator of L-idonate catabolism +FIG00008125 COG1399 protein in cluster with ribosomal protein L32p, Firmicutes subfamily +FIG00008150 Transcriptional regulator in BltB locus +FIG00008151 Pterin-binding family +FIG00008152 PTS system, mannose-specific IIB component (EC 2.7.1.69) / PTS system, mannose-specific IIC component / PTS system, mannose-specific IIA component +FIG00008153 Galactosamine-6-phosphate isomerase (galactosamine-6-phosphate deaminase) (EC 5.3.1.-) +FIG00008161 Osmotically activated L-carnitine/choline ABC transporter, permease protein OpuCB +FIG00008163 Photosystem II protein PsbT +FIG00008175 Protein YjgK, linked to biofilm formation +FIG00008187 Phosphoenolpyruvate-dihydroxyacetone phosphotransferase operon regulatory protein DhaR +FIG00008190 Siderophore [Alcaligin-like] biosynthesis complex, short chain @ Siderophore synthetase small component, acetyltransferase +FIG00008199 Hut operon positive regulatory protein +FIG00008217 Hypothetical protein probably associated with Carbamoyl-phosphate synthase +FIG00008221 Cadmium resistance protein +FIG00008230 Two-component sensor kinase yesM (EC 2.7.3.-), associated with MetSO reductase +FIG00008242 Virulence regulatory factor PrfA / Transcriptional regulator, CrP/Fnr family +FIG00008246 Na+/H+ antiporter +FIG00008251 Ferredoxin--sulfite reductase (EC 1.8.7.1) +FIG00008252 Various polyols ABC transporter, permease component 2 +FIG00008264 Osmotically activated L-carnitine/choline ABC transporter, substrate-binding protein OpuCC +FIG00008266 Lipoteichoic acid synthase LtaS Type Ia +FIG00008269 PTS system, galactosamine-specific IIC component +FIG00008270 (GlcNAc)2 ABC transporter, permease component 1 +FIG00008273 N-acetylneuraminate synthase (EC 2.5.1.56) +FIG00008276 Phosphoglycerate mutase family, Lmo0556 homolog +FIG00008279 Universal stress protein family 3 +FIG00008285 Ribose ABC transporter, periplasmic ribose-binding protein RbsB (TC 3.A.1.2.1) +FIG00008286 Osmotically activated L-carnitine/choline ABC transporter, ATP-binding protein OpuCA +FIG00008294 Membrane-bound lytic murein transglycosylase D precursor (EC 3.2.1.-) +FIG00008299 Cobalt-zinc-cadmium resistance protein CzcA; Cation efflux system protein CusA +FIG00008304 Aspartate 1-decarboxylase (EC 4.1.1.11) +FIG00008307 VgrG protein +FIG00008308 Putative oxidoreductase linked to yggC +FIG00008311 Inositol transport system sugar-binding protein +FIG00008319 conserved hypothetical membrane protein, paralogue of Y20848 +FIG00008333 Xanthosine permease +FIG00008334 Putative oxidoreductase YdjL +FIG00008337 Ferredoxin-like protein +FIG00008342 Anaerobic sulfite reductase subunit A +FIG00008348 Predicted transcriptional regulator of N-Acetylglucosamine utilization, GntR family +FIG00008358 Putative tonB protein +FIG00008360 Peptide methionine sulfoxide reductase MsrA (EC 1.8.4.11) / Peptide methionine sulfoxide reductase MsrB (EC 1.8.4.12) +FIG00008361 Uncharacterized protein sll1880 (YjbQ family) +FIG00008365 C5a peptidase (EC 3.4.21.-) +FIG00008370 Creatinine amidohydrolase (EC 3.5.2.10) +FIG00008372 Predicted alpha-ribazole-5-phosphate synthase CblS for cobalamin biosynthesis +FIG00008376 Predicted alpha-mannoside ABC transporter, permease protein 2 +FIG00008379 Internalin-like protein Lmo0549 homolog +FIG00008382 Uncharacterized sigma-54-dependent transcriptional regulator YgeV +FIG00008386 Uncharacterized protein YphG, TPR-domain containing +FIG00008394 2-keto-3-deoxy-D-arabino-heptulosonate-7-phosphate synthase I beta (EC 2.5.1.54) / Chorismate mutase I (EC 5.4.99.5) +FIG00008396 Aquaporin Z +FIG00008406 MSHA biogenesis protein MshK +FIG00008409 Similar to C-terminal Zn-finger domain of DNA topoisomerase I +FIG00008411 DNA polymerase III alpha subunit (EC 2.7.7.7) +FIG00008420 Putative chaperon-like protein Ycf39 for quinone binding in Photosystem II +FIG00008426 4Fe-4S ferredoxin, nitrogenase-associated +FIG00008439 Inositol transport system ATP-binding protein +FIG00008441 TsaD/Kae1/Qri7 protein, required for threonylcarbamoyladenosine t(6)A37 formation in tRNA / p53-regulating protein kinase (human PRPK/yeast YGR262c) +FIG00008444 Flagellar regulatory protein FleQ +FIG00008450 Transcriptional antiterminator of lichenan operon, BglG family / PTS system, cellobiose-specific IIA component (EC 2.7.1.69) +FIG00008455 Phosphonate ABC transporter permease protein phnE (TC 3.A.1.9.1) +FIG00008467 (GlcNAc)2 ABC transporter, permease component 2 +FIG00008474 ABC-type tungstate transport system, permease protein +FIG00008480 FIG008480: hypothetical protein +FIG00008487 (GlcNAc)2 ABC transporter, ATP-binding component 1 +FIG00008490 NAD-dependent protein deacetylase of SIR2 family +FIG00008493 2-vinyl bacteriochlorophyllide hydratase BchF (EC 4.2.1.-) +FIG00008505 Phycobilisome phycoerythrin-associated linker polypeptide +FIG00008507 Endopeptidase spore protease Gpr (EC 3.4.24.78) +FIG00008516 Phosphoglycerate mutase family 1 +FIG00008524 Programmed cell death antitoxin YdcD +FIG00008526 Metal-dependent hydrolase involved in phosphonate metabolism +FIG00008533 L-Cystine ABC transporter, ATP-binding protein TcyC +FIG00008539 Sorbitol operon transcription regulator +FIG00008542 Glucuronide transport facilitator UidC +FIG00008546 5-keto-2-deoxygluconokinase (EC 2.7.1.92) / uncharacterized domain +FIG00008556 L-proline glycine betaine ABC transport system permease protein ProV (TC 3.A.1.12.1) +FIG00008557 twitching motility protein PilG +FIG00008560 Uncharacterized protein ImpJ/VasE +FIG00008562 Inositol transport system permease protein +FIG00008566 bacterial transferase hexapeptide domain protein +FIG00008568 Flagellin protein FlaC +FIG00008572 Cadmium efflux system accessory protein +FIG00008573 Delta 1-pyrroline-5-carboxylate dehydrogenase domain protein +FIG00008590 Bis(5'-nucleosyl)-tetraphosphatase (asymmetrical) (EC 3.6.1.17) +FIG00008591 N-Acetyl-D-glucosamine ABC transport system, permease protein 1 +FIG00008602 Division initiation protein +FIG00008606 IncF plasmid conjugative transfer pilin acetylase TraX +FIG00008609 Dipeptide transport system permease protein DppC (TC 3.A.1.5.2); Putative hemine transporter ATP-binding subunit +FIG00008615 Fructoselysine transporter FrlA, cationic amino acid permease +FIG00008628 quinol oxidase polypeptide II QoxA (EC:1.9.3.-) +FIG00008632 CMP-N-acetylneuraminate-beta-galactosamide-alpha-2,3-sialyltransferase (EC 2.4.99.-) +FIG00008638 Glucosamine kinase GpsK (EC 2.7.1.8) +FIG00008639 Heme-regulated cyclic AMP phosphodiesterase (EC 3.1.4.-) +FIG00008646 Putative peptidoglycan bound protein (LPXTG motif) Lmo0175 homolog +FIG00008650 Internalin-like protein (LPXTG motif) Lmo0732 homolog +FIG00008656 Regulatory protein (induces abgABT, used to catabolize p-aminobenzoyl-glutamate) +FIG00008663 3-phenylpropionate dioxygenase ferredoxin--NAD(+) reductase component (EC 1.18.1.3) +FIG00008665 16 kDa heat shock protein A +FIG00008667 Superoxide dismutase [Mn/Fe] (EC 1.15.1.1) +FIG00008672 Cytochrome c oxidase (B(O/a)3-type) chain II (EC 1.9.3.1) +FIG00008680 Homoprotocatechuate degradative operon repressor +FIG00008692 Glucosamine-link cellobiase (EC 3.2.1.21) +FIG00008693 Predicted L-rhamnose permease RhaY +FIG00008701 Triacylglycerol lipase (EC 3.1.1.3) +FIG00008708 NADH dehydrogenase (EC 1.6.99.3) +FIG00008709 Fructoselysine kinase (EC 2.7.1.-) +FIG00008727 Phytoene desaturase, neurosporene or lycopene producing (EC 1.3.-.-) / 4,4'-diapolycopene oxidase +FIG00008732 Allophycocyanin beta chain +FIG00008736 Predicted transcriptional regulator of pyridoxine metabolism +FIG00008751 outer membrane protein, MtrB +FIG00008752 ComF operon protein C +FIG00008758 YeeV toxin protein +FIG00008759 Tricarboxylate transport protein TctB +FIG00008770 CRISPR-associated protein, Cas5e family +FIG00008776 Putative tRNA-m1A22 methylase +FIG00008778 Maltose operon transcriptional repressor MalR, LacI family +FIG00008789 Sodium-Choline Symporter +FIG00008796 Unspecified monosaccharide ABC transport system, permease component 2 +FIG00008812 Formate dehydrogenase -O, gamma subunit (EC 1.2.1.2) +FIG00008829 Putative peptidoglycan bound protein (LPXTG motif) Lmo0880 homolog +FIG00008835 Programmed cell death antitoxin MazE +FIG00008841 L-Cystine ABC transporter, permease protein TcyM +FIG00008842 Membrane lipoprotein lipid attachment site containing protein USSDB6D +FIG00008846 Multidrug-efflux transporter, major facilitator superfamily (MFS) (TC 2.A.1); Efflux pump Lde +FIG00008854 Uncharacterized domain COG3236 / GTP cyclohydrolase II (EC 3.5.4.25) +FIG00008870 Uncharacterized protein YohN precursor +FIG00008873 Pyrrolidone-carboxylate peptidase (EC 3.4.19.3) +FIG00008875 Uncharacterized protein YehA precursor +FIG00008879 Heme transporter IsdDEF, lipoprotein IsdE +FIG00008886 Septum site-determining protein MinC +FIG00008889 Arsenical-resistance protein ACR3 +FIG00008893 Capsular polysaccharide export system protein KpsS +FIG00008894 Polypeptide composition of the spore coat protein CotJC +FIG00008895 TRAP transporter solute receptor, TAXI family precursor +FIG00008903 Late competence protein ComGD, access of DNA to ComEA, FIG012777 +FIG00008905 Chaperone protein EcpD +FIG00008907 Alpha-L-Rha alpha-1,3-L-rhamnosyltransferase (EC 2.4.1.-) +FIG00008910 Ethanolamine sensory transduction histidine kinase +FIG00008916 quinol oxidase polypeptide III QoxC (EC:1.9.3.-) +FIG00008919 ATPase of the AAA+ family protein associated with FIG137771 hypothetical protein +FIG00008941 Fructose-1,6-bisphosphatase, Bacillus type (EC 3.1.3.11) +FIG00008952 Dipeptide transport system permease protein DppB (TC 3.A.1.5.2); putative hemin permease +FIG00008958 Copper-containing nitrite reductase (EC 1.7.2.1) +FIG00008961 Coenzyme F420-reducing hydrogenase, beta subunit +FIG00008970 Capsular polysaccharide ABC transporter, permease protein KpsM +FIG00008973 Ribosome biogenesis protein Nop10 +FIG00008985 TRAP dicarboxylate transporter, DctM subunit, unknown substrate 5 +FIG00009014 Anaerobic sulfite reductase subunit C (EC 1.8.1.-) +FIG00009017 Isochorismatase (EC 3.3.2.1) +FIG00009021 Disulfide bond regulator +FIG00009025 Putative curli production protein CsgC +FIG00009026 Hypothetical transmembrane protein CDS_ID OB1773 +FIG00009029 Major fimbrial subunit StfA +FIG00009031 Bacteriophage N4 adsorption protein A +FIG00009035 Rhodanese domain protein UPF0176, Firmicutes subgroup +FIG00009036 ABC transporter, permease protein EscB +FIG00009038 D,D-heptose 7-phosphate kinase +FIG00009044 Thiol-activated cytolysin +FIG00009050 Cytolethal distending toxin subunit A +FIG00009058 Cell surface protein IsdA, transfers heme from hemoglobin to apo-IsdC +FIG00009060 Fructuronate transporter GntP +FIG00009062 Citrate:6-N-acetyl-6-N-hydroxy-L-lysine ligase, alpha subunit (EC 6.3.2.27), aerobactin biosynthesis protein IucA @ Siderophore synthetase superfamily, group C @ Siderophore synthetase component, ligase +FIG00009068 RNA polymerase sigma factor for flagellar operon +FIG00009069 Transcriptional repressor of the myo-inositol catabolic operon DeoR family +FIG00009072 Polypeptide composition of the spore coat protein CotJB +FIG00009073 FIG015373: Membrane protein +FIG00009077 Protein of unknown function DUF374 +FIG00009080 Citrate:6-N-acetyl-6-N-hydroxy-L-lysine ligase, alpha subunit (EC 6.3.2.27), aerobactin biosynthesis protein IucA @ Siderophore synthetase superfamily, group A @ Siderophore synthetase large component, acetyltransferase +FIG00009095 FIG009095: D,D-carboxypeptidase family protein +FIG00009096 Galactosamine-6-phosphate isomerase (EC 5.3.1.-) +FIG00009100 Arginine/ornithine ABC transporter, permease protein AotQ +FIG00009109 Secreted and spore coat-associated protein 1, similar to biofilm matrix component TasA and to camelysin +FIG00009132 Inner membrane protein YjgN +FIG00009133 Putative HTH-type transcriptional regulator YjgJ, TetR family +FIG00009141 Internalin-like protein (LPXTG motif) Lmo0610 homolog +FIG00009148 FIG009148: Acetyltransferase, GNAT family +FIG00009149 Butyryl-CoA dehydrogenase (EC 1.3.99.2) +FIG00009152 Protein of avirulence locus ImpE +FIG00009154 tRNA-intron endonuclease (EC 3.1.27.9) +FIG00009156 Substrate-specific component RibU of riboflavin ECF transporter +FIG00009163 LysR family transcriptional regulator PA5218 +FIG00009194 Alpha-mannosidase (EC 3.2.1.24) +FIG00009203 L-O-lysylphosphatidylglycerol synthase (EC 2.3.2.3) @ FmtC (MrpF) protein involved in methicillin resistance +FIG00009206 HTH-type transcriptional regulator YtlI, LysR family +FIG00009208 L-sorbose 1-phosphate reductase (EC 1.1.1.-) +FIG00009210 FIG009210: peptidase, M16 family +FIG00009212 Lipoteichoic acid synthase LtaS Type Ib +FIG00009225 Heme ABC type transporter HtsABC, permease protein HtsC +FIG00009229 Heat shock protein 60 family co-chaperone GroES +FIG00009238 Phosphoglucosamine mutase (EC 5.4.2.10) / FemD, factor involved in methicillin resistance +FIG00009241 Aldehyde dehydrogenase (EC 1.2.1.3); Acetaldehyde dehydrogenase (EC 1.2.1.3) +FIG00009245 Hypothetical protein SAV1839 +FIG00009252 Hypothetical protein FIG016644 +FIG00009265 L-seryl-tRNA(Sec) selenium transferase (EC 2.9.1.1) +FIG00009266 Putative glycosyl/glycerophosphate transferase in teichoic acid biosynthesis +FIG00009270 Two component system histidine kinase ArlS (EC 2.7.3.-) +FIG00009273 Phycocyanin beta chain +FIG00009278 Phosphoenolpyruvate-protein phosphotransferase of PTS system (EC 2.7.3.9) / Fructose-specific phosphocarrier protein HPr (EC 2.7.1.69) / PTS system, fructose-specific IIA component (EC 2.7.1.69) +FIG00009290 Eight transmembrane protein EpsH / EpsI protein +FIG00009294 tRNA proofreading protein STM4549 +FIG00009300 TPR-repeat-containing protein, putative component of Menaquinone-cytochrome C reductase +FIG00009315 Hemin uptake protein +FIG00009337 Internalin C2 (LPXTG motif) +FIG00009338 Hemin transport protein HmuS +FIG00009347 Type VI secretion protein VasI +FIG00009355 type 1 fimbriae major subunit FimA +FIG00009373 Aconitate hydratase X, predicted +FIG00009374 tRNA-dependent lipid II-GlyGlyGly--glycine ligase @ tRNA-dependent lipid II-GlyGlyGlyGly--glycine ligase @ FemB, factor involved in methicillin resistance +FIG00009380 Diaminopimelate epimerase alternative form predicted for S.aureus (EC 5.1.1.7) +FIG00009385 FIG011895: hypothetical protein +FIG00009395 Substrate-specific component ThiW of predicted thiazole ECF transporter +FIG00009396 Protein-glutamine gamma-glutamyltransferase (EC 2.3.2.13) +FIG00009398 Flagellar hook-associated protein FlgL +FIG00009399 N-succinyldiaminopimelate aminotransferase (EC 2.6.1.17) +FIG00009400 Internalin-like protein (LPXTG motif) Lmo1136 homolog +FIG00009403 FIG013761: LmbE family protein +FIG00009406 Internalin-like protein (LPXTG motif) Lmo2821 homolog +FIG00009417 Gluconate permease, Bsu4004 homolog +FIG00009425 Hypothetical, similar to sarcosine oxidase alpha subunit, 2Fe-2S domain +FIG00009438 FIGfam009438: Two-component system DNA-binding response regulator +FIG00009439 FIG009439: Cytosolic protein containing multiple CBS domains +FIG00009446 BatD +FIG00009450 Peptidoglycan N-acetylglucosamine deacetylase (EC 3.5.1.-) +FIG00009455 Epoxide hydrolase (EC 3.3.2.9) +FIG00009464 Hypothetical protein, restriction endonuclease-like VRR-NUC domain +FIG00009466 Hypothetical protein, SAV0877 homolog [SA bacteriophages 11, Mu50B] +FIG00009481 Propanediol utilization transcriptional activator +FIG00009483 Ethylmalonyl-CoA mutase, methylsuccinyl-CoA-forming +FIG00009485 Coenzyme PQQ synthesis protein B +FIG00009496 Predicted endonuclease distantly related to archaeal Holliday junction resolvase +FIG00009500 Inner membrane protein YghQ, probably involved in polysaccharide biosynthesis +FIG00009510 Teicoplanin resistance associated membrane protein TcaA +FIG00009512 N-acetylornithine carbamoyltransferase (EC 2.1.3.9) +FIG00009530 Hypothetical protein SAV1869 +FIG00009537 YuzD-like protein +FIG00009544 Late competence protein ComEA, DNA receptor +FIG00009560 Predicted glycosylase, COG2152 +FIG00009563 Choloylglycine hydrolase (EC 3.5.1.24) +FIG00009564 Late competence protein ComEC, DNA transport +FIG00009570 tRNA-dependent lipid II--glycine ligase (FmhB) +FIG00009578 HmrA protein involved in methicillin resistance / amidohydrolase of M40 family +FIG00009591 Pheophorbide a oxygenase (EC 1.14.12.20) +FIG00009593 Phosphoglycerate mutase family 5 +FIG00009601 Probable low-affinity inorganic phosphate transporter +FIG00009610 Transcriptional regulator SarV (Staphylococcal accessory regulator V) +FIG00009614 omega-3 polyunsaturated fatty acid synthase subunit, PfaC +FIG00009623 Capsular polysaccharide biosynthesis protein WcbQ +FIG00009627 Phytoene desaturase (EC 1.14.99.-) +FIG00009628 Programmed cell death toxin YdcE +FIG00009630 Transcriptional regulator of biofilm formation (AraC/XylS family) +FIG00009633 Bilin biosynthesis protein CpeY +FIG00009634 GltC, transcription activator of glutamate synthase operon +FIG00009637 PaaD-like protein (DUF59) involved in Fe-S cluster assembly +FIG00009638 Hypothetical protein SAV1877 +FIG00009640 Benzoyl-CoA-dihydrodiol lyase (EC 4.1.2.44) +FIG00009641 Negative regulator of flagellin synthesis +FIG00009652 Sensor histidine kinase VraS +FIG00009679 Streptolysin S self-immunity protein (SagE) +FIG00009680 LysR family transcriptional regulator YbhD +FIG00009681 Bipolar DNA helicase HerA +FIG00009682 Phosphoglucosamine mutase (EC 5.4.2.10) +FIG00009688 FIG009688: Thioredoxin +FIG00009692 hypothetical fig|282458.1.peg.581 homolog +FIG00009695 Hypothetical protein FIG009695 +FIG00009700 Phytochelatin synthase (EC 2.3.2.15), bacterial type +FIG00009711 Predicted cell-wall-anchored protein SasF (LPXAG motif) +FIG00009714 Hydrogenase-4 component H +FIG00009720 Flagellar sensor histidine kinase FleS +FIG00009727 Internalin A (LPXTG motif) +FIG00009730 Fimbriae-like adhesin SfmA +FIG00009731 UPF0118 membrane protein YrrI +FIG00009734 alginate o-acetyltransferase AlgF +FIG00009736 CoA-disulfide reductase (EC 1.8.1.14) +FIG00009754 Hypothetical protein in cluster with penicillin-binding protein PBP1, Listerial type +FIG00009770 Transcriptional regulator BkdR of isoleucine and valine catabolism operon +FIG00009775 Glycosyl transferase, group 1 family protein +FIG00009782 Putative dihydroxyacetone kinase (EC 2.7.1.29), dihydroxyacetone binding subunit +FIG00009787 Poly(beta-D-mannuronate) C5 epimerase precursor (EC 5.1.3.-) +FIG00009790 O-phosphoseryl-tRNA:Cysteinyl-tRNA synthase +FIG00009793 Fimbrial protein YadN +FIG00009799 quinol oxidase polypeptide IV QoxD (EC:1.9.3.-) +FIG00009800 Beta-fimbriae usher protein +FIG00009807 Osmotically activated L-carnitine/choline ABC transporter, permease protein OpuCD +FIG00009828 Glucose 1-dehydrogenase (EC 1.1.1.47) +FIG00009846 benzoate-specific porin +FIG00009849 Acyl-CoA dehydrogenase, short-chain specific (EC 1.3.99.2) +FIG00009851 Mannosyl-D-glycerate utilization repressor MngR +FIG00009859 Coenzyme F420-0:L-glutamate ligase @ Coenzyme F420-1:L-glutamate ligase / domain of unknown function +FIG00009870 Hypothetical protein SAV1840 +FIG00009880 Peptide transport system permease protein SapC +FIG00009889 Mevalonate kinase (EC 2.7.1.36) +FIG00009894 Duplicated ATPase component YkoD of energizing module of thiamin-regulated ECF transporter for HydroxyMethylPyrimidine +FIG00009897 DNA polymerase X family +FIG00009898 Probable exported or periplasmic protein in ApbE locus +FIG00009905 Putative deoxyribonuclease similar to YcfH, type 4 +FIG00009910 Ribonuclease HI-related protein 3 +FIG00009915 Gluconate operon transcriptional repressor +FIG00009918 AttF component of AttEFGH ABC transport system / AttG component of AttEFGH ABC transport system +FIG00009946 5-oxopent-3-ene-1,2,5-tricarboxylate decarboxylase. +FIG00009947 L-O-lysylphosphatidylglycerol synthase (EC 2.3.2.3) / Lysyl-tRNA synthetase (class II) related protein found fused to membrane protein +FIG00009956 RNA:NAD 2'-phosphotransferase +FIG00009957 Alginate biosynthesis protein AlgX +FIG00009971 Lipoprotein releasing system transmembrane protein LolC +FIG00009989 Niacin transporter NiaP +FIG00009996 Alkaline phosphatase synthesis transcriptional regulatory protein PhoP +FIG00010003 Putative membrane protein Q2 colocalized with Q +FIG00010011 Hypothetical protein SAV1831 +FIG00010036 Ribonuclease HI, Vibrio paralog +FIG00010047 D-xylose-specific 1-epimerase (mutarotase) +FIG00010048 Capsular polysaccharide glycosyltransferase biosynthesis protein WcbB +FIG00010054 Substrate-specific component CblT of predicted B12-regulated ECF transporter for dimethylbenzimidazole +FIG00010063 FIG010063: hypothetical protein +FIG00010064 Teicoplanin resistance associated membrane protein TcaB +FIG00010078 Substrate-specific component YkoE of thiamin-regulated ECF transporter for HydroxyMethylPyrimidine +FIG00010088 Small, acid-soluble spore protein O +FIG00010099 Putative Holliday junction resolvase YqgF +FIG00010100 Citrate lyase beta chain (EC 4.1.3.6) +FIG00010105 Pyruvate oxidase [ubiquinone, cytochrome] (EC 1.2.2.2) @ Pyruvate oxidase, CidC +FIG00010121 LysR-family transcriptional regulator clustered with PA0057 +FIG00010128 Lipid carrier protein IgrF +FIG00010134 Methionine transporter MetT +FIG00010140 Stringent starvation protein B +FIG00010141 Alginate biosynthesis protein Alg8 +FIG00010145 Two component transcriptional regulator VraR +FIG00010146 FIGfam010146: Two component system histidine kinase +FIG00010157 Mn2+/Fe2+ transporter, NRAMP family +FIG00010165 Peptide methionine sulfoxide reductase regulator MsrR +FIG00010169 NAD(FAD)-utilizing dehydrogenase, sll0175 homolog +FIG00010170 Group 2 RNA polymerase sigma factor @ Cyanobacteria-specific RpoD-like sigma factor, type-7 +FIG00010172 Putative peptidoglycan bound protein (LPXTG motif) Lmo0550 homolog +FIG00010178 LPXTG specific sortase A +FIG00010188 Sigma-fimbriae uncharacterized subunit +FIG00010192 Zn(II) and Co(II) transmembrane diffusion facilitator +FIG00010194 Cell wall surface anchor family protein +FIG00010203 PvcA protein, related to known isonitrile synthases +FIG00010232 HoxN/HupN/NixA family cobalt transporter +FIG00010241 5-carboxymethyl-2-oxo-hex-3- ene-1,7-dioate decarboxylase (EC 4.1.1.68) / 2-hydroxyhepta-2,4-diene-1,7-dioate isomerase (EC 5.3.3.-) +FIG00010262 Allophanate hydrolase 2 subunit 2 (EC 3.5.1.54) +FIG00010267 diglucosyldiacylglycerol synthase (LTA membrane anchor synthesis) +FIG00010273 Transcriptional regulator of various polyols utilization, AraC family +FIG00010274 Teichoic acid biosynthesis protein X +FIG00010285 Ribonucleotide reductase of class II (coenzyme B12-dependent) (EC 1.17.4.1) +FIG00010286 Type IV pilus biogenesis protein PilQ +FIG00010310 ATP-dependent DNA helicase pcrA (EC 3.6.1.-) +FIG00010378 Pyoverdine synthetase PvdF, N5-hydroxyornithine formyltransferase +FIG00010380 Formate dehydrogenase-O, major subunit (EC 1.2.1.2) @ selenocysteine-containing +FIG00010386 FrmR: Negative transcriptional regulator of formaldehyde detoxification operon +FIG00010392 Sucrose-6-phosphate hydrolase (EC 3.2.1.B3) +FIG00010397 Heme ABC type transporter HtsABC, permease protein HtsB +FIG00010407 Ribonuclease HI, Bacillus nonfunctional homolog +FIG00010408 Bifunctional autolysin Atl / N-acetylmuramoyl-L-alanine amidase (EC 3.5.1.28) / Endo-beta-N-acetylglucosaminidase (EC 3.2.1.96) +FIG00010410 Putative HTH-type transcriptional regulator yahB +FIG00010414 ComF operon protein A, DNA transporter ATPase +FIG00010427 FIG010427: hypothetical protein +FIG00010442 Transmembrane component BL0694 of energizing module of predicted ECF transporter +FIG00010444 Positive regulator of competence TfoX +FIG00010453 4-oxalocrotonate tautomerase (EC 5.3.2.-) +FIG00010454 Tricarboxylate transport membrane protein TctA +FIG00010478 Phosphonate ABC transporter permease protein phnE2 (TC 3.A.1.9.1) +FIG00010489 5,10-methylenetetrahydrofolate reductase (EC 1.5.1.20) / Homolog of homocysteine-binding domain +FIG00010502 CsbB stress response protein +FIG00010507 Redox-sensing transcriptional regulator QorR, putative +FIG00010508 Phosphate ABC transporter, periplasmic phosphate-binding protein PstS (TC 3.A.1.7.1) +FIG00010516 Internalin-like protein (LPXTG motif) Lmo1290 homolog +FIG00010524 Aminobenzoyl-glutamate transport protein +FIG00010536 HemX protein, negative effector of steady-state concentration of glutamyl-tRNA reductase +FIG00010548 DNA topoisomerase III, Bacteroidales-type (EC 5.99.1.2) +FIG00010550 Bilin biosynthesis protein CpeZ +FIG00010554 Hpa2 protein +FIG00010556 Alternative cytochrome c oxidase polypeptide CoxN (EC 1.9.3.1) +FIG00010561 Putative peptidoglycan bound protein (LPXTG motif) Lmo2085 homolog +FIG00010563 CRISPR-associated protein, Cse2 family +FIG00010597 Phospholipase/carboxylesterase family protein, sll1284 homolog +FIG00010600 Xaa-Pro aminopeptidase (EC 3.4.11.9) +FIG00010604 Urease gamma subunit (EC 3.5.1.5) +FIG00010624 putative succinate dehydrogenase [membrane anchor subunit] (succinic dehydrogenase) +FIG00010632 Bacitracin export permease protein BceB +FIG00010638 Flagellin protein FlaF +FIG00010657 Type III secretion inner membrane protein (YscQ,homologous to flagellar export components) +FIG00010661 Alpha-L-Rha alpha-1,2-L-rhamnosyltransferase/alpha-L-Rha alpha-1,3-L- rhamnosyltransferase (EC 2.4.1.-) +FIG00010671 Flagellar basal-body P-ring formation protein FlgA +FIG00010675 Formate efflux transporter (TC 2.A.44 family) +FIG00010687 Nitrogen assimilation regulatory protein Nac +FIG00010697 Fructoselysine 3-epimerase +FIG00010710 Surface presentation of antigens protein +FIG00010713 Fe(2+)/alpha-ketoglutarate-dependent dioxygenase LpxO +FIG00010717 FIGfam010717 +FIG00010728 conserved hypothetical protein in cyt c oxidase gene clusters +FIG00010738 Imidazole glycerol phosphate synthase amidotransferase subunit (EC 2.4.2.-) +FIG00010749 Beta-galactosidase (EC 3.2.1.23) / Beta-glucosidase (EC 3.2.1.21) / Beta-fucosidase (EC 3.2.1.38) +FIG00010759 Putative dihydroxyacetone kinase (EC 2.7.1.29), ADP-binding subunit +FIG00010760 Sensor histidine kinase colocalized with HrtAB transporter +FIG00010766 Petrobactin ABC transporter, permease protein II +FIG00010771 SusC, outer membrane protein involved in starch binding +FIG00010780 5-oxoprolinase (EC 3.5.2.9) +FIG00010796 2-amino-3-carboxymuconate-6-semialdehyde decarboxylase (EC 4.1.1.45) +FIG00010810 Fimbrial protein YadK +FIG00010811 DNA binding protein, FIG046916 +FIG00010816 Alginate biosynthesis transcriptional activator +FIG00010818 L-serine dehydratase, beta subunit (EC 4.3.1.17) +FIG00010842 Type III secretion host injection protein (YopB) +FIG00010844 Flavodoxin +FIG00010846 Propanediol dehydratase reactivation factor large subunit +FIG00010851 Copper(I) chaperone CopZ +FIG00010861 Type III secretion system protein BsaR +FIG00010868 D-arabino-3-hexulose 6-phosphate formaldehyde-lyase (EC 4.1.2.43) +FIG00010869 Putative peptidoglycan bound protein (LPXTG motif) Lmo0627 homolog +FIG00010870 AttE component of AttEFGH ABC transport system +FIG00010871 hypothetical protein Rv3805c +FIG00010876 Two-component sensor kinase YesM (EC 2.7.3.-) +FIG00010877 Petrobactin ABC transporter, ATP-binding protein +FIG00010890 predicted N-acetylglucosamine kinase, glucokinase-like (EC 2.7.1.59) +FIG00010894 Streptolysin S biosynthesis protein (SagF) +FIG00010899 Biotin synthesis protein bioK +FIG00010902 HigA protein (antitoxin to HigB) +FIG00010908 CoB--CoM heterodisulfide reductase subunit C (EC 1.8.98.1) +FIG00010910 Short-chain dehydrogenase, associated with 2-hydroxychromene-2-carboxylate isomerase family protein +FIG00010912 Heme ABC transporter (Streptococcus), permease protein +FIG00010914 Export ABC transporter ATP-binding protein; Streptolysin S export protein (SagG) +FIG00010922 NADH-ubiquinone oxidoreductase chain G (EC 1.6.5.3) +FIG00010924 type 1 fimbriae regulatory protein FimB +FIG00010938 Petrobactin ABC transporter, permease protein I +FIG00010967 benzoate degradation ring-cleavage hydrolase +FIG00010982 Phosphoglycerate mutase family, Lmo0907 homolog +FIG00011002 L-Cystine ABC transporter, permease protein TcyB +FIG00011006 Chitin catabolic cascade sensor histidine kinase ChiS +FIG00011015 Transcriptional regulator VpsR +FIG00011016 Transcriptional regulator SarR (Staphylococcal accessory regulator R) +FIG00011029 Formylmethanofuran dehydrogenase (molybdenum) subunit B (EC 1.2.99.5) +FIG00011031 NADH-ubiquinone oxidoreductase chain B (EC 1.6.5.3) homolog; Hypothetical oxidoreductase +FIG00011044 hypothetical fig|282458.1.peg.579 homolog +FIG00011048 Heme d1 biosynthesis protein NirJ +FIG00011057 Deoxyribonucleoside regulator DeoR (transcriptional repressor) +FIG00011061 Phycobilisome rod linker polypeptide, phycocyanin-associated +FIG00011084 Ribosomal large subunit pseudouridine synthase F (EC 4.2.1.70) +FIG00011094 Cyn operon transcriptional activator +FIG00011102 Nitrite reductase probable electron transfer 4Fe-S subunit (EC 1.7.1.4) +FIG00011106 BatE +FIG00011114 Phosphate transport ATP-binding protein PstB (TC 3.A.1.7.1) +FIG00011115 PTS system, cellobiose-specific IIA component (EC 2.7.1.69) +FIG00011116 Fimbriae usher protein StfC +FIG00011121 FIG011121: hypothetical protein +FIG00011136 Dipeptide-binding ABC transporter, periplasmic substrate-binding component (TC 3.A.1.5.2); Putative hemin-binding lipoprotein +FIG00011140 Acetylornithine deacetylase/Succinyl-diaminopimelate desuccinylase and related deacylases +FIG00011155 FIG011155: Zinc carboxypeptidase-related protein +FIG00011165 Putative response regulator ArlR +FIG00011185 Internalin C +FIG00011186 ABC transporter in pyoverdin gene cluster, ATP-binding component +FIG00011192 Teicoplanin-resistance associated HTH-type transcriptional regulator TcaR +FIG00011200 Toprim domain protein +FIG00011203 Hypothetical protein in cluster with At3g50560-like gene family +FIG00011224 Zinc metalloproteinase precursor (EC 3.4.24.29) / aureolysin +FIG00011236 Phosphomevalonate kinase (EC 2.7.4.2) +FIG00011243 Transcriptional regulator of fimbriae expression FimZ (LuxR/UhpA family) +FIG00011260 2-Keto-D-gluconate dehydrogenase (EC 1.1.99.4), membrane-bound, flavoprotein +FIG00011268 Superantigen enterotoxin SEK +FIG00011271 Putative peptidoglycan bound protein (LPXTG motif) Lmo2714 homolog +FIG00011272 Prolyl endopeptidase (EC 3.4.21.26) +FIG00011279 BH2577 unknown conserved protein in B. subtilis +FIG00011280 Formate dehydrogenase subunit or accessory protein +FIG00011290 Ferredoxin--sulfite reductase, bacillial type (EC 1.8.7.1) +FIG00011301 Signal transduction histidine kinase +FIG00011306 Acetyl-CoA:Cys-GlcN-Ins acetyltransferase, mycothiol synthase MshD +FIG00011323 L-idonate, D-gluconate, 5-keto-D-gluconate transporter +FIG00011339 Haemin uptake system outer membrane receptor +FIG00011344 Streptolysin S biosynthesis protein D (SagD) +FIG00011357 Internalin-like protein Lmo2470 homolog +FIG00011373 Cytochrome b6-f complex subunit VIII (PetN) +FIG00011374 Methylsuccinyl-CoA dehydrogenase, predicted by (Erb et al, 2007) +FIG00011380 putative glycosyltransferase - possibly involved in cell wall localization and side chain formation of rhamnose-glucose polysaccharide +FIG00011382 Membrane proteins related to metalloendopeptidases +FIG00011383 Alternative Folylglutamate Synthase +FIG00011402 NAD-specific glutamate dehydrogenase (EC 1.4.1.2) +FIG00011408 Sigma-fimbriae chaperone protein +FIG00011414 hydrogenase, subunit gamma related protein +FIG00011422 Tryptophan synthase beta chain like (EC 4.2.1.20) +FIG00011423 Ferredoxin reductase +FIG00011427 Aspartokinase (EC 2.7.2.4) / Diaminopimelate decarboxylase (EC 4.1.1.20) +FIG00011450 High-affinity gluconate transporter GntT +FIG00011451 Type IV pilus biogenesis protein PilF +FIG00011465 DNA-binding response regulator ResD +FIG00011468 Phage tail length tape-measure protein +FIG00011486 PvdO, pyoverdine responsive serine/threonine kinase (predicted by OlgaV) +FIG00011501 FIG011501: YycH protein +FIG00011502 CFA/I fimbrial minor adhesin +FIG00011537 Phosphoesterase, DHH family protein +FIG00011548 Predicted broad substrate specificity phosphatase +FIG00011554 PTS system, mannose-specific IIC component +FIG00011570 Lipoteichoic acid synthase LtaS Type IIIb1 +FIG00011577 Microbial collagenase (EC 3.4.24.3) +FIG00011602 Spore germination protein GerLC +FIG00011607 Inner spore coat protein D +FIG00011609 Biofilm PGA synthesis N-glycosyltransferase PgaC (EC 2.4.-.-) +FIG00011613 ABC transporter permease protein YvcS +FIG00011622 Substrate-specific component ThiT of thiamin ECF transporter +FIG00011632 Arginine permease RocE +FIG00011646 Antibiotic biosynthesis monooxygenase domain-containing protein +FIG00011651 Two-component response regulator colocalized with HrtAB transporter +FIG00011659 Formate dehydrogenase-O, major subunit (EC 1.2.1.2) +FIG00011663 Anthranilate synthase, aminase component (EC 4.1.3.27) +FIG00011684 FIG011684: hypothetical protein +FIG00011712 2-hydroxy-6-ketonona-2,4-dienedioic acid hydrolase (EC 3.7.1.-) +FIG00011714 Putative methyltransferase associated with DUF414 +FIG00011718 Transcriptional regulator, YtfJ-family +FIG00011753 Major cell-binding factor precursor PebA +FIG00011803 Coenzyme F420-0:L-glutamate ligase @ Coenzyme F420-1:L-glutamate ligase +FIG00011808 Response regulator SaeR (Staphylococcus exoprotein expression protein R) +FIG00011811 Spore germination protein GerYC +FIG00011814 Transcriptional repressor of arabinoside utilization operon, GntR family +FIG00011820 L-2-hydroxyglutarate oxidase (EC 1.1.3.15) +FIG00011831 hypothetical fig|282458.1.peg.578 homolog +FIG00011842 Stage V sporulation protein AB (SpoVAB) +FIG00011844 Predicted transcriptional regulator of sulfate adenylyltransferase, Rrf2 family +FIG00011856 FIG011856: hypothetical protein +FIG00011864 Late competence protein ComGF, access of DNA to ComEA, FIG012620 +FIG00011871 FIG011871: Hypothetical protein +FIG00011879 Oxidoreductase ion channel +FIG00011890 Lipase precursor (EC 3.1.1.3) +FIG00011902 ATP-dependent Clp protease, ATP-binding subunit ClpC / Negative regulator of genetic competence clcC/mecB +FIG00011906 LysR family transcriptional regulator STM2281 +FIG00011916 MSHA biogenesis protein MshM +FIG00011952 Spore cortex biosynthesis protein +FIG00011987 Stage III sporulation protein AD +FIG00012037 heterodisulfide reductase, iron-sulfur binding subunit, putative +FIG00012057 Exosporium protein F +FIG00012060 Sporulation initiation phosphotransferase B (Spo0B) +FIG00012067 Substrate-specific component BioY of biotin ECF transporter +FIG00012083 Histidine transport protein (permease) +FIG00012089 N-acyl homoserine lactone hydrolase +FIG00012103 Protein GerPE, required for proper assembly of spore coat, mutations lead to super-dormant spore +FIG00012124 Stage IV sporulation protein FA (SpoIVFA) +FIG00012128 polyhydroxyalkanoate synthesis repressor PhaR +FIG00012154 Strepotococcal cysteine protease (Streptopain) (EC 3.4.22.10) / Streptococcal pyrogenic exotoxin B (SpeB) +FIG00012157 Universal stress protein family COG0589 +FIG00012176 O-acetyltransferase, anthrose biosynthesis +FIG00012181 N-acetylglucosamine regulated methyl-accepting chemotaxis protein +FIG00012189 Protein GerPF, required for proper assembly of spore coat, mutations lead to super-dormant spore +FIG00012203 Spore coat protein M +FIG00012232 ATP-dependent RNA helicase PA3950 +FIG00012250 Histidine ABC transporter, permease protein HisM (TC 3.A.1.3.1) +FIG00012254 putative patatin-like phospholipase +FIG00012267 Sialic acid utilization regulator, RpiR family +FIG00012273 Aminotransferase, anthrose biosynthesis +FIG00012283 Glycine betaine ABC transport system, permease protein OpuAB +FIG00012286 CFA/I fimbrial major subunit +FIG00012300 Hypothetical protein, FIG12300 and FIG043029 fams +FIG00012305 Protein GerPB, required for proper assembly of spore coat, mutations lead to super-dormant spore +FIG00012307 Sporulation kinase B (EC 2.7.13.3) +FIG00012309 Late competence protein ComGE, FIG075573 +FIG00012338 Protoporphyrinogen IX oxidase, oxygen-independent, HemG (EC 1.3.-.-) +FIG00012347 Heterodisulfide reductase, cytochrome reductase subunit +FIG00012349 Heme transporter analogous to IsdDEF, ATP-binding protein +FIG00012358 Negative transcriptional regulator-copper transport operon +FIG00012359 EcsC protein +FIG00012360 Protein GerPD, required for proper assembly of spore coat, mutations lead to super-dormant spore +FIG00012378 Cell division protein FtsI [Peptidoglycan synthetase] (EC 2.4.1.129) / Transpeptidase, Penicillin binding protein transpeptidase domain +FIG00012379 RNA polymerase sigma factor SigZ +FIG00012387 Probable carboxyvinyl-carboxyphosphonate phosphorylmutase (EC 2.7.8.23) +FIG00012388 Stage IV sporulation pro-sigma-K processing enzyme (SpoIVFB) +FIG00012390 Uncharacterized iron-regulated membrane protein; Iron-uptake factor PiuB +FIG00012395 DNA integrity scanning protein DisA +FIG00012401 TcuB: works with TcuA to oxidize tricarballylate to cis-aconitate +FIG00012403 Thiamin ABC transporter, substrate-binding component +FIG00012427 HTH domain protein SA1665, binds to mecA promoter region +FIG00012440 Secreted and spore coat-associated protein 2, similar to biofilm matrix component TasA and to camelysin +FIG00012446 Spore germination protein YpeB +FIG00012454 Exosporium protein B @ Spore coat protein G +FIG00012468 Lactate-responsive regulator LldR in Firmicutes, GntR family +FIG00012480 Protein GerPA, required for proper assembly of spore coat, mutations lead to super-dormant spore +FIG00012498 Uracil-DNA glycosylase family protein, clostridial type +FIG00012516 Small acid-soluble spore protein, alpha/beta family, SASP_6 +FIG00012521 Small acid-soluble spore protein, gamma-type SASP +FIG00012531 TRAP-type transport system, small permease component, predicted N-acetylneuraminate transporter +FIG00012536 Uncharacterized transporter, similarity to citrate transporter +FIG00012547 Adenosylmethionine-8-amino-7-oxononanoate aminotransferase (EC 2.6.1.62) +FIG00012552 COG3178: Predicted phosphotransferase related to Ser/Thr protein kinases +FIG00012565 Spore coat protein S +FIG00012569 Protein LiaI +FIG00012576 FIG012576: mutT/nudix family protein +FIG00012589 Glucoamylase (EC 3.2.1.3) +FIG00012591 Beta-1,4-galactosyltransferase +FIG00012602 Immune inhibitor A metalloprotease +FIG00012616 Benzoyl-CoA oxygenase component A +FIG00012617 Biofilm PGA synthesis auxiliary protein PgaD +FIG00012643 penicillin-binding protein, putative +FIG00012683 NLP/P60 family protein +FIG00012686 Copper-sensing two-component system response regulator CusR +FIG00012692 Site-specific tyrosine recombinase +FIG00012700 Trilactone hydrolase [bacillibactin] siderophore +FIG00012708 FmhA protein of FemAB family +FIG00012711 NAD-independent protein deacetylase AcuC +FIG00012727 Dehydrosqualene synthase (EC 2.5.1.-) +FIG00012728 Ferrous iron transport protein A +FIG00012729 Polymyxin transporter PmxC +FIG00012746 Glycine betaine transporter OpuD +FIG00012764 Transamidase GatB domain protein +FIG00012766 ATP-dependent RNA helicase BA2475 +FIG00012767 Two-component system response regulator DccR +FIG00012775 Fimbrial protein YadL +FIG00012782 Flagellar protein FlgT +FIG00012793 Beta-lysine acetyltransferase (EC 2.3.1.-) +FIG00012814 Spore cortex-lytic enzyme, N-acetylglucosaminidase SleL (EC 3.2.1.-) +FIG00012816 Stage II sporulation protein B +FIG00012826 Stage VI sporulation protein D +FIG00012841 L-fucose mutarotase, type 2 +FIG00012845 YbbL ABC transporter ATP-binding protein +FIG00012852 Aminoglycoside N6'-acetyltransferase (EC 2.3.1.82) +FIG00012860 Uncharacterized protein YppC +FIG00012871 LsrR, transcriptional repressor of lsr operon +FIG00012891 Lipoteichoic acid synthase LtaS Type IIIb2 +FIG00012900 Transcriptional regulator SarZ (Staphylococcal accessory regulator Z) +FIG00012916 Periplasmic nitrate reductase component NapL +FIG00012945 Ribose ABC transport system, permease protein RbsC (TC 3.A.1.2.1) +FIG00012961 Small acid-soluble spore protein, alpha/beta family, SASP_5 +FIG00012970 FIGfam012970: transmembrane protein +FIG00012971 TsaC protein (YrdC domain) required for threonylcarbamoyladenosine t(6)A37 modification in tRNA +FIG00012985 ATP-dependent RNA helicase VCA0768 +FIG00012988 Small acid-soluble spore protein, alpha/beta family, SASP_3 +FIG00012996 IncF plasmid conjugative transfer pilin protein TraA +FIG00013001 Phosphoglycerate mutase family 2 +FIG00013010 Dihydrolipoamide dehydrogenase of 2-oxoglutarate dehydrogenase (EC 1.8.1.4) +FIG00013036 Conserved hypothetical TPR repeat protein, clustered with yghQ +FIG00013075 FIG013075: PPE family protein +FIG00013096 Streptococcal cell surface hemoprotein receptor Shr +FIG00013124 KinB signaling pathway activation protein +FIG00013145 Superoxide dismutase SodM-like protein ChrF +FIG00013148 D-alanyl-D-alanine carboxypeptidase (EC 3.4.16.4) / Penicillin binding protein PBP4 +FIG00013154 Phosphoglycerate mutase family 3 +FIG00013156 Putative ABC transporter ATP-binding protein, spy1790 homolog +FIG00013168 Hypothetical protein in cluster with penicillin-binding protein PBP1, Bacillus type +FIG00013178 Stage V sporulation protein AA (SpoVAA) +FIG00013207 Polymyxin synthetase PmxB +FIG00013232 Holin associated hypothetical protein +FIG00013245 Protein GerPC, required for proper assembly of spore coat, mutations lead to super-dormant spore +FIG00013253 Formaldehyde dehydrogenase MscR, NAD/mycothiol-dependent (EC 1.2.1.66) / S-nitrosomycothiol reductase MscR +FIG00013261 Spore germination protein GerD +FIG00013268 FIG013268: hypothetical protein +FIG00013273 Spore germination protein GerHA/GerIA +FIG00013278 Uncharacterized protein DUF547 +FIG00013283 TRAP dicarboxylate transporter, DctQ subunit, unknown substrate 6 +FIG00013313 ATP-dependent RNA helicase YxiN +FIG00013322 KapD, inhibitor of KinA pathway to sporulation +FIG00013339 FIG053235: Diacylglucosamine hydrolase like +FIG00013347 Stage II sporulation protein related to metaloproteases (SpoIIQ) +FIG00013348 Uncharacterized protein in polymyxin biosynthetic cluster +FIG00013350 Putative ribose uptake protein RbsU, GRP transporter family (TC 2.A.7.5) +FIG00013354 FIG013354: hypothetical protein +FIG00013356 cell invasion protein SipB +FIG00013359 MdtR transcriptional regulator, MarR family +FIG00013364 Protease production regulatory protein Hpr (ScoC) +FIG00013366 ADP-heptose--lipooligosaccharide heptosyltransferase II (EC 2.4.1.-) +FIG00013373 MSHA biogenesis protein MshL +FIG00013410 Spore germination protein GerN (inosine-dependent germination), Na+/H+ antiporter +FIG00013414 Late competence protein ComGG, FIG068335 +FIG00013416 Choline kinase (EC 2.7.1.32) +FIG00013423 Sensor histidine kinase LiaS +FIG00013433 Protein secretion chaperonin CsaA +FIG00013439 Spore germination protein GerHC/GerIC +FIG00013453 Streptolysin S export transmembrane permease (SagI) +FIG00013458 Predicted molybdate-responsive regulator YvgK in bacilli +FIG00013475 Cytochrome c-type biogenesis protein CcmG/DsbE, thiol:disulfide oxidoreductase +FIG00013491 Stage V sporulation protein AF (SpoVAF) +FIG00013499 Arabinogalactan endo-1,4-beta-galactosidase (EC 3.2.1.89) +FIG00013516 Microbial collagenase, secreted (EC 3.4.24.3) +FIG00013525 Stage III sporulation protein AH +FIG00013534 Substrate-specific component BL0695 of predicted ECF transporter +FIG00013544 Exosporium protein K +FIG00013554 Stage III sporulation protein AB +FIG00013561 FIG146518: Zn-dependent hydrolases, including glyoxylases +FIG00013562 Hypothetical mga-associated protein +FIG00013579 Predicted transcriptional regulator LiuR of leucine degradation pathway, MerR family +FIG00013592 Putative ABC transporter (ATP-binding protein), spy1791 homolog +FIG00013609 DNA-entry nuclease (Competence-specific nuclease) (EC 3.1.30.-) +FIG00013626 N-Acetyl-D-glucosamine ABC transport system, sugar-binding protein +FIG00013631 PlcR activating protein PapR, quorum-sensing effector +FIG00013638 ATPase component of general energizing module of ECF transporters +FIG00013643 PTS system, sorbose-specific IIB component (EC 2.7.1.69) +FIG00013663 Energy-conserving hydrogenase (ferredoxin), subunit C +FIG00013666 Hypothetical protein in cluster with Ecs transporter (in Streptococci) +FIG00013674 Secreted Endo-beta-N-acetylglucosaminidase (EndoS) +FIG00013712 Predicted N-ribosylNicotinamide CRP-like regulator +FIG00013736 Cell division protein YlmG/Ycf19 (putative), YggT family +FIG00013755 Hypothetical protein, Spy1939 homolog +FIG00013762 CO dehydrogenase/acetyl-CoA synthase subunit epsilon, CO dehydrogenase subcomplex (EC 1.2.99.2) +FIG00013782 CFA/I fimbrial chaperone +FIG00013784 CFA/I fimbrial auxiliary subunit +FIG00013811 Periplasmic thiol:disulfide interchange protein DsbA +FIG00013813 Holin-like protein 2 +FIG00013835 Membrane protease family protein BA0301 +FIG00013868 Possible pyrimidine permease in reductive pathway +FIG00013871 Stage II sporulation protein P +FIG00013878 Inner spore coat protein H +FIG00013899 FIGfam013899: ABC transporter substrate-binding protein +FIG00013923 Xylanase +FIG00013928 Cephalosporin hydroxylase +FIG00013953 Multidrug efflux pump component MtrF +FIG00013968 Firmicutes ribosomal L7Ae family protein +FIG00013983 Hyaluronate lyase precursor (EC 4.2.2.1) +FIG00013994 Short chain fatty acids transporter +FIG00014000 ATP-dependent Clp protease ATP-binding subunit ClpA +FIG00014013 Spore cortex-lytic enzyme CwlJ +FIG00014014 Acetolactate synthase small subunit (EC 2.2.1.6), predicted +FIG00014027 Stage II sporulation protein D (SpoIID) +FIG00014038 Internalin B (GW modules) +FIG00014044 Heme ABC transporter (Streptococcus), ATP-binding protein +FIG00014048 Uncharacterized protein similar to VCA0109 +FIG00014053 FIG109201: Hypothetical protein +FIG00014057 Spore coat protein Z +FIG00014062 Glucose-selective porin OprB +FIG00014070 Outer membrane usher protein HtrE +FIG00014074 Streptokinase +FIG00014079 HipA protein +FIG00014093 Biofilm operon icaABCD HTH-type negative transcriptional regulator IcaR +FIG00014097 Putative sensory transducer +FIG00014100 Monomethylamine methyltransferase corrinoid protein +FIG00014104 Encapsulating protein for a DyP-type peroxidase or ferritin-like protein oligomers +FIG00014108 Sensor histidine kinase CqsS +FIG00014110 Putative peptidoglycan bound protein (LPXTG motif) Lmo0842 homolog +FIG00014127 Peptidylproline cis-trans-isomerase (EC 5.2.1.8); Proteinase maturation protein (RopA) +FIG00014133 Predicted dye-decolorizing peroxidase (DyP), encapsulated subgroup +FIG00014136 Transcriptional regulator YkgA +FIG00014169 Mitochondrial processing peptidase-like protein (EC 3.4.24.64) +FIG00014172 Lipopolysaccharide core biosynthesis protein RfaY +FIG00014175 Uncharacterized protein ImpI/VasC +FIG00014199 Ferrous iron transport protein B +FIG00014222 Fosfomycin resistance protein FosB +FIG00014239 Diaminohydroxyphosphoribosylaminopyrimidine deaminase (EC 3.5.4.26) +FIG00014250 Transcriptional regulator LuxT +FIG00014269 Putative peptidoglycan bound protein (LPXTG motif) Lmo0320 homolog +FIG00014279 NnrU family protein, required for expression of nitric oxide and nitrite reductases (Nir and Nor) +FIG00014282 CFA/I fimbrial subunit C usher protein +FIG00014294 Biopolymer transport protein ExbD1 +FIG00014301 Phenylacetic acid degradation protein PaaY +FIG00014303 Bacteriocin-like peptide M BlpM +FIG00014305 Type VI secretion lipoprotein/VasD +FIG00014339 ADP-heptose synthase (EC 2.7.-.-) / D-glycero-beta-D-manno-heptose 7-phosphate kinase +FIG00014348 Urea ABC transporter, ATPase protein UrtE +FIG00014352 4'-phosphopantetheinyl transferase entD (EC 2.7.8.-); Holo-[acyl-carrier protein] synthase, alternative (EC 2.7.8.7) +FIG00014356 FIG014356: hypothetical protein +FIG00014368 RNA polymerase sigma factor +FIG00014387 FIG014387: Transcriptional regulator, PadR family +FIG00014444 Hydroxymethylpyrimidine ABC transporter, transmembrane component +FIG00014492 Hypothetical protein GBAA1985 associated with anthrachelin biosynthesis, unique +FIG00014502 Inner-membrane permease FptX, ferripyochelin +FIG00014516 Pyrimidine ABC transporter, substrate-binding component +FIG00014549 Pyoverdin biosynthesis protein PvdN, putative aminotransferase, class V +FIG00014556 DNA sulfur modification protein DndD +FIG00014562 Enoyl-CoA hydratase [valine degradation] (EC 4.2.1.17) +FIG00014572 TRAP transporter solute receptor, unknown substrate 6 +FIG00014574 FIG014574: hypothetical protein +FIG00014577 Spore coat protein B +FIG00014578 Heme biosynthesis protein related to NirD and NirG / Heme biosynthesis protein related to NirL and NirH +FIG00014588 FIGfam014588: Predicted regulator of CFA/I fimbriae +FIG00014596 Cobalamin biosynthesis protein CbiG +FIG00014609 Long-chain-fatty-acid--CoA ligase associated with anthrachelin biosynthesis @ Long-chain-fatty-acid--CoA ligase of siderophore biosynthesis +FIG00014612 Oligogalacturonate lyase (EC 4.2.2.6) +FIG00014618 L-fuconate dehydratase (EC 4.2.1.68) +FIG00014623 Protein G-related alpha 2 macroglobulin-binding protein (GRAB) +FIG00014625 DNA-directed RNA polymerase subunit B (EC 2.7.7.6) +FIG00014631 Legionaminic acid biosynthesis protein PtmF +FIG00014640 Sporulation kinase B homolog 2 +FIG00014648 Molybdopterin oxidoreductase (EC 1.2.7.-) +FIG00014673 Glycosyl-4,4'-diaponeurosporenoate acyltransferase precursor (EC 2.3.1.-) +FIG00014684 Putative two-domain glycosyltransferase +FIG00014689 D-allulose-6-phosphate 3-epimerase (EC 5.1.3.-) +FIG00014703 Succinylglutamic semialdehyde dehydrogenase (EC 1.2.1.71) +FIG00014718 Phenylpropionate dioxygenase and related ring-hydroxylating dioxygenases, large terminal subunit +FIG00014737 CO dehydrogenase/acetyl-CoA synthase subunit beta, acetyl-CoA synthase (EC 2.3.1.169) +FIG00014742 Arginine utilization regulatory protein RocR +FIG00014760 Dimeric dUTPase (EC 3.6.1.23) +FIG00014761 ATP-dependent DNA helicase RecS (RecQ family) +FIG00014764 Phosphonate ABC transporter phosphate-binding periplasmic component (TC 3.A.1.9.1) +FIG00014777 5-keto-2-deoxygluconokinase (EC 2.7.1.92) +FIG00014782 Transcriptional regulator RegR, rpressor of hyaluronate and KDG utilization +FIG00014801 Cation ABC transporter, periplasmic cation-binding protein, PA2407 homolog +FIG00014804 Dimethylamine methyltransferase corrinoid protein +FIG00014816 DedA family inner membrane protein YqjA +FIG00014834 Protein gp11 [Bacteriophage A118] +FIG00014838 Protein gp8 [Bacteriophage A118] +FIG00014844 Phage terminase, ATPase subunit +FIG00014848 Oxygen-regulated invasion protein OrgB +FIG00014849 Hydrolase (HAD superfamily), YqeK +FIG00014856 Flp pilus assembly protein, ATPase CpaF +FIG00014878 Lipoteichoic acid synthase LtaS Type IIIa +FIG00014887 Exopolygalacturonate lyase (EC 4.2.2.9) +FIG00014890 Spore coat protein F +FIG00014893 Sporulation kinase B homolog 1 +FIG00014896 IncF plasmid conjugative transfer DNA-nicking and unwinding protein TraI +FIG00014903 Outer membrane receptor proteins, mostly Fe transport +FIG00014907 Dipeptide transport ATP-binding protein DppD (TC 3.A.1.5.2) +FIG00014909 RopB; Rgg-like transcription regulator +FIG00014910 D-allose ABC transporter, permease component +FIG00014915 Type cbb3 cytochrome oxidase biogenesis protein CcoS, involved in heme b insertion +FIG00014930 Propanediol diffusion facilitator +FIG00014956 DNA polymerase III psi subunit (EC 2.7.7.7) +FIG00014957 Zinc metalloproteinase precursor (EC 3.4.24.29) +FIG00014982 Flp pilus assembly protein, pilin Flp +FIG00014983 Multidrug efflux transporter MdtP +FIG00014984 Dihydroneopterin aldolase (EC 4.1.2.25) / delta 1-pyrroline-5-carboxylate synthetase +FIG00014987 Nicotine adenine dinucleotide glycohydrolase (NADGH) (EC 3.2.2.5) +FIG00014990 Similar to ribosomal large subunit pseudouridine synthase D, Bacillus subtilis YjbO type +FIG00014997 phytol kinase +FIG00014998 M protein trans-acting positive regulator (Mga) +FIG00015005 Putative long tail fibre [Bacteriophage A118] +FIG00015014 Coenzyme F420-dependent oxidoreductase +FIG00015016 Late competence protein ComGD, access of DNA to ComEA, FIG038316 +FIG00015025 Hypothetical protein GBAA1986 associated with anthrachelin biosynthesis, isomerase-like TIM barrel domain +FIG00015026 ABC transporter in pyoverdin gene cluster, permease component +FIG00015036 Stage V sporulation protein whose disruption leads to the production of immature spores (SpoVK) +FIG00015049 FIG015049: hypothetical protein +FIG00015075 NPQTN cell wall anchored protein IsdC +FIG00015077 Spore germination protein GerSC +FIG00015082 Prevent host death protein, Phd antitoxin +FIG00015085 Dehydrosqualene desaturase (EC 1.14.99.-) (Diapophytoene desaturase) (4,4'-diapophytoene desaturase) +FIG00015097 Glycosyltransferase PglI (EC 2.4.1.-) +FIG00015099 Similarity with glutathionylspermidine synthase (EC 6.3.1.8), group 2 +FIG00015100 3-oxoacyl-[acyl-carrier-protein] synthase, KASIII (EC 2.3.1.180) +FIG00015108 Substrate-specific component CbrT of predicted cobalamin ECF transporter +FIG00015118 StbE replicon stabilization toxin +FIG00015139 Serine peptidase (Alpha/beta hydrolase superfamily) fused to N- terminal uncharacterized domain specific to cyanobacteria +FIG00015161 5-aminovalerate aminotransferase (EC 2.6.1.48) / Gamma-aminobutyrate:alpha-ketoglutarate aminotransferase (EC 2.6.1.19) +FIG00015180 Dihydroneopterin aldolase (EC 4.1.2.25) / 2-amino-4-hydroxy-6-hydroxymethyldihydropteridine pyrophosphokinase (EC 2.7.6.3) +FIG00015188 Gentisate 1,2-dioxygenase (EC 1.13.11.4) +FIG00015203 Virulence-associated cell-wall-anchored protein SasH (LPXTG motif); 5'-nucleotidase (EC 3.1.3.5) +FIG00015210 Molybdenum cofactor biosynthesis protein MoaC / Molybdenum cofactor biosynthesis protein MoaB +FIG00015230 Outer membrane porin protein NmpC precursor +FIG00015231 Inhibitor of pro-sigmaK processing BofA +FIG00015257 FIG015257: hypothetical protein +FIG00015284 Ribosylnicotinamide kinase (EC 2.7.1.22) +FIG00015287 FIG015287: Zinc protease +FIG00015295 Exosporium protein E +FIG00015308 Polysaccharide intercellular adhesin (PIA) biosynthesis deacetylase IcaB (EC 3.-.-.-) +FIG00015310 Coenzyme PQQ synthesis protein F +FIG00015314 Putative symporter YjcG +FIG00015316 Flp pilus assembly protein TadB +FIG00015319 Prophage baseplate assembly protein V +FIG00015325 Transcriptional (co)regulator CytR +FIG00015327 S-layer protein / N-acetylmuramoyl-L-alanine amidase (EC 3.5.1.28) +FIG00015331 Putative peptidoglycan bound protein (LPXTG motif) Lin2281 homolog +FIG00015338 D-beta-hydroxybutyrate permease +FIG00015350 Polysaccharide intercellular adhesin (PIA) biosynthesis N-glycosyltransferase IcaA (EC 2.4.-.-) +FIG00015368 response regulator in two-component regulatory system with PhoQ +FIG00015381 Transmembrane component CbrV of energizing module of predicted cobalamin ECF transporter +FIG00015389 FIG015389: hypothetical membrane associated protein +FIG00015426 iron aquisition yersiniabactin synthesis enzyme (Irp2) +FIG00015462 Putative membrane protein precursor SPs0273 +FIG00015468 Substrate-specific component PdxU of predicted pyridoxine ECF transporter +FIG00015469 BatA (Bacteroides aerotolerance operon) +FIG00015476 Stage III sporulation protein D +FIG00015482 Phycocyanobilin lyase beta subunit +FIG00015488 Phenylalanine hydroxylase transcriptional activator PhhR +FIG00015490 FIG04612: Integral membrane protein (putative) +FIG00015495 KapB, lipoprotein required for KinB pathway to sporulation +FIG00015513 Late competence protein ComGE, FIG015513 +FIG00015518 Aspartyl aminopeptidase +FIG00015519 type 1 fimbriae anchoring protein FimD +FIG00015533 Thiosulfate reductase cytochrome B subunit (membrane anchoring protein) +FIG00015554 NADH peroxidase (EC 1.11.1.1) +FIG00015564 Late competence protein ComGE, FIG015564 +FIG00015588 DedA family; putative alkaline phosphatase-like protein +FIG00015592 Putative peptidoglycan bound protein (LPXTG motif) Lmo1413 homolog +FIG00015638 Formylmethanofuran dehydrogenase subunit B (EC 1.2.99.5) +FIG00015654 Clumping factor ClfA, fibrinogen-binding protein +FIG00015661 Siderophore staphylobactin biosynthesis protein SbnG +FIG00015670 C4 aminotransferase specific for PseB product (PseC, second step of pseudaminic acid biosynthesis) +FIG00015696 Protein msa (Modulator of sarA) +FIG00015702 D-allulose-6-phosphate 3-epimerase (EC 5.1.3.-), row_id 846 +FIG00015729 LSU ribosomal protein L29p (L35e) +FIG00015740 RNA polymerase sigma factor FecI +FIG00015744 Cell division protein FtsN +FIG00015751 Siderophore staphylobactin biosynthesis protein SbnF @ Siderophore synthetase superfamily, group C +FIG00015758 Transcriptional activator ToxR +FIG00015771 Sugar-1-epimerase YihR +FIG00015777 Dihydroaeruginoate synthetase PchE, non-ribosomal peptide synthetase modules +FIG00015785 Alpha-related fimbriae usher protein +FIG00015791 Biotin carboxylase of acetyl-CoA carboxylase (EC 6.3.4.14) / Biotin carboxyl carrier protein of acetyl-CoA carboxylase; Propionyl-CoA carboxylase alpha chain (EC 6.4.1.3) +FIG00015799 Hypothetical SAV0808 homolog, near pathogenicity islands SaPI att-site +FIG00015833 Oligosaccharide repeat unit polymerase Wzy +FIG00015834 Elastin binding protein EbpS +FIG00015843 Capsular polysaccharide synthesis enzyme Cap8P +FIG00015858 Streptococcal pyrogenic exotoxin G (SpeG) +FIG00015880 Polysaccharide intercellular adhesin (PIA) biosynthesis protein IcaC +FIG00015881 Siderophore staphylobactin biosynthesis protein SbnE @ Siderophore synthetase superfamily, group A +FIG00015882 4-hydroxybenzoate transporter +FIG00015890 Menaquinone via futalosine step 3 +FIG00015893 Type III secretion host injection and negative regulator protein (YopD) +FIG00015898 Alpha-related fimbriae chaperone 2 +FIG00015910 Methionine aminotransferase, PLP-dependent +FIG00015912 HipB protein +FIG00015923 ThiJ/PfpI family protein +FIG00015925 Menaquinone via futalosine step 4 +FIG00015932 Hypothetical protein, similarity with von Willebrand factor-binding VWbp +FIG00015936 Predicted L-lactate dehydrogenase, Fe-S oxidoreductase subunit YkgE / Predicted L-lactate dehydrogenase, Iron-sulfur cluster-binding subunit YkgF +FIG00015941 Ethanolamine ammonia-lyase light chain (EC 4.3.1.7) +FIG00015996 Lipopolysaccharide 1,6-galactosyltransferase (EC 2.4.1.-) +FIG00016004 Hypothetical protein in cluster with penicillin-binding protein PBP1, Staphylococcal type +FIG00016015 Protein gp45 [Bacteriophage A118] +FIG00016021 Putative EsaC protein analog (Listeria type 3) +FIG00016023 YqeJ protein +FIG00016028 Putative secretion system component EssB/YukC +FIG00016032 Ni,Fe-hydrogenase III large subunit +FIG00016047 Hypothetical protein FIG016047 +FIG00016055 Transcriptional regulator GabR of GABA utilization (GntR family with aminotransferase-like domain) +FIG00016061 L-lactate permease +FIG00016067 Flp pilus assembly protein TadD, contains TPR repeat +FIG00016077 LysR-family transcriptional regulator STM0764 +FIG00016092 Serine endopeptidase ScpC (EC 3.4.21.-) +FIG00016098 Gene Transfer Agent (GTA) ORFG08 +FIG00016103 Staphylocoagulase +FIG00016110 Xanthine/uracil/thiamine/ascorbate permease family protein +FIG00016119 Gene SCO4494, often clustered with other genes in menaquinone via futalosine pathway +FIG00016132 putative esterase +FIG00016137 PTS system, N-acetylglucosamine-specific IIA component / PTS system, N-acetylglucosamine-specific IIB component (EC 2.7.1.69) / PTS system, N-acetylglucosamine-specific IIC component +FIG00016145 Arginine decarboxylase (EC 4.1.1.19) +FIG00016153 Putative sugar transporter +FIG00016157 FIG016157: Similar to nicotianamine synthase +FIG00016185 Translation elongation factor G paralog +FIG00016187 Arginine utilization protein RocB +FIG00016203 7,8-didemethyl-8-hydroxy-5-deazariboflavin synthase subunit 1 +FIG00016213 Indolepyruvate ferredoxin oxidoreductase, alpha and beta subunits +FIG00016235 Two-component response regulator VncR +FIG00016239 Siderophore staphylobactin biosynthesis protein SbnA +FIG00016265 Carboxynorspermidine dehydrogenase, putative (EC 1.1.1.-) +FIG00016281 Biotin carboxyl carrier protein of oxaloacetate decarboxylase; Biotin carboxyl carrier protein +FIG00016286 Ribosyl nicotinamide transporter, PnuC-like +FIG00016288 Heme transporter IsdDEF, membrane component IsdD +FIG00016301 Streptodornase B; Mitogenic factor 1 +FIG00016303 Hyaluronan synthase (EC 2.4.1.212) +FIG00016317 FIG016317: Probable conserved transmembrane protein +FIG00016324 Protein gp9 [Bacteriophage A118] +FIG00016334 Formiminoglutamic iminohydrolase (EC 3.5.3.13) +FIG00016353 CcdB toxin protein +FIG00016370 Alpha-related fimbriae chaperone 1 +FIG00016372 Phage major capsid protein +FIG00016374 Staphylococcal accessory regulator A (SarA) +FIG00016382 Spore germination protein GerKC +FIG00016391 hypothetical oxidoreductase related to N-acetylglucosamine utilization +FIG00016394 Glutamyl endopeptidase precursor (EC 3.4.21.19), serine proteinase SspA +FIG00016412 Prokaryotic ubiquitin-like protein Pup +FIG00016435 Coenzyme PQQ synthesis protein A +FIG00016445 ABC efflux pump, fused inner membrane and ATPase subunits in pyochelin gene cluster +FIG00016450 photosystem I P700 chlorophyll a apoprotein subunit Ib (PsaB) +FIG00016461 Siderophore staphylobactin biosynthesis protein SbnI +FIG00016463 Holin [Bacteriophage A118] +FIG00016466 2-succinyl-6-hydroxy-2,4-cyclohexadiene-1-carboxylate synthase (EC 4.2.99.20) +FIG00016473 FIG016473: Diaminopimelate epimerase homolog +FIG00016482 Streptolysin S precursor (SagA) +FIG00016496 Type III secretion outermembrane pore forming protein (YscC,MxiD,HrcC, InvG) +FIG00016502 FIG016502: iron uptake protein +FIG00016506 Siderophore staphylobactin biosynthesis protein SbnD +FIG00016509 Transcriptional regulator MgrA (Regulator of autolytic activity) +FIG00016514 Type I restriction-modification system, restriction subunit R (EC 3.1.21.3) +FIG00016528 Nickel transport ATP-binding protein nikD2 (TC 3.A.1.5.3) +FIG00016546 Probable transcription regulator Mig-14 +FIG00016547 Protocatechuate 4,5-dioxygenase beta chain (EC 1.13.11.8) +FIG00016555 O-antigen flippase Wzx +FIG00016566 Arylsulfatase (EC 3.1.6.1) +FIG00016571 Transcriptional regulator of maltose utilization, LacI family +FIG00016592 Polysaccharide intercellular adhesin (PIA) biosynthesis protein IcaD +FIG00016600 Mhp operon transcriptional activator +FIG00016640 Mga-associated protein +FIG00016648 Uridine phosphorylase (EC 2.4.2.3) +FIG00016650 Siderophore staphylobactin ABC transporter, permease protein SirC +FIG00016663 TRAP-type C4-dicarboxylate transport system, periplasmic component +FIG00016673 S-layer protein Sap +FIG00016683 Glycyl-glycine endopeptidase LytM precursor (EC 3.4.24.75) +FIG00016684 Vitamin B12 ABC transporter, B12-binding component BtuF +FIG00016685 Transmembrane component MtsC of energizing module of methionine-regulated ECF transporter +FIG00016690 Glutarate-semialdehyde dehydrogenase (EC 1.2.1.20); Succinate-semialdehyde dehydrogenase [NADP+] (EC 1.2.1.79) +FIG00016731 Methyl coenzyme M reductase operon protein D +FIG00016744 RTX toxin transporter, determinant D +FIG00016745 Type II secretory pathway, ATPase PulE/Tfp pilus assembly pathway, ATPase PilB +FIG00016753 Similar to TadZ/CpaE, associated with Flp pilus assembly +FIG00016768 TRAP-type uncharacterized transport system, fused permease component +FIG00016780 NADH:ubiquinone oxidoreductase 17.2 kD subunit +FIG00016792 Actin-assembly inducing protein ActA precursor +FIG00016799 Periplasmic mercury(+2) binding protein +FIG00016818 Putative polyribitolphosphotransferase +FIG00016823 Extracellular ECM and plasma binding protein Emp +FIG00016824 hypothetical fig|282458.1.peg.572 homolog +FIG00016836 Transcription termination protein NusB +FIG00016846 N-acetyl-L,L-diaminopimelate deacetylase (EC 3.5.1.47) +FIG00016867 Predicted cobalt transporter CbtA +FIG00016887 Fimbrial adhesin +FIG00016888 rhamnogalacturonan acetylesterase +FIG00016896 Haemin uptake system ATP-binding protein +FIG00016900 Membrane protease family protein HP0248 +FIG00016912 Propanediol utilization protein PduV +FIG00016917 Putative antibiotic transport-associated protein +FIG00016920 Pimeloyl-CoA synthase (EC 6.2.1.14) +FIG00016929 HoxN/HupN/NixA family nickel/cobalt transporter +FIG00016939 Integrase, superantigen-encoding pathogenicity islands SaPI +FIG00016952 Predicted cell-wall-anchored protein SasD (LPXAG motif) +FIG00016973 hypothetical fig|282458.1.peg.573 homolog +FIG00016984 FIG056333: sensor +FIG00016999 Probable proline and glycine rich transmembrane protein gene in bax +FIG00017000 Programmed cell death toxin MazF +FIG00017013 2,3-diketo-5-methylthiopentyl-1-phosphate enolase-phosphatase (EC 3.1.3.77) +FIG00017015 Ammonia monooxygenase +FIG00017051 General secretion pathway protein I +FIG00017059 Lipid A export ATP-binding/permease protein MsbA +FIG00017060 Probable NADH-dependent flavin oxidoreductase in cluster with COG2110 +FIG00017079 Quorum-sensing regulator of virulence HapR +FIG00017106 PhnB protein; putative DNA binding 3-demethylubiquinone-9 3-methyltransferase domain protein +FIG00017107 TetR family regulatory protein +FIG00017108 FIG017108: hypothetical protein +FIG00017109 Predicted cell-wall-anchored protein SasC (LPXTG motif) +FIG00017120 Major transcriptional regulator of spore coat formation GerE +FIG00017147 iron aquisition regulator (YbtA,AraC-like,required for transcription of FyuA/psn,Irp2) +FIG00017159 4,4'-diaponeurosporenoate glycosyltransferase (EC 2.4.1.-) +FIG00017160 Methylmalonyl-CoA decarboxylase, alpha chain (EC 4.1.1.41) +FIG00017179 Putative permease often clustered with de novo purine synthesis +FIG00017181 Putative peptidoglycan bound protein (LPXTG motif) Lmo1666 homolog +FIG00017186 Phosphoenolpyruvate-dihydroxyacetone phosphotransferase (EC 2.7.1.121), dihydroxyacetone binding subunit DhaK +FIG00017190 Putative metal chaperone, involved in Zn homeostasis, GTPase of COG0523 family +FIG00017214 Putative lipoprotein required for motility +FIG00017225 Clumping factor ClfB, fibrinogen binding protein +FIG00017234 Hypothetical protein, similarity with fibrinogen-binding protein Efb +FIG00017247 Non-specific DNA-binding protein Dps / Iron-binding ferritin-like antioxidant protein / Ferroxidase (EC 1.16.3.1) +FIG00017262 Oxygen-regulated invasion protein OrgA +FIG00017264 Putative formate dehydrogenase, cytochrome B subunit (EC 1.2.1.2) +FIG00017265 Accessory secretory protein Asp3 +FIG00017269 Acetolactate synthase small subunit (EC 2.2.1.6), Xanthomonadales type +FIG00017282 PTS system permease (IIAMan), nitrogen regulatory IIA protein +FIG00017283 N5-methyltetrahydromethanopterin:coenzyme M methyltransferase subunit H (EC 2.1.1.86) +FIG00017289 Lipid A 3-O-deacylase +FIG00017303 PH adaptation potassium efflux system protein B1; sodium- potassium/hydrogen antiporter subunit B1 +FIG00017304 RTX toxin activating lysine-acyltransferase (EC 2.3.1.-) +FIG00017306 Chemotaxis response regulator protein-glutamate methylesterase CheB (EC 3.1.1.61) +FIG00017309 Alpha-fimbriae tip adhesin +FIG00017310 Conserved NnrU/NnuR ortholog membrane enzyme +FIG00017311 Capsular polysaccharide export system periplasmic protein KpsD +FIG00017321 Internalin-like protein (LPXTG motif) Lmo2026 homolog +FIG00017343 Flagellar M-ring protein FliF +FIG00017354 S-layer protein EA1 +FIG00017356 Phage portal protein; Phage capsid and scaffold +FIG00017358 Exosporium protein G +FIG00017362 Phosphoglycerate transporter protein PgtP +FIG00017367 Protein gp14 [Bacteriophage A118] +FIG00017378 IncF plasmid conjugative transfer pilus assembly protein TraV +FIG00017385 Cytochrome b6-f complex subunit, apocytochrome f +FIG00017394 Bacteriophage protein GP46 +FIG00017412 Glycogen debranching enzyme (EC 3.2.1.-) / Pullulanase (EC 3.2.1.41) +FIG00017426 Possible GPH family transporter (TC 2.A.2) for arabinosides +FIG00017431 Serine phosphatase RsbU, regulator of sigma subunit +FIG00017434 NADH-reducing hydrogenase maturation factor +FIG00017444 Ribosome-associated heat shock protein implicated in the recycling of the 50S subunit +FIG00017454 Indolepyruvate oxidoreductase subunit IorA (EC 1.2.7.8) +FIG00017458 Sensor histidine kinase VncS +FIG00017465 3'-to-5' oligoribonuclease B, Bacillus type +FIG00017466 Anthranilate synthase, amidotransferase component (EC 4.1.3.27) / Anthranilate phosphoribosyltransferase (EC 2.4.2.18) +FIG00017473 Protein gp13 [Bacteriophage A118] +FIG00017495 Nudix-related transcriptional regulator NrtR +FIG00017500 Cytochrome b559 alpha chain (PsbE) +FIG00017518 Alpha-L-arabinofuranosidase II precursor (EC 3.2.1.55) +FIG00017536 Heme ABC transporter (Streptococcus), heme and hemoglobin-binding protein SiaA/HtsA +FIG00017543 Phosphoglycerate transport system transcriptional regulatory protein PgtA +FIG00017553 Methyltransferase, anthrose biosynthesis +FIG00017555 Two-component response regulator CreB +FIG00017559 Phosphoglycerate transport regulatory protein PgtC +FIG00017562 Transcriptional regulator of D-allose utilization, RpiR family +FIG00017565 Antitoxin YafN +FIG00017570 Immunoglobulin G-endopeptidase (IdeS) / Mac/ Secreted immunoglobulin binding protein (Sib38) +FIG00017579 Putative peptidoglycan bound protein (LPXTG motif) Lmo0463 homolog +FIG00017582 HNH endonuclease family protein +FIG00017596 Putative LysR-like transcriptional regulator +FIG00017607 ATP synthase F0 sector subunit c +FIG00017608 FIG017608: hypothetical membrane protein, specific for cyanobacteria +FIG00017615 Universal stress protein family +FIG00017616 Antitoxin YgiT +FIG00017618 Predicted cell-wall-anchored protein SasA (LPXTG motif) +FIG00017636 Fructose-1,6-bisphosphatase, GlpX type (EC 3.1.3.11) / Sedoheptulose-1,7-bisphosphatase (EC 3.1.3.37) +FIG00017643 Putative insecticidal toxin complex +FIG00017647 Adhesin of unknown specificity SdrE, similar to bone sialoprotein-binding protein Bbp +FIG00017658 Phage-associated cell wall hydrolase +FIG00017660 FmhC protein of FemAB family +FIG00017689 iron aquisition outermembrane yersiniabactin receptor (FyuA,Psn,pesticin receptor) +FIG00017761 Biopolymer transport protein ExbD/TolR +FIG00017771 Protein gp44 [Bacteriophage A118] +FIG00017774 Late competence protein ComGF, access of DNA to ComEA, FIG017774 +FIG00017786 Hypothetical protein, PVL orf50 homolog [SA bacteriophages 11, Mu50B] +FIG00017787 MFS family multidrug efflux protein, similarity to bicyclomycin resistance protein Bcr +FIG00017796 Transcriptional regulator of D-allose utilization, LacI family +FIG00017797 Gene Transfer Agent (GTA) ORFG06 +FIG00017809 OpcA, an allosteric effector of glucose-6-phosphate dehydrogenase, cyanobacterial +FIG00017820 Haemin uptake system periplasmic haemin-binding protein +FIG00017823 FIG017823: ATPase, MoxR family +FIG00017860 Phage T7 exclusion protein +FIG00017861 FIG017861: hypothetical protein +FIG00017877 FIG143263: Glycosyl transferase / Lysophospholipid acyltransferase +FIG00017886 Hydrogen cyanide synthase HcnC / Opine oxidase subunit B +FIG00017899 D-allose kinase (EC 2.7.1.55) +FIG00017901 CcdA protein (antitoxin to CcdB) +FIG00017916 Protein PE35, involved in regulation of esxAB expression in Type VII secretion system ESX-1 +FIG00017926 Apo-citrate lyase phosphoribosyl-dephospho-CoA transferase (EC 2.7.7.61) +FIG00017942 Various polyols ABC transporter, ATP-binding component +FIG00017945 Cytochrome b6-f complex subunit VII (PetM) +FIG00017949 Phage terminase, large subunit +FIG00017958 Cytochrome b559 beta chain (PsbF) +FIG00017962 VapC toxin protein +FIG00017972 Internalin-like protein (LPXTG motif) Lmo0331 homolog +FIG00017973 Heat shock protein HtpX / FIG017973: domain of unknown function +FIG00017974 Protein YcgL +FIG00017986 UDP-glucose:(glucosyl)lipopolysaccharide alpha-1,3-glucosyltransferase WaaO (EC 2.4.1.-) +FIG00017991 ABC-type Na+ efflux pump, permease component +FIG00018005 Circadian oscillation regulator KaiB +FIG00018031 Putative oxidoreductase ferredoxin-type protein, clusters with CPO +FIG00018035 Duplicated ATPase component MtsB of energizing module of methionine-regulated ECF transporter +FIG00018039 Menaquinone via futalosine step 1 +FIG00018045 Holin associated membrane protein 1 +FIG00018072 Glycyl-tRNA synthetase alpha chain (EC 6.1.1.14) / Glycyl-tRNA synthetase beta chain (EC 6.1.1.14) +FIG00018079 Pyochelin biosynthetic protein PchC, predicted thioesterase +FIG00018084 F420-dependent N(5),N(10)-methylenetetrahydromethanopterin reductase (EC 1.5.99.11) +FIG00018087 Non functional Dihydropteroate synthase 2 +FIG00018129 Predicted secretion system X pseudopilin PulG-like +FIG00018130 Phage head completion-stabilization protein +FIG00018141 Cyclohexadienyl dehydrogenase (EC 1.3.1.12)(EC 1.3.1.43) +FIG00018154 Small acid-soluble spore protein, alpha/beta family, SASP_2 +FIG00018176 Phospholipid-lipopolysaccharide ABC transporter +FIG00018182 Transcriptional activator MetR +FIG00018201 HflC protein +FIG00018209 Protein A, von Willebrand factor binding protein Spa +FIG00018218 Molybdopterin biosynthesis protein MoeA +FIG00018224 Substrate-specific component MtsA of methionine-regulated ECF transporter +FIG00018226 FIG018226: DNA replication protein, phage-associated +FIG00018227 Sensory histidine kinase AtoS +FIG00018229 FIG018229: hypothetical protein +FIG00018250 Signal-transduction regulatory protein FlgR +FIG00018257 TRAP transporter solute receptor, unknown substrate 1 +FIG00018271 10 kDa culture filtrate antigen CFP-10 (EsxB) +FIG00018296 Repetitive hypothetical protein near ESAT cluster, SA0282 homolog +FIG00018327 D-allose ABC transporter, substrate-binding component +FIG00018328 Glycosyl transferase, group 1 +FIG00018330 Paraquat-inducible protein A +FIG00018333 IgG-binding protein SBI +FIG00018338 Phage tail completion protein +FIG00018348 RNA polymerase sigma-H factor AlgT +FIG00018353 Pyrimidine ABC transporter, ATP-binding protein +FIG00018369 Cell division protein FtsH (EC 3.4.24.-) +FIG00018382 Protein gp23 [Bacteriophage A118] +FIG00018388 Putative glycosyl hydrolase of unknown function (DUF1680) +FIG00018392 Exopolysaccharide biosynthesis transcriptional activator EpsA +FIG00018396 Thioredoxin reductase (EC 1.8.1.9) +FIG00018398 COG2363 +FIG00018400 Alpha-fimbriae usher protein +FIG00018405 Molybdenum cofactor biosynthesis protein MoaE +FIG00018409 WhiB-like transcription regulator +FIG00018412 Glutathione S-transferase domain protein (class beta) +FIG00018416 Putative short tail fibre [Bacteriophage A118] +FIG00018430 Transcriptional regulator PchR +FIG00018431 Putative oxidoreductase in 4-hydroxyproline catabolic gene cluster +FIG00018436 Replicative DNA helicase (EC 3.6.1.-) @ intein-containing +FIG00018444 EsaC protein within ESAT-6 gene cluster (S.aureus type) +FIG00018450 required for Yop secretion +FIG00018457 Ribose ABC transport system, ATP-binding protein RbsA (TC 3.A.1.2.1) +FIG00018463 Internalin-like protein (LPXTG motif) Lmo0409 homolog +FIG00018470 P-hydroxylaminobenzoate lyase +FIG00018484 Sulfate adenylyltransferase (EC 2.7.7.4) +FIG00018500 DNA-directed RNA polymerase beta subunit (EC 2.7.7.6) / DNA-directed RNA polymerase beta' subunit (EC 2.7.7.6) +FIG00018527 CRISPR-associated protein, Cas5d family +FIG00018530 Xylose ABC transporter, periplasmic xylose-binding protein XylF +FIG00018536 Electron transport complex protein RnfC +FIG00018543 Phage-encoded chromosome degrading nuclease YokF +FIG00018544 SAV0291 homolog within ESAT-6 gene cluster +FIG00018559 ABC-type Na+ transport system, ATPase component +FIG00018561 Phosphate transport system permease protein PstC (TC 3.A.1.7.1) +FIG00018579 putative carboxysome peptide A +FIG00018585 Novel N-acetylmannosamine kinase +FIG00018587 Motility integral membrane protein +FIG00018588 Siderophore staphylobactin ABC transporter, substrate-binding protein SirA +FIG00018590 3-deoxy-D-manno-octulosonic acid kinase (EC 2.7.1.-) +FIG00018591 Octaheme tetrathionate reductase +FIG00018606 Methanophenazine hydrogenase small subunit precursor (EC 1.12.98.3) +FIG00018615 Acetoacetate metabolism regulatory protein AtoC +FIG00018620 Carbamoyltransferase in large core OS assembly cluster +FIG00018621 Cysteine dioxygenase (EC 1.13.11.20) +FIG00018627 Taurine transport ATP-binding protein TauB +FIG00018635 Extracellular adherence protein of broad specificity Eap/Map +FIG00018644 Sarcosine oxidase delta subunit (EC 1.5.3.1) +FIG00018664 Holin-like protein 1 +FIG00018671 SpoVS-related protein, type 1 +FIG00018692 Penicillin-binding protein PBP2a, methicillin resistance determinant MecA, transpeptidase +FIG00018699 Long-chain-fatty-acid--CoA ligase (EC 6.2.1.3) +FIG00018700 FIG018700: hypothetical protein +FIG00018707 Putative dipeptidase, pyoverdin biosynthesis PvdM +FIG00018712 hypothetical protein Rv3802c +FIG00018716 Type III secretion bridge between inner and outermembrane lipoprotein (YscJ,HrcJ,EscJ, PscJ) +FIG00018726 Cyanobacteria-specific RpoD-like sigma factor, type-13 +FIG00018727 Iron-sulfur cluster assembly ATPase protein SufC +FIG00018732 Glutamate transport permease protein +FIG00018736 Accessory secretory protein Asp1 +FIG00018741 ATP-dependent Clp protease adaptor protein ClpS +FIG00018813 Internalin-like protein (LPXTG motif) Lmo1289 homolog +FIG00018816 ATP-dependent RNA helicase VCA0061 +FIG00018823 OpcA, an allosteric effector of glucose-6-phosphate dehydrogenase, actinobacterial +FIG00018846 Cytochrome oxidase biogenesis protein Surf1, facilitates heme A insertion +FIG00018865 Oligopeptide transport ATP-binding protein OppF (TC 3.A.1.5.1) +FIG00018866 COG1565: Uncharacterized conserved protein +FIG00018888 Glycosyltransferase IroB +FIG00018892 Fibronectin binding protein FnbB +FIG00018896 Cell surface receptor IsdB for hemoglobin and hemoglobin-haptoglobin complexes +FIG00018897 Sulfate transport system permease protein CysT +FIG00018902 Tricarboxylate transport transcriptional regulator TctD +FIG00018909 TldD family protein, Actinobacterial subgroup +FIG00018913 L-arabonate dehydratase (EC 4.2.1.25) +FIG00018915 Late competence protein ComGE, FIG018915 +FIG00018927 Probable transcriptional regulator of trehalose utilization, LuxR family +FIG00018934 Transcriptional regulator SarT (Staphylococcal accessory regulator T) +FIG00018939 Alpha-fimbriae major subunit +FIG00018955 Uracil-DNA glycosylase, family 5 +FIG00018965 Enoyl coenzyme A hydratase IgrE +FIG00018966 Signal transduction protein CetA, mediates an energy taxis response +FIG00018981 Cell surface receptor IsdH for hemoglobin-haptoglobin complexes +FIG00018996 Transcriptional regulator of beta-glucosides utilization, LacI family +FIG00019045 FIG019045: long form Mg-chelase associated protein with vWA domain +FIG00019052 Protein YjgL, putative CCAAT-box DNA binding protein subunit B +FIG00019079 Programmed cell death antitoxin ChpS +FIG00019082 Transcriptional regulator GbuR +FIG00019084 N5-methyltetrahydromethanopterin:coenzyme M methyltransferase subunit C (EC 2.1.1.86) +FIG00019092 Heme ABC type transporter HtsABC, heme-binding protein +FIG00019106 5-keto-2-deoxy-D-gluconate-6 phosphate aldolase [form 2] (EC 4.1.2.29) +FIG00019123 Terminase large subunit [Bacteriophage A118] +FIG00019142 Hypothetical domain / C-terminal domain of CinA type S +FIG00019146 Sporulation regulatory protein WhiB +FIG00019156 Competence-specific sigma factor ComX +FIG00019166 Capsular polysaccharide synthesis enzyme Cap5G; UDP-N-acetylglucosamine 2-epimerase (EC 5.1.3.14) +FIG00019175 FIG019175: putative membrane protein +FIG00019192 Outer membrane protein Imp, required for envelope biogenesis / Organic solvent tolerance protein precursor +FIG00019210 ABC transporter protein IroC +FIG00019212 Cobalt-precorrin-6x reductase (EC 1.3.1.54) +FIG00019213 4-hydroxy-3-methylbut-2-enyl diphosphate reductase (EC 1.17.1.2) / SSU ribosomal protein S1p +FIG00019216 FKBP-type peptidyl-prolyl cis-trans isomerase SlpA (EC 5.2.1.8) +FIG00019240 Chemotaxis response - phosphatase CheZ +FIG00019251 DNA primase (EC 2.7.7.-) +FIG00019256 Malonate utilization transcriptional regulator +FIG00019269 Phenylacetate-CoA oxygenase/reductase, PaaK subunit +FIG00019273 Phage major tail shaft protein +FIG00019275 Transcriptional repressor of CmeABC operon, CmeR +FIG00019278 FIG019278: hypothetical protein +FIG00019300 putative carboxysome peptide B +FIG00019313 Transmembrane regulatory protein ToxS +FIG00019322 Energy-conserving hydrogenase (ferredoxin), subunit B +FIG00019327 FIG019327: membrane domain / Dihydroneopterin triphosphate pyrophosphohydolase, putative, Actinobacterial type, NudB-like +FIG00019367 GCN5-related N-acetyltransferase, FIGfam019367 +FIG00019368 Magnesium chelatase, subunit ChlI (EC 6.6.1.1) +FIG00019370 Alpha-fimbriae chaperone protein +FIG00019387 UDP-6-deoxy-AltdiNAc hydrolase (PseG, third step of pseudaminic acid biosynthesis) +FIG00019404 PH adaptation potassium efflux system protein D 1 +FIG00019415 Putative activity regulator of membrane protease YbbK +FIG00019420 IncF plasmid conjugative transfer pilus assembly protein TraK +FIG00019439 Internalin-like protein (LPXTG motif) Lin0372 homolog +FIG00019454 NrfD protein +FIG00019456 Xylose isomerase (EC 5.3.1.5) +FIG00019468 Toxin YafO +FIG00019478 Pyruvate oxidase (EC 1.2.3.3) +FIG00019487 Sporulation-associated protease N-terminal domain protein +FIG00019497 Beta-ureidopropionase (EC 3.5.1.6) +FIG00019508 Phage major tail protein +FIG00019562 Glutamyl endopeptidase precursor (EC 3.4.21.19), blaSE +FIG00019600 4-hydroxy-tetrahydrodipicolinate synthase (EC 4.3.3.7) +FIG00019601 Peptide methionine sulfoxide reductase MsrB (EC 1.8.4.12) / Peptide methionine sulfoxide reductase MsrA (EC 1.8.4.11) +FIG00019615 IncF plasmid conjugative transfer protein TraR +FIG00019618 Aerobic cobaltochelatase CobT subunit (EC 6.6.1.2) +FIG00019622 Capsular polysaccharide biosynthesis protein WcbF +FIG00019652 Segregation and condensation protein A +FIG00019660 Tellurite resistance protein TrgB / ADP-ribose pyrophosphatase (EC 3.6.1.13) +FIG00019719 Haemin uptake system permease protein +FIG00019733 FIG019733: possible DNA-binding protein +FIG00019737 Phosphate-specific outer membrane porin OprP ; Pyrophosphate-specific outer membrane porin OprO +FIG00019810 Internalin-like protein Lin2537 homolog +FIG00019815 Putative iron-uptake ABC transport system ATP-binding protein +FIG00019818 Cyanobacteria-specific RpoD-like sigma factor, type-3 @ Group 2 RNA polymerase sigma factor +FIG00019844 Streptococcal mitogenic exotoxin Z (SmeZ) +FIG00019854 Secreted protein Hcp +FIG00019868 Maltose/maltodextrin ABC transporter, permease protein MalF +FIG00019870 Methylmalonyl-CoA epimerase (EC 5.1.99.1); Ethylmalonyl-CoA epimerase +FIG00019881 Cell surface protein Shp, transfers heme from hemoglobin to apo-SiaA/HtsA +FIG00019883 pyridoxal phosphate-dependent deaminase, putative +FIG00019890 Predicted amino-acid acetyltransferase (EC 2.3.1.1) complementing ArgA function in Arginine Biosynthesis pathway +FIG00019894 Integrase [Bacteriophage A118] +FIG00019896 HtrA protease/chaperone protein / Serine protease (Protease DO) (EC 3.4.21.-) +FIG00019907 Thiamin-phosphate pyrophosphorylase-like protein +FIG00019944 Phage capsid scaffolding protein +FIG00019954 Protein phosphatase ImpM +FIG00019956 N-formylglutamate deformylase (EC 3.5.1.68) [alternative form] +FIG00019965 Streptococcal extracellular nuclease 2; Mitogenic factor 2 +FIG00019980 Dihydropyrimidine dehydrogenase [NADP+] (EC 1.3.1.2) +FIG00019989 Ammonium transporter family +FIG00019991 WhiB-type transcription regulator +FIG00019993 FIG019993: putative exported protein +FIG00019996 LysR family transcriptional regulator near succinyl-CoA:3-ketoacid-coenzyme A transferase +FIG00020032 Putative ABC-type amino-acid transporter permease protein +FIG00020038 Programmed cell death toxin ChpB +FIG00020040 Predicted nucleoside ABC transporter, permease 1 component +FIG00020041 Molybdenum transport system protein ModD +FIG00020042 FIG020042: hypothetical protein +FIG00020049 Nikel transport family protein NikM +FIG00020065 Two-component system response regulator RacR +FIG00020070 DNA-binding protein HU-alpha +FIG00020072 DUF1794 +FIG00020094 Hypothetical protein, Lmo2305 homolog [Bacteriophage A118] +FIG00020116 Xanthan biosynthesis glycosyltransferase GumD +FIG00020123 Phenylacetic acid degradation operon negative regulatory protein PaaX +FIG00020136 Two-component system histidine kinase DccS +FIG00020169 Arginine N-succinyltransferase (EC 2.3.1.109) +FIG00020185 Branched-chain amino acid transport ATP-binding protein LivG (TC 3.A.1.4.1) +FIG00020188 Hypothetical protein, Lmo2306 homolog [Bacteriophage A118] +FIG00020189 TldE/PmbA family protein, Actinobacterial subgroup +FIG00020204 Alpha-glucosides-binding periplasmic protein AglE precursor +FIG00020218 Fused spore maturation proteins A and B +FIG00020267 Minor fimbrial subunit StfG +FIG00020286 Streptococcal pyrogenic exotoxin C (SpeC); Toximoron (Superantigen) +FIG00020289 Transketolase (EC 2.2.1.1) +FIG00020300 Pyrimidine ABC transporter, transmembrane component 2 +FIG00020306 ABC-type hemin transport system, ATPase component +FIG00020309 Extracellular ribonuclease Bsn +FIG00020313 FIG020313: hypothetical protein +FIG00020314 Uncharacterized protein Rv0487/MT0505 clustered with mycothiol biosynthesis gene +FIG00020323 FIGfam020323 +FIG00020327 Transcriptional activator NhaR +FIG00020335 Adenosine kinase (EC 2.7.1.20) +FIG00020337 CO dehydrogenase/acetyl-CoA synthase, acetyl-CoA synthase subunit (EC 2.3.1.169) +FIG00020360 Phosphoglycerate transport system sensor protein PgtB (EC 2.7.3.-) +FIG00020363 ABC-type tungstate transport system, periplasmic binding protein +FIG00020364 Phage tail tube protein +FIG00020370 Phage tape measure +FIG00020371 Outer membrane stress sensor protease DegS +FIG00020374 FIG020374: hypothetical protein +FIG00020381 Phage terminase, endonuclease subunit +FIG00020387 Transcriptional regulator SarU (Staphylococcal accessory regulator U) +FIG00020407 Peptide transport system ATP-binding protein SapF +FIG00020473 Putative ESAT-secreted protein, BA2187 homolog +FIG00020481 FIG071646: Sugar transferase +FIG00020500 Flagellin C +FIG00020533 Sucrose permease, major facilitator superfamily +FIG00020539 Signal transduction protein CetB, mediates an energy taxis response +FIG00020568 FIG020568: hypothetical protein +FIG00020572 Transcriptional factor in putative operon for degradation of branched-chain alkanes, nitroalkanes and may be also cyclic ketones, alkenoic acids +FIG00020576 Predicted nucleoside ABC transporter, ATP-binding component +FIG00020577 Cell surface protein IsdA1 +FIG00020579 Predicted 4-hydroxyproline dipeptidase +FIG00020606 IncI1 plasmid conjugative transfer ATPase PilQ +FIG00020613 Inosine-5'-monophosphate dehydrogenase (EC 1.1.1.205) +FIG00020623 Kynurenine formamidase (EC 3.5.1.9) +FIG00020626 Leucine dehydrogenase (EC 1.4.1.9) +FIG00020643 Cell wall surface anchor family protein, FPXTG motif +FIG00020646 IncF plasmid conjugative transfer protein TrbB +FIG00020647 Bis(5'-nucleosyl)-tetraphosphatase, symmetrical (EC 3.6.1.41) +FIG00020663 High-affinity branched-chain amino acid transport system permease protein LivH (TC 3.A.1.4.1) / Branched-chain amino acid transport system permease protein LivM (TC 3.A.1.4.1) +FIG00020711 putative cell division protein [Pyrobaculum aerophilum]; COG1537: Predicted RNA-binding proteins +FIG00020736 D-glucarate permease +FIG00020740 N5-methyltetrahydromethanopterin:coenzyme M methyltransferase subunit D (EC 2.1.1.86) +FIG00020766 Oligosaccharyltransferase PglB (EC 2.4.1.119) +FIG00020772 Circadian input kinase A +FIG00020799 iron aquisition yersiniabactin synthesis enzyme (Irp3) +FIG00020817 TesB-like acyl-CoA thioesterase 3 +FIG00020837 Quinone-reactive Ni/Fe-hydrogenase large chain (EC 1.12.5.1) +FIG00020847 Outer membrane protein OprN +FIG00020859 IncF plasmid conjugative transfer pilus assembly protein TraC +FIG00020863 Streptodornase D +FIG00020882 Type III secretion HpaB protein +FIG00020897 Acetylornithine deacetylase (EC 3.5.1.16) +FIG00020931 Integron integrase IntI4 +FIG00020934 Monodechloroaminopyrrolnitrin-3-halogenase PrnC +FIG00020942 Formaldehyde activating enzyme / D-arabino-3-hexulose 6-phosphate formaldehyde lyase +FIG00020957 Sulfur oxidation protein SoxZ +FIG00020962 NTD biosynthesis operon regulator NtdR +FIG00020995 Tryptophan halogenase PrnA +FIG00020998 N-Acetyltransferase PseH involved in the biosynthesis of pseudaminic acid +FIG00021007 Protein gp28 [Bacteriophage A118] +FIG00021012 Outer membrane fibronectin-binding protein +FIG00021030 Coenzyme F420 hydrogenase alpha subunit (FrcA) (EC 1.12.98.1) +FIG00021045 Two-component response regulator CreC +FIG00021073 Putative high-affinity iron permease +FIG00021132 Surface presentation of antigens protein SpaN (Invasion protein InvJ) +FIG00021152 Single-stranded DNA-binding protein (prophage associated) +FIG00021206 Beta-lactamase +FIG00021237 Rhodanese domain protein UPF0176 +FIG00021242 Xylonate dehydratase (EC 4.2.1.82) +FIG00021251 Putative lipoprotein, similar to CjrA of Escherichia coli O164 +FIG00021257 FIG032766: hypothetical protein +FIG00021266 ABC-type Fe3+ transport system protein; Molybdenum transport protein, putative +FIG00021288 Phage terminase large subunit, PBSX family +FIG00021289 ATP-dependent DNA helicase RecG (EC 3.6.1.-) +FIG00021304 ADP-dependent glucokinase (EC 2.7.1.147) +FIG00021330 Potassium efflux system KefA protein / Small-conductance mechanosensitive channel +FIG00021332 FtsK/SpoIIIE family protein EccCb1, component of Type VII secretion system ESX-1 +FIG00021335 Putative ESAT-secreted protein, BA2188 homolog +FIG00021347 Death on curing protein, Doc toxin +FIG00021360 Response regulator VieA +FIG00021381 Acriflavin resistance protein / Multidrug efflux system CmeDEF +FIG00021382 Capsular polysaccharide biosynthesis protein CapD +FIG00021384 Flagellar hook subunit protein +FIG00021392 IncF plasmid conjugative transfer protein TraN +FIG00021407 (R)-citramalate synthase (EC 2.3.1.182) +FIG00021412 Uxu operon transcriptional regulator +FIG00021430 Putative ESAT-secreted protein, BA2189 homolog +FIG00021433 FIG021862: membrane protein, exporter +FIG00021445 Pyridoxine biosynthesis glutamine amidotransferase, synthase subunit (EC 2.4.2.-) +FIG00021452 Transcriptional activator RamA +FIG00021468 FIG024738: Hypothetical protein +FIG00021470 heterodisulfide reductase, subunit E, putative +FIG00021484 Metallo-beta-lactamase superfamily domain protein in prophage +FIG00021490 Orotidine 5'-phosphate decarboxylase (EC 4.1.1.23) / Orotate phosphoribosyltransferase (EC 2.4.2.10) +FIG00021503 Thiosulfate reductase electron transport protein phsB +FIG00021517 Cell division protein FtsQ +FIG00021525 Glycosyl transferase, group 1 family, anthrose biosynthesis +FIG00021527 GAF domain/GGDEF domain/EAL domain protein +FIG00021549 Protein gp22 [Bacteriophage A118] +FIG00021555 Zinc ABC transporter, periplasmic-binding protein ZnuA +FIG00021569 Capsular polysaccharide synthesis enzyme Cap8O +FIG00021574 FIG021574: Possible membrane protein related to de Novo purine biosynthesis +FIG00021581 Putative tail or base plate protein gp19 [Bacteriophage A118] +FIG00021583 3-hydroxyisobutyrate dehydrogenase (EC 1.1.1.31) +FIG00021623 Nitrogenase FeMo-cofactor synthesis molybdenum delivery protein NifQ +FIG00021644 Molybdenum ABC transporter, periplasmic molybdenum-binding protein ModA (TC 3.A.1.8.1) +FIG00021647 Phenol hydroxylase, P1 oxygenase component DmpL (EC 1.14.13.7) +FIG00021663 Putative cytochrome c-type biogenesis protein related to CcmF +FIG00021674 Homoaconitase large subunit (EC 4.2.1.36) +FIG00021682 FIG038648: MoaD and/or ThiS families +FIG00021688 Acetylglutamate kinase (EC 2.7.2.8) / Acetylaminoadipate kinase (EC 2.7.2.-) +FIG00021706 Ferredoxin / Ferredoxin--NADP(+) reductase, actinobacterial (eukaryote-like) type (EC 1.18.1.2) +FIG00021745 Glutathione peroxidase family protein +FIG00021747 Phycoerythrin alpha chain +FIG00021764 FIG021764: Possible membrane protein +FIG00021779 IncF plasmid conjugative transfer mating signal transduction protein TraM +FIG00021808 Cell division protein BolA +FIG00021836 tRNA (guanine-N1)-methyltransferase (EC 2.1.1.31) / 2-C-methyl-D-erythritol 2,4-cyclodiphosphate synthase (EC 4.6.1.12) +FIG00021843 Chromosome (plasmid) partitioning protein ParB +FIG00021845 Septum formation protein Maf +FIG00021861 Nitrite transporter from formate/nitrite family +FIG00021888 Cobalt-precorrin-2 C20-methyltransferase (EC 2.1.1.130) / Cobalt-precorrin-3b C17-methyltransferase +FIG00021906 Small hypothetical protein Hyp1 +FIG00021909 Exosporium protein D +FIG00021976 Pyochelin biosynthetic protein PchG, oxidoreductase (NAD-binding) +FIG00021981 D-allose ABC transporter, ATPase component +FIG00021994 Enterobactin receptor VctA +FIG00022005 FIG045511: hypothetical antitoxin (to FIG022160: hypothetical toxin) +FIG00022019 Polymyxin resistance protein ArnC, glycosyl transferase (EC 2.4.-.-) +FIG00022022 NTD biosynthesis operon putative hydrolase NtdB (EC 3.-.-.-) +FIG00022027 Fibronectin binding protein FnbA +FIG00022031 L-fucose mutarotase +FIG00022041 ATP-dependent RNA helicase Atu1833 +FIG00022045 Putative uncharacterized protein BCG_3611 +FIG00022068 FIG022068: Hypothetical protein +FIG00022086 Homoaconitase small subunit (EC 4.2.1.36) +FIG00022101 Ferric siderophore transport system, biopolymer transport protein ExbD +FIG00022140 Peptidase, M23/M37 family +FIG00022142 Phage antirepressor protein / Antirepressor [Bacteriophage A118] +FIG00022143 Acetophenone carboxylase subunit Apc2 (EC 6.4.1.8) +FIG00022146 Urea carboxylase-related aminomethyltransferase (EC 2.1.2.10) +FIG00022151 Enterochelin uptake permease CeuB +FIG00022160 FIG022160: hypothetical toxin +FIG00022163 Putative tail or base plate protein gp17 [Bacteriophage A118] +FIG00022167 Biotin synthesis protein BioZ +FIG00022199 FIG022199: FAD-binding protein +FIG00022220 AAA+ family protein ATPase EccA1, component of Type VII secretion system ESX-1 +FIG00022223 N-acetylglucosamine deacetylase (EC 3.5.1.-) / 3-hydroxyacyl-[acyl-carrier-protein] dehydratase, FabZ form (EC 4.2.1.59) +FIG00022225 Invasion protein IagB precursor +FIG00022300 UDP-glucose 4-epimerase (EC 5.1.3.2) +FIG00022301 Outer membrane pyoverdine eflux protein +FIG00022337 Glucose ABC transport system, periplasmic sugar-binding protein +FIG00022346 Aldehyde decarbonylase (EC 4.1.99.5) +FIG00022401 LysR family transcriptional regulator PA4989 +FIG00022408 Transcriptional regulator NanR +FIG00022427 Cystathionine beta-synthase (EC 4.2.1.22) +FIG00022432 Putative peptidoglycan bound protein (LPXTG motif) Lmo0435 homolog +FIG00022443 Thiosulfate reductase cytochrome B subunit +FIG00022445 Regulation of D-alanyl-lipoteichoic acid biosynthesis, sensor histidine kinase +FIG00022446 Enterochelin uptake ATP-binding protein +FIG00022447 Pyoverdin biosynthesis protein PvdH, L-2,4-diaminobutyrate:2-oxoglutarate aminotransferase (EC 2.6.1.76) +FIG00022486 outer membrane protein AlgE +FIG00022488 Gluconate permease +FIG00022568 Phosphonate ABC transporter ATP-binding protein (TC 3.A.1.9.1) +FIG00022569 Transcriptional regulator, IclR family +FIG00022606 General secretion pathway protein A +FIG00022628 Mu-like prophage FluMu protein GP38 +FIG00022631 Acetyl-coenzyme A synthetase (EC 6.2.1.1) +FIG00022632 Putative outer membrane siderophore receptor +FIG00022668 Trilactone hydrolase IroD +FIG00022686 Lactobacillus delbrueckii phage mv4 main capsid protein Gp34 homolog lin2390 +FIG00022719 hydrogenase, (NiFe)/(NiFeSe) small subunit family +FIG00022724 Ribose/xylose/arabinose/galactoside ABC-type transport systems, permease component 1 +FIG00022735 ABC-type transport system involved in resistance to organic solvents, periplasmic component USSDB6C +FIG00022740 Phosphate transport regulator (distant homolog of PhoU) +FIG00022820 Enterochelin uptake permease CeuC +FIG00022837 Lmo0066 homolog within ESAT-6 gene cluster, similarity to ADP-ribosylating toxins +FIG00022869 FIG022869: Oxidoreductase, GMC family +FIG00022875 3-oxoacyl-[ACP] synthase +FIG00022876 PqsE, quinolone signal response protein +FIG00022899 Threonine dehydratase (EC 4.3.1.19) +FIG00022913 Sulfur oxidation protein SoxY +FIG00022915 Transaldolase (EC 2.2.1.2) / Glucose-6-phosphate isomerase (EC 5.3.1.9) +FIG00022943 TonB-like; putative TolA function +FIG00022966 Nicotinamide-nucleotide adenylyltransferase, NadR family (EC 2.7.7.1) / Ribosylnicotinamide kinase (EC 2.7.1.22) +FIG00022971 FtsK/SpoIIIE family protein EccCa1, component of Type VII secretion system ESX-1 +FIG00022976 Electron transport complex protein RnfD +FIG00022977 FIG040666: hypothetical protein perhaps implicated in de Novo purine biosynthesis +FIG00022996 Aconitate hydratase (EC 4.2.1.3) +FIG00023004 Deoxyguanosinetriphosphate triphosphohydrolase (EC 3.1.5.1) +FIG00023019 Carbonic anhydrase (EC 4.2.1.1) +FIG00023040 SAM-dependent methyltransferase, BioC-like +FIG00023042 Ribose ABC transport system, high affinity permease RbsD (TC 3.A.1.2.1) +FIG00023045 Phosphonates transport ATP-binding protein PhnL +FIG00023065 Transcriptional regulator, VCA0231 ortholog +FIG00023071 Multiple sugar metabolism regulator +FIG00023108 Leu operon leader peptide +FIG00023143 Autolysis response regulater LytR +FIG00023146 PhnI protein +FIG00023165 NTD biosynthesis operon putative oxidoreductase NtdC (EC 1.-.-.-) +FIG00023187 Lipoprotein releasing system transmembrane protein LolE +FIG00023196 Short-chain dehydrogenase/reductase in hypothetical Actinobacterial gene cluster +FIG00023208 Transcriptional regulator of rhamnose utilization, LacI family +FIG00023221 Exosporium protein C +FIG00023231 Membrane protein EccB1, component of Type VII secretion system ESX-1 +FIG00023232 IncF plasmid conjugative transfer pilus assembly protein TraU +FIG00023237 Flagellar regulon repressor RtsB +FIG00023268 DNA-binding protein HU-beta +FIG00023293 2-aminoethylphosphonate ABC transporter periplasmic binding component (TC 3.A.1.9.1) +FIG00023301 Predicted rhamnogalacturonide-specific TRAP-type transporter, large transmembrane component RhiC +FIG00023311 LysR family transcriptional regulator PA0133 +FIG00023315 periplasmic decaheme cytochrome c, MtrA +FIG00023348 Ethanolamine operon regulatory protein +FIG00023355 AMP-dependent synthetase/ligase in alkane synthesis cluster +FIG00023360 Glycosyltransferase (EC 2.4.1.-) in large core OS assembly cluster +FIG00023369 Chaperone protein DnaK +FIG00023406 FIG023406: hypothetical protein +FIG00023427 Agglutination protein +FIG00023451 Hypothetical protein VpsJ +FIG00023452 NADPH-dependent mycothiol reductase Mtr +FIG00023457 Type III secretion transcriptional activator HilA +FIG00023460 Iron-siderophore [Alcaligin-like] transport system, permease component @ Iron-siderophore transport system, permease component +FIG00023463 heterodisulfide reductase, subunit A/methylviologen reducing hydrogenase, subunit delta +FIG00023476 Methylamine utilization protein MauD +FIG00023485 Spore germination protein GerAC, germination response to L-alanine and related amino acids (earliest stage) +FIG00023502 Type IV fimbrial biogenesis protein PilV +FIG00023503 Putative 3-oxoacyl-[acyl-carrier-protein] synthase III in AHQ biosynthetic operon, related to PqsB +FIG00023524 N-acetyl-1-D-myo-inosityl-2-amino-2-deoxy-alpha-D-glucopyranoside deacetylase MshB +FIG00023531 Type III helper protein HrpK1 +FIG00023534 Protein EspJ, component of Type VII secretion system ESX-1 +FIG00023542 4-hydroxyproline epimerase (EC 5.1.1.8) +FIG00023549 Hypothetical protein VpsF +FIG00023565 Glycolate utilization operon transcriptional activator GlcC +FIG00023573 CRISPR-associated negative autoregulator +FIG00023614 Possible alpha/beta hydrolase superfamily, slr1827 homolog +FIG00023625 Putative peptidoglycan bound protein (LPXTG motif) Lmo2576 homolog +FIG00023646 Putative metal-dependent phosphohydrolase with tandem HD motifs +FIG00023651 Butyrate-acetoacetate CoA-transferase subunit A (EC 2.8.3.9) +FIG00023658 Internalin-like protein (LPXTG motif) Lmo0171 homolog +FIG00023677 FIG023677: hypothetical protein +FIG00023678 Predicted L-rhamnose ABC transporter, transmembrane component 1 +FIG00023679 SAM-dependent methyltransferase 2, in cluster with Hydroxyacylglutathione hydrolase (EC 3.1.2.6) +FIG00023690 DNA polymerase III chi subunit (EC 2.7.7.7) +FIG00023711 internalin, putative (LPXTG motif) +FIG00023722 Type III secretion cytoplasmic protein (YscF) +FIG00023726 Indole-3-glycerol phosphate synthase (EC 4.1.1.48) / Phosphoribosylanthranilate isomerase (EC 5.3.1.24) +FIG00023732 ABC-type tungstate transport system, ATP-binding protein +FIG00023766 Protein of unknown function DUF1446 +FIG00023769 FIG023769: Choline transport related protein +FIG00023779 Sucrose specific transcriptional regulator CscR, LacI family +FIG00023790 Cytolethal distending toxin subunit C +FIG00023799 Putative effector protein OrgC of SPI-1 type III secretion system +FIG00023840 Possible sterol desaturase +FIG00023843 Phenol hydroxylase, P2 regulatory component DmpM (EC 1.14.13.7) +FIG00023845 General secretion pathway protein H +FIG00023849 Type III secretion inner membrane protein (YscR,SpaR,HrcR,EscR,homologous to flagellar export components) +FIG00023863 TcuC: integral membrane protein used to transport tricarballylate across the cell membrane +FIG00023879 Anaerobic glycerol-3-phosphate dehydrogenase subunit B (EC 1.1.5.3) +FIG00023888 Thiamine kinase (EC 2.7.1.89) @ Adenosylcobinamide kinase (EC 2.7.1.156) +FIG00023901 Phage shock protein E +FIG00023916 Beta-fimbriae probable major subunit +FIG00023917 Paralog of coenzyme PQQ synthesis protein C +FIG00023936 Phenolic acid decarboxylase (EC 4.1.1.-) +FIG00023943 DNA polymerase IV (EC 2.7.7.7) +FIG00023946 CRISPR-associated protein Cas1 +FIG00023953 Energy-conserving hydrogenase (ferredoxin), subunit E +FIG00023982 Unknown pentose utilization regulator, LacI family +FIG00023985 ABC transporter involved in cytochrome c biogenesis, CcmB subunit +FIG00023994 ATP synthase gamma chain (EC 3.6.3.14) +FIG00024006 FIG024006: iron uptake protein +FIG00024032 Heme oxygenase (EC 1.14.99.3) +FIG00024044 Putrescine transport system permease protein PotH (TC 3.A.1.11.2) +FIG00024053 C3 family ADP-ribosyltransferase (EC 2.4.2.-) +FIG00024072 FIG002203: Octaprenyl-diphosphate synthase (EC 2.5.1.-) +FIG00024073 Galactokinase (EC 2.7.1.6) +FIG00024085 Capsular polysaccharide synthesis enzyme Cap5I +FIG00024110 Type III secretion transcriptional regulator HilD +FIG00024143 Erythritol kinase EryA (EC 2.7.1.27) +FIG00024147 Ferric vibriobactin, enterobactin transport system, permease protein VctD (TC 3.A.1.14.6) +FIG00024150 Phenylalanine-specific permease +FIG00024157 Type III secretion protein SsaI +FIG00024169 Cell invasion protein sipC (Effector protein SipC) +FIG00024214 FIG024214: Transcriptional regulator, AraC family +FIG00024226 Ribose operon repressor +FIG00024246 Ferrous iron transport protein C +FIG00024254 TRAP-type transport system, large permease component, predicted N-acetylneuraminate transporter / TRAP-type transport system, small permease component, predicted N-acetylneuraminate transporter +FIG00024279 DUF1275 domain-containing protein +FIG00024285 FIG024285: Hypothetical protein +FIG00024300 Methylamine utilization protein MauE +FIG00024314 MSHA pilin protein MshC +FIG00024328 Hypothetical protein, Lin0079 homolog [Bacteriophage A118] +FIG00024373 YggT family protein YlmG/ssl0353, required for proper distribution of nucleoids in chloroplast and cyanobacteria +FIG00024396 LysR family transcriptional regulator STM3121 +FIG00024401 UDP-N-acetylmuramoylalanyl-D-glutamyl-2,6-diaminopimelate--D-alanyl-D-alanine ligase (EC 6.3.2.10) +FIG00024402 OrgB protein, associated with InvC ATPase of type III secretion system +FIG00024409 Muconolactone isomerase (EC 5.3.3.4),putative +FIG00024410 Photosynthetic reaction center L subunit +FIG00024417 Protein-N(5)-glutamine methyltransferase PrmC, methylates polypeptide chain release factors RF1 and RF2 / tRNA (guanine46-N7-)-methyltransferase (EC 2.1.1.33) +FIG00024437 Putative non-ribosomal peptide synthetase in AHQ biosynthetic operon +FIG00024449 Nitrogenase vanadium-cofactor synthesis protein VnfN +FIG00024470 Capsular polysaccharide synthesis enzyme Cap5J +FIG00024471 Endolysin, L-alanyl-D-glutamate peptidase (EC 3.4.-.-) [Bacteriophage A118] +FIG00024505 Internalin-like protein (LPXTG motif) Lmo2396 homolog +FIG00024510 NAD(P)H oxidoreductase YRKL (EC 1.6.99.-) @ Putative NADPH-quinone reductase (modulator of drug activity B) @ Flavodoxin 2 +FIG00024546 Phosphonoacetaldehyde hydrolase (EC 3.11.1.1) +FIG00024563 Cyanobacteria-specific RpoD-like sigma factor, type-6 +FIG00024566 SPI1-associated transcriptional regulator SprB +FIG00024587 CO dehydrogenases maturation factor, CoxF family +FIG00024591 Ketoisovalerate oxidoreductase subunit VorC (EC 1.2.7.7) +FIG00024629 Capsular polysaccharide synthesis enzyme Cap5K +FIG00024630 Cell invasion protein SipD (Salmonella invasion protein D) +FIG00024637 Ferric vibriobactin, enterobactin transport system, ATP-binding protein ViuC (TC 3.A.1.14.6) +FIG00024641 Transcriptional regulator CdgA +FIG00024680 Type VI secretion-related protein VasL +FIG00024717 ATP-dependent RNA helicase VF1437 +FIG00024730 Ferric vibriobactin, enterobactin transport system, permease protein ViuD (TC 3.A.1.14.6) +FIG00024746 FIG024746: hypothetical protein +FIG00024757 Photosynthetic reaction center M subunit +FIG00024764 Type III secretion spans bacterial envelope protein (YscO) +FIG00024769 Nickel transport ATP-binding protein nikE2 (TC 3.A.1.5.3) +FIG00024811 polysulfide reductase, subunit A +FIG00024830 Siderophore [Alcaligin-like] decarboxylase (EC 4.1.1.-) @ Siderophore biosynthesis L-2,4-diaminobutyrate decarboxylase +FIG00024850 FIG024850: short form Mg-chelase associated protein with vWA domain +FIG00024851 Transmembrane component of general energizing module of ECF transporters +FIG00024898 Erythritol transcriptional regulator EryD +FIG00024913 IncF plasmid conjugative transfer protein TraQ +FIG00024930 1,4-alpha-glucan (glycogen) branching enzyme, GH-13-type (EC 2.4.1.18) +FIG00024965 Type III secretion chaperone protein for YopD (SycD) +FIG00024967 Surface-exposed lipoprotein JlpA +FIG00024982 Fimbrial protein YadC +FIG00024999 ABC-type nitrate/sulfonate/bicarbonate transport system, ATPase component +FIG00025014 Secretion system effector SseE +FIG00025049 Predicted transcriptional regulator of 4-carboxymuconolactone decarboxylase, Rrf2 family +FIG00025068 Surface presentation of antigens protein SpaM +FIG00025070 Periplasmic protein SypC involved in polysaccharide export +FIG00025086 Xanthine permease +FIG00025127 ATP-dependent Clp protease, ATP-binding subunit ClpC +FIG00025148 Capsular polysaccharide synthesis enzyme Cap5H; O-acetyl transferase +FIG00025174 Probable outer membrane component of multidrug efflux pump +FIG00025206 Photosystem II protein PsbL +FIG00025209 Nicotinamidase/isochorismatase family protein +FIG00025213 Cell envelope-associated transcriptional attenuator LytR-CpsA-Psr, subfamily A1 (as in PMID19099556) +FIG00025216 ClpB protein +FIG00025233 FIG025233: SAM-dependent methyltransferases +FIG00025268 Phosphorelay protein LuxU +FIG00025269 Outer membrane protein SypB +FIG00025307 FIG025307: hypothetical protein +FIG00025335 Lactate-responsive regulator LldR in Actinobacteria, GntR family +FIG00025343 Hypothetical protein in AHQ biosynthetic operon +FIG00025360 Flagellar motor rotation protein MotB +FIG00025385 Putative lipoprotein of ferric iron transporter system +FIG00025406 polysaccharide biosynthesis protein, putative +FIG00025419 NTD biosynthesis operon protein NtdA +FIG00025420 Chlorophyllide reductase subunit BchY (EC 1.18.-.-) +FIG00025433 3-hydroxy-3isohexenylglutaryl-CoA:acetate lyase +FIG00025475 Phosphoribosylformylglycinamidine synthase, glutamine amidotransferase subunit (EC 6.3.5.3) +FIG00025484 Plant-induced nitrilase (EC 3.5.5.1), hydrolyses beta-cyano-L-alanine +FIG00025493 Hypothetical protein, Lmo2276 homolog +FIG00025507 Methylamine dehydrogenase heavy chain precursor (EC 1.4.99.3) +FIG00025513 Hypothetical protein, Lmo2307 homolog [Bacteriophage A118] +FIG00025527 Pyruvate dehydrogenase E1 component beta subunit (EC 1.2.4.1) +FIG00025536 Peptide chain release factor 2 unshifted fragment +FIG00025538 Uracil-DNA glycosylase, putative family 6 +FIG00025567 Cyanobacteria-specific RpoD-like sigma factor, type-12 +FIG00025578 L-allo-threonine aldolase (EC 2.1.2.1) +FIG00025591 RbmA protein +FIG00025607 Multidrug resistance transporter, Bcr/CflA family +FIG00025611 Colanic acid biosynthesis glycosyl transferase WcaE +FIG00025630 cAMP-dependent Kef-type K+ transport system +FIG00025635 Cytochrome c in methylamine utilization cluster +FIG00025636 Alpha-glucosidase, family 31 of glycosyl hydrolases, COG1501 +FIG00025637 FIG026426: Hypothetical protein +FIG00025664 Acyclic terpenes utilization regulator AtuR, TetR family +FIG00025709 Homoisocitrate dehydrogenase (EC 1.1.1.87) +FIG00025734 Predicted L-rhamnose ABC transporter, substrate-binding component +FIG00025748 Accessory colonization factor AcfD precursor +FIG00025759 Orotate phosphoribosyltransferase (EC 2.4.2.10) +FIG00025814 Chlorophyllide reductase subunit BchZ (EC 1.18.-.-) +FIG00025821 Streptococcal extracellular nuclease 3; Mitogenic factor 3 +FIG00025877 Type III secretion protein (YscP) +FIG00025878 Protein gp34 [Bacteriophage A118] +FIG00025881 FIG025881: hypothetical protein in Ammonia conversion cluster +FIG00025887 Organic hydroperoxide resistance transcriptional regulator +FIG00025932 Type III secretion protein SsaK +FIG00025944 Maleate cis-trans isomerase (EC 5.2.1.1) +FIG00025980 Sulfur oxidation protein SoxX +FIG00026000 Methyltransferase (EC 2.1.1.-) colocalized with Q +FIG00026006 Succinate dehydrogenase iron-sulfur protein (EC 1.3.99.1) +FIG00026027 HTH-type transcriptional regulator PtxR +FIG00026044 Serine protease precursor MucD/AlgY associated with sigma factor RpoE +FIG00026060 Ni,Fe-hydrogenase maturation factor; HoxW +FIG00026094 Benzoyl-CoA oxygenase component B +FIG00026137 Aspartate-semialdehyde dehydrogenase (EC 1.2.1.11) +FIG00026146 Di/tripeptide permease DtpA +FIG00026158 Virulence-associated cell-wall-anchored protein SasG (LPXTG motif), binding to squamous nasal epithelial cells +FIG00026165 Periplasmic lysozyme inhibitor of c-type lysozyme +FIG00026169 photosystem I subunit VIII (PsaI) +FIG00026182 Hypothetical protein, Lmo2313 homolog [Bacteriophage A118] +FIG00026271 Conserved protein IgrD +FIG00026291 FIG026291: Hypothetical periplasmic protein +FIG00026295 50S ribosomal protein acetyltransferase +FIG00026306 Type III secretion injected virulence protein (YopE) +FIG00026323 exopolysaccharide biosynthesis protein EpsF, putative +FIG00026327 Phage hyaluronidase +FIG00026340 2-aminoethylphosphonate ABC transporter ATP-binding protein (TC 3.A.1.9.1) +FIG00026376 Ketoisovalerate oxidoreductase subunit VorB (EC 1.2.7.7) +FIG00026418 Transcriptional activator PlcR +FIG00026433 IncF plasmid conjugative transfer surface exclusion protein TraT +FIG00026478 tRNAHis-5'-guanylyltransferase +FIG00026514 Surface presentation of antigens protein SpaK (Invasion protein InvB) +FIG00026587 Sensor histidine kinase ChvG (EC 2.7.3.-) +FIG00026588 Coenzyme F420-reducing hydrogenase, alpha subunit +FIG00026595 ABC transporter membrane-spanning permease, Pep export, Vex3 +FIG00026664 Purine cyclase-related protein +FIG00026673 D-galactonate transporter +FIG00026704 Vibriolysin, extracellular zinc protease (EC 3.4.24.25) @ Pseudolysin, extracellular zinc protease (EC 3.4.24.26) +FIG00026728 Transcriptional regulator in PFGI-1-like cluster +FIG00026750 Predicted glucose transporter in maltodextrin utilization gene cluster +FIG00026758 Poly-gamma-glutamate synthase subunit PgsB/CapB (EC 6.3.2.-) +FIG00026765 FIG026765: hypothetical protein +FIG00026774 Transcriptional regulator AglR, LacI family +FIG00026775 Type III secretion effector SseF +FIG00026782 photosystem I subunit II (PsaD) +FIG00026783 polysaccharide export protein, putative +FIG00026800 Accessory gene regulator B +FIG00026818 DUF1022 domain-containing protein +FIG00026837 Gamma-glutamyltranspeptidase PgsD/CapD (EC 2.3.2.2), catalyses PGA anchorage to peptidoglycan +FIG00026838 Pyridoxal-5'-phosphate phosphatase (EC 3.1.3.74), Alphaproteobacterial type +FIG00026841 Spo0E-like putative sporulation regulatory protein in grePA-PF operon +FIG00026845 Alpha-related fimbriae minor subunit 2 +FIG00026855 Deoxyhypusine synthase (EC 2.5.1.46) +FIG00026918 Chromosome partition protein smc +FIG00026949 2-dehydro-3-deoxy-L-rhamnonate aldolase (EC 4.1.2.n3) +FIG00026959 Rhamnolipids biosynthesis 3-oxoacyl-[acyl-carrier-protein] reductase RhlG (EC 1.1.1.100) +FIG00026980 Secreted protein, suppressor for copper-sensitivity ScsC +FIG00026988 Putative LysR family transcriptional regulator +FIG00026991 Probable short-chain type dehydrogenase/reductase (EC 1.-.-.-) +FIG00027048 4-hydroxybenzoyl-CoA reductase, beta subunit (EC 1.3.99.20) +FIG00027087 GLUCOSE-FRUCTOSE OXIDOREDUCTASE (EC 1.1.99.28) +FIG00027094 Phycobilisome small core linker polypeptide +FIG00027115 FIG027115: Membrane protein +FIG00027125 Nitrate ABC transporter, nitrate-binding protein +FIG00027138 Transcriptional regulator for ferulate or vanillate catabolism +FIG00027150 Iron-siderophore [Alcaligin-like] transport system, transmembran component @ Iron-siderophore transport system, transmembran component +FIG00027156 Iron-siderophore [Alcaligin-like] transport system, substrate-binding component @ Iron-siderophore transport system, substrate-binding component +FIG00027198 Flp pilus assembly membrane protein TadE +FIG00027221 ATP-dependent Clp protease adaptor protein ClpS Cyano2 +FIG00027222 GDP-L-fucose synthetase (EC 1.1.1.271) +FIG00027226 DnaJ-class molecular chaperone CbpA +FIG00027232 SinI protein, antagonist of SinR +FIG00027233 Glycerol-3-phosphate ABC transporter, ATP-binding protein UgpC (TC 3.A.1.1.3) +FIG00027246 Glycolate dehydrogenase (EC 1.1.99.14), FAD-binding subunit GlcE +FIG00027266 WhiB-family transcriptional regulator +FIG00027270 Putative ABC transporter of substrate X, permease subunit I +FIG00027294 Hydrogen cyanide synthase HcnB / Opine oxidase subunit A +FIG00027320 NAD-dependent glyceraldehyde-3-phosphate dehydrogenase (EC 1.2.1.12) / Plasmin(ogen) receptor +FIG00027321 TonB-dependent heme receptor HutR +FIG00027349 Streptococcal pyrogenic exotoxin J (SpeJ) fragment +FIG00027358 Metalloprotease, putative zinc-binding domain +FIG00027368 cytochrome-c3 hydrogenase alpha chain +FIG00027469 Arginine ABC transporter, periplasmic arginine-binding protein ArtI +FIG00027470 Mannosyltransferase OCH1 and related enzymes +FIG00027522 IncF plasmid conjugative transfer protein TrbE +FIG00027526 Urea ABC transporter, ATPase protein UrtD +FIG00027527 Histidinol-phosphate aminotransferase (EC 2.6.1.9) @ Aromatic-amino-acid aminotransferase (EC 2.6.1.57) +FIG00027542 Putative thiol:disulfide oxidoreductase, nitrite reductase complex assembly +FIG00027565 Capsular polysaccharide synthesis enzyme Cap5L +FIG00027618 DedA family protein paralog +FIG00027620 DNA polymerase-like protein PA0670 +FIG00027631 Putative carbohydrate kinase in cluster with fructose-bisphosphate aldolase +FIG00027657 FmtB (Mrp) protein involved in methicillin resistance and cell wall biosynthesis +FIG00027659 Invasion protein invH precursor +FIG00027670 macromolecule metabolism; macromolecule synthesis, modification; proteins and peptides - translation and modification +FIG00027682 Hydrogen cyanide synthase HcnA / Opine oxidase subunit C +FIG00027695 Antibiotic biosynthesis monooxygenase +FIG00027732 Quorum-sensing transcriptional activator YspR +FIG00027750 Possible ABC transporter, periplasmic substrate X binding protein precursor +FIG00027805 Hypothetical protein, bax gene locus +FIG00027811 Phage antitermination protein Q +FIG00027818 DNA primase (EC 2.7.7.-), phage-associated +FIG00027828 FIG027828: Putative bacteriophage protein +FIG00027832 dTDP-4-dehydrorhamnose 3,5-epimerase (EC 5.1.3.13) / dTDP-4-dehydrorhamnose reductase (EC 1.1.1.133) +FIG00027907 Kynurenine 3-monooxygenase (EC 1.14.13.9) +FIG00027911 Photosystem II oxygen evolving complex protein PsbP +FIG00027940 Fructose-bisphosphate aldolase (EC 4.1.2.13) +FIG00027986 Antigen 85-C precursor (85C) (Antigen 85 complex C) (Ag85C) (Mycolyl transferase 85C) (EC 2.3.1.-) +FIG00028023 Transcriptional regulator of fimbriae expression FimY +FIG00028059 ATPase component CbiO of energizing module of cobalt ECF transporter +FIG00028073 N-acetyl-gamma-aminoadipyl-phosphate reductase (EC 1.2.1.-); N-acetyl-gamma-glutamyl-phosphate reductase (EC 1.2.1.38) +FIG00028129 4'-phosphopantetheinyl transferase (EC 2.7.8.-), inferred for PFA pathway +FIG00028132 Type I secretion outer membrane protein, TolC precursor +FIG00028147 ATP-dependent RNA helicase VCA0990 +FIG00028163 Protein gp47, recombination-related [Bacteriophage A118] +FIG00028172 Hypothetical protein VpsP +FIG00028177 Hemophore HasA +FIG00028179 Formaldehyde activating enzyme +FIG00028182 IncF plasmid conjugative transfer regulator TraJ +FIG00028201 RbmD, similar to Lipid A core - O-antigen ligase and related enzymes +FIG00028203 DNA gyrase subunit B (EC 5.99.1.3) +FIG00028204 Phage lysin, 1,4-beta-N-acetylmuramidase (EC 3.2.1.17) or lysozyme +FIG00028245 L-ornithine 5-monooxygenase (EC 1.13.12.-), PvdA of pyoverdin biosynthesis +FIG00028259 Transcriptional regulator LuxZ +FIG00028260 Malonate transporter, MadL subunit +FIG00028290 Exopolysaccharide production protein ExoZ +FIG00028318 Hemolysin-related protein RbmC +FIG00028323 Predicted rhamnogalacturonide-specific TRAP-type transporter, substrate-binding component RhiA +FIG00028335 Transcriptional regulator VpsT +FIG00028342 Two-component oxygen-sensor histidine kinase FixL +FIG00028377 Diaminobutyrate--2-oxoglutarate aminotransferase (EC 2.6.1.76) +FIG00028397 Two-component nitrogen fixation transcriptional regulator FixJ +FIG00028414 General secretion pathway protein J +FIG00028416 3-oxoacyl-[ACP] reductase (EC 1.1.1.100) +FIG00028420 Cobalt-precorrin-6x reductase (EC 1.3.1.54) / Cobalt-precorrin-6 synthase, anaerobic +FIG00028449 Streptococcal pyrogenic exotoxin A (SpeA); Toximoron (Superantigen) +FIG00028452 Possible electron transfer protein FdxB (EC 1.-.-.-) +FIG00028461 4-alpha-glucanotransferase (amylomaltase) (EC 2.4.1.25) +FIG00028472 Periplasmic esterase IroE +FIG00028476 Ribokinase (EC 2.7.1.15) +FIG00028501 Choline transporter BetT, short form +FIG00028541 Exosporium protein J +FIG00028545 Nitrate ABC transporter, permease protein +FIG00028564 Poly-gamma-glutamate synthase subunit PgsE/CapE (EC 6.3.2.-) +FIG00028586 Polysaccharide deacetylase, caspase activity +FIG00028627 Bacteriocin-like peptide I BlpI +FIG00028628 Probable cadmium-transporting ATPase (EC 3.6.3.3) +FIG00028629 Autoinducer 2 sensor kinase/phosphatase LuxQ (EC 2.7.3.-) (EC 3.1.3.-) +FIG00028633 Toxin mRNA interferase YgiU +FIG00028688 3-phenylpropionate dioxygenase alpha subunit (EC 1.14.1.-) +FIG00028694 Phosphoenolpyruvate-protein phosphotransferase of PTS system (EC 2.7.3.9) +FIG00028739 Uncharacterized membrane protein Ycf36 +FIG00028771 Sensor histidine kinase in cluster with mercury reductase +FIG00028779 Hydroxymethylpyrimidine ABC transporter, substrate-binding component +FIG00028784 Monooxygenase component A +FIG00028818 LysR family transcriptional regulator PA2758 +FIG00028852 Methyl coenzyme M reductase alpha subunit (EC 2.8.4.1) +FIG00028865 ABC transporter, ATP-binding protein Vex2 +FIG00028882 D-glycerate transporter (predicted) +FIG00028883 FIG028883: Permeases of the drug/metabolite transporter (DMT) superfamily +FIG00028888 Putative transcriptional regulator of unknown carbohydrate utilization cluster, GntR family +FIG00028917 Late competence protein ComGG, FIG028917 +FIG00028932 FIG028932: hypothetical protein +FIG00028942 Molybdopterin binding motif, CinA N-terminal domain +FIG00028983 Spore germination protein GerXA (on pXO1) +FIG00028984 Transcription regulator in CO-DH cluster +FIG00029017 DUF1850 domain-containing protein +FIG00029024 Alternative cytochrome c oxidase polypeptide CoxP (EC 1.9.3.1); Cytochrome c oxidase, subunit III (EC 1.9.3.1) +FIG00029028 Siderophore [Alcaligin-like] biosynthesis complex, long chain @ Siderophore synthetase component, ligase +FIG00029036 Type III secretion protein SsaH +FIG00029094 IncW plasmid conjugative protein TrwB (TraD homolog) +FIG00029116 carbon monoxide dehydrogenase D protein +FIG00029120 Phosphoenolpyruvate synthase / Pyruvate phosphate dikinase +FIG00029136 Cytochrome c-type biogenesis protein CcmD, interacts with CcmCE +FIG00029159 Siderophore transport protein +FIG00029176 Anti anti-sigma regulatory factor SypA +FIG00029180 Membrane protease family protein y2843 +FIG00029202 Phosphatidylethanolamine N-methyltransferase (EC 2.1.1.17) @ Phosphatidyl-N-methylethanolamine N-methyltransferase (EC 2.1.1.71) @ Phosphatidyl-N-dimethylethanolamine N-methyltransferase +FIG00029203 Beta-lactamase class D +FIG00029244 Two-component sensor PilS +FIG00029284 Extracellular deoxyribonuclease Xds +FIG00029301 Superantigen enterotoxin SEL +FIG00029303 AttH component of AttEFGH ABC transport system +FIG00029309 Benzoate transport, ATPase component +FIG00029311 Predicted polyamine sensor NspS, involved in biofilm formation +FIG00029322 Aerobic C4-dicarboxylate transporter for fumarate, L-malate, D-malate, succunate +FIG00029340 Polysulfide reductase, subunit A, putative +FIG00029355 Protein EspG1, component of Type VII secretion system ESX-1 +FIG00029412 Lipopolysaccharide synthesis protein WavE +FIG00029444 ATP-dependent RNA helicase VC1407 +FIG00029446 Fimbrial protein YadM +FIG00029454 IncQ plasmid conjugative transfer protein TraP +FIG00029458 Repressor (CI-like) [Bacteriophage A118] +FIG00029463 Regulatory sensor-transducer, BlaR1/MecR1 family / TonB-dependent receptor +FIG00029470 TRAP dicarboxylate transporter, DctM subunit, unknown substrate 6 +FIG00029484 Cytochrome c oxidase polypeptide I (EC 1.9.3.1) / Cytochrome c oxidase polypeptide III (EC 1.9.3.1) +FIG00029491 N-acetyl-gamma-aminoadipyl-phosphate reductase (EC 1.2.1.-) +FIG00029532 Acetylaminoadipate kinase (EC 2.7.2.-) +FIG00029533 Methylamine dehydrogenase light chain precursor (EC 1.4.99.3) +FIG00029555 Ketoisovalerate oxidoreductase subunit VorA (EC 1.2.7.7) +FIG00029563 Methylthioribulose-1-phosphate dehydratase related protein +FIG00029571 Nitrogenase (iron-iron) alpha chain (EC 1.18.6.1) +FIG00029572 Transcriptional regulatory protein UhpA +FIG00029606 Hexuronate utilization operon transcriptional repressor ExuR +FIG00029633 Putative sugar nucleotidyltransferase +FIG00029696 Autoinducer 2-binding periplasmic protein LuxP precursor +FIG00029706 Ferric vibriobactin, enterobactin transport system, permease protein ViuG (TC 3.A.1.14.6) +FIG00029709 Flagellar biosynthesis protein FlhA +FIG00029742 Methicillin resistance repressor MecI +FIG00029744 Iron-regulated virulence regulatory protein irgB +FIG00029758 N-carbamoyl-L-amino acid hydrolase (EC 3.5.1.87) +FIG00029792 Poly-gamma-glutamate synthase subunit PgsA/CapA (EC 6.3.2.-) +FIG00029798 Putative major teichoic acid biosynthesis protein C +FIG00029812 trans-acting positive regulator (Atx A) +FIG00029816 Septum site-determining protein MinD @ possible CpaE +FIG00029843 FIG035331: hypothetical protein +FIG00029868 Epi-inositol hydrolase (EC 3.7.1.-) +FIG00029869 NAD(P)H steroid dehydrogenase-like protein in alkane synthesis cluster +FIG00029872 Collagen-like surface protein +FIG00029879 Coenzyme PQQ synthesis protein D +FIG00029916 PTS system, cellobiose-specific IIC component (EC 2.7.1.69) +FIG00029939 GldJ +FIG00029945 Alternative cytochrome c oxidase polypeptide CoxP (EC 1.9.3.1) +FIG00029967 Uncharacterized MobA-related protein +FIG00029980 Global nitrogen regulatory protein, CRP family of transcriptional regulators +FIG00030006 ATP-dependent DNA helicase SCO5183 +FIG00030015 3-isopropylmalate dehydratase small subunit (EC 4.2.1.33); Homoaconitase small subunit (EC 4.2.1.36) +FIG00030028 Possible pterin-4 alpha-carbinolamine dehydratase-like protein +FIG00030029 3-demethylubiquinone-9 3-methyltransferase (EC 2.1.1.64) +FIG00030033 TPR domain protein in aerotolerance operon +FIG00030042 Poly-gamma-glutamate synthase subunit PgsC/CapC (EC 6.3.2.-) +FIG00030056 Small subunit naph/bph dioxygenase +FIG00030146 Putative Bax protein +FIG00030174 Predicted arginine uptake transporter +FIG00030183 Chondroitinase (chondroitin lyase) +FIG00030191 Serine/threonine protein kinase PrkC, regulator of stationary phase +FIG00030220 Small uncharacterized protein Bpro_4170 +FIG00030308 L-2-amino-thiazoline-4-carboxylic acid hydrolase (EC 3.5.2.-) +FIG00030326 Response regulator VieB +FIG00030330 FIG030330: hypothetical protein +FIG00030415 Microsomal dipeptidase (EC 3.4.13.19) +FIG00030440 Mercuric resistance operon regulatory protein +FIG00030452 General secretion pathway protein B +FIG00030480 Cytolysin and hemolysin, HlyA, Pore-forming toxin +FIG00030486 Predicted cell-wall-anchored protein SasK (LPXTG motif) +FIG00030491 FIGfam138462: Acyl-CoA synthetase, AMP-(fatty) acid ligase +FIG00030505 PTS system, beta-glucoside-specific IIB component (EC 2.7.1.69) / PTS system, beta-glucoside-specific IIC component +FIG00030566 Methyl coenzyme M reductase beta subunit (EC 2.8.4.1) +FIG00030585 Acetyl-CoA synthetase (ADP-forming) alpha and beta chains, putative +FIG00030678 Hypothetical protein, phi-ETA orf24 homolog [SA bacteriophages 11, Mu50B] +FIG00030688 dTDP-glucose 4,6-dehydratase (EC 4.2.1.46) +FIG00030692 Hypothetical protein RbmF +FIG00030731 Vibrioferrin amide bond forming protein PvsD @ Siderophore synthetase superfamily, group A +FIG00030759 Gene Transfer Agent (GTA) ORFG10 +FIG00030774 FIG138056: a glutathione-dependent thiol reductase +FIG00030797 C4-type zinc finger protein, DksA/TraR family +FIG00030813 Flagella-related protein FlaD +FIG00030821 Predicted thiamin transporter PnuT +FIG00030863 Per-activated serine protease autotransporter enterotoxin EspC +FIG00030868 Xanthan biosynthesis acetyltransferase GumF +FIG00030879 SSU ribosomal protein S23e (S12p) +FIG00030907 3-isopropylmalate dehydratase large subunit (EC 4.2.1.33); Homoaconitase large subunit (EC 4.2.1.36) +FIG00030925 Predicted chitobiose ABC transport system, permease protein 2 +FIG00030974 Toxin co-regulated pilus biosynthesis protein B +FIG00030978 Xanthan biosynthesis pyruvyltransferase GumL +FIG00031038 Photosystem P840 reaction center subunit PscD +FIG00031049 FIG031049: Hypothetical protein +FIG00031106 Capsular polysaccharide synthesis enzyme Cap8E +FIG00031150 Alpha-glucoside transport system permease protein AglG +FIG00031163 Nitrogen-responsive response regulator NrrA +FIG00031184 Xanthan biosynthesis glycosyltransferase GumM +FIG00031244 Cyclomaltodextrin glucanotransferase (EC 2.4.1.19); Maltogenic alpha-amylase (EC 3.2.1.133) +FIG00031250 D-3-phosphoglycerate dehydrogenase (EC 1.1.1.95) +FIG00031274 TRAP dicarboxylate transporter, DctQ subunit, unknown substrate 3 +FIG00031335 transcriptional activator AtxA, (pXO1-119) +FIG00031342 Ferric aerobactin ABC transporter, ATPase component +FIG00031343 Sulfhydrogenase II subunit d +FIG00031345 Predicted beta-glucoside transporter, GPH family +FIG00031347 2-desacetyl-2-hydroxyethyl bacteriochlorophyllide A dehydrogenase BchC +FIG00031351 Tetratrico-peptide repeat (TPR) protein within ESAT-6 gene cluster +FIG00031355 Photosystem II protein PsbK +FIG00031375 Sulfhydrogenase II subunit g +FIG00031383 Predicted cobalt transporter in Mycobacteria +FIG00031392 Transcriptional regulator of fucose utilization, GntR family +FIG00031409 Polysialic acid capsule sugar isomerase, KpsF/GutQ family +FIG00031412 Ethanolamine utilization polyhedral-body-like protein EutN +FIG00031476 Ferric aerobactin ABC transporter, periplasmic substrate binding protein +FIG00031493 Putative carbohydrate PTS system, IIC component (EC 2.7.1.69) +FIG00031504 Pyrophosphate-energized proton pump (EC 3.6.1.1) +FIG00031529 Xanthan biosynthesis glycosyltransferase GumH +FIG00031552 Peptide transport system permease protein SapB +FIG00031560 Minor teichoic acid biosynthesis protein GgaA +FIG00031569 Putative Isoquinoline 1-oxidoreductase subunit, Mll3835 protein +FIG00031586 Superantigen enterotoxin SEB +FIG00031652 Type I restriction-modification system, DNA-methyltransferase subunit M (EC 2.1.1.72) / Type I restriction-modification system, specificity subunit S (EC 3.1.21.3) +FIG00031653 Biotin carboxyl carrier protein of methylmalonyl-CoA decarboxylase +FIG00031665 Transcriptional regulator of AraC family, enterobactin-dependent, predicted +FIG00031715 COG0613, Predicted metal-dependent phosphoesterases (PHP family) +FIG00031723 Cyclic beta-1,2-glucan synthase (EC 2.4.1.-) +FIG00031731 CRISPR-associated RAMP protein, Csm4 family +FIG00031732 Peptidase, family M23 (EC 3.4.24.-) +FIG00031759 Periplasmic beta-glucosidase (EC 3.2.1.21) +FIG00031762 Polygalacturonase (EC 3.2.1.15) +FIG00031781 Ornithine aminotransferase (EC 2.6.1.13); N-terminus domain +FIG00031801 Possibly related to ydbT +FIG00031825 Hydrogen peroxide-inducible genes activator +FIG00031893 Protein gp59 [Bacteriophage A118] +FIG00031898 2',3'-cyclic-nucleotide 2'-phosphodiesterase (EC 3.1.4.16) / 5'-nucleotidase (EC 3.1.3.5) +FIG00031904 Coenzyme F(420)H(2) dehydrogenase (methanophenazine) subunit FpoH +FIG00031962 transmembrane protein, distant homology with ydbS +FIG00031969 capsular polysaccharide biosynthesis protein +FIG00032019 Type III secretion inner membrane protein (YscS,homologous to flagellar export components) +FIG00032035 Toxin co-regulated pilus biosynthesis protein Q +FIG00032055 Coenzyme F(420)H(2) dehydrogenase (methanophenazine) subunit FpoJ +FIG00032108 Enoyl-[acyl-carrier-protein] reductase [NADPH] (EC 1.3.1.10) +FIG00032110 Methyl coenzyme M reductase gamma subunit (EC 2.8.4.1) +FIG00032146 Photosystem II protein PsbN +FIG00032149 Xylosidase/arabinosidase ass w/ COG3533 +FIG00032178 Erythronate-4-phosphate dehydrogenase (EC 1.1.1.290) +FIG00032194 Coenzyme F(420)H(2) dehydrogenase (methanophenazine) subunit FpoD +FIG00032195 Beta-carotene hydroxylase +FIG00032196 Formate hydrogenlyase transcriptional activator +FIG00032229 Molybdenum cofactor biosynthesis protein MoaB +FIG00032236 Coenzyme F(420)H(2) dehydrogenase (methanophenazine) subunit FpoF +FIG00032248 FIG032248: hypothetical protein +FIG00032281 ATP-dependent RNA helicase SO1501 +FIG00032292 Hypothetical protein FtpB in pyochelin gene cluster +FIG00032309 Pyruvate carboxylase (EC 6.4.1.1) / Biotin carboxyl carrier protein +FIG00032362 FIG032362: Hypothetical protein +FIG00032371 3-isopropylmalate dehydrogenase (EC 1.1.1.85); Homoisocitrate dehydrogenase (EC 1.1.1.87) +FIG00032397 FIG032397: Phage protein +FIG00032409 2H phosphoesterase superfamily protein BC2899 +FIG00032437 putative cytochrome P450 hydroxylase +FIG00032442 Chlorocatechol 1,2-dioxygenase +FIG00032483 PTS system, fructose- and mannose-inducible IID component (EC 2.7.1.69) +FIG00032516 Coenzyme F(420)H(2) dehydrogenase (methanophenazine) subunit FpoC +FIG00032527 Hypothetical protein, PV83 orf19 homolog [SA bacteriophages 11, Mu50B] +FIG00032551 Chlorosome protein C +FIG00032582 putative Cytochrome bd2, subunit II +FIG00032591 Thiol:disulfide oxidoreductase associated with MetSO reductase / Peptide methionine sulfoxide reductase MsrA (EC 1.8.4.11) / Peptide methionine sulfoxide reductase MsrB (EC 1.8.4.12) +FIG00032652 Predicted gluconate TRAP family transporter, DctM subunit +FIG00032670 Biosynthetic Aromatic amino acid aminotransferase beta (EC 2.6.1.57) +FIG00032686 Xanthan biosynthesis acetyltransferase GumG +FIG00032740 Putrescine transport ATP-binding protein PotG (TC 3.A.1.11.2) +FIG00032749 Protein YicC +FIG00032753 Transmembrane component YkoC of energizing module of thiamin-regulated ECF transporter for HydroxyMethylPyrimidine +FIG00032776 Putative regulatory protein, contains AAA+ NTPase domain and putative R3H ssDNA-binding domain +FIG00032815 MSHA biogenesis protein MshF +FIG00032828 Bacteriocin-like peptide J BlpJ +FIG00032843 Photosystem P840 reaction center iron-sulfur subunit PscB +FIG00032861 Coenzyme F(420)H(2) dehydrogenase (methanophenazine) subunit FpoA +FIG00032907 Two-component sensor kinase YvcQ +FIG00032920 Hypothetical succinate dehydrogenase membrane anhor protein +FIG00032938 Methyl-accepting chemotaxis protein, hemolysin secretion protein HylB +FIG00032964 L-2,4-diaminobutyrate decarboxylase (EC 4.1.1.86) +FIG00032966 Putative polyamine transporter; Oligopeptide transport system permease protein OppC (TC 3.A.1.5.1) +FIG00033015 HrpB2 protein +FIG00033040 Sulfate adenylyltransferase (EC 2.7.7.4) / Adenylylsulfate kinase (EC 2.7.1.25) +FIG00033105 Formylmethanofuran dehydrogenase (molybdenum) operon gene F (polyferredoxin) +FIG00033143 Optional hypothetical component of the B12 transporter BtuM +FIG00033190 photosystem I biogenesis protein BtpA +FIG00033206 Enoyl-CoA hydratase (EC 4.2.1.17) +FIG00033235 Biotin carboxylase (EC 6.3.4.14) / Biotin carboxyl carrier protein +FIG00033244 MSHA biogenesis protein MshP +FIG00033248 phi 11 orf36 homolog [SA bacteriophages 11, Mu50B] +FIG00033292 Hypothetical protein colocalized with Enterobactin receptor VctA +FIG00033367 ABC-type bacteriocin/lantibiotic exporter, contains an N-terminal double-glycine peptidase domain +FIG00033404 FIG121501: Prophage tail protein +FIG00033424 Minor curlin subunit CsgB, nucleation component of curlin monomers +FIG00033473 Methyltransferase (EC 2.1.1.-) +FIG00033484 Protein gp29 [Bacteriophage A118] +FIG00033514 Capsule synthesis positive regulator AcpB +FIG00033516 phi 11 orf37 homolog [SA bacteriophages 11, Mu50B] +FIG00033540 Transcriptional regulator of the arabinose operon in Shewanella, GntR family +FIG00033560 4-hydroxybenzoyl-CoA reductase, gamma subunit (EC 1.3.99.20) +FIG00033567 Streptococcal phospholipase A2; _Toximoron (Other) +FIG00033623 Aminoglycoside 3'-phosphotransferase 2 (EC 2.7.1.95) @ Streptomycin 3'-kinase StrB (EC 2.7.1.87) +FIG00033650 Beta-fimbriae chaperone protein +FIG00033655 Toxin co-regulated pilin A +FIG00033663 Predicted maltose transporter MalT +FIG00033680 FIG033680: Hypothetical protein +FIG00033694 Conserved hypothetical protein potentially related to ribose or hydroxymethylpyrimidine metabolism +FIG00033697 Nitric-oxide reductase (EC 1.7.99.7), quinol-dependent +FIG00033705 Biotin synthesis protein BioC +FIG00033724 hypothetical protein sometimes fused to ribosomal protein S6 glutaminyl transferase / Ribosomal protein S6 glutaminyl transferase +FIG00033748 Phenol hydroxylase, P4 oxygenase component DmpO (EC 1.14.13.7) +FIG00033758 Phosphatidylcholine synthase (EC 2.7.8.24) +FIG00033765 gliding motility protein MglA +FIG00033787 Cobalt/zinc/cadmium efflux RND transporter, membrane fusion protein, CzcB family +FIG00033837 Coenzyme F(420)H(2) dehydrogenase (methanophenazine) subunit FpoB +FIG00033847 Na(+)-translocating NADH-quinone reductase subunit B (EC 1.6.5.-) +FIG00033877 Serine transporter +FIG00033885 Xanthan biosynthesis chain length determinant protein GumC +FIG00033893 Trehalose-6-phosphate hydrolase (EC 3.2.1.93) +FIG00033897 FIG033897: hypothetical protein +FIG00033907 Cytochrome c-type biogenesis protein ResA +FIG00033944 Mercuric resistance operon coregulator +FIG00033965 Alpha-related fimbriae major subunit +FIG00033999 Toxin 1, PIN domain +FIG00034023 Hypothetical protein VpsQ +FIG00034057 Eukaryotic translation initiation factor 2 beta subunit +FIG00034059 Acetyl-CoA synthase corrinoid activation protein +FIG00034073 Proline and alanine rich protein EspK, component of Type VII secretion system ESX-1 +FIG00034170 Aminoglycoside 3'-phosphotransferase (EC 2.7.1.95) +FIG00034195 FIG032621: Hydrolase, alpha/beta hydrolase fold family +FIG00034200 Arsenic resistance protein ArsH +FIG00034257 Lipoate-protein ligase A, C-terminal 70 percent +FIG00034276 Photosystem P840 reaction center large subunit PscA +FIG00034293 Protein export cytoplasm protein SecA ATPase RNA helicase (TC 3.A.5.1.1) +FIG00034309 Transcriptional regulator in custer with plant-induced nitrilase +FIG00034376 FIG034376: Hypothetical protein +FIG00034392 UDP-N-acetylglucosamine 1-carboxyvinyltransferase (EC 2.5.1.7) +FIG00034394 Adenylyl-sulfate reductase [thioredoxin] (EC 1.8.4.10) +FIG00034420 lipopolysaccharide biosynthesis protein, putative +FIG00034445 Protein hydE +FIG00034461 Polysaccharide biosynthesis protein CpsF +FIG00034538 CRISPR-associated protein, Csm2 family +FIG00034550 Methyl coenzyme M reductase operon protein C +FIG00034561 Vibrioferrin ligase/carboxylase protein PvsA +FIG00034602 FIG034602: Probable transmembrane protein +FIG00034604 MSHA pilin protein MshD +FIG00034652 Beta-galactosidase small subunit (EC 3.2.1.23) +FIG00034655 Type IV fimbrial biogenesis protein PilX +FIG00034670 Small, acid-soluble spore protein P +FIG00034689 Paratox +FIG00034704 UDP-galactose:(galactosyl) LPS alpha1,2-galactosyltransferase WaaW (EC 2.4.1.-) +FIG00034727 Thiaminase II (EC 3.5.99.2) +FIG00034760 phi 11 orf40 homolog [SA bacteriophages 11, Mu50B] +FIG00034774 Glucokinase, ROK family (EC 2.7.1.2) +FIG00034803 Alternative cytochrome c oxidase polypeptide CoxM (EC 1.9.3.1) +FIG00034824 Vibrioferrin membrane-spanning transport protein PvsC +FIG00034851 RND efflux system, inner membrane transporter CmeB +FIG00034881 Alkaline phosphatase (EC 3.1.3.1); Type I phosphodiesterase/nucleotide pyrophosphatase precursor +FIG00034884 FtsK/SpoIIIE family protein, putative EssC component of Type VII secretion system / interrupted? +FIG00034889 Predicted erythritol ABC transporter 2, permease component +FIG00034926 Twitching motility protein PilT +FIG00034950 Alpha-related fimbriae minor subunit 1 +FIG00034968 LSU ribosomal protein L23Ae (L23p) +FIG00034970 Acetyl-coenzyme A carboxyl transferase alpha chain (EC 6.4.1.2) / Acetyl-coenzyme A carboxyl transferase beta chain (EC 6.4.1.2) / Biotin carboxylase of acetyl-CoA carboxylase (EC 6.3.4.14) / Biotin carboxyl carrier protein of acetyl-CoA carboxylase +FIG00034973 2-dehydropantoate 2-reductase (EC 1.1.1.169) +FIG00034981 Proline/sodium symporter PutP (TC 2.A.21.2.1) @ Propionate/sodium symporter +FIG00034988 Conjugative transposon protein TraQ +FIG00035008 Putative transcription antitermination protein NusG +FIG00035038 Coenzyme F(420)H(2) dehydrogenase (methanophenazine) subunit FpoK +FIG00035070 Riboflavin synthase archaeal (EC 2.5.1.9) +FIG00035092 2,3-butanediol dehydrogenase, R-alcohol forming, (R)- and (S)-acetoin-specific (EC 1.1.1.4) +FIG00035113 Aerotaxis sensor receptor protein +FIG00035126 Photosystem II protein PsbM +FIG00035130 Xanthan biosynthesis exopolysaccharide polymerase GumE +FIG00035175 Asparagine synthetase [glutamine-hydrolyzing] (EC 6.3.5.4) +FIG00035182 Ferric aerobactin ABC transporter, permease component +FIG00035187 Spore germination protein GerXC (on pXO1) +FIG00035193 Ferric siderophore transport system, biopolymer transport protein ExbB +FIG00035201 Ornithine aminotransferase (EC 2.6.1.13) +FIG00035226 Substrate-specific component NiaX of predicted niacin ECF transporter +FIG00035237 Conjugative transposon protein TraG +FIG00035246 FIG035246: DoxX family protein +FIG00035255 O antigen biosynthesis rhamnosyltransferase rfbN (EC 2.4.1.-) +FIG00035268 Rossmann fold nucleotide-binding protein Smf possibly involved in DNA uptake +FIG00035305 Related to Dihydropteroate synthase / Alternative dihydrofolate reductase 2 +FIG00035344 Predicted lactate-responsive transcriptional regulator of ykgEFG LDH gene cluster, LysR-type +FIG00035373 8-amino-7-oxononanoate synthase (EC 2.3.1.47) / CqsA +FIG00035412 BatC +FIG00035415 Chlorosome protein A; Bacteriochlorophyll c binding protein +FIG00035447 General secretion pathway protein K +FIG00035471 N5-methyltetrahydromethanopterin:coenzyme M methyltransferase subunit E (EC 2.1.1.86) +FIG00035567 N5-methyltetrahydromethanopterin:coenzyme M methyltransferase subunit G (EC 2.1.1.86) +FIG00035575 Possible D-erythrulose 4-phosphate dehydrogenase EryC (EC 1.1.1.-) +FIG00035586 FIG143263: Glycosyl transferase @ Dolichyl-phosphate mannose synthase related protein +FIG00035595 FIG035595: Phage protein +FIG00035627 Glycerol-3-phosphate cytidylyltransferase (EC 2.7.7.39) +FIG00035633 adenylate cyclase ExoY +FIG00035634 Formamidopyrimidine-DNA glycosylase (EC 3.2.2.23) +FIG00035672 UDP-N-acetyl-D-mannosaminuronate dehydrogenase +FIG00035701 Tyrosine-protein kinase EpsD (EC 2.7.10.2) +FIG00035725 LSU ribosomal protein L10e (L16p) +FIG00035759 Sulfite reduction-associated complex DsrMKJOP protein DsrK (=HmeD) +FIG00035782 ABC transporter ATP-binding protein USSDB6B +FIG00035794 DNA-directed RNA polymerase subunit A' (EC 2.7.7.6) +FIG00035800 Ferrous iron transport protein A, putative +FIG00035803 Predicted mannose transporter, GGP family +FIG00035825 Biotin synthase (EC 2.8.1.6) / Adenosylmethionine-8-amino-7-oxononanoate aminotransferase (EC 2.6.1.62) +FIG00035830 FIG035830: Two-component system regulatory protein +FIG00035876 COG1399 protein in cluster with ribosomal protein L32p, Bacteroidetes/Chlorobi subfamily +FIG00035893 Nickel ABC transporter, periplasmic nickel-binding protein NikA (TC 3.A.1.5.3) +FIG00035934 Ferric enterobactin-binding periplasmic protein FepB (TC 3.A.1.14.2) +FIG00035950 Predicted erythritol ABC transporter 2, ATP-binding component +FIG00036015 Phage tail fiber assembly protein +FIG00036144 Putative Zn-dependent hydrolase in polyisoprenoid biosynthetic cluster +FIG00036176 Iron(III) dicitrate transport protein FecA +FIG00036183 FIG036183: Transcriptional regulator, XRE family +FIG00036219 ABC alpha-glucoside transporter, inner membrane subunit AglF +FIG00036220 Xanthan biosynthesis glycosyltransferase GumI +FIG00036222 Zinc binding domain / DNA primase (EC 2.7.7.-), Phage P4-associated / Replicative helicase RepA, Phage P4-associated +FIG00036224 Sialidase (EC 3.2.1.18) +FIG00036235 Protein gp49, replication initiation [Bacteriophage A118] +FIG00036279 Type III restriction-modification system StyLTI enzyme res (EC 3.1.21.5) +FIG00036284 Flagellin protein FlaE +FIG00036306 3,4-dihydroxy-2-butanone 4-phosphate synthase (EC 4.1.99.12) / GTP cyclohydrolase II (EC 3.5.4.25) +FIG00036320 Alpha-1,4-N-acetylgalactosamine transferase PglJ (EC 2.4.1.-) +FIG00036335 Putative amidotransferase (Type 1 glutamine amidotransferase - GATase1) +FIG00036347 TRAP dicarboxylate transporter, DctM subunit, unknown substrate 4 +FIG00036375 hydrogenase/sulfur reductase, delta subunit +FIG00036406 Survival protein SurA precursor (Peptidyl-prolyl cis-trans isomerase SurA) (EC 5.2.1.8) +FIG00036410 Biotin--protein ligase (EC 6.3.4.9, EC 6.3.4.10, EC 6.3.4.11, EC 6.3.4.15) / Pantothenate kinase type III, CoaX-like (EC 2.7.1.33) +FIG00036444 Dihydrolipoamide dehydrogenase of pyruvate dehydrogenase complex (EC 1.8.1.4); Dihydrolipoamide dehydrogenase (EC 1.8.1.4) +FIG00036445 Hypothetical protein, PV83 orf22 homolog [SA bacteriophages 11, Mu50B] +FIG00036490 Non-ribosomal peptide synthetase modules, pyoverdine?? +FIG00036497 phi 11 orf38 homolog [SA bacteriophages 11, Mu50B] +FIG00036553 Gluconokinase (EC 2.7.1.12) / oxidoreductase domain +FIG00036605 LysR-family transcriptional regulator SinR +FIG00036655 Extracellular solute binding protein ScrB +FIG00036726 Protein gp7 [Bacteriophage A118] +FIG00036757 FIG036757: Plasmid-related protein +FIG00036771 TesB-like acyl-CoA thioesterase 1 +FIG00036772 Arabinan endo-1,5-alpha-L-arabinosidase (EC 3.2.1.99) +FIG00036793 Glycosyl transferase CpsG +FIG00036805 Sporulation regulatory protein WhiD +FIG00036831 Circadian clock protein KaiA +FIG00036938 Glycosyltransferase (EC 2.4.1.-), group 1 family protein; Putative UDP-dependent alpha-galactosyltransferase, GalT +FIG00036967 Putative uncharacterized protein BCG_3619c +FIG00036983 Metallo-beta-lactamase family protein, RNA-specific +FIG00036997 Na(+)-translocating NADH-quinone reductase subunit C (EC 1.6.5.-) +FIG00037033 Antitoxin 1 +FIG00037038 Monooxygenase, FAD- and [2Fe-2S]-containing component B +FIG00037045 Possible alpha/beta hydrolase superfamily, slr1235 homolog +FIG00037057 Xanthan biosynthesis oligosaccharidyl-lipid flippase GumJ +FIG00037073 PTS system, N-acetylglucosamine-specific IIA component +FIG00037099 Sensory box sensor histidine kinase/response regulator VieS +FIG00037127 FIG037127: Two-component system sensor protein +FIG00037139 Transcriptional regulator HxlR, formaldehyde assimilation +FIG00037155 Biphenyl-2,3-diol 1,2-dioxygenase (EC 1.13.11.39) +FIG00037161 Conjugative transposon protein TraE +FIG00037195 Iron-sulfur cluster assembly protein SufB @ intein-containing +FIG00037240 Alpha-N-arabinofuranosidase 2 (EC 3.2.1.55) +FIG00037273 SSU ribosomal protein S2p (SAe) +FIG00037278 Acetoin dehydrogenase E1 component alpha-subunit (EC 1.2.4.-) / Acetoin dehydrogenase E1 component beta-subunit (EC 1.2.4.-) +FIG00037316 Benzoate transport, inner-membrane translocator +FIG00037387 Coenzyme F(420)H(2) dehydrogenase (methanophenazine) subunit FpoN +FIG00037409 Phycoerythrobilin:ferredoxin oxidoreductase PebB (EC 1.3.7.3) +FIG00037412 ATP-dependent RNA helicase VVA0939 +FIG00037431 DNA repair protein RadC +FIG00037439 Lycopene cyclase, CruA type +FIG00037470 Formylmethanofuran dehydrogenase (molybdenum) subunit D (EC 1.2.99.5) +FIG00037488 FIG001590: Putative conserved exported protein precursor +FIG00037496 Predicted D-glucarate or D-galactorate regulator, GntR family +FIG00037500 Phage minor capsid protein +FIG00037502 HrcQ protein +FIG00037535 Type III secretion protein SsaG +FIG00037541 Methanophenazine hydrogenase cytochrome b subunit (EC 1.12.98.3) +FIG00037562 Glutathione-dependent formaldehyde-activating enzyme (EC 4.4.1.22) +FIG00037687 Fimbrial assembly protein FimB +FIG00037697 Isopentenyl phosphate kinase +FIG00037735 Actin-ADP-ribosyltransferase, toxin SpvB +FIG00037741 COG2106 Methylase +FIG00037745 Type III secretion outermembrane negative regulator of secretion (TyeA) +FIG00037794 Uncharacterized protein MJ0498 +FIG00037808 Type III secretion chaperone protein for YopT (SycT) +FIG00037819 UPF0129 protein MJ1474 +FIG00037830 Phosphate-specific outer membrane porin OprP +FIG00037943 Capsular polysaccharide transcription antitermination protein, UpxY family +FIG00037962 LysR family transcriptional regulator PA0191 +FIG00037995 FIG037995: Hypothetical protein +FIG00037998 Putative lumenal protein, contains 8 pentapeptide repeats, sll0301 homolog +FIG00038030 Putative PpiC-type peptidyl-prolyl cis-trans isomerase precursor associated with VreARI signaling system +FIG00038055 Lipopolysaccharide core biosynthesis protein RfaS +FIG00038079 Siderophore [Alcaligin-like] biosynthesis complex, medium chain @ Siderophore synthetase large component, acetyltransferase +FIG00038121 Sigma factor regulator VreR (cytoplasmic membrane-localized) of trans-envelope signaling system +FIG00038155 Major pilus subunit of type IV secretion complex (VirB2) +FIG00038156 CblY, a non-orthologous displasment for Alpha-ribazole-5'-phosphate phosphatase +FIG00038193 NADH-ubiquinone oxidoreductase chain G2 (EC 1.6.5.3); Formate dehydrogenase putative subunit (EC 1.2.1.2) +FIG00038245 FIG124007: hypothetical protein +FIG00038273 PhaK-like protein +FIG00038336 N5-methyltetrahydromethanopterin:coenzyme M methyltransferase subunit A (EC 2.1.1.86) +FIG00038343 Alfa-L-rhamnosidase (EC 3.2.1.40) +FIG00038371 Novel Xylose regulator from LacI family +FIG00038393 tRNA m5C48-49 methylase +FIG00038402 ATP-binding protein p271 +FIG00038410 LSU ribosomal protein L37e +FIG00038415 FIG039767: hypothetical protein +FIG00038436 Putative oxidoreductase YcjS (EC 1.-.-.-), NADH-binding +FIG00038456 Pyrimidine-nucleoside phosphorylase (EC 2.4.2.2) +FIG00038461 Putative deoxyribonuclease YjjV +FIG00038502 Hypothetical SAV0799 homolog in superantigen-encoding pathogenicity islands SaPI +FIG00038504 Sulfur oxidation molybdopterin C protein +FIG00038531 Oligosaccharide repeat unit polymerase Wzy; O-antigen ligase +FIG00038572 Membrane bound hydrogenase, MbhA subunit +FIG00038611 Succinyl-CoA ligase [ADP-forming] alpha chain (EC 6.2.1.5) +FIG00038619 Benzoate catabolic operon transcription regulator +FIG00038650 Coenzyme F420 hydrogenase gamma subunit (FrcG) (EC 1.12.98.1) +FIG00038653 Predicted L-fucose-specific phosphotransferase system, EIIB component +FIG00038668 Thiamin-phosphate pyrophosphorylase (EC 2.5.1.3) / Hydroxymethylpyrimidine phosphate kinase ThiD (EC 2.7.4.7) +FIG00038683 DNA-directed RNA polymerase subunit A'' (EC 2.7.7.6) +FIG00038726 Ferric siderophore transport system, periplasmic binding protein TonB +FIG00038814 RNA polymerase sigma factor RpoD +FIG00038920 Alpha-L-fucosidase (EC 3.2.1.51) +FIG00038955 Type III secretion cytoplasmic protein (YscI) +FIG00038982 FIG038982: hypothetical protein +FIG00038983 Extracellular Matrix protein PslJ +FIG00038996 Antitoxin 1a +FIG00039061 FIG039061: hypothetical protein related to heme utilization +FIG00039067 Nitrilotriacetate monooxygenase component B (EC 1.14.13.-) +FIG00039068 Competence protein C; Chromosome segregation ATPases +FIG00039076 Putative pertussis-like toxin subunit PtlA (EC 2.4.2.-) +FIG00039085 Mlr0777 protein +FIG00039112 Putative uncharacterized protein in cluster with two glycosyl transferases +FIG00039155 Lmo0065 homolog within ESAT-6 gene cluster +FIG00039156 SSU ribosomal protein S24e +FIG00039210 DNA replication helicase protein MCM +FIG00039386 UPF0288 protein MJ1412 +FIG00039403 Membrane bound hydrogenase, MbhG subunit +FIG00039439 Type III secretion negative modulator of injection (YopK,YopQ,controls size of translocator pore) +FIG00039442 Type III secretion cytoplasmic LcrG inhibitor (LcrV,secretion and targeting control protein, V antigen) +FIG00039465 Additional component NikL of nickel ECF transporter +FIG00039496 Distant homolog of E. coli HemX protein in Xanthomonadaceae +FIG00039521 Iron siderophore sensor protein +FIG00039527 Ketoisovalerate oxidoreductase subunit VorD (EC 1.2.7.7) +FIG00039528 2',3'-cyclic-nucleotide 2'-phosphodiesterase (EC 3.1.4.16) +FIG00039538 3-oxoacyl-(acyl carrier protein) synthase (EC 2.3.1.41) +FIG00039628 "phi-Carotenoid synthase" (EC 1.3.-.- and EC 2.1.1-) +FIG00039631 Uncharacterized protein MJ0404 +FIG00039685 Cytochrome b6-f complex alternative Rieske iron sulfur protein PetC3 +FIG00039709 Thiamin-regulated outer membrane receptor Omr1 +FIG00039723 Uncharacterized protein homologous to Paeru. PA2364 +FIG00039748 Candidate gene for the hypothesized phosphomevalonate decarboxylase; COG1355, Predicted dioxygenase +FIG00039750 N5-methyltetrahydromethanopterin:coenzyme M methyltransferase subunit B (EC 2.1.1.86) +FIG00039855 ATPase component of general energizing module of ECF transporters / ATPase component of general energizing module of ECF transporters +FIG00039857 Biotin synthesis protein BioG / Biotin synthesis protein BioC +FIG00039918 Geranylgeranyl diphosphate reductase (EC 1.3.1.83) +FIG00039921 Nitrogenase (molybdenum-iron) reductase and maturation protein NifH +FIG00039923 NifT protein +FIG00039935 Parvulin-like peptidyl-prolyl isomerase +FIG00039944 Capsular polysaccharide biosynthesis protein CpsK(V) +FIG00039951 Membrane bound hydrogenase, MbhE subunit +FIG00039969 CRISPR-associated protein, Csm5 family +FIG00039983 Tol biopolymer transport system, TolR protein +FIG00039986 Kef-type K+ transport systems (NAD-binding component fused to domain related to exopolyphosphatase) +FIG00040003 LSU ribosomal protein L23e (L14p) +FIG00040011 Tetrahydromethanopterin:alpha-L-glutamate ligase +FIG00040124 Toxin co-regulated pilus biosynthesis protein E, anchors TcpT to membrane +FIG00040173 Urea carboxylase-related ABC transporter, permease protein +FIG00040177 Competence-stimulating peptide ABC transporter permease protein ComB +FIG00040209 Tetrachloroethene reductive dehalogenase TceA +FIG00040212 O-phosphoseryl-tRNA(Cys) synthetase +FIG00040232 L-beta-lysine 5,6-aminomutase alpha subunit (EC 5.4.3.3) +FIG00040241 ATP synthase beta chain (EC 3.6.3.14) +FIG00040248 ATPase component BioM of energizing module of biotin ECF transporter +FIG00040274 ATP-dependent protease LonB-like Type I +FIG00040288 Fosfomycin resistance protein FosA +FIG00040315 Type III secretion negative regulator of effector production protein (LcrQ,YscM, YscM1 and YscM2) +FIG00040317 Rhodanese domain protein UPF0176, Rickettsiales subgroup +FIG00040344 Subtilase family domain protein +FIG00040371 Iron-dependent repressor IdeR/DtxR +FIG00040421 Autoinducer 2 (AI-2) kinase LsrK (EC 2.7.1.-) +FIG00040508 Competence-stimulating peptide ABC transporter ATP-binding protein ComA +FIG00040519 Formylmethanofuran dehydrogenase (molybdenum) operon gene E +FIG00040528 Shikimate/quinate 5-dehydrogenase I beta (EC 1.1.1.282) +FIG00040555 Mercuric transport protein, MerC +FIG00040605 transferase, hexapeptide repeat family +FIG00040610 Type III secretion transporter lipoprotein (YscW,VirG) +FIG00040657 Coenzyme F420 hydrogenase beta subunit (FrcB) (EC 1.12.98.1) +FIG00040689 GldB +FIG00040704 Uncharacterized protein MJ0802 +FIG00040719 Coenzyme F420-reducing hydrogenase, gamma subunit +FIG00040766 Type III secretion negative modulator of injection (YopK,YopQ,controls size of translocator pore) +FIG00040809 Related to Dihydropteroate synthase +FIG00040817 Sugar diacid utilization regulator SdaR +FIG00040824 Propionate kinase, propanediol utilization (EC 2.7.2.1) +FIG00040837 Uncharacterized protein MJ0800 +FIG00040843 Hexuronate transporter +FIG00040858 Additional periplasmic component NikK of nickel ECF transporter +FIG00040870 CoB--CoM heterodisulfide reductase subunit A (EC 1.8.98.1) +FIG00040890 tRNA-dependent lipid II-Ala--L-alanine ligase +FIG00040972 Lipoate-protein ligase A, N-terminal 30 percent +FIG00040974 Type III secretion cytoplasmic protein (YscK) +FIG00041008 Cytidylate kinase (EC 2.7.4.25) +FIG00041027 Possible subunit variant of phosphoribosylaminoimidazolecarboxamide formyltransferase [alternate form] +FIG00041038 DNA polymerase III alpha subunit (EC 2.7.7.7) +FIG00041054 Transcriptional activator GpuR +FIG00041073 PTS system, tagatose-specific IIA-TPr component (EC 2.7.1.69) +FIG00041103 Flagella-related protein FlaG +FIG00041137 Transmembrane component CbiQ of energizing module of cobalt ECF transporter +FIG00041163 Spore coat protein X +FIG00041164 Additional substrate-specific component CbiN of cobalt ECF transporter +FIG00041210 Ribose-1,5-bisphosphate isomerase +FIG00041229 Phenazine biosynthesis protein PhzA +FIG00041266 FIG041266: ATP-dependent nuclease subunit B +FIG00041289 probable dibenzothiophene desulfurization enzyme +FIG00041301 FIG041301: Hypothetical protein +FIG00041353 LSU ribosomal protein L26e (L24p) +FIG00041363 Type IV pilus biogenesis protein PilM / Competence protein PilM +FIG00041382 Anaerobic dehydrogenases, typically selenocysteine-containing +FIG00041388 FIG041388: hypothetical protein in PFGI-1-like cluster +FIG00041424 Extracellular Matrix protein PelA +FIG00041431 Light-harvesting LHI, beta subunit +FIG00041435 Transcriptional regulator NfxB +FIG00041460 Uncharacterized HTH-type transcriptional regulator MJ0272 +FIG00041549 Coenzyme B synthesis from 2-oxoglutarate: steps 1, 6, and 10 +FIG00041566 Gating protein PPE68, component of Type VII secretion system ESX-1 +FIG00041571 Ribonuclease I precursor (EC 3.1.27.6) +FIG00041575 Coenzyme F(420)H(2) dehydrogenase (methanophenazine) subunit FpoI +FIG00041629 N5-methyltetrahydromethanopterin:coenzyme M methyltransferase subunit X +FIG00041642 Protein gp55 [Bacteriophage A118] +FIG00041648 Type III secretion cytoplasmic protein (YscL) +FIG00041680 Mlr0789 protein +FIG00041724 Coenzyme F(420)H(2) dehydrogenase (methanophenazine) subunit FpoM +FIG00041735 Cobalt-zinc-cadmium resistance protein CzcA +FIG00041811 cb-type cytochrome c oxidase subunit IV [EC:1.9.3.1] +FIG00041818 Uncharacterized protein MJ0094 +FIG00041819 N-acylglucosamine 2-epimerase (EC 5.1.3.8) +FIG00041823 RelE/StbE replicon stabilization toxin +FIG00041831 Dimethylallyltransferase (EC 2.5.1.1) / (2E,6E)-farnesyl diphosphate synthase (EC 2.5.1.10) / Farnesyltranstransferase (EC 2.5.1.29) +FIG00041851 Protein gp37 [Bacteriophage A118] +FIG00041881 Light-harvesting LHI, alpha subunit +FIG00041887 Cytochrome c oxidase polypeptide II (EC 1.9.3.1) +FIG00041920 BlpT protein, fusion +FIG00041927 4-oxalomesaconate hydratase (EC 4.2.1.83) +FIG00041967 Cell surface protein Shp, transfers heme from hemoglobin to apo-SiaA/HtsA / Heme ABC transporter (Streptococcus), heme and hemoglobin-binding protein SiaA/HtsA +FIG00041974 Nucleoside binding-domain containing protein +FIG00041985 IncF plasmid conjugative transfer protein TraP +FIG00041993 MazG protein domain +FIG00042023 Capsular polysaccharide synthesis enzyme Cap8I +FIG00042070 Type III secretion protein (YscE) +FIG00042074 2-hydroxymuconic semialdehyde hydrolase (EC 3.7.1.9) +FIG00042083 Protein gp65 [Bacteriophage A118] +FIG00042179 Pyrimidine ABC transporter, transmembrane component 1 +FIG00042188 Dihydroflavonol-4-reductase (EC 1.1.1.219) +FIG00042254 nonspecific lipid-transfer protein (acethyl CoA synthetase) +FIG00042267 GMP synthase [glutamine-hydrolyzing] (EC 6.3.5.2) +FIG00042275 ABC transport system, permease component YbhR +FIG00042311 Capsular polysaccharide ABC transporter, ATP-binding protein KpsT +FIG00042351 General secretion pathway protein L +FIG00042375 Digeranylgeranylglycerophospholipid reductase +FIG00042413 Protein clustered with O-phosphoseryl-tRNA(Cys) synthetase +FIG00042414 Formylmethanofuran dehydrogenase (molybdenum) subunit C (EC 1.2.99.5) +FIG00042457 Threonyl-tRNA synthetase fragment +FIG00042495 6-phosphofructokinase (EC 2.7.1.11), PF08013 family +FIG00042504 Putative snRNP Sm-like protein +FIG00042507 Hypothetical protein associated with short form of CcmH +FIG00042530 Type III secretion inner membrane protein (YscD,homologous to flagellar export components) +FIG00042556 Eukaryotic translation initiation factor 2 gamma subunit +FIG00042581 Internalin-like protein (LPXTG motif) Lmo0801 homolog +FIG00042594 FIG042594: DUF1550 domain-containing protein +FIG00042616 Dihydroxyacetone kinase family protein +FIG00042627 Magnesium and cobalt efflux protein CorC +FIG00042639 NifZ protein +FIG00042640 Choline ABC transporter permease protein +FIG00042691 Molybdopterin biosynthesis protein MoeA / Periplasmic molybdate-binding domain +FIG00042768 Sodium - Bile acid symporter +FIG00042777 GTP-binding protein RBG1/RBG2 +FIG00042781 Indolepyruvate oxidoreductase subunit IorB (EC 1.2.7.8) +FIG00042791 Putative EsaC protein analog (Listeria type 1) +FIG00042847 Similar to tRNA pseudouridine synthase C, group TruC1 +FIG00042860 Methanol:corrinoid methyltransferase +FIG00042865 Predicted transcriptional regulator of NADH dehydrogenase, Rrf2 family +FIG00042908 Sigma-54 dependent DNA-binding response regulator +FIG00042921 FIG042921: similarity to aminoacyl-tRNA editing enzymes YbaK, ProX +FIG00042966 Outer membrane porin, coexpressed with pyoverdine biosynthesis regulon +FIG00042970 Protein gp40 [Bacteriophage A118] +FIG00043030 Exodeoxyribonuclease V beta chain (EC 3.1.11.5) +FIG00043083 Cytochrome b6-f complex alternative Rieske iron sulfur protein PetC2 +FIG00043116 Homocitrate synthase (EC 2.3.3.14) +FIG00043159 Putative glutathione transporter,solute-binding component +FIG00043161 Streptococcal pyrogenic exotoxin H (SpeH); _Toximoron (Superantigen) +FIG00043183 Nitrogenase (vanadium-iron) alpha chain (EC 1.18.6.1) +FIG00043197 FIG043197: Inositol monophosphatase family protein +FIG00043221 DotB protein +FIG00043252 SAM radical protein, elongator protein +FIG00043259 Myo-inositol 2-dehydrogenase 1 (EC 1.1.1.18) +FIG00043262 WARNINIG TorE protein +FIG00043265 hydrogenase/sulfur reductase, alpha subunit +FIG00043285 Nitrite reductase accessory protein NirV +FIG00043289 Type III secretion spans bacterial envelope protein (YscG) +FIG00043329 DNA-binding domain of ModE +FIG00043362 Uncharacterized protein, Bsl7517 homolog +FIG00043373 Putative peptidoglycan bound protein (LPXTG motif) Lmo2179 homolog +FIG00043398 Putative regulatory protein associated with the ectoine operon +FIG00043400 TRAP dicarboxylate transporter, DctQ subunit, unknown substrate 4 +FIG00043402 Dipeptidyl peptidase IV in 4-hydroxyproline catabolic gene cluster +FIG00043458 DedA family membrane protein +FIG00043470 Acetyl-CoA synthetase (ADP-forming) alpha chain (EC 6.2.1.13) +FIG00043476 preQ1-regulated inosine-uridine nucleoside hydrolase (EC 3.2.2.1) +FIG00043517 putative type III secretion protein SycN +FIG00043519 Type III secretion low calcium response protein (LcrR) +FIG00043527 Neuraminidase NanP +FIG00043547 Lipoteichoic acid synthase LtaS Type IIa +FIG00043564 Fe-S-cluster-containing hydrogenase components 2 +FIG00043603 3,5-diaminohexanoate dehydrogenase (EC 1.4.1.11) +FIG00043624 Sigma factor PvdS, controling pyoverdin biosynthesis +FIG00043657 Replication factor C large subunit +FIG00043664 Lipoprotein involved in the synthesis of group B streptococcal carboyhdrate antigen +FIG00043716 Sarcosine dehydrogenase (EC 1.5.99.1) +FIG00043717 Folate-dependent protein for Fe/S cluster synthesis/repair in oxidative stress +FIG00043720 Delta-1-pyrroline-5-carboxylate dehydrogenase (EC 1.5.1.12) +FIG00043723 Aerobic glycerol-3-phosphate dehydrogenase (EC 1.1.5.3) +FIG00043740 Coenzyme F(420)H(2) dehydrogenase (methanophenazine) subunit FpoJ2 +FIG00043758 COG2078: Uncharacterized ACR +FIG00043763 TsaB protein, required for threonylcarbamoyladenosine (t(6)A) formation in tRNA / Ribosomal-protein-S18p-alanine acetyltransferase (EC 2.3.1.-) +FIG00043765 Maltose phosphorylase (EC 2.4.1.8) / Trehalose phosphorylase (EC 2.4.1.64) +FIG00043778 FIG043778: hypothetical protein +FIG00043809 Virulence protein pGP4-D +FIG00043852 2-deoxy-D-gluconate 3-dehydrogenase (EC 1.1.1.125) +FIG00043861 Methylcobalamin:coenzyme M methyltransferase, methanol-specific +FIG00043886 Type III secretion injected virulence protein (YopE); SipA +FIG00043905 CoB--CoM heterodisulfide reductase 2 subunit E (EC 1.8.98.1) +FIG00043922 alginate biosynthesis protein AlgJ +FIG00043932 Accessory colonization factor AcfC +FIG00043988 Substrate-specific component NikM of nickel ECF transporter +FIG00043992 Coenzyme F(420)H(2) dehydrogenase (methanophenazine) subunit FpoL +FIG00044004 Choline-binding lipoprotein +FIG00044008 FIG00432558: hypothetical protein +FIG00044013 Low molecular weight protein-tyrosine-phosphatase Wzb (EC 3.1.3.48) +FIG00044032 Thioesterase PvdG involved in non-ribosomal peptide biosynthesis +FIG00044041 Type III secretion cytoplasmic plug protein (LcrG) +FIG00044059 Ferric hydroxamate ABC transporter (TC 3.A.1.14.3), ATP-binding protein FhuC +FIG00044093 Sepiapterin reductase (EC 1.1.1.153) +FIG00044241 FldA protein +FIG00044258 2-isopropylmalate synthase (EC 2.3.3.13); Homocitrate synthase (EC 2.3.3.14) +FIG00044377 Lactyl (2) diphospho-(5')guanosine:7,8-didemethyl-8-hydroxy-5-deazariboflavin 2-phospho-L-lactate transferase +FIG00044389 Type III secretion protein EprH +FIG00044391 Transcriptional repressor of nif and glnA operons +FIG00044407 Proline and alanine rich protein EspI, component of Type VII secretion system ESX-1 +FIG00044478 Phosphoribosylformimino-5-aminoimidazole carboxamide ribotide isomerase (EC 5.3.1.16) +FIG00044513 Glutathione-regulated potassium-efflux system protein KefKL +FIG00044522 Serine/threonine protein kinase (EC 2.7.11.1) PpkA +FIG00044533 Methyl coenzyme M reductase system component A2 homolog +FIG00044564 HigB toxin protein +FIG00044619 Similarity with yeast transcription factor IIIC Tau subunit that binds B-block elements of class III promoters +FIG00044622 Ribonucleotide reductase of class III (anaerobic), large subunit (EC 1.17.4.2) +FIG00044633 Formylmethanofuran dehydrogenase subunit D (EC 1.2.99.5) +FIG00044693 Flagella-related protein FlaC +FIG00044735 Aminopeptidase S (Leu, Val, Phe, Tyr preference) (EC 3.4.11.24) +FIG00044761 Drug/metabolite transporter (DMT) superfamily protein +FIG00044804 Hydrolase in cluster with beta-lactamase (HAD superfamily) +FIG00044810 Transcriptional regulator, lysR family +FIG00044817 RNA polymerase sigma-70 factor, ECF family +FIG00044820 (AF179595) Vco33 +FIG00044859 Cytochrome c-type heme lyase subunit nrfF, nitrite reductase complex assembly / Cytochrome c-type heme lyase subunit nrfG, nitrite reductase complex assembly +FIG00044883 LSU ribosomal protein P0 (L10p) +FIG00044893 Glutathione S-transferase, unnamed subgroup 2 (EC 2.5.1.18) +FIG00044984 DNA topoisomerase VI subunit B (EC 5.99.1.3) +FIG00045022 GTP-binding protein, gtp1/obg family +FIG00045085 FIG045085: Hypothetical protein +FIG00045144 Methionine ABC transporter permease protein +FIG00045177 IncI1 plasmid conjugative transfer protein TraW +FIG00045183 Uridine kinase family protein +FIG00045255 Cell envelope-bound metalloprotease, Camelysin (EC 3.4.24.-) +FIG00045287 5'-methylthioadenosine/S-adenosylhomocysteine nucleosidase related protein BCZK2595 / hydrolase, haloacid dehalogenase-like family protein BCZK2594 +FIG00045341 Phosphate starvation-inducible protein PhoH, predicted ATPase +FIG00045374 FIG045374: Type II restriction enzyme, methylase subunit YeeA +FIG00045393 Dipeptide transport ATP-binding protein DppF (TC 3.A.1.5.2) +FIG00045397 Conserved hypothetical protein probably involved in assimilatory sulfate reduction +FIG00045408 Membrane bound hydrogenase, MbhF subunit +FIG00045413 Glycerol uptake facilitator protein +FIG00045491 TRAP dicarboxylate transporter, DctQ subunit, unknown substrate 5 +FIG00045507 CblX, a non-orthologous displasment for Alpha-ribazole-5'-phosphate phosphatase +FIG00045545 D-arabino-3-hexulose 6-phosphate formaldehyde lyase / Hypothetical protein with distant similarity to Ribonuclease E inhibitor RraA (former MenG) +FIG00045575 O-antigen export system, permease protein +FIG00045581 10 kDa culture filtrate antigen CFP-10 (EsxB) +FIG00045677 FIG071147: hypothetical protein +FIG00045761 Protocatechuate 4,5-dioxygenase alpha chain (EC 1.13.11.8) +FIG00045814 TRAP-type transport system, large permease component, predicted N-acetylneuraminate transporter +FIG00045853 Fap amyloid fibril minor component +FIG00045881 Universal stress protein family 2 +FIG00045902 Multidrug resistance efflux pump PmrA +FIG00045930 Membrane bound hydrogenase, NiFe-hydrogenase MbhK +FIG00046007 Cobalamin biosynthesis protein CbiG / Cobalt-precorrin-4 C11-methyltransferase (EC 2.1.1.133) +FIG00046123 Virulence plasmid protein pGP3-D +FIG00046134 Phosphopantetheine adenylyltransferase, type II eukaryotic (EC 2.7.7.3) +FIG00046135 Pyrophosphate-specific outer membrane porin OprO +FIG00046171 Ribonuclease P protein component 3 (EC 3.1.26.5) +FIG00046179 Lysine-arginine-ornithine-binding periplasmic protein precursor (TC 3.A.1.3.1) +FIG00046195 Type III restriction-modification system DNA endonuclease res (EC 3.1.21.5) +FIG00046200 Cobalt-precorrin-3b C17-methyltransferase / Cobalt-precorrin-8x methylmutase (EC 5.4.1.2) +FIG00046218 tRNA pseudouridine 13 synthase (EC 4.2.1.-) +FIG00046227 Translation initiation factor 1A +FIG00046230 PQS biosynthesis protein PqsB, similar to 3-oxoacyl-[acyl-carrier-protein] synthase III +FIG00046247 FIG118045: Phage immunity repressor protein +FIG00046270 IncF plasmid conjugative transfer protein TrbG +FIG00046271 Uncharacterized protein MJ0157 +FIG00046335 Hemolysin-related protein Vcp +FIG00046358 Transport ATP-binding protein CydC +FIG00046424 Capsular polysaccharide repeat unit transporter CpsL +FIG00046451 N-acetyl-lysine aminotransferase (EC 2.6.1.-) +FIG00046459 Myo-inositol 2-dehydrogenase 2 (EC 1.1.1.18) +FIG00046494 N-acetyl-lysine deacetylase (EC 3.5.1.-) +FIG00046509 Transcriptional repressor of aerobactin receptor iutR +FIG00046540 FIG046540: CBS domain protein +FIG00046548 FMN adenylyltransferase, type 3 archaeal (EC 2.7.7.2) +FIG00046591 (3R)-hydroxymyristoyl-[ACP] dehydratase (EC 4.2.1.-) +FIG00046597 Ribonuclease P protein component 2 (EC 3.1.26.5) +FIG00046614 Hypothetical zinc-type alcohol dehydrogenase-like protein YdjJ +FIG00046640 SAG1025 homolog within ESAT-6 gene cluster +FIG00046703 UDP-4-amino-4-deoxy-L-arabinose--oxoglutarate aminotransferase (EC 2.6.1.-) +FIG00046709 FIG046709: Hypothetical protein +FIG00046742 Potassium-transporting ATPase B chain (EC 3.6.3.12) (TC 3.A.3.7.1) +FIG00046771 LSU ribosomal protein L35e (L29p) +FIG00046874 Conserved domain protein in cluster with two glycosyl transferases +FIG00046902 Glutamine synthetase, clostridia type (EC 6.3.1.2) +FIG00046929 Cell division protein FtsI [Peptidoglycan synthetase] (EC 2.4.1.129) +FIG00046941 Programmed cell death antitoxin MazE like +FIG00047056 UDP-N-acetylglucosamine--N-acetylmuramyl-(pentapeptide) pyrophosphoryl-undecaprenol N-acetylglucosamine transferase (EC 2.4.1.227) +FIG00047081 Ferric receptor CfrA +FIG00047111 Osmoprotectant ABC transporter binding protein YehZ +FIG00047117 Transcription regulator of multidrug efflux pump operon, TetR (AcrR) family +FIG00047207 ATP/GTP-binding site motif A +FIG00047213 Outer membrane lipoprotein e (P4) / NMN 5'-nucleotidase, extracellular (EC 3.1.3.5) +FIG00047230 Extracellular Matrix protein PelB +FIG00047247 Type III secretion injected virulence protein (EC 3.4.22.-,YopT,cysteine protease,depolymerizes actin filaments of cytoskeleton,causes cytotoxicity) +FIG00047313 N5-methyltetrahydromethanopterin:coenzyme M methyltransferase subunit F (EC 2.1.1.86) +FIG00047325 Carboxysome protein CcmL +FIG00047336 L-beta-lysine 5,6-aminomutase beta subunit (EC 5.4.3.3) +FIG00047393 Capsular polysaccharide synthesis enzyme Cap8H +FIG00047414 GTP pyrophosphokinase (EC 2.7.6.5), (p)ppGpp synthetase I +FIG00047463 Predicted cobalt transporter in Bacteroides_Porphyromonas +FIG00047509 Methionine ABC transporter substrate-binding protein +FIG00047512 Type III secretion effector protein (YopR, encoded by YscH) +FIG00047514 Protein EspD, component of Type VII secretion system ESX-1 +FIG00047529 Sensor protein PhoQ (EC 2.7.13.3) +FIG00047557 ABC transporter in pyoverdin gene cluster, periplasmic component +FIG00047571 Phenazine-specific methyltransferase PhzM +FIG00047587 Tail fiber protein [SA bacteriophages 11, Mu50B] +FIG00047589 VgrG-3 protein +FIG00047602 Possible alpha/beta hydrolase superfamily, sll1129 homolog +FIG00047633 Putative RNA-binding protein COG1094 +FIG00047650 Transcription factor S +FIG00047657 Beta-lactamase (Cephalosporinase) (EC 3.5.2.6) +FIG00047664 cyclolysin secretion ATP-binding protein +FIG00047674 Exodeoxyribonuclease V alpha chain (EC 3.1.11.5) +FIG00047706 Programmed cell death toxin MazF like +FIG00047750 Extracellular Matrix protein PslL +FIG00047828 RNase L inhibitor +FIG00047830 DNA-directed RNA polymerase subunit B'' (EC 2.7.7.6) +FIG00047879 Phosphoglycerate mutase family (Rhiz) +FIG00047926 Hypothetical SAV0794 homolog in superantigen-encoding pathogenicity islands SaPI +FIG00047936 Energy conserving hydrogenase Eha large subunit homolog (protein O) +FIG00047993 Protein acetyltransferase +FIG00048004 Cytochrome c heme lyase subunit CcmH; short form +FIG00048014 Fumarate reductase flavoprotein subunit (EC 1.3.99.1) +FIG00048049 DNA-directed RNA polymerase subunit P (EC 2.7.7.6) +FIG00048108 Filamentous haemagglutinin family outer membrane protein associated with VreARI signalling system +FIG00048122 6 kDa early secretory antigenic target ESAT-6 (EsxA) +FIG00048145 Putative DAK transcriptional regulator / Putative dihydroxyacetone kinase (EC 2.7.1.29), dihydroxyacetone binding subunit +FIG00048195 Sirohydrochlorin cobaltochelatase (EC 4.99.1.3) / Putative 2Fe-2S ferredoxin CbiW involved in B12 biosynthesis +FIG00048208 hypothetical protein related to DNA replication/repair +FIG00048242 Capsular polysaccharide synthesis enzyme Cap8J +FIG00048251 Streptococcal pyrogenic exotoxin K (SpeK) +FIG00048268 Membrane protein associated with methylmalonyl-CoA decarboxylase +FIG00048303 Protein gp68 [Bacteriophage A118] +FIG00048406 FIG050068: DNA-binding protein +FIG00048453 Single-stranded-DNA-specific exonuclease RecJ, clostridial paralog +FIG00048465 Urea carboxylase-related amino acid permease +FIG00048507 Catabolite control protein A +FIG00048518 Sulfopyruvate decarboxylase - alpha subunit (EC 4.1.1.79) / Sulfopyruvate decarboxylase - beta subunit (EC 4.1.1.79) +FIG00048546 Minor pilin of type IV secretion complex (VirB5) +FIG00048580 Hcp transcriptional regulator HcpR (Crp/Fnr family) +FIG00048602 Choline ABC transporter ATP-binding protein +FIG00048620 DNA polymerase sliding clamp protein PCNA +FIG00048626 FIG048626: Hypothetical protein +FIG00048749 Type III secretion chaperone protein for YopN (SycN,YscB) +FIG00048776 Translation elongation factor 1 alpha-related protein +FIG00048798 IncI1 plasmid conjugative transfer protein PilM +FIG00048827 alpha-1,6-rhamnosyltransferase paralog +FIG00048839 Alpha-N-acetylglucosaminidase (EC 3.2.1.50) +FIG00048863 3-dehydroquinate dehydratase I (EC 4.2.1.10) / Shikimate 5-dehydrogenase I alpha (EC 1.1.1.25) +FIG00048877 Glycosyl transferase involved in teichoic acid biosynthesis +FIG00048884 LysR family transcriptional regulator PA2877 +FIG00048894 Methanol methyltransferase corrinoid protein +FIG00048906 LSU ribosomal protein L34e +FIG00048908 Predicted protein SypD +FIG00048918 SSU ribosomal protein S9e (S4p) +FIG00048933 LSU ribosomal protein L14e +FIG00049012 Ribonuclease P protein component 1 (EC 3.1.26.5) +FIG00049022 Peptidyl-tRNA hydrolase, archaeal type (EC 3.1.1.29) +FIG00049035 Type III secretion chaperone protein for YopE (SycE) +FIG00049097 Heavy metal RND efflux outer membrane protein, CzcC family +FIG00049111 FIG049111: Hypothetical protein in pyoverdin gene cluster +FIG00049118 Biotin synthesis protein BioC / Dethiobiotin synthetase (EC 6.3.3.3) +FIG00049141 Hypothetical protein, SAV0878 homolog [SA bacteriophages 11, Mu50B] +FIG00049154 Spore maturation protein A-like protein +FIG00049160 Beta-(1-->2)glucan export ATP-binding/permease protein NdvA (EC 3.6.3.42) +FIG00049181 FIG049181: CBS-domain-containing protein +FIG00049184 Predicted erythritol ABC transporter 1, permease component 1 +FIG00049242 Acetate permease ActP (cation/acetate symporter) +FIG00049243 N-Acetylneuraminate cytidylyltransferase (EC 2.7.7.43) / Platelet activating factor +FIG00049258 5'-methylthioadenosine phosphorylase (EC 2.4.2.28) +FIG00049267 Membrane bound hydrogenase, MbhI subunit +FIG00049325 Uncharacterized protein MA3991 +FIG00049336 Foldase protein PrsA precursor (EC 5.2.1.8) +FIG00049340 3-keto-5-aminohexanoate cleavage enzyme +FIG00049389 Phosphopantothenate synthetase, archaeal +FIG00049411 Capsular polysaccharide biosynthesis/export periplasmic protein WcbA; Capsular polysaccharide export system protein KpsC +FIG00049433 Periplasmic [Fe] hydrogenase large subunit (EC 1.12.7.2) +FIG00049434 FIG049434: Periplasmic protein TonB, links inner and outer membranes +FIG00049476 FIG049476: HIT family protein +FIG00049479 Sensory box/GGDEF family protein ScrC (involved in swarmer cell regulation) +FIG00049519 Cytochrome c heme lyase subunit CcmH +FIG00049521 Putative conjugative transposon mobilization protein BF0132 +FIG00049580 2-oxoglutarate oxidoreductase, beta subunit (EC 1.2.7.3) +FIG00049596 Ribonuclease HI (EC 3.1.26.4) / DNA polymerase III epsilon subunit (EC 2.7.7.7) +FIG00049605 putative isobutyryl-CoA mutase, chain B +FIG00049744 SSU ribosomal protein S27e +FIG00049756 TRAP dicarboxylate transporter, DctM subunit, unknown substrate 3 +FIG00049775 carboxysome shell protein CsoS1 +FIG00049808 Choline binding protein D +FIG00049816 SSU ribosomal protein S29e (S14p) +FIG00049831 IcmP (DotM) protein +FIG00049866 Utilization protein for unknown catechol-siderophore X +FIG00049913 Lysine 2-monooxygenase (EC 1.13.12.2) +FIG00049915 GTP-binding and nucleic acid-binding protein YchF +FIG00049930 type III secretion protein HrpJ +FIG00049959 Negative regulator of beta-lactamase expression +FIG00049969 Predicted Zn-ribbon RNA-binding protein with a function in translation +FIG00050049 YfjZ protein (antitoxin to YpjF) +FIG00050164 Von Willebrand factor type A domain protein, associated with Flp pilus assembly +FIG00050194 Sulfide dehydrogenase [flavocytochrome C] flavoprotein chain precursor (EC 1.8.2.-) +FIG00050233 FIG057954: metal-binding, possibly nucleic acid-binding protein +FIG00050243 Alanyl-tRNA synthetase family protein +FIG00050244 IcmO (DotL) protein +FIG00050295 Lipopolysaccharide core biosynthesis protein RfaZ +FIG00050391 Choline permease LicB +FIG00050404 Phosphosulfolactate synthase (EC 4.4.1.19) +FIG00050462 Thiol-activated cytolysin; Streptolysin O +FIG00050525 Streptococcal extracellular nuclease 4; Mitogenic factor 4 +FIG00050576 RNA polymerase principal sigma factor HrdA +FIG00050592 Superoxide dismutase [Mn] (EC 1.15.1.1) +FIG00050603 Branched-chain amino acid aminotransferase (EC 2.6.1.42) +FIG00050669 Heme d1 biosynthesis protein NirH +FIG00050711 Sulfopyruvate decarboxylase - beta subunit (EC 4.1.1.79) +FIG00050782 HpaP protein +FIG00050825 FIGfam050825 +FIG00050852 Hydrolase alpha/beta fold family, slr0264 homolog +FIG00050854 Tricarboxylate transport protein TctC +FIG00050908 Glutamate transport membrane-spanning protein +FIG00050918 Capsular polysaccharide synthesis enzyme CpsH +FIG00050922 Primosomal replication protein N +FIG00051001 8-amino-7-oxononanoate synthase (EC 2.3.1.47) +FIG00051009 Iron(III) dicitrate transport system permease protein FecD (TC 3.A.1.14.1) +FIG00051025 Predicted sialic acid transporter +FIG00051037 V-type ATP synthase subunit A (EC 3.6.3.14) @ intein-containing +FIG00051060 Conjugative transposon protein TraH +FIG00051066 HpaA protein +FIG00051118 Nitrogenase vanadium-cofactor synthesis protein VnfE +FIG00051161 3'-phosphoadenosine 5'-phosphosulfate sulfurtransferase DndC +FIG00051207 MazG-related protein +FIG00051266 Predicted N-acetyl-glucosamine kinase 2, ROK family (EC 2.7.1.59) +FIG00051279 IcmB (DotO) protein +FIG00051303 Predicted nucleotidyltransferases +FIG00051313 ATPase component NikO of energizing module of nickel ECF transporter +FIG00051321 Cyanate ABC transporter, substrate binding protein +FIG00051361 Putative fibronectin domain-containing lipoprotein +FIG00051364 Heme d1 biosynthesis protein NirD +FIG00051374 IcmT protein +FIG00051439 DNA ligase (EC 6.5.1.2) +FIG00051447 Toxic shock syndrome toxin 1 (TSST-1) +FIG00051456 IgA1 protease +FIG00051483 Putative mobilization protein BF0133 +FIG00051547 Sulfite dehydrogenase cytochrome subunit SoxD +FIG00051652 Sigma-54 dependent transcriptional regulator SypG +FIG00051656 Preprotein translocase subunit YajC (TC 3.A.5.1.1) +FIG00051666 Lon-like protease with PDZ domain +FIG00051725 Putrescine-ornithine antiporter +FIG00051769 Programmed cell death toxin PemK +FIG00051800 Geranylgeranyl pyrophosphate synthetase (EC 2.5.1.29) +FIG00051808 Ribonucleotide reductase of class II (coenzyme B12-dependent) (EC 1.17.4.1) @ intein-containing +FIG00051882 Cobalt-precorrin-8x methylmutase (EC 5.4.1.2) +FIG00051931 Valine dehydrogenase (EC 1.4.1.-) +FIG00051957 Substrate-specific component FolT of folate ECF transporter +FIG00051986 DNA-binding domain of ModE / Molybdate-binding domain of ModE +FIG00052062 Amidase clustered with urea ABC transporter and nitrile hydratase functions +FIG00052183 Protein ImpG/VasA +FIG00052300 Zn-dependent hydrolase (beta-lactamase superfamily) +FIG00052311 Cytochrome c551 NirM +FIG00052406 Biopolymer transport protein ExbD/TolR; potentially related to transport or biosynthesis of folate +FIG00052443 Conjugative transposon protein TraL +FIG00052480 IcmE (DotG) protein +FIG00052562 DNA-binding HTH domain in riboflavin kinase / CTP-dependent archaeal riboflavin kinase +FIG00052603 YeeC-like protein +FIG00052605 Cardiolipin synthetase (EC 2.7.8.-) +FIG00052647 N-carbamoylsarcosine amidase (EC 3.5.1.59) +FIG00052661 Phycoerythrin beta chain +FIG00052681 Sulfopyruvate decarboxylase - alpha subunit (EC 4.1.1.79) +FIG00052730 ATP-dependent nuclease, subunit B +FIG00052739 Iron compound ABC uptake transporter permease protein PiaB +FIG00052775 TRAP transporter solute receptor, unknown substrate 4 +FIG00052789 SSU ribosomal protein S6e +FIG00052802 Agmatinase (EC 3.5.3.11) +FIG00052863 Group 2 RNA polymerase sigma factor @ RNA polymerase sigma factor RpoD +FIG00052867 Predicted rhamnose oligosaccharide ABC transport system, permease component 2 +FIG00052896 Integrase regulator R +FIG00052904 Serine protein kinase (prkA protein), P-loop containing +FIG00052943 Glycerol-3-phosphate transporter +FIG00052964 FIG052964: hypothetical protein +FIG00052980 ATP-dependent DNA ligase (EC 6.5.1.1) +FIG00053044 Threonine dehydrogenase and related Zn-dependent dehydrogenases +FIG00053082 FIG061771: ATP-dependent nuclease subunit A +FIG00053125 Transcriptional regulator, ArsR family / Methyltransferase fusion +FIG00053138 AMP/CMP kinase AK6 +FIG00053199 Collagen binding protein Cna +FIG00053249 "N-acetyl-gamma-glutamyl-phosphate reductase ; N- acetyl-gamma-aminoadipyl-phosphate reductase " +FIG00053282 Hypothetical protein involved in heavy metal export +FIG00053287 FIG085779: Lipoprotein +FIG00053295 alpha-1,3-rhamnosyltransferase +FIG00053398 CTP:Inositol-1-phosphate cytidylyltransferase (2.7.7.-) / Phospho-di-inositol-1-phosphate synthase (EC 2.7.8.-) +FIG00053446 Heme d1 biosynthesis protein NirF +FIG00053448 Vulnibactin utilization protein VuuB +FIG00053486 MSHA biogenesis protein MshQ +FIG00053487 Molybdenum cofactor biosynthesis protein MoaC +FIG00053499 PTS system, maltose and glucose-specific IIC component (EC 2.7.1.69) / PTS system, maltose and glucose-specific IIB component (EC 2.7.1.69) / +FIG00053507 Predicted hydroxymethylpyrimidine transporter CytX +FIG00053579 Phenazine biosynthesis protein PhzD @ 2-Amino-2-deoxy-isochorismate hydrolase (EC 3.-.-.-) +FIG00053728 GDP-mannose 4,6-dehydratase (EC 4.2.1.47) +FIG00053738 Pyoverdine sidechain non-ribosomal peptide synthetase PvdI +FIG00053843 TilS-like type 2 +FIG00053876 Cobalt-precorrin-3b C17-methyltransferase / Cobalt-precorrin-6x reductase (EC 1.3.1.54) +FIG00053886 2,3-butanediol dehydrogenase, S-alcohol forming, (R)-acetoin-specific (EC 1.1.1.4) / Acetoin (diacetyl) reductase (EC 1.1.1.5) +FIG00053889 Pyruvate dehydrogenase E1 component alpha subunit (EC 1.2.4.1) +FIG00053944 putative Adenosine kinase (EC 2.7.1.20) +FIG00053954 FIG053954: Probable conserved membrane protein +FIG00053994 CRISPR-associated RAMP Cmr1 +FIG00054034 DNA-directed RNA polymerase subunit H (EC 2.7.7.6) +FIG00054057 N-butyryl-L-homoserine lactone quorum-sensing transcriptional activator @ Transcriptional regulator RhlR +FIG00054058 Putative pertussis-like toxin subunit PtlB +FIG00054094 Uncharacterized protein with LysM domain, COG1652 +FIG00054154 Filamentous haemagglutinin domain protein +FIG00054177 Formylmethanofuran dehydrogenase (molybdenum) operon gene G +FIG00054221 FIG054221: Possible conserved alanine rich membrane protein +FIG00054260 Sulfite reduction-associated complex DsrMKJOP protein DsrP (= HmeB) +FIG00054285 Iron(III) dicitrate transport system, periplasmic iron-binding protein FecB (TC 3.A.1.14.1) +FIG00054299 Maleylpyruvate isomerase, mycothiol-dependent (EC 5.2.1.4) +FIG00054316 FIG054316: Phage polarity suppression protein +FIG00054317 Urea carboxylase-related ABC transporter, periplasmic substrate-binding protein +FIG00054354 N-acetyl-L,L-diaminopimelate aminotransferase (EC 2.6.1.-) +FIG00054355 IcmW protein +FIG00054459 Phosphoglycerate kinase (EC 2.7.2.3) +FIG00054466 TRAP transporter solute receptor, TAXI family precursor, unknown substrate 2 +FIG00054476 archaeal ATPase, fused to C-terminal DUF234 domain +FIG00054478 Ribosomal-protein-L7p-serine acetyltransferase +FIG00054491 FIG054491: hypothetical protein +FIG00054521 Mesaconyl-CoA hydratase +FIG00054551 Iron compound ABC uptake transporter ATP-binding protein PiaD +FIG00054590 CRISPR-associated protein, Cas2 +FIG00054607 NAD-specific glutamate dehydrogenase (EC 1.4.1.2); NADP-specific glutamate dehydrogenase (EC 1.4.1.4) +FIG00054610 archaeosine tRNA-ribosyltransferase (EC 2.4.2.-) type 5 +FIG00054664 Ni,Fe-hydrogenase maturation factor +FIG00054694 Predicted rhamnose oligosaccharide ABC transport system, substrate-binding component +FIG00054739 Phosphoenolpyruvate-dihydroxyacetone phosphotransferase (EC 2.7.1.121), subunit DhaM; DHA-specific IIA component +FIG00054771 type III secretion protein HrpP +FIG00054875 D-amino acid dehydrogenase small subunit (EC 1.4.99.1) +FIG00054888 CoB--CoM heterodisulfide reductase subunit D (EC 1.8.98.1) +FIG00054912 Glycosyltransferase SypN +FIG00054929 Nickel uptake regulation protein NUR / Ferric uptake regulation protein FUR +FIG00054950 Lipase (EC 3.1.1.3) family protein, sll1969 homolog +FIG00055032 Small primase-like proteins (Toprim domain) +FIG00055090 Photosystem P840 reaction center subunit PscC, cytochrome c-551 +FIG00055130 Branched-chain alpha-keto acid dehydrogenase, E1 component, beta subunit (EC 1.2.4.4) +FIG00055134 Cell envelope-associated transcriptional attenuator LytR-CpsA-Psr, subfamily M (as in PMID19099556) +FIG00055202 Hydroxymethylpyrimidine ABC transporter, ATPase component +FIG00055225 TRAP transporter solute receptor, unknown substrate 3 +FIG00055240 Methylmalonyl-CoA:Pyruvate transcarboxylase 12S subunit (EC 2.1.3.1) +FIG00055244 Conjugative transposon protein TraO +FIG00055259 Nitrogenase-associated protein NifO +FIG00055307 IcmC (DotE) protein +FIG00055371 Hypothetical protein in pyoverdin gene cluster / Fe2+/Zn2+ uptake regulation proteins +FIG00055378 Putative SigmaB asociated two-component system sensor protein +FIG00055460 Multiple virulence factor regulator MvfR/PqsR +FIG00055520 Regulation of D-alanyl-lipoteichoic acid biosynthesis, DltR +FIG00055526 Predicted D-glucarate or D-galactorate regulator, IclR family +FIG00055531 FIG055531: putative outer membrane protein +FIG00055556 Outer membrane protein YfgL, lipoprotein component of the protein assembly complex (forms a complex with YaeT, YfiO, and NlpB) +FIG00055563 LSU ribosomal protein L35Ae +FIG00055594 Uncharacterized protein MJ0054 +FIG00055632 Phosphoenolpyruvate-dihydroxyacetone phosphotransferase (EC 2.7.1.121), subunit DhaM; DHA-specific IIA component / DHA-specific phosphocarrier protein HPr +FIG00055673 SSU ribosomal protein S11p (S14e) +FIG00055715 Branched-chain amino acid ABC transporter, amino acid-binding protein (TC 3.A.1.4.1) +FIG00055762 Alcohol dehydrogenase (EC 1.1.1.1); Acetaldehyde dehydrogenase (EC 1.2.1.10) +FIG00055817 Trans-feruloyl-CoA synthase (EC 6.2.1.34) +FIG00055840 ATPase provides energy for both assembly of type IV secretion complex and secretion of T-DNA complex (VirB11) +FIG00055842 Protein gp33 [Bacteriophage A118] +FIG00055851 Macrophage infectivity potentiator/GldI +FIG00055864 Putative anti-sigma factor antagonist +FIG00055970 Rhodanese domain protein UPF0176, Actinobacterial subgroup +FIG00055992 Heme biosynthesis protein related to NirD / Heme biosynthesis protein related to NirL +FIG00055999 Phenazine biosynthesis protein PhzB +FIG00056085 RTX toxin activating lysine-acyltransferase (EC 2.3.1.-) / cyclolysin-activating lysine-acyltransferase +FIG00056131 Amino-terminal intein-mediated trans-splice / DNA polymerase III alpha subunit (EC 2.7.7.7) +FIG00056147 Capsular polysaccharide biosynthesis heptosyltransferase HddD +FIG00056179 Cyanate ABC transporter, permease protein +FIG00056210 Photosystem II 12 kDa extrinsic protein (PsbU) +FIG00056212 Pyridine nucleotide-disulfide oxidoreductase; NADH dehydrogenase (EC 1.6.99.3) +FIG00056241 Bacteriochlorophyllide c C12 methyltransefase BchR +FIG00056264 Hydroxyneurosporene methyltransferase (EC 2.1.1.-) +FIG00056420 Protein gp30 [Bacteriophage A118] +FIG00056421 Regulator of polyketide synthase expression +FIG00056451 IcmQ protein +FIG00056456 Glycosyltransferase SypP +FIG00056516 NnrU family protein in cluster with Mesaconyl-CoA hydratase +FIG00056526 Nitrogenase (molybdenum-iron) reductase and maturation protein NifH / Nitrogenase FeMo-cofactor scaffold and assembly protein NifE +FIG00056617 PTS system, fructose- and mannose-inducible IIC component (EC 2.7.1.69) +FIG00056665 alpha-1,6-rhamnosyltransferase +FIG00056694 Uroporphyrinogen-III synthase (EC 4.2.1.75) +FIG00057022 IncI1 plasmid conjugative transfer inner membrane protein PilR +FIG00057095 Ortho-halobenzoate 1,2-dioxygenase alpha-ISP protein OhbB +FIG00057120 COG1293, Predicted RNA-binding protein homologous to eukaryotic snRNP +FIG00057144 Glycosyltransferase (EC 2.4.1.-) SypI +FIG00057217 Protein gp43 [Bacteriophage A118] +FIG00057284 Glucose-6-phosphate isomerase, archaeal (EC 5.3.1.9) +FIG00057293 Crotonyl-CoA carboxylase/reductase, ethylmalonyl-CoA producing +FIG00057395 Substrate-specific component NikM of nickel ECF transporter / Additional substrate-specific component NikN of nickel ECF transporter +FIG00057416 Choline dehydrogenase (EC 1.1.99.1) +FIG00057432 Flagellar biosynthesis protein FliL +FIG00057450 Ribitol operon repressor +FIG00057548 Mercuric transport protein, MerT +FIG00057555 Inducers of aerial mycelium formation biosynthesis protein BldG +FIG00057566 Ferrichrome-iron receptor +FIG00057597 TesB-like acyl-CoA thioesterase 5 +FIG00057611 Pantoate kinase, archaeal (EC 2.7.1.-) +FIG00057669 Putative CDP-glycerol:glycerophosphate glycerophosphotransferase (EC 2.7.8.-) +FIG00057709 DNA polymerase III delta prime subunit (EC 2.7.7.7) +FIG00057753 IncI1 plasmid pilus assembly protein PilO +FIG00057758 LSU ribosomal protein L44e +FIG00057771 2,3-diketo-L-gulonate TRAP transporter large permease protein yiaN +FIG00057777 Polyketide beta-ketoacyl synthase WhiE-KS +FIG00057778 CRISPR-associated RAMP Cmr4 +FIG00057801 Conjugative transposon protein TraN +FIG00057836 Ferredoxin-like protein involved in electron transfer +FIG00057840 Imidazolonepropionase (EC 3.5.2.7) +FIG00057910 Cobalt-containing nitrile hydratase subunit beta (EC 4.2.1.84) +FIG00057987 Pyruvate:ferredoxin oxidoreductase, delta subunit (EC 1.2.7.1) +FIG00057993 Probable thioesterase involved in non-ribosomal peptide biosynthesis, PA2411 homolog +FIG00058048 Protein gp51 [Bacteriophage A118] +FIG00058071 Rhodanese domain protein UPF0176, Legionella subgroup +FIG00058153 Hemin transport protein +FIG00058189 Substrate-specific component PdxU2 of predicted pyridoxin-related ECF transporter +FIG00058199 Uncharacterized protein AF0741 (similar to YjbQ) +FIG00058213 Esterase/lipase/thioesterase family, pmt2269 homolog +FIG00058260 Glutamine synthetase inactivating factor IF7 +FIG00058277 Hypothetical protein, slr1506/slr1944 homolog +FIG00058322 Sodium-dependent phosphate transporter +FIG00058387 Predicted beta-glucoside-regulated ABC transport system, permease component 2, COG0395 +FIG00058402 Phycobilisome core-membrane linker polypeptide +FIG00058406 DNA-directed RNA polymerase subunit F (EC 2.7.7.6) +FIG00058485 Phycobilisome small rod capping linker polypeptide, phycocyanin-associated +FIG00058499 S-adenosylmethionine decarboxylase proenzyme (EC 4.1.1.50), prokaryotic class 1B / Spermidine synthase (EC 2.5.1.16) +FIG00058517 Uncharacterized ferredoxin oxidoreductase MJ0100 +FIG00058561 IcmF protein +FIG00058578 Optional hypothetical component of the B12 transporter BtuN +FIG00058595 archaeosine tRNA-ribosyltransferase (EC 2.4.2.-) type 1 +FIG00058636 GDSL-like lipase/acylhydrolase +FIG00058663 Probable spermidine/putrescine substrate binding protein in Mollicutes +FIG00058669 Dephospho-CoA kinase archaeal, predicted (EC 2.7.1.24) +FIG00058683 Hemoglobin-dependent two component system, sensory histidine kinase HrrS +FIG00058747 Sulfur carrier protein ThiS +FIG00058830 6-phosphofructokinase (EC 2.7.1.11) +FIG00058860 Glutamate Aspartate transport system permease protein GltK (TC 3.A.1.3.4) +FIG00058905 Adenosylcobinamide amidohydrolase (EC 3.5.1.90) +FIG00058930 ATP-dependent DNA helicase UvrD/PcrA/Rep, epsilon proteobacterial type 1 +FIG00058943 Methanol dehydrogenase large subunit protein (EC 1.1.99.8) +FIG00058983 ABC transporter (iron.B12.siderophore.hemin) , permease component +FIG00058998 Vancomycin response regulator VanR +FIG00059025 Alpha,alpha-trehalose-phosphate synthase [UDP-forming] (EC 2.4.1.15) / Trehalose-6-phosphate phosphatase (EC 3.1.3.12) +FIG00059069 IcmS protein +FIG00059089 SSU ribosomal protein S30e +FIG00059112 Glycosyltransferase (EC 2.4.1.-) SypJ +FIG00059124 Low molecular weight protein tyrosine phosphatase (EC 3.1.3.48) +FIG00059146 Predicted adenosylcobinamide-phosphate guanylyltransferase CobY (EC 2.7.7.62) +FIG00059211 RecD-like DNA helicase YrrC +FIG00059222 COG1836 +FIG00059233 D-arabino-3-hexulose 6-phosphate formaldehyde lyase / 6-phospho-3-hexuloisomerase +FIG00059266 Predicted rhamnose oligosaccharide ABC transport system, permease component +FIG00059280 Zinc ABC transporter, ATP-binding protein ZnuC +FIG00059298 Transcriptional regulator AlcR in siderophore [Alcaligin] cluster +FIG00059338 Kappa-fimbriae chaperone protein +FIG00059351 Putative lumenal protein, contains 8 pentapeptide repeats, sll0577 homolog +FIG00059366 Adenosylhopane nucleosidase, HpnG +FIG00059413 Phosphoenolpyruvate-dihydroxyacetone phosphotransferase (EC 2.7.1.121), ADP-binding subunit DhaL +FIG00059426 Cytoplasmic axial filament protein CafA and Ribonuclease G (EC 3.1.4.-) +FIG00059463 Phage NinB DNA recombination +FIG00059476 Acyl-homoserine lactone acylase PvdQ (EC 3.5.1.-), quorum-quenching +FIG00059485 CRISPR-associated protein Cas7 +FIG00059491 Possible alpha/beta hydrolase superfamily, sll0553 homolog +FIG00059552 Phenylacetate-CoA oxygenase, PaaJ subunit +FIG00059619 Methylmalonyl-CoA:Pyruvate transcarboxylase 5S subunit (EC 2.1.3.1) +FIG00059640 Spore germination protein GerQC +FIG00059649 RNA polymerase principal sigma factor HrdD +FIG00059802 Hypothetical SAV0787 homolog in superantigen-encoding pathogenicity islands SaPI +FIG00059814 FIG059814: Transporter, LysE family +FIG00059826 Hypothetical protein (associated with DNA helicase - Rad25 homolog) +FIG00059862 Isochorismate pyruvate-lyase (EC 4.-.-.-) +FIG00059881 Transmembrane component NikQ of energizing module of nickel ECF transporter +FIG00059898 Assimilatory nitrate reductase large subunit (EC:1.7.99.4) +FIG00059923 Translation initiation factor 2B alpha/beta/delta-type subunit +FIG00060024 Mannonate dehydratase (EC 4.2.1.8) +FIG00060088 Biopolymer transport ExbD protein +FIG00060115 Pertussis toxin subunit 4 precursor (PTX S4) +FIG00060233 Unknown carbohydrate transporter from TRAP family, small transmembrane component UctM +FIG00060246 Multicopper oxidase +FIG00060285 FIG139438: lipoprotein B +FIG00060294 ABC transport system, permease component YbhS +FIG00060299 Similar to Teicoplanin resistance associated membrane protein TcaA +FIG00060364 DUF324 domain containing Cmr2-like protein +FIG00060371 Periplasmic aromatic aldehyde oxidoreductase, FAD binding subunit YagS +FIG00060387 Type III secretion chaperone protein for YopH (SycH) +FIG00060421 YhfA Protein in tra region of some IncF plasmids +FIG00060464 Lipid carrier : UDP-N-acetylgalactosaminyltransferase (EC 2.4.1.-) / Alpha-1,3-N-acetylgalactosamine transferase PglA (EC 2.4.1.-); Putative glycosyltransferase +FIG00060475 Conjugative transposon protein TraJ +FIG00060517 Single-stranded-DNA-specific exonuclease RecJ (EC 3.1.-.-) +FIG00060523 FIG113347: hypothetical protein +FIG00060542 Heme biosynthesis protein related to NirD and NirG +FIG00060571 Ribonuclease J1 (endonuclease and 5' exonuclease) +FIG00060605 Membrane protein YcjF +FIG00060678 Thiol:disulfide oxidoreductase TlpA +FIG00060683 Taurine transport system permease protein TauC +FIG00060700 protein of unknown function DUF358 +FIG00060735 F420-dependent methylenetetrahydromethanopterin dehydrogenase (EC 1.5.99.9) +FIG00060740 Hypothetical glycine rich membrane protein DUF1517 +FIG00060825 Membrane efflux protein associated with [Alcaligin] siderophore cluster +FIG00060838 Small nuclear ribonucleoprotein F +FIG00061110 Oligosaccharide translocase SypK +FIG00061131 sugar ABC transporter permease +FIG00061176 Type IV fimbrial biogenesis protein FimT +FIG00061257 2-Keto-D-gluconate dehydrogenase (EC 1.1.99.4), membrane-bound, gamma subunit +FIG00061267 Pyrroloquinoline-quinone synthase (EC 1.3.3.11) +FIG00061305 L-Proline/Glycine betaine transporter ProP +FIG00061313 Replicative DNA helicase (EC 3.6.1.-) +FIG00061365 TRAP transporter, 4TM/12TM fusion protein, unknown substrate 2 +FIG00061387 Competence positive regulator ComW +FIG00061396 gar1 - like small nucleolar rnp +FIG00061408 COG2117: Predicted ATPase of the PP-loop superfamily +FIG00061602 hypothetical protein clusted with conjugative transposons, BF0131 +FIG00061715 D-alanine--poly(phosphoribitol) ligase subunit 2 (EC 6.1.1.13) +FIG00061755 Cell wall-associated murein hydrolase LytA +FIG00061832 Glucosamine-1-phosphate N-acetyltransferase (EC 2.3.1.157) +FIG00061853 Sensory subunit of low CO2-induced protein complex, putative +FIG00061912 Alkanesulfonates ABC transporter ATP-binding protein / Sulfonate ABC transporter, ATP-binding subunit SsuB +FIG00061935 Probable glycerol transport protein +FIG00061968 Hydrolase in polyol utilization gene cluster, haloacid dehalogenase-like family +FIG00062027 Subtilisin-like protease / autotransporter domain, T5aSS type secretion +FIG00062054 Putative glycosyltransferase protein +FIG00062058 Coenzyme F(420)H(2) dehydrogenase (methanophenazine) subunit FpoO +FIG00062156 IcmK (DotH) protein +FIG00062284 Terminal oxidase, small hydrophobic subunit (DoxE) +FIG00062440 Type III secretion injected virulence protein (YopP,YopJ, induces apoptosis, prevents cytokine induction, inhibits NFkb activation) +FIG00062447 CRISPR-associated protein Csx11 +FIG00062522 Cyanophycinase (EC 3.4.15.6) +FIG00062541 IcmV protein +FIG00062547 Superoxide reductase (EC 1.15.1.2) +FIG00062548 Predicted beta-glucoside-regulated ABC transport system, permease component 1, COG1175 +FIG00062565 Replication factor A (ssDNA-binding protein) +FIG00062612 Putative ABC transporter of substrate X, ATP-binding subunit; interrupted +FIG00062614 Sugar transferase SypR involved in lipopolysaccharide synthesis +FIG00062728 MxiG protein +FIG00062772 Transmembrane component BioN of energizing module of biotin ECF transporter +FIG00062860 FIG062860: Dehydrogenases with different specificities (related to short-chain alcohol dehydrogenases) +FIG00062957 Anthranilate phosphoribosyltransferase (EC 2.4.2.18) +FIG00063038 photosystem I subunit IX (PsaJ) +FIG00063050 Signal peptidase, type IV - prepilin/preflagellin +FIG00063075 Type III secretion protein (YscA) +FIG00063189 Translation elongation factor G +FIG00063288 Iron-sulfur protein in siderophore [Alcaligin] cluster +FIG00063325 N(5),N(10)-methenyltetrahydromethanopterin cyclohydrolase (EC 3.5.4.27) +FIG00063353 Additional lipoprotein component of predicted cobalamin ECF transporter +FIG00063362 Flagellin protein FlaG +FIG00063388 Heme d1 biosynthesis protein NirG +FIG00063390 HAD hydrolase of unknown function / Dephospho-CoA kinase (EC 2.7.1.24) +FIG00063425 2-amino-4-hydroxy-6-hydroxymethyldihydropteridine pyrophosphokinase (EC 2.7.6.3) / Dihydropteroate synthase (EC 2.5.1.15) +FIG00063453 Pertussis toxin subunit 3 precursor (PTX S3) +FIG00063488 NAD-dependent formate dehydrogenase (EC 1.2.1.2) +FIG00063506 Photosystem II protein PsbZ +FIG00063519 Thiosulfate sulfurtransferase, rhodanese (EC 2.8.1.1) / Phosphatidylserine decarboxylase (EC 4.1.1.65) +FIG00063530 Conjugative transposon protein TraM +FIG00063655 Periplasmic protein torT precursor +FIG00063680 Metallothionein +FIG00063730 Cell wall-associated murein hydrolase LytC +FIG00063741 Nitrogenase (vanadium-iron) delta chain (EC 1.18.6.1) +FIG00063745 IcmR protein +FIG00063817 IcmJ (DotN) protein +FIG00063845 Two-peptide bacteriocin peptide CibA +FIG00063869 (S)-2,3-di-O-geranylgeranylglyceryl phosphate synthase +FIG00063913 Lipoate-protein ligase A type 2 +FIG00063925 type IV pilus biogenesis protein PilJ +FIG00064100 Methanophenazine hydrogenase large subunit (EC 1.12.98.3) +FIG00064104 Cobalt-containing nitrile hydratase subunit alpha (EC 4.2.1.84) +FIG00064110 Cysteine synthase (EC 2.5.1.47) +FIG00064138 Probable Co/Zn/Cd efflux system membrane fusion protein / Multidrug efflux membrane fusion protein MexE +FIG00064151 Nitrogenase (iron-iron) beta chain (EC 1.18.6.1) +FIG00064154 ParE toxin protein +FIG00064241 Immunity factor ComM +FIG00064304 tRNA-dependent lipid II-AlaAla--L-alanine ligase +FIG00064397 Rhamnogalacturonide transporter RhiT +FIG00064434 Cytochrome oxidase biogenesis protein Sco1/SenC/PrrC, putative copper metallochaperone +FIG00064492 Hypothetical protein PvdX +FIG00064496 FIG064496: Hypothetical protein +FIG00064515 Quinate/shikimate dehydrogenase [Pyrroloquinoline-quinone] (EC 1.1.99.25) +FIG00064522 Xanthan biosynthesis glucuronosyltransferase GumK +FIG00064574 Glycosyltransferase (EC 2.4.1.-) SypH +FIG00064620 Pyoverdine sidechain non-ribosomal peptide synthetase PvdD +FIG00064655 2-Amino-2-deoxy-isochorismate synthase (EC 4.1.3.-) +FIG00064705 FIG064705: cation/hydrogen antiporter +FIG00064709 Membrane protein associated with oxaloacetate decarboxylase +FIG00064730 Hydroxymethylpyrimidine synthesis protein THI5 +FIG00064849 BlpZ protein, fusion +FIG00064864 Single-stranded-DNA-specific exonuclease RecJ, cyanobacterial paralog +FIG00064872 Glycosyl transferase in large core OS assembly cluster +FIG00065033 Circadian period extender Pex +FIG00065052 MutS domain protein, family 2 +FIG00065119 Biliverdin reductase (EC 1.3.1.24) +FIG00065210 Pertussis toxin subunit 5 precursor (PTX S5) +FIG00065314 Rod shape-determining protein MreB +FIG00065388 2-Keto-D-gluconate dehydrogenase (EC 1.1.99.4), membrane-bound, cytochrome c +FIG00065468 Predicted transcriptional regulator of sulfate transport, Rrf2 family +FIG00065488 LSU ribosomal protein L40e +FIG00065532 ADP-dependent phosphofructokinase (EC 2.7.1.146) +FIG00065617 Benzoate transport, extracellular ligand-binding receptor +FIG00065668 SSU ribosomal protein S4e +FIG00065774 5-keto-2-deoxygluconokinase (EC 2.7.1.92) / 5-deoxy-glucuronate isomerase (EC 5.3.1.-) +FIG00065780 Endo-1,4-beta-mannosidase +FIG00065865 Uncharacterized ABC transporter, permease component YrbE +FIG00065872 2-dehydro-3-deoxyphosphogalactonate aldolase (EC 4.1.2.21) +FIG00065907 CMP-Kdo synthetase, KpsU +FIG00065937 ABC-type probable sulfate transporter, permease protein +FIG00065948 Putative CoA-transferase subunit alpha Rv3551/MT3655 (EC 2.8.3.-) +FIG00065976 Glyceraldehyde-3-phosphate: ferredoxin oxidoreductase (EC 1.2.7.6) +FIG00066026 Predicted beta-glucoside-regulated ABC transport system, sugar binding component, COG1653 +FIG00066038 Putative iron reductase in siderophore [Alcaligin] cluster +FIG00066052 IcmX protein +FIG00066096 hypothetical protein SC6C5.04c +FIG00066123 Ni,Fe-hydrogenase I cytochrome b subunit +FIG00066143 N-acetylglutamate synthase (EC 2.3.1.1); Lysine biosynthesis protein LysX +FIG00066239 type III secretion protein HrcQa +FIG00066259 type 4 fimbrial biogenesis protein FimU +FIG00066264 ATP-dependent DNA helicase UvrD/PcrA, clostridial paralog 2 +FIG00066280 V-type ATP synthase subunit G (EC 3.6.3.14) +FIG00066397 tRNA-dependent lipid II--amino acid ligase +FIG00066414 Cytochrome c551/c552 +FIG00066425 DNA polymerase III beta subunit (EC 2.7.7.7) +FIG00066440 Replication factor C small subunit @ intein-containing +FIG00066446 Conjugative transfer ATPase PilU in PFGI-1-like cluster +FIG00066504 Glucarate dehydratase (EC 4.2.1.40) +FIG00066508 Inositol-1-phosphate synthase (EC 5.5.1.4) +FIG00066569 Two-peptide bacteriocin peptide CibB +FIG00066575 Exopolyphosphatase (EC 3.6.1.11) +FIG00066613 Methyltransferase, FkbM family protein +FIG00066641 Haloalkane dehalogenase-like protein, At1g52510/AT4G12830 homolog +FIG00066643 Neopullulanase (EC 3.2.1.135) +FIG00066713 DotD +FIG00066718 Putative phosphoenolpyruvate synthase/pyruvate phosphate dikinase, C-terminal domain +FIG00066771 CoB--CoM-reducing hydrogenase (Sec) gamma subunit +FIG00066791 Similar to secretin RcpA/CpaC, associated with Flp pilus assembly +FIG00066878 Type III secretion outermembrane contact sensing protein (YopN,Yop4b,LcrE) / Type III secretion outermembrane negative regulator of secretion (TyeA) +FIG00066879 Hypothetical iron-sulfur cluster binding protein YccM +FIG00066899 putative cytochrome p450 oxidoreductase +FIG00066904 CpeR homolog, phycoerythrin linker-proteins region +FIG00066926 polyhydroxyalkanoate granule-associated protein PhaI +FIG00066958 LphA protein +FIG00067008 Accessory colonization factor AcfA +FIG00067014 photosystem I subunit XII (PsaM) +FIG00067021 Asparagine--tRNA ligase related protein +FIG00067081 Peroxidase (EC 1.11.1.7) +FIG00067120 Hemoglobin-dependent two component system response regulator HrrA +FIG00067204 Small Molecule Metabolism; Central intermediary metabolism; salvage of nucleosides and nucleotides +FIG00067220 Glycine oxidase ThiO (EC 1.4.3.19) / Thiazole biosynthesis protein ThiG +FIG00067248 Acetate kinase (EC 2.7.2.1) +FIG00067300 Nicotinamidase (EC 3.5.1.19) +FIG00067420 LysR family transcriptional regulator PA0739 +FIG00067460 Cytochrome C550 (Soluble cytochrome C) +FIG00067497 SSU ribosomal protein S17e +FIG00067512 IncQ plasmid conjugative transfer protein TraQ (RP4 TrbM homolog) +FIG00067562 V-type ATP synthase subunit E (EC 3.6.3.14) +FIG00067572 Membrane protein SypL involved in exopolysaccharide production +FIG00067574 rRNA biogenesis protein Nop5/Nop56 +FIG00067620 Conserved hypothetical protein probably involved in sulfate reduction +FIG00067642 L-O-lysylphosphatidylglycerol synthase (EC 2.3.2.3) +FIG00067681 Transcription-repair coupling factor +FIG00067750 Metal-dependent hydrolases of the beta-lactamase superfamily II +FIG00067777 Streptomycin 3''-O-adenylyltransferase (EC 2.7.7.47) @ Spectinomycin 9-O-adenylyltransferase +FIG00067849 Transcription factor S-related protein 2 +FIG00067864 Toxin co-regulated pilus biosynthesis protein C, outer membrane protein +FIG00067882 LysR family transcriptional regulator PerR +FIG00067888 NifB-domain protein, type 2 +FIG00067909 tRNA pseudouridine 55 synthase (EC 4.2.1.70) +FIG00068038 IncI1 plasmid conjugative transfer lipoprotein PilN +FIG00068086 FIG068086: hypothetical protein +FIG00068109 IncI1 plasmid conjugative transfer protein TraM +FIG00068115 3-hydroxybutyryl-CoA dehydrogenase (EC 1.1.1.157) +FIG00068132 CO dehydrogenase/acetyl-CoA synthase subunit alpha, CO dehydrogenase subcomplex (EC 1.2.99.2) +FIG00068144 Nitrogenase (vanadium-iron) beta chain (EC 1.18.6.1) +FIG00068188 type III secretion protein HrpG +FIG00068256 Di/tripeptide permease DtpB +FIG00068302 Protoporphyrinogen IX oxidase, aerobic, HemY (EC 1.3.3.4) +FIG00068423 Accessory cholera enterotoxin +FIG00068491 ABC-type probable sulfate transporter, periplasmic binding protein +FIG00068527 WhiB-type transcriptional regulator +FIG00068620 IncI1 plasmid conjugative transfer protein TraN +FIG00068727 NADH-ubiquinone oxidoreductase chain L (EC 1.6.5.3) +FIG00068733 2-carboxylbenzaldehyde dehydrogenase +FIG00068743 Benzoate 1,2-dioxygenase beta subunit (EC 1.14.12.10) +FIG00068809 Beta-lactamase AmpS +FIG00068866 Type IV prepilin peptidase TadV/CpaA +FIG00068924 Carbon dioxide concentrating mechanism protein CcmO +FIG00068942 Uncharacterized protein MJ0405 +FIG00068973 Nicotinate-nucleotide adenylyltransferase (EC 2.7.7.18) / Hydrolase (HAD superfamily), YqeK +FIG00069016 Transcriptional regulator, GntR family, in hypothetical Actinobacterial gene cluster +FIG00069238 Formylmethanofuran dehydrogenase (tungsten) operon gene F (polyferredoxin) +FIG00069448 Putative Desferrioxamine E transporter +FIG00069450 L-arabinose-specific 1-epimerase (mutarotase) +FIG00069510 Formate dehydrogenase O putative subunit +FIG00069518 Phosphoglycolate phosphatase, archaeal type (EC 3.1.3.18) +FIG00069533 FIG069533: Putative bacteriophage protein +FIG00069535 Kappa-fimbriae usher protein +FIG00069622 type III secretion protein HrpQ +FIG00069634 Putative gluthatione transporter,solute-binding component +FIG00069642 type III secretion protein HrpD +FIG00069656 Coenzyme F420 hydrogenase gamma subunit (FruG) (EC 1.12.98.1) +FIG00069704 Thiol:disulfide interchange protein, thioredoxin family +FIG00069722 Phosphoribosylanthranilate isomerase (EC 5.3.1.24) +FIG00069725 Protein-L-isoaspartate O-methyltransferase (EC 2.1.1.77) +FIG00069748 FIG069748: Hypothetical protein +FIG00069821 DUF324 domain containing Cmr6-like protein +FIG00069829 Glycosyltransferase SypQ +FIG00069838 3-aminobutyrl-CoA ammonia lyase (EC 4.3.1.14) +FIG00069887 FIG069887: hypothetical protein +FIG00069895 ABC-type Fe3+-siderophore transport system, ATPase component +FIG00070083 IcmL (DotI) protein +FIG00070111 Type IV pilus biogenesis protein PilQ; Competence protein D +FIG00070121 FIG070121: Phage capsid and scaffold protein +FIG00070140 Polysaccharide biosynthesis chain length regulator SypO +FIG00070168 PTS system, fructose- and mannose-inducible IIB component (EC 2.7.1.69) +FIG00070169 (S)-2-hydroxy-acid oxidase (EC 1.1.3.15) +FIG00070265 bifunctional hemolysin-adenylate cyclase precursor +FIG00070284 Saccharopine dehydrogenase [NAD+, L-lysine-forming] (EC 1.5.1.7) +FIG00070318 COGs COG3146 +FIG00070333 Hypothetical cyanobacterial membrane protein, in cluster with PxcA +FIG00070384 putative Type III secretion protein Spa33 +FIG00070480 Delta 1-piperideine-2-carboxylate reductase (EC 1.5.1.21) / Delta 1-pyrroline-2-carboxylate reductase (EC 1.5.1.1) +FIG00070494 Phosphoribulokinase (EC 2.7.1.19) +FIG00070513 phosphotransbutyrylase (EC 2.3.1.19) +FIG00070580 ATP-dependent protease La (EC 3.4.21.53) Type II @ intein-containing +FIG00070611 Phosphonate ABC transporter permease protein phnE1 (TC 3.A.1.9.1) +FIG00070625 Membrane-bound lytic murein transglycosylase D precursor (EC 3.2.1.-) @ repetitive LysM domain +FIG00070670 Lactate-responsive regulator LldR in Betaproteobacteria, LysR family +FIG00070690 Dihydrolipoamide dehydrogenase of pyruvate dehydrogenase complex (EC 1.8.1.4) / Dihydrolipoamide dehydrogenase (EC 1.8.1.4) +FIG00070692 putative type III secretion system lipoprotein precursor EprK +FIG00070733 Polyketide chain length factor WhiE-CLF +FIG00070816 Gamma-tocopherol C-methyltransferase (EC 2.1.1.95) +FIG00070877 Cyanobacteria-specific RpoD-like sigma factor, type-1 +FIG00070884 Eukaryotic translation initiation factor 2 alpha subunit +FIG00070922 Hypothetical SAV0795 homolog in superantigen-encoding pathogenicity islands SaPI +FIG00071052 Nitrous oxide reductase maturation protein NosR +FIG00071059 Acetyl-CoA synthetase (ADP-forming) beta chain (EC 6.2.1.13) +FIG00071065 Methionyl-tRNA synthetase-related protein +FIG00071077 Translation elongation factor 1 alpha subunit +FIG00071107 Cytochrome b6-f complex subunit V (PetG) +FIG00071111 Conjugative transfer protein PilM in PFGI-1-like cluster +FIG00071133 Ribulose bisphosphate carboxylase small chain (EC 4.1.1.39) +FIG00071137 Heme efflux system permease HrtB +FIG00071154 2-phosphosulfolactate phosphatase (EC 3.1.3.71) +FIG00071200 Amidohydrolase YlmB, involved in salvage of thiamin pyrimidine moiety +FIG00071291 tRNA N2,N2-dimethyl(Guanine26-N2)-methyltransferase (EC 2.1.1.32) +FIG00071345 Beta-carotene ketolase (EC 1.14.-.-) +FIG00071359 Glutamine amidotransferases class-II (GATase) / Queuosine Biosynthesis QueC ATPase +FIG00071434 SSU ribosomal protein S27Ae +FIG00071442 Permeases of the major facilitator superfamily / Thymidylate kinase (EC 2.7.4.9) +FIG00071557 NAD(P)-dependent glyceraldehyde 3-phosphate dehydrogenase archaeal (EC 1.2.1.59) +FIG00071623 Naphthoate synthase (EC 4.1.3.36) +FIG00071640 LSU ribosomal protein L30e +FIG00071684 Xanthosine operon regulatory protein XapR, LysR family +FIG00071696 ATP-dependent DNA helicase UvrD/PcrA, proteobacterial paralog +FIG00071708 CRISPR-associated protein Csm6 +FIG00071728 Uncharacterized ABC transporter ATP-binding protein MJ0121 +FIG00071794 Putative snRNP Sm-like protein, Archaeal +FIG00071874 Cytochrome c-type protein TorY +FIG00071877 Protein CP12, regulation of Calvin cycle via association/dissociation of PRK/CP12/GAPDH complex +FIG00072072 Cro-like repressor, superantigen-encoding pathogenicity islands SaPI +FIG00072102 Lipocalin-related protein and Bos/Can/Equ allergen +FIG00072107 Putative oxidoreductase component of anaerobic dehydrogenases; Functional role page for Chaperone protein TorD +FIG00072108 Phosphosugar-binding transcriptional repressor, RpiR family +FIG00072123 Heptosyltransferase family protein, lipopolysaccharide core biosynthesis +FIG00072159 DNA adenine methyltransferase, phage-associated +FIG00072202 Additional substrate-specific component NikN of nickel ECF transporter +FIG00072244 Conjugative transposon protein TraD +FIG00072271 Meso-diaminopimelate D-dehydrogenase (EC 1.4.1.16) +FIG00072383 Uncharacterized ATP-dependent helicase MJ0294 +FIG00072435 IncQ plasmid conjugative transfer DNA primase TraO (pTi TraA homolog) +FIG00072450 5-keto-2-deoxy-D-gluconate-6 phosphate aldolase (EC 4.1.2.29) +FIG00072588 Heavy metal sensor histidine kinase +FIG00072797 Iron-sulfur cluster assembly protein SufD +FIG00073050 Siderophore biosynthesis diaminobutyrate--2-oxoglutarate aminotransferase (EC 2.6.1.76) +FIG00073159 FIG073159: hypothetical protein +FIG00073198 NADPH-dependent aldo-keto reductase, similarity to GRE3, stress-induced in yeast +FIG00073201 Dolichol-phosphate mannosyltransferase (EC 2.4.1.83) +FIG00073282 Cytochrome c oxidase polypeptide IV(EC 1.9.3.1) +FIG00073301 Phosphate regulon sensor protein PhoR (SphS) (EC 2.7.13.3) +FIG00073306 Sulfur acceptor protein SufE for iron-sulfur cluster assembly +FIG00073317 Conjugative transposon protein TraK +FIG00073345 Protein TadG, associated with Flp pilus assembly +FIG00073385 Lipoteichoic acid synthase LtaS Type IVb +FIG00073421 Type IV fimbrial biogenesis protein PilY2 +FIG00073493 HupE-UreJ family metal transporter +FIG00073539 ATP/GTP-binding protein, SA1392 homolog +FIG00073655 Hypothetical SAV0788 homolog in superantigen-encoding pathogenicity islands SaPI +FIG00073693 Streptococcal pyrogenic exotoxin J (SpeJ) +FIG00073703 Carboxysome protein CcmN +FIG00073737 7,8-didemethyl-8-hydroxy-5-deazariboflavin synthase subunit 1 / 7,8-didemethyl-8-hydroxy-5-deazariboflavin synthase subunit 2 +FIG00073807 IncI1 plasmid conjugative transfer protein TraO +FIG00073905 Chorismate mutase I (EC 5.4.99.5) / Prephenate dehydratase (EC 4.2.1.51) +FIG00074065 Cytochrome c553 +FIG00074196 D-glycerate 2-kinase (EC 2.7.1.-) +FIG00074201 Polysulfide binding protein +FIG00074225 2-C-methyl-D-erythritol 4-phosphate cytidylyltransferase (EC 2.7.7.60) +FIG00074231 Putative exported protein clustered with Gamma-glutamyltranspeptidase +FIG00074537 N-Acetyl-D-glucosamine ABC transport system ATP-binding protein +FIG00074891 Cell envelope-associated transcriptional attenuator LytR-CpsA-Psr, subfamily S (as in PMID19099556) +FIG00074916 Acetolactate synthase, catabolic (EC 2.2.1.6) +FIG00075111 LSU ribosomal protein L19e +FIG00075163 Putative photosynthetic complex assembly protein +FIG00075347 TtuB +FIG00075415 Iron(III) dicitrate transmembrane sensor protein FecR +FIG00075426 Predicted ATPase related to phosphate starvation-inducible protein PhoH +FIG00075438 Blr3520 protein homolog, hypothetical protein +FIG00075564 D-serine dehydratase transcriptional activator +FIG00075602 Cyanate ABC transporter, ATP-binding protein +FIG00075634 Kappa-fimbriae major subunit +FIG00075702 Glycerol kinase (EC 2.7.1.30) +FIG00075709 Phenol hydroxylase, P3 oxygenase component DmpN (EC 1.14.13.7) +FIG00075739 Heavy metal resistance transcriptional regulator HmrR +FIG00075791 Signal transduction histidine kinase SypF +FIG00075798 Light-harvesting LHII, alpha subunit B +FIG00075840 DNA reverse gyrase (EC 5.99.1.-) +FIG00075965 iron aquisition yersiniabactin synthesis enzyme (YbtT,resembles thioesterases) +FIG00075970 5-Enolpyruvylshikimate-3-phosphate synthase (EC 2.5.1.19) +FIG00076039 COG3269, Predicted RNA-binding protein, contains TRAM domain +FIG00076210 FIG076210: Hypothetical protein +FIG00076285 Substrate-specific component STY3230 of queuosine-regulated ECF transporter +FIG00076288 FIG050275: Chromosome partition protein smc +FIG00076298 3-hydroxyacyl-CoA dehydrogenase PaaC (EC 1.1.1.-) +FIG00076381 Putative secretion accessory protein EsaA/YueB / Bacteriophage SPP1 receptor +FIG00076433 Predicted erythritol ABC transporter 1, ATP-binding component 2 +FIG00076487 Siderophore biosynthesis L-2,4-diaminobutyrate decarboxylase +FIG00076495 Metal-dependent membrane protease, abortive infection protein +FIG00076542 N-acetylglucosamine-6-phosphate deacetylase (EC 3.5.1.25) +FIG00076676 FIG076676: Hypothetical protein +FIG00076704 Resolvase/Integrase TinR protein +FIG00076844 SSU ribosomal protein S18e (S13p) +FIG00076987 NADH dehydrogenase subunit 2 +FIG00077003 Molybdenum cofactor biosynthesis protein MoaD / Molybdenum cofactor biosynthesis protein MoaE +FIG00077037 Coenzyme gamma-F420-2:L-glutamate ligase +FIG00077188 Substrate-specific component TrpP of tryptophan ECF transporter +FIG00077271 IncF plasmid conjugative transfer protein TrbI +FIG00077393 DNA repair and recombination protein RadB +FIG00077440 Predicted N6-adenine-specific RNA methylase containing THUMP domain +FIG00077461 Bsl0345 protein +FIG00077466 RstA phage-related replication protein +FIG00077469 Achromobactin biosynthesis protein AcsD @ Siderophore synthetase superfamily, group A +FIG00077562 Circadian input kinase A / Phytochrome-like protein +FIG00077601 omega-3 polyunsaturated fatty acid synthase subunit, PfaB +FIG00077620 Single-stranded DNA-binding protein +FIG00077647 Monomethylamine permease +FIG00077666 Polyhydroxyalkanoate granule-associated protein PhaF +FIG00077673 Flagellar protein FlbB +FIG00077780 Sigma-70 factor FpvI (ECF subfamily), controling pyoverdin biosynthesis +FIG00077825 Phage NinG rap recombination +FIG00077849 Ethanolamine utilization protein similar to PduU +FIG00077876 UDP-glucuronate 5'-epimerase (EC 5.1.3.12) +FIG00077927 Aliphatic sulfonate monooxygenase family, FMNH2- or F420-dependent +FIG00077951 Uncharacterized protein MJ0065 +FIG00078028 Tetrachloroethene reductive dehalogenase PceA (EC 1.97.1.8) +FIG00078081 Glutamine synthetase type II, eukaryotic (EC 6.3.1.2) +FIG00078083 5'-nucleotidase family protein in cluster with NagD-like phosphatase +FIG00078127 Flagellar hook-basal body complex protein FliE +FIG00078334 Phthalate 3,4-dioxygenase beta subunit +FIG00078450 Cytochrome c2 +FIG00078593 Acyl carrier protein associated with anthrachelin biosynthesis / Hypothetical protein GBAA1985 associated with anthrachelin biosynthesis, unique +FIG00078613 FIG078613: hypothetical protein in iron scavenging cluster +FIG00078626 LSU ribosomal protein L7Ae +FIG00078671 Eukaryotic peptide chain release factor subunit 1 +FIG00078683 Heterocyst differentiation protein HetC +FIG00078697 Nicel/Cobalt-specific TonB-dependent outer membrane receptor +FIG00078818 Phytoene/squalene synthetase-like protein +FIG00078918 Tellurite resistance protein TrgA +FIG00079075 Hydroxymethylpyrimidine phosphate synthase ThiC (EC 4.1.99.17) / Thiamin-phosphate pyrophosphorylase (EC 2.5.1.3) +FIG00079085 type IV pili signal transduction protein PilI +FIG00079247 predicted biotin regulatory protein BioR (GntR family) +FIG00079328 Nitrous oxide reductase maturation periplasmic protein NosX +FIG00079368 Glutaredoxin +FIG00079505 Type III secretion translocator of effector proteins (HrpF, NolX) +FIG00079521 TRAP dicarboxylate transporter, DctM subunit, unknown substrate 8 +FIG00079533 Suppression of copper sensitivity: putative copper binding protein ScsA +FIG00079537 Predicted 5-dehydro-4-deoxyglucarate regulator YcbG +FIG00079648 Pyridine nucleotide-disulphide oxidoreductase associated with reductive pyrimidine catabolism +FIG00079700 Heme ABC transporter, cell surface heme and hemoprotein receptor HmuT +FIG00079740 Xyloside transporter XynT +FIG00079746 Dimethylsulfoniopropionate (DSMP) lyase DddL +FIG00079788 Energy conserving hydrogenase Eha small subunit homolog (protein N) +FIG00079804 Eukaryotic translation initiation factor 6 +FIG00079822 Aspartate ammonia-lyase (EC 4.3.1.1) +FIG00079825 Methylmalonyl-CoA decarboxylase, gamma chain (EC 4.1.1.41) +FIG00079833 FIG079833: putative dimethyladenosine transferase +FIG00079879 alternative photosystem I reaction center subunit X (PsaK2) +FIG00079888 Succinyl-CoA:3-ketoacid-coenzyme A transferase subunit A (EC 2.8.3.5) / Succinyl-CoA:3-ketoacid-coenzyme A transferase subunit B (EC 2.8.3.5) +FIG00079900 DNA-binding protein MTH1615 +FIG00079981 Predicted glucose transporter in beta-glucoside utilization gene cluster +FIG00079988 Copper-translocating P-type ATPase (EC 3.6.3.4) +FIG00080072 transmembrane protein, distant homology with ydbT +FIG00080099 Beta-glucanase precursor (EC 3.2.1.73) +FIG00080110 TrkA-N:Sodium/hydrogen exchanger +FIG00080118 Vi polysaccharide biosynthesis protein tviD +FIG00080231 Ribosome protection-type tetracycline resistance related proteins, group 2 +FIG00080271 Cyanobacteria-specific RpoD-like sigma factor, type-2 @ Group 2 RNA polymerase sigma factor +FIG00080381 Major myo-inositol transporter IolT +FIG00080382 Formylmethanofuran--tetrahydromethanopterin N-formyltransferase (EC 2.3.1.101) +FIG00080395 Type IV pilus biogenesis protein PilO; Competence protein PilO +FIG00080451 n-type ATP pyrophosphatase superfamily / TilS and TtcA-like +FIG00080534 Pyrrolysine synthetase +FIG00080642 putative Cytochrome bd2, subunit I +FIG00080658 Predicted biotin repressor from TetR family +FIG00080676 Possible alpha/beta hydrolase superfamily, tll2163 homolog +FIG00080700 Spore germination protein GerAA, germination response to L-alanine and related amino acids (earliest stage) +FIG00080818 3-hydroxyacyl-CoA dehydrogenase (PaaH) (EC 1.1.1.157) +FIG00080874 Main regulator of heterocyst differentiation HetR +FIG00080904 DNA methyl transferase, phage-associated +FIG00080952 Tetrachloroethene reductive dehalogenase TceA membrane-bound subunit +FIG00080955 Helicase PriA essential for oriC/DnaA-independent DNA replication +FIG00081016 FIG005429: hypothetical protein +FIG00081068 PTS system, sucrose-specific IIB component (EC 2.7.1.69) / PTS system, sucrose-specific IIC component (EC 2.7.1.69) +FIG00081201 FIG081201: hypothetical protein +FIG00081230 tRNA (adenine57/58-N1)-methyltransferase (EC 2.1.1.36) +FIG00081311 rubredoxin-oxygen oxidoreductase +FIG00081441 Conjugative transposon protein TraA +FIG00081553 Alpha-arabinosides ABC transport system, permease protein 1 +FIG00081563 N-acetylmannosamine kinase (EC 2.7.1.60) +FIG00081580 Arsenic efflux pump protein +FIG00081591 Two-component sensor histidine kinase BceS +FIG00081664 RNA polymerase heat shock sigma factor SigI +FIG00081667 5-FCL-like protein +FIG00082059 Hydroxyneurosporene dehydrogenase (EC 1.-.-.-) +FIG00082097 Diaminohydroxyphosphoribosylaminopyrimidine deaminase (EC 3.5.4.26) / Domain of unknown function +FIG00082138 vacuolating cytotoxin +FIG00082274 Methane monooxygenase component A beta chain (EC 1.14.13.25) +FIG00082379 Glutathione S-transferase N-terminal domain protein (EC 2.5.1.18) +FIG00082496 hydrogenase, group 4, HycE subunit, putative +FIG00082526 IncQ plasmid conjugative transfer protein TraG +FIG00082612 Capsular polysaccharide repeating-unit polymerase CpsH +FIG00082657 IncI1 plasmid conjugative transfer protein TraX +FIG00082709 Gamma-glutamyl-aminobutyraldehyde dehydrogenase (EC 1.2.1.-) +FIG00083017 Serine protease, DegP/HtrA, do-like (EC 3.4.21.-) +FIG00083019 Glyoxylate reductase (1.1.1.26) / Hydroxypyruvate reductase (EC 1.1.1.81) +FIG00083207 Dehydrogenase flavoprotein LodB +FIG00083257 Cobyric acid synthase (EC 6.3.5.10) / Adenosylcobinamide-phosphate guanylyltransferase (EC 2.7.7.62) +FIG00083321 Vitamin B12 ABC transporter, ATPase component BtuD / Adenosylcobinamide amidohydrolase (EC 3.5.1.90) +FIG00083472 [Fe] hydrogenase, HymB subunit, putative +FIG00083565 ATPase with chaperone activity, associated with Flp pilus assembly +FIG00083717 ATP-dependent DNA helicase UvrD/PcrA/Rep, cyanobacterial paralog +FIG00083946 Phosphate transport system permease protein PstA (TC 3.A.1.7.1) +FIG00083973 CAMP phosphodiesterases class-II:Metallo-beta-lactamase superfamily +FIG00084095 2,3-dihydroxy-p-cumate-3,4-dioxygenase (CmtC) +FIG00084105 2-C-methyl-D-erythritol 2,4-cyclodiphosphate synthase (EC 4.6.1.12) +FIG00084118 Tetrachloroethene reductive dehalogenase PceA membrane-bound subunit +FIG00084203 Hypothetical protein in ApbE locus +FIG00084222 Proteorhodopsin +FIG00084255 Stage III sporulation protein AC +FIG00084466 Lycopene epsilon cyclase +FIG00084485 CoB--CoM-reducing hydrogenase (Sec) alpha subunit @ selenocysteine-containing +FIG00084557 Putative TolA protein involved in Tol transport system in Chlamydia +FIG00084561 Hypothetical protein associated with desferrioxamine E biosynthesis +FIG00084562 Acyltransferase family protein associated with ethylmalonyl-CoA pathway +FIG00084569 FIG084569: hydrolase, alpha/beta fold family +FIG00084588 Unknown, probably involved in type III secretion +FIG00084637 DNA-directed RNA polymerase alpha subunit domain +FIG00084658 Hypothetical SAV0792 homolog in superantigen-encoding pathogenicity islands SaPI +FIG00084745 Predicted secretion system X FIG084745: hypothetical protein +FIG00084781 photosystem I 4.8K protein (PsaX) +FIG00084786 Histidine ABC transporter, histidine-binding periplasmic protein precursor HisJ (TC 3.A.1.3.1) +FIG00084883 Autoinducer 1 sensor kinase/phosphatase LuxN (EC 2.7.3.-) (EC 3.1.3.-) +FIG00084998 B12 binding domain / kinase domain / Methylmalonyl-CoA mutase (EC 5.4.99.2) +FIG00085009 Formate dehydrogenase O alpha subunit (EC 1.2.1.2) +FIG00085031 Nitrogenase FeMo-cofactor scaffold and assembly protein NifE / Nitrogenase FeMo-cofactor scaffold and assembly protein NifN +FIG00085033 UDP-N-acetylmuramoylalanine--D-glutamate ligase (EC 6.3.2.9) +FIG00085180 Tetrathionate reductase two-component response regulator +FIG00085182 NAD-dependent formate dehydrogenase alpha subunit +FIG00085197 Trimethylamine methyltransferase corrinoid protein +FIG00085227 Putative Acyl-CoA thiolase +FIG00085285 Nickel-dependent hydrogenase, large subunit +FIG00085334 Conjugative transposon protein TraB +FIG00085353 Putative thiol:disulfide oxidoreductase involved in cytochrome C-type biogenesis +FIG00085487 Formate dehydrogenase alpha subunit (EC 1.2.1.2) +FIG00085530 DNA replication helicase protein MCM @ intein-containing +FIG00085608 1,4-dihydroxy-2-naphthoate polyprenyltransferase (EC 2.5.1.74) +FIG00085723 Integration host factor alpha subunit +FIG00085740 N-acetylhexosamine 1-kinase +FIG00085764 TesB-like acyl-CoA thioesterase 4 +FIG00085770 PTS system, D-allose-specific IIB component (EC 2.7.1.69) / PTS system, D-allose-specific IIC component (EC 2.7.1.69) / PTS system, D-allose-specific IIA component (EC 2.7.1.69) +FIG00085852 tRNA (Guanine37-N1) -methyltransferase (EC 2.1.1.31) / protein of unknown function aq_054 +FIG00085920 Photosystem II protein PsbY +FIG00085936 NAD-dependent formate dehydrogenase alpha subunit @ selenocysteine-containing +FIG00086005 Acetylornithine deacetylase (EC 3.5.1.16); N-acetyl-lysine deacetylase (EC 3.5.1.-) +FIG00086043 Molybdopterin oxidoreductase subunit, predicted; chaperone protein HtpG +FIG00086056 Phycobilisome degradation protein NblA +FIG00086220 Oligo-1,6-glucosidase (EC 3.2.1.10) +FIG00086289 ATPase component STY3232 of energizing module of queuosine-regulated ECF transporter / ATPase component STY3233 of energizing module of queuosine-regulated ECF transporter +FIG00086487 hypothetical protein sometimes fused to ribosomal protein S6 glutaminyl transferase +FIG00086540 IncI1 plasmid conjugative transfer protein TraR +FIG00086649 Colanic acid biosynthesis acetyltransferase WcaF (EC 2.3.1.-) +FIG00086688 Phosphoribosylaminoimidazolecarboxamide formyltransferase [alternate form] +FIG00086697 Beta-1,3-glucosyltransferase +FIG00086707 Photosynthetic reaction center H subunit +FIG00086761 CoB--CoM-reducing hydrogenase (Sec) delta subunit @ selenocysteine-containing +FIG00086831 TonB-dependent siderophore receptor +FIG00086941 Predicted RNA-binding protein COG1491 +FIG00087063 NADH-quinone oxidoreductase chain F 2 (EC 1.6.99.5); Hypothetical FeS oxidoreductase +FIG00087157 Urea ABC transporter, urea binding protein +FIG00087161 probable RuBisCo-expression protein CbbX +FIG00087169 Aspartyl-tRNA(Asn) amidotransferase subunit B (EC 6.3.5.6) @ Glutamyl-tRNA(Gln) amidotransferase subunit B (EC 6.3.5.7) / Aspartyl-tRNA synthetase (EC 6.1.1.12) @ Aspartyl-tRNA(Asn) synthetase (EC 6.1.1.23) +FIG00087231 Glyceraldehyde-3-phosphate ketol-isomerase (EC 5.3.1.1) +FIG00087317 Bilin biosynthesis protein MpeU +FIG00087463 Formylmethanofuran dehydrogenase (tungsten) operon gene G +FIG00087516 Similar to ribosomal large subunit pseudouridine synthase D, TTE1780-type +FIG00087623 Glycosyltransferase LafA, responsible for the formation of Glc-DAG +FIG00087648 Hypothetical protein in predicted poly-gamma-glutamate synthase operon +FIG00087702 Benzoate transport, ATP binding protein +FIG00087842 FIG087842: Hypothetical protein +FIG00087875 Multidrug-efflux transporter, major facilitator superfamily (MFS) (TC 2.A.1) +FIG00087897 Permease of the major facilitator superfamily in achromobactin biosynthesis operon +FIG00088067 Duplicated ATPase component CbrU of energizing module of predicted cobalamin ECF transporter +FIG00088103 Predicted galacto-N-biose-/lacto-N-biose I ABC transporter, permease component 1 +FIG00088405 Glycine reductase component B beta subunit (EC 1.21.4.2) / Glycine reductase component B alpha subunit (EC 1.21.4.2) +FIG00088522 Melibiose carrier protein, Na+/melibiose symporter +FIG00088533 Cobalt-precorrin-2 C20-methyltransferase (EC 2.1.1.130) +FIG00088537 L-Cystine ABC transporter, periplasmic cystine-binding protein TcyA +FIG00088538 Putative uncharacterized protein TTHA1760 +FIG00088598 Hypothetical protein in aerobactin uptake cluster +FIG00088630 ABC transporter, ATP-binding protein, ortholog to Borrelia burgdorferi BB0466 +FIG00088723 Fimbrial protein Yad-like +FIG00088850 Copper resistance protein C precursor +FIG00088865 Phycoerythrocyanin beta chain +FIG00088996 Substrate-specific component PanT of predicted pantothenate ECF transporter +FIG00089051 Small acid-soluble spore protein, beta-type SASP +FIG00089163 GldD +FIG00089252 Transcriptional regulator, RofA +FIG00089363 Seryl-tRNA synthetase (EC 6.1.1.11), archaeal +FIG00089374 Predicted RNA methylase COG2263 +FIG00089384 Sulfate permease, Pit-type +FIG00089446 15,16-dihydrobiliverdin:ferredoxin oxidoreductase PebA (EC 1.3.7.2) +FIG00089473 Activator of the mannose operon (transcriptional antiterminator), BglG family +FIG00089616 LysR family transcriptional regulator clustered with dicarboxylate transport +FIG00089699 Creatinase (EC 3.5.3.3) +FIG00089707 Outer membrane protein H precursor +FIG00089740 Beta-glucoside ABC transport system, sugar-binding protein +FIG00089781 Possible alpha-xyloside ABC transporter, permease component +FIG00089870 Family 13 glycosyl hydrolase, row 724 +FIG00089999 ATP-dependent helicase, DEAD/DEAH box family, associated with Flp pilus assembly +FIG00090031 UDP-sulfoquinovose synthase (EC 3.13.1.1) +FIG00090068 Nitrate ABC transporter, ATP-binding protein / Nitrate ABC transporter, nitrate-binding protein +FIG00090246 Zona occludens toxin +FIG00090327 p-cymene degradation operon transcriptional regulator +FIG00090410 Putative CDP-glycosylpolyol phosphate:glycosylpolyol glycosylpolyolphosphotransferase +FIG00090418 Saccharopine dehydrogenase [NADP , L-glutamate-forming] (EC 1.5.1.10) +FIG00090475 Inner membrane protein DotU +FIG00090491 Biphenyl dioxygenase system ferredoxin component +FIG00090514 Hypothetical protein RbmB +FIG00090522 Siroheme synthase / Precorrin-2 oxidase (EC 1.3.1.76) / Sirohydrochlorin ferrochelatase (EC 4.99.1.4) / Uroporphyrinogen-III methyltransferase (EC 2.1.1.107) +FIG00090701 Tetracycline resistance protein TetW +FIG00090749 Anti-cleavage anti-GreA transcription factor Gfh1 +FIG00090765 Lactose and galactose permease, GPH translocator family +FIG00090781 LSU ribosomal protein L14p (L23e) +FIG00090914 Nickel-dependent hydrogenase, small subunit +FIG00090958 Fructokinase in mannoside utilization gene cluster (EC 2.7.1.4) +FIG00091179 Fructose ABC transporter, permease component FrcC +FIG00091204 Transmembrane regulator protein PrtR +FIG00091239 Putative achromobactin biosynthesis protein, related to 2-demethylmenaquinone methyltransferase +FIG00091347 Pectin degradation protein KdgF +FIG00091493 IncQ plasmid conjugative transfer DNA nicking endonuclease TraR (pTi VirD2 homolog) +FIG00091584 Cytochrome c553-like +FIG00091606 Methionine synthase activation domain (EC 2.1.1.13) +FIG00091940 Histidine ammonia-lyase (EC 4.3.1.3) +FIG00091949 Dimethylglycine dehydrogenase (EC 1.5.99.2) +FIG00092041 TonB system biopolymer transport component; Chromosome segregation ATPase +FIG00092051 putative membrane protein +FIG00092101 3-oxoacyl-[acyl-carrier-protein] synthase (EC 2.3.1.41); Malonyl CoA-acyl carrier protein transacylase (EC 2.3.1.39) +FIG00092115 FIG092115: Oxidoreductase, aldo/keto reductase family +FIG00092279 Xylose-responsive transcription regulator, ROK family +FIG00092303 Hypothetical SAV0789 homolog in superantigen-encoding pathogenicity islands SaPI +FIG00092351 Beta-1,4-N-acetylgalactosaminyltransferase (EC 2.4.1.-) / N-Acetylneuraminate cytidylyltransferase (EC 2.7.7.43) +FIG00092459 Propionate catabolism operon transcriptional regulator of GntR family [predicted] +FIG00092479 biphenyl-2,3-diol 1,2-dioxygenase III-related protein VCA0463 VCA0328 VCA0341 +FIG00092574 transcriptional regulator SoxR +FIG00092584 Uncharacterized protein YidS +FIG00092649 Ribonuclease P protein component (EC 3.1.26.5) +FIG00092725 Dissimilatory sulfite reductase (desulfoviridin), alpha and beta subunits +FIG00092760 Energy-conserving hydrogenase (ferredoxin), subunit F +FIG00092843 TRAP dicarboxylate transporter, DctM subunit, unknown substrate 7 +FIG00092882 IncI1 plasmid conjugative transfer protein TraP +FIG00093014 Porphobilinogen deaminase (EC 2.5.1.61) / Uroporphyrinogen-III synthase, divergent, Flavobacterial type (EC 4.2.1.75) +FIG00093022 Archaeal DNA polymerase II small subunit (EC 2.7.7.7) +FIG00093098 3-carboxyethylcatechol 2,3-dioxygenase (EC 1.13.11.16) +FIG00093180 Choline binding protein A +FIG00093200 Proteasome subunit beta (EC 3.4.25.1), archaeal +FIG00093264 Dissimilatory sulfite reductase clustered protein DsrD +FIG00093352 CRISPR-associated RecB family exonuclease Cas4a +FIG00093377 FIG093377: FHA domain-containing protein +FIG00093506 Phycoerythrin gamma chain linker polypeptide +FIG00093544 FIG149030: hypothetical protein +FIG00093903 Conjugative signal peptidase TrhF +FIG00093957 Signal transduction histidine kinase HoxJ (hydrogenase regulation) +FIG00093999 Competence protein PilN +FIG00094011 D(-)-3-hydroxybutyrate oligomer hydrolase (EC 3.1.1.22) +FIG00094085 Predicted methyltransferase, DUF43 family +FIG00094132 Hypothetical SAV0801 homolog in superantigen-encoding pathogenicity islands SaPI +FIG00094176 Urocanate hydratase (EC 4.2.1.49) +FIG00094280 protein of unknown function DUF1403 +FIG00094335 FIG094335: Putative phage protein +FIG00094346 p-cumate dioxygenase ferredoxin +FIG00094383 Sulfhydrogenase II subunit b +FIG00094401 Lacto-N-biose phosphorylase (EC 2.4.1.211) +FIG00094409 Radical SAM family enzyme, similar to coproporphyrinogen III oxidase, oxygen-independent, clustered with nucleoside-triphosphatase RdgB +FIG00094447 Vi polysaccharide export inner-membrane protein vexB +FIG00094525 Aromatic-amino-acid aminotransferase (EC 2.6.1.57) +FIG00094658 SSU ribosomal protein S25e +FIG00094764 Peptide transport periplasmic protein SapA +FIG00094826 Gene Transfer Agent (GTA) ORFG07 / Bacteriophage head-tail adaptor +FIG00094874 Red chlorophyll catabolite reductase (EC 1.-.-.-) +FIG00094930 Beta-lysine acetyltransferase (EC 2.3.1.-) / Lysine 2,3-aminomutase (EC 5.4.3.2) +FIG00094966 IncF plasmid conjugative transfer protein TrbJ +FIG00095018 All3116 protein +FIG00095112 Crossover junction endodeoxyribonuclease RuvC (EC 3.1.22.4) +FIG00095148 Predicted transcriptional regulator of N-Acetylglucosamine utilization, LacI family +FIG00095254 Cyanate hydratase (EC 4.2.1.104) +FIG00095288 Cell wall endopeptidase, family M23/M37 +FIG00095599 formate dehydrogenase formation protein FdhE +FIG00095620 Predicted erythritol ABC transporter 2, hypothetical lipoprotein +FIG00095672 Ribonuclease HI-related protein 2 +FIG00095749 Possible alpha/beta hydrolase superfamily, slr1917 homolog +FIG00095822 Pseudouridine kinase (EC 2.7.1.83) +FIG00095830 Putative Heme-regulated two-component response regulator +FIG00095838 FIG095838: hypothetical protein +FIG00095943 Methane monooxygenase regulatory protein B +FIG00095947 Flagella-related protein FlaH +FIG00096095 Hypothetical SAR0369 homolog in superantigen-encoding pathogenicity islands SaPI +FIG00096155 Protein BchJ, involved in reduction of C-8 vinyl of divinyl protochlorophyllide +FIG00096162 Transcriptional regulator KdgR, KDG operon repressor +FIG00096515 L-threonine 3-O-phosphate decarboxylase (EC 4.1.1.81) / Cobyric acid synthase (EC 6.3.5.10) +FIG00096540 Energy-conserving hydrogenase (ferredoxin), subunit D +FIG00096593 Cytochrome d ubiquinol oxidase subunit I (EC 1.10.3.-) +FIG00096667 type III secretion protein HrpB(Pto) +FIG00096830 Ribose-phosphate pyrophosphokinase (EC 2.7.6.1) +FIG00096834 Sulfite reduction-associated complex DsrMKJOP multiheme protein DsrJ (=HmeF) +FIG00096897 Hypothetical SAV0793 homolog in superantigen-encoding pathogenicity islands SaPI +FIG00096929 2,3-dihydroxy-2,3-dihydro-p-cumate dehydrogenase(CmtB) (EC 1.1.1.100) +FIG00096994 Heterocyst differentiation protein HetP +FIG00097000 PTS system, trehalose-specific IIB component (EC 2.7.1.69) / PTS system, trehalose-specific IIC component (EC 2.7.1.69) +FIG00097052 FIG097052: Sugar transporter +FIG00097084 Serine-protease NalP involved in processing of other autotransporters / autotransporter domain, T5aSS type secretion +FIG00097460 CRISPR-associated RAMP Cmr3 +FIG00097496 photosystem I assembly related protein Ycf3 +FIG00097505 Flavocytochrome c heme subunit +FIG00097548 Predicted thiamin transporter ThiT +FIG00097597 Partial urea carboxylase (EC 6.3.4.6) +FIG00097608 5-methylthioribose kinase (EC 2.7.1.100) +FIG00097706 bll7545; putative esterase +FIG00097743 Conjugative transposon protein TraI +FIG00097886 Neopullulanase (EC 3.2.1.135) / Maltodextrin glucosidase (EC 3.2.1.20) +FIG00097951 Spheroidene monooxygenase +FIG00097968 Conjugative transfer protein TrbA +FIG00098005 CI-like repressor, superantigen-encoding pathogenicity islands SaPI +FIG00098029 Late competence protein ComER, similarity with Pyrroline-5-carboxylate reductase +FIG00098135 IncI1 plasmid conjugative transfer integral membrane protein TraY +FIG00098195 p53-regulating protein kinase (human PRPK/yeast YGR262c) +FIG00098273 Glycine/sarcosine/betaine reductase component C chain 2 +FIG00098404 FIG098404: Hypothetical protein +FIG00098480 Heme ABC transporter, permease protein HmuU +FIG00098481 Biphenyl dioxygenase alpha subunit (EC 1.14.12.18) +FIG00098821 Flagella-related protein FlaF +FIG00099001 Conjugative transfer protein ELI_04330 +FIG00099224 FIG138315: Putative alpha helix protein +FIG00099240 Transcriptional regulator, TetR family, in cluster with 2-hydroxychromene-2-carboxylate isomerase family protein, glutathione-dependent +FIG00099259 Response regulator NasT +FIG00099284 Mu-like prophage FluMu protein gp37 +FIG00099294 Menaquinone-cytochrome C reductase iron-sulfur subunit +FIG00099318 RNA polymerase sigma factor SigV +FIG00099352 FIG099352: hypothetical protein +FIG00099389 PilS cassette +FIG00099514 Conserved protein YcjX with nucleoside triphosphate hydrolase domain +FIG00099516 Putative thylakoid membrane protein, contains 8 pentapeptide repeats, sll0274 homolog +FIG00099726 Internalin-like protein (LPXTG motif) Lin1204 homolog +FIG00099730 Translation initiation factor 2 @ intein-containing +FIG00099737 Transcriptional regulator ligR, LysR family +FIG00099804 D-alanyl-D-alanine dipeptidase (EC 3.4.13.22) @ Vancomycin B-type resistance protein VanX +FIG00099819 Conjugative transposon protein TraF +FIG00100068 FIG100068: Hypothetical protein +FIG00100329 Carboxysome protein CcmM +FIG00100407 Dihydrofolate reductase (EC 1.5.1.3) / Segregation and condensation protein A +FIG00100439 Translation elongation factor 2 +FIG00100472 Flavocytochrome c flavin subunit +FIG00100502 Autoinducer synthesis protein LuxI +FIG00100504 Phenylalanine-4-hydroxylase (EC 1.14.16.1) - Long +FIG00100582 Glycerol uptake facilitator protein @ Propanediol diffusion facilitator +FIG00100659 Phosphopantetheine adenylyltransferase, type II eukaryotic (EC 2.7.7.3) / DUF84 +FIG00100716 carboxysome shell protein CsoS2 +FIG00100905 Uncharacterized HTH-type transcriptional regulator MJ0621 +FIG00100961 Tricarboxylate transport membrane protein TctA / Tricarboxylate transport protein TctB +FIG00101113 Pertussis toxin subunit 2 precursor (PTX S2) +FIG00101140 Cyanate transport protein CynX +FIG00101309 COG4073: protein of unknown function in methanogens +FIG00101535 N-acylamino acid racemase +FIG00101578 Folate transporter 3 +FIG00101624 NusA protein homolog 2, archaeal +FIG00101625 Sulfur oxidation protein SoxB +FIG00101741 Polyketide cyclase WhiE VII +FIG00101898 Hypothetical SAV0797 homolog in superantigen-encoding pathogenicity islands SaPI +FIG00101933 Zinc-regulated TonB-dependent outer membrane receptor +FIG00101975 Putative 2-keto-3-deoxygluconate kinase (EC 2.7.1.45) +FIG00101992 Mercuric transport protein, MerE +FIG00102079 Hypothetical protein ortholog to Borrelia burgdorferi BB0464 +FIG00102132 Deoxycytidine triphosphate deaminase (EC 3.5.4.13) +FIG00102247 Predicted sodium-dependent mannose transporter +FIG00102319 Ferric vulnibactin receptor VuuA +FIG00102414 omega-3 polyunsaturated fatty acid synthase subunit, PfaA +FIG00102416 Threonyl-tRNA synthetase-related protein +FIG00102439 HupE-UreJ family cobalt transporter +FIG00102465 Multidrug efflux transporter MexF +FIG00102469 Mu-like prophage FluMu I protein +FIG00102493 Small acid-soluble spore protein, alpha-type SASP +FIG00102562 Histidine utilization repressor +FIG00102653 Structure-specific tRNA-binding protein +FIG00102673 putative sodium-dependent bicarbonate transporter +FIG00102687 Lysine-epsilon oxidase (EC 1.4.3.20) antimicrobial protein LodA +FIG00102688 RNA polymerase sigma factor SigW +FIG00102709 Heme ABC transporter, ATPase component HmuV +FIG00102780 LSU ribosomal protein L21e +FIG00102798 CTP:Inositol-1-phosphate cytidylyltransferase (2.7.7.-) +FIG00102908 IncI1 plasmid conjugative transfer protein TraE +FIG00102933 Chemotaxis protein CheX +FIG00102939 Phycocyanobilin lyase alpha subunit +FIG00103122 tRNA-dependent lipid II--glycine ligase @ tRNA-dependent lipid II-Gly--glycine ligase +FIG00103126 Cytochrome c oxidase subunit CcoN (EC 1.9.3.1) +FIG00103303 Hypothetical SAV0798 homolog in superantigen-encoding pathogenicity islands SaPI +FIG00103367 poly(beta-D-mannuronate) lyase (EC 4.2.2.3) +FIG00103499 Methylene tetrahydromethanopterin dehydrogenase (EC 1.5.99.9) +FIG00103606 RuBisCO operon transcriptional regulator +FIG00103613 Anti-sigma F factor antagonist (spoIIAA-2); Anti-sigma B factor antagonist RsbV +FIG00103625 Predicted transcriptional regulator of cysteine synthase, Rrf2 family +FIG00103661 Transcriptional regulator, MerR family, near polyamine transporter +FIG00104028 Binding-protein-dependent transport systems inner membrane component:ATP/GTP-binding site motif A (P-loop) :TrkA-N:Potassium e +FIG00104085 Hypothetical protein ortholog to Borrelia burgdorferi BB0465 +FIG00104146 FIG104146: hypothetical protein +FIG00104261 Photosystem II protein PsbX +FIG00104354 Ribonuclease P protein component 4 (EC 3.1.26.5) +FIG00104511 Single-stranded DNA-binding protein / Single-stranded DNA-binding protein +FIG00104670 Type III secretion, hypothetical protein +FIG00104687 NAD(P)H-plastoquinone oxidoreductase (EC 1.6.5.-) subunit K, NDHK +FIG00104738 RuBisCO operon transcriptional regulator CbbR +FIG00104788 Phage NinC +FIG00104848 Phosphate transport system regulatory protein PhoU +FIG00104852 Predicted D-lactate dehydrogenase, Fe-S protein, FAD/FMN-containing +FIG00104894 Small uncharacterized protein Bpro_4170 / Protein of unknown function DUF1446 +FIG00104950 2'-O-glycosyltransferase CruG +FIG00105028 IncF plasmid conjugative transfer surface exclusion protein TraS +FIG00105129 biphenyl-2,3-diol 1,2-dioxygenase III-related protein +FIG00105281 Predicted galacto-N-biose-/lacto-N-biose I ABC transporter, permease component 2 +FIG00105359 Cyanobacteria-specific RpoD-like sigma factor, type-14 +FIG00105365 Hypothetical radical SAM family enzyme, NOT coproporphyrinogen III oxidase, oxygen-independent +FIG00105509 Phosphomethylpyrimidine kinase (EC 2.7.4.7) +FIG00105527 Ethanolamine utilization protein similar to PduV +FIG00105533 Tryptophan synthase alpha chain (EC 4.2.1.20) +FIG00105721 Benzoate transport, inner-membrane translocator precursor +FIG00105942 Regulator of carotenoid biosynthesis; Transcriptional regulator, PpsR +FIG00106088 Heat shock protein FtsJ/RrmJ @ Ribosomal RNA large subunit methyltransferase E (EC 2.1.1.-) +FIG00106126 Acetylglutamate kinase (EC 2.7.2.8) @ Acetylaminoadipate kinase (EC 2.7.2.-) +FIG00106248 Nitrogenase (iron-iron) reductase and maturation protein AnfH +FIG00106273 D-xylose proton-symporter XylE +FIG00106284 IncI1 plasmid conjugative transfer protein TraU +FIG00106349 Putative N-acetylgalactosaminyl-diphosphoundecaprenol glucuronosyltransferase +FIG00106413 Lycopene beta cyclase (EC 1.14.-.-) +FIG00106460 Predicted alternative glutathione synthetase (EC 6.3.2.3) +FIG00106480 Protein of unknown function UPF0047 +FIG00106599 2,3-butanediol dehydrogenase, S-alcohol forming, (S)-acetoin-specific (EC 1.1.1.76) +FIG00106647 7,8-didemethyl-8-hydroxy-5-deazariboflavin synthase subunit 2 +FIG00106663 DNA polymerase III delta subunit (EC 2.7.7.7) +FIG00106696 IncI1 plasmid conjugative transfer protein TraQ +FIG00106752 Putative cyclic di-GMP phosphodiesterase, EAL domain protein +FIG00106768 YLXX protein +FIG00107024 Translation initiation factor 3 related protein +FIG00107038 Shufflon-specific DNA recombinase +FIG00107090 Uncharacterized siderophore S biosynthesis protein, AcsC-like @ Siderophore synthetase superfamily, group C @ Siderophore synthetase component, ligase +FIG00107119 Predicted thiazole transporter ThiU +FIG00107208 Hypothetical protein ortholog to Borrelia burgdorferi BB0468 +FIG00107285 Achromobactin biosynthesis protein AcsE, Orn/DAP/Arg decarboxylase family +FIG00107349 Glycine/sarcosine/betaine reductase component C chain 1 +FIG00107554 Predicted cobalt transporter CbtC +FIG00107906 Mu-like prophage protein GP36 +FIG00107971 Inner membrane ABC transporter permease protein YcjP +FIG00108043 histone acetyltransferase, ELP3 family +FIG00108063 Negative regulator of phenolic acid metabolism PadR +FIG00108124 Flagellar biosynthesis protein FliQ +FIG00108285 Ribose ABC transport system, permease protein RbsC (TC 3.A.1.2.1) / Ribose ABC transport system, periplasmic ribose-binding protein RbsB (TC 3.A.1.2.1) +FIG00108342 tRNA-i(6)A37 methylthiotransferase +FIG00108431 Conjugative transfer protein ELI_00880 +FIG00108586 Energy conserving hydrogenase Ehb transmembrane protein E +FIG00108740 FIG108740: putative two-component response regulator +FIG00108813 D-amino acid dehydrogenase large subunit (EC 1.4.99.1) +FIG00108957 Candidate substrate-specific domain of ECF transporters in Mycobacteria / Duplicated ATPase component of energizing module of predicted ECF transporter in Mycobacteria +FIG00109309 Secreted protein Ear, superantigen-encoding pathogenicity islands SaPI +FIG00109339 Type III effector +FIG00109428 Probable 3-phenylpropionic acid transporter +FIG00109461 CysQ, putative +FIG00109555 Uroporphyrinogen-III methyltransferase (EC 2.1.1.107) +FIG00109595 Non-specific DNA-binding protein Dps / Iron-binding ferritin-like antioxidant protein / Ferroxidase (EC 1.16.3.1) +FIG00109604 DNA polymerase III alpha subunit (EC 2.7.7.7) / Carboxy-terminal intein-mediated trans-splice +FIG00109688 Glycogen debranching enzyme (EC 3.2.1.-) +FIG00109713 TRAP transporter solute receptor, unknown substrate 7 +FIG00109793 Nudix dNTPase DR1776 (EC 3.6.1.-) +FIG00109897 TRAP-type transport system, periplasmic component, predicted N-acetylneuraminate-binding protein +FIG00109914 Putative ABC transporter of substrate X, permease subunit II +FIG00109976 photosystem I subunit III precursor, plastocyanin (cyt c553) docking protein (PsaF) +FIG00110059 Outer membrane receptor for ferric-pyochelin FptA +FIG00110067 Believed to be involved in assembly of Fe-S clusters +FIG00110223 2,4-dihydroxyhept-2-ene-1,7-dioic acid aldolase (EC 4.1.2.n4) +FIG00110436 Lmo0069 homolog within ESAT-6 gene cluster +FIG00110521 Mlc, transcriptional repressor of MalT (the transcriptional activator of maltose regulon) and manXYZ operon +FIG00110555 FIGfam110555 +FIG00110615 Nickel transporter UreH +FIG00110947 Organomercurial lyase (EC 4.99.1.2) +FIG00111064 Catechol siderophore ABC transporter, substrate-binding protein +FIG00111198 Predicted rhamnulose-1-phosphate aldolase (EC 4.1.2.19) / Predicted lactaldehyde dehydrogenase (EC 1.2.1.22) +FIG00111267 Trehalase (EC 3.2.1.28) +FIG00111388 Conjugative transfer protein TraA +FIG00111447 Substrate-specific component FolT of folate ECF transporter / Aspartyl-tRNA(Asn) amidotransferase subunit C (EC 6.3.5.6) @ Glutamyl-tRNA(Gln) amidotransferase subunit C (EC 6.3.5.7) +FIG00111469 Predicted erythritol ABC transporter 1, ATP-binding component 1 +FIG00111547 Putative prenyltransferase, contains 1,4-dihydroxy-2-naphthoate octaprenyltransferase domain +FIG00111678 FIG111678: IS, phage, Tn; Transposon-related functions +FIG00111686 PurR: transcription regulator associated with purine metabolism +FIG00111848 ATP-dependent DNA ligase (EC 6.5.1.1) LigC +FIG00111925 Phycoerythrocyanin alpha chain +FIG00112061 Aromatase WhiE VI +FIG00112098 Putative phosphatase YieH +FIG00112132 Shiga-like toxin II subunit A precursor (EC 3.2.2.22) +FIG00112191 Homoserine dehydrogenase (EC 1.1.1.3); Sorbitol-6-phosphate 2-dehydrogenase (EC 1.1.1.140) +FIG00112322 LRV (FeS)4 cluster domain protein clustered with nitrogenase cofactor synthesis +FIG00112376 Heat shock protein 60 family chaperone GroEL / Thermosome subunit +FIG00112492 AnfO protein, required for Mo- and V-independent nitrogenase +FIG00112612 Siderophore related permease +FIG00112715 Eukaryotic translation initiation factor 5A +FIG00112765 Peptidyl-prolyl cis-trans isomerase PpiA precursor (EC 5.2.1.8) +FIG00112872 Pyruvate oxidase [ubiquinone, cytochrome] (EC 1.2.2.2); putative +FIG00112878 Achromobactin biosynthesis protein AcsF; Diaminobutyrate--2-oxoglutarate aminotransferase (EC 2.6.1.76) +FIG00112961 Ferric enterobactin transport ATP-binding protein FepC (TC 3.A.1.14.2) +FIG00112966 SSU ribosomal protein S3Ae +FIG00113075 FIG145533: Methyltransferase (EC 2.1.1.-) +FIG00113090 Metal-dependent hydrolases of the beta-lactamase superfamily III +FIG00113099 Bifunctional PLP-dependent enzyme with beta-cystathionase and maltose regulon repressor activities +FIG00113168 Indolepyruvate oxidoreductase subunit IorB (EC 1.2.7.8) / Ferredoxin +FIG00113173 TRAP dicarboxylate transporter, DctQ subunit, unknown substrate 7 +FIG00113254 Xanthosine/inosine triphosphate pyrophosphatase +FIG00113484 Similarity to Na+/myo-inositol cotransporter +FIG00113651 RNA-binding protein Hfq / RNA-binding protein Hfq +FIG00113730 Alkanesulfonate monooxygenase (EC 1.14.14.5) +FIG00113839 Isocitrate lyase (EC 4.1.3.1) +FIG00113918 Conjugative transfer protein TrbH +FIG00113996 Photosystem II 10 kDa phosphoprotein (PsbH) +FIG00114139 Alternative cytochrome c oxidase polypeptide CoxO (EC 1.9.3.1) +FIG00114209 Malonate decarboxylase delta subunit / Malonate decarboxylase beta subunit +FIG00114297 Gamma-glutamyl-putrescine synthetase (EC 6.3.1.11) +FIG00114397 2,3-dihydroxybenzoate-AMP ligase (EC 2.7.7.58) [enterobactin] siderophore +FIG00114531 Predicted secretion system X protein GspE-like +FIG00114542 Putative Dimethylglycine oxidase +FIG00114625 C-1'-hydroxylase CruF +FIG00114660 CRISPR-associated RAMP Cmr2 +FIG00114965 Phenylacetic acid degradation protein PaaD, thioesterase +FIG00114982 heme uptake regulator +FIG00114996 IncI1 plasmid conjugative transfer protein TraL +FIG00115103 FIG115103: hypothetical protein +FIG00115451 Tlr0729 protein +FIG00115578 Predicted gluconate TRAP family transporter, DctQ subunit +FIG00115654 2-amino-4-hydroxy-6-hydroxymethyldihydropteridine pyrophosphokinase (EC 2.7.6.3) / Deoxyadenosine kinase (EC 2.7.1.76) @ Deoxyguanosine kinase (EC 2.7.1.113) +FIG00115712 Pantoate--beta-alanine ligase (EC 6.3.2.1) / Cytidylate kinase (EC 2.7.4.25) +FIG00115829 Flap structure-specific endonuclease (EC 3.-.-.-) +FIG00116113 Ubiquitin-like small archaeal modifier protein SAMP2 +FIG00116138 Aromatic amino acid transport protein AroP +FIG00116323 Tryptophan synthase beta chain (EC 4.2.1.20) +FIG00116418 type III secretion protein HrpT +FIG00116538 Monoamine oxidase (1.4.3.4) +FIG00116582 Putative transition state regulator Abh +FIG00116638 Carboxynorspermidine decarboxylase, putative (EC 4.1.1.-) +FIG00116698 Cytochrome c552 +FIG00116746 Nudix family (d)NDPase DR0975 +FIG00116834 photosystem II protein D1 (PsbA) +FIG00116849 FIG116849: hypothetical protein +FIG00116865 SoxH protein, homolog +FIG00117063 HOMODA hydrolase (CmtE) (EC 3.7.1.-) +FIG00117080 Light-harvesting LHII, alpha subunit E +FIG00117131 Phage neck whiskers +FIG00117185 IncW plasmid conjugative relaxase protein TrwC (TraI homolog) +FIG00117328 Methylmalonyl-CoA decarboxylase, alpha chain (EC 4.1.1.41); Acetyl-coenzyme A carboxyl transferase alpha chain (EC 6.4.1.2) / Acetyl-coenzyme A carboxyl transferase beta chain (EC 6.4.1.2) +FIG00117429 Non-phosphorylating glyceraldehyde-3-phosphate dehydrogenase (NAD) +FIG00117432 Lycopene cyclase +FIG00117520 N-(3-hydroxybutanoyl)-L- homoserine lactone synthase LuxM +FIG00117785 Guanine deaminase (EC 3.5.4.3) +FIG00117822 FIG117822: Putative phage protein +FIG00117890 NADH-ubiquinone oxidoreductase chain F (EC 1.6.5.3) +FIG00117918 CRISPR-associated protein Cas02710 +FIG00118027 Conjugated Bile Salt Transporter +FIG00118072 Archaeal DNA polymerase I (EC 2.7.7.7) +FIG00118117 Cystine ABC transporter, ATP-binding protein +FIG00118138 Indolepyruvate oxidoreductase subunit IorB II (EC 1.2.7.8) +FIG00118213 Hemophore HasA outer membrane receptor HasR / Iron siderophore receptor protein +FIG00118281 Hypothetical SAV0791 homolog in superantigen-encoding pathogenicity islands SaPI +FIG00118333 Hypothetical protein PvdY +FIG00118376 L-2-keto-3-deoxyarabonate dehydratase (EC 4.2.1.43) +FIG00118422 Distant similarity with phosphate transport system regulator +FIG00118495 2,3-bisphosphoglycerate-independent phosphoglycerate mutase, archaeal type (EC 5.4.2.1) +FIG00118764 Probable acyl-CoA dehydrogenase FadE29 (EC 1.3.99.-); Acyl-CoA dehydrogenase IgrC +FIG00118775 Cytochrome c oxidase (B(O/a)3-type) chain I (EC 1.9.3.1) +FIG00118784 Hypothetical protein in cluster with SinR and SinI +FIG00119021 Universal stress protein family 8 +FIG00119028 Type III secretion possible injected virulence protein (YopM) / internalin, putative +FIG00119047 Plasmid replication protein RepA +FIG00119213 2-hydroxychromene-2-carboxylate isomerase family protein, glutathione-dependent +FIG00119243 FIG119243: hypothetical protein +FIG00119516 Putative teichuronic acid biosynthesis glycosyl transferase TuaC +FIG00119690 Flagellar basal-body rod protein FlgG +FIG00119746 omega-3 polyunsaturated fatty acid synthase module PfaB/C +FIG00119755 Distant homolog of hypothetical protein SA_21 +FIG00119808 Hypothetical SAR0371 homolog in superantigen-encoding pathogenicity islands SaPI +FIG00120001 DNA repair and recombination protein RadA +FIG00120101 TonB-dependent receptor; Outer membrane receptor for ferrienterochelin and colicins +FIG00120144 Transcriptional regulator of xylitol utilization, LacI family +FIG00120233 Cytochrome c-type protein NapC +FIG00120274 Citronellol and citronellal dehydrogenase +FIG00120276 Putative sugar ABC transport system, permease protein YjfF +FIG00120441 CRISPR-associated protein, Csn1 family +FIG00120518 Conjugative transfer protein TrbN +FIG00120615 Glycine N-methyltransferase (EC 2.1.1.20) @ Sarcosine N-methyltransferase +FIG00120617 TPR repeat containing exported protein; Putative periplasmic protein contains a protein prenylyltransferase domain +FIG00120622 Alternative cytochrome c oxidase polypeptide CoxO (EC 1.9.3.1); Cytochrome c oxidase, subunit III (EC 1.9.3.1) +FIG00120639 HTH-type transcriptional regulator IlvY +FIG00120714 Hypothetical SAV0786 homolog in superantigen-encoding pathogenicity islands SaPI +FIG00120733 Cytochrome c-type biogenesis protein, archaeal, distantly related to heme lyase subunit CcmF +FIG00120792 Structure-specific tRNA-binding protein trbp111 +FIG00120834 Archaeal DNA polymerase II large subunit (EC 2.7.7.7) +FIG00120900 Energy conserving hydrogenase Ehb small subunit (protein M) +FIG00121014 2-pyrone-4,6-dicarboxylic acid hydrolase +FIG00121047 Minor myo-inositol transporter IolF +FIG00121082 Ubiquinol--cytochrome c reductase, cytochrome B subunit (EC 1.10.2.2) / ubiquinol cytochrome C oxidoreductase, cytochrome C1 subunit +FIG00121088 Dimethylglycine N-methyltransferase +FIG00121127 Lycopene elongase (EC 2.5.1.-) +FIG00121186 RND efflux system, outer membrane lipoprotein, NodT +FIG00121239 Fructose-1,6-bisphosphatase, type V, archaeal (EC 3.1.3.11) +FIG00121366 Alpha-arabinosides ABC transport system, permease protein 2 +FIG00121383 Various polyols ABC transporter, permease component 1 +FIG00121395 CrtV-methyltransferase-like protein +FIG00121451 Iron-responsive repressor RirA +FIG00121578 CrtT-methyltransferase-like protein +FIG00121593 Possible RuBisCo chaperonin RbcX +FIG00121614 Hypothetical protein ywlG +FIG00121763 5-dehydro-4-deoxyglucarate dehydratase (EC 4.2.1.41) +FIG00121768 Malate permease +FIG00121995 L-lactate dehydrogenase (EC 1.1.2.3) +FIG00121999 Catechol siderophore ABC transporter, permease component +FIG00122058 Iron siderophore receptor protein +FIG00122134 Malolactic regulator +FIG00122145 Ribosomal-protein-S18p-alanine acetyltransferase (EC 2.3.1.-) +FIG00122148 Isoflavone reductase homolog P3 (EC 1.3.1.-) +FIG00122158 Archaeal DNA polymerase II large subunit (EC 2.7.7.7) @ intein-containing +FIG00122164 Predicted secretion system X transmembrane protein 1 +FIG00122177 2-methyl-6-phytyl-1,4-benzoquinone cyclase +FIG00122210 Dimethylamine permease +FIG00122441 Two-component sensor kinase SA14-24 +FIG00122445 thioredoxin SoxW +FIG00122495 Trimethylamine:corrinoid methyltransferase @ pyrrolysine-containing +FIG00122755 Sodium/myo-inositol cotransporter +FIG00122936 Cu(I)-responsive transcriptional regulator +FIG00123062 FIG123062: hypothetical protein +FIG00123154 Acetyltransferase SypM +FIG00123196 3-ketoacyl-CoA thiolase (EC 2.3.1.16) +FIG00123201 SSU ribosomal protein S26e +FIG00123257 Glucose-6-phosphate isomerase, archaeal II (EC 5.3.1.9) / Mannose-6-phosphate isomerase, archaeal (EC 5.3.1.8) +FIG00123356 Formate hydrogenlyase hypothetical subunit +FIG00123504 CRISPR-associated RAMP Cmr5 +FIG00123657 2-amino-4-hydroxy-6-hydroxymethyldihydropteridine pyrophosphokinase (EC 2.7.6.3) / GTP cyclohydrolase I (EC 3.5.4.16) type 1 +FIG00123696 Protein FraG required for filament integrity and heterocyst maturation +FIG00123914 Exopolysaccharide production protein ExoQ +FIG00124148 Plasmid partitioning protein ParA +FIG00124174 Energy conserving hydrogenase Ehb protein P +FIG00124187 CBS domain protein sometimes clustered with YjeE +FIG00124189 Bilin biosynthesis protein PecE +FIG00124313 Isocitrate dehydrogenase [NADP] (EC 1.1.1.42) @ Homoisocitrate dehydrogenase (EC 1.1.1.87) +FIG00124426 LuxD. acyl transferase (EC 2.3.1.-) +FIG00124524 Photosystem II CP47 protein (PsbB) +FIG00124534 Dimethylallyltransferase (EC 2.5.1.1) @ (2E,6E)-farnesyl diphosphate synthase (EC 2.5.1.10) @ Geranylgeranyl diphosphate synthase (EC 2.5.1.29) +FIG00124544 FIG137360: hypothetical protein +FIG00124585 FIG124585: Hypothetical protein +FIG00124607 Effector domain of the CAP family of transcription factors @ Methylglyoxal synthase (EC 4.2.3.3) +FIG00124621 NADH-quinone oxidoreductase subunit 15 (EC 1.6.99.5) +FIG00124657 Probable cytochrome c-552 +FIG00124671 Ribose 5-phosphate isomerase B (EC 5.3.1.6) / 3-demethylubiquinol 3-O-methyltransferase (EC 2.1.1.64) +FIG00124748 Glucose dehydrogenase, PQQ-dependent (EC 1.1.5.2) +FIG00124888 2-hydroxypenta-2,4-dienoate hydratase (CmtF) (EC 4.2.1.-) +FIG00125152 Putative symporter in putrescine utilization cluster +FIG00125164 DNA reverse gyrase (EC 5.99.1.-) @ intein-containing +FIG00125235 Mu-like prophage FluMu protein gp41 +FIG00125283 AttG component of AttEFGH ABC transport system +FIG00125327 Flagellar protein FlbD +FIG00125391 5-carboxymethyl uridine and 5-carboxymethyl 2-thiouridine methyltransferase +FIG00125395 Teichoic acid translocation permease protein TagG +FIG00125515 Flagellin FlaB1 +FIG00125524 Cobalt-precorrin-3b C17-methyltransferase / domain of unknown function +FIG00125558 p-cumic alcohol dehydrogenase (CymB) +FIG00125725 Predicted gluconate TRAP family transporter, DctP subunit +FIG00125773 ParD protein (antitoxin to ParE) +FIG00125795 Unspecified monosaccharide ABC transport system, substrate-binding component / CD4+ T cell-stimulating antigen, lipoprotein +FIG00125800 Shiga-like toxin II subunit B precursor +FIG00125839 Cytochrome c55X precursor NirC +FIG00126059 Uncharacterized component of anaerobic dehydrogenases +FIG00126067 Riboflavin transporter PnuX +FIG00126286 Beta-glucoside ABC transport system, permease protein 1 +FIG00126296 Stage 0 sporulation protein J +FIG00126333 Competence-stimulating peptide (CSP) precursor ComC +FIG00126338 Nicotinamide-nucleotide adenylyltransferase, NadM family (EC 2.7.7.1) @ Nicotinate-nucleotide adenylyltransferase, NadM family (EC 2.7.7.18) +FIG00126507 Dihydropteroate synthase (EC 2.5.1.15) / Dihydroneopterin aldolase (EC 4.1.2.25) / 2-amino-4-hydroxy-6-hydroxymethyldihydropteridine pyrophosphokinase (EC 2.7.6.3) +FIG00126797 Dihydroneopterin triphosphate pyrophosphohydolase +FIG00126836 AttF component of AttEFGH ABC transport system +FIG00126843 Periplasmic [Fe] hydrogenase (EC 1.12.7.2) +FIG00126855 Fructose ABC transporter, substrate-binding component FrcB +FIG00127025 Substrate-specific component QueT (COG4708) of predicted queuosine-regulated ECF transporter +FIG00127030 Flagellin FlaB +FIG00127245 Probable peroxiredoxin (EC 1.11.1.15) +FIG00127296 Gluconolactonase (EC 3.1.1.17) +FIG00127319 Nitrogenase (iron-iron) delta chain (EC 1.18.6.1) +FIG00127517 IncI1 plasmid conjugative transfer protein TraT +FIG00127570 Putative DHNTP pyrophosphatase +FIG00127704 ; Aldehyde dehydrogenase A (EC 1.2.1.22) +FIG00127747 Dihydrolipoamide succinyltransferase component (E2) of 2-oxoglutarate dehydrogenase complex (EC 2.3.1.61) +FIG00127885 Cyclohexadienyl dehydrogenase (EC 1.3.1.12)(EC 1.3.1.43) / 5-Enolpyruvylshikimate-3-phosphate synthase (EC 2.5.1.19) +FIG00128001 Bundle-forming pilus prepilin BfpI +FIG00128165 putative endopeptidase +FIG00128182 Copper-binding periplasmic protein +FIG00128255 Predicted alpha-ribazole-5'-phosphate phosphatase CobZ (EC 3.1.3.73) +FIG00128356 DNA sulfur modification protein DndE +FIG00128411 Methyl coenzyme M reductase associated protein @ Fe-S oxidoreductase, related to NifB/MoaA family +FIG00128532 Homogentisate prenyltransferase (EC 2.5.1.-) +FIG00128570 N-acetylmuramoyl-L-alanine amidase (family 2); Negative regulator of beta-lactamase expression +FIG00128579 Vi polysaccharide biosynthesis protein tviE +FIG00128631 Cytochrome c-552 precursor +FIG00128735 Arsenate reductase (EC 1.20.4.1) ; ArsR family transcriptional regulator +FIG00128809 Heme biosynthesis protein related to NirL and NirH +FIG00128947 NAD-reducing hydrogenase subunit HoxU (EC 1.12.1.2) +FIG00129130 NADP-specific glutamate dehydrogenase (EC 1.4.1.4) +FIG00129284 Photosystem II stability/assembly factor HCF136/Ycf48 +FIG00129379 Toluene-4-monooxygenase, subunit TmoB +FIG00129463 Hypothetical SAV0796 homolog in superantigen-encoding pathogenicity islands SaPI +FIG00129552 FIG006045: Sigma factor, ECF subfamily +FIG00129616 GTP-binding protein EngA +FIG00129675 Glycine/D-amino acid oxidase (deaminating) in putrescine utilization cluster +FIG00129686 Putative carbohydrate PTS system, IIA component (EC 2.7.1.69) +FIG00129722 dTDP-rhamnosyl transferase RfbF (EC 2.-.-.-) +FIG00129794 Energy conserving hydrogenase Ehb integral membrane protein O +FIG00130036 Ribonuclease PH (EC 2.7.7.56) / Nucleoside 5-triphosphatase RdgB (dHAPTP, dITP, XTP-specific) (EC 3.6.1.15) +FIG00130057 Heme d1 biosynthesis protein NirL +FIG00130076 D-alanine--D-lactate ligase (EC 6.1.2.1) @ Vancomycin Teicoplanin A-type resistance protein VanA +FIG00130123 Plasmid replication protein RepC +FIG00130185 Photosystem II CP43 protein (PsbC) +FIG00130328 Putative Ton-B dependent hemine receptor +FIG00130339 Cytochrome c heme lyase subunit CcmF +FIG00130344 Citrate synthase (si) (EC 2.3.3.1) +FIG00130439 Hypothetical protein ortholog to Borrelia burgdorferi BB0467 +FIG00130460 Predicted secretion system X translation initiation factor +FIG00130468 Conjugative transfer protein TrbC +FIG00130527 Heme A synthase, cytochrome oxidase biogenesis protein Cox15-CtaA / Heme O synthase, protoheme IX farnesyltransferase (EC 2.5.1.-) COX10-CtaB +FIG00130586 Universal stress protein family 1 +FIG00130690 Nitrite reductase associated c-type cytochorome NirN +FIG00130751 Clavaminate synthase-like protein At3g21360 (EC 1.-.-.-) +FIG00130801 DNA-directed RNA polymerase subunit N (EC 2.7.7.6) +FIG00130805 Ribitol/Xylitol/Arabitol transporter, MFS superfamily +FIG00130900 Inner membrane protein translocase component YidC, short form OxaI-like +FIG00131095 Phage tail assembly chaperone +FIG00131160 Pedicted L-rhamnose permease, NCS1 Family +FIG00131167 Carbon dioxide concentrating mechanism protein CcmL +FIG00131328 FIG131328: Predicted ATP-dependent endonuclease of the OLD family +FIG00131366 Energy conserving hydrogenase Ehb anchor subunit F +FIG00131407 NAD(P)H-quinone oxidoreductase chain 5 (EC 1.6.5.2) +FIG00131408 Transcriptional regulator, TetR family, associated with agmatine catabolism +FIG00131476 RecD-like DNA helicase Atu2026 +FIG00131495 Multidrug efflux RND membrane fusion protein MexC +FIG00131635 domain of unknown function / Regulator of nucleoside diphosphate kinase +FIG00131636 Anthrachelin biosynthesis protein AsbA @ Siderophore synthetase superfamily, group A @ Siderophore synthetase large component, acetyltransferase +FIG00131651 IcmD (DotP) protein +FIG00131953 LuxB, luciferase beta chain (EC 1.14.14.3) +FIG00132003 Uncharacterized Fe-S protein in siderophore biosynthesis operon +FIG00132093 Bundle-forming prepilin peptidase BfpP +FIG00132167 Acetolactate synthase small subunit , predicted, Archaeal type +FIG00132203 IncI1 plasmid pilus assembly protein PilP +FIG00132213 tRNA(Ile)-lysidine synthetase (EC 6.3.4.19) / tRNA-specific adenosine-34 deaminase (EC 3.5.4.-) +FIG00132544 Phytoene dehydrogenase (EC 1.14.99.-) +FIG00132548 Thiol peroxidase, Bcp-type (EC 1.11.1.15) +FIG00132549 Thioredoxin peroxidase 1 (EC 1.6.4.-) +FIG00132557 2-keto-3-deoxy-L-fuconate dehydrogenase +FIG00132577 Uncharacterized sugar kinase YegV, PfkB family +FIG00132578 Uncharacterized sugar kinase YdjH +FIG00132586 NAD-dependent glyceraldehyde-3-phosphate dehydrogenase (EC 1.2.1.12) +FIG00132590 Pyrroline-5-carboxylate reductase (EC 1.5.1.2), ProG-like +FIG00132591 PQS biosynthesis protein PqsD, similar to 3-oxoacyl-[acyl-carrier-protein] synthase III +FIG00132592 PQS biosynthesis protein PqsC, similar to 3-oxoacyl-[acyl-carrier-protein] synthase III +FIG00132601 Radical SAM family protein HutW, similar to coproporphyrinogen III oxidase, oxygen-independent, associated with heme uptake +FIG00132602 Coproporphyrinogen III oxidase, oxygen-independent (EC 1.3.99.22), divergent, putative +FIG00132606 Protein similar to glutamate synthase [NADPH] small chain, clustered with sulfite reductase +FIG00132607 Phenazine modifying protein PhzH / Asparagine synthetase [glutamine-hydrolyzing] (EC 6.3.5.4) +FIG00132617 ATP-dependent protease La (EC 3.4.21.53) Type I +FIG00132618 ATP-dependent protease La (EC 3.4.21.53) +FIG00132623 PTS system, lactose-specific IIB component (EC 2.7.1.69) / PTS system, lactose-specific IIC component (EC 2.7.1.69) +FIG00132629 Cytochrome c oxidase polypeptide I (EC 1.9.3.1) +FIG00132630 Ferric uptake regulation protein FUR +FIG00132658 Alcohol dehydrogenase GbsB (type III ), essential for the utilization of choline (EC 1.1.1.1) +FIG00132666 Hypothetical similar to thiamin biosynthesis lipoprotein ApbE +FIG00132673 Glycerol-1-phosphate dehydrogenase [NAD(P)] (EC 1.1.1.261) +FIG00132685 Anthranilate synthase, amidotransferase component (EC 4.1.3.27) @ Para-aminobenzoate synthase, amidotransferase component (EC 2.6.1.85) +FIG00132695 Isochorismate synthase (EC 5.4.4.2) [pyochelin] siderophore +FIG00132702 2-ketoglutaric semialdehyde dehydrogenase (EC 1.2.1.26) +FIG00132709 Pseudaminic acid synthase (EC 4.1.3.-) +FIG00132715 Butyrate-acetoacetate CoA-transferase subunit B (EC 2.8.3.9) +FIG00132716 putative Cytochrome bd2, subunit I / Cyanide insensitive terminal oxidase, subunit I +FIG00132717 ATP-dependent protease La (EC 3.4.21.53) Type II +FIG00132726 PTS system, fructose-specific IIB component (EC 2.7.1.69) +FIG00132736 Valine--pyruvate aminotransferase (EC 2.6.1.66) +FIG00132737 tRNA 2-thiouridine synthesizing protein E (EC 2.8.1.-) @ Sulfite reductase, dissimilatory-type gamma subunit (EC 1.8.99.3) +FIG00132738 Dissimilatory sulfite reductase, gamma subunit (EC 1.8.99.3) +FIG00132745 Glyoxylate reductase (EC 1.1.1.26) / Hydroxypyruvate reductase (EC 1.1.1.81) +FIG00132748 Metal-dependent hydrolases of the beta-lactamase superfamily I +FIG00132758 Beta-galactosidase large subunit (EC 3.2.1.23) +FIG00132759 FAD-dependent monooxygenase PhzS +FIG00132760 PQS biosynthesis protein PqsH, similar to FAD-dependent monooxygenases +FIG00132763 Rubisco activation protein CbbQ +FIG00132768 Fumarate hydratase class I, aerobic (EC 4.2.1.2) +FIG00132770 Prephenate and/or arogenate dehydrogenase (unknown specificity) (EC 1.3.1.12)(EC 1.3.1.43) +FIG00132779 Rubisco activation protein CbbO +FIG00132784 UDP-N-acetylglucosamine 4,6-dehydratase (inverting) (EC 4.2.1.115) +FIG00132787 Prephenate dehydrogenase (EC 1.3.1.12) +FIG00132790 Ketoglutarate semialdehyde dehydrogenase (EC 1.2.1.26) +FIG00132797 (GlcNAc)2 ABC transporter, ATP-binding component 2 +FIG00132798 Ribulose-1,5-bisphosphate carboxylase, Type III (EC 4.1.1.39) +FIG00132801 Sensor histidine kinase VanS (EC 2.7.3.-) +FIG00132803 PTS system, mannitol-specific IIC component (EC 2.7.1.69) / PTS system, mannitol-specific IIB component (EC 2.7.1.69) / PTS system, mannitol-specific IIA component +FIG00132808 Cyclohexadienyl dehydratase (EC 4.2.1.51)(EC 4.2.1.91) +FIG00132814 Periplasmic chorismate mutase I precursor (EC 5.4.99.5) +FIG00132820 Arogenate dehydrogenase (EC 1.3.1.43) +FIG00132823 Isochorismatase (EC 3.3.2.1) of siderophore biosynthesis +FIG00132828 CapK protein, putative +FIG00132829 Isochorismate synthase (EC 5.4.4.2) of siderophore biosynthesis +FIG00132833 NADH dehydrogenase subunit 5 +FIG00132834 NADH dehydrogenase subunit 5, Involved in CO2 fixation +FIG00132836 PTS system, fructose-specific IIC component +FIG00132838 Sulfite reduction-associated complex DsrMKJOP iron-sulfur protein DsrO (=HmeA) +FIG00132839 Glutamine synthetase type III, GlnN (EC 6.3.1.2) +FIG00132844 Putative heme iron utilization protein +FIG00132845 Predicted iron-dependent peroxidase, Dyp-type family +FIG00132864 Sirohydrochlorin ferrochelatase (EC 4.99.1.4) +FIG00132874 Integron integrase IntIPac +FIG00132875 Integron integrase +FIG00132876 Integron integrase IntI2 +FIG00132885 RNA polymerase sigma factor SigB +FIG00132888 Cell-shape determining protein MreBH +FIG00132892 Bicarbonate transporter, bicarbonate binding protein +FIG00132896 Pheromone cAD1 precursor lipoprotein Cad +FIG00132904 Anthranilate synthase, aminase component (EC 4.1.3.27) / Anthranilate synthase, amidotransferase component (EC 4.1.3.27) @ Para-aminobenzoate synthase, amidotransferase component (EC 2.6.1.85) +FIG00132912 Iron compound ABC uptake transporter permease protein PiuC +FIG00132913 Iron compound ABC uptake transporter permease protein PiuB +FIG00132917 Putative beta-galactosidase in 4-hydroxyproline catabolic gene cluster +FIG00132918 Pyridoxamine 5'-phosphate oxidase-related putative heme iron utilization protein +FIG00132920 Nitric oxide -responding transcriptional regulator Dnr (Crp/Fnr family) +FIG00132936 Hexose phosphate transport protein UhpT +FIG00132938 Cytochrome c oxidase subunit CcoN (EC 1.9.3.1) / Cytochrome c oxidase subunit CcoO (EC 1.9.3.1) +FIG00132942 RND multidrug efflux transporter; Acriflavin resistance protein +FIG00132943 Histidine ABC transporter, permease protein HisQ (TC 3.A.1.3.1) +FIG00132945 Bicarbonate transport system permease protein +FIG00132966 Amide synthase component of siderophore synthetase +FIG00132967 Iron(III) dicitrate transport ATP-binding protein FecE (TC 3.A.1.14.1) +FIG00132969 UDP-glucose hexose 1-phosphate uridylyltransferase +FIG00132976 Glucose-1-phosphate cytidylyltransferase (EC 2.7.7.33) +FIG00132977 Ureidoglycolate/malate/sulfolactate dehydrogenase family (EC 1.1.1.-) +FIG00132994 Glycerol dehydrogenase (EC 1.1.1.6) +FIG00133002 Pyridoxamine 5'-phosphate oxidase (EC 1.4.3.5) +FIG00133005 Lysophospholipase L2 (EC 3.1.1.5) +FIG00133016 Glyoxylate reductase (EC 1.1.1.79) / Glyoxylate reductase (EC 1.1.1.26) / Hydroxypyruvate reductase (EC 1.1.1.81); 2-ketoaldonate reductase, broad specificity (EC 1.1.1.215) (EC 1.1.1.-) +FIG00133034 Excinuclease ABC subunit A paralog of unknown function +FIG00133041 NADH-ubiquinone oxidoreductase chain H (EC 1.6.5.3) +FIG00133072 Cytochrome oxidase biogenesis protein Sco1/SenC/PrrC, putative copper metallochaperone / cytochrome c +FIG00133085 Formate dehydrogenase beta subunit (EC 1.2.1.2) +FIG00133087 Similar to phosphoglycolate phosphatase, clustered with ribosomal large subunit pseudouridine synthase C +FIG00133108 N-succinyl-L,L-diaminopimelate desuccinylase (EC 3.5.1.18) +FIG00133111 3-hydroxyisobutyryl-CoA hydrolase (EC 3.1.2.4) +FIG00133139 Superoxide dismutase [Fe] (EC 1.15.1.1) +FIG00133143 Sulfate adenylyltransferase subunit 1 (EC 2.7.7.4) +FIG00133144 Muconate cycloisomerase (EC 5.5.1.1) +FIG00133181 Cyanobacteria-specific RpoD-like sigma factor, type-9 +FIG00133186 Fumarate hydratase class I, aerobic (EC 4.2.1.2); L(+)-tartrate dehydratase beta subunit (EC 4.2.1.32) +FIG00133196 L-xylulose 5-phosphate 3-epimerase (EC 5.1.3.-) +FIG00133200 Benzoate-CoA ligase (EC 6.2.1.25) +FIG00133209 2-dehydro-3-deoxygluconate kinase (EC 2.7.1.45) +FIG00133219 Thiamin biosynthesis lipoprotein ApbE +FIG00133226 Dihydrolipoamide dehydrogenase of acetoin dehydrogenase (EC 1.8.1.4) +FIG00133227 N-acetylneuraminate lyase (EC 4.1.3.3) +FIG00133228 Succinyl-CoA:3-ketoacid-coenzyme A transferase subunit A (EC 2.8.3.5) +FIG00133229 2-hydroxy-3-oxopropionate reductase (EC 1.1.1.60) +FIG00133231 Lipopolysaccharide heptosyltransferase I (EC 2.4.1.-) +FIG00133235 NAD(P)H-plastoquinone oxidoreductase (EC 1.6.5.-) chain 3, NDHC +FIG00133238 Cytochrome c-type biogenesis protein CcdA (DsbD analog) +FIG00133251 GTP cyclohydrolase III (EC 3.5.4.29) +FIG00133276 Succinyl-CoA:3-ketoacid-coenzyme A transferase subunit B (EC 2.8.3.5) +FIG00133285 Beta-ketoadipate enol-lactone hydrolase (EC 3.1.1.24) +FIG00133288 Excinuclease ABC subunit A, dimeric form +FIG00133292 Electron transport complex protein RnfB +FIG00133297 2-keto-3-deoxy-D-arabino-heptulosonate-7-phosphate synthase II (EC 2.5.1.54) +FIG00133325 Pyrroline-5-carboxylate reductase (EC 1.5.1.2) +FIG00133345 2,3-dihydro-2,3-dihydroxybenzoate dehydrogenase (EC 1.3.1.28) [enterobactin] siderophore +FIG00133347 Bicarbonate transporter, bicarbonate binding protein 2 +FIG00133353 membrane c-type cytochrome cy +FIG00133356 Ferric hydroxamate ABC transporter (TC 3.A.1.14.3), periplasmic substrate binding protein FhuD +FIG00133359 Carbon monoxide-induced hydrogenase membrane protein CooM +FIG00133360 Translation elongation factor P-related protein +FIG00133362 Dihydropyrimidine dehydrogenase [NADP+] (EC 1.3.1.2); Dihydroorotate dehydrogenase (EC 1.3.3.1) +FIG00133381 Carbon monoxide dehydrogenase large chain (EC 1.2.99.2) +FIG00133384 Putative pheromone precursor lipoprotein +FIG00133428 Integron integrase IntI1 +FIG00133433 Glycolate oxidase (EC 1.1.3.15) / (S)-2-hydroxy-acid oxidase (EC 1.1.3.15) +FIG00133445 Similar to ribosomal large subunit pseudouridine synthase D, CAC1266-type +FIG00133459 Phenylacetate-CoA oxygenase, PaaG subunit +FIG00133479 Flagellar basal-body rod protein FlgB +FIG00133490 Phenylacetate-coenzyme A ligase (EC 6.2.1.30) PaaF +FIG00133491 twitching motility protein PilJ +FIG00133502 Formate hydrogenlyase subunit 4 +FIG00133510 1-pyrroline-4-hydroxy-2-carboxylate deaminase (EC 3.5.4.22) +FIG00133513 Possible carbon dioxide concentrating mechanism protein CcmK +FIG00133515 Dihydroorotate dehydrogenase electron transfer subunit (EC 1.3.3.1) +FIG00133521 Sulfate adenylyltransferase subunit 1 (EC 2.7.7.4) / Adenylylsulfate kinase (EC 2.7.1.25) +FIG00133522 Carbon monoxide-induced hydrogenase iron-sulfur protein CooX +FIG00133525 D-proline reductase, 45 kDa subunit (EC 1.21.4.1) / D-proline reductase, 23 kDa subunit (EC 1.21.4.1) +FIG00133533 Ribulose bisphosphate carboxylase large chain (EC 4.1.1.39) +FIG00133539 NADH-ubiquinone oxidoreductase chain B (EC 1.6.5.3) +FIG00133544 5-carboxymethyl-2-hydroxymuconate semialdehyde dehydrogenase (EC 1.2.1.60) +FIG00133569 Segregation and condensation protein B +FIG00133578 Uptake hydrogenase small subunit precursor (EC 1.12.99.6) +FIG00133580 Coenzyme PQQ synthesis protein E +FIG00133583 Predicted cobalt transporter in sulfate-reducing delta-proteobacteria +FIG00133602 Radical SAM family protein HutW, similar to coproporphyrinogen III oxidase, oxygen-independent, associated with heme uptake / Putative heme iron utilization protein +FIG00133628 Nitric oxide reductase activation protein NorD +FIG00133639 predicted nucleic acid-binding protein, containing PIN domain COG1848 +FIG00133645 Nitrogenase (iron-iron) transcriptional regulator +FIG00133659 Carbon monoxide-induced hydrogenase proton translocating subunit CooK +FIG00133676 Chorismate mutase I (EC 5.4.99.5) / 2-keto-3-deoxy-D-arabino-heptulosonate-7-phosphate synthase I beta (EC 2.5.1.54) +FIG00133698 Similar to phosphoglycolate phosphatase, clustered with ubiquinone biosynthesis SAM-dependent O-methyltransferase +FIG00133713 Phosphoenolpyruvate carboxylase (EC 4.1.1.31); divergent? +FIG00133714 LSU ribosomal protein L38e +FIG00133738 Hydroxyaromatic non-oxidative decarboxylase protein C (EC 4.1.1.-) +FIG00133739 Glucosamine 6-phosphate N-acetyltransferase (EC 2.3.1.4) +FIG00133743 Fructose repressor FruR, LacI family +FIG00133744 Nitric oxide reductase activation protein NorQ +FIG00133750 PTS system, glucose-specific IIA component / Phosphotransferase system, phosphocarrier protein HPr / Phosphoenolpyruvate-protein phosphotransferase of PTS system (EC 2.7.3.9) +FIG00133767 Alpha-galactosidase precursor (EC 3.2.1.22) +FIG00133770 CoB--CoM-reducing hydrogenase (Cys) beta subunit +FIG00133774 2-ketoaldonate reductase, broad specificity (EC 1.1.1.215) (EC 1.1.1.-) +FIG00133778 Putative TolA protein +FIG00133779 Probable beta-lactamase ybxI precursor (EC 3.5.2.6) +FIG00133784 Phycocyanin alpha phycocyanobilin lyase related protein NblB +FIG00133792 Flagellar biosynthesis protein FliC +FIG00133816 Beta-galactosidase (EC 3.2.1.23) / Beta-glucosidase/6-phospho-beta-glucosidase +FIG00133821 Glutamate formiminotransferase (EC 2.1.2.5) @ Glutamate formyltransferase / Formiminotetrahydrofolate cyclodeaminase (EC 4.3.1.4) +FIG00133861 Fumarate hydratase class I, aerobic (EC 4.2.1.2); L(+)-tartrate dehydratase alpha subunit (EC 4.2.1.32) +FIG00133864 Glyoxylate reductase (EC 1.1.1.79) / Glyoxylate reductase (EC 1.1.1.26) / Hydroxypyruvate reductase (EC 1.1.1.81) +FIG00133870 Threonine dehydratase, catabolic (EC 4.3.1.19) +FIG00133886 Inositol-1-monophosphatase (EC 3.1.3.25) +FIG00133921 4-oxalocrotonate decarboxylase (EC 4.1.1.77) +FIG00133923 Anthranilate synthase, aminase component (EC 4.1.3.27) / Anthranilate synthase, amidotransferase component (EC 4.1.3.27) +FIG00133928 Enoyl-CoA hydratase [valine degradation] (EC 4.2.1.17) / Enoyl-CoA hydratase [isoleucine degradation] (EC 4.2.1.17) +FIG00133935 Flagellin FlaB2 +FIG00133978 Ureidoglycolate dehydrogenase (EC 1.1.1.154) +FIG00133983 Universal stress protein family 4 +FIG00134017 DMSP demethylase (DmdA) (EC 2.1.2.10) +FIG00134038 putative ring-hydroxylating dioxygenase small subunit +FIG00134039 Type IV pilus biogenesis protein PilE +FIG00134057 1,2-diacylglycerol 3-glucosyltransferase (EC 2.4.1.157); diglucosyldiacylglycerol synthase (LTA membrane anchor synthesis); putative +FIG00134060 Electron transport complex protein RnfE +FIG00134067 Energy conserving hydrogenase Eha associated gene 2 +FIG00134068 Pyruvate:ferredoxin oxidoreductase, porF subunit (EC 1.2.7.1) +FIG00134089 Glycine N-methyltransferase (EC 2.1.1.20) +FIG00134128 Protein arginine N-methyltransferase 1 (EC 2.1.1.-) +FIG00134134 Pantothenate:Na+ symporter (TC 2.A.21.1.1) / Sodium-dependent multivitamin transporter +FIG00134135 Glycogen synthase, ADP-glucose transglucosylase (EC 2.4.1.21) +FIG00134152 Energy conserving hydrogenase Eha transmembrane protein J +FIG00134158 IMP cyclohydrolase (EC 3.5.4.10) [alternate form] +FIG00134159 Trehalose 6-phosphate phosphorylase (EC 2.4.1.216) +FIG00134167 V-type ATP synthase subunit B (EC 3.6.3.14) +FIG00134171 GldI +FIG00134202 Glucan 1,6-alpha-glucosidase (EC 3.2.1.70) +FIG00134207 Spermidine Putrescine ABC transporter permease component potC (TC_3.A.1.11.1) / ABC transporter, periplasmic spermidine putrescine-binding protein PotD (TC 3.A.1.11.1) +FIG00134224 2-dehydro-3-deoxygluconate aldolase (EC 4.1.2-) +FIG00134230 L-allo-threonine aldolase +FIG00134232 Flavoprotein MioC +FIG00134246 Serine/threonine protein kinase PrkC, regulator of stationary phase, short form +FIG00134249 2-keto-4-pentenoate hydratase/2-oxohepta-3-ene-1,7-dioic acid hydratase (catechol pathway) +FIG00134255 LSU ribosomal protein L13e +FIG00134263 Energy conserving hydrogenase Ehb large subunit (protein N) +FIG00134275 Chlorophyllide a oxygenase (EC 1.14.13.122) +FIG00134282 Thiosulfate reductase precursor (EC 1.-.-.-) +FIG00134294 Quinol oxidase-2, sulfocyanin (blue copper protein) (SoxE) +FIG00134295 Energy conserving hydrogenase Ehb protein H / Energy conserving hydrogenase Ehb protein I +FIG00134298 Toxin co-regulated pilus biosynthesis protein F, putative outer membrane channel for TcpA extrusion +FIG00134342 Ribose 5-phosphate isomerase B (EC 5.3.1.6) +FIG00134348 TsaD/Kae1/Qri7 protein, required for threonylcarbamoyladenosine t(6)A37 formation in tRNA +FIG00134368 Cytosine deaminase (EC 3.5.4.1) +FIG00134380 Lactose permease +FIG00134403 Ferredoxin--NADP(+) reductase, actinobacterial (eukaryote-like) type (EC 1.18.1.2) +FIG00134414 Thiamin-phosphate synthase ThiN (EC 2.5.1.3) +FIG00134421 Chorismate mutase I (EC 5.4.99.5) / Prephenate and/or arogenate dehydrogenase (unknown specificity) (EC 1.3.1.12)(EC 1.3.1.43) +FIG00134437 Capsular polysaccharide export system protein KpsF +FIG00134441 Fatty acid desaturase (EC 1.14.19.3) +FIG00134443 Ubiquinone biosynthesis monooxygenase UbiH/COQ6 (EC 1.14.13.-); 2-octaprenyl-6-methoxyphenol hydroxylase (EC 1.14.13.-) +FIG00134447 Aldehyde dehydrogenase (EC 1.2.1.3), PaaZ +FIG00134486 Replicative DNA helicase (EC 3.6.1.-) [SA14-24] +FIG00134501 1,2-dihydroxynaphthalene dioxygenase +FIG00134532 Phenylacetaldehyde dehydrogenase (EC 1.2.1.39) +FIG00134535 Phenylacetic acid degradation protein paaD; PaaD-like protein (DUF59) involved in Fe-S cluster assembly +FIG00134556 Nudix dNTPase DR1025 (EC 3.6.1.-) +FIG00134577 IncI1 plasmid conjugative transfer protein TraC +FIG00134592 PTS system, mannose-specific IID component +FIG00134628 Energy conserving hydrogenase Eha transmembrane protein G +FIG00134639 Hydroxymethylpyrimidine phosphate kinase ThiD (EC 2.7.4.7) / Thiaminase II (EC 3.5.99.2) involved in salvage of thiamin pyrimidine moiety, TenA subgroup with Cys in active site +FIG00134662 Cytoplasmic trehalase (EC 3.2.1.28) +FIG00134685 4-cresol dehydrogenase [hydroxylating] flavoprotein subunit (EC 1.17.99.1) +FIG00134695 Predicted PTS system, galactosamine-specific IIA component (EC 2.7.1.69) +FIG00134700 Phenazine biosynthesis protein PhzG; Pyridoxamine 5'-phosphate oxidase (EC 1.4.3.5) +FIG00134722 Protein serine/threonine phosphatase PrpC, regulation of stationary phase +FIG00134728 Hypothetical protein, SLT orf81b homolog [SA bacteriophages 11, Mu50B] +FIG00134746 Carbon monoxide-responsive transcriptional activator CooA +FIG00134749 Menaquinone-specific isochorismate synthase (EC 5.4.4.2) +FIG00134750 superoxide dismutase [Fe-Zn] (EC 1.15.1.1) +FIG00134798 putative porin for vanillate trafficking (VanP) +FIG00134814 Energy conserving hydrogenase Ehb polyferredoxin (protein K) +FIG00134818 Geranylfarnesyl diphosphate synthetase (EC EC 2.5.1.81) @ Hexaprenyl pyrophosphate synthetase +FIG00134827 Cytochrome c4 +FIG00134830 Lysine 2,3-aminomutase (EC 5.4.3.2) +FIG00134840 Citrate lyase transcriptional regulator CitI +FIG00134848 Formate dehydrogenase N alpha subunit (EC 1.2.1.2) +FIG00134863 Conjugative transposon protein TraP @ DNA primase (EC 2.7.7.-) +FIG00134889 Glutamine synthetase type I (EC 6.3.1.2) +FIG00134921 Energy conserving hydrogenase Eha transmembrane protein F +FIG00134923 Energy conserving hydrogenase Ehb protein G +FIG00134930 Universal stress protein family 7 +FIG00134942 IncI1 plasmid conjugative transfer protein TraH +FIG00134943 Periplasmic [Fe] hydrogenase large subunit (EC 1.12.7.2) +FIG00134946 4-hydroxy-tetrahydrodipicolinate synthase (EC 4.3.3.7) / N-acetylneuraminate lyase (EC 4.1.3.3) +FIG00134951 putative facilitator of salicylate uptake +FIG00134953 Glycine betaine/L-proline ABC transporter, glycine betaine/L-proline- binding/permease protein +FIG00134974 Flagellin FlaB3 +FIG00134997 TCP pilus virulence regulatory protein ToxT, transcription activator +FIG00135013 Carbon monoxide-induced hydrogenase large subunit CooH +FIG00135025 Aldose 1-epimerase (EC 5.1.3.3) +FIG00135043 mandelate racemase/muconate lactonizing enzyme family protein +FIG00135048 Polysulfide reductase, subunit B, putative +FIG00135056 Adenylylsulfate reductase alpha-subunit (EC 1.8.99.2) +FIG00135061 Toxin co-regulated pilus biosynthesis protein P, transcriptional activator of ToxT promoter +FIG00135074 Poly [ADP-ribose] polymerase-1 (EC 2.4.2.30) +FIG00135082 Energy conserving hydrogenase Eha protein M +FIG00135154 Alginate lyase (EC 4.2.2.3) +FIG00135157 Light-harvesting LHII, alpha subunit D +FIG00135159 Indole-3-glycerol phosphate synthase (EC 4.1.1.48) +FIG00135160 Glycine reductase component B gamma subunit (EC 1.21.4.2) @ selenocysteine-containing +FIG00135165 Phosphotransferase system for xylose-containing disaccharide, EIIC component +FIG00135167 TCP pilin signal peptidase, TcpA processing +FIG00135189 IncN plasmid KikA protein +FIG00135225 archaeosine tRNA-ribosyltransferase (EC 2.4.2.-) PUA domain +FIG00135232 Galactose permease +FIG00135260 Energy conserving hydrogenase Eha proton-sodium antiporter homolog protein H +FIG00135264 Phosphate transport system permease protein PstA (TC 3.A.1.7.1) / Phosphate transport system permease protein PstC (TC 3.A.1.7.1) +FIG00135273 Zeaxanthin glucosyl transferase +FIG00135282 Phosphoserine phosphatase (EC 3.1.3.3) / 1-acyl-sn-glycerol-3-phosphate acyltransferase (EC 2.3.1.51) +FIG00135315 Ribosomal silencing factor RsfA (former Iojap) +FIG00135319 Universal stress protein family 6 +FIG00135320 ribulose 1,5-bisphosphate carboxylase/oxygenase activase +FIG00135357 Phosphoribosylglycinamide formyltransferase (EC 2.1.2.2) / Phosphoribosylaminoimidazolecarboxamide formyltransferase (EC 2.1.2.3) +FIG00135373 Conjugative transfer protein PSLT093 +FIG00135394 2,5-diamino-6-ribitylamino-pyrimidinone 5-phosphate deaminase, fungal (EC 3.5.4.-) +FIG00135407 Glutamine synthetase inactivating factor IF17 +FIG00135420 Flagella-related protein FlaE +FIG00135434 Energy conserving hydrogenase Eha ferredoxin (protein P2) +FIG00135437 Formylmethanofuran dehydrogenase (tungsten) operon gene H +FIG00135440 Formylmethanofuran dehydrogenase (tungsten) subunit D (EC 1.2.99.5) +FIG00135441 LSU ribosomal protein L12e (L11p) +FIG00135459 2-ketogluconate utilization repressor PtxS +FIG00135469 Aminopeptidase YpdF (MP-, MA-, MS-, AP-, NP- specific) +FIG00135472 Oxaloacetate decarboxylase involved in citrate fermentation (EC 4.1.1.3) +FIG00135494 Possible alpha-xyloside ABC transporter, substrate-binding component +FIG00135495 1H-3-hydroxy-4-oxoquinaldine 2,4-dioxygenase +FIG00135497 Betaine reductase component B beta subunit (EC 1.21.4.4) @ selenocysteine-containing +FIG00135535 CoB--CoM-reducing hydrogenase (Sec) beta subunit +FIG00135537 Flp pilus assembly protein RcpB +FIG00135545 Energy conserving hydrogenase Ehb protein Q +FIG00135546 Predicted rhamnogalacturonan lyase in rhamnose utilization cluster +FIG00135551 Type III restriction-modification system StyLTI enzyme mod (EC 2.1.1.72); Type III restriction-modification system methylation subunit (EC 2.1.1.72) +FIG00135553 Methoxyneurosporene dehydrogenase (EC 1.14.99.-) +FIG00135554 UDP-N-acetylmuramate--alanine ligase (EC 6.3.2.8) +FIG00135557 Energy conserving hydrogenase Ehb protein A +FIG00135572 Pyruvate:ferredoxin oxidoreductase, gamma subunit (EC 1.2.7.1) / Pyruvate:ferredoxin oxidoreductase, delta subunit (EC 1.2.7.1) +FIG00135573 NADPH-dependent methylglyoxal reductase (D-lactaldehyde dehydrogenase) +FIG00135583 Betaine--homocysteine S-methyltransferase (EC 2.1.1.5) +FIG00135600 Ribonuclease PH (EC 2.7.7.56) +FIG00135619 Adenosylcobinamide amidohydrolase (EC 3.5.1.90) / Predicted alpha-ribazole-5'-phosphate phosphatase CobZ (EC 3.1.3.73) +FIG00135639 Purine trans deoxyribosylase (Nucleoside deoxyribosyltransferase-I) (EC 2.4.2.6) +FIG00135644 IncF plasmid conjugative transfer protein TrbF +FIG00135656 Isochorismate synthase (EC 5.4.4.2); Menaquinone-specific isochorismate synthase (EC 5.4.4.2) +FIG00135664 Putative glutamine synthetase, Rickettsiales type (EC 6.3.1.2) +FIG00135677 Dimethylamine:corrinoid methyltransferase @ pyrrolysine-containing +FIG00135700 Respiratory nitrate reductase subunit, conjectural (EC 1.7.99.4) +FIG00135711 Phosphotransferase system for xylose-containing disaccharide, EIIA component +FIG00135730 Heme-binding SCHIC domain protein, putative oxygen sensor +FIG00135742 Ribonuclease HI-related protein +FIG00135747 Glycine/sarcosine/betaine reductase protein A @ selenocysteine-containing +FIG00135773 Pyruvate:ferredoxin oxidoreductase, porE subunit (EC 1.2.7.1) +FIG00135777 Conjugative transfer protein s043 +FIG00135801 Similar to ribosomal large subunit pseudouridine synthase A, group 2 +FIG00135811 Energy conserving hydrogenase Eha transmembrane protein B +FIG00135825 Monomethylamine:corrinoid methyltransferase @ pyrrolysine-containing +FIG00135830 Energy conserving hydrogenase Ehb protein D +FIG00135837 Teichuronic acid biosynthesis protein TuaF +FIG00135862 Alpha-aminoadipate aminotransferase (EC 2.6.1.39) +FIG00135886 ATP phosphoribosyltransferase regulatory subunit, divergent variant (EC 2.4.2.17) +FIG00135892 Duplicated ATPase component TTE1589 of energizing module of predicted methylthioadenosine ECF transporter +FIG00135906 Phosphotransferase system for xylose-containing disaccharide, EIIB component +FIG00135914 Ribose 5-phosphate isomerase B (EC 5.3.1.6) / Galactose 6-phosphate isomerase +FIG00135915 Ornithine aminotransferase (EC 2.6.1.13); Succinylornithine transaminase (EC 2.6.1.-); Acetylornithine aminotransferase (EC 2.6.1.11) +FIG00135918 Heme biosynthesis protein related to NirG / Heme biosynthesis protein related to NirH +FIG00135950 IncI1 plasmid conjugative transfer protein TraF +FIG00135961 Vancomycin resistance protein VanH / D-lactate dehydrogenase (EC 1.1.1.28) +FIG00135973 Sirohydrochlorin cobaltochelatase (EC 4.99.1.3) / Cobalt-precorrin-8x methylmutase (EC 5.4.1.2) +FIG00135980 Conjugative transfer transglycosylase +FIG00135993 Hydroxymethylglutaryl-CoA synthase (EC 2.3.3.10) +FIG00135997 Nudix dNTPase DR0550 (EC 3.6.1.-) +FIG00136002 IncI1 plasmid conjugative transfer DNA primase +FIG00136036 Betaine reductase component B alpha subunit (EC 1.21.4.4) +FIG00136041 NADP-reducing hydrogenase, subunit A +FIG00136062 4-cresol dehydrogenase [hydroxylating] cytochrome c subunit precursor +FIG00136084 Aspartate carbamoyltransferase (EC 2.1.3.2) / Aspartate carbamoyltransferase regulatory chain (PyrI) +FIG00136093 Fe-S oxidoreductase; Homology to heterodisulfide reductase 2 iron-sulfur subunit; Succinate dehydrogenase iron-sulfur protein (EC 1.3.99.1) +FIG00136099 Energy conserving hydrogenase Ehb ferredoxin-containing protein L +FIG00136100 IncI1 plasmid conjugative transfer protein PilI +FIG00136138 Maltose phosphorylase (EC 2.4.1.8) +FIG00136193 Dihydrolipoamide dehydrogenase (EC 1.8.1.4) +FIG00136194 Cobalamin biosynthesis protein BluB @ 5,6-dimethylbenzimidazole synthase, flavin destructase family / Nicotinate-nucleotide--dimethylbenzimidazole phosphoribosyltransferase (EC 2.4.2.21) +FIG00136200 Coenzyme F420 hydrogenase beta subunit (FruB) (EC 1.12.98.1) +FIG00136214 Toxin co-regulated pilus biosynthesis protein I, chemoreceptor, negative regulator of TcpA +FIG00136215 Formylmethanofuran dehydrogenase (tungsten) subunit C (EC 1.2.99.5) +FIG00136220 Coenzyme F420 hydrogenase alpha subunit (FruA) (EC 1.12.98.1) @ selenocysteine-containing +FIG00136221 Carbon monoxide-induced hydrogenase small subunit CooL +FIG00136223 putative Fe-S, FMN containing oxidoreductase +FIG00136224 Hmc operon transcriptional regulator Rrf2 +FIG00136225 Cytidylate kinase (EC 2.7.4.25) / SSU ribosomal protein S1p +FIG00136227 S-adenosylmethionine decarboxylase proenzyme (EC 4.1.1.50), eukaryotic +FIG00136249 N-acetylmannosamine-6-phosphate 2-epimerase (EC 5.1.3.9) / N-acetylmannosamine kinase (EC 2.7.1.60) +FIG00136256 5'-nucleotidase (EC 3.1.3.5); Thermonuclease +FIG00136261 Transcription factor S-related protein 1 +FIG00136263 Predicted cobalt ABC transporter periplasmic component +FIG00136323 SAM-dependent methlytransferase UbiG +FIG00136352 Transmembrane component SS1135 of energizing module of predicted ECF transporter +FIG00136386 Additional substrate-binding component of thiamin-regulated ECF transporter for HydroxyMethylPyrimidine +FIG00136407 FIG135464: Cytochrome c4 +FIG00136410 Light-harvesting LHII, alpha subunit A +FIG00136441 Energy conserving hydrogenase Eha transmembrane protein D +FIG00136447 Hypothetical nudix hydrolase YeaB +FIG00136476 Cobalamine-related hypothetical metal-binding protein CrdX +FIG00136488 Accessory colonization factor AcfB +FIG00136515 Transmembrane component TTE1588 of energizing module of predicted methylthioadenosine ECF transporter +FIG00136522 Ribonuclease BN (EC 3.1.-.-) +FIG00136525 Putative periplasmic phosphate-binding protein PstS (Mycoplasma type) +FIG00136579 quinone-reactive Ni/Fe-hydrogenase, small subunit +FIG00136586 Formate dehydrogenase alpha subunit (EC 1.2.1.2) @ selenocysteine-containing +FIG00136588 Single-stranded-DNA-specific exonuclease RecJ, Bacteriophage SPBc2-type +FIG00136598 Erythritol phosphate dehydrogenase EryB +FIG00136626 Heme d1 biosynthesis protein NirD / Heme d1 biosynthesis protein NirL +FIG00136630 2-Oxobutyrate dehydrogenase E1 (EC:1.2.4.1) +FIG00136635 Glutathione S-transferase, unnamed subgroup (EC 2.5.1.18) +FIG00136659 Uncharacterized ATP-dependent helicase MJ0294 @ intein-containing +FIG00136665 ABC transporter (iron.B12.siderophore.hemin) , ATP-binding component +FIG00136668 Adenylate kinase (EC 2.7.4.3) / histone protein +FIG00136675 Dihydrolipoamide acetyltransferase component of pyruvate dehydrogenase complex (EC 2.3.1.12) +FIG00136680 Light-harvesting LHII, beta subunit B +FIG00136682 Formylmethanofuran dehydrogenase (tungsten) subunit B (EC 1.2.99.5) @ selenocysteine-containing +FIG00136688 Hypothetical SAR0385 homolog in superantigen-encoding pathogenicity islands SaPI +FIG00136692 Acetolactate synthase large subunit (EC 2.2.1.6) +FIG00136718 Dihydrodiol dehydrogenase (EC 1.3.1.56) +FIG00136725 Putative teichuronic acid biosynthesis glycosyl transferase TuaH +FIG00136761 hydantoin racemase +FIG00136775 Energy conserving hydrogenase Ehb protein C +FIG00136813 Teichuronic acid biosynthesis protein TuaB +FIG00136831 Dihydrolipoamide acetyltransferase component of pyruvate dehydrogenase complex (EC 2.3.1.12) / Dihydrolipoamide dehydrogenase of pyruvate dehydrogenase complex (EC 1.8.1.4) +FIG00136832 secreted alkaline phosphatase +FIG00136843 Toxin co-regulated pilus biosynthesis protein T, putative ATP-binding translocase of TcpA +FIG00136858 IncI1 plasmid conjugative transfer protein TraG +FIG00136866 Electron transfer flavoprotein, alpha subunit +FIG00136878 Hemoglobin, heme-dependent two component system response regulator ChrA +FIG00136885 Toxin co-regulated pilus biosynthesis protein D +FIG00136918 Energy conserving hydrogenase Eha polyferredoxin (protein P3) +FIG00136922 Succinate dehydrogenase flavoprotein subunit (EC 1.3.99.1) +FIG00136957 PpaA, heme-binding SCHIC domain sensory protein, regulator for photosystem formation +FIG00136962 Nickel-cobalt-cadmium resistance protein NccB +FIG00136968 Transcriptional regulator, luxR family, associated with agmatine catabolism +FIG00136969 DNA topoisomerase I (EC 5.99.1.2) @ intein-containing +FIG00136973 O-antigen export system, polymerase or transferase +FIG00137002 Energy conserving hydrogenase Eha-associated regulator +FIG00137035 cytochrome c subunit of flavocytochrome c sulfide dehydrogenase +FIG00137036 Peroxide stress regulator / Ferric uptake regulation protein +FIG00137047 p-cumate dioxygenase small subunit (CmtAc) +FIG00137051 Sulfhydrogenase II subunit a +FIG00137076 NMN synthetase (EC 6.3.1.-) +FIG00137081 Photosynthetic reaction center cytochrome c subunit +FIG00137125 Biotin carboxyl carrier protein of methylmalonyl-CoA:Pyruvate transcarboxylase +FIG00137127 AreB (Aryl-alcohol dehydrogenase) (EC 1.1.1.90) +FIG00137128 TsaC protein (YrdC domain) required for threonylcarbamoyladenosine t(6)A37 modification in tRNA / Protein-N(5)-glutamine methyltransferase PrmC, methylates polypeptide chain release factors RF1 and RF2 +FIG00137145 Uroporphyrinogen-III methyltransferase (EC 2.1.1.107) / Uroporphyrinogen-III synthase (EC 4.2.1.75) +FIG00137162 Hypothetical protein in cluster with dihydroxyacetone kinase in Rhizobia +FIG00137170 Phospho-di-inositol-1-phosphate synthase (EC 2.7.8.-) +FIG00137184 PTS system, trehalose-specific IIA component (EC 2.7.1.69) +FIG00137189 Carbon monoxide-induced hydrogenase NuoC-like protein CooU +FIG00137194 Endo-beta-1,3-1,4 glucanase (Licheninase) (EC 3.2.1.73) +FIG00137228 Energy conserving hydrogenase Ehb protein I +FIG00137229 PTS system, mannose-specific IIA component; PTS system, mannose-specific IIB component (EC 2.7.1.69) +FIG00137246 gamma-carotene desaturase, putative +FIG00137251 Propionate--CoA ligase (EC 6.2.1.17) / Acetyl-coenzyme A synthetase (EC 6.2.1.1) +FIG00137255 Acetoacetyl-CoA synthetase (EC 6.2.1.16) / Long-chain-fatty-acid--CoA ligase (EC 6.2.1.3) +FIG00137260 Predicted maltose-specific TonB-dependent receptor +FIG00137261 Predicted sucrose-specific TonB-dependent receptor +FIG00137262 Predicted b-glucoside-specific TonB-dependent outer membrane receptor +FIG00137263 Trehalose-regulated TonB-dependent outer membrane receptor +FIG00137264 Mannosides-regulated TonB-dependent outer membrane receptor +FIG00137267 Protein involved in stability of MscS mechanosensitive channel +FIG00137270 Zinc-type alcohol dehydrogenase YcjQ +FIG00137273 Protein export cytoplasm protein SecA2 ATPase RNA helicase (TC 3.A.5.1.1) +FIG00137274 Preprotein translocase SecY2 subunit (TC 3.A.5.1.1) +FIG00137279 Cobalamin synthesis protein/P47K family protein +FIG00137284 Vibrioferrin decarboxylase protein PvsE +FIG00137286 DNA ligase (EC 6.5.1.2), LigB +FIG00137296 Phosphoribosylformimino-5-aminoimidazole carboxamide ribotide isomerase (EC 5.3.1.16) / Acting phosphoribosylanthranilate isomerase (EC 5.3.1.24) +FIG00137301 Ferric siderophore receptor PsuA +FIG00137302 Vibrioferrin receptor PvuA +FIG00137315 Folate biosynthesis protein PTPS-III, catalyzes a reaction that bypasses dihydroneopterin aldolase (FolB) +FIG00137334 predicted 2-keto-3-deoxyxylonate dehydratase +FIG00137337 Fumarylacetoacetate (FAA) hydrolase (EC 4.1.1.68) +FIG00137348 Putative histidine ammonia-lyase protein +FIG00137362 putative Glutathione-regulated potassium-efflux system protein KefB +FIG00137367 Geranyl-CoA carboxylase carboxyl transferase subunit (EC 6.4.1.5) +FIG00137372 Methylmalonate-semialdehyde dehydrogenase (EC 1.2.1.27) +FIG00137374 ATP-dependent DNA helicase SCO5184 +FIG00137389 Hydroxypyruvate isomerase (EC 5.3.1.22) +FIG00137390 Unspecified monosaccharide ABC transport system, substrate-binding component +FIG00137400 UPF0301 protein YqgE +FIG00137403 Isohexenylglutaconyl-CoA hydratase +FIG00137419 FIG001014_Response regulator of the LytR/AlgR family +FIG00137421 L-arabinolactonase (EC 3.1.1.15) +FIG00137422 Xylonolactonase (EC 3.1.1.68) +FIG00137434 Type II/IV secretion system ATPase TadZ/CpaE, associated with Flp pilus assembly +FIG00137440 Acetylornithine aminotransferase (EC 2.6.1.11) / N-succinyl-L,L-diaminopimelate aminotransferase (EC 2.6.1.17) / Succinylornithine transaminase (EC 2.6.1.81) +FIG00137450 hypothetical protein PA3071 +FIG00137462 Hca operon (3-phenylpropionic acid catabolism) transcriptional activator HcaR +FIG00137466 Transcriptional regulator YcjW, LacI family, possibly involved in maltodextrin utilization pathway +FIG00137468 Transcriptional regulator of trehalose utilization, LacI family +FIG00137481 Predicted 2-keto-4-pentenoate hydratase/2-oxohepta-3-ene-1,7-dioic acid hydratase +FIG00137484 FIG139928: Putative protease +FIG00137486 Probable transcription regulator protein of MDR efflux pump cluster +FIG00137491 Arginine ABC transporter, periplasmic arginine-binding protein ArtJ +FIG00137495 Probable 5-carboxymethyl-2-hydroxymuconate delta isomerase +FIG00137498 Uncharacterized secreted protein associated with spyDAC +FIG00137501 Kef-type transport system 2 (probable substrate potassium), subunit 1 +FIG00137502 Kef-type transport system 2 (probable substrate potassium), subunit 2 +FIG00137508 Psp operon transcriptional activator +FIG00137509 Alpha-amylase (Neopullulanase) SusA (EC 3.2.1.135) +FIG00137514 YcgN (Fragment) +FIG00137517 Membrane bound hydrogenase, MbhC subunit +FIG00137522 Glucosamine-6-phosphate deaminase [isomerizing], alternative (EC 3.5.99.6) +FIG00137528 Multidrug transporter MdtB +FIG00137529 Ferrous iron transport peroxidase EfeB +FIG00137531 L-lysine 6-monooxygenase [NADPH] (EC 1.14.13.59), aerobactin biosynthesis protein IucD @ Siderophore biosynthesis protein, monooxygenase +FIG00137534 Lipopolysaccharide core biosynthesis glycosyltransferase, group 2 family protein (EC 2.4.1.-) +FIG00137536 5-carboxymethyl-2-hydroxymuconate delta-isomerase (EC 5.3.3.10) +FIG00137538 2-hydroxyhepta-2,4-diene-1,7-dioate isomerase (EC 5.3.3.-) / 5-carboxymethyl-2-oxo-hex-3- ene-1,7-dioate decarboxylase (EC 4.1.1.68) +FIG00137541 Transcriptional repressor protein TyrR +FIG00137542 Xylulose-5-phosphate phosphoketolase (EC 4.1.2.9) @ Fructose-6-phosphate phosphoketolase (EC 4.1.2.22) +FIG00137543 COG1872 +FIG00137546 NADH-ubiquinone oxidoreductase chain B (EC 1.6.5.3) / NADH-ubiquinone oxidoreductase chain C (EC 1.6.5.3) / NADH-ubiquinone oxidoreductase chain D (EC 1.6.5.3) +FIG00137548 Putrescine utilization regulator +FIG00137553 carbon monoxide dehydrogenase E protein +FIG00137556 Putrescine aminotransferase (EC 2.6.1.82) +FIG00137565 Hypothetical phosphoglucomutase family hydrolase in arabinose utilization cluster +FIG00137580 Not a Proline racemase, nor 4-hydroxyproline epimerase [missing catalytic residues] +FIG00137581 Transcriptional regulator of mannoside utilization, variant 2, LacI family +FIG00137583 ABC-type transport system involved in resistance to organic solvents, permease component USSDB6A +FIG00137588 Ferrous iron transport periplasmic protein EfeO, contains peptidase-M75 domain and (frequently) cupredoxin-like domain +FIG00137594 FIG137594: Putative iron-regulated membrane protein +FIG00137602 3-phenylpropionate dioxygenase, alpha subunit (EC 1.14.12.19) +FIG00137607 Proline racemase (EC 5.1.1.4) +FIG00137613 YfaA +FIG00137619 Pup ligase PafA, possible component of postulated heterodimer PafA-PafA' +FIG00137633 Outer membrane ferripyoverdine receptor FpvA, TonB-dependent +FIG00137637 Outer membrane ferripyoverdine receptor FpvB, for Type I pyoverdine +FIG00137642 FIG139976: hypothetical protein +FIG00137648 PTS system, N-acetylmuramic acid-specific IIB component (EC 2.7.1.69) / PTS system, N-acetylmuramic acid-specific IIC component +FIG00137661 Predicted ATPase with chaperone activity, associated with Flp pilus assembly +FIG00137670 Ornithine aminotransferase (EC 2.6.1.13); Acetylornithine aminotransferase (EC 2.6.1.11) +FIG00137674 FIG139612: Possible conserved membrane protein +FIG00137678 Gamma-hemolysin component B +FIG00137679 Panton-Valentine leukocidin chain F precursor +FIG00137681 Gamma-hemolysin component A +FIG00137682 Leukotoxin LukE +FIG00137683 Panton-Valentine leukocidin chain S precursor +FIG00137686 CO dehydrogenase/acetyl-CoA synthase, CO dehydrogenase subunit (EC 1.2.99.2) +FIG00137687 3-phenylpropionate dioxygenase beta subunit (EC 1.14.1.-) +FIG00137689 FIG141694: hypothetical protein in PFGI-1-like cluster +FIG00137690 FIG141751: hypothetical protein in PFGI-1-like cluster +FIG00137692 Propionate kinase (EC 2.7.2.15) / Acetate kinase (EC 2.7.2.1) +FIG00137697 Vibrioferrin amide bond forming protein PvsB @ Siderophore synthetase superfamily, group B +FIG00137698 Achromobactin biosynthesis protein AcsA @ Siderophore synthetase superfamily, group B +FIG00137716 Probable hydrolase, coexpressed with pyoverdine biosynthesis regulon +FIG00137724 LysR family transcriptional regulator YfeR +FIG00137727 Alkanesulfonate utilization operon LysR-family regulator CbI +FIG00137732 Surface presentation of antigens protein SpaQ +FIG00137739 Positive regulator of Tartrate dehydrogenase/decarboxylase/D-malic enzyme +FIG00137740 Putative IpgF protein +FIG00137745 Arginine/ornithine ABC transporter, periplasmic arginine/ornithine binding protein +FIG00137747 Flp pilus assembly surface protein TadF, ATP/GTP-binding motif +FIG00137757 Ornithine aminotransferase (EC 2.6.1.13); Succinylornithine transaminase (EC 2.6.1.81); Acetylornithine aminotransferase (EC 2.6.1.11) +FIG00137759 LuxA, luciferase alpha chain (EC 1.14.14.3) +FIG00137767 Legionaminic acid biosynthesis protein PtmG +FIG00137772 Transcriptional regulator near Vibriobactin biosynthetic gene custer +FIG00137774 D-ribulokinase (EC 2.7.1.47) +FIG00137778 N-3-oxooctanoyl-L-homoserine lactone synthase @ N-3-oxohexanoyl-L-homoserine lactone synthase +FIG00137779 N-3-oxohexanoyl-L-homoserine lactone synthase +FIG00137803 Acetyl-CoA synthase corrinoid iron-sulfur protein, small subunit +FIG00137806 Uncharacterized ABC transporter, ATP-binding protein YrbF +FIG00137819 Phosphate regulon transcriptional regulatory protein PhoB (SphR); Sensory transduction protein regX3 +FIG00137820 Ferrichrome ABC transporter (permease) PvuC +FIG00137824 Iron compound ABC uptake transporter substrate-binding protein PiuA +FIG00137847 Iron compound ABC uptake transporter ATP-binding protein +FIG00137864 FIG137864: putative endonuclease containing a URI domain +FIG00137869 IncI1 plasmid conjugative transfer protein TraI +FIG00137875 Acyl carrier protein associated with anthrachelin biosynthesis +FIG00137877 FIG137877: Hypothetical protein in pyoverdin gene cluster +FIG00137878 Hypothetical protein FIG015671 in large core OS assembly cluster +FIG00137886 Pyruvate dehydrogenase E1 component (EC 1.2.4.1) +FIG00137902 Acetylornithine aminotransferase (EC 2.6.1.11); Ornithine aminotransferase (EC 2.6.1.13) +FIG00137917 Autoinducer 2 (AI-2) ABC transport system, fused AI2 transporter subunits and ATP-binding component +FIG00137918 Predicted sugar ABC transport system, ATP-binding protein YphE +FIG00137952 COG2047: Uncharacterized protein (ATP-grasp superfamily) +FIG00137957 2-methylaconitate racemase +FIG00137967 Transcriptional regulator MexT +FIG00137972 Sucrose phosphorylase (EC 2.4.1.7) +FIG00137985 LuxE, long-chain-fatty-acid ligase (EC 6.2.1.19) +FIG00137986 Aldehyde dehydrogenase (EC 1.2.1.3) in 4-hydroxyproline catabolic gene cluster +FIG00138004 Sucrose phosphorylase (EC 2.4.1.7) +FIG00138018 Alpha-glucosidase SusB (EC 3.2.1.20) +FIG00138020 Autoinducer 2 (AI-2) ABC transport system, membrane channel protein LsrD +FIG00138023 Predicted sugar ABC transport system, permease protein YphD +FIG00138031 Iron compound ABC uptake transporter permease protein +FIG00138037 Acetyl-CoA synthase corrinoid iron-sulfur protein, large subunit +FIG00138059 Citronellyl-CoA dehydrogenase +FIG00138060 Isochorismate pyruvate-lyase (EC 4.-.-.-) [pyochelin] siderophore (EC 4.2.99.21) +FIG00138066 Heme bearing subunit I of the terminal oxidase (DoxB) +FIG00138070 Translation elongation factor G Stremptomyces paralog +FIG00138071 2,3-dihydroxybenzoate-AMP ligase (EC 2.7.7.58) [pyochelin] siderophore +FIG00138082 5'-nucleotidase (EC 3.1.3.5); NAD pyrophosphatase, periplasmic (EC 3.6.1.22) +FIG00138083 Geranyl-CoA carboxylase biotin-containing subunit (EC 6.4.1.5) +FIG00138086 Ferrichrome ABC transporter (ATP binding subunit) PvuE +FIG00138089 Phosphate regulon sensor protein PhoR (SphS) (EC 2.7.13.3); Sensor-like histidine kinase senX3 (EC 2.7.13.3) +FIG00138090 S-adenosylhomocysteine deaminase (EC 3.5.4.28); Methylthioadenosine deaminase +FIG00138099 PvcC protein, related to two-component flavin adenine dinucleotide-dependent monooxygenases +FIG00138111 Nitrate reductase cytochrome c550-type subunit +FIG00138112 Formiminoglutamase (EC 3.5.3.8) +FIG00138127 3-(3-hydroxy-phenyl)propionate hydroxylase (EC 1.14.13.-) +FIG00138154 Conjugative transfer protein TrbF +FIG00138171 6-carboxytetrahydropterin synthase (EC 4.1.2.50) @ Queuosine biosynthesis QueD, PTPS-I +FIG00138175 Ribosomal RNA small subunit methyltransferase B (EC 2.1.1.-) +FIG00138182 Beta-mannosidase (EC 3.2.1.25) +FIG00138192 glutamine synthetase family protein +FIG00138200 Aconitate hydratase (EC 4.2.1.3) @ 2-methylisocitrate dehydratase (EC 4.2.1.99) +FIG00138202 Tetraacyldisaccharide 4'-kinase (EC 2.7.1.130) +FIG00138205 Uptake hydrogenase large subunit (EC 1.12.99.6) +FIG00138208 Glycolate dehydrogenase (EC 1.1.99.14), subunit GlcD +FIG00138209 Galactose/methyl galactoside ABC transport system, ATP-binding protein MglA (EC 3.6.3.17) +FIG00138210 NADH-ubiquinone oxidoreductase chain I (EC 1.6.5.3) +FIG00138225 Acetyl-CoA acetyltransferase (EC 2.3.1.9) @ Beta-ketoadipyl CoA thiolase (EC 2.3.1.-) +FIG00138227 NADH-ubiquinone oxidoreductase chain M (EC 1.6.5.3) +FIG00138231 Uncharacterized protein, similar to the N-terminal domain of Lon protease +FIG00138232 ATP-binding protein PhnN; Guanylate kinase (EC 2.7.4.8) +FIG00138239 tRNA:m(5)U-54 MTase gid +FIG00138240 Peptidyl-prolyl cis-trans isomerase PpiC (EC 5.2.1.8) +FIG00138249 Methylcrotonyl-CoA carboxylase carboxyl transferase subunit (EC 6.4.1.4) +FIG00138250 Diaminopimelate decarboxylase (EC 4.1.1.20) +FIG00138258 Dihydroxy-acid dehydratase (EC 4.2.1.9) +FIG00138266 Cytochrome c heme lyase subunit CcmL +FIG00138270 hypothetical protein NAS141_09886 +FIG00138286 quinol oxidase polypeptide I QoxB (EC:1.9.3.-) +FIG00138292 Protocatechuate 3,4-dioxygenase alpha chain (EC 1.13.11.3) +FIG00138298 Predicted L-lactate dehydrogenase, Iron-sulfur cluster-binding subunit YkgF +FIG00138308 Predicted L-lactate dehydrogenase, hypothetical protein subunit YkgG +FIG00138313 Twin-arginine translocation protein TatA +FIG00138316 Glutathione-regulated potassium-efflux system protein KefB +FIG00138353 Flagellar biosynthesis protein FliP +FIG00138354 Alkanesulfonates transport system permease protein +FIG00138356 Translation initiation factor SUI1-related protein +FIG00138381 Fibronectin/fibrinogen-binding protein +FIG00138385 Probable cytochrome c2 +FIG00138402 FolM Alternative dihydrofolate reductase 1 +FIG00138403 Methylglutaconyl-CoA hydratase (EC 4.2.1.18) +FIG00138404 UDP-3-O-[3-hydroxymyristoyl] glucosamine N-acyltransferase (EC 2.3.1.191) +FIG00138410 Light-independent protochlorophyllide reductase subunit N (EC 1.18.-.-) +FIG00138413 Fructose-1,6-bisphosphatase, GlpX type (EC 3.1.3.11) +FIG00138424 Conserved hypothetical protein (perhaps related to histidine degradation) +FIG00138440 Arginine/ornithine ABC transporter, permease protein AotM +FIG00138443 Mgl repressor and galactose ultrainduction factor GalS, HTH-type transcriptional regulator +FIG00138444 Succinylornithine transaminase (EC 2.6.1.81) +FIG00138446 Putative cytoplasmic protein ,probably associated with Glutathione-regulated potassium-efflux +FIG00138449 NADH-ubiquinone oxidoreductase chain D (EC 1.6.5.3) +FIG00138458 Isocitrate dehydrogenase [NAD] (EC 1.1.1.41) +FIG00138459 Benzoate 1,2-dioxygenase alpha subunit (EC 1.14.12.10) +FIG00138461 Cyclic AMP receptor protein +FIG00138468 Cobyrinic acid A,C-diamide synthase +FIG00138476 sulfur oxidation protein SoxA +FIG00138489 Alternative dihydrofolate reductase 3 +FIG00138511 Mg-protoporphyrin IX monomethyl ester oxidative cyclase (anaerobic) (EC 1.14.13.81) +FIG00138512 Formate dehydrogenase-O, iron-sulfur subunit (EC 1.2.1.2); Putative formate dehydrogenase iron-sulfur subunit (EC 1.2.1.2) +FIG00138514 probably aromatic ring hydroxylating enzyme, evidenced by COGnitor; PaaD-like protein (DUF59) involved in Fe-S cluster assembly +FIG00138517 FIG138517: Putative lipid carrier protein +FIG00138520 Penicillin-binding protein PBP2 +FIG00138523 Acetoin dehydrogenase E1 component alpha-subunit (EC 1.2.4.-) +FIG00138538 Aminomethyltransferase (glycine cleavage system T protein) (EC 2.1.2.10) +FIG00138542 Predicted nucleoside ABC transporter, substrate-binding component +FIG00138549 2-keto-3-deoxy-D-arabino-heptulosonate-7-phosphate synthase II PhzC (EC 2.5.1.54) +FIG00138562 Type cbb3 cytochrome oxidase biogenesis protein CcoG, involved in Cu oxidation +FIG00138566 Enterochelin uptake periplasmic binding protein +FIG00138576 FIG138576: 3-oxoacyl-[ACP] synthase (EC 2.3.1.41) +FIG00138580 Alcaligin biosynthesis complex, short chain / Alcaligin biosynthesis complex, large chain @ Siderophore synthetase component, ligase / Siderophore synthetase small component, acetyltransferase +FIG00138585 Bacterial proteasome-activating AAA-ATPase (PAN) +FIG00138604 Arabinose-regulated TonB-dependent outer membrane receptor +FIG00138609 Type IV secretion system protein VirD4 +FIG00138613 4-hydroxyphenylacetate 3-monooxygenase (EC 1.14.13.3) +FIG00138617 Organic hydroperoxide resistance protein +FIG00138619 CRISPR-associated protein, Cas5h family +FIG00138625 Malyl-CoA lyase (EC 4.1.3.24) +FIG00138632 Z-ring-associated protein ZapA +FIG00138665 phosphotransbutyrylase (EC 2.3.1.19) / Phosphate acetyltransferase (EC 2.3.1.8) +FIG00138695 Predicted signal-transduction protein containing cAMP-binding and CBS domains +FIG00138712 Isovaleryl-CoA dehydrogenase (EC 1.3.8.4) +FIG00138719 N-acetylgalactosamine kinase, ROK-type (EC 2.7.1.157) +FIG00138727 PvdE, pyoverdine ABC export system, fused ATPase and permease components +FIG00138741 Aldehyde dehydrogenase B (EC 1.2.1.22) +FIG00138754 Uncharacterized protein YtfN +FIG00138801 Beta-1,4-N-acetylgalactosaminyltransferase (EC 2.4.1.-) +FIG00138820 5-aminopentanamidase (EC 3.5.1.30) +FIG00138826 Substrate-specific component TTE1586 of predicted methylthioadenosine ECF transporter +FIG00138829 N-acetylglucosamine-1-phosphate uridyltransferase (EC 2.7.7.23) +FIG00138843 PTS system, N-acetylgalactosamine-specific IIC component +FIG00138868 Dihydrofolate synthase (EC 6.3.2.12) @ Folylpolyglutamate synthase (EC 6.3.2.17) / Alternative dihydrofolate reductase 2 / Dihydropteroate synthase (EC 2.5.1.15) +FIG00138880 Glutathione-regulated potassium-efflux system protein KefC +FIG00138887 Similar to carbon monoxide dehydrogenase CooS subunit +FIG00138889 O-antigen ligase +FIG00138908 Flavin reductase (EC 1.5.1.30) +FIG00138924 Amino acid regulated cytosolic protein +FIG00138928 FIG138928: iron-regulated membrane protein +FIG00138938 tRNA(Cytosine32)-2-thiocytidine synthetase +FIG00138942 Nitrite reductase [NAD(P)H] small subunit (EC 1.7.1.4) +FIG00138944 3-phenylpropionate dioxygenase, beta subunit (EC 1.14.12.19) +FIG00138953 Hydrogenase-4 component E +FIG00138960 Autolysis histidine kinase LytS +FIG00138965 Gluconate 2-dehydrogenase (EC 1.1.99.3), membrane-bound, cytochrome c +FIG00138976 Propionyl-CoA thioesterase activity +FIG00138978 Propionate--CoA ligase (EC 6.2.1.17) +FIG00138993 polysulfide reductase, subunit C +FIG00138994 2-methylaconitate isomerase +FIG00138999 Guanosine-5'-triphosphate,3'-diphosphate pyrophosphatase (EC 3.6.1.40) @ Exopolyphosphatase (EC 3.6.1.11) +FIG00139004 Hydantoin permease +FIG00139011 Circadian clock protein KaiC +FIG00139019 UDP-glucose:(heptosyl) LPS alpha1,3-glucosyltransferase WaaG (EC 2.4.1.-) +FIG00139040 Hypothetical transcriptional regulator YqhC +FIG00139050 Anaerobic glycerol-3-phosphate dehydrogenase subunit C (EC 1.1.5.3) +FIG00139058 Putrescine/proton symporter, putrescine/ornithine antiporter PotE +FIG00139069 N-acetyl-lysine aminotransferase (EC 2.6.1.-); Acetylornithine aminotransferase (EC 2.6.1.11) +FIG00139111 N-Acetyl-D-galactosamine permease, possible +FIG00139117 Putative phosphatase YqaB +FIG00139128 Transcriptional regulator FrcR for fructose utilization, ROK family +FIG00139150 Catalyzes the cleavage of p-aminobenzoyl-glutamate to p-aminobenzoate and glutamate, subunit B +FIG00139157 Type II/IV secretion system protein TadC, associated with Flp pilus assembly +FIG00139160 P-hydroxybenzoate hydroxylase (EC 1.14.13.2) +FIG00139162 Phytoene dehydrogenase and related proteins +FIG00139182 Fe-bacillibactin uptake system FeuC +FIG00139187 Predicted L-arabinose ABC transport system, permease protein 2 +FIG00139190 Lipopolysaccharide heptosyltransferase III (EC 2.4.1.-) +FIG00139192 NAD-reducing hydrogenase subunit HoxF (EC 1.12.1.2) +FIG00139194 L-pipecolate dehydrogenase (EC 1.5.99.3) +FIG00139213 CRISPR-associated protein, Csa2 family +FIG00139215 Hypothetical glycoside hydrolase, family 43, similar to arabinosidase +FIG00139218 Hypothetical protein GlcG in glycolate utilization operon +FIG00139235 Predicted trehalose permease, MFS family, FucP subfamily +FIG00139238 Galactoside O-acetyltransferase (EC 2.3.1.18) +FIG00139259 Eukaryotic-type low-affinity urea transporter +FIG00139262 Poly(glycerol-phosphate) alpha-glucosyltransferase (EC 2.4.1.52) +FIG00139273 ElaA protein +FIG00139277 Bona fide RidA/YjgF/TdcF/RutC subgroup +FIG00139292 Outer membrane porin, OprD family +FIG00139310 Glutathione S-transferase, Streptococcal type (EC 2.5.1.18) +FIG00139333 4'-phosphopantetheinyl transferase (EC 2.7.8.-) [enterobactin] siderophore +FIG00139343 Iron compound ABC uptake transporter substrate-binding protein +FIG00139347 Mll7752 protein +FIG00139370 Acetoacetyl-CoA synthetase (EC 6.2.1.16) +FIG00139395 Propanediol utilization polyhedral body protein PduA +FIG00139402 Uroporphyrinogen-III synthase, divergent, Francisella type (EC 4.2.1.75) +FIG00139406 Putative iron-regulated membrane protein FtpC in pyochelin gene cluster +FIG00139408 L-fuco-beta-pyranose dehydrogenase (EC 1.1.1.122) +FIG00139413 Proteasome-activating AAA-ATPase (PAN), archaeal +FIG00139423 Chlorophyllide reductase subunit BchX (EC 1.18.-.-) +FIG00139433 Formate hydrogenlyase subunit 5 +FIG00139435 Quorum-sensing transcriptional activator YpeR +FIG00139460 Lipoprotein NlpD +FIG00139491 NAD-reducing hydrogenase subunit HoxE (EC 1.12.1.2) +FIG00139508 periplasmic fructose-binding protein component of signal transduction system LevQ +FIG00139513 Protein of unknown function DUF1009 clustered with KDO2-Lipid A biosynthesis genes +FIG00139522 Predicted glycogen synthase, ADP-glucose transglucosylase (EC 2.4.1.21), Actinobacterial type +FIG00139550 Xaa-Pro dipeptidase PepQ (EC 3.4.13.9) +FIG00139552 FIG139552: Putative protease +FIG00139565 (Pyruvate) Oxoisovalerate Dehydrogenase Alpha & Beta Fusion like +FIG00139573 Nitrous oxide reductase maturation transmembrane protein NosY +FIG00139579 Uncharacterized protein YtfM precursor +FIG00139589 Probable L-ascorbate-6-phosphate lactonase UlaG (EC 3.1.1.-) (L-ascorbate utilization protein G) +FIG00139601 PTS system, sorbose-specific IID component +FIG00139643 Mannose-1-phosphate guanylyltransferase (GDP) (EC 2.7.7.22) ; Mannose-6-phosphate isomerase (EC 5.3.1.8) +FIG00139651 Pseudaminic acid biosynthesis protein PseA, possible Pse5Ac7Ac acetamidino synthase +FIG00139652 PTS system, tagatose-specific IIBC component (EC 2.7.1.69) +FIG00139680 Sucrose repressor, LacI family, Shewanella subfamily +FIG00139688 Putative phosphoenolpyruvate synthase/pyruvate phosphate dikinase, N-terminal domain +FIG00139706 N-acetyl glucosamine transporter, NagP +FIG00139719 Predicted L-arabinose ABC transport system, permease protein 1 +FIG00139722 Gluconate 2-dehydrogenase (EC 1.1.99.3), membrane-bound, gamma subunit +FIG00139726 Predicted L-arabinose ABC transport system, ATP-binding protein +FIG00139735 fructose sensor histidine kinase +FIG00139739 Lipopolysaccharide biosynthesis protein WzxC +FIG00139756 Siderophore staphylobactin biosynthesis protein SbnC @ Siderophore synthetase superfamily, group B +FIG00139777 Quinol oxidase-2, subunit II (SoxH) +FIG00139780 Iron(III) dicitrate transport system permease protein FecC (TC 3.A.1.14.1) +FIG00139793 Homoserine lactone synthase YpeI +FIG00139796 Zinc resistance-associated protein +FIG00139798 Pyoverdine chromophore precursor synthetase PvdL +FIG00139810 Predicted dehydrogenase in CelR regulon, COG0673 +FIG00139819 Predicted L-arabinose ABC transport system, periplasmic arabinose-binding protein +FIG00139823 Predicted Lactate-responsive regulator, IclR family +FIG00139895 Uncharacterized sugar kinase YeiI +FIG00139912 LuxC, acyl-CoA reductase (EC 1.2.1.50) +FIG00139960 PTS system, sorbose-specific IIA component +FIG00139970 Hypothetical protein in cluster with Mesaconyl-CoA hydratase +FIG00139991 FIG139991: Putative thiamine pyrophosphate-requiring enzyme +FIG00140038 L-threonine transporter, anaerobically inducible +FIG00140039 Dihydrolipoamide dehydrogenase of branched-chain alpha-keto acid dehydrogenase (EC 1.8.1.4) / Dihydrolipoamide dehydrogenase (EC 1.8.1.4) +FIG00140042 Sco1/SenC/PrrC protein family +FIG00140044 Trehalase (EC 3.2.1.28); Periplasmic trehalase precursor (EC 3.2.1.28) +FIG00140053 PTS system, fructose- and mannose-inducible IIA component (EC 2.7.1.69) +FIG00140064 Protein involved in meta-pathway of phenol degradation +FIG00140080 Inner membrane protein YphA +FIG00140088 Argininosuccinate lyase (EC 4.3.2.1) / N-acetylglutamate synthase (EC 2.3.1.1) +FIG00140091 IncI1 plasmid conjugative transfer protein TraJ, related to pilus biogenesis/retracton protein +FIG00140093 Putative arylsulfatase regulatory protein +FIG00140112 Urate oxidase (EC 1.7.3.3) +FIG00140113 Hypothetical transmembrane protein ywlD +FIG00140115 Arginine decarboxylase (EC 4.1.1.19) / Ornithine decarboxylase (EC 4.1.1.17) +FIG00140131 Porphobilinogen deaminase (EC 2.5.1.61) / Uroporphyrinogen-III synthase (EC 4.2.1.75) +FIG00140139 Predicted sucrose permease, MFS family, FucP subfamily +FIG00140152 Conjugative transfer protein TrbP (IncF TraX homolog) +FIG00140156 PvcD protein, related to two-component flavin adenine dinucleotide-dependent monooxygenases +FIG00140178 Probable glutathione S-transferase (EC 2.5.1.18), YfcG homolog +FIG00140180 N-acetylgalactosamine-6-phosphate deacetylase, predicted alternative (EC 3.5.1.25) +FIG00140212 Formate hydrogenlyase subunit 2 +FIG00140277 Acetoacetyl-CoA synthetase [leucine] (EC 6.2.1.16) / Long-chain-fatty-acid--CoA ligase (EC 6.2.1.3) +FIG00140280 UPF0131 protein YtfP +FIG00140307 PTS system, sorbose-specific IIC component +FIG00140326 Sialic acid-regulated TonB-dependent outer membrane receptor +FIG00140384 Transcriptional regulator of mannoside utilization, LacI family +FIG00140403 UDP-N-acetylmuramate--alanine ligase (EC 6.3.2.8) / D-alanine--D-alanine ligase (EC 6.3.2.4) +FIG00140448 Pyoverdine efflux carrier and ATP binding protein +FIG00140474 Toxin co-regulated pilus biosynthesis protein S +FIG00140480 Terminal oxidase, subunit (DoxC) +FIG00140555 V-type ATP synthase subunit I (EC 3.6.3.14) +FIG00140585 Ornithine aminotransferase (EC 2.6.1.13) / Acetylornithine aminotransferase (EC 2.6.1.11) +FIG00140657 vannilate transporter VanK +FIG00140689 low-specificity D-threonine aldolase +FIG00140752 PTS system, fructose- and mannose-inducible putative EII component +FIG00140809 Acetylornithine aminotransferase (EC 2.6.1.11); N-acetyl-lysine aminotransferase (EC 2.6.1.-) +FIG00140814 CRISPR-associated protein Cas5 +FIG00140889 Distant similarity with leukotriene C4 synthase (microsomal glutathione S-transferase) +FIG00140898 periplasmic fructose-binding protein component of signal transduction system LevT +FIG00140926 RecA protein @ intein-containing +FIG00140994 CRISPR-associated RecB family exonuclease Cas4 / CRISPR-associated protein Cas1 +FIG00141042 Flagellar trans-acting factor FliX +FIG00141064 Dihydrolipoamide dehydrogenase of acetoin dehydrogenase (EC 1.8.1.4) / Dihydrolipoamide dehydrogenase (EC 1.8.1.4) +FIG00141119 PTS system, galactose-inducible IIA component (EC 2.7.1.69) +FIG00141138 Mucin-desulfating sulfatase MdsA precursor (EC 3.1.6.14) +FIG00141156 Hemoglobin, heme-dependent two component system sensory histidine kinase ChrS +FIG00141213 Phosphonate uptake and metabolism regulator, LysR-family +FIG00141281 CRISPR-associated protein, Csh1 family +FIG00141282 DsrK-like protein @ selenocysteine-containing +FIG00141295 IncI1 plasmid conjugative transfer protein PilL +FIG00141316 6-pyruvoyl-tetrahydropterin synthase related protein +FIG00141344 duf556 family protein / Dihydroneopterin aldolase (EC 4.1.2.25) +FIG00141373 Regulatory protein SusR +FIG00141465 Monooxygenase component C / Probable epoxide hydrolase EphB (EC 3.3.2.9) +FIG00141548 Serine acetyltransferase (EC 2.3.1.30); PaaD-like protein (DUF59) involved in Fe-S cluster assembly +FIG00141575 Protein LiaH, similar to phage shock protein A +FIG00141588 Methylamine operon regulatory protein +FIG00141600 Aldehyde dehydrogenase in Methylamine utilization cluster +FIG00141602 Outer Membrane Siderophore Receptor IroN +FIG00141617 Fe-S-cluster-containing hydrogenase components 1 +FIG00141620 TniB NTP-binding protein +FIG00141624 Alpha-2-macroglobulin +FIG00141658 tRNA 2-thiouridine synthesizing protein E (EC 2.8.1.-) +FIG00141720 Glycosyl transferase ,group 2 family, anthrose biosynthesis +FIG00141730 Energy conserving hydrogenase Eha transmembrane protein K2 +FIG00141739 Ferric vibriobactin, enterobactin transport system, substrate-binding protein VctP (TC 3.A.1.14.6) +FIG00141779 RNA polymerase principal sigma factor HrdC +FIG00141795 Heparinase II/III-like +FIG00141802 Energy conserving hydrogenase Eha transmembrane protein C +FIG00141846 D-proline reductase, 26 kDa subunit (EC 1.21.4.1) @ selenocysteine-containing +FIG00141869 Light-harvesting LHII, beta subunit A +FIG00141875 hypothetical protein SKA53_09994 +FIG00141887 Bilin biosynthesis protein PecF +FIG00141920 Conjugative transfer entry exclusion protein TrbK +FIG00141928 Uroporphyrinogen-III synthase, divergent, Flavobacterial type (EC 4.2.1.75) +FIG00141977 macromolecule metabolism; macromolecule degradation; degradation of rna +FIG00141996 fumarate reductase/succinate dehydrogenase flavoprotein, N-terminal:FAD dependent oxidoreductase +FIG00142005 Predicted cobalt transporter in Thermoplasma +FIG00142039 DHA-specific phosphocarrier protein HPr +FIG00142056 Energy conserving hydrogenase Eha transmembrane protein L +FIG00142145 domain of unknown function / Thymidylate kinase (EC 2.7.4.9) +FIG00142152 hydrogenase, methyl-violgen-reducing type, delta subunit +FIG00142166 Maleylacetoacetate isomerase (EC 5.2.1.2) / Glutathione S-transferase, theta (EC 2.5.1.18) +FIG00142176 Energy conserving hydrogenase Ehb protein B +FIG00142195 Hydrogenase-4 transcriptional activator +FIG00142211 LuxG, NAD(P)H-dependent FMN reductase (EC 1.5.1.29) +FIG00142222 Uptake hydrogenase large subunit (EC 1.12.99.6) @ selenocysteine-containing +FIG00142223 Energy conserving hydrogenase Eha transmembrane protein E +FIG00142226 TonB-dependent receptor possibly related to N-acetylgalactosamine utilization +FIG00142243 Energy conserving hydrogenase Eha transmembrane protein A +FIG00142267 Energy conserving hydrogenase Eha transmembrane protein I +FIG00142306 Phosphoribosylaminoimidazolecarboxamide formyltransferase (EC 2.1.2.3) / IMP cyclohydrolase (EC 3.5.4.10) +FIG00142394 Ribonucleotide reductase of class Ib (aerobic), alpha subunit (EC 1.17.4.1) @ intein-containing +FIG00142410 Hypothetical SAR0365 homolog in superantigen-encoding pathogenicity islands SaPI +FIG00142475 ECF family sigma factor +FIG00142507 NADP-reducing hydrogenase, subunit B +FIG00142549 FIG00623394: hypothetical protein +FIG00142650 Energy conserving hydrogenase Ehb protein J +FIG00142691 Sugar kinase YihV +FIG00142729 IMP cyclohydrolase (EC 3.5.4.10) +FIG00142796 A-factor biosynthesis protein AfsA +FIG00142820 Archaeal DNA polymerase I (EC 2.7.7.7) @ intein-containing +FIG00142831 Aminotransferase ScrA +FIG00142837 Probable acetyl-CoA acetyltransferase FadA5 (EC 2.3.1.9) +FIG00142848 Shikimate 5-dehydrogenase I gamma (EC 1.1.1.25) +FIG00142855 Fructoselysine 6-phosphate deglycase (EC 3.5.-.-) +FIG00142867 Coenzyme B synthesis from 2-oxoglutarate: steps 4, 7, 8, 11, and 12 [large subunit] +FIG00142868 Similar to Glycine cleavage system H protein +FIG00142875 Plasmid conjugative transfer DNA helicase TrhI +FIG00142880 5'-methylthioadenosine/S-adenosylhomocysteine nucleosidase related protein BA2564 +FIG00142893 tRNA S(4)U 4-thiouridine synthase (former ThiI) +FIG00142915 Capsular polysaccharide biosynthesis/export periplasmic protein WcbC +FIG00142931 Putative phthalate 4,5-dioxygenase reductase subunit (OhpA1) +FIG00142933 Spore germination protein GerHB/GerIB +FIG00142934 Spore germination protein GerLB +FIG00142935 Spore germination protein GerSB +FIG00142936 Spore germination protein GerAB, germination response to L-alanine and related amino acids (earliest stage) +FIG00142937 Spore germination protein GerYB +FIG00142938 Spore germination protein GerXB (on pXO1) +FIG00142939 Uncharacterized spore germination protein YndE +FIG00142940 Spore germination protein GerQB +FIG00142951 Formate dehydrogenase-O, iron-sulfur subunit (EC 1.2.1.2) +FIG00142956 Putative membrane protein, clustering with ActP PaaL +FIG00142957 Membrane bound hydrogenase, MbhB subunit +FIG00142975 Putative two-component system response regulator YedW +FIG00142990 Hypothetical hydrolase YgeZ (EC 3.-.-.-) +FIG00142993 Putative oxidoreductase in putrescine utilization cluster +FIG00143001 Bona fide RidA/YjgF/TdcF/RutC subgroup +FIG00143002 Intradiol ring-cleavage dioxygenase (EC 1.13.11.1) +FIG00143005 Invasion protein InvA +FIG00143012 Predicted trehalose ABC transporter, substrate-binding component, Archaea-type +FIG00143014 Formate hydrogenlyase subunit 3 +FIG00143015 hydrogenase, HycC subunit, putative +FIG00143023 Spore germination protein GerLA +FIG00143043 2-chlorobenzoate 1,2-dioxygenase reductase component +FIG00143045 Pyruvate:ferredoxin oxidoreductase, gamma subunit (EC 1.2.7.1) / Ketoisovalerate oxidoreductase subunit VorG (EC 1.2.7.7) +FIG00143055 LysR-family transcriptional regulator STM3020 +FIG00143058 Invasion protein InvE +FIG00143062 2-ketobutyrate formate-lyase (EC 2.3.1.-) / Pyruvate formate-lyase (EC 2.3.1.54) +FIG00143078 Putative glucanase glgE (EC 3.2.1.-) +FIG00143080 Spore germination protein GerSA +FIG00143086 Acetophenone carboxylase subunit Apc1 (EC 6.4.1.8) +FIG00143087 Acetophenone carboxylase subunit Apc3 (EC 6.4.1.8) +FIG00143091 Spore germination protein GerQA +FIG00143110 Gamma-glutamyl-GABA hydrolase +FIG00143112 Hypothetical sugar ABC transporter, membrane protein UgtG +FIG00143114 Glucose ABC transport system, inner membrane component 2 +FIG00143121 Sialic acid biosynthesis protein NeuD, O-acetyltransferase +FIG00143126 Predicted chitobiose ABC transport system, permease protein 1 +FIG00143134 Stationary phase secreted protein TasA, major protein component of biofilm matrix +FIG00143136 Internalin G (LPXTG motif) +FIG00143145 Surface presentation of antigens protein SpaO +FIG00143164 ATPase component of energizing module of predicted pantothenate ECF transporter +FIG00143165 Membrane bound hydrogenase, NiFe-hydrogenase small subunit MbJ +FIG00143173 Tail tape-measure protein [Bacteriophage A118] +FIG00143189 Protein InvG precursor +FIG00143195 Ribose/xylose/arabinose/galactoside ABC-type transport systems, ATP-binding protein (EC 3.6.3.17) +FIG00143203 Hypothetical lactonase in carbon monoxide dehydrogenase cluster +FIG00143209 Acetylaminoadipate kinase (EC 2.7.2.-) @ Acetylglutamate kinase (EC 2.7.2.8) +FIG00143216 NAD-dependent epimerase/dehydratase family protein +FIG00143223 Transmembrane component of energizing module of ECF transporters in Mycobacteria +FIG00143224 Transmembrane component of energizing module of predicted tryptophan ECF transporter +FIG00143230 LysR family transcriptional regulator PA3398 +FIG00143262 Putative phthalate 4,5-dioxygenase oxygenase subunit (OhpA2) +FIG00143276 Capsule synthesis positive regulator AcpA +FIG00143287 Duplicated ATPase component SS1136 of energizing module of predicted ECF transporter +FIG00143288 Duplicated ATPase component of energizing module of predicted tryptophan ECF transporter +FIG00143294 Phenylacetic acid-specific porin PaaM +FIG00143316 CTP-dependent archaeal riboflavin kinase +FIG00143319 Co2 transporter containing CBS domains +FIG00143328 Large subunit toluate/benzoate dioxygenase +FIG00143332 archaeosine tRNA-ribosyltransferase (EC 2.4.2.-) type 1 / archaeosine tRNA-ribosyltransferase (EC 2.4.2.-) PUA domain +FIG00143356 tRNA(U54)-2-thioribothymidine synthetase +FIG00143363 Aminodeoxychorismate lyase (EC 4.1.3.38) / Branched-chain amino acid aminotransferase +FIG00143364 Minor teichoic acid biosynthesis protein GgaB +FIG00143378 Periplasmic Murein Peptide-Binding Protein MppA +FIG00143388 Phosphatase, Ppx/GppA family +FIG00143405 Capsular polysaccharide export system protein KpsC +FIG00143406 Polysialic acid transport protein KpsM +FIG00143419 hydroxybenzoate permease +FIG00143420 Membrane bound hydrogenase, MbhM subunit +FIG00143472 Carbon-monoxide dehydrogenase form II, large subunit (EC 1.2.99.2) +FIG00143474 Carbon monoxide dehydrogenase large chain (EC 1.2.99.2) without typical motifs +FIG00143478 Capsular polysaccharide biosynthesis/export periplasmic protein WcbA +FIG00143482 2-aminomuconate semialdehyde dehydrogenase (EC 1.2.1.32) +FIG00143484 Predicted chitobiose ABC transport system II, permease protein 2 +FIG00143499 Small subunit toluate/benzoate dioxygenase +FIG00143531 Penicillin-binding protein 2 (PBP-2) +FIG00143544 Ring hydroxylating dioxygenase, alpha subunit/Rieske (2Fe-2S) protein (EC 1.14.12.18) +FIG00143547 Aromatic-ring-hydroxylating dioxygenase, beta subunit +FIG00143557 Branched-chain amino acid aminotransferase (EC 2.6.1.42) @ Aminodeoxychorismate lyase (EC 4.1.3.38) +FIG00143561 Glutamine synthetase family protein in hypothetical Actinobacterial gene cluster +FIG00143564 Membrane bound hydrogenase, 4Fe-4S cluster-binding subunit MbhN +FIG00143582 2-chlorobenzoate 1,2-dioxygenase alpha subunit (EC 1.14.12.13) +FIG00143607 Monoamine/putrescine oxidase (EC 1.4.3.10) +FIG00143615 DedA family inner membrane protein YghB +FIG00143617 Bacteriochlorophyllide c C8 methyltransefase BchQ +FIG00143624 FIG002082: Protein SirB2 +FIG00143626 CRISPR-associated protein, WS1616 family +FIG00143635 L-seryl-tRNA(Sec) kinase +FIG00143643 Accessory secretory protein Asp2 +FIG00143645 Pup ligase PafA' paralog, possible component of postulated heterodimer PafA-PafA' +FIG00143647 GftB: Glycosyl transferase, family 8 +FIG00143668 TniQ +FIG00143694 5-tetrahydromethanopterin:corrinoid iron-sulfur protein methyltransferase / CO dehydrogenase/acetyl-CoA synthase subunit gamma, corrinoid iron-sulfur subcomplex large subunit +FIG00143703 CO dehydrogenase/acetyl-CoA synthase subunit delta, corrinoid iron-sulfur subcomplex small subunit +FIG00143722 Triacylglycerol lipase precursor (EC 3.1.1.3) +FIG00143804 TRAP transporter, 4TM/12TM fusion protein, unknown substrate 1 +FIG00143814 Indolepyruvate oxidoreductase subunit IorA-like (EC 1.2.7.8) +FIG00143828 FIG143828: Hypothetical protein YbgA +FIG00143837 D-galactonate regulator, IclR family +FIG00143849 3-dehydroshikimate dehydratase +FIG00143862 Secreted and spore coat-associated protein 3, similar to biofilm matrix component TasA and to camelysin +FIG00143891 Aldehyde dehydrogenase (EC 1.2.1.3) +FIG00143894 Polysaccharide biosynthesis glycosyl transferase CpsO +FIG00143902 Phosphoenolpyruvate-dihydroxyacetone phosphotransferase (EC 2.7.1.121), subunit DhaM; DHA-specific EI component +FIG00143941 LysR family transcriptional regulator PA1145 +FIG00143942 Aromatic amino acid aminotransferase gamma (EC 2.6.1.57) +FIG00143960 DHA-specific IIA component +FIG00143964 Putative spore germination protein, GerB family +FIG00144006 Major facilitator superfamily (MFS) transporter in predicted poly-gamma-glutamate synthase operon +FIG00144007 Polysaccharide biosynthesis glycosyl transferase CpsJ +FIG00144020 Putative peptidoglycan hydrolase YvbX, NOT involved in spore germination +FIG00144025 Teichoic acid glycosylation protein +FIG00144080 Phosphoribosylaminoimidazole-succinocarboxamide synthase (EC 6.3.2.6) / Phosphoribosylamine--glycine ligase (EC 6.3.4.13) +FIG00144082 O-phosphoseryl-tRNA(Sec) selenium transferase +FIG00144104 Phytochrome, two-component sensor histidine kinase (EC 2.7.3.-); cyanobacterial phytochrome 1 +FIG00144121 Phosphocarrier protein kinase/phosphorylase, nitrogen regulation associated +FIG00144128 Predicted rhamnose oligosaccharide ABC transporter, substrate-binding component +FIG00144167 Coenzyme B synthesis from 2-oxoglutarate: steps 4, 7, 8, 11, and 12 [small subunit] +FIG00144192 alternative Ribulokinase (EC 2.7.1.16) +FIG00144197 UPF0425 pyridoxal phosphate-dependent protein MJ0158 +FIG00144228 P-cymene monooxygenase, reductase subunit(CymAb) (EC 1.17.1.-) +FIG00144233 Cysteine synthase A (EC 2.5.1.47) +FIG00144244 Dihydrolipoamide dehydrogenase of 2-oxoglutarate dehydrogenase (EC 1.8.1.4) / Dihydrolipoamide dehydrogenase (EC 1.8.1.4) +FIG00144245 TldD-domain protein +FIG00144296 Mll9366 protein +FIG00144334 benzoate dioxygenase, ferredoxin reductase component / 1,2-dihydroxycyclohexa-3,5-diene-1-carboxylate dehydrogenase (EC 1.3.1.25) +FIG00144413 6-phosphofructokinase, fungal/animal type (EC 2.7.1.11) +FIG00144439 Shikimate kinase I (EC 2.7.1.71) / Shikimate 5-dehydrogenase I alpha (EC 1.1.1.25) +FIG00144447 TRAP-type C4-dicarboxylate transport system, periplasmic component / putative Taurine transporter, periplasmatic component +FIG00144450 Glycolate dehydrogenase (EC 1.1.99.14), subunit GlcD / Glycolate dehydrogenase (EC 1.1.99.14), FAD-binding subunit GlcE +FIG00144464 CooT +FIG00144487 Predicted rhamnose oligosaccharide ABC transporter, permease component 1 +FIG00144499 Slr, positive regulator of the extracellular matrix biosynthesis operon yqxM-sipW-tasA +FIG00144500 Substrate-specific component ST1137 of predicted ECF transporter +FIG00144554 Gamma-DL-glutamyl hydrolase PgsS (EC 3.4.19.-), catalyzes PGA release +FIG00144563 ATP-dependent DNA helicase UvrD/PcrA, clostridial paralog +FIG00144622 protein of unknown function DUF1612 +FIG00144627 clavaldehyde dehydrogenase +FIG00144657 Light-harvesting LHII, alpha subunit C +FIG00144674 Spore protein YdhD, not involved in spore germination +FIG00144741 Sensory histidine kinase CreB +FIG00144772 Repetitive hypothetical protein in ESAT cluster, BH0979 homolog +FIG00144817 Predicted mannitol permease +FIG00144821 ATP-dependent DNA helicase UvrD/PcrA/Rep +FIG00144900 Benzoate transport, ATPase component / Benzoate transport, inner membrane transport component +FIG00144902 Uncharacterized protein YkvT, NOT involved in spore germination +FIG00144951 Small primase-like proteins (Toprim domain) / 5-amino-6-(5-phosphoribosylamino)uracil reductase (EC 1.1.1.193) +FIG00144965 Similar to gamma-glutamyl-putrescine oxidase +FIG00144969 Polysaccharide biosynthesis protein CpsM(V) +FIG00144978 Coproporphyrinogen III oxidase, oxygen-independent (EC 1.3.99.22), divergent, putative 2 +FIG00145004 Pyruvate:ferredoxin oxidoreductase, alpha subunit (EC 1.2.7.1) / Pyruvate:ferredoxin oxidoreductase, beta subunit (EC 1.2.7.1) +FIG00145038 Indolepyruvate oxidoreductase subunit IorA (EC 1.2.7.8) / Indolepyruvate oxidoreductase subunit IorB (EC 1.2.7.8) +FIG00145041 p-cumate dioxygenase ferredoxin reductase subunit (CmtAa) +FIG00145070 Predictet Brp-like protein Blh +FIG00145080 tRNA nucleotidyltransferase related protein MMP0420 +FIG00145107 Glyceraldehyde-3-phosphate dehydrogenase (EC 1.2.1.12) (GAPDH) +FIG00145111 Cysteine synthase (EC 2.5.1.47) / Cysteinyl-tRNA synthetase paralog 2 +FIG00145126 D-xylose proton-symporter XylT +FIG00145159 Broad-specificity glycerol dehydrogenase (EC 1.1.99.22), subunit SldA +FIG00145171 HCOMODA decarboxylase +FIG00145176 ABC transporter, periplasmic spermidine putrescine-binding protein PotD (TC 3.A.1.11.1) / Spermidine Putrescine ABC transporter permease component potC (TC_3.A.1.11.1) +FIG00145196 Gliding motility protein (GldA) related protein +FIG00145201 Capsular polysaccharide biosythesis protein CpsI +FIG00145230 Monogalactosyldiacylglycerol synthase precursor +FIG00145231 p-cymene monooxygenase, hydroxylase subunit(CymAa) +FIG00145232 Predicted arabinose ABC transporter, substrate binding protein +FIG00145275 2-chlorobenzoate 1,2-dioxygenase (EC 1.14.12.13) +FIG00145308 Ribosylnicotinamide kinase (EC 2.7.1.22) / Unknown conserved in Flavobacteria +FIG00145335 Diphthine synthase (EC 2.1.1.98) ; L-lactate permease +FIG00145376 carbon monoxide dehydrogenase operon C protein +FIG00145380 Sulfur carrier protein ThiS / Thiazole biosynthesis protein ThiG +FIG00145399 CooJ +FIG00145462 Photosynthetic reaction center L subunit / Photosynthetic reaction center M subunit +FIG00145466 Gluconolactonase (EC 3.1.1.17) / Isochorismatase (EC 3.3.2.1) +FIG00145469 Probable acetyl-CoA acetyltransferase FadA6 (EC 2.3.1.9) +FIG00145485 Putative deoxyribonuclease YcfH / radical SAM domain protein +FIG00145487 Phosphoribosylaminoimidazolecarboxamide formyltransferase (EC 2.1.2.3) +FIG00145493 Menaquinone via futalosine step 2 +FIG00145497 AMP phosphohydrolase +FIG00145503 Zinc finger, TFIIB-type domain protein +FIG00145504 Proteasome subunit alpha (EC 3.4.25.1), bacterial +FIG00145505 Methenyltetrahydrofolate cyclohydrolase (EC 3.5.4.9) +FIG00145509 Glutamate synthase, alpha subunit domain protein +FIG00145525 UDP-N-acetylglucosamine 4-epimerase (EC 5.1.3.7) / UDP-glucose 4-epimerase (EC 5.1.3.2) +FIG00145528 Probable acyl-CoA dehydrogenase FadE28 (EC 1.3.99.-); Acyl-CoA dehydrogenase IgrB +FIG00145538 Probable enoyl-CoA hydratase EchA20 (EC 4.2.1.17) +FIG00145540 N-3-oxododecanoyl-L-homoserine lactone quorum-sensing transcriptional activator @ Transcriptional regulator LasR +FIG00145546 Superoxide dismutase [Mn] (EC 1.15.1.1); Superoxide dismutase [Fe] (EC 1.15.1.1); Superoxide dismutase ChrC +FIG00145554 Proteasome subunit beta (EC 3.4.25.1), bacterial +FIG00145557 cytochrome oxidase,subunit I (cydA-1) +FIG00145571 Fructokinase in mannitol utilization gene cluster (EC 2.7.1.4) +FIG00145589 NAD-specific glutamate dehydrogenase (EC 1.4.1.2) / NADP-specific glutamate dehydrogenase (EC 1.4.1.4) +FIG00145596 Putative CoA-transferase subunit beta Rv3552/MT3656 (EC 2.8.3.-) +FIG00145597 Carbon monoxide dehydrogenase CooS subunit (EC 1.2.99.2) +FIG00145602 Quinate/shikimate 5-dehydrogenase I delta (EC 1.1.1.25) +FIG00145678 Menaquinone via futalosine step 4, possible alternative +FIG00145698 Broad-specificity glycerol dehydrogenase (EC 1.1.99.22), subunit SldB +FIG00145743 Menaquinone via futalosine step 1 / Menaquinone via futalosine step 3 +FIG00145757 Methylthioribose-1-phosphate isomerase (EC 5.3.1.23) / Methylthioribulose-1-phosphate dehydratase (EC 4.2.1.109) +FIG00145778 ADP-dependent glucokinase (EC 2.7.1.147) @ ADP-dependent phosphofructokinase (EC 2.7.1.146) +FIG00145793 UDP-N-acetylmuramoylalanyl-D-glutamate--L-lysine ligase (EC 6.3.2.7) +FIG00145817 3-hydroxyisobutyryl-CoA hydrolase (EC 3.1.2.4); Enoyl-CoA hydratase (EC 4.2.1.17) +FIG00145851 14 kDa peptide of ubiquinol-cytochrome C2 oxidoreductase complex +FIG00145870 Lipid carrier : UDP-N-acetylgalactosaminyltransferase (EC 2.4.1.-) / Alpha-1,3-N-acetylgalactosamine transferase PglA (EC 2.4.1.-) +FIG00145874 Choline ABC transport system, ATP-binding protein OpuBA +FIG00145885 Transcriptional regulator, Crp/Fnr family +FIG00145963 Membrane-bound lytic murein transglycosylase B (EC 3.2.1.-) +FIG00146043 Putative hydrolase in cluster with formaldehyde/S-nitrosomycothiol reductase MscR +FIG00146048 L-cysteine:1D-myo-inosityl 2-amino-2-deoxy-alpha-D-glucopyranoside ligase MshC +FIG00146051 (R)-citramalate synthase (EC 2.3.1.182); 2-isopropylmalate synthase (EC 2.3.3.13) +FIG00146055 UDP-Bac2Ac4Ac hydrolyzing 2-epimerase NeuC homolog +FIG00146067 Thiol:disulfide involved in conjugative transfer +FIG00146073 Legionaminic acid cytidylyltransferase (EC 2.7.7.43) +FIG00146074 Pseudaminic acid cytidylyltransferase (EC 2.7.7.43) +FIG00146089 Sirohydrochlorin cobaltochelatase CbiK (EC 4.99.1.3) / Sirohydrochlorin ferrochelatase (EC 4.99.1.4) +FIG00146104 Uncharacterized GST-like protein yghU associated with glutathionylspermidine synthetase/amidase +FIG00146107 Uncharacterized GST-like protein yibF +FIG00146116 Glutathione S-transferase, theta (EC 2.5.1.18) +FIG00146146 Exopolysaccharide biosynthesis transcription antiterminator, LytR family / Cell envelope-associated transcriptional attenuator LytR-CpsA-Psr, subfamily F1 (as in PMID19099556) +FIG00146150 Acetone carboxylase, alpha subunit (EC 6.4.1.6) +FIG00146163 Similar to 5-oxoprolinase (EC 3.5.2.9) and Methylhydantoinases A, B (EC 3.5.2.14), C-terminal domain +FIG00146174 Legionaminic acid synthase (EC 2.5.1.56) +FIG00146182 Arginine N-succinyltransferase, alpha subunit (EC 2.3.1.109) +FIG00146183 Arginine N-succinyltransferase, beta subunit (EC 2.3.1.109) +FIG00146186 Acetone carboxylase, gamma subunit (EC 6.4.1.6) +FIG00146203 cytochrome-c3 hydrogenase delta chain +FIG00146204 cytochrome-c3 hydrogenase gamma chain +FIG00146212 FIG146212: Enoyl-CoA hydratase (EC 4.2.1.17) +FIG00146219 TonB-dependent heme and hemoglobin receptor HutA; TonB-dependent hemin , ferrichrome receptor +FIG00146238 L-sulfolactate dehydrogenase (EC 1.1.1.272) / Malate dehydrogenase (EC 1.1.1.37) +FIG00146278 FIG146278: Maf/YceF/YhdE family protein +FIG00146291 tRNA N6-threonylcarbamoyladenosine 2-methylthiotransferase (putative) @ tRNA-i(6)A37 methylthiotransferase +FIG00146342 2,3-diketo-L-gulonate-binding periplasmic protein yiaO precursor +FIG00146356 Aldehyde dehydrogenase in hypothetical Actinobacterial gene cluster +FIG00146363 COG2071: predicted glutamine amidotransferases in hypothetical Actinobacterial gene cluster +FIG00146364 Exopolysaccharide biosynthesis transcription antiterminator, LytR family +FIG00146368 RstR phage-related transcriptional repressor +FIG00146372 Amino acid permease in hypothetical Actinobacterial gene cluster +FIG00146381 Acetolactate synthase small subunit , predicted, Archaeal type 2 +FIG00146397 FIG146397: peptidase, M16 family +FIG00146405 RstB phage-related integrase +FIG00146421 Cyanobacteria-specific RpoD-like sigma factor, type-3; Group 2 RNA polymerase sigma factor +FIG00146436 Amino acid/metabolite permease in hypothetical Actinobacterial gene cluster; BAT1-like +FIG00146452 FIG146452: Zinc protease +FIG00146464 RstC phage-related antirepressor +FIG00146485 Cell envelope-associated transcriptional attenuator LytR-CpsA-Psr, subfamily F4 (as in PMID19099556) +FIG00146515 Hypothetical metal-binding enzyme, YcbL homolog +FIG00146516 Similar to Hydroxyacylglutathione hydrolase, but in an organism lacking glutathione biosynthesis +FIG00146520 Aspartate/ornithine carbamoyltransferase family protein protein YgeW +FIG00146524 Shikimate kinase III (EC 2.7.1.71) +FIG00146531 Capsular polysaccharide biosynthesis protein WcbJ, NAD-dependent epimerase/dehydratase family +FIG00146538 pH adaptation potassium efflux system protein D 3 +FIG00146542 Carbamate kinase-like protein YqeA +FIG00146544 Protein-N(5)-glutamine methyltransferase PrmB, methylates LSU ribosomal protein L3p +FIG00146546 Putative polysaccharide export protein YccZ precursor +FIG00146553 3-dehydroquinate dehydratase I (EC 4.2.1.10) / Chorismate mutase I (EC 5.4.99.5) +FIG00146565 Deblocking aminopeptidase (EC 3.4.11.-) @ Cyanophycinase 2 (EC 3.4.15.6) +FIG00146573 Thiol:disulfide oxidoreductase associated with MetSO reductase +FIG00146581 Beta-galactosidase 3 +FIG00146582 Putative glycogen debranching enzyme, archaeal type, TIGR01561 +FIG00146593 DegV family protein in cluster with TrmH family tRNA/rRNA methyltransferase YacO +FIG00146594 Aldose-ketose isomerase YihS +FIG00146604 Inner membrane transport protein YfaV +FIG00146606 Late competence protein ComC, processing protease; Leader peptidase (Prepilin peptidase) (EC 3.4.23.43) / N-methyltransferase (EC 2.1.1.-) +FIG00146647 Fructokinase (EC 2.7.1.4); Sugar kinase YihV +FIG00146651 Phenazine biosynthesis protein PhzE @ 2-Amino-2-deoxy-isochorismate synthase (EC 4.1.3.-) +FIG00146664 Predicted functional analog of homoserine kinase (EC 2.7.1.-) +FIG00146670 Multidrug efflux RND transporter MexD +FIG00146678 Cytochrome c-type biogenesis protein CcdA homolog, associated with MetSO reductase +FIG00146700 Acetylornithine aminotransferase 2 (EC 2.6.1.11) +FIG00146730 Outer membrane ferripyoverdine receptor +FIG00146735 Phage adsorption protein / Type IV fimbrial assembly, ATPase PilB +FIG00146737 General secretion pathway protein F / Type II secretory pathway, component PulF +FIG00146740 Ornithine aminotransferase (EC 2.6.1.13); Succinylornithine transaminase (EC 2.6.1.-); Acetylornithine aminotransferase (EC 2.6.1.11); N-succinyl-L,L-diaminopimelate aminotransferase (EC 2.6.1.17) +FIG00146759 Putative outer membrane lipoprotein YmcA +FIG00146763 Peptide methionine sulfoxide reductase MsrA (EC 1.8.4.11) / Thiol:disulfide oxidoreductase associated with MetSO reductase / Peptide methionine sulfoxide reductase MsrB (EC 1.8.4.12) +FIG00146792 Leader peptidase (Prepilin peptidase) (EC 3.4.23.43) +FIG00146814 Dimethylsulfoniopropionate (DMSP) acyl CoA transferase DddD +FIG00146831 Putative cytochrome P450 125 (EC 1.14.-.-); Putative cytochrome P450 IgrA +FIG00146907 Putative uncharacterized protein (Hypothetical short-chain type dehydrogenase/reductase) +FIG00146908 Predicted Fructose-bisphosphate aldolase (EC 4.1.2.13) in Geobacter +FIG00146965 Trehalose phosphorylase (EC 2.4.1.64) +FIG00146992 N-carbamoylputrescine amidase (3.5.1.53) / Agmatine deiminase (EC 3.5.3.12) +FIG00147003 Cyanophycinase (EC 3.4.15.6) dimer +FIG00147089 NADPH dependent preQ0 reductase-like +FIG00147090 Serine hydroxymethyltransferase 1 (EC 2.1.2.1) +FIG00147103 Outer membrane and periplasm component of type IV secretion of T-DNA complex, has secretin-like domain, VirB9 +FIG00147107 Inner membrane protein of type IV secretion of T-DNA complex, VirB8 +FIG00147108 Aromatic ring-opening dioxygenase +FIG00147124 Putative 2,4-dihydroxyhept-2-ene-1,7-dioic acid aldolase +FIG00147164 Fe-containing alcohol dehydrogenase +FIG00147166 Archaeal succinyl-CoA ligase [ADP-forming] alpha chain (EC 6.2.1.5) +FIG00147176 Archaeal succinyl-CoA ligase [ADP-forming] beta chain (EC 6.2.1.5) +FIG00147179 Two component system sensor histidine kinase PnpS; Phosphate regulon sensor protein PhoR (SphS) (EC 2.7.13.3) +FIG00147183 Putative 5-carboxymethyl-2-hydroxymuconate semialdehyde dehydrogenase oxidoreductase protein (EC 1.2.1.60) +FIG00147187 Putative fumarylacetoacetate (FAA) hydrolase +FIG00147247 3-oxoadipate enol-lactone hydrolase/4-carboxymuconolactone decarboxylase +FIG00147292 Inositol oxygenase (EC 1.13.99.1) +FIG00147293 decarboxylase +FIG00147384 Ferric uptake regulation protein +FIG00147439 Phage terminase large subunit @ intein-containing +FIG00147468 Putative malate dehydrogenase (EC 1.1.1.37), similar to archaeal MJ1425 +FIG00147479 Peptide methionine sulfoxide reductase MsrA (EC 1.8.4.11) @ selenocysteine-containing +FIG00147515 TRAP-type transport system, periplasmic component, predicted N-acetylneuraminate-binding protein / TRAP transporter solute receptor, unknown substrate 8 +FIG00147532 Uronate isomerase, family BH0493 (EC 5.3.1.12) +FIG00147534 probable cytochrome oxidase (cbb3-type) +FIG00147618 Signal peptidase I (EC 3.4.21.89) +FIG00147619 Serine hydroxymethyltransferase (EC 2.1.2.1) / H4MPt-dependent SHMT +FIG00147622 2-amino-4-ketopentanoate thiolase, beta subunit +FIG00147632 Putative 3-hydroxyacyl-coa dehydrogenase +FIG00147633 PTS system, galactosamine-specific IID component (EC 2.7.1.69) +FIG00147644 4'-phosphopantetheinyl transferase (EC 2.7.8.-) in polymyxin biosynthetic cluster +FIG00147649 Novel glucosamine kinase in celF cluster +FIG00147654 PTS system, galactosamine-specific IIB component (EC 2.7.1.69) +FIG00147666 Conserved protein YghR, with nucleoside triphosphate hydrolase domain +FIG00147670 Lipopolysaccharide cholinephosphotransferase LicD3 (EC 2.7.8.-) +FIG00147693 ABC Fe3+ siderophore transporter, inner membrane subunit +FIG00147706 PTS system, galactosamine-specific IIC component (EC 2.7.1.69) +FIG00147713 Alpha-glucoside transport ATP-binding protein AglK +FIG00147720 Acyl-coenzyme A synthetases/AMP-(fatty) acid ligases, YtcI homolog +FIG00147737 Possible 3-(3-hydroxy-phenyl)propionate hydroxylase (EC 1.14.13.-) +FIG00147738 Enoyl-CoA hydratase/isomerase family protein, may be related to NAD-dependent histone deacetylation +FIG00147779 pH adaptation potassium efflux system protein D 2 +FIG00147784 PTPS-like type 4 +FIG00147787 GTP pyrophosphokinase +FIG00147806 Fe-S oxidoreductase-like protein in Rubrerythrin cluster +FIG00147816 2,4-diaminopentanoate dehydrogenase (EC 1.4.1.12) +FIG00147823 Permease Ygh-P2, YjgP/YjgQ family +FIG00147825 Two-component response regulator YvcP +FIG00147834 2-amino-4-ketopentanoate thiolase, alpha subunit +FIG00147837 Ubiquinol-cytochrome C chaperone +FIG00147841 Multidrug transporter MdtC +FIG00147842 Peptidase C14, caspase catalytic subunit p20 +FIG00147843 Regulatory protein LuxO +FIG00147851 D-Ornithine 4,5-aminomutase S subunit (EC 5.4.3.5) +FIG00147854 PH adaptation potassium efflux system protein G; sodium- potassium/hydrogen antiporter subunit G +FIG00147862 DNA sulfur modification protein DndB +FIG00147868 Putative HTH-type transcriptional regulator YdjF +FIG00147869 FIG147869: Carbon-nitrogen hydrolase +FIG00147881 Putative carbohydrate PTS system, IIB component (EC 2.7.1.69) +FIG00147885 Two-component response regulator BceR +FIG00147889 Hypothetical protein probably related to Formate dehydrogenase function +FIG00147891 FO biosynthesis ArfB +FIG00147892 Probable reactivating factor for D-ornithine aminomutase +FIG00147912 D-Ornithine 4,5-aminomutase E subunit (EC 5.4.3.5) +FIG00147918 PH adaptation potassium efflux system protein E; sodium- potassium/hydrogen antiporter subunit E +FIG00147922 Permease Ygh-P1, YjgP/YjgQ family +FIG00147929 Gamma-hemolysin component C +FIG00147930 Ornithine racemase (EC 5.1.1.12) +FIG00147940 Immunity factor CibC +FIG00147949 Conserved protein LiaG in B. subtilis in Lia cluster +FIG00147953 DNA-directed RNA polymerase subunit G (EC 2.7.7.6) +FIG00147973 beta-lactamase-like +FIG00147987 Leukotoxin LukD +FIG00147993 Ferrous iron transport permease EfeU / Ferrous iron transport periplasmic protein EfeO, contains peptidase-M75 domain and (frequently) cupredoxin-like domain +FIG00148008 PH adaptation potassium efflux system protein B2; sodium- potassium/hydrogen antiporter subunit B2 +FIG00148188 CoB--CoM-reducing hydrogenase (Sec) delta subunit; selenocysteine-containing +FIG00148200 Putative pentose isomerase +FIG00148227 Pseudouridine 5'-phosphate glycosidase +FIG00148254 Inner membrane protein CreD-like protein +FIG00148262 Inner membrane transport protein YeiM, in cluster with pseudouridine metabolism operon +FIG00148322 Ribokinase (EC 2.7.1.15); Ribokinase in cluster with nucleoside hydrolase (EC 2.7.1.15) +FIG00148338 PTS system, diacetylchitobiose-specific IIC component (EC 2.7.1.69) +FIG00148353 Iron-sulfur protein clustered with CO dehydrogenase/acetyl-CoA synthase +FIG00148371 Membrane protein CarB involved in the export of O-antigen and teichoic acid, Streptococci specific +FIG00148382 Enoyl-CoA hydratase (EC 4.2.1.17) / Delta(3)-cis-delta(2)-trans-enoyl-CoA isomerase (EC 5.3.3.8) / 3-hydroxyacyl-CoA dehydrogenase (EC 1.1.1.35) +FIG00148406 TTE0858 replicon stabilization protein (antitoxin to TTE0859) +FIG00148414 CitH citrate transporter +FIG00148417 AnfR protein, required for Mo- and V-independent nitrogenase +FIG00148432 Nitrogenase vanadium-cofactor synthesis protein VnfY +FIG00148434 Lipopolysaccharide biosynthesis glycosyltransferase +FIG00148448 Cobalamin biosynthesis protein BluB; 5,6-dimethylbenzimidazole synthase, flavin destructase family +FIG00148451 Nitrogenase cofactor carrier protein NafY +FIG00148457 NifY protein +FIG00148459 NifM protein +FIG00148460 Response regulator SypE +FIG00148484 Lipopolysaccharide synthesis protein WavD +FIG00148488 Homoserine dehydrogenase (EC 1.1.1.3) / Aspartokinase (EC 2.7.2.4) +FIG00148490 Propanediol utilization protein PduX; Threonine kinase in B12 biosynthesis +FIG00148492 Nitrogenase FeMo-cofactor scaffold and assembly protein NifN / Nitrogenase FeMo-cofactor synthesis FeS core scaffold and assembly protein NifB +FIG00148503 Nitrogenase (vanadium-iron) transcriptional regulator VnfA +FIG00148514 Microcompartment protein protein similar to PduA/PduJ +FIG00148520 Cob(I)alamin adenosyltransferase fragment +FIG00148535 Hypothetical protein with distant similarity to Ribonuclease E inhibitor RraA (former MenG) +FIG00148577 2-dehydro-3-deoxyphosphogluconate aldolase (EC 4.1.2.14) / 2-dehydro-3-deoxygluconate kinase (EC 2.7.1.45) +FIG00148579 Serine/threonine-protein kinase ImpN involved in nitrogen fixation +FIG00148580 Penicillin-insensitive transglycosylase (EC 2.4.2.-) & transpeptidase PBP-1C +FIG00148597 UDP-N-acetylmuramoylalanyl-D-glutamate--L-ornithine ligase +FIG00148600 Regulatory protein of benzoate catabolism +FIG00148607 ATP-binding protein ManX +FIG00148617 Cystathionine gamma-synthase (EC 2.5.1.48) / Cystathionine gamma-synthase (EC 2.5.1.48) fungal type +FIG00148624 Isocitrate lyase (EC 4.1.3.1) @ Methylisocitrate lyase (EC 4.1.3.30) +FIG00148627 FIG000868: Homolog of E. coli HemY protein +FIG00148628 Outer membrane (iron.B12.siderophore.hemin) receptor +FIG00148629 PTS system, mannose-specific IID component @ PTS system, fructose-specific IID component (EC 2.7.1.69) +FIG00148635 FIG001393: Sensor histidine kinase PrrB (RegB) (EC 2.7.3.-) +FIG00148653 Iron-siderophore [Alcaligin-like] ferric reductase (1.6.99.14) +FIG00148663 Acetyl-CoA acetyltransferase (EC 2.3.1.9) of ethylmalonyl-CoA pathway +FIG00148680 Aerobactin siderophore receptor IutA / Rhizobactin 1021 siderophore outer membrane receptor / Schizokinen siderophore outer membrane receptor +FIG00148681 Outer membrane receptor proteins, likely involved in siderophore uptake @ TonB-dependent siderophore receptor +FIG00148683 Ferrichrome transport system permease protein FhuB (TC 3.A.1.14.3) +FIG00148694 Isochorismate synthase (EC 5.4.4.2) [enterobactin] siderophore +FIG00148695 FIG004131: Transcriptional regulator, ArsR family +FIG00148697 Ferric enterobactin transport system permease protein FepG (TC 3.A.1.14.2) @ ABC-type Fe3+-siderophore transport system, permease 2 component +FIG00148699 Ferric enterobactin transport system permease protein FepD (TC 3.A.1.14.2) @ ABC-type Fe3+-siderophore transport system, permease component +FIG00148701 Siderophore achromobactin ABC transporter, permease protein +FIG00148704 tRNA-dependent lipid II--L-alanine ligase +FIG00148708 Circadian phase modifier @ NCAIR mutase (PurE)-related protein +FIG00148725 Predicted alpha-arabinosides ABC transport system, permease protein 2 +FIG00148731 Siderophore synthetase small component, acetyltransferase +FIG00148733 Desferrioxamine E biosynthesis protein DesC @ Siderophore synthetase small component, acetyltransferase +FIG00148737 Predicted arabinose ABC transporter, permease protein 1 +FIG00148755 Fe-bacillibactin uptake system FeuA, Fe-bacillibactin binding +FIG00148756 Ferrichrome ABC transporter, periplasmic iron-binding protein PvuB +FIG00148761 Glucose ABC transporter, ATP-binding subunit (EC 3.6.3.-) +FIG00148762 Putative coenzyme F420-dependent oxidoreductase MJ1349 +FIG00148776 Spore coat protein Y +FIG00148781 Glucose ABC transport system, inner membrane component 1 +FIG00148785 Desferrioxamine E biosynthesis protein DesA @ Siderophore biosynthesis L-2,4-diaminobutyrate decarboxylase +FIG00148787 GbcA family protein, putative N1-methylnicotinamide or trigonelline demethylase +FIG00148788 Toluene-4-monooxygenase, subunit TmoC +FIG00148792 L-ornithine 5-monooxygenase (EC 1.13.12.-), PvdA of pyoverdin biosynthesis @ Siderophore biosynthesis protein, monooxygenase +FIG00148794 Phosphonopyruvate hydrolase (EC 3.11.1.3) +FIG00148795 Desferrioxamine E biosynthesis protein DesD @ Siderophore synthetase superfamily, group C @ Siderophore synthetase component, ligase +FIG00148796 Siderophore [Alcaligin] biosynthesis complex, long chain @ Siderophore synthetase component, ligase +FIG00148797 Iron-siderophore [Alcaligin-like] receptor @ TonB-dependent siderophore receptor +FIG00148798 Iron-siderophore [Alcaligin] receptor @ TonB-dependent siderophore receptor +FIG00148799 Putative OMR family iron-siderophore receptor precursor @ TonB-dependent siderophore receptor +FIG00148808 GbcB Glycine betaine demethylase subunit B +FIG00148809 GbcB family protein +FIG00148831 Phenol hydroxylase, FAD- and [2Fe-2S]-containing reductase component DmpP +FIG00148837 Acetoacetyl-CoA reductase (EC 1.1.1.36) of ethylmalonyl-CoA pathway +FIG00148840 crotonyl-CoA reductase +FIG00148847 heme uptake transmembrane sensor +FIG00148848 Toluene-4-monooxygenase, subunit TmoA +FIG00148852 Foldase protein PrsA precursor (EC 5.2.1.8) @ Foldase clustered with pyrimidine conversion +FIG00148853 UDP-N-acetylmuramoyl-tripeptide--D-alanyl-D-alanine ligase (EC 6.3.2.10) +FIG00148854 FIG094199: Fumarylacetoacetate hydrolase +FIG00148863 Iron-siderophore [Alcaligin-like] transport system, ATP-binding component @ Iron-siderophore transport system, ATP-binding component +FIG00148864 Ferric enterobactin transport ATP-binding protein FepC (TC 3.A.1.14.2) @ ABC-type Fe3+-siderophore transport system, ATPase component +FIG00148877 Superoxide dismutase [Fe] (EC 1.15.1.1) @ Exosporium SOD +FIG00148885 2,3-dihydro-2,3-dihydroxybenzoate dehydrogenase (EC 1.3.1.28) [bacillibactin] siderophore @ 2,3-dihydro-2,3-dihydroxybenzoate dehydrogenase (EC 1.3.1.28) of siderophore biosynthesis +FIG00148890 Isochorismatase (EC 3.3.2.1) [bacillibactin] siderophore @ Isochorismatase (EC 3.3.2.1) of siderophore biosynthesis +FIG00148894 Isochorismate synthase (EC 5.4.4.2) [bacillibactin] siderophore @ Isochorismate synthase (EC 5.4.4.2) of siderophore biosynthesis +FIG00148911 RidA/YER057c/UK114 superfamily, group 1 +FIG00148913 Uncharacterized iron compound ABC uptake transporter, ATP-binding protein +FIG00148923 2,3-dihydroxybenzoate-AMP ligase (EC 2.7.7.58) [bacillibactin] siderophore +FIG00148929 Ferric hydroxamate outer membrane receptor FhuA +FIG00148938 Malyl-CoA lyase (EC 4.1.3.24) @ Beta-methylmalyl-CoA lyase (EC 4.1.3.-) @ Citramalyl-CoA lyase (EC 4.1.3.-) +FIG00148941 Siderophore biosynthesis protein, monooxygenase +FIG00148942 Siderophore [Alcaligin] biosynthetic enzyme (EC 1.14.13.59) @ Siderophore biosynthesis protein, monooxygenase +FIG00148943 Siderophore [Alcaligin-like] biosynthetic enzyme (EC 1.14.13.59) @ Siderophore biosynthesis protein, monooxygenase +FIG00148946 Poly(glycerol-phosphate) alpha-glucosyltransferase GftA (EC 2.4.1.52) +FIG00148947 Uncharacterized iron compound ABC uptake transporter, substrate-binding protein +FIG00148988 hypothetical protein possibly connected to lactam utilization and allophanate hydrolase +FIG00148990 COG2041: Sulfite oxidase and related enzymes +FIG00148991 Thimet oligopeptidase (EC 3.4.24.15) +FIG00148997 Uracil-DNA glycosylase, family 3 +FIG00149001 Aromatic amino acid aminotransferase gamma (EC 2.6.1.57) @ Aspartate aminotransferase (EC 2.6.1.1) +FIG00149002 ORF C81-like +FIG00149004 Uncharacterized conserved protein +FIG00149005 mRNA 3-end processing factor +FIG00149009 Similar to ribosomal protein L11p +FIG00149013 CRISPR-associated protein TM1812 +FIG00149015 Methane monooxygenase component A alpha chain (EC 1.14.13.25) +FIG00149016 FIG000124: Ribosomal large subunit pseudouridine synthase D (EC 4.2.1.70) +FIG00149020 Lipoate-protein ligase A / domain of unknown function +FIG00149021 CBSS-74546.3.peg.720: hypothetical protein +FIG00149023 FIG107367: tRNA-binding protein +FIG00149024 CRISPR-associated RAMP Cmr6 +FIG00149025 Endo-alpha-mannosidase +FIG00149026 Phage T7 exclusion protein associated hypothetical protein +FIG00149029 SpoVS-related protein, type 5 +FIG00149030 CBSS-498211.3.peg.1514: hypothetical protein +FIG00149033 DNA polymerase-like protein MT3142 +FIG00149036 Extracytoplasmic function (ECF) sigma factor VreI +FIG00149040 Hypothetical protein distantly related to cytochrome C-type biogenesis protein CcdA +FIG00149041 FIG149041: Thioredoxin +FIG00149043 Phosphonoalanine and/or phosphonopyruvate ABC transporter ATP-binding protein +FIG00149044 CBSS-293826.4.peg.2064: hypothetical protein +FIG00149045 Hypothetical similar to CcmC, putative heme lyase for CcmE +FIG00149047 FIG133424: Low molecular weight protein tyrosine phosphatase (EC 3.1.3.48) +FIG00149048 Diadenosine 5'5'''-P1,P4-tetraphosphate pyrophosphohydrolase / Uracil-DNA glycosylase, family 4 +FIG00149049 COG1399 protein in cluster with ribosomal protein L32p, Francisella subfamily +FIG00149053 Toluene-4-monooxygenase, subunit TmoD +FIG00149054 Inosine-uridine preferring nucleoside hydrolase (EC 3.2.2.1) in exosporium +FIG00149058 Methionyl-tRNA synthetase, clostridial paralog +FIG00149059 sulfatase family protein( EC:3.1.6.- ) +FIG00149060 hydrogenase/sulfur reductase, beta subunit +FIG00149061 Chlorosome protein B; Chlorosome envelope +FIG00149062 NLP/P60 family lipoprotein +FIG00149063 Phosphate-binding DING protein (related to PstS) +FIG00149065 Arginyl-tRNA synthetase related protein 1 +FIG00149068 Phenol hydroxylase, assembly protein DmpK +FIG00149071 SpoVS-related protein, type 2 +FIG00149072 Quino(hemo)protein alcohol dehydrogenase, PQQ-dependent (EC 1.1.99.8) +FIG00149074 Hypothetical distantly related to thiol:disulfide interchange protein DsbA +FIG00149076 Toluene-4-monooxygenase, subunit TmoF +FIG00149078 Methane monooxygenase component C (EC 1.14.13.25) +FIG00149079 Cytochrome c-type biogenesis protein CcdA (DsbD analog) / Cytochrome c-type biogenesis protein ResA +FIG00149082 Polyketide cyclase WhiE II +FIG00149085 Toluene-4-monooxygenase, subunit TmoE +FIG00149090 Regulatory protein BlaR1 +FIG00149091 Sarcosine N-methyltransferase @ Dimethylglycine N-methyltransferase +FIG00149095 Predicted arabinose ABC transporter, permease protein 2 +FIG00149098 hydrogenase/sulfur reductase, gamma subunit +FIG00149099 Phage antitermination protein N +FIG00149107 Predicted galacto-N-biose-/lacto-N-biose I ABC transporter, periplasmic substrate-binding protein +FIG00149113 Achromobactin biosynthesis protein AcsB, HpcH/HpaI aldolase family +FIG00149114 Cholinephosphate cytidylyltransferase (EC 2.7.7.15) / Choline kinase (EC 2.7.1.32) +FIG00149121 Acyl carrier protein WhiE V +FIG00149122 macromolecule metabolism; macromolecule degradation; degradation of polysaccharides +FIG00149124 Transcription elongation factor GreB-related protein +FIG00149125 Thiamin-phosphate pyrophosphorylase (EC 2.5.1.3) / Hydroxymethylpyrimidine phosphate kinase ThiD (EC 2.7.4.7) / Thiaminase II (EC 3.5.99.2) involved in salvage of thiamin pyrimidine moiety, TenA subgroup with Cys in active site +FIG00149127 Vibrioferrin amide bond forming protein PvsB +FIG00149128 TesB-like acyl-CoA thioesterase 2 +FIG00149130 Homocitrate synthase omega subunit (EC 2.3.3.14) +FIG00149132 Siderophore synthetase superfamily, group C @ Siderophore synthetase component, ligase / Siderophore synthetase small component, acetyltransferase +FIG00149134 ABC-type Fe3+-siderophore transport system, periplasmic iron-binding component +FIG00149135 Lipoteichoic acid synthase LtaS Type IVa +FIG00149136 macromolecule metabolism; macromolecule degradation; degradation of dna +FIG00149137 HTH-type transcriptional regulator YidP +FIG00149138 coenzyme F420-reducing hydrogenase, beta subunit homolog +FIG00149142 CBSS-345074.3.peg.1627: Cysteine desulfurase (EC 2.8.1.7) +FIG00149143 Chlorosome protein E +FIG00149147 Chorismate mutase I (EC 5.4.99.5) / Shikimate kinase I (EC 2.7.1.71) +FIG00149152 Chlorosome protein J, 2Fe-2S ferredoxin +FIG00149153 Glutamate--cysteine ligase archaeal (EC 6.3.2.2) +FIG00149157 Capsular polysaccharide synthesis enzyme CpsE +FIG00149162 Polyketide chain length factor WhiE-CLF paralog +FIG00149163 TonB-dependent ferric achromobactin receptor protein +FIG00149164 Putative acetyltransferase / Putative acetyltransferase, GNAT family / DNA-3-methyladenine glycosylase (EC 3.2.2.20) / GMP synthase [glutamine-hydrolyzing] (EC 6.3.5.2) +FIG00149173 L-sulfolactate dehydrogenase (EC 1.1.1.272) +FIG00149175 Cobalamin biosynthesis protein CobG / Cobalt-precorrin-8x methylmutase (EC 5.4.1.2) +FIG00149177 WhiE I protein of unknown function +FIG00149178 Siderophore synthetase large component, acetyltransferase +FIG00149182 Polyketide beta-ketoacyl synthase WhiE-KS paralog +FIG00149184 Positive regulator of phenol hydroxylase +FIG00149186 Heme-degrading oxygenase, IsdG-like +FIG00149188 Phosphonoalanine and/or phosphonopyruvate ABC transporter permease protein +FIG00149189 Particulate methane monooxygenase B-subunit (EC 1.14.13.25) +FIG00149194 Chlorosome protein X +FIG00149196 Hypothetical bd-type Menaquinol oxidase subunit +FIG00149198 SpoVS-related protein, type 3 +FIG00149208 Siderophore achromobactin ABC transporter, substrate-binding protein +FIG00149209 Superoxide dismutase (EC 1.15.1.1) +FIG00149214 Sporulation kinase C (EC 2.7.13.3) +FIG00149218 FixO3 cytochrome-c oxidase subunit +FIG00149221 D-proline reductase, 26 kDa subunit @ selenocysteine-containing +FIG00149222 Predicted alpha-arabinosides ABC transport system, substrate-binding protein +FIG00149223 antitermination protein Q +FIG00149229 Adenosylcobinamide-phosphate guanylyltransferase (EC 2.7.7.62) / Nicotinate-nucleotide--dimethylbenzimidazole phosphoribosyltransferase (EC 2.4.2.21) +FIG00149230 CBSS-272943.3.peg.263: hypothetical protein +FIG00149234 macromolecule metabolism; macromolecule degradation +FIG00149236 Adenylate/guanylate cyclase (EC 4.6.1.2) +FIG00149237 Membrane protein involved in the export of O-antigen and teichoic acid +FIG00149239 DotC protein +FIG00149241 Siderophore achromobactin ABC transporter, ATPase component +FIG00149244 Hydroxylamine oxidoreductase precursor (EC 1.7.3.4) +FIG00149245 Siderophore synthetase component, ligase +FIG00149252 FIG002343: hypothetical protein / FIG001454: Transglutaminase-like enzymes, putative cysteine proteases +FIG00149257 Uracil DNA glycosylase superfamily protein +FIG00149259 WhiB-like transcriptional regulator +FIG00149261 NAD-dependent formate dehydrogenase alpha subunit; selenocysteine-containing +FIG00149263 similar bacteriphage P22 ninH +FIG00149264 Particulate methane monooxygenase A-subunit (EC 1.14.13.25) +FIG00149267 Hypothetical protein distantly related to putative heme lyase CcmC +FIG00149270 domain similar to cysteinyl-tRNA synthetase and MshC +FIG00149274 Putative periplasmic phosphate-binding protein PstS (Catenulisporaceae type) +FIG00149275 Ferrous iron transport permease EfeU, N-terminal extended +FIG00149277 Exodeoxyribonuclease V beta chain (EC 3.1.11.5) / Exodeoxyribonuclease V alpha chain (EC 3.1.11.5) +FIG00149285 Uptake hydrogenase large subunit (EC 1.12.99.6); selenocysteine-containing +FIG00149286 Polyketide hydroxylase WhiE VIII +FIG00149287 TonB-dependent hemin receptor +FIG00149290 archaeosine tRNA-ribosyltransferase (EC 2.4.2.-) type 1 like +FIG00149291 Chlorosome protein H +FIG00149296 Chlorosome protein I, 2Fe-2S ferredoxin +FIG00149298 Glycerol dehydratase reactivation factor small subunit +FIG00149300 Hypothetical protein pVir0042 +FIG00149301 Transcriptional activator similar to cyn operon regulator +FIG00149307 Geranylgeranyl pyrophosphate synthetase (GGPP synthetase) (GGPS) [Includes: Dimethylallyltranstransferase (EC 2.5.1.1); (2E,6E)-farnesyl diphosphate synthase (EC 2.5.1.10); Farnesyltranstransferase (EC 2.5.1.29)] +FIG00149312 Predicted transporter accosiated with cytochrome c biogenesis +FIG00149313 Predicted alpha-arabinosides ABC transport system, permease protein 1 +FIG00149320 Putative toxin component near putative ESAT-related proteins, repetitive / Repetitive hypothetical protein near ESAT cluster, SA0282 homolog +FIG00149325 Permease of the major facilitator superfamily in uncharacterized siderophore S biosynthesis operon +FIG00149332 Uncharacterized siderophore S biosynthesis AcsA-like protein @ Siderophore synthetase superfamily, group B +FIG00149335 LSU ribosomal protein L22p (L17e) / COG4933, hypothetical protein +FIG00149336 Transcriptional regulator, MerR family / putative protein phosphatase +FIG00149346 Nitrite reductase [NAD(P)H] large subunit (EC 1.7.1.4) / Nitrite reductase [NAD(P)H] small subunit (EC 1.7.1.4) +FIG00149347 Bacteriocin-like peptide N BlpN +FIG00149351 Protein PufX, involved in assembly of B875 and B800-850 pigment-protein complexes +FIG00149352 Chlorosome protein F +FIG00149356 Siderophore staphylobactin ABC transporter, substrate-binding protein SirA, putative @ ABC-type Fe3+-siderophore transport system, periplasmic iron-binding component +FIG00149359 Phosphonoalanine aminotransferase +FIG00149363 Replication initiation protein, topisomerase +FIG00149366 FIG060329: MOSC domain protein +FIG00149372 Circadian clock protein KaiC @ intein-containing +FIG00149375 [Ni/Fe] hydrogenase, group 1, large subunit; selenocysteine-containing +FIG00149376 Kappa-fimbriae probable subunit +FIG00149378 Glycerol dehydratase medium subunit (EC 4.2.1.30) +FIG00149381 transcriptional regulator, Fur family +FIG00149389 Siderophore staphylobactin ABC transporter, permease protein SirB, putative @ ABC-type Fe3+-siderophore transport system, permease component +FIG00149391 Cytochrome b6-f complex subunit, cytochrome b6, putative +FIG00149395 Glycerol dehydratase small subunit (EC 4.2.1.30) +FIG00149397 COG1399 protein in cluster with ribosomal protein L32p, putative divergent +FIG00149403 Transcriptional regulator, IclR family / Gluconolactonase family protein +FIG00149408 Clostridium cellulosome enzyme, dockerin type I precursor +FIG00149413 Siderophore staphylobactin ABC transporter, permease protein SirC, putative @ ABC-type Fe3+-siderophore transport system, permease 2 component +FIG00149415 Uncharacterized siderophore S biosynthesis protein, AcsD-like @ Siderophore synthetase superfamily, group A @ Siderophore synthetase large component, acetyltransferase +FIG00149419 Alternative L-arabinose isomerase (EC 5.3.1.4) +FIG00149425 Internalin-like protein (LPXTG motif) Lin0661 homolog +FIG00149427 Rhodanese-like protein ChrE +FIG00149429 Phosphonoalanine and phosphonopyruvate utilization regulatory protein, LysR family +FIG00149431 Particulate methane monooxygenase C-subunit (EC 1.14.13.25) +FIG00149435 Phosphonoalanine and/or phosphonopyruvate ABC transporter periplasmic binding component +FIG00149438 Solanesyl diphosphate synthase (EC 2.5.1.11) +FIG00149443 Nitrogenase vanadium-cofactor synthesis protein VnfX +FIG00149445 2,3-dihydro-2,3-dihydroxybenzoate dehydrogenase (EC 1.3.1.28) @ 2,3-dihydro-2,3-dihydroxybenzoate dehydrogenase (EC 1.3.1.28) of siderophore biosynthesis +FIG00149447 Probable Lysine n(6)-hydroxylase associated with siderophore S biosynthesis (EC 1.14.13.59) @ Siderophore biosynthesis protein, monooxygenase +FIG00149452 Cysteine desulfurase CsdA-CsdE (EC 2.8.1.7), main protein CsdA +FIG00149466 tRNA nucleotidyltransferase, archaeal type (EC 2.7.7.21) (EC 2.7.7.25) +FIG00149470 Iron-sulfur cluster assembly scaffold protein IscU/NifU-like +FIG00149471 Iron-sulfur cluster assembly scaffold protein IscU/NifU-like for SUF system, SufE3 +FIG00149486 Mannose-6-phosphate isomerase, class I (EC 5.3.1.8) +FIG00149492 Type IV pilus biogenesis protein PilO / Type IV pilus biogenesis protein PilP +FIG00149502 FIG002261: Cytochrome c family protein +FIG00149519 FIG143263: Glycosyl transferase +FIG00149539 Lysophospholipid acyltransferase +FIG00149566 Xanthine dehydrogenase iron-sulfur subunit (EC 1.17.1.4) +FIG00149569 probable iron binding protein from the HesB_IscA_SufA family in Nif operon +FIG00149573 Cysteine desulfurase CsdA-CsdE, sulfur acceptor protein CsdE +FIG00149576 FIG110192: hypothetical protein +FIG00149617 Cysteine desulfurase CsdA-CsdE (EC 2.8.1.7), main protein CsdA / Cysteine desulfurase CsdA-CsdE, sulfur acceptor protein CsdE +FIG00149618 CRISPR-associated protein APE2256 +FIG00149619 Lipopolysaccharide biosynthesis chain length determinant protein +FIG00149621 MutS domain protein, family 4 +FIG00149627 CRISPR repeat RNA endoribonuclease Cas6 +FIG00149628 Tricarboxylate porin OpdH +FIG00149629 Replicative DNA helicase (EC 3.6.1.-); intein-containing +FIG00149630 Decorin binding protein B +FIG00149631 Decorin binding protein A +FIG00149632 L-Cystine ABC transporter, ATP-binding protein TcyN +FIG00149635 FIG069887: hypothetical protein / Protein-N(5)-glutamine methyltransferase PrmC, methylates polypeptide chain release factors RF1 and RF2 +FIG00149636 FIG032225: Transcriptional regulator, LysR family +FIG00149639 MutS domain protein, family 6 +FIG00149640 hypothetical protein ssl1918 +FIG00149641 MutS domain protein, family 5 +FIG00149645 CRISPR-associated protein DxTHG +FIG00149646 Glycine-rich cell wall structural protein precursor +FIG00149647 CRISPR-associated RAMP, TM1809 family +FIG00149649 Type IV pilus biogenesis protein PilNx +FIG00149656 FIG137776: Glycosyltransferase +FIG00149657 L-Cystine ABC transporter, periplasmic cystine-binding protein TcyJ +FIG00149658 Glutamate racemase (EC 5.1.1.3) / Nucleoside 5-triphosphatase RdgB (dHAPTP, dITP, XTP-specific) (EC 3.6.1.15) +FIG00149662 Possible alpha-xyloside ABC transporter, ATP-binding component +FIG00149726 Predicted secretion system X protein GspD-like +FIG00149747 Predicted secretion system X transmembrane protein 2 +FIG00150184 Bacillosamine/Legionaminic acid biosynthesis aminotransferase PglE; 4-keto-6-deoxy-N-Acetyl-D-hexosaminyl-(Lipid carrier) aminotransferase +FIG00150395 FIG065221: Holliday junction DNA helicase +FIG00150396 Purine nucleotide synthesis repressor +FIG00150516 Conjugative transfer protein 234 +FIG00150519 Conjugative transfer protein TraI, relaxase +FIG00150526 Conjugative transfer protein TraV +FIG00151396 EpsI protein +FIG00151400 Eight transmembrane protein EpsH +FIG00152015 FIG123464: Polysaccharide export protein +FIG00152177 3-oxoacyl-[ACP] synthase III in alkane synthesis cluster +FIG00152217 Predicted secretion system W hypothetical protein +FIG00152540 Thioredoxin associated with NnrU/NnuR ortholog membrane enzyme +FIG00152541 Possible alpha/beta hydrolase superfamily, slr1916 homolog +FIG00153287 Bacteriocin-like peptide O BlpO +FIG00153566 Uncharacterized ATPase (AAA family) associated with cysteine desulfurase +FIG00153929 Duplicated ATPase component of energizing module of predicted pyridoxine-related ECF transporter +FIG00155155 Tryptophan-rich protein DUF2389, Ssr2843 homolog +FIG00156132 Substrate-specific component Cce_1529 of predicted ECF transporter +FIG00156201 Transmembrane component Cce_1531 of energizing module of predicted ECF transporter +FIG00158115 Geranylgeranyl hydrogenase BchP +FIG00159015 Gene Transfer Agent (GTA) ORFG12b +FIG00159080 COG3866 Pectate lyase +FIG00159273 Trehalose synthase, nucleoside diphosphate glucose dependent +FIG00160238 NADH-dependent butanol dehydrogenase B (EC 1.1.1.-) +FIG00160529 Hypothetical periplasmic glycoside hydrolase, family DUF1680 +FIG00160561 putative transcriptional regulator, inferred for PFA pathway +FIG00161025 Extracellular deoxyribonuclease PA3909 (required for catabolism of external DNA) +FIG00162144 General secretion pathway protein D / Type II secretion outermembrane pore forming protein (PulD) +FIG00162742 TRAP transporter solute receptor, unknown substrate 8 +FIG00162920 Membrane bound hydrogenase, NiFe-hydrogenase large subunit MbhL +FIG00162921 N1-specific pseudouridine methyltransferase NEP1, biosynthesis of m1acp3-psi in 18S/16S rRNA in Eukaryotes and Archaea +FIG00162922 Membrane bound hydrogenase, MbhH subunit +FIG00162929 Single-stranded exonuclease associated with Rad50/Mre11 complex +FIG00164345 PilT +FIG00165477 omega-3 polyunsaturated fatty acid synthase subunit, PfaB / omega-3 polyunsaturated fatty acid synthase subunit, PfaC +FIG00167295 General secretion pathway protein F +FIG00168558 Xylose oligosaccharides ABC transporter, permease protein 1 +FIG00168560 Beta-glucoside ABC transport system, permease protein 2 +FIG00168579 Regulator of chitobiose utilization ChiR, ROK family +FIG00168586 Regulator of pectin and galacturonate utilization, GntR family +FIG00168591 Hypothetical sugar ABC transporter, solute-binding protein UgtE +FIG00168605 Glycosyl transferase group 1 +FIG00168623 Xylan oligosaccharide ABC transporter, permease component 2 +FIG00168626 Predicted xylose oligosaccharide ABC transporter, substrate-binding component +FIG00168631 Predicted chitobiose ABC transport system, sugar-binding protein +FIG00168641 Regulator of trehalose utilization TreR, ROK family +FIG00168652 Hypothetical protein, DUF192 family +FIG00168669 Xylose oligosaccharides ABC transporter, permease protein 2 +FIG00168670 Cellobiose-responsive regulator of beta-glucosides utilization, ROK family +FIG00168676 Beta-glucoside ABC transport system, ATP-binding protein 2 +FIG00168677 Mannose-responsive regulator of mannose and mannoside utilization, ROK family +FIG00168680 Predicted regulator of glucose and trehalose utilization, ROK family +FIG00168699 Predicted cellobiose ABC transport system, permease protein 1 +FIG00168727 Cytoplasmic endo-1,4-beta-glucanase (EC 3.2.1.4) +FIG00168750 Uncharacterized protein COG3461 +FIG00168760 Beta-glucoside ABC transport system, ATP-binding protein 1 +FIG00168768 Predicted sugar catabolic transcriptional regulator UgtR, RpiR family +FIG00168790 Xylose oligosaccharides ABC transporter, ATP-binding protein 2 +FIG00168799 Predicted regulator of mannoside utilization, LacI family +FIG00168841 Laminarinase (EC 3.2.1.39) +FIG00168850 Xylan oligosaccharide ABC transporter, ATP-binding protein 2 +FIG00168851 Mannoside ABC transport system, permease protein 2 +FIG00168858 Xylose oligosaccharides ABC transporter, ATP-binding protein 1 +FIG00168885 Cellobiose phosphorylase (EC 2.4.1.-) +FIG00168906 Predicted trehalose ABC transporter, permease component 2, Archaea-type +FIG00168911 Hypothetical sugar ABC transporter, membrane protein UgtF +FIG00168912 Predicted trehalose ABC transporter, permease component 1, Archaea-type +FIG00169724 Duplicated ATPase component of energizing module of predicted B12-regulated ECF transporter for dimethylbenzimidazole +FIG00170660 FIG170660: TPR domain protein +FIG00171102 Predicted secretion system X DNA-binding regulator +FIG00171655 Phthalate 3,4-dioxygenase alpha subunit +FIG00172122 Phthalate dioxygenase ferredoxin subunit +FIG00172487 Protein of unknown function DUF81, type 2 +FIG00172705 putative type III secretion system EscC protein +FIG00173362 Mannoside ABC transport system, ATP-binding protein 1 +FIG00173621 Uncharacterized protein MJ0488 +FIG00175230 Molybdopterin binding domain MoeA-like +FIG00178742 prophage MuSo2, virion morphogenesis protein, putative +FIG00180798 Type I secretion system, membrane fusion protein LapC +FIG00181043 Pullulanase (EC 3.2.1.41) +FIG00181675 Lipoprotein VsaC +FIG00181748 Gamma-D-glutamyl-meso-diaminopimelate peptidase (EC 3.4.19.11) +FIG00181848 Spore coat protein V +FIG00181856 Sporulation thiol-disulfide oxidoreductase StoA precursor (Stage IV sporulation protein H) +FIG00181893 Spore coat protein A +FIG00182617 Predicted alpha-L-rhamnosidase +FIG00183535 Methylcrotonyl-CoA carboxylase biotin-containing subunit (EC 6.4.1.4) +FIG00183671 Molybdopterin-guanine dinucleotide biosynthesis protein MobA / Molybdopterin-guanine dinucleotide biosynthesis protein MobB +FIG00184167 Conjugative transfer protein TrbO +FIG00184482 Putative extracytoplasmic tricarboxylate-binding receptor of a tripartite transporter, in cluster with DUF1446 +FIG00185944 FIG136845: Rhodanese-related sulfurtransferase +FIG00186664 Predicted secretion system W protein GspE-like +FIG00186764 Uncharacterized protein MJ0119 +FIG00187466 Myo-inositol-1-phosphate ABC transporter, ATP-binding protein InoK +FIG00187475 Regulator of myo-inositol utilization IolR, ROK family +FIG00187477 Myo-inositol-1-phosphate ABC transporter, permease protein InoF +FIG00187485 Myo-inositol-1-phosphate ABC transporter, periplasmic sugar-binding protein InoE +FIG00187538 Myo-inositol-1-phosphate ABC transporter, permease protein InoG +FIG00188614 Gene Transfer Agent (GTA) ORFG10 / Gene Transfer Agent (GTA) ORFG10b +FIG00190890 General secretion pathway protein K / Type II secretion inner membrane protein (PulK) +FIG00191025 Gas vesicle protein GvpK +FIG00191048 Siderophore synthetase large component, acetyltransferase / Siderophore synthetase small component, acetyltransferase +FIG00192333 TRAP-type C4-dicarboxylate transport system, small permease component / Taurine transporter, small permease component +FIG00193265 tRNA and rRNA cytosine-C5-methylases +FIG00194074 Secreted cyanophycinase CphE (EC 3.4.15.6) +FIG00194159 Molybdopterin biosynthesis enzyme / CTP:molybdopterin cytidylyltransferase +FIG00194954 Molybdopterin-guanine dinucleotide biosynthesis protein MobB / Molybdopterin-guanine dinucleotide biosynthesis protein MobA +FIG00196963 Two-component sensor kinase, associated with ferric iron transporter, SPy1061 homolog +FIG00197164 Respiratory arsenate reductase cytoplasmic chaperone +FIG00197685 Putative uncharacterized protein ST0479 +FIG00199619 Transcriptional regulator of rhamnose utilization, GntR family +FIG00200342 NnrT family protein, required for expression of nitric oxide and nitrite reductases (Nir and Nor) +FIG00202338 Chloroflexi-specific hypothetical protein +FIG00206097 Type III secretion effector SseF +FIG00207095 Membrane fusion protein of RND family multidrug efflux pump +FIG00208126 UPF0047 protein Bsu YugU +FIG00208418 GTP-binding protein 1 +FIG00208483 Membrane protease family protein PAE0262 +FIG00208896 Conjugative transfer protein PSLT087 +FIG00209620 Conjugative transfer protein 345 +FIG00209992 D-xylose transport ATP-binding protein XylG +FIG00212443 COG1355, Predicted dioxygenase +FIG00214017 Gas vesicle protein GvpN +FIG00214151 Ubiquitin-like small archaeal modifier protein SAMP1 +FIG00214229 Gas vesicle protein GvpA +FIG00215339 ADP-ribose pyrophosphatase, mitochondrial precursor (EC 3.6.1.13) +FIG00216386 Nudix dNTPase DR0274 (EC 3.6.1.-) +FIG00217833 Predicted L-rhamnose mutarotase +FIG00218417 probable beta-D-galactosidase +FIG00219897 Uncharacterized protein MJ0548 +FIG00219919 Uncharacterized protein MJ0239 +FIG00219956 Uncharacterized protein MJ0235 +FIG00219957 Uncharacterized protein MJ0296 +FIG00219960 Small heat shock protein HSP16.5 +FIG00219962 Energy conserving hydrogenase Eha protein T +FIG00220003 Uncharacterized protein MJ0163 +FIG00220021 Uncharacterized protein MJ0114 +FIG00220099 Uncharacterized protein MJ0248 +FIG00220179 Uncharacterized protein MJ0241 +FIG00220238 Uncharacterized protein MJ0453 +FIG00220257 Uncharacterized protein MJ0452 +FIG00220262 Uncharacterized protein MJ0259 +FIG00221339 Phage endolysin +FIG00221470 Bactriocin immunity protein BlpX +FIG00221658 Alpha-arabinosides ABC transport system, substrate-binding protein +FIG00222222 Florfenicol/chloramphenicol resistance protein Cfr; LSU rRNA m2A2503-8-methyltransferase +FIG00222744 Export ABC transporter ATP-binding protein +FIG00224060 Phosphoribosylanthranilate isomerase (EC 5.3.1.24) / Tryptophan synthase beta chain (EC 4.2.1.20) +FIG00227694 Tetraacyldisaccharide 4'-kinase (EC 2.7.1.130) / hypothetical protein +FIG00229185 Phage capsid protein +FIG00229198 Cysteine desulfurase (EC 2.8.1.7), IscS subfamily +FIG00229199 Cysteine desulfurase (EC 2.8.1.7), SufS subfamily +FIG00229216 Diacylglycerol kinase (EC 2.7.1.107) +FIG00229219 Iron-sulfur cluster assembly scaffold protein IscU +FIG00229224 UDP-N-acetylglucosamine 2-epimerase (EC 5.1.3.14) 2 +FIG00229225 Hypothetical ATP-binding protein UPF0042, contains P-loop +FIG00229229 NAD(P)H-quinone oxidoreductase chain J (EC 1.6.5.2) +FIG00229232 Ornithine cyclodeaminase (EC 4.3.1.12) / Siderophore staphylobactin biosynthesis protein SbnB +FIG00229234 Trk system potassium uptake protein TrkG +FIG00229235 Glutaredoxin 3 (Grx3) +FIG00229236 Glutaredoxin 3 (Grx2) +FIG00229238 Glutaredoxin 3 (Grx1) +FIG00229240 Putative xylulose kinase (EC 2.7.1.17) +FIG00229241 L-xylulokinase (EC 2.7.1.53) @ 3-keto-L-gulonate kinase +FIG00229243 Phosphocarrier protein, nitrogen regulation associated +FIG00229244 Allophanate hydrolase 2 subunit 1 (EC 3.5.1.54) / Allophanate hydrolase 2 subunit 2 (EC 3.5.1.54) +FIG00229246 Allophanate hydrolase (EC 3.5.1.54) +FIG00229247 Urea carboxylase (EC 6.3.4.6) +FIG00229248 Tricarboxylate transport sensor protein TctE +FIG00229249 Signal transduction histidine kinase CitA regulating citrate metabolism +FIG00229252 Adenylate-forming enzyme +FIG00229257 Histidinol-phosphatase (EC 3.1.3.15) +FIG00229259 Type II secretory pathway, component PulF / Type IV fimbrial assembly protein PilC +FIG00229270 D-arabinitol 4-dehydrogenase (EC 1.1.1.11) +FIG00229272 Protein-export membrane protein SecD (TC 3.A.5.1.1) / Protein-export membrane protein SecF (TC 3.A.5.1.1) +FIG00229273 Alpha-glucosidase AglA +FIG00229276 FIG229276: Transcriptional regulator, AraC family +FIG00229278 Type II/IV secretion system secretin RcpA/CpaC, associated with Flp pilus assembly +FIG00229283 Probable RND efflux membrane fusion protein +FIG00229290 Acyl carrier protein (ACP1) +FIG00229294 General secretion pathway protein E / Type II secretion cytoplasmic ATP binding protein (PulE, ATPase) +FIG00229301 Membrane-bound lytic murein transglycosylase E (EC 3.2.1.-) +FIG00229302 Urea carboxylase (EC 6.3.4.6) without Allophanate hydrolase 2 domains +FIG00229303 Regulatory protein SoxS +FIG00229317 Peptidase M14, carboxypeptidase A +FIG00229318 probable FMN oxidoreductase +FIG00229321 FIG004655: Polysaccharide deacetylase +FIG00229322 Nitrate/TMAO reductases, membrane-bound tetraheme cytochrome c subunit +FIG00229323 FIG004851: hypothetical protein +FIG00229326 3-keto-L-gulonate-6-phosphate decarboxylase UlaD (EC 4.1.1.85) (L-ascorbate utilization protein D) +FIG00229328 Benzoate 1,2-dioxygenase (EC 1.14.12.10) +FIG00229329 Type IV fimbriae expression regulatory protein PilR +FIG00229332 Protein-tyrosine kinase (EC 2.7.1.112) +FIG00229333 Capsular polysaccharide synthesis enzyme CpsD, exopolysaccharide synthesis +FIG00229339 MSHA biogenesis protein MshK3 +FIG00229340 MSHA biogenesis protein MshK2 +FIG00229341 TctB citrate transporter +FIG00229345 Thermostable carboxypeptidase 1 (EC 3.4.17.19) +FIG00229346 TctA citrate transporter +FIG00229352 Predicted L-rhamnose ABC transporter, transmembrane component 2 +FIG00229357 Response regulator BaeR +FIG00229359 Predicted L-rhamnose ABC transporter, ATP-binding component +FIG00229360 Tagatose-6-phosphate kinase (EC 2.7.1.144) +FIG00229361 Response regulator CitB of citrate metabolism +FIG00229363 Rhodanese domain protein UPF0176, cyanobacterial/alphaproteobacterial subgroup +FIG00229366 Nitrate ABC transporter, ATP-binding protein +FIG00229367 Urea carboxylase-related ABC transporter, ATPase protein +FIG00229368 FIG022606: AAA ATPase +FIG00229372 FIGfam138462: Acyl-CoA synthetase, AMP-(fatty) acid ligase / (3R)-hydroxymyristoyl-[ACP] dehydratase (EC 4.2.1.-) +FIG00229373 PQS biosynthesis protein PqsA, anthranilate-CoA ligase (EC 6.2.1.32) +FIG00229379 Asparagine synthetase [glutamine-hydrolyzing] (EC 6.3.5.4) AsnB +FIG00229386 Glycerol-3-phosphate dehydrogenase (EC 1.1.5.3) +FIG00229387 Alpha-glycerophosphate oxidase (EC 1.1.3.21) +FIG00229393 Predicted regulator of methionine metabolism, ArsR family +FIG00229394 TctC citrate transporter +FIG00229397 GTP-binding protein +FIG00229400 FIG070318: hypothetical protein +FIG00229404 iron aquisition 2,3-dihydroxybenzoate-AMP ligase (EC 2.7.7.58,Irp5) +FIG00229405 General secretion pathway protein E / Type II secretory pathway, ATPase PulE/Tfp pilus assembly pathway, ATPase PilB +FIG00229407 Predicted secretion system W transmembrane protein 1 +FIG00229420 Predicted secretion system W protein GspD-like +FIG00229421 Predicted secretion system W protein PilO-like +FIG00229422 MSHA biogenesis protein MshG +FIG00229423 L-ribulose-5-phosphate 4-epimerase UlaF (EC 5.1.3.4) (L-ascorbate utilization protein F) +FIG00229424 Transcriptional regulator, LysR family, in glycolate utilization operon +FIG00229425 FIG022886: Transcriptional regulator, LysR family +FIG00229426 MSHA biogenesis protein MshF2 +FIG00229427 Predicted secretion system X protein GspF-like +FIG00229428 Predicted erythritol ABC transporter 2, substrate-binding component +FIG00229430 Bundle-forming pilus protein BfpK +FIG00229431 Predicted D-tagaturonate epimerase +FIG00229433 Predicted secretion system X protein GspG-like 2 +FIG00229434 HesA/MoeB/ThiF family protein, possibly E1-enzyme activating SAMPs for protein conjugation +FIG00229435 Predicted secretion system X protein GspG-like +FIG00229436 FIG003465: Conjugative transfer outer membrane protein +FIG00229440 General secretion pathway protein O +FIG00229441 General secretion pathway protein E / Type II secretory pathway, ATPase PulE +FIG00229442 Bundle-forming pilus lipoprotein BfpH +FIG00229443 Major structural subunit of bundle-forming pilus precursor Bundlin BfpA +FIG00229445 Predicted erythritol ABC transporter 1, substrate-binding component +FIG00229448 Conjugative transfer ATP binding protein +FIG00229449 Predicted erythritol ABC transporter 1, permease component 2 +FIG00229453 Predicted secretion system X protein GspG-like 3 +FIG00229461 Transcriptional regulator of rhamnose utilization, LysR family +FIG00229463 Partial urea carboxylase 2 (EC 6.3.4.6) +FIG00229481 Phosphoribosylamine--glycine ligase (EC 6.3.4.13) / Phosphoribosylaminoimidazole carboxylase catalytic subunit (EC 4.1.1.21) +FIG00229485 Hypothetical protein of L-Asparaginase type 2-like superfamily +FIG00229490 DNA topoisomerase III (EC 5.99.1.2) in PFGI-1-like cluster +FIG00229509 Rhamnulokinase RhaK in alpha-proteobacteria (EC 2.7.1.5) +FIG00229516 FIG003847: Oxidoreductase (flavoprotein) +FIG00229527 2-hydroxy-3-keto-5-methylthiopentenyl-1-phosphate phosphatase related protein +FIG00229528 Chromosome partitioning ATPase in PFGI-1-like cluster, ParA-like +FIG00229531 Inner membrane protein translocase component YidC, long form / Inner membrane protein translocase component YidC, short form OxaI-like +FIG00229539 F420-dependent sulfite reductase +FIG00229543 Conjugative transfer ATPase PilQ in PFGI-1-like cluster +FIG00229550 Phosphate starvation-inducible protein PhoH, predicted ATPase +FIG00229554 CoB--CoM-reducing hydrogenase (Cys) delta subunit +FIG00229555 Conjugative transfer protein PilL in PFGI-1-like cluster +FIG00229557 Conjugative transfer protein PilO in PFGI-1-like cluster +FIG00229560 Conjugative transfer protein PilN in PFGI-1-like cluster +FIG00229578 COG0398: uncharacterized membrane protein / PF00070 family, FAD-dependent NAD(P)-disulphide oxidoreductase +FIG00229583 Conjugative transfer pilus-tip adhesin protein PilV in PFGI-1-like cluster +FIG00229585 Cell division protein FtsI [Peptidoglycan synthetase] (EC 2.4.1.129) / Stage V sporulation protein D (Sporulation-specific penicillin-binding protein) +FIG00229594 Glutamyl-tRNA synthetase (EC 6.1.1.17) @ Glutamyl-tRNA(Gln) synthetase +FIG00229598 Aspartyl-tRNA synthetase (EC 6.1.1.12); Aspartyl-tRNA(Asn) synthetase (EC 6.1.1.23) +FIG00229604 Inner membrane protein translocase component YidC, OxaA protein +FIG00229605 Replicative DNA helicase (EC 3.6.1.-) in PFGI-1-like cluster +FIG00229606 Phosphopentomutase like (EC 5.4.2.7) +FIG00229608 Uncharacterized ferredoxin MJ0099 +FIG00229609 N5-methyltetrahydromethanopterin:coenzyme M methyltransferase subunit A (EC 2.1.1.86) / N5-methyltetrahydromethanopterin:coenzyme M methyltransferase subunit F (EC 2.1.1.86) +FIG00229610 Uncharacterized protein MJ0164 +FIG00229611 CoB--CoM-reducing hydrogenase (Sec) alpha' subunit @ selenocysteine-containing +FIG00229612 Anthranilate synthase, amidotransferase component (EC 4.1.3.27) @ Para-aminobenzoate synthase, amidotransferase component (EC 2.6.1.85) +FIG00229614 DNA/RNA helicase in PFGI-1-like cluster +FIG00229615 Glycine/sarcosine/betaine reductase protein A; selenocysteine-containing +FIG00229642 Cytosolic Fe-S cluster assembling factor NBP35 +FIG00229655 S-adenosyl-L-methionine dependent methyltransferase, similar to cyclopropane-fatty-acyl-phospholipid synthase +FIG00229667 Deoxyribodipyrimidine photolyase, single-strand-specific +FIG00229679 CoA-disulfide reductase (EC 1.8.1.14) / Polysulfide binding and transferase domain +FIG00229687 Taurine transporter substrate-binding protein +FIG00229692 Deoxyribodipyrimidine photolyase, type II (EC 4.1.99.3) +FIG00229695 Histidine triad (HIT) nucleotide-binding protein, similarity with At5g48545 and yeast YDL125C (HNT1) +FIG00229698 Methanophenazine hydrogenase maturation protease (EC 3.4.24.-) +FIG00229709 AsmA protein / A/G-specific adenine glycosylase (EC 3.2.2.-) +FIG00229720 Deoxyribodipyrimidine photolyase, type II (EC 4.1.99.3) / COG3380: Amine oxidase, flavin-containing +FIG00230177 putative Dnase +FIG00230350 Biotinyl-lipoyl attachment domain protein, GcvH-like +FIG00231261 Two-component response regulator, associated with ferric iron transporter, SPy1062 homolog +FIG00232269 Type III secretion system protein, YscF family +FIG00236134 DNA primase (EC 2.7.7.-), phage-associated / Replicative helicase RepA +FIG00237590 Phage NinF +FIG00237873 2-dehydro-3-deoxy-D-gluconate 5-dehydrogenase (EC 1.1.1.127) +FIG00238007 GTP pyrophosphokinase / guanosine-3',5'-bis(Diphosphate) 3'- pyrophosphohydrolase (EC 2.7.6.5) (EC 3.1.7.2) +FIG00238563 Peptide methionine sulfoxide reductase MsrA (EC 1.8.4.11) / Peptide methionine sulfoxide reductase msrB (EC 1.8.4.12) +FIG00238865 Glycosyltransferase (EC 2.4.1.-), group 1 family protein +FIG00239408 Molybdopterin-guanine dinucleotide biosynthesis protein MobB / Molybdopterin biosynthesis protein MoeA +FIG00239443 Phosphate regulon metal ion transporter containing CBS domains +FIG00239453 Molybdenum cofactor biosynthesis protein MoaC / Molybdopterin-guanine dinucleotide biosynthesis protein MobA +FIG00239460 Molybdenum transport system permease protein ModB (TC 3.A.1.8.1) / Molybdenum transport ATP-binding protein ModC (TC 3.A.1.8.1) +FIG00241620 Bundle-forming pilus protein BfpD +FIG00242670 Outer membrane lipoprotein BfpB +FIG00243304 Bundle-forming pilus protein BfpF +FIG00243703 IncI1 plasmid conjugative transfer protein TraK +FIG00244065 Bundle-forming pilus transmembrane protein BfpE +FIG00244482 UDP-glucose:(glucosyl)lipopolysaccharide alpha-1,2-glucosyltransferase (EC 2.4.1.58) +FIG00245036 chaperone FimC +FIG00245680 Phage NinH +FIG00245726 FIG107037: Phage late gene regulator +FIG00247463 Phage neck +FIG00247898 Zn-dependent hydroxyacylglutathione hydrolase / Polysulfide binding protein +FIG00248044 FIG002984: FAD-dependent pyridine nucleotide-disulphide oxidoreductase +FIG00254877 Protein VanZ +FIG00257341 Homocitrate synthase alpha subunit (EC 2.3.3.14) +FIG00257451 a forespore shell protein +FIG00275131 DNA primase TraC (EC 2.7.7.-) +FIG00277179 (GlcNAc)2 ABC transporter, periplasmic substrate-binding protein +FIG00282244 Phosphoglycerate mutase family 4 +FIG00284281 Thiamin ABC transporter, ATPase component +FIG00291945 FIG040338: Glycosyl transferase +FIG00292025 FIG146262: hypothetical protein +FIG00297514 Protein gp38 [Bacteriophage A118] +FIG00297862 Protein gp52 [Bacteriophage A118] +FIG00305178 Malonate decarboxylase beta subunit / Malonate decarboxylase gamma subunit +FIG00314685 LysR family transcriptional regulator YcjZ +FIG00315429 Phenylacetic acid degradation protein PaaE, ketothiolase +FIG00315648 Glutamate Aspartate transport ATP-binding protein GltL (TC 3.A.1.3.4) +FIG00315971 Putative 2-hydroxyacid dehydrogenase YcdW (EC 1.-.-.-) +FIG00316708 Phenylacetate degradation enoyl-CoA hydratase PaaB (EC 4.2.1.17) +FIG00325339 putative uricase +FIG00329170 Na(+)Citrate OH(-) antiporter +FIG00329555 LysR-family transcriptional regulator YeeY +FIG00329858 Uncharacterized protein YcdY, TorD family +FIG00331104 Fimbriae-like adhesin FimI +FIG00331276 Phage NinY +FIG00333746 Type III secretion injected virulence protein (YopO,YpkA,serine-threonine kinase) +FIG00337896 Ethanolamine utilization protein similar to PduA/PduJ +FIG00340098 Capsular polysaccharide synthesis enzyme CpsA, sugar transferase +FIG00340141 Possible colicin V production protein +FIG00340157 PTS system, mannitol-specific cryptic IIB component (EC 2.7.1.69) / PTS system, mannitol-specific cryptic IIC component (EC 2.7.1.69) +FIG00340163 Inosine/xanthosine triphosphatase (EC 3.6.1.-); Hypothetical cytoplasmic protein in cluster with NspS +FIG00340171 Lysine efflux permease +FIG00340177 Inorganic pyrophospatase PpaX +FIG00340218 Dimethylallyltransferase (EC 2.5.1.1); (2E,6E)-farnesyl diphosphate synthase (EC 2.5.1.10); Geranylgeranyl pyrophosphate synthetase (EC 2.5.1.29) +FIG00340229 Ferric vibriobactin, enterobactin transport system, substrate-binding protein ViuP (TC 3.A.1.14.6) +FIG00340251 5-FCL-like protein, but predicted not to be 5-formyltetrahydrofolate cyclo-ligase (5-FCL) +FIG00340261 2,3-dihydroxybenzoate-AMP ligase (EC 2.7.7.58) +FIG00340273 Petrobactin ABC transporter, periplasmic binding protein +FIG00340292 Duplicated ATPase component BL0693 of energizing module of predicted ECF transporter +FIG00340314 Phage DNA packaging +FIG00340315 Capsular polysaccharide synthesis enzyme Cap8D +FIG00340316 Ferrichrome ABC transporter (permease) PvuD +FIG00340318 Hydrogenase-4 component G +FIG00340320 Phage baseplate hub assembly chaperone (T4-like gp26) +FIG00340321 Penicillin-binding protein 2B +FIG00340323 FIG055075: Possibly a cell division protein, antigen 84 in Mycobacteria +FIG00340326 Phage baseplate protein +FIG00340331 Cell division protein FtsI [Peptidoglycan synthetase] (EC 2.4.1.129) / Stage V sporulation protein D (Sporulation-specific penicillin-binding protein) +FIG00340332 Nudix hydrolase family protein YffH +FIG00340333 FIG021292: hypothetical protein +FIG00340334 16 kDa heat shock protein B +FIG00340335 Ni,Fe-hydrogenase I large subunit +FIG00340337 Sensor histidine kinase ResE (EC 2.7.3.-) +FIG00340338 Isovaleryl-CoA dehydrogenase (EC 1.3.8.4); Acyl-CoA dehydrogenase, short-chain specific (EC 1.3.8.1) +FIG00340340 Phage baseplate wedge initiator +FIG00340341 peptidoglycan lytic protein P45 +FIG00340342 Phage collar / T7-like phage head-to-tail joining protein +FIG00340343 Phage tail fiber protein / T7-like tail tubular protein A +FIG00340345 Phage tail fiber protein / T7-like tail tubular protein B +FIG00340350 Anti-sigma F factor antagonist (spoIIAA-2); Anti-sigma B factor antagonist RsbV +FIG00340351 FemC, factor involved in methicillin resistance / Glutamine synthetase repressor +FIG00340352 Heavy metal-(Cd/Co/Hg/Pb/Zn)-translocating P-type ATPase:Heavy metal translocating P-type ATPase +FIG00340353 ADP-heptose--lipooligosaccharide heptosyltransferase, putative +FIG00340354 Predicted rhamnogalacturonide-specific TRAP-type transporter, small transmembrane component RhiB +FIG00340359 Germination-specific N-acetylmuramoyl-L-alanine amidase (EC 3.5.1.28), cell wall hydrolase CwlD +FIG00340362 membrane docking protein +FIG00340364 Phage baseplate wedge subunit (T4-like gp25) +FIG00340365 VirE2 involved in nuclear transport of T-DNA, single-strand DNA binding protein +FIG00340368 FIG020413: transmembrane protein +FIG00340369 Protein NinE +FIG00340377 Octaprenyl diphosphate synthase (EC 2.5.1.90); Dimethylallyltransferase (EC 2.5.1.1); (2E,6E)-farnesyl diphosphate synthase (EC 2.5.1.10); Geranylgeranyl pyrophosphate synthetase (EC 2.5.1.29) +FIG00340378 Iron(III)-binding periplasmic protein SfuA / Thiamin ABC transporter, substrate-binding component +FIG00340381 Putative purine permease YgfO +FIG00340383 Bacillosamine/Legionaminic acid biosynthesis N-acetyltrasferase PglD (PseH and NeuD homolog); 4-amino-6-deoxy-N-Acetyl-D-hexosaminyl-(Lipid carrier) acetyltrasferase +FIG00340385 tRNA(Ile)-lysidine synthetase (EC 6.3.4.19) / Hypoxanthine-guanine phosphoribosyltransferase (EC 2.4.2.8) +FIG00340386 Substrate-specific component PAM0308 of predicted lipoate ECF transporter +FIG00340387 Protein gp10 [Bacteriophage A118] +FIG00340389 Phage long tail fiber proximal subunit +FIG00340390 Galactose-regulated TonB-dependent outer membrane receptor +FIG00340397 Nudix dNTPase DR0261 (EC 3.6.1.-) +FIG00340399 L-aminoadipate-semialdehyde dehydrogenase large subunit (EC 1.2.1.31) +FIG00340405 Cyanobacteria-specific RpoD-like sigma factor, type-4 +FIG00340409 2-dehydropantoate 2-reductase (EC 1.1.1.169) / Rhodanese-related sulfurtransferase +FIG00340411 Putative tricarboxylic transport TctC +FIG00340415 putative CRISPR associated hypothetical protein +FIG00340416 Duplicated ATPase component YkoD of energizing module of thiamin-regulated ECF transporter for HydroxyMethylPyrimidine / Transmembrane component YkoC of energizing module of thiamin-regulated ECF transporter for HydroxyMethylPyrimidine +FIG00340419 Branched-chain amino acid transport ATP-binding protein LivG (TC 3.A.1.4.1) / Branched-chain amino acid transport ATP-binding protein LivF (TC 3.A.1.4.1) +FIG00340423 galactosamine-containing minor teichoic acid biosynthesis protein +FIG00340425 Transmembrane component of energizing module of predicted pantothenate ECF transporter +FIG00340426 Molybdenum cofactor biosynthesis protein MoaB / Molybdenum cofactor biosynthesis protein MoaE +FIG00340428 Transcriptional regulator, MerR family / Transcriptional regulator, TetR family +FIG00340429 Portal protein [Bacteriophage A118] +FIG00340433 Pyruvate synthase subunit porB (EC 1.2.7.1) +FIG00340434 Malonate transporter, MadM subunit / Transcriptional regulator, GntR family +FIG00340436 FIG001571: Hypothetical protein / S-adenosyl-L-methionine dependent methyltransferase, similar to cyclopropane-fatty-acyl-phospholipid synthase +FIG00340438 Translation elongation factor P @ Translation initiation factor 5A +FIG00340443 Phage EaD protein +FIG00340446 Proton/glutamate symport protein; Proton/aspartate symport protein +FIG00340452 IncQ plasmid conjugative transfer protein TraB +FIG00340453 MglB +FIG00340456 Secretion protein, HlyD family +FIG00340460 Phage EaC protein +FIG00340463 Lysine ketoglutarate reductase (EC 1.5.1.8) (LKR) / Saccharopine dehydrogenase (EC 1.5.1.9) +FIG00340466 tricarboxylate transport protein TctB, putative +FIG00340468 Voltage-gated potassium channel +FIG00340471 Ferrichrome transport ATP-binding protein FhuC (TC 3.A.1.14.3) @ Ferric hydroxamate ABC transporter (TC 3.A.1.14.3), ATP-binding protein FhuC +FIG00340827 Ribose ABC transport system, permease protein RbsC (TC 3.A.1.2.1) / Ribose ABC transporter, periplasmic ribose-binding protein RbsB (TC 3.A.1.2.1) +FIG00340847 Protein VirD5 in virD operon +FIG00340848 Imidazole glycerol phosphate synthase amidotransferase subunit (EC 2.4.2.-) / Imidazole glycerol phosphate synthase cyclase subunit (EC 4.1.3.-) +FIG00340849 Glutathione S-transferase, alpha (EC 2.5.1.18) +FIG00340850 Anthranilate synthase, amidotransferase component like (EC 4.1.3.27) / Para-aminobenzoate synthase, amidotransferase component (EC 2.6.1.85) +FIG00340853 Oxalyl-CoA decarboxylase (EC 4.1.1.8) +FIG00340854 Riboflavin kinase (EC 2.7.1.26) +FIG00340855 Ubiquinone biosynthesis enzyme COQ7 +FIG00340860 3-dehydroquinate synthase (EC 4.2.3.4) / Exopolyphosphatase (EC 3.6.1.11) +FIG00340861 Nopaline transporter ATP-binding protein NocP +FIG00340870 Galactocerebrosidase precursor (EC 3.2.1.46) +FIG00340871 Ubiquinol-cytochrome C reductase complex core protein I, mitochondrial precursor (EC 1.10.2.2) +FIG00340872 Glutathione S-transferase, phi (EC 2.5.1.18) +FIG00340873 Plant-inducible protein PinF1, cytochrome P450-like, contributes to virulence +FIG00340874 Two-component response regulator of vir regulon, VirG +FIG00340875 Oxytetracycline resistance protein OtrA +FIG00340876 Phosphoribosylaminoimidazole carboxylase ATPase subunit (EC 4.1.1.21) / Phosphoribosylaminoimidazole carboxylase catalytic subunit (EC 4.1.1.21) +FIG00340880 T-DNA border endonuclease, VirD1 +FIG00340881 Nopaline transporter periplasmic substrate-binding protein NocT +FIG00340883 LysR-type transcriptional regulator for nopaline catabolism NocR +FIG00340884 Two-component sensor kinase of vir regulon, VirA +FIG00340886 Glutamate-pyruvate aminotransferase (EC 2.6.1.2) +FIG00341164 Para-aminobenzoate synthase, aminase component (EC 2.6.1.85) +FIG00341289 Prephenate dehydratase (EC 4.2.1.51) +FIG00344322 Shikimate kinase I (EC 2.7.1.71) / 3-dehydroquinate synthase (EC 4.2.3.4) +FIG00346039 Tyrosyl-tRNA synthetase (EC 6.1.1.1) +FIG00346989 Pili retraction protein pilT +FIG00348725 Phosphoprotein phosphatase PppA +FIG00351520 Putative siderophore biosynthesis protein, related to 2-demethylmenaquinone methyltransferase +FIG00351742 Primosomal protein I +FIG00362834 Cytochrome c-type heme lyase subunit nrfF, nitrite reductase complex assembly +FIG00367528 Transcriptional regulator CtsR +FIG00368792 Arabinose sensor protein +FIG00369872 5'-nucleotidase (EC 3.1.3.5); 2',3'-cyclic-nucleotide 2'-phosphodiesterase (EC 3.1.4.16); Putative UDP-sugar hydrolase (EC 3.6.1.45) +FIG00378264 Photosystem II protein PsbJ +FIG00378368 Similar to non-heme chloroperoxidase +FIG00380575 Peptide methionine sulfoxide reductase MsrB (EC 1.8.4.12) +FIG00381187 Malate synthase (EC 2.3.3.9) / Isocitrate lyase (EC 4.1.3.1) +FIG00394362 DNA for glycosyltransferase, lytic transglycosylase, dTDP-4-rhamnose reductase +FIG00394443 Shikimate 5-dehydrogenase I alpha (EC 1.1.1.25) / Shikimate kinase I (EC 2.7.1.71) +FIG00402359 Pyoverdine biosynthesis related protein PvdP +FIG00403610 FIG032012: hypothetical protein +FIG00403940 Zn-ribbon-containing, possibly RNA-binding protein and truncated derivatives +FIG00404298 FIG036016: hypothetical protein +FIG00405640 COG5434 Endopygalactorunase +FIG00405688 Teichuronic acid biosynthesis protein TuaE, putative secreted polysaccharide polymerase +FIG00406857 Glycogen +FIG00410085 Cell division ZapA family protein +FIG00410305 FIG034863: hypothetical protein +FIG00416919 3,4-dihydroxy-2-butanone 4-phosphate synthase (EC 4.1.99.12) / Shikimate DH-like protein associated with RibB +FIG00423993 Transmembrane component of energizing module of predicted pyridoxine-related ECF transporter +FIG00424663 Duplicated ATPase component of energizing module of riboflavin ECF transporter / Transmembrane component of energizing module of riboflavin ECF transporter +FIG00425179 Indole-3-glycerol phosphate synthase (EC 4.1.1.48) / Tryptophan synthase beta chain (EC 4.2.1.20) +FIG00430439 FIG016940: Type III secretion protein +FIG00430996 DnaK suppressor protein, putative +FIG00431108 FIG00431113: hypothetical protein +FIG00431156 30S ribosomal protein S21 +FIG00431195 FIG00431200: hypothetical protein +FIG00431204 FIG00431205: hypothetical protein +FIG00431216 FIG00514008: hypothetical protein +FIG00431217 FIG00431220: hypothetical protein +FIG00431220 CsdL (EC-YgdL) protein of the HesA/MoeB/ThiF family, part of the CsdA-E-L sulfur transfer pathway +FIG00431317 FIG00985613: hypothetical protein +FIG00431319 FIG00431320: hypothetical protein +FIG00431330 FIG00431331: hypothetical protein +FIG00431349 Possible elongation subunit of DNA-dependent DNA polymerase +FIG00431356 sensor histidine kinase +FIG00431395 FIG00431398: hypothetical protein +FIG00431398 thioredoxin 1, redox factor +FIG00431409 FIG00431411: hypothetical protein +FIG00431416 FIG00431422: hypothetical protein +FIG00431422 Transcriptional regulatory protein, C terminal domain +FIG00431425 Lipoprotein YcfM, part of a salvage pathway of unknown substrate +FIG00431426 FIG00431428: hypothetical protein +FIG00431428 outer membrane protein OprC +FIG00431434 FIG00431435: hypothetical protein +FIG00431435 FIG00431444: hypothetical protein +FIG00431448 FIG00431450: hypothetical protein +FIG00431452 3-hydroxyisobutirate dehydrogenase +FIG00431453 FIG00431460: hypothetical protein +FIG00431462 FIG00431466: hypothetical protein +FIG00431466 FIG00431467: hypothetical protein +FIG00431467 ortholog of Bordetella pertussis (BX470248) BP2502 +FIG00431474 FIG00431479: hypothetical protein +FIG00431479 ortholog of Bordetella pertussis (BX470248) BP3721 no significant database matches +FIG00431482 putative substrate-binding protein +FIG00431485 FIG00431487: hypothetical protein +FIG00431487 FIG00431489: hypothetical protein +FIG00431489 FIG00431493: hypothetical protein +FIG00431513 FIG00431514: hypothetical protein +FIG00431514 FIG00431522: hypothetical protein +FIG00431522 ortholog of Bordetella pertussis (BX470248) BP1793 +FIG00431526 FIG00431529: hypothetical protein +FIG00431529 FIG00431530: hypothetical protein +FIG00431530 Uncharacterised conserved protein UCP012702 +FIG00431531 FIG00431532: hypothetical protein +FIG00431536 ortholog of Bordetella pertussis (BX470248) BP3409 +FIG00431541 rRNA methylases +FIG00431550 putative binding-protein-dependent transport protein +FIG00431557 FIG00431560: hypothetical protein +FIG00431562 FIG00431565: hypothetical protein +FIG00431565 FIG00431567: hypothetical protein +FIG00431571 FIG00431573: hypothetical protein +FIG00431575 FIG00431576: hypothetical protein +FIG00431576 putative ATP/GTP-binding protein +FIG00431577 FIG00431578: hypothetical protein +FIG00431583 ortholog of Bordetella pertussis (BX470248) BP3513 +FIG00431601 Probable proline rich signal peptide protein +FIG00431621 probable bifunctional hydroxylase/oxidoreductase +FIG00431622 FIG00431623: hypothetical protein +FIG00431627 putative integrase (Remnant) +FIG00431631 tRNA (uracil(54)-C5)-methyltransferase (EC 2.1.1.35) +FIG00431633 FIG00431634: hypothetical protein +FIG00431634 FIG00431635: hypothetical protein +FIG00431635 FIG00431636: hypothetical protein +FIG00431636 putative endonuclease/exonuclease/phosphatase family protein +FIG00431646 FIG00431648: hypothetical protein +FIG00431648 FIG00431650: hypothetical protein +FIG00431650 AcrB/AcrD/AcrF family protein +FIG00431655 FIG00431656: hypothetical protein +FIG00431664 FIG00431679: hypothetical protein +FIG00431679 ortholog of Bordetella pertussis (BX470248) BP2989 +FIG00431688 FIG00431690: hypothetical protein +FIG00431699 FIG00431700: hypothetical protein +FIG00431701 ortholog of Bordetella pertussis (BX470248) BP2887 +FIG00431704 ortholog of Bordetella pertussis (BX470248) BP3302 +FIG00431708 FIG00431716: hypothetical protein +FIG00431718 FIG00431721: hypothetical protein +FIG00431721 Outer membrane lipoprotein +FIG00431724 ortholog of Bordetella pertussis (BX470248) BP2020 +FIG00431730 FIG00431731: hypothetical protein +FIG00431741 FIG00431745: hypothetical protein +FIG00431746 FIG00431752: hypothetical protein +FIG00431753 FIG00431758: hypothetical protein +FIG00431760 ABC-type branched-chain amino acid transport systems, ATPase component +FIG00431769 MutT/nudix family protein +FIG00431772 two-component response regulatory protein +FIG00431776 FIG00431777: hypothetical protein +FIG00431777 FIG00431779: hypothetical protein +FIG00431779 Branched-chain amino acid transport protein AzlC +FIG00431782 putative glutaredoxin +FIG00431786 FIG00431792: hypothetical protein +FIG00431797 tRNA (5-methylaminomethyl-2-thiouridylate)-methyltransferase (EC 2.1.1.61) / FAD-dependent cmnm(5)s(2)U34 oxidoreductase +FIG00431804 FIG00431806: hypothetical protein +FIG00431806 putative ECF-family RNA polymerase sigma factor +FIG00431808 5'(3')-deoxyribonucleotidase +FIG00431809 FIG00431810: hypothetical protein +FIG00431812 FIG00431814: hypothetical protein +FIG00431814 ortholog of Bordetella pertussis (BX470248) BP2423 +FIG00431824 FIG00431825: hypothetical protein +FIG00431827 FIG00537018: hypothetical protein +FIG00431831 FIG00431833: hypothetical protein +FIG00431833 FIG00431834: hypothetical protein +FIG00431835 FIG00431837: hypothetical protein +FIG00431837 FIG00431846: hypothetical protein +FIG00431856 FIG00431858: hypothetical protein +FIG00431861 FIG00431863: hypothetical protein +FIG00431863 FIG00431865: hypothetical protein +FIG00431874 FIG00431876: hypothetical protein +FIG00431877 FIG00431878: hypothetical protein +FIG00431878 FIG00431880: hypothetical protein +FIG00431880 ortholog of Bordetella pertussis (BX470248) BP2374 +FIG00431885 FIG00431888: hypothetical protein +FIG00431888 FIG00431889: hypothetical protein +FIG00431899 response regulator protein +FIG00431901 ortholog of Bordetella pertussis (BX470248) BP2581 +FIG00431909 FIG00431917: hypothetical protein +FIG00431918 putative peptidase family M23/M37 protein +FIG00431924 FIG00431926: hypothetical protein +FIG00431926 FIG00431927: hypothetical protein +FIG00431929 FIG00431931: hypothetical protein +FIG00431940 FIG00431944: hypothetical protein +FIG00431944 FIG00431945: hypothetical protein +FIG00431945 FIG00431947: hypothetical protein +FIG00431947 putative ABC-transporter permease component +FIG00431956 FIG00431960: hypothetical protein +FIG00431966 ortholog of Bordetella pertussis (BX470248) BP2222 +FIG00431967 FIG00431968: hypothetical protein +FIG00431972 COGs COG2960 +FIG00431975 FIG00431976: hypothetical protein +FIG00431976 Zn-dependent hydrolases, including glyoxylases +FIG00431980 FIG00431981: hypothetical protein +FIG00431981 FIG00431984: hypothetical protein +FIG00431985 FIG00431995: hypothetical protein +FIG00431999 FIG00432000: hypothetical protein +FIG00432001 FIG00432002: hypothetical protein +FIG00432002 ortholog of Bordetella pertussis (BX470248) BP2567 +FIG00432003 FIG00432004: hypothetical protein +FIG00432004 Branched-chain amino acid transport ATP-binding protein LivG (TC 3.A.1.4.1) +FIG00432005 FIG00432006: hypothetical protein +FIG00432008 putative exported protein +FIG00432026 Dipeptide transport system, periplasmic component in protein degradation cluster +FIG00432030 FIG00432032: hypothetical protein +FIG00432032 FIG00432035: hypothetical protein +FIG00432035 FIG00432040: hypothetical protein +FIG00432049 FIG00432052: hypothetical protein +FIG00432057 Uncharacterized hydroxylase PA0655 +FIG00432062 Rhodanese-related sulfurtransferase +FIG00432063 FIG00432069: hypothetical protein +FIG00432073 FIG00432082: hypothetical protein +FIG00432084 FIG00432085: hypothetical protein +FIG00432087 putattive exported protein +FIG00432088 tRNA pseudouridine synthase A (EC 4.2.1.70) +FIG00432091 FIG00432092: hypothetical protein +FIG00432092 FIG00432097: hypothetical protein +FIG00432098 FIG00432102: hypothetical protein +FIG00432118 FIG00432120: hypothetical protein +FIG00432122 LEU/ILE/VAL-BINDING PROTEIN PRECURSOR +FIG00432125 FIG00432130: hypothetical protein +FIG00432138 ortholog of Bordetella pertussis (BX470248) BP1660 +FIG00432143 histidine triad protein +FIG00432148 FIG00432150: hypothetical protein +FIG00432151 Glycolate utilization operon transcriptional activator GlcC +FIG00432167 FIG00432169: hypothetical protein +FIG00432169 hypothetical protein +FIG00432174 FIG00432178: hypothetical protein +FIG00432178 FIG00432180: hypothetical protein +FIG00432183 probable type II secretion system protein +FIG00432189 FIG00432194: hypothetical protein +FIG00432194 Glutamate uptake regulatory protein +FIG00432196 FIG00432197: hypothetical protein +FIG00432197 Putative sulfatase (EC 3.1.6.-) +FIG00432199 FIG00432200: hypothetical protein +FIG00432200 FIG00432202: hypothetical protein +FIG00432202 FIG00432205: hypothetical protein +FIG00432205 FIG00432208: hypothetical protein +FIG00432214 serum resistance protein +FIG00432216 probable two-component sensor protein +FIG00432218 FIG00432220: hypothetical protein +FIG00432229 FIG00432230: hypothetical protein +FIG00432232 ortholog of Bordetella pertussis (BX470248) BP2315 +FIG00432233 cellobiose phosphotransferase system celC +FIG00432240 ortholog of Bordetella pertussis (BX470248) BP0546 +FIG00432241 ortholog of Bordetella pertussis (BX470248) BP3511 +FIG00432243 Putative cardiolipin synthase YmdC +FIG00432248 FIG00432251: hypothetical protein +FIG00432253 exported protein +FIG00432261 FIG00432263: hypothetical protein +FIG00432272 ortholog of Bordetella pertussis (BX470248) BP3723 no significant database matches +FIG00432274 Quinone oxidoreductase (EC 1.6.5.5) +FIG00432284 ortholog of Bordetella pertussis (BX470248) BP2560 +FIG00432290 ortholog of Bordetella pertussis (BX470248) BP2496 +FIG00432305 putative fimbrial adhesin +FIG00432308 FIG00432320: hypothetical protein +FIG00432320 FIG00432323: hypothetical protein +FIG00432331 FIG00432333: hypothetical protein +FIG00432334 FIG00432336: hypothetical protein +FIG00432344 FIG00432347: hypothetical protein +FIG00432349 ortholog of Bordetella pertussis (BX470248) BP2792 +FIG00432350 bacterial extracellular solute-binding protein +FIG00432360 Oligopeptide ABC transporter, periplasmic oligopeptide-binding protein OppA (TC 3.A.1.5.1) +FIG00432365 ortholog of Bordetella pertussis (BX470248) BP1767 +FIG00432369 FIG00432371: hypothetical protein +FIG00432379 FIG00432381: hypothetical protein +FIG00432381 FIG00432384: hypothetical protein +FIG00432384 FIG00432385: hypothetical protein +FIG00432395 FIG00432396: hypothetical protein +FIG00432396 FIG00432405: hypothetical protein +FIG00432405 Almost identical to Bordetella bronchiseptica hypothetical protein Bblps1.11 SWALL:O87984 (EMBL:AJ007747) (866 aa) fasta scores: E(): 0, 99.65% id in 866 aa +FIG00432407 FIG00432408: hypothetical protein +FIG00432422 putative branched-chain amino acid binding protein +FIG00432423 ortholog of Bordetella pertussis (BX470248) BP3290 +FIG00432437 ortholog of Bordetella pertussis (BX470248) BP2827 +FIG00432446 FIG00432447: hypothetical protein +FIG00432449 FIG00432453: hypothetical protein +FIG00432453 ortholog of Bordetella pertussis (BX470248) BP3221 +FIG00432454 FIG00432457: hypothetical protein +FIG00432464 low-specificity D-threonine aldolase +FIG00432465 FIG00432467: hypothetical protein +FIG00432469 Domain of unknown function DUF1537 +FIG00432488 FIG00432491: hypothetical protein +FIG00432491 FIG00432495: hypothetical protein +FIG00432511 FIG00432516: hypothetical protein +FIG00432521 ortholog of Bordetella pertussis (BX470248) BP2469 +FIG00432525 FIG00432528: hypothetical protein +FIG00432541 FIG00432543: hypothetical protein +FIG00432559 FIG00432563: hypothetical protein +FIG00432563 Membrane protein TerC, possibly involved in tellurium resistance +FIG00432575 Short chain dehydrogenase (EC 1.1.1.35) +FIG00432583 putative enoyl-CoA hydratase/isomerase +FIG00432596 FIG00432598: hypothetical protein +FIG00432610 ortholog of Bordetella pertussis (BX470248) BP1540 +FIG00432620 Putative dioxygenase +FIG00432626 ortholog of Bordetella pertussis (BX470248) BP3235 +FIG00432633 FIG00432642: hypothetical protein +FIG00432642 probable Binding-protein-dependent transport system, permease protein +FIG00432646 FIG00432650: hypothetical protein +FIG00432650 FIG00432654: hypothetical protein +FIG00432654 FIG00432658: hypothetical protein +FIG00432659 FIG00432660: hypothetical protein +FIG00432660 FIG00432661: hypothetical protein +FIG00432668 FIG00432671: hypothetical protein +FIG00432671 Azurin +FIG00432678 FIG00432679: hypothetical protein +FIG00432686 FIG00432695: hypothetical protein +FIG00432713 FIG00432715: hypothetical protein +FIG00432715 FIG00432717: hypothetical protein +FIG00432717 FIG00432718: hypothetical protein +FIG00432719 FIG00432723: hypothetical protein +FIG00432723 FIG00432724: hypothetical protein +FIG00432731 FIG00432733: hypothetical protein +FIG00432733 FIG00432735: hypothetical protein +FIG00432757 FIG00432758: hypothetical protein +FIG00432762 FIG00432765: hypothetical protein +FIG00432765 FIG00432770: hypothetical protein +FIG00432772 FIG00432773: hypothetical protein +FIG00432775 FIG00432778: hypothetical protein +FIG00432778 FIG00432781: hypothetical protein +FIG00432791 FIG00432792: hypothetical protein +FIG00432804 FIG00432807: hypothetical protein +FIG00432807 FIG00432809: hypothetical protein +FIG00432814 FIG00432821: hypothetical protein +FIG00432822 probable aldehyde dehydrogenase +FIG00432825 FIG00432826: hypothetical protein +FIG00432826 FIG00432827: hypothetical protein +FIG00432840 FIG00432847: hypothetical protein +FIG00432847 FIG00432851: hypothetical protein +FIG00432851 FIG00432855: hypothetical protein +FIG00432858 FIG00432864: hypothetical protein +FIG00432876 FIG00432878: hypothetical protein +FIG00432878 FIG00432882: hypothetical protein +FIG00432884 FIG00432887: hypothetical protein +FIG00432888 FIG00432898: hypothetical protein +FIG00432906 ortholog of Bordetella pertussis (BX470248) BP3098 +FIG00432922 FIG00432923: hypothetical protein +FIG00432923 FIG00432926: hypothetical protein +FIG00432933 branched-chain amino acid-binding protein +FIG00432936 FIG00432937: hypothetical protein +FIG00432937 FIG00432938: hypothetical protein +FIG00432954 putative argininosuccinate lyase +FIG00432956 ortholog of Bordetella pertussis (BX470248) BP0066 +FIG00432976 GMP synthase (EC 6.3.5.2) +FIG00432994 FIG00432997: hypothetical protein +FIG00432997 FIG00433002: hypothetical protein +FIG00433013 Uncharacterized protein PA2301 +FIG00433027 FIG00433030: hypothetical protein +FIG00433039 FIG00433045: hypothetical protein +FIG00433045 FIG00433046: hypothetical protein +FIG00433048 Inner membrane protein YihY, formerly thought to be RNase BN +FIG00433058 FIG00433063: hypothetical protein +FIG00433079 FIG00433089: hypothetical protein +FIG00433101 FIG00433107: hypothetical protein +FIG00433107 FIG00433111: hypothetical protein +FIG00433116 FIG00433117: hypothetical protein +FIG00433118 FIG00433120: hypothetical protein +FIG00433128 FIG00433129: hypothetical protein +FIG00433140 FIG00433142: hypothetical protein +FIG00433170 FIG00433176: hypothetical protein +FIG00433176 FIG00433180: hypothetical protein +FIG00433180 FIG00433184: hypothetical protein +FIG00433184 FIG00433189: hypothetical protein +FIG00433193 ortholog of Bordetella pertussis (BX470248) BP3509 +FIG00433194 Flp pilus assembly protein, ATPase CpaE +FIG00433202 Glutamate--UDP-2-acetamido-2-deoxy-D-ribohex-3-uluronic acid aminotransferase (PLP cofactor) +FIG00433208 hypothetical 20.3 kDa protein +FIG00433214 LysE-family efflux protein +FIG00433221 FIG00433229: hypothetical protein +FIG00433229 FIG00433232: hypothetical protein +FIG00433232 FIG00433234: hypothetical protein +FIG00433234 FIG00433236: hypothetical protein +FIG00433236 FIG00433241: hypothetical protein +FIG00433244 FIG00433250: hypothetical protein +FIG00433253 Prophage P4 integrase +FIG00433263 Phage terminase small subunit +FIG00433264 FIG00433271: hypothetical protein +FIG00433274 tRNA (5-methylaminomethyl-2-thiouridylate)-methyltransferase (EC 2.1.1.61) / FAD-dependent cmnm(5)s(2)U34 oxidoreductase +FIG00433286 FIG00433290: hypothetical protein +FIG00433311 MmgE/PrpD family protein +FIG00433333 FIG00433334: hypothetical protein +FIG00433347 FIG00433352: hypothetical protein +FIG00433360 FIG00433363: hypothetical protein +FIG00433366 FIG00433367: hypothetical protein +FIG00433377 FIG00433382: hypothetical protein +FIG00433382 ortholog of Bordetella pertussis (BX470248) BP1407 +FIG00433389 FIG00433392: hypothetical protein +FIG00433392 FIG00433395: hypothetical protein +FIG00433451 FIG00433453: hypothetical protein +FIG00433453 FIG00433455: hypothetical protein +FIG00433469 ortholog of Bordetella pertussis (BX470248) BP3512 +FIG00433472 FIG00433484: hypothetical protein +FIG00433484 putative capsular polysaccharide biosynthesis protein +FIG00433516 ortholog of Bordetella pertussis (BX470248) BP3508 +FIG00433524 putative outer membrane ligand binding protein +FIG00433547 FIG00433549: hypothetical protein +FIG00433566 ortholog of Bordetella pertussis (BX470248) BP1341 +FIG00433570 FIG00433574: hypothetical protein +FIG00433599 FIG00433600: hypothetical protein +FIG00433632 FIG00433639: hypothetical protein +FIG00433643 FIG00433649: hypothetical protein +FIG00433649 putative ABC transpoter permease protein +FIG00433660 TRAP dicarboxylate transporter, DctM subunit, unknown substrate 7 +FIG00433663 FIG00433665: hypothetical protein +FIG00433672 FIG00433673: hypothetical protein +FIG00433678 FIG00433679: hypothetical protein +FIG00433680 ortholog of Bordetella pertussis (BX470248) BP2907 +FIG00433711 FIG00433714: hypothetical protein +FIG00433801 FIG00433802: hypothetical protein +FIG00433811 FIG00433818: hypothetical protein +FIG00433856 FIG00433859: hypothetical protein +FIG00433887 ABC-type taurine transport system, periplasmic component +FIG00433902 FIG00433907: hypothetical protein +FIG00433907 Peptidase, M50 family +FIG00433912 FIG00433914: hypothetical protein +FIG00433926 FIG01064544: hypothetical protein +FIG00433929 FIG00433932: hypothetical protein +FIG00433937 FIG00433940: hypothetical protein +FIG00433940 FIG00433945: hypothetical protein +FIG00433947 FIG00433951: hypothetical protein +FIG00433955 FIG00433965: hypothetical protein +FIG00433980 FIG00433981: hypothetical protein +FIG00433992 Phage DNA repair protein +FIG00434024 Type II and III secretion system protein precursor +FIG00434095 MaoC-like dehydratase +FIG00434102 FIG00434103: hypothetical protein +FIG00434103 FIG00434104: hypothetical protein +FIG00434104 ortholog to Borrelia burgdorferi BB0554 +FIG00434105 FIG00434107: hypothetical protein +FIG00434107 FIG00434108: hypothetical protein +FIG00434108 FIG00434109: hypothetical protein +FIG00434109 Variable large protein 12 precursor +FIG00434110 FIG00434111: hypothetical protein +FIG00434111 FIG00434112: hypothetical protein +FIG00434114 FIG00434115: hypothetical protein +FIG00434115 FIG00434116: hypothetical protein +FIG00434116 FIG00434117: hypothetical protein +FIG00434117 FIG00434118: hypothetical protein +FIG00434118 FIG00434119: hypothetical protein +FIG00434119 FIG00434120: hypothetical protein +FIG00434120 FIG00434121: hypothetical protein +FIG00434121 FIG00434122: hypothetical protein +FIG00434122 FIG00434123: hypothetical protein +FIG00434123 FIG00434124: hypothetical protein +FIG00434124 FIG00434125: hypothetical protein +FIG00434125 FIG00434126: hypothetical protein +FIG00434126 FIG00434127: hypothetical protein +FIG00434127 FIG00434128: hypothetical protein +FIG00434128 FIG00434129: hypothetical protein +FIG00434129 FIG00434131: hypothetical protein +FIG00434131 FIG00434133: hypothetical protein +FIG00434133 FIG00434134: hypothetical protein +FIG00434134 FIG00434135: hypothetical protein +FIG00434135 FIG00434136: hypothetical protein +FIG00434136 FIG00434138: hypothetical protein +FIG00434138 FIG00434140: hypothetical protein +FIG00434140 FIG00434142: hypothetical protein +FIG00434142 FIG00434143: hypothetical protein +FIG00434144 FIG00434147: hypothetical protein +FIG00434147 FIG00434148: hypothetical protein +FIG00434148 FIG00434149: hypothetical protein +FIG00434149 FIG00434150: hypothetical protein +FIG00434150 FIG00434151: hypothetical protein +FIG00434151 FIG00434153: hypothetical protein +FIG00434153 FIG00434155: hypothetical protein +FIG00434155 FIG00434157: hypothetical protein +FIG00434157 ortholog to Borrelia burgdorferi BB0592 +FIG00434158 FIG00434159: hypothetical protein +FIG00434159 B. burgdorferi predicted coding region BBA40 +FIG00434160 FIG00434161: hypothetical protein +FIG00434161 FIG00434162: hypothetical protein +FIG00434162 FIG00434163: hypothetical protein +FIG00434163 FIG00434164: hypothetical protein +FIG00434165 FIG00434166: hypothetical protein +FIG00434166 ortholog to Borrelia burgdorferi BB0032 +FIG00434168 FIG00434171: hypothetical protein +FIG00434171 FIG00434172: hypothetical protein +FIG00434172 FIG00434173: hypothetical protein +FIG00434173 FIG00434175: hypothetical protein +FIG00434175 outer surface protein D +FIG00434177 FIG00435340: hypothetical protein +FIG00434179 FIG00434180: hypothetical protein +FIG00434181 FIG00434182: hypothetical protein +FIG00434182 FIG00434183: hypothetical protein +FIG00434183 aminopeptidase II +FIG00434184 FIG00434185: hypothetical protein +FIG00434185 FIG00434186: hypothetical protein +FIG00434186 FIG00434187: hypothetical protein +FIG00434187 FIG00434188: hypothetical protein +FIG00434188 FIG00434190: hypothetical protein +FIG00434190 FIG00434192: hypothetical protein +FIG00434192 FIG00434193: hypothetical protein +FIG00434195 FIG00434196: hypothetical protein +FIG00434196 FIG00434197: hypothetical protein +FIG00434197 FIG00434198: hypothetical protein +FIG00434198 FIG00434200: hypothetical protein +FIG00434200 FIG00434201: hypothetical protein +FIG00434201 FIG00434203: hypothetical protein +FIG00434203 FIG00434207: hypothetical protein +FIG00434207 ortholog to Borrelia burgdorferi BB0353 +FIG00434208 FIG00434209: hypothetical protein +FIG00434209 FIG00434210: hypothetical protein +FIG00434210 FIG00434211: hypothetical protein +FIG00434211 FIG00434212: hypothetical protein +FIG00434212 FIG00434213: hypothetical protein +FIG00434213 FIG00434214: hypothetical protein +FIG00434214 FIG00434215: hypothetical protein +FIG00434215 FIG00434216: hypothetical protein +FIG00434216 FIG00434218: hypothetical protein +FIG00434218 FIG00434219: hypothetical protein +FIG00434219 FIG00434220: hypothetical protein +FIG00434220 B. burgdorferi predicted coding region BB0813 +FIG00434221 FIG00434223: hypothetical protein +FIG00434223 FIG00434224: hypothetical protein +FIG00434224 FIG00434225: hypothetical protein +FIG00434225 FIG00434226: hypothetical protein +FIG00434226 FIG00434228: hypothetical protein +FIG00434228 B. burgdorferi predicted coding region BBI16 +FIG00434229 FIG00434230: hypothetical protein +FIG00434230 FIG00434231: hypothetical protein +FIG00434231 FIG00434232: hypothetical protein +FIG00434232 FIG00434233: hypothetical protein +FIG00434233 FIG00434234: hypothetical protein +FIG00434234 B. burgdorferi predicted coding region BB0011 +FIG00434236 CdsE +FIG00434237 FIG00434238: hypothetical protein +FIG00434242 FIG00434243: hypothetical protein +FIG00434243 FIG00434244: hypothetical protein +FIG00434244 B. burgdorferi predicted coding region BB0751 +FIG00434246 FIG00434247: hypothetical protein +FIG00434247 FIG00434250: hypothetical protein +FIG00434251 FIG00434252: hypothetical protein +FIG00434252 FIG00434253: hypothetical protein +FIG00434253 FIG00434254: hypothetical protein +FIG00434254 FIG00434255: hypothetical protein +FIG00434255 FIG00434256: hypothetical protein +FIG00434256 ortholog to Borrelia burgdorferi BB0400 +FIG00434257 P115 protein +FIG00434261 FIG00434263: hypothetical protein +FIG00434263 FIG00434264: hypothetical protein +FIG00434264 FIG00434265: hypothetical protein +FIG00434265 FIG00434266: hypothetical protein +FIG00434266 FIG00434268: hypothetical protein +FIG00434268 FIG00434269: hypothetical protein +FIG00434269 B. burgdorferi predicted coding region BBJ21 +FIG00434270 FIG00434271: hypothetical protein +FIG00434273 FIG00434274: hypothetical protein +FIG00434274 FIG00434275: hypothetical protein +FIG00434276 FIG00434277: hypothetical protein +FIG00434277 FIG00434278: hypothetical protein +FIG00434278 FIG00434279: hypothetical protein +FIG00434279 ATP-dependent Clp protease, subunit A +FIG00434280 FIG00434282: hypothetical protein +FIG00434282 FIG00434283: hypothetical protein +FIG00434283 ortholog to Borrelia burgdorferi BB0538 +FIG00434286 FIG00434288: hypothetical protein +FIG00434288 FIG00434289: hypothetical protein +FIG00434290 FIG00434291: hypothetical protein +FIG00434291 ortholog to Borrelia burgdorferi BB0606 +FIG00434292 FIG00434293: hypothetical protein +FIG00434293 FIG00434294: hypothetical protein +FIG00434294 FIG00434296: hypothetical protein +FIG00434296 FIG00434297: hypothetical protein +FIG00434297 FIG00434298: hypothetical protein +FIG00434299 FIG00434300: hypothetical protein +FIG00434300 FIG00434301: hypothetical protein +FIG00434302 FIG00434305: hypothetical protein +FIG00434305 FIG00434306: hypothetical protein +FIG00434306 FIG00434307: hypothetical protein +FIG00434308 FIG00434309: hypothetical protein +FIG00434309 FIG00434311: hypothetical protein +FIG00434313 FIG00434314: hypothetical protein +FIG00434314 FIG00434315: hypothetical protein +FIG00434315 FIG00434317: hypothetical protein +FIG00434319 FIG00434320: hypothetical protein +FIG00434320 FIG00434322: hypothetical protein +FIG00434324 FIG00434325: hypothetical protein +FIG00434326 FIG00434327: hypothetical protein +FIG00434327 FIG00434328: hypothetical protein +FIG00434328 FIG00434331: hypothetical protein +FIG00434331 FIG00434333: hypothetical protein +FIG00434333 FIG00434335: hypothetical protein +FIG00434335 FIG00434336: hypothetical protein +FIG00434336 FIG00434337: hypothetical protein +FIG00434337 FIG00434339: hypothetical protein +FIG00434343 FIG00434344: hypothetical protein +FIG00434344 ortholog to Borrelia burgdorferi BB0308 +FIG00434345 FIG00434346: hypothetical protein +FIG00434346 FIG00434347: hypothetical protein +FIG00434347 FIG00434349: hypothetical protein +FIG00434351 FIG00434352: hypothetical protein +FIG00434352 FIG00434353: hypothetical protein +FIG00434353 FIG028593: membrane protein +FIG00434358 dnaK suppressor +FIG00434359 CdsD +FIG00434360 FIG00434361: hypothetical protein +FIG00434361 FIG00434364: hypothetical protein +FIG00434364 FIG00434368: hypothetical protein +FIG00434368 ortholog to Borrelia burgdorferi BB0255 +FIG00434371 B. burgdorferi predicted coding region BBA28 +FIG00434372 ortholog to Borrelia burgdorferi BB0839 +FIG00434375 FIG00434378: hypothetical protein +FIG00434378 ATP-dependent Clp protease, subunit C (clpC) +FIG00434379 FIG00434410: hypothetical protein +FIG00434381 FIG00434382: hypothetical protein +FIG00434382 ortholog to Borrelia burgdorferi BB0584 +FIG00434383 FIG00434384: hypothetical protein +FIG00434384 FIG00434385: hypothetical protein +FIG00434385 FIG00434386: hypothetical protein +FIG00434386 FIG00434387: hypothetical protein +FIG00434387 FIG00434388: hypothetical protein +FIG00434390 FIG00434391: hypothetical protein +FIG00434391 FIG00434392: hypothetical protein +FIG00434392 FIG00434393: hypothetical protein +FIG00434395 FIG00434396: hypothetical protein +FIG00434396 FIG00434398: hypothetical protein +FIG00434398 FIG00434399: hypothetical protein +FIG00434399 FIG00434400: hypothetical protein +FIG00434403 FIG00434404: hypothetical protein +FIG00434404 FIG00434406: hypothetical protein +FIG00434406 FIG00434408: hypothetical protein +FIG00434408 FIG00434409: hypothetical protein +FIG00434413 FIG00434414: hypothetical protein +FIG00434414 FIG00434415: hypothetical protein +FIG00434415 B. burgdorferi predicted coding region BB0530 +FIG00434416 FIG00434418: hypothetical protein +FIG00434419 ortholog to Borrelia burgdorferi BB0806 +FIG00434420 FIG00434421: hypothetical protein +FIG00434421 virulence factor mviN protein (mviN) (SP:P37169) +FIG00434422 FIG00434423: hypothetical protein +FIG00434423 FIG00434424: hypothetical protein +FIG00434424 PTS system, glucose-specific IIBC component (EC 2.7.1.69) +FIG00434427 FIG00434428: hypothetical protein +FIG00434429 FIG00434430: hypothetical protein +FIG00434430 FIG00434432: hypothetical protein +FIG00434432 FIG00434433: hypothetical protein +FIG00434433 B. burgdorferi predicted coding region BBA47 +FIG00434435 FIG00434436: hypothetical protein +FIG00434436 FIG00434437: hypothetical protein +FIG00434441 FIG00434442: hypothetical protein +FIG00434443 FIG00434444: hypothetical protein +FIG00434446 FIG00434447: hypothetical protein +FIG00434447 FIG00434449: hypothetical protein +FIG00434449 B. burgdorferi predicted coding region BB0212 +FIG00434450 FIG00434451: hypothetical protein +FIG00434451 FIG00434452: hypothetical protein +FIG00434452 FIG00434453: hypothetical protein +FIG00434453 FIG00434454: hypothetical protein +FIG00434454 FIG00434455: hypothetical protein +FIG00434455 FIG00434457: hypothetical protein +FIG00434457 FIG00434460: hypothetical protein +FIG00434460 FIG00434462: hypothetical protein +FIG00434462 FIG00434463: hypothetical protein +FIG00434463 FIG00434464: hypothetical protein +FIG00434465 FIG00434466: hypothetical protein +FIG00434466 FIG00434468: hypothetical protein +FIG00434468 FIG00434470: hypothetical protein +FIG00434470 FIG00434472: hypothetical protein +FIG00434472 FIG00434473: hypothetical protein +FIG00434473 FIG00434477: hypothetical protein +FIG00434477 FIG00434478: hypothetical protein +FIG00434478 FIG00434479: hypothetical protein +FIG00434479 FIG00434480: hypothetical protein +FIG00434480 FIG00434481: hypothetical protein +FIG00434481 FIG00434482: hypothetical protein +FIG00434482 FIG00434485: hypothetical protein +FIG00434485 FIG00434486: hypothetical protein +FIG00434486 basic membrane protein C (bmpC) +FIG00434488 FIG00434489: hypothetical protein +FIG00434489 FIG00434491: hypothetical protein +FIG00434491 FIG00434492: hypothetical protein +FIG00434492 acriflavine resistance protein +FIG00434494 FIG00434496: hypothetical protein +FIG00434496 FIG00434497: hypothetical protein +FIG00434497 FIG00434498: hypothetical protein +FIG00434498 B. burgdorferi predicted coding region BB0187 +FIG00434499 FIG00434500: hypothetical protein +FIG00434500 B. burgdorferi predicted coding region BB0075 +FIG00434501 FIG00434502: hypothetical protein +FIG00434502 FIG00434503: hypothetical protein +FIG00434503 FIG00434504: hypothetical protein +FIG00434504 FIG00434505: hypothetical protein +FIG00434506 FIG00434507: hypothetical protein +FIG00434510 FIG00434511: hypothetical protein +FIG00434514 ortholog to Borrelia burgdorferi BB0352 +FIG00434515 plasmid partition protein, putative +FIG00434516 FIG00434517: hypothetical protein +FIG00434517 B. burgdorferi predicted coding region BB0733 +FIG00434518 phosphoglucomutase (femD) +FIG00434520 FIG00434521: hypothetical protein +FIG00434521 FIG00434523: hypothetical protein +FIG00434523 FIG00434525: hypothetical protein +FIG00434525 FIG00434526: hypothetical protein +FIG00434526 FIG00434528: hypothetical protein +FIG00434528 FIG00434529: hypothetical protein +FIG00434529 FIG00434532: hypothetical protein +FIG00434532 FIG00434533: hypothetical protein +FIG00434533 FIG00434535: hypothetical protein +FIG00434535 FIG00434537: hypothetical protein +FIG00434537 FIG00434538: hypothetical protein +FIG00434538 FIG00434539: hypothetical protein +FIG00434539 FIG00434540: hypothetical protein +FIG00434540 FIG00434541: hypothetical protein +FIG00434542 FIG00434543: hypothetical protein +FIG00434543 FIG00434544: hypothetical protein +FIG00434545 B. burgdorferi predicted coding region BB0749 +FIG00434546 FIG00434548: hypothetical protein +FIG00434548 holin, BlyA family +FIG00434550 FIG00434553: hypothetical protein +FIG00434553 FIG00434557: hypothetical protein +FIG00434557 FIG00434558: hypothetical protein +FIG00434559 ortholog to Borrelia burgdorferi BB0816 +FIG00434561 FIG00434564: hypothetical protein +FIG00434564 FIG00434826: hypothetical protein +FIG00434565 ortholog to Borrelia burgdorferi BB0267 +FIG00434566 FIG00434679: hypothetical protein +FIG00434569 FIG00434570: hypothetical protein +FIG00434570 FIG00434571: hypothetical protein +FIG00434571 FIG00434572: hypothetical protein +FIG00434574 ortholog to Borrelia burgdorferi BB0309 +FIG00434575 FIG00434576: hypothetical protein +FIG00434576 FIG00434577: hypothetical protein +FIG00434578 FIG00434579: hypothetical protein +FIG00434579 aspartyl-tRNA synthetase( EC:6.1.1.12 ) +FIG00434580 FIG00434581: hypothetical protein +FIG00434581 FIG00434582: hypothetical protein +FIG00434582 FIG00434583: hypothetical protein +FIG00434583 ortholog to Borrelia burgdorferi BB0624 +FIG00434584 FIG00434586: hypothetical protein +FIG00434586 FIG00434587: hypothetical protein +FIG00434588 FIG00434589: hypothetical protein +FIG00434589 FIG00434590: hypothetical protein +FIG00434593 ortholog to Borrelia burgdorferi BB0336 +FIG00434594 FIG00434596: hypothetical protein +FIG00434599 outer surface protein, putative +FIG00434601 FIG00434602: hypothetical protein +FIG00434602 FIG00434604: hypothetical protein +FIG00434604 FIG00434605: hypothetical protein +FIG00434605 FIG00434607: hypothetical protein +FIG00434608 FIG00434609: hypothetical protein +FIG00434610 FIG00434611: hypothetical protein +FIG00434611 immunogenic protein P37 +FIG00434614 FIG00434615: hypothetical protein +FIG00434615 FIG00434616: hypothetical protein +FIG00434621 FIG00434622: hypothetical protein +FIG00434622 FIG00434624: hypothetical protein +FIG00434624 FIG00434626: hypothetical protein +FIG00434626 FIG00434628: hypothetical protein +FIG00434628 FIG00434630: hypothetical protein +FIG00434630 FIG00434631: hypothetical protein +FIG00434631 FIG00434632: hypothetical protein +FIG00434632 FIG00434634: hypothetical protein +FIG00434635 FIG00434636: hypothetical protein +FIG00434636 FIG00434637: hypothetical protein +FIG00434637 B. burgdorferi predicted coding region BB0077 +FIG00434638 FIG00434639: hypothetical protein +FIG00434639 FIG00434640: hypothetical protein +FIG00434640 FIG00434641: hypothetical protein +FIG00434642 FIG00434643: hypothetical protein +FIG00434644 FIG00434646: hypothetical protein +FIG00434647 FIG00434649: hypothetical protein +FIG00434651 FIG00434653: hypothetical protein +FIG00434653 FIG00434654: hypothetical protein +FIG00434654 FIG00434656: hypothetical protein +FIG00434659 FIG00434660: hypothetical protein +FIG00434662 FIG00434665: hypothetical protein +FIG00434669 FIG00434670: hypothetical protein +FIG00434672 FIG00434675: hypothetical protein +FIG00434676 FIG00434677: hypothetical protein +FIG00434677 FIG00434678: hypothetical protein +FIG00434679 FIG00434680: hypothetical protein +FIG00434680 FIG00434682: hypothetical protein +FIG00434687 FIG00434688: hypothetical protein +FIG00434688 FIG00434691: hypothetical protein +FIG00434691 FIG00434692: hypothetical protein +FIG00434692 FIG00434694: hypothetical protein +FIG00434696 FIG00434697: hypothetical protein +FIG00434700 FIG00434708: hypothetical protein +FIG00434708 FIG00434709: hypothetical protein +FIG00434709 FIG00434713: hypothetical protein +FIG00434713 FIG00434716: hypothetical protein +FIG00434716 FIG00434717: hypothetical protein +FIG00434718 FIG00434719: hypothetical protein +FIG00434720 FIG00434721: hypothetical protein +FIG00434725 FIG00434727: hypothetical protein +FIG00434727 FIG00434729: hypothetical protein +FIG00434729 FIG00434730: hypothetical protein +FIG00434730 FIG00434733: hypothetical protein +FIG00434738 FIG00434739: hypothetical protein +FIG00434743 FIG00434745: hypothetical protein +FIG00434745 FIG00434746: hypothetical protein +FIG00434747 FIG00434749: hypothetical protein +FIG00434749 FIG00434751: hypothetical protein +FIG00434757 FIG00434759: hypothetical protein +FIG00434764 FIG00434765: hypothetical protein +FIG00434765 FIG00434766: hypothetical protein +FIG00434766 FIG00434768: hypothetical protein +FIG00434771 FIG00434772: hypothetical protein +FIG00434773 FIG00434777: hypothetical protein +FIG00434777 FIG00434779: hypothetical protein +FIG00434783 FIG00434785: hypothetical protein +FIG00434785 FIG00434787: hypothetical protein +FIG00434787 FIG00434788: hypothetical protein +FIG00434789 hypothetical protein +FIG00434795 FIG00434796: hypothetical protein +FIG00434796 B. burgdorferi predicted coding region BBJ28 +FIG00434806 FIG00434808: hypothetical protein +FIG00434808 FIG00434810: hypothetical protein +FIG00434810 FIG00434811: hypothetical protein +FIG00434811 FIG00434813: hypothetical protein +FIG00434813 FIG00434814: hypothetical protein +FIG00434814 FIG00434817: hypothetical protein +FIG00434817 FIG00434818: hypothetical protein +FIG00434822 FIG00434824: hypothetical protein +FIG00434831 FIG00434832: hypothetical protein +FIG00434834 FIG00434835: hypothetical protein +FIG00434835 FIG00434836: hypothetical protein +FIG00434836 FIG00434837: hypothetical protein +FIG00434837 FIG00434838: hypothetical protein +FIG00434838 ORF18/36 kDa +FIG00434842 FIG00434845: hypothetical protein +FIG00434848 FIG00434849: hypothetical protein +FIG00434850 FIG00434852: hypothetical protein +FIG00434858 FIG00434859: hypothetical protein +FIG00434859 FIG00434860: hypothetical protein +FIG00434860 FIG00434861: hypothetical protein +FIG00434872 FIG00434873: hypothetical protein +FIG00434873 FIG00434874: hypothetical protein +FIG00434874 FIG00434875: hypothetical protein +FIG00434878 FIG00434880: hypothetical protein +FIG00434880 FIG00434881: hypothetical protein +FIG00434883 FIG00434884: hypothetical protein +FIG00434884 FIG00434885: hypothetical protein +FIG00434896 FIG00434897: hypothetical protein +FIG00434901 ORF17/2.9-9 lipoprotein +FIG00434904 FIG00434905: hypothetical protein +FIG00434906 FIG00434908: hypothetical protein +FIG00434909 FIG00434910: hypothetical protein +FIG00434911 FIG00434915: hypothetical protein +FIG00434915 FIG00434917: hypothetical protein +FIG00434917 FIG00434918: hypothetical protein +FIG00434919 OspE-related lipoprotein +FIG00434925 FIG00434926: hypothetical protein +FIG00434926 rev protein +FIG00434927 FIG00434928: hypothetical protein +FIG00434928 FIG00434931: hypothetical protein +FIG00434933 FIG00434934: hypothetical protein +FIG00434934 FIG00434935: hypothetical protein +FIG00434940 FIG00434943: hypothetical protein +FIG00434943 FIG00434944: hypothetical protein +FIG00434945 FIG00434946: hypothetical protein +FIG00434947 FIG00434951: hypothetical protein +FIG00434953 FIG00434955: hypothetical protein +FIG00434955 FIG00434957: hypothetical protein +FIG00434957 FIG00434960: hypothetical protein +FIG00434961 FIG00434962: hypothetical protein +FIG00434967 FIG00434969: hypothetical protein +FIG00434969 FIG00434971: hypothetical protein +FIG00434979 FIG00434981: hypothetical protein +FIG00434982 FIG00434983: hypothetical protein +FIG00434983 FIG00434987: hypothetical protein +FIG00434987 FIG00434989: hypothetical protein +FIG00434994 FIG00434995: hypothetical protein +FIG00434998 FIG00435000: hypothetical protein +FIG00435000 FIG00435001: hypothetical protein +FIG00435003 FIG00435008: hypothetical protein +FIG00435008 FIG01291708: hypothetical protein +FIG00435017 FIG00435018: hypothetical protein +FIG00435028 FIG00435031: hypothetical protein +FIG00435031 BBK01-like protein +FIG00435032 FIG00435036: hypothetical protein +FIG00435037 FIG00435045: hypothetical protein +FIG00435045 FIG00435046: hypothetical protein +FIG00435046 FIG00435051: hypothetical protein +FIG00435051 FIG00435052: hypothetical protein +FIG00435054 FIG00435055: hypothetical protein +FIG00435057 FIG00435063: hypothetical protein +FIG00435067 FIG00435068: hypothetical protein +FIG00435072 FIG00435075: hypothetical protein +FIG00435075 FIG00435078: hypothetical protein +FIG00435078 B. burgdorferi predicted coding region BBF30 +FIG00435082 FIG00435084: hypothetical protein +FIG00435084 FIG00435085: hypothetical protein +FIG00435085 FIG00435086: hypothetical protein +FIG00435086 FIG00435088: hypothetical protein +FIG00435089 FIG00435090: hypothetical protein +FIG00435091 FIG00435095: hypothetical protein +FIG00435098 FIG00435100: hypothetical protein +FIG00435104 FIG00435107: hypothetical protein +FIG00435107 FIG00435108: hypothetical protein +FIG00435111 FIG00435114: hypothetical protein +FIG00435120 FIG00435121: hypothetical protein +FIG00435124 FIG00435125: hypothetical protein +FIG00435125 FIG00435126: hypothetical protein +FIG00435134 FIG00435135: hypothetical protein +FIG00435146 hypothetical protein +FIG00435151 FIG00435153: hypothetical protein +FIG00435161 FIG00435162: hypothetical protein +FIG00435164 FIG00435165: hypothetical protein +FIG00435166 FIG00435169: hypothetical protein +FIG00435169 FIG00435174: hypothetical protein +FIG00435174 FIG00435176: hypothetical protein +FIG00435177 FIG00435178: hypothetical protein +FIG00435178 erpB2 protein +FIG00435179 FIG00435181: hypothetical protein +FIG00435185 FIG00435186: hypothetical protein +FIG00435200 FIG00435201: hypothetical protein +FIG00435212 FIG00435213: hypothetical protein +FIG00435213 FIG00435215: hypothetical protein +FIG00435219 FIG00435220: hypothetical protein +FIG00435222 FIG00435224: hypothetical protein +FIG00435224 FIG00435226: hypothetical protein +FIG00435235 FIG00435240: hypothetical protein +FIG00435240 FIG00435242: hypothetical protein +FIG00435244 FIG00435245: hypothetical protein +FIG00435268 FIG00435270: hypothetical protein +FIG00435280 FIG00435282: hypothetical protein +FIG00435283 FIG00435288: hypothetical protein +FIG00435294 FIG00435299: hypothetical protein +FIG00435301 CdsC +FIG00435319 FIG00435321: hypothetical protein +FIG00435331 FIG00435332: hypothetical protein +FIG00435334 FIG00435337: hypothetical protein +FIG00435338 FIG00435339: hypothetical protein +FIG00435378 putative sugar ABC transporter, ATPase component +FIG00435540 putative integral membrane transport protein +FIG00435567 probable sugar ABC transporter, permease protein +FIG00435633 ABC peptide transporter, ATP-binding component +FIG00435673 FIG00435687: hypothetical protein +FIG00435755 ABC transporter, transmembrane region (EC 3.6.3.27) +FIG00435857 Glucose/mannose:H+ symporter GlcP +FIG00435892 probable glutatione regulated potassium efflux transport protein +FIG00436052 Phytanoyl-CoA dioxygenase, peroxisomal precursor (EC 1.14.11.18) +FIG00436066 beta-lactamase +FIG00436112 putative ABC-type sugar transport system, permease component +FIG00436113 FIG00436128: hypothetical protein +FIG00436346 protein of unknown function DUF58 +FIG00436356 Biotin-protein ligase (EC 6.3.4.15) +FIG00436361 FIG00436364: hypothetical protein +FIG00436364 NADH-dependent dehydrogenase +FIG00436510 Mg(2+) transport ATPase protein C +FIG00436719 oleandomycin resistance ATPase +FIG00436805 COG0566: rRNA methylases +FIG00436822 FIG00436826: hypothetical protein +FIG00437208 FIG00437212: hypothetical protein +FIG00437283 FIG00437291: hypothetical protein +FIG00437298 FIG00437299: hypothetical protein +FIG00437299 FIG00437301: hypothetical protein +FIG00437301 FIG00437304: hypothetical protein +FIG00437304 carotenoid isomerase, putative +FIG00437307 FIG00437309: hypothetical protein +FIG00437309 FIG00437311: hypothetical protein +FIG00437313 Hypothetical radical SAM family enzyme in heat shock gene cluster, similarity with CPO of BS HemN-type +FIG00437317 FIG00437318: hypothetical protein +FIG00437318 FIG00437319: hypothetical protein +FIG00437321 Hvp 53 +FIG00437326 Flagellar hook protein FlgE +FIG00437327 FIG00437331: hypothetical protein +FIG00437331 FIG00437332: hypothetical protein +FIG00437332 FIG00437335: hypothetical protein +FIG00437335 FIG00437337: hypothetical protein +FIG00437337 FIG00437338: hypothetical protein +FIG00437338 FIG00437342: hypothetical protein +FIG00437342 FIG00437343: hypothetical protein +FIG00437344 FIG00437346: hypothetical protein +FIG00437349 FIG00437350: hypothetical protein +FIG00437350 FIG00437351: hypothetical protein +FIG00437351 [FeFe]-hydrogenase maturation protein HydE +FIG00437354 FIG00437356: hypothetical protein +FIG00437356 FIG00437357: hypothetical protein +FIG00437357 FIG00437359: hypothetical protein +FIG00437359 FIG00437362: hypothetical protein +FIG00437362 FIG00437369: hypothetical protein +FIG00437369 FIG00437371: hypothetical protein +FIG00437374 FIG00437375: hypothetical protein +FIG00437375 FIG00437376: hypothetical protein +FIG00437376 FIG00437380: hypothetical protein +FIG00437385 FIG00437386: hypothetical protein +FIG00437386 FIG00437388: hypothetical protein +FIG00437391 FIG00437393: hypothetical protein +FIG00437393 multimeric flavodoxin WrbA fused to cytochrome c-like domain +FIG00437394 FIG00437400: hypothetical protein +FIG00437400 FIG00437402: hypothetical protein +FIG00437416 FIG00437419: hypothetical protein +FIG00437420 FIG00437422: hypothetical protein +FIG00437422 FIG00437430: hypothetical protein +FIG00437430 FIG00437434: hypothetical protein +FIG00437434 FIG00437435: hypothetical protein +FIG00437435 FIG00437437: hypothetical protein +FIG00437440 FIG00437444: hypothetical protein +FIG00437444 FIG00437446: hypothetical protein +FIG00437451 FIG00437452: hypothetical protein +FIG00437452 FIG00437453: hypothetical protein +FIG00437455 Methylase involved in ubiquinone/menaquinone biosynthesis-like +FIG00437456 FIG00437457: hypothetical protein +FIG00437457 FIG00437458: hypothetical protein +FIG00437458 FIG00437459: hypothetical protein +FIG00437459 FIG00437460: hypothetical protein +FIG00437463 FIG00437466: hypothetical protein +FIG00437466 FIG00437467: hypothetical protein +FIG00437468 FIG00437470: hypothetical protein +FIG00437470 FIG00437474: hypothetical protein +FIG00437474 FIG00437481: hypothetical protein +FIG00437481 FIG00437484: hypothetical protein +FIG00437484 FIG00437485: hypothetical protein +FIG00437485 conserved hypothetical protein 374 +FIG00437486 FIG00437487: hypothetical protein +FIG00437492 FIG00437493: hypothetical protein +FIG00437498 FIG00437501: hypothetical protein +FIG00437503 FIG00437505: hypothetical protein +FIG00437505 D amino acid oxidase (DAO) family (EC 1.4.3.3) +FIG00437506 FIG00437507: hypothetical protein +FIG00437507 FIG00437511: hypothetical protein +FIG00437511 FIG00437512: hypothetical protein +FIG00437512 FIG00437518: hypothetical protein +FIG00437518 FIG00437525: hypothetical protein +FIG00437526 flagellar biosynthetic protein FlhF, putative +FIG00437530 FIG00437531: hypothetical protein +FIG00437531 FIG00437532: hypothetical protein +FIG00437534 FIG00437536: hypothetical protein +FIG00437536 FIG00437537: hypothetical protein +FIG00437537 serpulina hyodysenteriae variable surface /protein_id= +FIG00437540 FIG00437542: hypothetical protein +FIG00437542 FIG00437547: hypothetical protein +FIG00437547 FIG00437551: hypothetical protein +FIG00437551 methyltransferase small +FIG00437552 FIG00437555: hypothetical protein +FIG00437555 FIG00437557: hypothetical protein +FIG00437557 FIG00437558: hypothetical protein +FIG00437563 VSH-1 associated protein 2 +FIG00437571 FIG00437577: hypothetical protein +FIG00437577 FIG00437578: hypothetical protein +FIG00437578 FIG00437581: hypothetical protein +FIG00437581 FIG00437587: hypothetical protein +FIG00437588 FIG00437592: hypothetical protein +FIG00437592 FIG00437594: hypothetical protein +FIG00437600 Protein of unknown function UPF0074 +FIG00437603 flavin reductase-like, FMN-binding +FIG00437609 FIG00437611: hypothetical protein +FIG00437611 FIG00437612: hypothetical protein +FIG00437615 FIG00437621: hypothetical protein +FIG00437621 FIG00437624: hypothetical protein +FIG00437624 Protein of unknown function DUF152 +FIG00437625 FIG00437626: hypothetical protein +FIG00437626 FIG00437628: hypothetical protein +FIG00437628 FIG00437631: hypothetical protein +FIG00437631 FIG00437632: hypothetical protein +FIG00437632 FIG00437638: hypothetical protein +FIG00437638 FIG00437642: hypothetical protein +FIG00437642 FIG00437643: hypothetical protein +FIG00437644 Streptolysin S export transmembrane permease (SagI) +FIG00437647 FIG00437648: hypothetical protein +FIG00437649 FIG00437654: hypothetical protein +FIG00437657 FIG00437658: hypothetical protein +FIG00437658 FIG00437659: hypothetical protein +FIG00437659 FIG00437661: hypothetical protein +FIG00437665 FIG00437668: hypothetical protein +FIG00437668 ATPase component ABC-type multidrug transport system +FIG00437669 FIG00437672: hypothetical protein +FIG00437672 Cell division protein FtsJ / Ribosomal RNA large subunit methyltransferase E (EC 2.1.1.-) +FIG00437674 FIG00437681: hypothetical protein +FIG00437689 FIG00437690: hypothetical protein +FIG00437690 FIG00437691: hypothetical protein +FIG00437691 FIG00437697: hypothetical protein +FIG00437697 FIG00437700: hypothetical protein +FIG00437700 possible phosphoesterase +FIG00437701 FIG00437702: hypothetical protein +FIG00437702 FIG00437706: hypothetical protein +FIG00437706 FIG00437707: hypothetical protein +FIG00437707 FIG00437709: hypothetical protein +FIG00437709 Outer membrane protein H precursor +FIG00437715 FIG00437716: hypothetical protein +FIG00437717 FIG00437720: hypothetical protein +FIG00437720 FIG00437722: hypothetical protein +FIG00437723 FIG00437724: hypothetical protein +FIG00437724 FIG00437728: hypothetical protein +FIG00437728 FIG00437729: hypothetical protein +FIG00437730 FIG00437731: hypothetical protein +FIG00437732 FIG00437733: hypothetical protein +FIG00437733 FIG00437737: hypothetical protein +FIG00437739 FIG00437740: hypothetical protein +FIG00437741 FIG00437742: hypothetical protein +FIG00437742 FIG00437743: hypothetical protein +FIG00437743 FIG00437746: hypothetical protein +FIG00437746 FIG00437752: hypothetical protein +FIG00437752 FIG00437756: hypothetical protein +FIG00437756 FIG00437758: hypothetical protein +FIG00437758 FIG00437759: hypothetical protein +FIG00437759 FIG00437760: hypothetical protein +FIG00437760 FIG00437761: hypothetical protein +FIG00437761 Branched-chain amino acid transport +FIG00437766 FIG00437768: hypothetical protein +FIG00437768 FIG00437770: hypothetical protein +FIG00437770 FIG00437771: hypothetical protein +FIG00437771 FIG00437774: hypothetical protein +FIG00437774 FIG00437775: hypothetical protein +FIG00437775 FIG00437780: hypothetical protein +FIG00437780 FIG00437790: hypothetical protein +FIG00437790 FIG00437791: hypothetical protein +FIG00437799 FIG00437800: hypothetical protein +FIG00437800 Mg/Co/Ni transporter MgtE / CBS domain +FIG00437802 FIG00437803: hypothetical protein +FIG00437803 FIG00437806: hypothetical protein +FIG00437806 Nucleoside ABC transporter, permease protein 1 +FIG00437812 FIG00437816: hypothetical protein +FIG00437820 FIG00437822: hypothetical protein +FIG00437822 FIG00437824: hypothetical protein +FIG00437824 FIG00437825: hypothetical protein +FIG00437827 FIG00437830: hypothetical protein +FIG00437830 FIG00437833: hypothetical protein +FIG00437833 FIG00437834: hypothetical protein +FIG00437834 FIG00437836: hypothetical protein +FIG00437836 FIG00437837: hypothetical protein +FIG00437837 FIG00437840: hypothetical protein +FIG00437845 methyl-accepting chemotaxis sensory transducer with Pas/Pac sensor +FIG00437848 FIG00437849: hypothetical protein +FIG00437854 FIG00437855: hypothetical protein +FIG00437865 FIG00437875: hypothetical protein +FIG00437878 FIG00437880: hypothetical protein +FIG00437880 FIG00437881: hypothetical protein +FIG00437884 FIG00437886: hypothetical protein +FIG00437888 FIG00437889: hypothetical protein +FIG00437895 FIG00437896: hypothetical protein +FIG00437896 FIG00437899: hypothetical protein +FIG00437899 FIG00437901: hypothetical protein +FIG00437902 FIG00437907: hypothetical protein +FIG00437909 Accessory protein YqeC in selenium-dependent molybdenum hydroxylase maturation / CTP:molybdopterin cytidylyltransferase +FIG00437912 FIG00437913: hypothetical protein +FIG00437913 FIG00437918: hypothetical protein +FIG00437918 FIG00437920: hypothetical protein +FIG00437920 FIG00437926: hypothetical protein +FIG00437926 FIG00437929: hypothetical protein +FIG00437929 FIG00437932: hypothetical protein +FIG00437937 FIG028593: membrane protein +FIG00437941 FIG00437947: hypothetical protein +FIG00437949 FIG00437950: hypothetical protein +FIG00437950 FIG00437951: hypothetical protein +FIG00437972 FIG00437975: hypothetical protein +FIG00437975 FIG00437981: hypothetical protein +FIG00437983 Putative phopsphoesterase or exonuclease +FIG00437984 FIG00437986: hypothetical protein +FIG00437986 FIG00437988: hypothetical protein +FIG00437988 FIG00437989: hypothetical protein +FIG00437993 FIG00437994: hypothetical protein +FIG00437994 FIG00437995: hypothetical protein +FIG00437995 FIG00437999: hypothetical protein +FIG00437999 FIG00438003: hypothetical protein +FIG00438004 FIG00438006: hypothetical protein +FIG00438008 Sporulation protein and related proteins-like +FIG00438011 FIG00438013: hypothetical protein +FIG00438013 FIG00438018: hypothetical protein +FIG00438022 FIG00438023: hypothetical protein +FIG00438023 FIG00438025: hypothetical protein +FIG00438025 Glutathione peroxidase (EC 1.11.1.9) @ selenocysteine-containing +FIG00438027 FIG00438030: hypothetical protein +FIG00438031 FIG00438034: hypothetical protein +FIG00438034 FIG00438041: hypothetical protein +FIG00438041 FIG00438042: hypothetical protein +FIG00438043 FIG00438044: hypothetical protein +FIG00438061 FIG00438065: hypothetical protein +FIG00438065 FIG00438067: hypothetical protein +FIG00438067 FIG00438068: hypothetical protein +FIG00438068 FIG00438069: hypothetical protein +FIG00438069 FIG00438071: hypothetical protein +FIG00438071 FIG00438072: hypothetical protein +FIG00438081 FIG00438082: hypothetical protein +FIG00438087 FIG007067: Putative ATP:guanido phosphotransferase yacI (EC 2.7.3.-) +FIG00438088 FIG00438094: hypothetical protein +FIG00438094 FIG00438103: hypothetical protein +FIG00438103 FIG00438104: hypothetical protein +FIG00438104 FIG00438109: hypothetical protein +FIG00438110 FIG00438111: hypothetical protein +FIG00438111 FIG00438113: hypothetical protein +FIG00438115 FIG00438121: hypothetical protein +FIG00438121 FIG00438123: hypothetical protein +FIG00438123 FIG00438127: hypothetical protein +FIG00438127 FIG00438128: hypothetical protein +FIG00438128 FIG00438130: hypothetical protein +FIG00438130 taurine ABC transporter, periplasmic binding protein +FIG00438135 FIG00438136: hypothetical protein +FIG00438138 Uncharacterized protein in tlyA 5'region (ORF1) (Fragment) +FIG00438142 Alkanesulfonates ABC transporter ATP-binding protein BUT NOT +FIG00438143 FIG00438144: hypothetical protein +FIG00438146 FIG00438149: hypothetical protein +FIG00438152 FIG00438153: hypothetical protein +FIG00438154 FIG00438156: hypothetical protein +FIG00438156 FIG00438157: hypothetical protein +FIG00438158 FIG00438162: hypothetical protein +FIG00438164 FIG00438165: hypothetical protein +FIG00438165 FIG00438166: hypothetical protein +FIG00438166 FIG00438167: hypothetical protein +FIG00438174 FIG00438176: hypothetical protein +FIG00438179 FIG00438181: hypothetical protein +FIG00438181 putative 11.6 kDa protein +FIG00438189 FIG00438191: hypothetical protein +FIG00438191 FIG00438192: hypothetical protein +FIG00438192 intracellular protease +FIG00438196 Hol +FIG00438200 FIG00438202: hypothetical protein +FIG00438204 FIG00438205: hypothetical protein +FIG00438206 Type II restriction enzyme HinfI (EC 3.1.21.4) (Endonuclease HinfI) (R.HinfI) +FIG00438212 FIG00438215: hypothetical protein +FIG00438215 FIG00438217: hypothetical protein +FIG00438217 FIG00438228: hypothetical protein +FIG00438228 FIG00438231: hypothetical protein +FIG00438239 FIG00438241: hypothetical protein +FIG00438242 FIG00438243: hypothetical protein +FIG00438243 FIG00438247: hypothetical protein +FIG00438247 FIG00438249: hypothetical protein +FIG00438255 FIG00438256: hypothetical protein +FIG00438256 FIG00438257: hypothetical protein +FIG00438257 FIG00438258: hypothetical protein +FIG00438258 FIG00438259: hypothetical protein +FIG00438264 FIG00438265: hypothetical protein +FIG00438265 FIG00438269: hypothetical protein +FIG00438269 FIG00438270: hypothetical protein +FIG00438270 FIG00438271: hypothetical protein +FIG00438271 FIG00438272: hypothetical protein +FIG00438272 FIG00438273: hypothetical protein +FIG00438277 FIG00438278: hypothetical protein +FIG00438278 FIG00438279: hypothetical protein +FIG00438301 FIG00438303: hypothetical protein +FIG00438303 FIG00438306: hypothetical protein +FIG00438309 FIG00438311: hypothetical protein +FIG00438311 FIG00438312: hypothetical protein +FIG00438312 Coenzyme A transferase +FIG00438322 FIG00438325: hypothetical protein +FIG00438327 flagellar filament outer layer protein (flaA-2) +FIG00438328 FIG00438331: hypothetical protein +FIG00438331 Trep +FIG00438335 FIG00438339: hypothetical protein +FIG00438339 FIG00438341: hypothetical protein +FIG00438341 FIG00438343: hypothetical protein +FIG00438345 FIG00438347: hypothetical protein +FIG00438347 FIG00438352: hypothetical protein +FIG00438360 FIG00438361: hypothetical protein +FIG00438361 FIG00438365: hypothetical protein +FIG00438365 FIG00438366: hypothetical protein +FIG00438366 FIG00438367: hypothetical protein +FIG00438367 FIG00438368: hypothetical protein +FIG00438368 FIG00438372: hypothetical protein +FIG00438373 FIG00438376: hypothetical protein +FIG00438376 FIG00438384: hypothetical protein +FIG00438384 PTS system, 3-keto-L-gulonate/L-ascorbate specific IIB component (SgaB) +FIG00438386 FIG00438387: hypothetical protein +FIG00438387 FIG00438389: hypothetical protein +FIG00438389 FIG00438393: hypothetical protein +FIG00438393 FIG00438396: hypothetical protein +FIG00438396 Sam dependent methyltransferase +FIG00438403 FIG00438406: hypothetical protein +FIG00438406 FIG00438407: hypothetical protein +FIG00438407 FIG00438408: hypothetical protein +FIG00438409 FIG00438411: hypothetical protein +FIG00438411 FIG00438413: hypothetical protein +FIG00438413 FIG00438415: hypothetical protein +FIG00438415 FIG00438416: hypothetical protein +FIG00438416 FIG00438418: hypothetical protein +FIG00438418 FIG00438419: hypothetical protein +FIG00438419 FIG00438426: hypothetical protein +FIG00438426 VSH-1 associated protein 3 +FIG00438431 Flagellar protein FliJ +FIG00438444 FIG00438446: hypothetical protein +FIG00438446 FIG00438448: hypothetical protein +FIG00438450 FIG00438452: hypothetical protein +FIG00438459 FIG00438462: hypothetical protein +FIG00438466 FIG00438468: hypothetical protein +FIG00438470 Protein of unknown function DUF115 +FIG00438478 FIG00438480: hypothetical protein +FIG00438480 FIG00438487: hypothetical protein +FIG00438489 FIG00438490: hypothetical protein +FIG00438492 FIG00438496: hypothetical protein +FIG00438496 FIG00438498: hypothetical protein +FIG00438498 FIG00438501: hypothetical protein +FIG00438501 FIG00438503: hypothetical protein +FIG00438503 FIG00438504: hypothetical protein +FIG00438504 FIG00438510: hypothetical protein +FIG00438510 FIG00438513: hypothetical protein +FIG00438513 FIG00438514: hypothetical protein +FIG00438514 chemotaxis protein CheX +FIG00438520 FIG00438521: hypothetical protein +FIG00438521 FIG00438526: hypothetical protein +FIG00438526 FIG00438528: hypothetical protein +FIG00438528 FIG00438531: hypothetical protein +FIG00438533 FIG00438537: hypothetical protein +FIG00438537 FIG00438540: hypothetical protein +FIG00438542 FIG00438543: hypothetical protein +FIG00438543 FIG00438544: hypothetical protein +FIG00438544 FIG00438548: hypothetical protein +FIG00438552 FIG00438556: hypothetical protein +FIG00438556 FIG00438559: hypothetical protein +FIG00438565 FIG00438569: hypothetical protein +FIG00438570 FIG00438573: hypothetical protein +FIG00438573 FIG00438575: hypothetical protein +FIG00438576 FIG00438580: hypothetical protein +FIG00438587 FIG00438588: hypothetical protein +FIG00438588 FIG00438589: hypothetical protein +FIG00438589 FIG00438596: hypothetical protein +FIG00438596 FIG00438601: hypothetical protein +FIG00438601 FIG00438603: hypothetical protein +FIG00438604 FIG00438609: hypothetical protein +FIG00438612 B. burgdorferi predicted coding region BBJ29 +FIG00438613 FIG00438614: hypothetical protein +FIG00438617 FIG00438620: hypothetical protein +FIG00438620 FIG00438621: hypothetical protein +FIG00438627 FIG00438633: hypothetical protein +FIG00438634 FIG00438637: hypothetical protein +FIG00438637 FIG00438639: hypothetical protein +FIG00438639 FIG00438641: hypothetical protein +FIG00438641 putative conserved membrane exported protein +FIG00438642 FIG00438644: hypothetical protein +FIG00438644 FIG00438647: hypothetical protein +FIG00438647 Chromosome undetermined scaffold_631, whole genome shotgun sequence +FIG00438655 FIG00438656: hypothetical protein +FIG00438657 FIG00438662: hypothetical protein +FIG00438670 FIG00438671: hypothetical protein +FIG00438671 FIG00438672: hypothetical protein +FIG00438678 FIG00438680: hypothetical protein +FIG00438680 FIG00438685: hypothetical protein +FIG00438686 FIG00438687: hypothetical protein +FIG00438693 FIG00438696: hypothetical protein +FIG00438696 FIG00438697: hypothetical protein +FIG00438697 FIG00438699: hypothetical protein +FIG00438699 hydrogenase, Fe-only +FIG00438701 FIG00438702: hypothetical protein +FIG00438704 FIG00438705: hypothetical protein +FIG00438708 FIG00438710: hypothetical protein +FIG00438713 Ribosomal large subunit pseudouridine synthase B (EC 5.4.99.-) +FIG00438716 Squalene synthase (EC 2.5.1.21) +FIG00438721 ankyrin repeat protein, putative +FIG00438725 FIG00438728: hypothetical protein +FIG00438728 FIG00438734: hypothetical protein +FIG00438744 FIG00438745: hypothetical protein +FIG00438745 flavodoxin, putative +FIG00438748 FIG00438749: hypothetical protein +FIG00438753 FIG00438756: hypothetical protein +FIG00438756 FIG00438757: hypothetical protein +FIG00438759 FIG00438761: hypothetical protein +FIG00438761 Periplasmic mercuric ion binding protein +FIG00438767 FIG00438768: hypothetical protein +FIG00438768 FIG00438769: hypothetical protein +FIG00438769 FIG00438773: hypothetical protein +FIG00438775 FIG00438780: hypothetical protein +FIG00438780 FIG00438783: hypothetical protein +FIG00438792 FIG00438794: hypothetical protein +FIG00438794 FIG00438796: hypothetical protein +FIG00438796 FIG00438800: hypothetical protein +FIG00438800 FIG00438808: hypothetical protein +FIG00438808 FIG00438813: hypothetical protein +FIG00438819 FIG00438824: hypothetical protein +FIG00438827 FIG00438828: hypothetical protein +FIG00438828 FIG00438829: hypothetical protein +FIG00438829 FIG00438835: hypothetical protein +FIG00438840 FIG00438844: hypothetical protein +FIG00438844 FIG00438846: hypothetical protein +FIG00438846 FIG00438851: hypothetical protein +FIG00438851 FIG00438853: hypothetical protein +FIG00438853 FIG00438857: hypothetical protein +FIG00438866 putative outer membrane efflux protein +FIG00438869 FIG00438870: hypothetical protein +FIG00438870 FIG00438872: hypothetical protein +FIG00438872 FIG00438876: hypothetical protein +FIG00438881 FIG00438882: hypothetical protein +FIG00438882 FIG00438885: hypothetical protein +FIG00438885 FIG00438886: hypothetical protein +FIG00438890 FIG00438894: hypothetical protein +FIG00438894 FIG00438897: hypothetical protein +FIG00438901 FIG00438902: hypothetical protein +FIG00438911 FIG00438913: hypothetical protein +FIG00438919 FIG00438920: hypothetical protein +FIG00438920 FIG00438921: hypothetical protein +FIG00438921 FIG00438927: hypothetical protein +FIG00438927 FIG00438928: hypothetical protein +FIG00438928 FIG00438929: hypothetical protein +FIG00438929 FIG00438933: hypothetical protein +FIG00438933 FIG00438937: hypothetical protein +FIG00438941 FIG00438945: hypothetical protein +FIG00438945 putative NADPH-dependent glutamate synthase +FIG00438965 FIG00438966: hypothetical protein +FIG00438966 FIG00438972: hypothetical protein +FIG00438979 FIG00438983: hypothetical protein +FIG00438983 putative uncharacterized membrane protein, ortholog YYAS B.subtilis +FIG00438984 FIG00438985: hypothetical protein +FIG00438985 FIG00438986: hypothetical protein +FIG00438986 FIG00438988: hypothetical protein +FIG00438993 FIG00438994: hypothetical protein +FIG00438994 FIG00438996: hypothetical protein +FIG00438996 FIG00439004: hypothetical protein +FIG00439006 FIG00439016: hypothetical protein +FIG00439016 FIG00439017: hypothetical protein +FIG00439017 FIG00439018: hypothetical protein +FIG00439028 Ankyrin repeat domain-containing protein 44 +FIG00439030 FIG00439033: hypothetical protein +FIG00439033 FIG00439036: hypothetical protein +FIG00439038 FIG00439040: hypothetical protein +FIG00439048 FIG00439049: hypothetical protein +FIG00439052 FIG00439054: hypothetical protein +FIG00439054 putative methyl-accepting chemotaxis sensory transducer +FIG00439059 FIG00439060: hypothetical protein +FIG00439061 FIG00439062: hypothetical protein +FIG00439062 FIG00439064: hypothetical protein +FIG00439066 FIG00439067: hypothetical protein +FIG00439067 FIG00439069: hypothetical protein +FIG00439075 FIG00439077: hypothetical protein +FIG00439077 FIG00439079: hypothetical protein +FIG00439080 FIG00439085: hypothetical protein +FIG00439085 FIG00439086: hypothetical protein +FIG00439090 FIG00439091: hypothetical protein +FIG00439100 FIG00439105: hypothetical protein +FIG00439105 FIG00439107: hypothetical protein +FIG00439116 FIG00439121: hypothetical protein +FIG00439121 FIG00439124: hypothetical protein +FIG00439124 FIG00439129: hypothetical protein +FIG00439129 FIG00439132: hypothetical protein +FIG00439132 FIG00439133: hypothetical protein +FIG00439133 FIG00439135: hypothetical protein +FIG00439136 FIG00439137: hypothetical protein +FIG00439137 FIG00439139: hypothetical protein +FIG00439141 FIG00439144: hypothetical protein +FIG00439144 FIG00439148: hypothetical protein +FIG00439148 FIG00439149: hypothetical protein +FIG00439149 FIG00439152: hypothetical protein +FIG00439152 FIG00439155: hypothetical protein +FIG00439155 FIG00439159: hypothetical protein +FIG00439159 FIG00439163: hypothetical protein +FIG00439170 FIG00439182: hypothetical protein +FIG00439182 FIG00439184: hypothetical protein +FIG00439205 FIG00439216: hypothetical protein +FIG00439216 FIG00439226: hypothetical protein +FIG00439226 putative transcriptional regulator, Crp/Fnr /protein_id= +FIG00439230 Polymerase +FIG00439235 FIG00439237: hypothetical protein +FIG00439237 FIG00439239: hypothetical protein +FIG00439246 Hvp 24 +FIG00439247 FIG00439257: hypothetical protein +FIG00439257 FIG00439258: hypothetical protein +FIG00439258 FIG00439260: hypothetical protein +FIG00439275 FIG00439279: hypothetical protein +FIG00439284 FIG00439287: hypothetical protein +FIG00439287 FIG00439291: hypothetical protein +FIG00439292 FIG00439293: hypothetical protein +FIG00439293 FIG00439303: hypothetical protein +FIG00439303 CNPV019 ankyrin repeat protein +FIG00439314 FIG00439315: hypothetical protein +FIG00439316 Type I restriction-modification enzyme M subunit +FIG00439321 FIG00439322: hypothetical protein +FIG00439331 FIG00439339: hypothetical protein +FIG00439352 FIG00439356: hypothetical protein +FIG00439356 FIG00439358: hypothetical protein +FIG00439361 FIG00439366: hypothetical protein +FIG00439368 probable Mg2+ transport protein +FIG00439394 FIG00439395: hypothetical protein +FIG00439407 FIG00439409: hypothetical protein +FIG00439412 FIG00439413: hypothetical protein +FIG00439424 FIG00439425: hypothetical protein +FIG00439425 Hydrogenase maturation factor HoxT/HybE +FIG00439432 FIG00439433: hypothetical protein +FIG00439433 FIG00439437: hypothetical protein +FIG00439439 Bsl2212 protein +FIG00439444 FIG00439446: hypothetical protein +FIG00439446 Methionine biosynthesis protein MetW +FIG00439447 FIG00439449: hypothetical protein +FIG00439449 Probable cation efflux pump +FIG00439451 COGs COG0845 +FIG00439452 FIG00439453: hypothetical protein +FIG00439459 blr4874; putative alcohol dehydrogenase (EC 1.1.1.1) +FIG00439462 Diheme Ferric reductase (EC 1.16.5.1) +FIG00439463 FIG00439465: hypothetical protein +FIG00439465 FIG00439467: hypothetical protein +FIG00439468 FIG00439469: hypothetical protein +FIG00439469 FIG00439470: hypothetical protein +FIG00439472 FIG00439473: hypothetical protein +FIG00439474 FIG00439477: hypothetical protein +FIG00439478 FIG00439479: hypothetical protein +FIG00439479 FIG00439481: hypothetical protein +FIG00439481 FIG00439483: hypothetical protein +FIG00439483 FIG01007306: hypothetical protein +FIG00439485 Glycosyl transferase WbpZ +FIG00439487 FIG00439488: hypothetical protein +FIG00439488 FIG00439489: hypothetical protein +FIG00439493 FIG00439494: hypothetical protein +FIG00439494 FIG00439495: hypothetical protein +FIG00439495 Putative Zn-dependent protease +FIG00439497 FIG00439499: hypothetical protein +FIG00439500 FIG00439502: hypothetical protein +FIG00439504 FIG00439505: hypothetical protein +FIG00439505 putative Permease of the major facilitator superfamily +FIG00439507 FIG00439508: hypothetical protein +FIG00439512 FIG00439513: hypothetical protein +FIG00439515 FIG00439516: hypothetical protein +FIG00439516 FIG00439517: hypothetical protein +FIG00439523 FIG00450267: hypothetical protein +FIG00439524 FIG00439527: hypothetical protein +FIG00439527 FIG00439528: hypothetical protein +FIG00439529 Phytochrome-like protein; Cph2 +FIG00439531 FIG00439534: hypothetical protein +FIG00439534 FIG00439535: hypothetical protein +FIG00439536 FIG00439537: hypothetical protein +FIG00439549 putative cytochrome b561 family protein +FIG00439556 FIG00439558: hypothetical protein +FIG00439558 FIG00439560: hypothetical protein +FIG00439567 Bsr6783 protein +FIG00439568 FIG00439569: hypothetical protein +FIG00439569 FIG00439572: hypothetical protein +FIG00439572 Catalase( EC:1.11.1.6 ) +FIG00439574 FIG00439576: hypothetical protein +FIG00439576 FIG00439578: hypothetical protein +FIG00439587 FIG00439588: hypothetical protein +FIG00439591 FIG00439594: hypothetical protein +FIG00439602 FIG00439605: hypothetical protein +FIG00439605 FIG00439607: hypothetical protein +FIG00439623 FIG01006414: hypothetical protein +FIG00439624 4-amino-4-deoxy-L-arabinose transferase and related glycosyltransferases of PMT family +FIG00439626 FIG00439627: hypothetical protein +FIG00439627 FIG00439628: hypothetical protein +FIG00439629 FIG00439630: hypothetical protein +FIG00439630 FIG00439631: hypothetical protein +FIG00439635 DNA-binding response regulator PetR +FIG00439636 FIG00439637: hypothetical protein +FIG00439638 FIG00439641: hypothetical protein +FIG00439647 Aminoglycoside 6'-N-acetyltransferase +FIG00439654 FIG00439656: hypothetical protein +FIG00439657 FIG00439658: hypothetical protein +FIG00439658 Conserved hypothetical protein; putative signal peptide +FIG00439661 FIG00439663: hypothetical protein +FIG00439663 FIG00439664: hypothetical protein +FIG00439664 FIG00439666: hypothetical protein +FIG00439667 FIG00439669: hypothetical protein +FIG00439669 Succinate-semialdehyde dehydrogenase [NAD(P)+] (EC 1.2.1.16) +FIG00439672 FIG00439673: hypothetical protein +FIG00439673 FIG00439675: hypothetical protein +FIG00439675 FIG00439676: hypothetical protein +FIG00439676 FIG00439679: hypothetical protein +FIG00439679 FIG00439680: hypothetical protein +FIG00439680 FIG00439681: hypothetical protein +FIG00439681 Bll1500 protein +FIG00439685 FIG00439688: hypothetical protein +FIG00439694 FIG00439697: hypothetical protein +FIG00439697 FIG00439698: hypothetical protein +FIG00439698 membrane protein, putative +FIG00439707 FIG00451037: hypothetical protein +FIG00439714 FIG00439717: hypothetical protein +FIG00439721 FIG00439723: hypothetical protein +FIG00439736 FIG00450701: hypothetical protein +FIG00439739 FIG00439742: hypothetical protein +FIG00439746 FIG00439747: hypothetical protein +FIG00439748 FIG00439749: hypothetical protein +FIG00439749 FIG00886816: hypothetical protein +FIG00439751 FIG00439752: hypothetical protein +FIG00439752 FIG00439754: hypothetical protein +FIG00439754 NAD/NADP dependent oxidoreductase +FIG00439756 FIG00439762: hypothetical protein +FIG00439762 FIG00439764: hypothetical protein +FIG00439764 FIG00439765: hypothetical protein +FIG00439765 Bll5524 protein +FIG00439771 FIG00439772: hypothetical protein +FIG00439778 Predicted integral membrane protein +FIG00439785 FIG01095098: hypothetical protein +FIG00439790 InterPro IPR001687:IPR006021 COGs COG1525 +FIG00439796 FIG00439797: hypothetical protein +FIG00439799 FIG00439803: hypothetical protein +FIG00439803 FIG00439805: hypothetical protein +FIG00439805 FIG00439808: hypothetical protein +FIG00439808 FIG00439814: hypothetical protein +FIG00439814 FIG00439815: hypothetical protein +FIG00439815 3-hydroxy-2-methylpyridine-4,5-dicarboxylate 4-decarboxylase (EC 4.1.1.51) +FIG00439824 FIG00439826: hypothetical protein +FIG00439826 Glutathione transferase (EC 2.5.1.18) +FIG00439830 FIG00845751: hypothetical protein +FIG00439831 FIG00439832: hypothetical protein +FIG00439833 FIG00439836: hypothetical protein +FIG00439836 FIG00439841: hypothetical protein +FIG00439841 blr3951; hypothetical protein +FIG00439844 FIG00439845: hypothetical protein +FIG00439845 FIG00439846: hypothetical protein +FIG00439846 FIG00439847: hypothetical protein +FIG00439853 FIG00439859: hypothetical protein +FIG00439860 FIG00439862: hypothetical protein +FIG00439862 FIG00439865: hypothetical protein +FIG00439868 FIG00439869: hypothetical protein +FIG00439870 FIG00439871: hypothetical protein +FIG00439877 Two-component transcriptional regulator, winged helix family +FIG00439880 FIG00439882: hypothetical protein +FIG00439883 FIG00439885: hypothetical protein +FIG00439885 FIG00439886: hypothetical protein +FIG00439887 FIG00439889: hypothetical protein +FIG00439890 FIG00439895: hypothetical protein +FIG00439905 Outer surface protein +FIG00439910 FIG00439920: hypothetical protein +FIG00439923 FIG00439926: hypothetical protein +FIG00439926 FIG00439928: hypothetical protein +FIG00439928 FIG00450348: hypothetical protein +FIG00439931 FIG00439934: hypothetical protein +FIG00439934 putative two-component system sensor protein with Hpt domain +FIG00439939 bsr2468; hypothetical protein +FIG00439942 FIG00439944: hypothetical protein +FIG00439944 FIG00439945: hypothetical protein +FIG00439948 FIG00439950: hypothetical protein +FIG00439950 FIG00852261: hypothetical protein +FIG00439954 FIG00439959: hypothetical protein +FIG00439959 FIG00439961: hypothetical protein +FIG00439967 FIG00439968: hypothetical protein +FIG00439972 FIG00439975: hypothetical protein +FIG00439975 N-acyl-D-aspartate/D-glutamate deacylase +FIG00439977 FIG00439981: hypothetical protein +FIG00439981 ABC transporter, binding protein +FIG00439982 FIG00439984: hypothetical protein +FIG00439984 FIG00439985: hypothetical protein +FIG00439985 FIG00450081: hypothetical protein +FIG00439990 FIG00439991: hypothetical protein +FIG00439991 DoxX +FIG00439992 putative Transcriptional regulatory protein AraC/XylS family +FIG00439994 FIG00439995: hypothetical protein +FIG00439995 FIG00439997: hypothetical protein +FIG00439997 FIG00440000: hypothetical protein +FIG00440000 FIG00440003: hypothetical protein +FIG00440009 FIG00440014: hypothetical protein +FIG00440014 bacterioferritin +FIG00440016 HAD superfamily protein involved in N-acetyl-glucosamine catabolism +FIG00440024 FIG00440025: hypothetical protein +FIG00440025 FIG00440027: hypothetical protein +FIG00440030 FIG00440031: hypothetical protein +FIG00440031 FIG01008274: hypothetical protein +FIG00440032 FIG00440034: hypothetical protein +FIG00440040 FIG00440041: hypothetical protein +FIG00440041 FIG00440042: hypothetical protein +FIG00440042 FIG00440043: hypothetical protein +FIG00440043 Putative fatty acid desaturase (DesA family) +FIG00440044 FIG00440046: hypothetical protein +FIG00440046 FIG00440048: hypothetical protein +FIG00440048 FIG00887518: hypothetical protein +FIG00440053 FIG00440054: hypothetical protein +FIG00440067 Short-chain dehydrogenase/reductase SDR +FIG00440068 FIG00440070: hypothetical protein +FIG00440079 FIG00440080: hypothetical protein +FIG00440092 Bll5738 protein +FIG00440096 FIG00440098: hypothetical protein +FIG00440098 FIG00440100: hypothetical protein +FIG00440100 FIG00440101: hypothetical protein +FIG00440105 FIG00440108: hypothetical protein +FIG00440109 FIG00440112: hypothetical protein +FIG00440114 FIG00450577: hypothetical protein +FIG00440117 FIG00440119: hypothetical protein +FIG00440124 FIG00440125: hypothetical protein +FIG00440125 FIG00440129: hypothetical protein +FIG00440129 FIG00440130: hypothetical protein +FIG00440132 FIG00440135: hypothetical protein +FIG00440135 FIG00440136: hypothetical protein +FIG00440136 FRUCTOKINASE (EC 2.7.1.4) +FIG00440140 FIG00440141: hypothetical protein +FIG00440144 FIG00440145: hypothetical protein +FIG00440145 FIG00440146: hypothetical protein +FIG00440146 FIG00440147: hypothetical protein +FIG00440148 Signal transduction response regulator / Disease resistance protein / Tetratricopeptide repeat-containing protein +FIG00440151 Bll5849 protein +FIG00440155 Bll5333 protein +FIG00440158 FIG00440159: hypothetical protein +FIG00440167 FIG00440168: hypothetical protein +FIG00440168 FIG00440169: hypothetical protein +FIG00440169 FIG00440174: hypothetical protein +FIG00440175 FIG00440176: hypothetical protein +FIG00440176 FIG00440177: hypothetical protein +FIG00440177 FIG00440179: hypothetical protein +FIG00440179 FIG00440181: hypothetical protein +FIG00440185 InterPro IPR002668 COGs COG1972 +FIG00440190 FIG00440192: hypothetical protein +FIG00440192 AsmA family protein +FIG00440197 FIG00440204: hypothetical protein +FIG00440205 FIG00440206: hypothetical protein +FIG00440208 FIG00440209: hypothetical protein +FIG00440213 ABC transporter HlyB/MsbA family +FIG00440214 FIG00440216: hypothetical protein +FIG00440222 FIG00440224: hypothetical protein +FIG00440224 FIG00440226: hypothetical protein +FIG00440226 blr0920; hypothetical protein +FIG00440228 FIG00440229: hypothetical protein +FIG00440229 Bll5254 protein +FIG00440230 FIG00440233: hypothetical protein +FIG00440233 polyhydroxyalkanoate depolymerase, intracellular +FIG00440238 D-aminoacylase (EC 3.5.1.81) (N-acyl-D-amino-acid deacylase) +FIG00440249 FIG00440253: hypothetical protein +FIG00440253 FIG00440254: hypothetical protein +FIG00440256 FIG00440258: hypothetical protein +FIG00440258 FIG00440260: hypothetical protein +FIG00440260 Sporulation related domain +FIG00440267 Bll6187 protein +FIG00440272 FIG00440275: hypothetical protein +FIG00440276 FIG00440278: hypothetical protein +FIG00440278 FIG00440279: hypothetical protein +FIG00440280 FIG00440281: hypothetical protein +FIG00440281 FIG00440285: hypothetical protein +FIG00440285 InterPro IPR000379:IPR000734 COGs COG0596 +FIG00440286 FIG00440295: hypothetical protein +FIG00440296 FIG00440297: hypothetical protein +FIG00440297 FIG00440298: hypothetical protein +FIG00440301 FIG00440303: hypothetical protein +FIG00440310 FIG00440312: hypothetical protein +FIG00440312 FIG00440314: hypothetical protein +FIG00440314 FIG00440315: hypothetical protein +FIG00440315 FIG00440316: hypothetical protein +FIG00440316 FIG00440318: hypothetical protein +FIG00440318 putative transcriptional regulator, AraC/XylS family +FIG00440320 Putative multidrug resistance efflux pump protein +FIG00440324 FIG00440325: hypothetical protein +FIG00440328 FIG00440329: hypothetical protein +FIG00440331 FIG00440334: hypothetical protein +FIG00440334 FIG00440335: hypothetical protein +FIG00440335 FIG00440340: hypothetical protein +FIG00440341 FIG00440342: hypothetical protein +FIG00440342 FIG00440349: hypothetical protein +FIG00440350 FIG00440353: hypothetical protein +FIG00440353 FIG00440354: hypothetical protein +FIG00440357 FIG00440358: hypothetical protein +FIG00440371 FIG00440373: hypothetical protein +FIG00440375 FIG00440376: hypothetical protein +FIG00440377 FIG00440381: hypothetical protein +FIG00440390 FIG00440391: hypothetical protein +FIG00440393 FIG00440394: hypothetical protein +FIG00440398 FIG00440402: hypothetical protein +FIG00440403 FIG00440405: hypothetical protein +FIG00440406 Bll6993 protein +FIG00440409 FIG00440410: hypothetical protein +FIG00440414 FIG00440415: hypothetical protein +FIG00440430 N-methyltransferase +FIG00440433 FIG00440435: hypothetical protein +FIG00440435 FIG00440436: hypothetical protein +FIG00440436 FIG00440438: hypothetical protein +FIG00440438 FIG00440439: hypothetical protein +FIG00440439 FIG00440441: hypothetical protein +FIG00440441 FIG00440442: hypothetical protein +FIG00440447 FIG00440450: hypothetical protein +FIG00440450 InterPro IPR001687:IPR002937 COGs COG0492 +FIG00440452 FIG00440458: hypothetical protein +FIG00440458 FIG00440459: hypothetical protein +FIG00440459 FIG00440462: hypothetical protein +FIG00440462 FIG00440463: hypothetical protein +FIG00440466 FIG00440468: hypothetical protein +FIG00440468 FIG00440469: hypothetical protein +FIG00440469 putative membrane protein of unknown function +FIG00440475 FIG00440476: hypothetical protein +FIG00440476 FIG00440478: hypothetical protein +FIG00440478 FIG00440480: hypothetical protein +FIG00440480 FIG00440481: hypothetical protein +FIG00440483 FIG00440484: hypothetical protein +FIG00440484 Copper binding protein, plastocyanin/azurin family +FIG00440489 FIG00440491: hypothetical protein +FIG00440491 FIG00440492: hypothetical protein +FIG00440499 Possible polysaccharide deacetylase precursor +FIG00440503 FIG00440504: hypothetical protein +FIG00440504 FIG00440506: hypothetical protein +FIG00440515 FIG00440518: hypothetical protein +FIG00440520 DedA family +FIG00440526 blr0228; hypothetical protein +FIG00440533 FIG00440534: hypothetical protein +FIG00440534 FIG00440536: hypothetical protein +FIG00440536 FIG00440537: hypothetical protein +FIG00440537 FIG00440539: hypothetical protein +FIG00440539 FIG00440541: hypothetical protein +FIG00440541 Cytochrome c-553I precursor (Cytochrome c553I) +FIG00440543 FIG00440548: hypothetical protein +FIG00440548 FIG00440549: hypothetical protein +FIG00440549 FIG00440552: hypothetical protein +FIG00440552 FIG00440554: hypothetical protein +FIG00440554 FIG00440555: hypothetical protein +FIG00440555 FIG00440556: hypothetical protein +FIG00440556 FIG00440558: hypothetical protein +FIG00440571 FIG00440573: hypothetical protein +FIG00440578 FIG00440579: hypothetical protein +FIG00440580 FIG00440581: hypothetical protein +FIG00440581 FIG00440582: hypothetical protein +FIG00440582 FIG00440583: hypothetical protein +FIG00440585 FIG00440587: hypothetical protein +FIG00440588 Bll5714 protein +FIG00440592 FIG00440594: hypothetical protein +FIG00440595 FIG00440596: hypothetical protein +FIG00440602 putative phosphohydrolases, Icc family +FIG00440604 FIG00440609: hypothetical protein +FIG00440609 FIG00440612: hypothetical protein +FIG00440612 Nucleoside-binding outer membrane protein +FIG00440613 FIG00440614: hypothetical protein +FIG00440614 FIG00440615: hypothetical protein +FIG00440627 FIG00440630: hypothetical protein +FIG00440630 putative class II antigen +FIG00440631 FIG00440633: hypothetical protein +FIG00440635 FIG00440640: hypothetical protein +FIG00440640 FIG00440641: hypothetical protein +FIG00440646 FIG00440649: hypothetical protein +FIG00440653 Phosphatidylethanolamine N-methyltransferase (EC 2.1.1.17) +FIG00440659 FIG00440661: hypothetical protein +FIG00440661 putative RNA polymerase sigma subunit +FIG00440665 Chemotaxis protein CheYIII +FIG00440667 FIG00440668: hypothetical protein +FIG00440668 FIG00440669: hypothetical protein +FIG00440671 FIG00440674: hypothetical protein +FIG00440674 FIG00440675: hypothetical protein +FIG00440680 FIG00440682: hypothetical protein +FIG00440682 FIG00440684: hypothetical protein +FIG00440684 FIG00440685: hypothetical protein +FIG00440692 FIG00440697: hypothetical protein +FIG00440698 FIG00440699: hypothetical protein +FIG00440700 FIG00440701: hypothetical protein +FIG00440709 FIG00440711: hypothetical protein +FIG00440712 FIG00440713: hypothetical protein +FIG00440714 FIG00440715: hypothetical protein +FIG00440722 putative methyl-accepting chemotaxis receptor/sensory transducer +FIG00440723 FIG00440725: hypothetical protein +FIG00440725 FIG00440729: hypothetical protein +FIG00440738 FIG00440739: hypothetical protein +FIG00440740 FIG00440744: hypothetical protein +FIG00440745 Bll3066 protein +FIG00440749 hypothetical protein; putative membrane protein; putative signal peptide +FIG00440750 FIG00440753: hypothetical protein +FIG00440753 FIG00440754: hypothetical protein +FIG00440754 FIG00440757: hypothetical protein +FIG00440758 FIG00440759: hypothetical protein +FIG00440759 NADPH:quinone oxidoreductase 2 +FIG00440762 FIG00440763: hypothetical protein +FIG00440763 FIG00440764: hypothetical protein +FIG00440765 FIG00440766: hypothetical protein +FIG00440769 FIG00440770: hypothetical protein +FIG00440770 Glutathione peroxidase family protein +FIG00440771 FIG00440773: hypothetical protein +FIG00440773 FIG00440775: hypothetical protein +FIG00440775 FIG00440777: hypothetical protein +FIG00440777 FIG00440778: hypothetical protein +FIG00440778 putative Sensor histidine kinase (HWE family) with a GAF domain +FIG00440788 FIG00440792: hypothetical protein +FIG00440792 Bsl6681 protein +FIG00440798 FIG00440799: hypothetical protein +FIG00440799 FIG00440800: hypothetical protein +FIG00440807 Bsr6686 protein +FIG00440808 FIG00440809: hypothetical protein +FIG00440809 FIG00440816: hypothetical protein +FIG00440816 FIG00440817: hypothetical protein +FIG00440819 FIG00440821: hypothetical protein +FIG00440839 FIG00440842: hypothetical protein +FIG00440844 Mlr9743 protein +FIG00440850 FIG00440851: hypothetical protein +FIG00440853 FIG00440854: hypothetical protein +FIG00440856 FIG00440858: hypothetical protein +FIG00440858 FIG00440859: hypothetical protein +FIG00440859 FIG00440864: hypothetical protein +FIG00440867 C-methyltransferase +FIG00440869 Dihydrolipoamide acetyltransferase component of pyruvate dehydrogenase complex (EC 2.3.1.12) @ Dihydrolipoamide acyltransferase component of branched-chain alpha-keto acid dehydrogenase complex (EC 2.3.1.168) +FIG00440872 FIG00440873: hypothetical protein +FIG00440886 Sulfite dehydrogenase (EC 1.7.99.4) +FIG00440888 FIG00440890: hypothetical protein +FIG00440890 FIG00440892: hypothetical protein +FIG00440892 FIG00440893: hypothetical protein +FIG00440894 FIG00440899: hypothetical protein +FIG00440901 FIG00440904: hypothetical protein +FIG00440906 FIG00440908: hypothetical protein +FIG00440908 Bll5679 protein +FIG00440912 FIG00440914: hypothetical protein +FIG00440915 FIG00440919: hypothetical protein +FIG00440919 conserved hypothetical protein +FIG00440931 FIG00440932: hypothetical protein +FIG00440932 Hypothetical protein COG2043 +FIG00440936 FIG00440938: hypothetical protein +FIG00440938 Mlr4903 protein +FIG00440944 FIG00440945: hypothetical protein +FIG00440945 Invasion protein B, involved in pathogenesis +FIG00440948 FIG00440949: hypothetical protein +FIG00440949 FIG00440951: hypothetical protein +FIG00440951 FIG00440953: hypothetical protein +FIG00440973 FIG00440974: hypothetical protein +FIG00440976 FIG00450475: hypothetical protein +FIG00440978 FIG00440980: hypothetical protein +FIG00440980 FIG00440982: hypothetical protein +FIG00440990 FIG00440991: hypothetical protein +FIG00440991 FIG00440993: hypothetical protein +FIG00440995 FIG00441000: hypothetical protein +FIG00441000 FIG00441001: hypothetical protein +FIG00441002 FIG00441004: hypothetical protein +FIG00441011 FIG00441012: hypothetical protein +FIG00441016 FIG00441019: hypothetical protein +FIG00441019 FIG00441021: hypothetical protein +FIG00441022 FIG00441023: hypothetical protein +FIG00441045 FIG00441046: hypothetical protein +FIG00441047 FIG00441050: hypothetical protein +FIG00441054 FIG00441059: hypothetical protein +FIG00441064 FIG00441065: hypothetical protein +FIG00441068 FIG00441069: hypothetical protein +FIG00441073 FIG00441075: hypothetical protein +FIG00441075 putative transcriptional regulatory protein (protein cheY) +FIG00441081 Patatin-like phospholipase domain +FIG00441093 bll6500; unknown protein +FIG00441094 bll5334; probable nucleic-acid-binding protein containing a Zn-ribbon +FIG00441098 FIG00441099: hypothetical protein +FIG00441099 FIG00887099: hypothetical protein +FIG00441102 FIG00441105: hypothetical protein +FIG00441111 FIG00441112: hypothetical protein +FIG00441120 FIG00441122: hypothetical protein +FIG00441122 FIG00441123: hypothetical protein +FIG00441125 FIG00441126: hypothetical protein +FIG00441133 FIG00441137: hypothetical protein +FIG00441140 FIG00441143: hypothetical protein +FIG00441143 FIG00441144: hypothetical protein +FIG00441144 FIG140336: TPR domain protein +FIG00441147 FIG00441148: hypothetical protein +FIG00441148 FIG00441149: hypothetical protein +FIG00441149 FIG00441158: hypothetical protein +FIG00441158 FIG00441159: hypothetical protein +FIG00441159 bll5848; putative decarboxylase +FIG00441163 FIG00441165: hypothetical protein +FIG00441166 FIG00441167: hypothetical protein +FIG00441185 FIG00441187: hypothetical protein +FIG00441187 putative Short-chain dehydrogenase/reductase (SDR) family protein( EC:1.1.1.- ) +FIG00441192 FIG00450046: hypothetical protein +FIG00441205 FIG00441206: hypothetical protein +FIG00441206 FIG00441207: hypothetical protein +FIG00441211 FIG00441216: hypothetical protein +FIG00441223 FIG00441225: hypothetical protein +FIG00441226 FIG00441227: hypothetical protein +FIG00441227 FIG00441229: hypothetical protein +FIG00441232 FIG00441233: hypothetical protein +FIG00441233 FIG00441234: hypothetical protein +FIG00441234 FIG00441235: hypothetical protein +FIG00441235 blr4704; putative phosphoglycolate phosphatase (EC 3.1.3.18) +FIG00441236 FIG00441238: hypothetical protein +FIG00441241 flagellar export protein +FIG00441255 FIG00441256: hypothetical protein +FIG00441263 FIG00441265: hypothetical protein +FIG00441265 FIG00441266: hypothetical protein +FIG00441266 FIG00441268: hypothetical protein +FIG00441268 FIG00441270: hypothetical protein +FIG00441270 FIG00441275: hypothetical protein +FIG00441275 FIG00441276: hypothetical protein +FIG00441276 FIG00441277: hypothetical protein +FIG00441277 FIG00441278: hypothetical protein +FIG00441278 FIG00441279: hypothetical protein +FIG00441282 FIG00441286: hypothetical protein +FIG00441286 FIG01006597: hypothetical protein +FIG00441290 COGs COG0683 +FIG00441291 FIG00441294: hypothetical protein +FIG00441294 FIG00441296: hypothetical protein +FIG00441296 Probable beta-phosphoglucomutase (EC 5.4.2.6) +FIG00441300 FIG00441301: hypothetical protein +FIG00441301 40-residue YVTN beta-propeller repeat +FIG00441303 FIG00441306: hypothetical protein +FIG00441327 FIG00441328: hypothetical protein +FIG00441332 RidA/YER057c/UK114 superfamily, group 2, YoaB-like protein +FIG00441342 bll0789; putative carboxypeptidase (EC 3.4.17.11) +FIG00441346 FIG01004475: hypothetical protein +FIG00441351 FIG00441352: hypothetical protein +FIG00441352 FIG00441354: hypothetical protein +FIG00441355 Probable tautomerase bsl7456 (EC 5.3.2.-) +FIG00441370 putative secretion ATP-binding protein (ABC-type transporter family); putative toxin/protease secretion system +FIG00441378 Flavin reductase-like, FMN-binding +FIG00441379 Acetyltransferase-like +FIG00441380 FIG00441381: hypothetical protein +FIG00441383 FIG00441386: hypothetical protein +FIG00441386 FIG00441387: hypothetical protein +FIG00441394 conserved hypothetical protein, hypothetical UPF0337 protein +FIG00441395 FIG00441398: hypothetical protein +FIG00441404 FIG00441406: hypothetical protein +FIG00441406 FIG00441408: hypothetical protein +FIG00441411 FIG00441414: hypothetical protein +FIG00441415 FIG00441418: hypothetical protein +FIG00441421 putative Rare lipoprotein A +FIG00441424 FIG00441427: hypothetical protein +FIG00441437 FIG00441438: hypothetical protein +FIG00441438 FIG00441439: hypothetical protein +FIG00441440 HEN1 C-terminal domain; double-stranded RNA 3'-methylase +FIG00441447 putative N-acyl homoserine lactone transcriptional regulator, LuxR-like protein +FIG00441448 FIG00441450: hypothetical protein +FIG00441451 FIG00441454: hypothetical protein +FIG00441454 FIG00441456: hypothetical protein +FIG00441456 FIG00441457: hypothetical protein +FIG00441461 FIG00441464: hypothetical protein +FIG00441465 FIG00450775: hypothetical protein +FIG00441468 FIG00441469: hypothetical protein +FIG00441470 FIG00441471: hypothetical protein +FIG00441492 Putative uncharacterized protein Blr0494 +FIG00441496 FIG00441497: hypothetical protein +FIG00441500 FIG00450516: Zinc-finger domain protein +FIG00441509 FIG00441513: hypothetical protein +FIG00441513 FIG00441514: hypothetical protein +FIG00441515 FIG00441520: hypothetical protein +FIG00441522 FIG00441523: hypothetical protein +FIG00441523 bll4670; hypothetical protein +FIG00441526 ABC transporter peptide-binding protein +FIG00441533 Mll0539 protein +FIG00441535 FIG00441537: hypothetical protein +FIG00441538 Cytochrome c' precursor +FIG00441553 FIG00441555: hypothetical protein +FIG00441566 FIG00441567: hypothetical protein +FIG00441569 FIG00441572: hypothetical protein +FIG00441572 FIG00441573: hypothetical protein +FIG00441575 FIG00441577: hypothetical protein +FIG00441577 Uncharacterized protein, possibly including a L,D-transpeptidase domain +FIG00441578 6-phosphogluconate dehydrogenase, NAD-binding +FIG00441579 FIG00441580: hypothetical protein +FIG00441580 FIG00441586: hypothetical protein +FIG00441586 FIG00441590: hypothetical protein +FIG00441592 FIG00800105: hypothetical protein +FIG00441597 cytochrome C +FIG00441602 conserved hypothetical protein; putative outer-membrane immunogenic protein precursor; putative exported protein +FIG00441603 putative outer-membrane immunogenic protein precursor +FIG00441611 Bll8157 protein +FIG00441613 Mlr8448 protein +FIG00441616 acyl-CoA hydrolase +FIG00441619 FIG00441620: hypothetical protein +FIG00441620 FIG00441621: hypothetical protein +FIG00441627 FIG00441633: hypothetical protein +FIG00441639 COGs COG3672 +FIG00441646 FIG01005603: hypothetical protein +FIG00441648 FIG00441649: hypothetical protein +FIG00441649 Cyanuric acid amidohydrolase (EC 3.5.2.15) +FIG00441650 FIG00441651: hypothetical protein +FIG00441651 FIG00441656: hypothetical protein +FIG00441656 FIG00441661: hypothetical protein +FIG00441661 Chaperone required for the assembly of the mitochondrial F1-ATPase +FIG00441680 oxalate/formate antiporter +FIG00441681 FIG00441682: hypothetical protein +FIG00441684 FIG00441685: hypothetical protein +FIG00441692 Predicted exporter of the RND superfamily, Rpal_4267 +FIG00441697 FIG00441698: hypothetical protein +FIG00441698 Putative dipeptide ABC transporter +FIG00441700 FIG00441701: hypothetical protein +FIG00441701 FIG071259; hypothetical protein +FIG00441703 FIG00450254: hypothetical protein +FIG00441704 Maleate cis-trans isomerase +FIG00441706 FIG00441709: hypothetical protein +FIG00441709 FIG01004502: hypothetical protein +FIG00441713 FIG00441714: hypothetical protein +FIG00441722 FIG00441725: hypothetical protein +FIG00441729 putative UDP-glucose 4-epimerase( EC:5.1.3.2 ) +FIG00441730 FIG00441731: hypothetical protein +FIG00441735 FIG00441737: hypothetical protein +FIG00441737 FIG00441743: hypothetical protein +FIG00441752 FIG00441755: hypothetical protein +FIG00441755 FIG00441762: hypothetical protein +FIG00441767 FIG00441768: hypothetical protein +FIG00441773 Conserved hypothetical protein, gene in Ubiquinol-cytochrome C chaperone locus +FIG00441774 FIG00441776: hypothetical protein +FIG00441776 FIG00441778: hypothetical protein +FIG00441778 Bll0389 protein +FIG00441780 FIG00441782: hypothetical protein +FIG00441787 putative ABC transporter (ATP-binding protein)( EC:3.6.3.- ) +FIG00441788 FIG00441790: hypothetical protein +FIG00441790 FIG00441792: hypothetical protein +FIG00441794 blr0325; hypothetical protein +FIG00441805 FIG00441807: hypothetical protein +FIG00441814 FIG00441815: hypothetical protein +FIG00441815 FIG00441817: hypothetical protein +FIG00441818 FIG00441821: hypothetical protein +FIG00441821 FIG00458549: hypothetical protein +FIG00441828 FIG00441830: hypothetical protein +FIG00441830 FIG00441833: hypothetical protein +FIG00441833 peptidase C14, caspase catalytic subunit p20 +FIG00441837 FIG01005994: hypothetical protein +FIG00441838 FIG00441842: hypothetical protein +FIG00441851 putative transmembrane protein +FIG00441858 FIG00441860: hypothetical protein +FIG00441864 FIG00441865: hypothetical protein +FIG00441865 FIG00441866: hypothetical protein +FIG00441872 FIG00441873: hypothetical protein +FIG00441873 FIG00441876: hypothetical protein +FIG00441876 FIG00441877: hypothetical protein +FIG00441879 FIG00441882: hypothetical protein +FIG00441882 FIG00441887: hypothetical protein +FIG00441892 FIG00441894: hypothetical protein +FIG00441897 FIG00441898: hypothetical protein +FIG00441898 putative transcriptional regulatory protein (protein cheY homolog) +FIG00441900 FIG00854283: hypothetical protein +FIG00441903 FIG00441906: hypothetical protein +FIG00441906 Epoxide hydrolase (EC 3.3.2.3) +FIG00441918 FIG00441919: hypothetical protein +FIG00441919 FIG00441920: hypothetical protein +FIG00441932 FIG00441938: hypothetical protein +FIG00441938 FIG00441940: hypothetical protein +FIG00441942 FIG00441943: hypothetical protein +FIG00441943 FIG00441946: hypothetical protein +FIG00441951 FIG00441953: hypothetical protein +FIG00441953 FIG00441956: hypothetical protein +FIG00441958 FIG00441959: hypothetical protein +FIG00441959 hypothetical protein +FIG00441960 FIG00441964: hypothetical protein +FIG00441964 FIG00954108: hypothetical protein +FIG00441965 FIG00441968: hypothetical protein +FIG00441974 Short-chain dehydrogenase +FIG00441978 FIG00441980: hypothetical protein +FIG00441981 FIG00441982: hypothetical protein +FIG00441984 FIG00441987: hypothetical protein +FIG00441987 FIG00441988: hypothetical protein +FIG00441988 FIG00441989: hypothetical protein +FIG00441989 FIG00441990: hypothetical protein +FIG00441990 FIG00441991: hypothetical protein +FIG00441991 FIG00441992: hypothetical protein +FIG00441995 putative periplasmic-binding protein; putative amino-acid periplasmic-binding protein +FIG00442005 alpha/beta hydrolase fold( EC:1.11.1.10 ) +FIG00442011 FIG00442018: hypothetical protein +FIG00442024 InterPro IPR002204 COGs COG2084 +FIG00442042 FIG00442044: hypothetical protein +FIG00442045 FIG00442049: hypothetical protein +FIG00442063 putative blue (type 1) copper protein +FIG00442072 FIG00442074: hypothetical protein +FIG00442076 FIG00442082: hypothetical protein +FIG00442086 Peptidase, T4 family +FIG00442090 FIG00442096: hypothetical protein +FIG00442096 FIG00442097: hypothetical protein +FIG00442098 FIG00442099: hypothetical protein +FIG00442103 FIG00442104: hypothetical protein +FIG00442104 Outer-membrane immunogenic protein +FIG00442105 FIG00442106: hypothetical protein +FIG00442111 Bsl5083 protein +FIG00442120 monooxygenase domain protein +FIG00442124 FIG00442126: hypothetical protein +FIG00442126 FIG00442128: hypothetical protein +FIG00442128 FIG00442129: hypothetical protein +FIG00442129 FIG00442130: hypothetical protein +FIG00442140 FIG00442141: hypothetical protein +FIG00442142 FIG00442145: hypothetical protein +FIG00442147 FIG00442148: hypothetical protein +FIG00442149 FIG00442151: hypothetical protein +FIG00442151 Bll0213 protein +FIG00442153 FIG00442154: hypothetical protein +FIG00442157 FIG00442159: hypothetical protein +FIG00442159 FIG00442160: hypothetical protein +FIG00442160 FIG00442161: hypothetical protein +FIG00442161 FIG00442162: hypothetical protein +FIG00442162 FIG00442163: hypothetical protein +FIG00442177 Bll8136 protein +FIG00442189 Acetyl-CoA synthetase (ADP-forming) alpha and beta chains, putative +FIG00442197 FIG00442200: hypothetical protein +FIG00442201 bll0251; putative efflux protein +FIG00442204 FIG00442207: hypothetical protein +FIG00442207 FIG00442214: hypothetical protein +FIG00442220 FIG00442223: hypothetical protein +FIG00442223 FIG00442228: hypothetical protein +FIG00442228 FIG00442232: hypothetical protein +FIG00442232 Osmolarity sensor protein EnvZ (EC 2.7.3.-) +FIG00442245 Bsl0049 protein +FIG00442246 bll3835; hypothetical protein +FIG00442258 FIG00442259: hypothetical protein +FIG00442259 FIG00442263: hypothetical protein +FIG00442263 FIG00442264: hypothetical protein +FIG00442264 ZINC-FINGER PROTEIN +FIG00442270 FIG00442276: hypothetical protein +FIG00442277 Bll6819 protein +FIG00442283 Hydrogenase maturation protein HupF/HypC/HoxL +FIG00442285 FIG00442289: hypothetical protein +FIG00442289 FIG065752: hypothetical protein +FIG00442294 FIG00442299: hypothetical protein +FIG00442306 Amidase (EC 3.5.1.4) +FIG00442308 FIG00442310: hypothetical protein +FIG00442316 FIG00442322: hypothetical protein +FIG00442324 Non-hemolytic phospholipase C precursor (EC 3.1.4.3) (PLC-N) (Phosphatidylcholine cholinephosphohydrolase) (Phosphatidylcholine-hydrolyzing phospholipase C) (PC-PLC) +FIG00442328 FIG00886901: hypothetical protein +FIG00442332 FIG00442336: hypothetical protein +FIG00442338 Bll0838 protein +FIG00442343 bll5948; hypothetical protein +FIG00442345 FIG00442353: hypothetical protein +FIG00442353 Tat (Twin-arginine translocation) pathway signal sequence domain protein +FIG00442360 FIG00442361: hypothetical protein +FIG00442364 FIG00442365: hypothetical protein +FIG00442365 Bsr6782 protein +FIG00442371 FIG00442372: hypothetical protein +FIG00442378 FIG00442381: hypothetical protein +FIG00442381 putative beta lactamase family protein( EC:3.4.16.4 ) +FIG00442389 FIG00442390: hypothetical protein +FIG00442395 FIG00442398: hypothetical protein +FIG00442398 FIG00442400: hypothetical protein +FIG00442400 FIG00442401: hypothetical protein +FIG00442416 FIG00442417: hypothetical protein +FIG00442417 cytochrome P450 +FIG00442422 FIG00442423: hypothetical protein +FIG00442428 Bona fide RidA/YjgF/TdcF/RutC subgroup +FIG00442431 FIG00442432: hypothetical protein +FIG00442432 FIG00442433: hypothetical protein +FIG00442435 Copper metallochaperone, bacterial analog of Cox17 protein / Conserved membrane protein in copper uptake, YcnI +FIG00442446 FIG00442447: hypothetical protein +FIG00442453 FIG00442456: hypothetical protein +FIG00442456 Bll0914 protein +FIG00442467 putative phage Major head protein +FIG00442472 CoxF protein +FIG00442473 Bll7505 protein +FIG00442479 FIG00442481: hypothetical protein +FIG00442481 FIG00442482: hypothetical protein +FIG00442486 putative two-component response regulatory protein, response regulator receiver +FIG00442487 FIG00442488: hypothetical protein +FIG00442489 COG1982: Arginine/lysine/ornithine decarboxylases +FIG00442490 FIG00442497: hypothetical protein +FIG00442497 FIG00442498: hypothetical protein +FIG00442498 FIG00442499: hypothetical protein +FIG00442506 FIG00442507: hypothetical protein +FIG00442509 putative transmembrane anti-sigma factor +FIG00442510 probable 1,4-butanediol diacrylate esterase +FIG00442524 putative Two-component system histidine kinase +FIG00442528 FIG00442529: hypothetical protein +FIG00442529 FIG00442537: hypothetical protein +FIG00442537 FIG00442538: hypothetical protein +FIG00442538 FIG00442546: hypothetical protein +FIG00442552 blr7814; putative L-proline 4-hydroxylase +FIG00442553 FIG00442554: hypothetical protein +FIG00442554 periplasmic binding protein/LacI transcriptional regulator +FIG00442560 FIG00442563: hypothetical protein +FIG00442563 Bll7438 protein +FIG00442575 bsr4431; hypothetical protein +FIG00442587 FIG00442588: hypothetical protein +FIG00442599 Protein-disulfide isomerase +FIG00442608 FIG00442609: hypothetical protein +FIG00442609 FIG00442610: hypothetical protein +FIG00442610 FIG00442611: hypothetical protein +FIG00442611 FIG00442617: hypothetical protein +FIG00442617 putative [Acyl-carrier-protein] phosphodiesterase (ACP phosphodiesterase)( EC:3.1.4.14 ) +FIG00442618 FIG00442620: hypothetical protein +FIG00442637 FIG00442641: hypothetical protein +FIG00442641 FIG00442643: hypothetical protein +FIG00442647 FIG00442650: hypothetical protein +FIG00442659 VapB protein (antitoxin to VapC) +FIG00442662 FIG00442663: hypothetical protein +FIG00442663 FIG00442668: hypothetical protein +FIG00442673 FIG00442674: hypothetical protein +FIG00442687 FIG00442688: hypothetical protein +FIG00442689 FIG00442692: hypothetical protein +FIG00442692 FIG00442694: hypothetical protein +FIG00442704 FIG00442705: hypothetical protein +FIG00442705 FIG00442706: hypothetical protein +FIG00442712 FIG00442713: hypothetical protein +FIG00442713 FIG00442715: hypothetical protein +FIG00442716 FIG00442718: hypothetical protein +FIG00442718 probable minor curlin subunit precursor +FIG00442719 putative transcriptional regulatory protein, GntR family +FIG00442722 FIG00442725: hypothetical protein +FIG00442727 FIG00442729: hypothetical protein +FIG00442735 FIG00442736: hypothetical protein +FIG00442749 FIG00442754: hypothetical protein +FIG00442757 Transcriptional regulatory protein fixJ +FIG00442766 FIG00442767: hypothetical protein +FIG00442767 FIG00442772: hypothetical protein +FIG00442778 FIG00442781: hypothetical protein +FIG00442787 FIG00442790: hypothetical protein +FIG00442792 FIG00442794: hypothetical protein +FIG00442794 FIG00442796: hypothetical protein +FIG00442797 FIG00442803: hypothetical protein +FIG00442804 FIG00442805: hypothetical protein +FIG00442810 FKBP-type 22KD peptidyl-prolyl cis-trans isomerase (rotamase) +FIG00442823 FIG00442827: hypothetical protein +FIG00442833 FIG00442834: hypothetical protein +FIG00442838 FIG00442844: hypothetical protein +FIG00442844 FIG00442846: hypothetical protein +FIG00442847 FIG00442849: hypothetical protein +FIG00442864 FIG00442868: hypothetical protein +FIG00442869 FIG00442870: hypothetical protein +FIG00442870 FIG00442871: hypothetical protein +FIG00442871 bll6276; unknown protein +FIG00442884 beta-(1-3)-glucosyl transferase +FIG00442887 regulatory protein, putative +FIG00442905 FIG00442906: hypothetical protein +FIG00442910 COG1872 +FIG00442913 FIG00442914: hypothetical protein +FIG00442915 FIG00442918: hypothetical protein +FIG00442918 FIG00442919: hypothetical protein +FIG00442919 FIG00442920: hypothetical protein +FIG00442929 FIG00442932: hypothetical protein +FIG00442940 THIO:disulfide Interchange Protein +FIG00442947 FIG00442951: hypothetical protein +FIG00442951 Bll0045 protein +FIG00442954 ABC-type cobalamin/Fe3+-siderophores transport systems, ATPase components +FIG00442968 Malic enzyme +FIG00442977 FIG00442978: hypothetical protein +FIG00442978 FIG00442979: hypothetical protein +FIG00442981 FIG00442984: hypothetical protein +FIG00442986 FIG00442991: hypothetical protein +FIG00442991 FIG00442992: hypothetical protein +FIG00442992 FIG00442997: hypothetical protein +FIG00443001 putative O-antigen/LPS export system ATP-binding protein +FIG00443015 FIG00443016: hypothetical protein +FIG00443020 FIG00443024: hypothetical protein +FIG00443024 FIG00443025: hypothetical protein +FIG00443025 FIG00443026: hypothetical protein +FIG00443032 FIG00443036: hypothetical protein +FIG00443036 Dimethylhistidine N-methyltransferase +FIG00443038 Bsr0093 protein +FIG00443048 FIG00443049: hypothetical protein +FIG00443049 FIG00443052: hypothetical protein +FIG00443052 FIG00443053: hypothetical protein +FIG00443053 putative ABC transporter-like protein +FIG00443054 FIG00443055: hypothetical protein +FIG00443055 FIG00443056: hypothetical protein +FIG00443057 FIG00443059: hypothetical protein +FIG00443059 probable periplasmic protein Cj0610c {imported} - Campylobacter jejuni (strain NCTC 11168) +FIG00443066 FIG00443067: hypothetical protein +FIG00443073 FIG00443075: hypothetical protein +FIG00443076 FIG00450379: hypothetical protein +FIG00443077 FIG00852950: hypothetical protein +FIG00443087 FIG00443088: hypothetical protein +FIG00443089 Conserved membrane protein in copper uptake, YcnI +FIG00443090 FIG00443092: hypothetical protein +FIG00443096 FIG00443097: hypothetical protein +FIG00443099 FIG00443100: hypothetical protein +FIG00443101 putative diguanylate cyclase (GGDEF)domain +FIG00443106 FIG00443113: hypothetical protein +FIG00443119 blr3941; hypothetical protein +FIG00443120 FIG00451076: hypothetical protein +FIG00443124 FIG00443126: hypothetical protein +FIG00443126 FIG00443128: hypothetical protein +FIG00443138 Mll2248 protein +FIG00443142 FIG00443143: hypothetical protein +FIG00443143 Glutamate-1-semialdehyde-2,1-aminomutase +FIG00443147 FIG00443149: hypothetical protein +FIG00443149 FIG00443151: hypothetical protein +FIG00443156 Chalcone synthase (EC 2.3.1.74) +FIG00443161 Transcriptional regulator, AraC family / Acetamidase/Formamidase +FIG00443172 FIG00443175: hypothetical protein +FIG00443175 FIG00443178: hypothetical protein +FIG00443178 FIG00443180: hypothetical protein +FIG00443180 FIG00443183: hypothetical protein +FIG00443187 FIG00443189: hypothetical protein +FIG00443192 FIG00443194: hypothetical protein +FIG00443200 Mg(2+) transport ATPase protein C +FIG00443201 FIG00443202: hypothetical protein +FIG00443209 Bll4385 protein +FIG00443211 FIG00443212: hypothetical protein +FIG00443213 bsl1473; hypothetical protein +FIG00443222 Sterol binding protein +FIG00443232 FIG00443233: hypothetical protein +FIG00443233 FIG00443234: hypothetical protein +FIG00443242 FIG00443246: hypothetical protein +FIG00443246 FIG00443247: hypothetical protein +FIG00443247 FIG00443249: hypothetical protein +FIG00443249 Bll6168 protein +FIG00443250 FIG018171: hypothetical protein of Cupin superfamily +FIG00443253 Ribonuclease +FIG00443256 FIG00443258: hypothetical protein +FIG00443274 FIG00443276: hypothetical protein +FIG00443277 FIG00443283: hypothetical protein +FIG00443284 Type IV secretory pathway, VirD2 components (relaxase) +FIG00443294 2-dehydro-3-deoxyphosphogalactonate aldolase (EC 4.1.2.21) (6-phospho-2-dehydro-3-deoxygalactonate aldolase) (2- oxo-3-deoxygalactonate 6-phosphate aldolase) / Galactonate dehydratase (EC 4.2.1.6) +FIG00443306 FIG00443311: hypothetical protein +FIG00443313 FIG00443316: hypothetical protein +FIG00443317 FIG00443320: hypothetical protein +FIG00443320 FIG00443325: hypothetical protein +FIG00443330 FIG00443331: hypothetical protein +FIG00443331 FIG00443334: hypothetical protein +FIG00443334 FIG00443335: hypothetical protein +FIG00443353 FIG00443355: hypothetical protein +FIG00443355 FIG00443357: hypothetical protein +FIG00443362 bll5454; hypothetical protein +FIG00443363 FIG00443364: hypothetical protein +FIG00443364 FIG00443370: hypothetical protein +FIG00443370 FIG00443371: hypothetical protein +FIG00443371 putative exported protein of unknown function +FIG00443376 FIG00443378: hypothetical protein +FIG00443378 FIG00443381: hypothetical protein +FIG00443381 FIG00443382: hypothetical protein +FIG00443385 FIG00443388: hypothetical protein +FIG00443403 FIG00443404: hypothetical protein +FIG00443404 FIG00443409: hypothetical protein +FIG00443426 FOG: WD40-like repeat +FIG00443434 FIG00443435: hypothetical protein +FIG00443439 FIG00443442: hypothetical protein +FIG00443449 FIG00443450: hypothetical protein +FIG00443450 FIG00443453: hypothetical protein +FIG00443458 FIG00443459: hypothetical protein +FIG00443465 FIG00443467: hypothetical protein +FIG00443467 FIG00443469: hypothetical protein +FIG00443477 FIG00443480: hypothetical protein +FIG00443482 Protocatechuate 3,4-Dioxygenase beta chain (EC 1.13.11.3) +FIG00443484 FIG00443488: hypothetical protein +FIG00443488 FIG00443492: hypothetical protein +FIG00443492 FIG00443496: hypothetical protein +FIG00443496 Similarities with probable transcriptional regulator LumQ +FIG00443505 FIG00443514: hypothetical protein +FIG00443523 FIG00443524: hypothetical protein +FIG00443530 FIG00443531: hypothetical protein +FIG00443531 flagellar FlbT +FIG00443542 FIG00443543: hypothetical protein +FIG00443545 FIG00443546: hypothetical protein +FIG00443551 FIG00443552: hypothetical protein +FIG00443559 FIG00443564: hypothetical protein +FIG00443571 FIG00443572: hypothetical protein +FIG00443572 FIG00443573: hypothetical protein +FIG00443573 putative exported protein of unknown function with calcium-binding domain +FIG00443577 FIG00443579: hypothetical protein +FIG00443590 bll0558; unknown protein +FIG00443597 bll6640; hypothetical protein +FIG00443600 conserved hypothetical protein (putative granule-associated protein) +FIG00443605 FIG00443606: hypothetical protein +FIG00443609 FIG00443610: hypothetical protein +FIG00443610 Bll0096 protein +FIG00443615 FIG00443616: hypothetical protein +FIG00443616 Epoxide hydrolase +FIG00443623 Mll1762 protein +FIG00443632 FIG00443633: hypothetical protein +FIG00443633 FIG00443637: hypothetical protein +FIG00443648 6-hydroxynicotinate reductase (EC 1.3.7.1) +FIG00443654 FIG00443655: hypothetical protein +FIG00443658 Hpt domain +FIG00443659 FIG00443663: hypothetical protein +FIG00443678 FIG00443685: hypothetical protein +FIG00443687 FIG00443690: hypothetical protein +FIG00443690 FIG00443692: hypothetical protein +FIG00443696 putative MutT/nudix family protein +FIG00443697 FIG00443699: hypothetical protein +FIG00443699 FIG00443700: hypothetical protein +FIG00443706 FIG00443709: hypothetical protein +FIG00443709 Bll7976 protein +FIG00443717 FIG00443718: hypothetical protein +FIG00443719 FIG00443722: hypothetical protein +FIG00443722 Possible sugar kinase +FIG00443726 FIG00443729: hypothetical protein +FIG00443750 FIG00443752: hypothetical protein +FIG00443773 Arginine-tRNA-protein transferase (EC 2.3.2.8) +FIG00443780 FIG00443782: hypothetical protein +FIG00443790 Mlr2967 protein +FIG00443814 FIG00443815: hypothetical protein +FIG00443815 FIG00443816: hypothetical protein +FIG00443817 conserved hypothetical protein; putative dioxygenase +FIG00443818 FIG00443820: hypothetical protein +FIG00443820 FIG00443821: hypothetical protein +FIG00443821 FIG00443822: hypothetical protein +FIG00443823 FIG00443826: hypothetical protein +FIG00443826 FIG00443827: hypothetical protein +FIG00443832 FIG00852398: hypothetical protein +FIG00443842 FIG00443848: hypothetical protein +FIG00443849 FIG00443850: hypothetical protein +FIG00443851 FIG00443857: hypothetical protein +FIG00443857 FIG00443862: hypothetical protein +FIG00443862 FIG00443863: hypothetical protein +FIG00443874 FIG00443876: hypothetical protein +FIG00443876 putative Thioredoxin (H-type,TRX-H) +FIG00443882 FIG00443883: hypothetical protein +FIG00443883 FIG00443886: hypothetical protein +FIG00443886 FIG00443888: hypothetical protein +FIG00443888 ABC-type transport system involved in resistance to organic solvents, periplasmic component +FIG00443889 Luciferase-like +FIG00443893 FIG00443897: hypothetical protein +FIG00443897 FIG00443898: hypothetical protein +FIG00443915 conserved hypothetical protein; putative histidine-containing phosphotransfer domain, HPT domain +FIG00443952 FIG00443953: hypothetical protein +FIG00443955 putative glutamine synthetase translation inhibitor +FIG00443973 FIG00443974: hypothetical protein +FIG00443974 FIG00443976: hypothetical protein +FIG00443976 FIG00853462: hypothetical protein +FIG00443979 FIG00443980: hypothetical protein +FIG00443982 Copper resistance protein CopC +FIG00443986 FIG00443989: hypothetical protein +FIG00443989 FIG00443992: hypothetical protein +FIG00443992 FIG00443996: hypothetical protein +FIG00444003 FIG00444004: hypothetical protein +FIG00444004 bll6633; unknown protein +FIG00444006 FIG00444009: hypothetical protein +FIG00444009 FIG00444011: hypothetical protein +FIG00444011 FIG00444012: hypothetical protein +FIG00444019 FIG00444023: hypothetical protein +FIG00444060 FIG00444062: hypothetical protein +FIG00444073 FIG00444077: hypothetical protein +FIG00444077 FIG00444079: hypothetical protein +FIG00444079 flavin reductase domain protein FMN-binding +FIG00444100 Branched-chain amino acid transport ATP-binding protein livG (TC 3.A.1.4.1) +FIG00444118 FIG00444121: hypothetical protein +FIG00444121 FIG00444123: hypothetical protein +FIG00444123 Lipid A biosynthesis-like protein +FIG00444125 FIG00444127: hypothetical protein +FIG00444127 PROBABLE INTRACELLULAR SEPTATION PROTEIN +FIG00444131 FIG00444136: hypothetical protein +FIG00444139 FIG00444140: hypothetical protein +FIG00444144 FIG00444146: hypothetical protein +FIG00444147 FIG00444149: hypothetical protein +FIG00444149 Putative two component-response regulator receiver (CheY-like protein) +FIG00444152 FIG00444156: hypothetical protein +FIG00444167 SirA-like +FIG00444175 FIG00444176: hypothetical protein +FIG00444176 FIG00444179: hypothetical protein +FIG00444180 FIG00444181: hypothetical protein +FIG00444196 FIG00444197: hypothetical protein +FIG00444197 FIG00444203: hypothetical protein +FIG00444210 FIG00444212: hypothetical protein +FIG00444213 FIG00444214: hypothetical protein +FIG00444233 FIG00444234: hypothetical protein +FIG00444234 FIG00444235: hypothetical protein +FIG00444235 FIG00444239: hypothetical protein +FIG00444240 Bll4147 protein +FIG00444242 FIG00444243: hypothetical protein +FIG00444243 FIG00444247: hypothetical protein +FIG00444248 FIG00444249: hypothetical protein +FIG00444254 FIG00444255: hypothetical protein +FIG00444255 FIG00444258: hypothetical protein +FIG00444258 FIG00444260: hypothetical protein +FIG00444267 FIG00444269: hypothetical protein +FIG00444283 FIG00444284: hypothetical protein +FIG00444284 FIG00444286: hypothetical protein +FIG00444291 FIG00444295: hypothetical protein +FIG00444296 FIG00444297: hypothetical protein +FIG00444297 FIG00444299: hypothetical protein +FIG00444306 bll4315; putative O-antigen export system ATP-binding protein homolog +FIG00444328 FIG00444331: hypothetical protein +FIG00444340 FIG00444342: hypothetical protein +FIG00444344 FIG00444345: hypothetical protein +FIG00444347 FIG00444358: hypothetical protein +FIG00444359 putative hydrolase( EC:3.- ) +FIG00444360 FIG01261915: hypothetical protein +FIG00444377 FIG00444379: hypothetical protein +FIG00444379 FIG00444381: hypothetical protein +FIG00444383 FIG00444384: hypothetical protein +FIG00444384 FIG00444386: hypothetical protein +FIG00444394 FIG00444396: hypothetical protein +FIG00444409 FIG00444414: hypothetical protein +FIG00444419 FIG00444421: hypothetical protein +FIG00444421 Response regulator receiver:ATP-binding region, ATPase-like:Histidine kinase A, N-terminal +FIG00444442 FIG00444443: hypothetical protein +FIG00444443 FIG00444445: hypothetical protein +FIG00444445 FIG00444446: hypothetical protein +FIG00444447 FIG00444449: hypothetical protein +FIG00444455 putative ABC-type branched-chain amino acid transporter (substrate binding protein) +FIG00444463 FIG00444465: hypothetical protein +FIG00444477 FIG00444478: hypothetical protein +FIG00444479 FIG00444480: hypothetical protein +FIG00444483 FIG00444485: hypothetical protein +FIG00444503 FIG00463570: hypothetical protein +FIG00444509 FIG00444512: hypothetical protein +FIG00444516 FIG00444517: hypothetical protein +FIG00444526 FIG00444528: hypothetical protein +FIG00444534 FIG00444535: hypothetical protein +FIG00444535 FIG00444536: hypothetical protein +FIG00444546 FIG00444549: hypothetical protein +FIG00444550 FIG00444555: hypothetical protein +FIG00444557 FIG00444565: hypothetical protein +FIG00444565 Amidase family protein bll0246 +FIG00444570 FIG00444571: hypothetical protein +FIG00444576 FIG00444582: hypothetical protein +FIG00444589 FIG00444594: hypothetical protein +FIG00444596 Ergothioneine biosynthesis protein EgtB +FIG00444613 FIG00444614: hypothetical protein +FIG00444614 Integrase /recombinase +FIG00444624 FIG00444626: hypothetical protein +FIG00444634 Uncharacterized protein y4eB +FIG00444660 FIG01006880: hypothetical protein +FIG00444664 protein of unknown function DUF463, YcjX-like protein +FIG00444672 FIG00444673: hypothetical protein +FIG00444675 FIG00444682: hypothetical protein +FIG00444686 FIG00444689: hypothetical protein +FIG00444699 FIG00444700: hypothetical protein +FIG00444701 FIG00444702: hypothetical protein +FIG00444703 FIG00444705: hypothetical protein +FIG00444705 FIG00444708: hypothetical protein +FIG00444722 FIG00444725: hypothetical protein +FIG00444746 tRNA dihydrouridine synthase A +FIG00444749 putative exopolysaccharide production protein +FIG00444762 FIG00444763: hypothetical protein +FIG00444766 Bll0679 protein +FIG00444768 FIG00444769: hypothetical protein +FIG00444769 FIG00444770: hypothetical protein +FIG00444788 FIG00444789: hypothetical protein +FIG00444790 FIG00444791: hypothetical protein +FIG00444808 FIG00444811: hypothetical protein +FIG00444811 FIG00444813: hypothetical protein +FIG00444817 FIG00444819: hypothetical protein +FIG00444823 FIG00444824: hypothetical protein +FIG00444824 FIG00444827: hypothetical protein +FIG00444832 FIG00444833: hypothetical protein +FIG00444870 FIG00444871: hypothetical protein +FIG00444871 FIG139438: lipoprotein B +FIG00444880 FIG00444883: hypothetical protein +FIG00444887 FIG00444890: hypothetical protein +FIG00444891 FIG00444893: hypothetical protein +FIG00444905 FIG00444907: hypothetical protein +FIG00444907 FIG00444910: hypothetical protein +FIG00444921 FIG00444922: hypothetical protein +FIG00444922 Polysaccharide biosynthesis associated protein +FIG00444931 FIG00444932: hypothetical protein +FIG00444940 FIG00444942: hypothetical protein +FIG00444944 FIG00444948: hypothetical protein +FIG00444948 FIG00444949: hypothetical protein +FIG00444958 FIG00444959: hypothetical protein +FIG00444966 FIG00444967: hypothetical protein +FIG00444968 Carboxynorspermidine dehydrogenase +FIG00444969 FIG00444970: hypothetical protein +FIG00444984 FIG00444988: hypothetical protein +FIG00445008 FIG01004535: hypothetical protein +FIG00445009 FIG00445010: hypothetical protein +FIG00445022 HTH-type transcriptional regulator PetP +FIG00445026 conserved hypothetical protein; putative secreted protein +FIG00445031 conserved hypothetical protein; putative NUDIX hydrolase +FIG00445038 FIG00445044: hypothetical protein +FIG00445053 FIG166913: hypothetical protein +FIG00445055 FIG00445056: hypothetical protein +FIG00445063 FIG00445064: hypothetical protein +FIG00445068 FIG00445075: hypothetical protein +FIG00445076 FIG00445077: hypothetical protein +FIG00445082 FIG00445083: hypothetical protein +FIG00445090 putative ATPase, AAA family +FIG00445107 FIG00445110: hypothetical protein +FIG00445112 FIG00445113: hypothetical protein +FIG00445113 FIG00445122: hypothetical protein +FIG00445129 FIG00445133: hypothetical protein +FIG00445137 FIG00445140: hypothetical protein +FIG00445151 FIG00445153: hypothetical protein +FIG00445153 FIG00445156: hypothetical protein +FIG00445157 FIG00445162: hypothetical protein +FIG00445187 possible signal peptide protein +FIG00445198 FIG00445200: hypothetical protein +FIG00445224 FIG00445225: hypothetical protein +FIG00445225 FIG00445226: hypothetical protein +FIG00445240 FIG00445245: hypothetical protein +FIG00445245 FIG00445246: hypothetical protein +FIG00445249 FIG00445250: hypothetical protein +FIG00445258 FIG00445265: hypothetical protein +FIG00445269 FIG00445271: hypothetical protein +FIG00445271 FIG00445272: hypothetical protein +FIG00445276 FIG00445279: hypothetical protein +FIG00445279 FIG00445281: hypothetical protein +FIG00445283 FIG00445285: hypothetical protein +FIG00445293 FIG00445296: hypothetical protein +FIG00445297 FIG00445299: hypothetical protein +FIG00445316 FIG00445317: hypothetical protein +FIG00445317 FIG00445324: hypothetical protein +FIG00445324 FIG00445335: hypothetical protein +FIG00445337 FIG00445338: hypothetical protein +FIG00445344 FIG00445347: hypothetical protein +FIG00445369 FIG00445370: hypothetical protein +FIG00445371 FIG00445377: hypothetical protein +FIG00445401 FIG00445402: hypothetical protein +FIG00445408 FIG00445410: hypothetical protein +FIG00445431 FIG00445432: hypothetical protein +FIG00445432 FIG00445435: hypothetical protein +FIG00445448 FIG00445454: hypothetical protein +FIG00445477 FIG00445478: hypothetical protein +FIG00445482 TOMM biosynthesis dehydrogenase (protein B) +FIG00445506 FIG00445513: hypothetical protein +FIG00445528 FIG00445529: hypothetical protein +FIG00445541 FIG00445542: hypothetical protein +FIG00445544 FIG00445547: hypothetical protein +FIG00445559 FIG00983977: hypothetical protein +FIG00445577 FIG00445578: hypothetical protein +FIG00445578 FIG00445582: hypothetical protein +FIG00445582 FIG00445584: hypothetical protein +FIG00445584 Bll6428 protein +FIG00445597 Bll4295 protein +FIG00445609 FIG00445611: hypothetical protein +FIG00445611 FAD binding domain protein +FIG00445616 probable ABC transporter substrate-binding protein +FIG00445622 FIG00445623: hypothetical protein +FIG00445627 FIG00445630: hypothetical protein +FIG00445640 FIG00445641: hypothetical protein +FIG00445641 FIG00445645: hypothetical protein +FIG00445655 FIG00445662: hypothetical protein +FIG00445662 FIG00445664: hypothetical protein +FIG00445674 FIG00445680: hypothetical protein +FIG00445682 FIG01024405: hypothetical protein +FIG00445722 FIG00445732: hypothetical protein +FIG00445736 FIG00445738: hypothetical protein +FIG00445753 probable outer membrane protein B +FIG00445780 Oxidoreductase, short chain dehydrogenase/reductase family +FIG00445790 hypothetical protein; putative His Kinase A domain +FIG00445807 FIG00445811: hypothetical protein +FIG00445822 FIG00445824: hypothetical protein +FIG00445835 FIG00445838: hypothetical protein +FIG00445840 InterPro IPR001687:IPR003439:IPR003593 COGs COG0410 +FIG00445845 FIG00445847: hypothetical protein +FIG00445858 blr5788; hypothetical protein +FIG00445870 FIG00445872: hypothetical protein +FIG00445890 FIG00445893: hypothetical protein +FIG00445905 FIG00445907: hypothetical protein +FIG00445923 INTEGRAL MEMBRANE PROTEIN (Rhomboid family) +FIG00445925 FIG00445926: hypothetical protein +FIG00445927 FIG00445928: hypothetical protein +FIG00445970 FIG00445975: hypothetical protein +FIG00445981 FIG00445991: hypothetical protein +FIG00445998 FIG00446004: hypothetical protein +FIG00446004 FIG00446006: hypothetical protein +FIG00446006 FIG00446009: hypothetical protein +FIG00446009 FIG00446011: hypothetical protein +FIG00446015 FIG00446020: hypothetical protein +FIG00446023 FIG00446024: hypothetical protein +FIG00446033 FIG00450953: hypothetical protein +FIG00446036 FIG00446037: hypothetical protein +FIG00446080 bll7240; hypothetical protein +FIG00446109 FIG00446118: hypothetical protein +FIG00446120 FIG00446123: hypothetical protein +FIG00446123 FIG00446125: hypothetical protein +FIG00446133 6-aminohexanoate-dimer hydrolase (EC 3.5.1.46) (Nylon oligomers-degrading enzyme EII) +FIG00446134 FIG00446140: hypothetical protein +FIG00446155 FIG00446156: hypothetical protein +FIG00446156 FIG00446161: hypothetical protein +FIG00446179 FIG01004290: hypothetical protein +FIG00446185 VapB protein (antitoxin to VapC) +FIG00446218 bll5766; hypothetical protein +FIG00446236 putative Transcriptional regulatory protein, TetR family +FIG00446240 FIG00446242: hypothetical protein +FIG00446260 FIG00446264: hypothetical protein +FIG00446301 FIG00446302: hypothetical protein +FIG00446308 FIG00446309: hypothetical protein +FIG00446320 Mll2313 protein +FIG00446328 FIG00446329: hypothetical protein +FIG00446413 Probable transmembrane protein precursor +FIG00446425 FIG00446426: hypothetical protein +FIG00446426 FIG00446429: hypothetical protein +FIG00446429 FIG00446431: hypothetical protein +FIG00446431 Putative stomatin/prohibitin-family membrane protease subunit PA4582 +FIG00446437 FIG00446439: hypothetical protein +FIG00446448 FIG00446451: hypothetical protein +FIG00446458 FIG00446462: hypothetical protein +FIG00446463 FIG00446465: hypothetical protein +FIG00446468 FIG00446471: hypothetical protein +FIG00446481 Poly(3-hydroxyalkanoate) synthetase +FIG00446485 FIG00446486: hypothetical protein +FIG00446489 FIG00446490: hypothetical protein +FIG00446512 FIG00446515: hypothetical protein +FIG00446523 similar to nuclease +FIG00446547 FIG00446552: hypothetical protein +FIG00446552 FIG00446553: hypothetical protein +FIG00446553 FIG00446558: hypothetical protein +FIG00446585 RTX toxin activating lysine-acyltransferase (EC 2.3.1.-) +FIG00446586 FIG00446590: hypothetical protein +FIG00446590 FIG00446593: hypothetical protein +FIG00446593 FIG00446594: hypothetical protein +FIG00446601 FIG00446604: hypothetical protein +FIG00446615 FIG00446617: hypothetical protein +FIG00446618 GcrA cell cycle regulator +FIG00446640 FIG00446645: hypothetical protein +FIG00446645 FIG00446651: hypothetical protein +FIG00446658 FIG00446659: hypothetical protein +FIG00446664 Retron-type RNA-directed DNA polymerase (EC 2.7.7.49) +FIG00446681 FIG00446684: hypothetical protein +FIG00446716 FIG00446717: hypothetical protein +FIG00446784 Branched-chain amino acid transport system permease protein LivM / Branched-chain amino acid transport atp-binding protein LivG +FIG00446790 FIG00446791: hypothetical protein +FIG00446813 Mlr2494 protein +FIG00446865 FIG00446866: hypothetical protein +FIG00446916 FIG00446917: hypothetical protein +FIG00446929 Metal dependent phosphohydrolase with a response regulator receiver domain +FIG00446985 FIG01075795: hypothetical protein +FIG00446996 FIG00446999: hypothetical protein +FIG00446999 putative diguanylate cyclase (GGDEF)/phosphodiesterase (EAL) with PAS domains +FIG00447017 bll1202; hypothetical protein +FIG00447026 FIG00447027: hypothetical protein +FIG00447027 similar to flavohemoprotein +FIG00447029 FIG00447030: hypothetical protein +FIG00447031 blr2472; unknown protein +FIG00447057 FIG01005307: hypothetical protein +FIG00447082 FIG00447085: hypothetical protein +FIG00447092 FIG00447107: hypothetical protein +FIG00447142 FIG00447151: hypothetical protein +FIG00447182 FIG00447185: hypothetical protein +FIG00447195 FIG00447197: hypothetical protein +FIG00447255 FIG00447258: hypothetical protein +FIG00447270 FIG00447271: hypothetical protein +FIG00447280 bll3990; hypothetical protein +FIG00447309 bll7572; unknown protein +FIG00447512 InterPro IPR001258 +FIG00447542 FIG00447547: hypothetical protein +FIG00447560 FIG00447562: hypothetical protein +FIG00447566 FIG00447567: hypothetical protein +FIG00447567 FIG00447568: hypothetical protein +FIG00447572 FIG00447574: hypothetical protein +FIG00447614 FIG00447615: hypothetical protein +FIG00447620 COG0308: Aminopeptidase N +FIG00447624 ATP/GTP-binding integral membrane protein +FIG00447680 FIG00447681: hypothetical protein +FIG00447684 Na(+) H(+) antiporter subunit E +FIG00447698 FIG00447700: hypothetical protein +FIG00447700 COG1579: Zn-ribbon protein, possibly nucleic acid-binding +FIG00447703 COG0542: ATPases with chaperone activity, ATP-binding subunit +FIG00447715 FIG00447718: hypothetical protein +FIG00447718 FIG00447721: hypothetical protein +FIG00447723 FIG00447729: hypothetical protein +FIG00447744 FIG056164: rhomboid family serine protease +FIG00447746 FIG00447747: hypothetical protein +FIG00447756 FIG00447758: hypothetical protein +FIG00447767 FIG00724315: hypothetical protein +FIG00447769 Two component response regulator MppU +FIG00447782 FIG00447785: hypothetical protein +FIG00447785 Transcriptional regulatory protein +FIG00447795 FIG00447797: hypothetical protein +FIG00447797 Amidase (EC 3.5.1.4) +FIG00447798 FIG00447800: hypothetical protein +FIG00447803 FIG00447805: hypothetical protein +FIG00447826 FIG00447829: hypothetical protein +FIG00447829 PROBABLE MACROLIDE-TRANSPORT ATP-BINDING PROTEIN ABC TRANSPORTER +FIG00447836 FIG024784: Integral membrane protein related to pyrimidine synthesis +FIG00447840 FIG00447841: hypothetical protein +FIG00447854 FIG00447856: hypothetical protein +FIG00447856 FIG00447858: hypothetical protein +FIG00447876 FIG00447877: hypothetical protein +FIG00447877 FIG00447880: hypothetical protein +FIG00447883 FIG00447884: hypothetical protein +FIG00447890 FIG00447899: hypothetical protein +FIG00447927 FIG00447931: hypothetical protein +FIG00447931 FIG00447935: hypothetical protein +FIG00447967 FIG00447970: hypothetical protein +FIG00447970 FIG00447971: hypothetical protein +FIG00447971 FIG00447973: hypothetical protein +FIG00447994 GTP cyclohydrolase II (EC 3.5.4.25) / 5-amino-6-(5-phosphoribosylamino)uracil reductase (EC 1.1.1.193) +FIG00448013 FIG00448014: hypothetical protein +FIG00448025 Putative p-aminobenzoyl-glutamate transporter +FIG00448044 FIG00390190: hypothetical protein +FIG00448046 FIG00448048: hypothetical protein +FIG00448059 Probable cytochrome c oxidase polypeptide IV (EC 1.9.3.1) +FIG00448067 FIG00448077: hypothetical protein +FIG00448087 FIG00448090: hypothetical protein +FIG00448090 FIG00448094: hypothetical protein +FIG00448094 FIG00448096: hypothetical protein +FIG00448096 FIG00448097: hypothetical protein +FIG00448097 FIG00448100: hypothetical protein +FIG00448100 FIG00448105: hypothetical protein +FIG00448105 putative esterase/lipase [EC:3.1.1.1] +FIG00448112 FIG00448114: hypothetical protein +FIG00448122 FIG00448123: hypothetical protein +FIG00448123 FIG00448126: hypothetical protein +FIG00448135 FIG00448137: hypothetical protein +FIG00448152 FIG00448161: hypothetical protein +FIG00448167 FIG00448168: hypothetical protein +FIG00448168 FIG00448172: hypothetical protein +FIG00448175 Transcriptional regulator, LytR family +FIG00448180 FIG00448187: hypothetical protein +FIG00448193 COG0681: Signal peptidase I +FIG00448206 FIG00448212: hypothetical protein +FIG00448219 FIG00448220: hypothetical protein +FIG00448228 FIG00448232: hypothetical protein +FIG00448236 COG2062: Phosphohistidine phosphatase SixA +FIG00448237 FIG00448238: hypothetical protein +FIG00448267 FIG00448270: hypothetical protein +FIG00448271 FIG00448272: hypothetical protein +FIG00448288 FIG00448289: hypothetical protein +FIG00448295 Histone protein Lsr2 +FIG00448297 FIG00448298: hypothetical protein +FIG00448304 Tryptophan-associated membrane protein +FIG00448309 FIG00448319: hypothetical protein +FIG00448327 4Fe-4S ferredoxin, iron-sulfur binding +FIG00448405 FIG00448407: hypothetical protein +FIG00448413 Transcriptional regulator, GlnR family +FIG00448421 Mrp protein homolog +FIG00448426 FIG00448427: hypothetical protein +FIG00448429 RRNA methylase family protein +FIG00448435 FIG00448437: hypothetical protein +FIG00448437 FIG00448439: hypothetical protein +FIG00448441 membrane-flanked domain +FIG00448449 FIG00448453: hypothetical protein +FIG00448462 FIG00448465: hypothetical protein +FIG00448465 FIG00448468: hypothetical protein +FIG00448472 FIG00448475: hypothetical protein +FIG00448501 FIG00448504: hypothetical protein +FIG00448532 FIG00448535: hypothetical protein +FIG00448541 ABC-2:Amidohydrolase +FIG00448548 FIG00448550: hypothetical protein +FIG00448550 FIG00448553: hypothetical protein +FIG00448568 FIG00448572: hypothetical protein +FIG00448572 FIG00448573: hypothetical protein +FIG00448592 FIG00448593: hypothetical protein +FIG00448593 Possible DO serine protease +FIG00448600 FIG00448603: hypothetical protein +FIG00448628 FIG00448629: hypothetical protein +FIG00448629 FIG00448633: hypothetical protein +FIG00448641 FIG00448642: hypothetical protein +FIG00448642 helicase, putative +FIG00448679 Membrane spanning lipoprotein +FIG00448687 FIG00448688: hypothetical protein +FIG00448688 COG0120: Ribose 5-phosphate isomerase +FIG00448705 FIG00448706: hypothetical protein +FIG00448713 FIG00448714: hypothetical protein +FIG00448724 FIG00448729: hypothetical protein +FIG00448729 FIG00448736: hypothetical protein +FIG00448745 FIG00448749: hypothetical protein +FIG00448749 FIG00448754: hypothetical protein +FIG00448754 FIG00448757: hypothetical protein +FIG00448775 FIG00448778: hypothetical protein +FIG00448778 FIG00448779: hypothetical protein +FIG00448797 FIG00820627: hypothetical protein +FIG00448809 FIG00448815: hypothetical protein +FIG00448847 Probable transmembrane transport protein +FIG00448849 FIG00448855: hypothetical protein +FIG00448859 FIG00448863: hypothetical protein +FIG00448863 Nucleotidyltransferase domain protein +FIG00448895 FIG00448897: hypothetical protein +FIG00448899 FIG00448906: hypothetical protein +FIG00448906 FIG00448908: hypothetical protein +FIG00448911 FIG00448912: hypothetical protein +FIG00448912 Acyl-coenzyme A synthetases/AMP-(fatty) acid ligases +FIG00448933 FIG00448936: hypothetical protein +FIG00448944 Heat shock protein 22.5 (Hsp22.5) +FIG00448961 FIG00448967: hypothetical protein +FIG00448992 FIG00448994: hypothetical protein +FIG00449016 FIG00449020: hypothetical protein +FIG00449020 FIG00449025: hypothetical protein +FIG00449044 FIG00449048: hypothetical protein +FIG00449127 FIG00449129: hypothetical protein +FIG00449149 FIG00449150: hypothetical protein +FIG00449193 FIG00449195: hypothetical protein +FIG00449199 FIG00449204: hypothetical protein +FIG00449221 FIG00449238: hypothetical protein +FIG00449259 FIG00449260: hypothetical protein +FIG00449267 Multidrug ABC transporter ATP-binding protein +FIG00449297 Similar to vanillate/3-O-methylgallate O-demethylase +FIG00449325 FIG00449326: hypothetical protein +FIG00449326 FIG00449327: hypothetical protein +FIG00449327 FIG00449328: hypothetical protein +FIG00449330 FIG00449332: hypothetical protein +FIG00449334 FIG004853: possible toxin to DivIC +FIG00449367 FIG027937: secreted protein +FIG00449380 hypothetical membrane-associated protein +FIG00449465 FIG00449467: hypothetical protein +FIG00449499 FIG00449502: hypothetical protein +FIG00449504 FIG00449505: hypothetical protein +FIG00449505 FIG00449506: hypothetical protein +FIG00449508 FIG00449511: hypothetical protein +FIG00449511 FIG00449512: hypothetical protein +FIG00449518 FIG00449520: hypothetical protein +FIG00449520 FIG00449521: hypothetical protein +FIG00449521 FIG00449522: hypothetical protein +FIG00449523 FIG00449524: hypothetical protein +FIG00449524 FIG00449525: hypothetical protein +FIG00449525 FIG00449526: hypothetical protein +FIG00449536 FIG00449537: hypothetical protein +FIG00449538 FIG00449539: hypothetical protein +FIG00449543 FIG00449544: hypothetical protein +FIG00449554 FIG00449556: hypothetical protein +FIG00449558 FIG00449559: hypothetical protein +FIG00449559 Hypothetical protein USSDB1E +FIG00449562 FIG00449563: hypothetical protein +FIG00449566 FIG00449567: hypothetical protein +FIG00449567 FIG00449570: hypothetical protein +FIG00449570 FIG00449571: hypothetical protein +FIG00449571 FIG00449573: hypothetical protein +FIG00449573 FIG00449574: hypothetical protein +FIG00449575 FIG00449576: hypothetical protein +FIG00449576 COG1896: Predicted hydrolases of HD superfamily +FIG00449581 FIG00449582: hypothetical protein +FIG00449584 FIG00449585: hypothetical protein +FIG00449586 FIG00449587: hypothetical protein +FIG00449587 FIG00449588: hypothetical protein +FIG00449588 FIG00449589: hypothetical protein +FIG00449589 FIG00449590: hypothetical protein +FIG00449590 protein of unknown function, Spy-related +FIG00449591 FIG00449592: hypothetical protein +FIG00449595 Phospholipase D/Transphosphatidylase +FIG00449597 FIG00449599: hypothetical protein +FIG00449599 FIG00449600: hypothetical protein +FIG00449611 FIG00449612: hypothetical protein +FIG00449612 FIG00449613: hypothetical protein +FIG00449613 FIG00449616: hypothetical protein +FIG00449616 FIG00449617: hypothetical protein +FIG00449619 FIG00449620: hypothetical protein +FIG00449620 FIG00449621: hypothetical protein +FIG00449626 FIG00449627: hypothetical protein +FIG00449627 FIG00449629: hypothetical protein +FIG00449629 FIG00449632: hypothetical protein +FIG00449633 FIG00449634: hypothetical protein +FIG00449635 FIG00449636: hypothetical protein +FIG00449638 FIG00449641: hypothetical protein +FIG00449641 FIG00449642: hypothetical protein +FIG00449642 FIG00449643: hypothetical protein +FIG00449643 FIG00449644: hypothetical protein +FIG00449644 FIG00449645: hypothetical protein +FIG00449646 FIG00449647: hypothetical protein +FIG00449647 FIG00449649: hypothetical protein +FIG00449649 FIG00449652: hypothetical protein +FIG00449653 FIG00449654: hypothetical protein +FIG00449654 FIG00449655: hypothetical protein +FIG00449660 FIG00449661: hypothetical protein +FIG00449664 FIG00449665: hypothetical protein +FIG00449666 FIG00449669: hypothetical protein +FIG00449670 FIG00449671: hypothetical protein +FIG00449671 LysE family translocator, putative +FIG00449672 FIG00449673: hypothetical protein +FIG00449674 FIG00449676: hypothetical protein +FIG00449680 FIG00449681: hypothetical protein +FIG00449681 FIG00449682: hypothetical protein +FIG00449682 FIG00449684: hypothetical protein +FIG00449687 FIG00449688: hypothetical protein +FIG00449691 FIG00449692: hypothetical protein +FIG00449694 FIG00449695: hypothetical protein +FIG00449706 FIG00449709: hypothetical protein +FIG00449709 FIG00449711: hypothetical protein +FIG00449711 FIG00449713: hypothetical protein +FIG00449713 FIG00449715: hypothetical protein +FIG00449720 FIG00449723: hypothetical protein +FIG00449725 FIG00449729: hypothetical protein +FIG00449729 FIG00449731: hypothetical protein +FIG00449732 FIG00449733: hypothetical protein +FIG00449733 FIG00449737: hypothetical protein +FIG00449737 FIG00449738: hypothetical protein +FIG00449738 FIG00449739: hypothetical protein +FIG00449739 FIG00449740: hypothetical protein +FIG00449761 FIG00449762: hypothetical protein +FIG00449763 FIG00449765: hypothetical protein +FIG00449765 FIG00449766: hypothetical protein +FIG00449770 FIG00449771: hypothetical protein +FIG00449771 FIG00449773: hypothetical protein +FIG00449776 FIG00449777: hypothetical protein +FIG00449778 FIG00449780: hypothetical protein +FIG00449783 FIG00449784: hypothetical protein +FIG00449784 FIG00449785: hypothetical protein +FIG00449785 FIG00449788: hypothetical protein +FIG00449788 FIG00449789: hypothetical protein +FIG00449789 FIG00449792: hypothetical protein +FIG00449793 prepilin peptidase +FIG00449802 FIG00449803: hypothetical protein +FIG00449805 FIG00449806: hypothetical protein +FIG00449809 L-rhamnose-1-dehydrogenase ( EC 1.1.1.173) +FIG00449810 FIG00449811: hypothetical protein +FIG00449811 FIG00449812: hypothetical protein +FIG00449815 FIG00449816: hypothetical protein +FIG00449820 Peptidase M15B and M15C, D,D-carboxypeptidase VanY/endolysins +FIG00449822 FIG00449823: hypothetical protein +FIG00449824 FIG00449825: hypothetical protein +FIG00449833 FIG00449835: hypothetical protein +FIG00449835 FIG00449836: hypothetical protein +FIG00449837 FIG00449838: hypothetical protein +FIG00449841 FIG00449842: hypothetical protein +FIG00449842 FIG00449844: hypothetical protein +FIG00449845 FIG00449847: hypothetical protein +FIG00449847 FIG00449848: hypothetical protein +FIG00449849 FIG00449853: hypothetical protein +FIG00449868 FIG00449870: hypothetical protein +FIG00449871 FIG00449873: hypothetical protein +FIG00449874 Mlr8507 protein +FIG00449878 FIG00449879: hypothetical protein +FIG00449879 FIG00449880: hypothetical protein +FIG00449880 Outer membrane lipoprotein OmlA +FIG00449885 FIG00449887: hypothetical protein +FIG00449889 FIG00449890: hypothetical protein +FIG00449892 FIG00449894: hypothetical protein +FIG00449894 FIG00449895: hypothetical protein +FIG00449895 FIG00449896: hypothetical protein +FIG00449897 FIG00449899: hypothetical protein +FIG00449899 FIG00449900: hypothetical protein +FIG00449901 FIG00449903: hypothetical protein +FIG00449903 FIG00449904: hypothetical protein +FIG00449904 FIG00449905: hypothetical protein +FIG00449911 ferredoxin-NADP reductase +FIG00449913 FIG00449916: hypothetical protein +FIG00449916 FIG00449917: hypothetical protein +FIG00449918 FIG00449919: hypothetical protein +FIG00449922 FIG00449924: hypothetical protein +FIG00449927 FIG00449928: hypothetical protein +FIG00449933 FIG00449934: hypothetical protein +FIG00449937 FIG00449939: hypothetical protein +FIG00449939 FIG00449940: hypothetical protein +FIG00449943 FIG00449944: hypothetical protein +FIG00449944 FIG00449945: hypothetical protein +FIG00449945 FIG00449947: hypothetical protein +FIG00449951 FIG00449953: hypothetical protein +FIG00449953 FIG00449954: hypothetical protein +FIG00449956 FIG00449957: hypothetical protein +FIG00449959 FIG00449960: hypothetical protein +FIG00449960 FIG00449961: hypothetical protein +FIG00449965 FIG00449966: hypothetical protein +FIG00449967 FIG00449970: hypothetical protein +FIG00449983 FIG00449984: hypothetical protein +FIG00449984 FIG00449986: hypothetical protein +FIG00449986 FIG00449987: hypothetical protein +FIG00449988 FIG00449990: hypothetical protein +FIG00449990 FIG00449992: hypothetical protein +FIG00449996 FIG00449997: hypothetical protein +FIG00449997 FIG00449998: hypothetical protein +FIG00449998 iron compound ABC transporter, periplasmic substrate-binding protein +FIG00449999 FIG00450000: hypothetical protein +FIG00450012 FIG00450013: hypothetical protein +FIG00450017 FIG00450019: hypothetical protein +FIG00450019 FIG00450021: hypothetical protein +FIG00450021 FIG00450022: hypothetical protein +FIG00450022 FIG00450023: hypothetical protein +FIG00450023 FIG00450024: hypothetical protein +FIG00450024 FIG00450025: hypothetical protein +FIG00450025 FIG00450026: hypothetical protein +FIG00450026 DeoR family transcriptional regulator probably related to glycerate, glycolaldehyde metabolism +FIG00450027 FIG00450029: hypothetical protein +FIG00450029 FIG00450030: hypothetical protein +FIG00450031 FIG00450034: hypothetical protein +FIG00450034 FIG00450035: hypothetical protein +FIG00450035 FIG00450037: hypothetical protein +FIG00450038 FIG00363499: hypothetical protein +FIG00450041 FIG00450042: hypothetical protein +FIG00450042 FIG00450044: hypothetical protein +FIG00450044 FIG00450045: hypothetical protein +FIG00450045 FIG00450046: hypothetical protein +FIG00450046 FIG00450047: hypothetical protein +FIG00450047 FIG00450049: hypothetical protein +FIG00450049 FIG00450050: hypothetical protein +FIG00450050 FIG00450051: hypothetical protein +FIG00450051 FIG00450052: hypothetical protein +FIG00450052 ATP/GTP-binding site motif A (P-loop) :Porin, alpha proteobacteria type +FIG00450053 FIG00450055: hypothetical protein +FIG00450054 FIG00450055: hypothetical protein +FIG00450055 FIG00450056: hypothetical protein +FIG00450056 FIG00450057: hypothetical protein +FIG00450057 FIG00450058: hypothetical protein +FIG00450058 FIG00450059: hypothetical protein +FIG00450060 FIG00450061: hypothetical protein +FIG00450061 Transcriptional regulator, LuxR family +FIG00450062 FIG00450063: hypothetical protein +FIG00450063 FIG00450064: hypothetical protein +FIG00450067 FIG00450068: hypothetical protein +FIG00450068 FIG00450069: hypothetical protein +FIG00450069 FIG00450070: hypothetical protein +FIG00450070 FIG00450071: hypothetical protein +FIG00450071 FIG00450072: hypothetical protein +FIG00450072 FIG00450073: hypothetical protein +FIG00450073 FIG00450074: hypothetical protein +FIG00450074 FIG00450075: hypothetical protein +FIG00450075 FIG00450076: hypothetical protein +FIG00450078 FIG00450080: hypothetical protein +FIG00450080 FIG00450081: hypothetical protein +FIG00450081 FIG00450082: hypothetical protein +FIG00450082 FIG00450083: hypothetical protein +FIG00450083 FIG00450084: hypothetical protein +FIG00450084 FIG00450086: hypothetical protein +FIG00450088 FIG00450089: hypothetical protein +FIG00450090 FIG00450091: hypothetical protein +FIG00450091 FIG00450092: hypothetical protein +FIG00450092 FIG00450093: hypothetical protein +FIG00450093 FIG00450095: hypothetical protein +FIG00450095 FIG00450096: hypothetical protein +FIG00450096 FIG00450097: hypothetical protein +FIG00450097 FIG00450098: hypothetical protein +FIG00450098 FIG00450099: hypothetical protein +FIG00450099 FIG00450100: hypothetical protein +FIG00450100 FIG00450101: hypothetical protein +FIG00450101 FIG00450102: hypothetical protein +FIG00450102 FIG00450103: hypothetical protein +FIG00450103 FIG00450106: hypothetical protein +FIG00450106 FIG00450107: hypothetical protein +FIG00450108 FIG00450109: hypothetical protein +FIG00450109 Iron compound ABC transporter, ATP-binding protein +FIG00450110 FIG00450111: hypothetical protein +FIG00450111 FIG00450112: hypothetical protein +FIG00450112 FIG00450113: hypothetical protein +FIG00450113 FIG00450114: hypothetical protein +FIG00450115 FIG00450116: hypothetical protein +FIG00450116 FIG00450118: hypothetical protein +FIG00450118 FIG00450121: hypothetical protein +FIG00450121 FIG00450122: hypothetical protein +FIG00450122 Pyridoxamine 5'-phosphate oxidase-related, FMN-binding +FIG00450123 FIG00450125: hypothetical protein +FIG00450126 FIG00450131: hypothetical protein +FIG00450131 FIG00450132: hypothetical protein +FIG00450132 Cis,cis-muconate transport protein MucK +FIG00450133 FIG00450134: hypothetical protein +FIG00450134 FIG00450135: hypothetical protein +FIG00450135 FIG00450136: hypothetical protein +FIG00450137 RidA/YER057c/UK114 superfamily, group 2, YoaB-like protein +FIG00450138 FIG00450139: hypothetical protein +FIG00450139 Lyzozyme M1 (1,4-beta-N-acetylmuramidase) (EC 3.2.1.17) +FIG00450141 FIG00450142: hypothetical protein +FIG00450142 FIG00450143: hypothetical protein +FIG00450143 FIG00450145: hypothetical protein +FIG00450145 FIG00450146: hypothetical protein +FIG00450148 FIG00450150: hypothetical protein +FIG00450151 Protein tyrosine phosphatases +FIG00450152 FIG00450153: hypothetical protein +FIG00450153 FIG00450155: hypothetical protein +FIG00450155 FIG00450156: hypothetical protein +FIG00450156 FIG00450157: hypothetical protein +FIG00450157 FIG00450158: hypothetical protein +FIG00450158 FIG00450161: hypothetical protein +FIG00450162 FIG00450163: hypothetical protein +FIG00450165 FIG00450166: hypothetical protein +FIG00450166 FIG00450168: hypothetical protein +FIG00450169 FIG00450170: hypothetical protein +FIG00450170 FIG00450171: hypothetical protein +FIG00450171 FIG00450172: hypothetical protein +FIG00450175 FIG00450176: hypothetical protein +FIG00450176 FIG00450177: hypothetical protein +FIG00450177 FIG00450178: hypothetical protein +FIG00450178 FIG00450180: hypothetical protein +FIG00450182 LysE type translocator +FIG00450183 FIG00450185: hypothetical protein +FIG00450185 FIG00450187: hypothetical protein +FIG00450187 hypothetical protein +FIG00450188 FIG00450189: hypothetical protein +FIG00450189 FIG00450192: hypothetical protein +FIG00450193 FIG00450194: hypothetical protein +FIG00450194 FIG00450195: hypothetical protein +FIG00450195 FIG00450196: hypothetical protein +FIG00450197 FIG00450198: hypothetical protein +FIG00450198 FIG00450199: hypothetical protein +FIG00450200 FIG01306803: hypothetical protein +FIG00450202 FIG00450203: hypothetical protein +FIG00450203 FIG00450204: hypothetical protein +FIG00450204 FIG00450205: hypothetical protein +FIG00450205 FIG00450206: hypothetical protein +FIG00450206 FIG00450207: hypothetical protein +FIG00450207 FIG00450208: hypothetical protein +FIG00450210 FIG00450211: hypothetical protein +FIG00450211 FIG00450213: hypothetical protein +FIG00450213 FIG00450214: hypothetical protein +FIG00450214 FIG00450216: hypothetical protein +FIG00450219 Nitrogen regulation protein NtrC +FIG00450220 Peptidase, U32 family +FIG00450223 FIG00450224: hypothetical protein +FIG00450224 FIG00984811: hypothetical protein +FIG00450226 FIG00450228: hypothetical protein +FIG00450228 FIG00450229: hypothetical protein +FIG00450229 FIG00450230: hypothetical protein +FIG00450231 Biphenyl-2,3-diol 1,2-dioxygenase III (EC 1.13.11.39) +FIG00450233 FIG00450235: hypothetical protein +FIG00450235 FIG00450237: hypothetical protein +FIG00450238 FIG00450240: hypothetical protein +FIG00450240 FIG00450243: hypothetical protein +FIG00450243 FIG00450244: hypothetical protein +FIG00450244 FIG00450246: hypothetical protein +FIG00450246 FIG00450247: hypothetical protein +FIG00450249 FIG00450251: hypothetical protein +FIG00450251 FIG00450252: hypothetical protein +FIG00450252 FIG00450254: hypothetical protein +FIG00450254 FIG00450255: hypothetical protein +FIG00450255 FIG00450256: hypothetical protein +FIG00450256 hypothetical protein +FIG00450260 FIG00450261: Chaperone required for the assembly of the F1-ATPase +FIG00450261 FIG00450262: hypothetical protein +FIG00450262 FIG00450263: hypothetical protein +FIG00450263 FIG00450264: zinc-binding protein +FIG00450265 FIG00450267: hypothetical protein +FIG00450268 Gene Transfer Agent host specificity protein +FIG00450269 FIG00450270: hypothetical protein +FIG00450270 FIG00450271: hypothetical protein +FIG00450271 FIG00450274: hypothetical protein +FIG00450274 FIG00450275: hypothetical protein +FIG00450275 FIG00450277: hypothetical protein +FIG00450277 FIG00450278: hypothetical protein +FIG00450278 FIG00450280: hypothetical protein +FIG00450280 FIG00450281: hypothetical protein +FIG00450281 FIG00450283: hypothetical protein +FIG00450284 Transporter +FIG00450286 FIG00450287: hypothetical protein +FIG00450287 FIG00450288: hypothetical protein +FIG00450288 FIG00450290: hypothetical protein +FIG00450290 FIG00450291: hypothetical protein +FIG00450291 FIG00450292: hypothetical protein +FIG00450292 Putative oxoacyl-(acyl carrier protein) reductase +FIG00450293 FIG00450294: hypothetical protein +FIG00450294 FIG00450295: hypothetical protein +FIG00450295 FIG00450296: hypothetical protein +FIG00450296 FIG00450297: hypothetical protein +FIG00450297 FIG00450301: hypothetical protein +FIG00450301 FIG00450302: hypothetical protein +FIG00450302 FIG00450303: hypothetical protein +FIG00450303 FIG00450304: hypothetical protein +FIG00450304 FIG00450305: hypothetical protein +FIG00450305 FIG00450306: hypothetical protein +FIG00450306 FIG00450307: hypothetical protein +FIG00450307 FIG00450308: hypothetical protein +FIG00450308 FIG00450309: hypothetical protein +FIG00450309 FIG00450310: hypothetical protein +FIG00450310 FIG00450311: hypothetical protein +FIG00450311 FIG00450312: hypothetical protein +FIG00450312 FIG00450313: hypothetical protein +FIG00450313 FIG00450314: hypothetical protein +FIG00450314 FIG139438: lipoprotein B +FIG00450315 FIG00450316: hypothetical protein +FIG00450316 NifU protein +FIG00450317 FIG00450318: hypothetical protein +FIG00450318 Gene Transfer Agent tail tape measure +FIG00450319 FIG00450321: hypothetical protein +FIG00450321 FIG00450322: hypothetical protein +FIG00450322 FIG00450323: hypothetical protein +FIG00450323 FIG00450324: hypothetical protein +FIG00450324 FIG00450325: hypothetical protein +FIG00450325 FIG00450327: hypothetical protein +FIG00450328 FIG00450330: hypothetical protein +FIG00450330 FIG00450331: hypothetical protein +FIG00450331 FIG00450333: hypothetical protein +FIG00450333 FIG00450335: hypothetical protein +FIG00450335 FIG048711: hypothetical protein +FIG00450337 FIG00450338: hypothetical protein +FIG00450338 FIG00450339: hypothetical protein +FIG00450340 FIG00450341: hypothetical protein +FIG00450341 FIG00450342: hypothetical protein +FIG00450342 FIG00450344: hypothetical protein +FIG00450344 FIG00450345: hypothetical protein +FIG00450345 FIG00450347: hypothetical protein +FIG00450347 FIG00450348: hypothetical protein +FIG00450348 FIG00450349: hypothetical protein +FIG00450349 FIG00450350: hypothetical protein +FIG00450350 hypothetical protein +FIG00450352 FIG00450353: hypothetical protein +FIG00450356 FIG00450357: hypothetical protein +FIG00450357 FIG00450360: hypothetical protein +FIG00450361 FIG00450362: hypothetical protein +FIG00450362 FIG00450364: hypothetical protein +FIG00450364 FIG00450365: hypothetical protein +FIG00450365 FIG00450366: hypothetical protein +FIG00450368 FIG00450369: hypothetical protein +FIG00450369 FIG00450371: hypothetical protein +FIG00450371 Mannosyltransferase WboA +FIG00450374 FIG00450375: hypothetical protein +FIG00450375 FIG00450376: hypothetical protein +FIG00450376 FIG00450377: hypothetical protein +FIG00450377 FIG00450378: hypothetical protein +FIG00450378 FIG00450379: hypothetical protein +FIG00450380 Colanic acid biosynthesis acetyltransferase WcaF (EC 2.3.1.-) +FIG00450381 FIG00450382: hypothetical protein +FIG00450382 FIG00450383: hypothetical protein +FIG00450383 Exopolysaccharide production protein ExoF precursor +FIG00450386 FIG00984076: hypothetical protein +FIG00450387 FIG00792793: hypothetical protein +FIG00450388 Ureidoglycine aminohydrolase +FIG00450390 FIG00450391: hypothetical protein +FIG00450392 FIG00450393: hypothetical protein +FIG00450393 Gene Transfer Agent associated protein Atu0955 +FIG00450395 FIG00450396: hypothetical protein +FIG00450396 FIG00983982: hypothetical protein +FIG00450397 FIG00450398: hypothetical protein +FIG00450398 FIG00450399: hypothetical protein +FIG00450399 FIG00450401: hypothetical protein +FIG00450401 FIG00450402: hypothetical protein +FIG00450402 FIG00450403: hypothetical protein +FIG00450403 Bacteriophage capsid protein [General function prediction only] +FIG00450404 Gene Transfer Agent (GTA) ORFG12 +FIG00450405 FIG00450407: hypothetical protein +FIG00450407 FIG00450408: hypothetical protein +FIG00450408 FIG00450409: hypothetical protein +FIG00450409 FIG00450410: hypothetical protein +FIG00450410 FIG00450411: hypothetical protein +FIG00450413 FIG038675: hypothetical protein +FIG00450414 FIG00450418: hypothetical protein +FIG00450418 hypothetical protein +FIG00450419 FIG00450420: hypothetical protein +FIG00450420 FIG00450423: hypothetical protein +FIG00450425 FIG00450427: hypothetical protein +FIG00450427 FIG00450429: hypothetical protein +FIG00450429 FIG00450430: hypothetical protein +FIG00450431 FIG00450432: hypothetical protein +FIG00450432 FIG00450433: hypothetical protein +FIG00450433 FIG00450434: hypothetical protein +FIG00450434 FIG00450435: hypothetical protein +FIG00450435 FIG00450436: hypothetical protein +FIG00450436 Conserved hypothetical protein, gene in Ubiquinol-cytochrome C chaperone locus +FIG00450439 Gene Transfer Agent host specificity protein +FIG00450440 FIG00450441: hypothetical protein +FIG00450441 FIG00450442: hypothetical protein +FIG00450442 FIG00450444: hypothetical protein +FIG00450445 FIG00450446: hypothetical protein +FIG00450446 FIG00450447: hypothetical protein +FIG00450447 FIG00450448: hypothetical protein +FIG00450450 FIG00450452: hypothetical protein +FIG00450452 FIG00450453: hypothetical protein +FIG00450453 FIG00450455: hypothetical protein +FIG00450455 FIG00450456: hypothetical protein +FIG00450456 FIG00450458: hypothetical protein +FIG00450458 FIG00450460: hypothetical protein +FIG00450460 Peptidase family M23 +FIG00450461 FIG00450463: hypothetical protein +FIG00450463 FIG00450464: hypothetical protein +FIG00450464 FIG00450465: hypothetical protein +FIG00450465 FIG00450467: hypothetical protein +FIG00450467 FIG00450469: hypothetical protein +FIG00450469 FIG00450470: hypothetical protein +FIG00450471 FIG00450473: hypothetical protein +FIG00450474 FIG00450475: hypothetical protein +FIG00450476 FIG00450478: hypothetical protein +FIG00450478 FIG00450479: hypothetical protein +FIG00450479 FIG00450480: hypothetical protein +FIG00450480 FIG00450481: hypothetical protein +FIG00450481 L-carnitine dehydratase/bile acid-inducible protein F (EC 2.8.3.16) +FIG00450485 Metallo-beta-lactamase superfamily +FIG00450487 FIG00450489: hypothetical protein +FIG00450489 FIG00450490: hypothetical protein +FIG00450490 Gene Transfer Agent (GTA) ORFG07 +FIG00450491 FIG00450492: hypothetical protein +FIG00450492 FIG00450493: hypothetical protein +FIG00450493 FIG00450495: hypothetical protein +FIG00450495 FIG00450496: hypothetical protein +FIG00450496 FIG00450497: hypothetical protein +FIG00450497 FIG00450498: hypothetical protein +FIG00450498 FIG00450499: hypothetical protein +FIG00450499 FIG00450500: hypothetical protein +FIG00450500 FIG00450501: hypothetical protein +FIG00450501 FIG00450502: hypothetical protein +FIG00450503 FIG00450504: hypothetical protein +FIG00450504 FIG00450506: hypothetical protein +FIG00450506 FIG00450507: hypothetical protein +FIG00450507 FIG00450509: hypothetical protein +FIG00450509 FIG00450510: hypothetical protein +FIG00450510 FIG00450511: hypothetical protein +FIG00450511 FIG00450513: hypothetical protein +FIG00450513 FIG00450514: hypothetical protein +FIG00450515 FIG00450516: Zinc-finger domain protein +FIG00450516 hypothetical protein +FIG00450518 FIG00450521: hypothetical protein +FIG00450521 FIG00450524: hypothetical protein +FIG00450524 FIG00450526: hypothetical protein +FIG00450526 FIG00450527: hypothetical protein +FIG00450527 FIG00450528: hypothetical protein +FIG00450528 FIG00450529: hypothetical protein +FIG00450529 FIG00450531: hypothetical protein +FIG00450531 FIG00450532: hypothetical protein +FIG00450532 FIG00450533: hypothetical protein +FIG00450534 FIG00450535: hypothetical protein +FIG00450535 FIG00450536: hypothetical protein +FIG00450536 FIG00450537: hypothetical protein +FIG00450537 FIG00450538: hypothetical protein +FIG00450538 FIG00450539: hypothetical protein +FIG00450540 FIG00450541: hypothetical protein +FIG00450541 FIG00450542: hypothetical protein +FIG00450542 FIG00450543: hypothetical protein +FIG00450543 FIG00450544: hypothetical protein +FIG00450545 FIG00450546: hypothetical protein +FIG00450546 FIG00450547: hypothetical protein +FIG00450547 FIG00450549: hypothetical protein +FIG00450549 FIG00450550: hypothetical protein +FIG00450550 FIG00450552: hypothetical protein +FIG00450552 FIG00450553: hypothetical protein +FIG00450555 FIG00450556: hypothetical protein +FIG00450556 FIG00450557: hypothetical protein +FIG00450557 FIG00450558: hypothetical protein +FIG00450562 FIG00450564: hypothetical protein +FIG00450564 FIG00450565: hypothetical protein +FIG00450565 FIG00450566: hypothetical protein +FIG00450566 FIG00450567: hypothetical protein +FIG00450567 FIG00450570: hypothetical protein +FIG00450570 FIG00450571: hypothetical protein +FIG00450571 FIG00450572: hypothetical protein +FIG00450572 GGDEF domain protein +FIG00450577 FIG00450579: hypothetical protein +FIG00450579 FIG00450581: hypothetical protein +FIG00450581 FIG00450582: hypothetical protein +FIG00450582 FIG00450583: hypothetical protein +FIG00450583 FIG00450584: hypothetical protein +FIG00450584 FIG00450585: hypothetical protein +FIG00450585 FIG00450586: hypothetical protein +FIG00450586 FIG00983433: hypothetical protein +FIG00450587 FIG00450591: hypothetical protein +FIG00450591 FIG00450592: hypothetical protein +FIG00450593 FIG00450594: hypothetical protein +FIG00450594 FIG00450596: hypothetical protein +FIG00450598 FIG00450599: hypothetical protein +FIG00450599 FIG00450600: hypothetical protein +FIG00450600 FIG00450601: hypothetical protein +FIG00450603 FIG00450604: hypothetical protein +FIG00450604 FIG00450605: hypothetical protein +FIG00450605 FIG00450606: hypothetical protein +FIG00450606 FIG00450608: hypothetical protein +FIG00450608 FIG00450610: hypothetical protein +FIG00450612 FIG00450613: hypothetical protein +FIG00450617 hypothetical protein +FIG00450618 FIG00450619: hypothetical protein +FIG00450622 FIG00450623: hypothetical protein +FIG00450624 Type I restriction-modification enzyme, S subunit +FIG00450625 FIG00450626: hypothetical protein +FIG00450626 FIG00450627: hypothetical protein +FIG00450627 FIG00450176: hypothetical protein +FIG00450629 FIG00450631: hypothetical protein +FIG00450632 FIG00450633: hypothetical protein +FIG00450633 Branched-chain amino acid transport protein (AzlD) +FIG00450634 FIG00450635: hypothetical protein +FIG00450635 FIG00450636: hypothetical protein +FIG00450636 FIG00450637: Antifreeze protein, type I +FIG00450637 FIG00450641: hypothetical protein +FIG00450641 FIG00450642: hypothetical protein +FIG00450642 FIG00450643: hypothetical protein +FIG00450643 FIG00450645: hypothetical protein +FIG00450645 hypothetical protein +FIG00450646 FIG00450647: hypothetical protein +FIG00450647 FIG00450648: hypothetical protein +FIG00450648 FIG00450649: hypothetical protein +FIG00450649 FIG00450652: hypothetical protein +FIG00450652 FIG01306807: hypothetical protein +FIG00450655 FIG00450656: hypothetical protein +FIG00450657 FIG00450658: hypothetical protein +FIG00450659 FIG00450661: hypothetical protein +FIG00450661 hypothetical protein +FIG00450662 FIG00450664: hypothetical protein +FIG00450665 FIG00450666: hypothetical protein +FIG00450667 FIG00450668: hypothetical protein +FIG00450669 FIG00450670: hypothetical protein +FIG00450670 FIG00450671: hypothetical protein +FIG00450671 FIG00450672: hypothetical protein +FIG00450672 FIG01306805: hypothetical protein +FIG00450673 FIG00450674: hypothetical protein +FIG00450674 PII-like signaling protein +FIG00450679 FIG00450681: hypothetical protein +FIG00450681 hypothetical protein +FIG00450682 FIG00450683: hypothetical protein +FIG00450683 FIG01306808: hypothetical protein +FIG00450684 FIG00450685: hypothetical protein +FIG00450685 FIG00450686: hypothetical protein +FIG00450686 FIG00450687: hypothetical protein +FIG00450687 FIG00450689: hypothetical protein +FIG00450690 FIG00450691: hypothetical protein +FIG00450692 FIG00450693: hypothetical protein +FIG00450693 FIG00450695: hypothetical protein +FIG00450695 hypothetical protein +FIG00450696 FIG00450697: hypothetical protein +FIG00450698 FIG00450699: hypothetical protein +FIG00450699 FIG00450700: hypothetical protein +FIG00450700 FIG00450701: hypothetical protein +FIG00450701 FIG00450702: hypothetical protein +FIG00450702 FIG00450703: hypothetical protein +FIG00450704 FIG00450705: hypothetical protein +FIG00450705 FIG00450706: hypothetical protein +FIG00450706 FIG00450707: hypothetical protein +FIG00450707 FIG00450708: hypothetical protein +FIG00450709 FIG00450710: hypothetical protein +FIG00450710 FIG00450711: hypothetical protein +FIG00450711 FIG00450712: hypothetical protein +FIG00450712 competence lipoprotein ComL, putative +FIG00450713 FIG00450714: hypothetical protein +FIG00450714 FIG00450715: hypothetical protein +FIG00450715 FIG00450716: hypothetical protein +FIG00450716 FIG00450717: hypothetical protein +FIG00450717 FIG00450718: hypothetical protein +FIG00450718 FIG00450721: hypothetical protein +FIG00450721 FIG00450722: hypothetical protein +FIG00450723 FIG00450724: hypothetical protein +FIG00450724 FIG00450725: hypothetical protein +FIG00450725 FIG00450728: hypothetical protein +FIG00450728 FIG00450729: hypothetical protein +FIG00450729 FIG00450732: hypothetical protein +FIG00450732 FIG00450735: hypothetical protein +FIG00450736 FIG00450737: hypothetical protein +FIG00450737 FIG00450738: hypothetical protein +FIG00450739 FIG00450742: hypothetical protein +FIG00450742 FIG00450743: hypothetical protein +FIG00450743 FIG00450745: hypothetical protein +FIG00450745 FIG00450747: hypothetical protein +FIG00450747 FIG00450749: hypothetical protein +FIG00450749 FIG00450750: hypothetical protein +FIG00450750 FIG00450751: hypothetical protein +FIG00450751 FIG00450752: hypothetical protein +FIG00450752 FIG00450754: hypothetical protein +FIG00450754 FIG00450755: hypothetical protein +FIG00450755 FIG00450756: hypothetical protein +FIG00450756 FIG00450757: hypothetical protein +FIG00450757 FIG00450760: hypothetical protein +FIG00450760 FIG00450761: hypothetical protein +FIG00450761 FIG00450762: hypothetical protein +FIG00450762 FIG00450764: hypothetical protein +FIG00450764 FIG00450765: hypothetical protein +FIG00450765 FIG00450058: hypothetical protein +FIG00450767 FIG00450769: hypothetical protein +FIG00450769 FIG00450770: hypothetical protein +FIG00450770 FIG00450771: hypothetical protein +FIG00450772 FIG00450773: hypothetical protein +FIG00450773 FIG00450774: hypothetical protein +FIG00450777 FIG00450778: hypothetical protein +FIG00450781 FIG00450782: hypothetical protein +FIG00450783 FIG00450785: hypothetical protein +FIG00450785 FIG00450786: hypothetical protein +FIG00450786 FIG00450787: hypothetical protein +FIG00450787 FIG00450788: hypothetical protein +FIG00450788 FIG00450789: hypothetical protein +FIG00450789 FIG00450790: hypothetical protein +FIG00450790 FIG00450791: hypothetical protein +FIG00450791 FIG00450792: hypothetical protein +FIG00450792 FIG00450793: hypothetical protein +FIG00450793 FIG00450794: hypothetical protein +FIG00450794 FIG00450795: hypothetical protein +FIG00450795 FIG00450796: hypothetical protein +FIG00450796 ABC transporter ATP-binding protein +FIG00450797 FIG00450798: hypothetical protein +FIG00450798 FIG00450799: hypothetical protein +FIG00450799 FIG00450801: hypothetical protein +FIG00450801 FIG00450803: hypothetical protein +FIG00450803 FIG00450805: hypothetical protein +FIG00450805 FIG00450806: hypothetical protein +FIG00450806 FIG00450807: hypothetical protein +FIG00450807 FIG00450808: hypothetical protein +FIG00450808 FIG00450809: hypothetical protein +FIG00450811 FIG00450812: hypothetical protein +FIG00450812 FIG00450813: hypothetical protein +FIG00450814 FIG00450815: hypothetical protein +FIG00450815 Oxidoreductase, FMN-binding/pyridine nucleotide-disulfide oxidoreductase +FIG00450816 FIG00450818: hypothetical protein +FIG00450818 FIG00450819: hypothetical protein +FIG00450819 FIG00450820: hypothetical protein +FIG00450820 FIG00450821: hypothetical protein +FIG00450821 ABC-type polar amino acid transport system protein, permease protein +FIG00450822 FIG00450823: hypothetical protein +FIG00450823 FIG00450824: hypothetical protein +FIG00450824 FIG00450829: hypothetical protein +FIG00450829 FIG00450830: hypothetical protein +FIG00450833 FIG00450834: hypothetical protein +FIG00450834 Acetyl-CoA hydrolase/transferase family protein +FIG00450836 FIG00450839: hypothetical protein +FIG00450839 FIG00450841: hypothetical protein +FIG00450841 FIG00450842: hypothetical protein +FIG00450842 FIG00450845: hypothetical protein +FIG00450845 FIG00450846: hypothetical protein +FIG00450846 FIG00450847: hypothetical protein +FIG00450849 FIG00450850: hypothetical protein +FIG00450850 FIG00450851: hypothetical protein +FIG00450851 FIG00450853: hypothetical protein +FIG00450853 FIG00450854: hypothetical protein +FIG00450854 FIG00450855: hypothetical protein +FIG00450858 FIG00792028: hypothetical protein +FIG00450859 FIG00450860: hypothetical protein +FIG00450862 FIG00450865: hypothetical protein +FIG00450870 FIG00450871: hypothetical protein +FIG00450872 FIG00450873: hypothetical protein +FIG00450873 FIG00450874: hypothetical protein +FIG00450874 FIG00450875: hypothetical protein +FIG00450875 FIG00450876: hypothetical protein +FIG00450878 FIG00450879: hypothetical protein +FIG00450881 FIG00450883: hypothetical protein +FIG00450885 FIG048170: Secreted Zn-dependent protease involved in posttranslational modification +FIG00450887 FIG00450888: hypothetical protein +FIG00450888 FIG00450889: hypothetical protein +FIG00450889 FIG00450891: hypothetical protein +FIG00450891 FIG00450892: hypothetical protein +FIG00450892 FIG00450893: hypothetical protein +FIG00450893 FIG00450894: hypothetical protein +FIG00450894 FIG00450895: hypothetical protein +FIG00450896 FIG00450897: hypothetical protein +FIG00450897 FIG00450900: hypothetical protein +FIG00450900 AcrB/AcrD/AcrF multidrug efflux protein +FIG00450901 FIG00450902: hypothetical protein +FIG00450903 FIG00450904: hypothetical protein +FIG00450905 ABC-type transport system involved in resistance to organic solvents, permease component +FIG00450908 FIG00450910: hypothetical protein +FIG00450910 FIG00450913: hypothetical protein +FIG00450914 FIG00450916: hypothetical protein +FIG00450917 FIG00450918: hypothetical protein +FIG00450918 FIG00450919: hypothetical protein +FIG00450919 FIG00450920: hypothetical protein +FIG00450920 FIG00450921: hypothetical protein +FIG00450921 FIG00450922: hypothetical protein +FIG00450922 FIG00450924: hypothetical protein +FIG00450924 FIG00450925: hypothetical protein +FIG00450925 FIG00450926: hypothetical protein +FIG00450926 FIG00450927: hypothetical protein +FIG00450927 FIG00450929: hypothetical protein +FIG00450929 FIG00450930: hypothetical protein +FIG00450930 FIG00450931: hypothetical protein +FIG00450931 hypothetical protein +FIG00450932 FIG00450933: hypothetical protein +FIG00450933 FIG00450935: hypothetical protein +FIG00450936 FIG00450937: hypothetical protein +FIG00450937 FIG00450939: hypothetical protein +FIG00450939 FIG00450941: hypothetical protein +FIG00450941 FIG00450942: hypothetical protein +FIG00450942 FIG065852: hypothetical protein in Mg(2+) transport ATPase cluster +FIG00450943 FIG00450944: hypothetical protein +FIG00450944 FIG00450945: hypothetical protein +FIG00450945 hypothetical protein +FIG00450946 FIG00450948: hypothetical protein +FIG00450948 FIG00793409: hypothetical protein +FIG00450953 FIG00450954: hypothetical protein +FIG00450954 FIG00450955: hypothetical protein +FIG00450955 Sensor histidine kinase +FIG00450957 FIG00450958: hypothetical protein +FIG00450958 FIG00450959: hypothetical protein +FIG00450959 FIG00450960: hypothetical protein +FIG00450960 FIG00450961: hypothetical protein +FIG00450961 Modification methylase HindV (EC 2.1.1.37) +FIG00450962 FIG00450963: hypothetical protein +FIG00450963 FIG00450965: hypothetical protein +FIG00450967 FIG00450968: hypothetical protein +FIG00450968 FIG00450970: hypothetical protein +FIG00450970 FIG00450972: hypothetical protein +FIG00450973 FIG00450974: hypothetical protein +FIG00450974 FIG00450975: hypothetical protein +FIG00450975 FIG00450976: hypothetical protein +FIG00450976 FIG00450977: hypothetical protein +FIG00450977 17K common-antigen +FIG00450978 FIG00450981: hypothetical protein +FIG00450981 Membrane lipoprotein lipid attachment site containing protein +FIG00450982 FIG00450983: hypothetical protein +FIG00450983 FIG00450984: hypothetical protein +FIG00450985 FIG00450987: hypothetical protein +FIG00450988 FIG00450991: hypothetical protein +FIG00450991 FIG00450992: hypothetical protein +FIG00450992 FIG00450994: hypothetical protein +FIG00450994 FIG00450996: hypothetical protein +FIG00450996 FIG00450997: hypothetical protein +FIG00450998 FIG00450999: hypothetical protein +FIG00450999 FIG00451000: hypothetical protein +FIG00451000 FIG00451002: hypothetical protein +FIG00451004 FIG00451005: hypothetical protein +FIG00451006 FIG00451007: hypothetical protein +FIG00451007 FIG00451008: hypothetical protein +FIG00451008 FIG00451009: hypothetical protein +FIG00451011 FIG00451012: hypothetical protein +FIG00451012 FIG00451013: hypothetical protein +FIG00451013 FIG00451014: hypothetical protein +FIG00451014 FIG00451015: hypothetical protein +FIG00451017 FIG00451018: hypothetical protein +FIG00451018 FIG00451019: hypothetical protein +FIG00451019 FIG00481961: hypothetical protein +FIG00451020 hypothetical protein +FIG00451021 FIG00451023: hypothetical protein +FIG00451023 FIG00451025: hypothetical protein +FIG00451026 FIG00451027: hypothetical protein +FIG00451028 COGs COG3777 +FIG00451031 FIG00451032: hypothetical protein +FIG00451032 FIG00451033: hypothetical protein +FIG00451033 FIG00451035: hypothetical protein +FIG00451041 FIG00451042: hypothetical protein +FIG00451042 FIG00451043: hypothetical protein +FIG00451044 FIG00451045: hypothetical protein +FIG00451045 FIG00451046: hypothetical protein +FIG00451046 FIG00451047: hypothetical protein +FIG00451047 hypothetical protein +FIG00451049 FIG00451050: hypothetical protein +FIG00451050 FIG00451051: hypothetical protein +FIG00451053 FIG00451055: hypothetical protein +FIG00451055 FIG00451056: hypothetical protein +FIG00451056 FIG00451057: hypothetical protein +FIG00451057 FIG00451059: hypothetical protein +FIG00451060 FIG00451062: hypothetical protein +FIG00451062 FIG00451063: hypothetical protein +FIG00451063 FIG00451064: hypothetical protein +FIG00451067 FIG00451069: hypothetical protein +FIG00451070 FIG00451071: hypothetical protein +FIG00451071 FIG00451073: hypothetical protein +FIG00451076 FIG00451077: hypothetical protein +FIG00451077 FIG00451081: hypothetical protein +FIG00451081 FIG00451082: hypothetical protein +FIG00451082 FIG00451083: hypothetical protein +FIG00451083 FIG00451085: hypothetical protein +FIG00451085 FIG00451087: hypothetical protein +FIG00451087 FIG00451088: hypothetical protein +FIG00451088 FIG00451090: hypothetical protein +FIG00451090 Glycosyltransferase, group 1 family protein +FIG00451092 FIG00451093: hypothetical protein +FIG00451093 FIG00451095: hypothetical protein +FIG00451095 Oligopeptide ABC transporter, periplasmic oligopeptide-binding protein OppA (TC 3.A.1.5.1) +FIG00451097 FIG00451098: hypothetical protein +FIG00451098 FIG00451099: hypothetical protein +FIG00451099 hypothetical protein +FIG00451101 FIG00451102: hypothetical protein +FIG00451104 FIG00451105: hypothetical protein +FIG00451105 FIG00451106: hypothetical protein +FIG00451114 FIG00441938: hypothetical protein +FIG00451115 FIG00451116: hypothetical protein +FIG00451116 FIG00451117: hypothetical protein +FIG00451117 FIG00451118: hypothetical protein +FIG00451119 FIG00451120: hypothetical protein +FIG00451120 FIG00451121: hypothetical protein +FIG00451121 FIG00451122: hypothetical protein +FIG00451122 FIG00451123: hypothetical protein +FIG00451123 FIG00451124: hypothetical protein +FIG00451124 FIG00451125: hypothetical protein +FIG00451125 FIG00451128: hypothetical protein +FIG00451128 FIG00451129: hypothetical protein +FIG00451130 FIG00451131: hypothetical protein +FIG00451131 FIG00451132: hypothetical protein +FIG00451137 FIG00451138: hypothetical protein +FIG00451141 FIG00451142: hypothetical protein +FIG00451142 FIG00451144: hypothetical protein +FIG00451144 FIG00451145: hypothetical protein +FIG00451145 FIG00451146: hypothetical protein +FIG00451146 FIG00451148: hypothetical protein +FIG00451148 FIG00451149: hypothetical protein +FIG00451149 FIG00451151: hypothetical protein +FIG00451151 FIG00451152: hypothetical protein +FIG00451152 FIG00451153: hypothetical protein +FIG00451154 FIG00451162: hypothetical protein +FIG00451162 FIG00451164: hypothetical protein +FIG00451165 hypothetical protein +FIG00451166 FIG00451169: hypothetical protein +FIG00451169 FIG01306798: hypothetical protein +FIG00451172 FIG00451175: hypothetical protein +FIG00451175 FIG00451177: hypothetical protein +FIG00451184 Lysine-arginine-ornithine-binding periplasmic protein +FIG00451185 FIG00451186: hypothetical protein +FIG00451186 FIG00451187: hypothetical protein +FIG00451187 hypothetical protein +FIG00451191 hypothetical protein +FIG00451192 sugar ABC transporter, periplasmic sugar-binding protein +FIG00451193 FIG00451194: hypothetical protein +FIG00451194 hypothetical protein +FIG00451195 FIG00451198: hypothetical protein +FIG00451198 High-affnity carbon uptake protein Hat/HatR +FIG00451199 FIG00451200: hypothetical protein +FIG00451200 FIG00451202: hypothetical protein +FIG00451202 FIG00792156: hypothetical protein +FIG00451206 Gene Transfer Agent tail protein +FIG00451207 hypothetical protein +FIG00451208 FIG00451216: hypothetical protein +FIG00451216 FIG00451217: hypothetical protein +FIG00451217 FIG00451218: hypothetical protein +FIG00451218 FIG00451223: hypothetical protein +FIG00451225 FIG00451226: hypothetical protein +FIG00451226 FIG00451227: hypothetical protein +FIG00451227 FIG00451228: hypothetical protein +FIG00451228 FIG00451229: hypothetical protein +FIG00451229 FIG00451230: hypothetical protein +FIG00451230 FIG00451231: hypothetical protein +FIG00451238 FIG00451240: hypothetical protein +FIG00451240 FIG00451241: hypothetical protein +FIG00451243 FIG00451244: hypothetical protein +FIG00451244 FIG00451249: hypothetical protein +FIG00451249 FIG00451250: hypothetical protein +FIG00451250 FIG00451253: hypothetical protein +FIG00451254 FIG00451255: hypothetical protein +FIG00451255 Gene Transfer Agent (GTA) ORFG10b +FIG00451256 FIG00451257: hypothetical protein +FIG00451257 FIG00451259: hypothetical protein +FIG00451259 FIG00451261: hypothetical protein +FIG00451262 FIG00451263: hypothetical protein +FIG00451265 FIG00451266: hypothetical protein +FIG00451270 FIG00451271: hypothetical protein +FIG00451277 FIG00451278: hypothetical protein +FIG00451278 FIG00451280: hypothetical protein +FIG00451280 FIG00451281: hypothetical protein +FIG00451281 FIG00451282: hypothetical protein +FIG00451282 FIG00451283: hypothetical protein +FIG00451283 FIG00451284: hypothetical protein +FIG00451284 FIG00451285: hypothetical protein +FIG00451290 FIG00451292: hypothetical protein +FIG00451298 FIG00451300: hypothetical protein +FIG00451304 FIG00451306: hypothetical protein +FIG00451306 FIG00451307: hypothetical protein +FIG00451307 FIG00451308: hypothetical protein +FIG00451308 FIG00451310: hypothetical protein +FIG00451310 FIG00451311: hypothetical protein +FIG00451312 FIG00451313: hypothetical protein +FIG00451313 FIG00451314: hypothetical protein +FIG00451315 FIG00451316: hypothetical protein +FIG00451316 FIG00451317: hypothetical protein +FIG00451317 FIG00451319: hypothetical protein +FIG00451319 FIG00451320: hypothetical protein +FIG00451320 hypothetical protein +FIG00451321 FIG00451323: hypothetical protein +FIG00451329 FIG00451331: hypothetical protein +FIG00451331 FIG00451333: hypothetical protein +FIG00451333 FIG00451334: hypothetical protein +FIG00451335 FIG00451336: hypothetical protein +FIG00451336 FIG00451337: hypothetical protein +FIG00451342 FIG00451344: hypothetical protein +FIG00451344 FIG00451346: hypothetical protein +FIG00451348 hypothetical protein +FIG00451350 FIG00451351: hypothetical protein +FIG00451351 FIG00451352: hypothetical protein +FIG00451352 FIG00451354: hypothetical protein +FIG00451354 Bacterial extracellular solute-binding protein, family 3 +FIG00451358 FIG00451363: hypothetical protein +FIG00451363 FIG00451364: hypothetical protein +FIG00451364 FIG00451366: hypothetical protein +FIG00451366 FIG00451368: hypothetical protein +FIG00451368 FIG00451369: hypothetical protein +FIG00451369 FIG00451370: hypothetical protein +FIG00451370 Imidazolonepropionase (EC 3.5.2.7) / Histidine ammonia-lyase (EC 4.3.1.3) +FIG00451371 FIG00451372: hypothetical protein +FIG00451372 FIG00451374: hypothetical protein +FIG00451374 FIG00451375: hypothetical protein +FIG00451375 FIG00451376: hypothetical protein +FIG00451377 FIG00451378: hypothetical protein +FIG00451378 FIG00451379: hypothetical protein +FIG00451382 FIG00451383: hypothetical protein +FIG00451383 hypothetical protein +FIG00451386 FIG00451389: hypothetical protein +FIG00451390 FIG00451393: hypothetical protein +FIG00451393 FIG00451394: hypothetical protein +FIG00451394 FIG00451402: hypothetical protein +FIG00451402 FIG00451404: hypothetical protein +FIG00451405 BRO family protein +FIG00451407 FIG00451408: hypothetical protein +FIG00451409 hypothetical protein +FIG00451410 FIG00451411: hypothetical protein +FIG00451411 hypothetical protein +FIG00451412 FIG00451413: hypothetical protein +FIG00451413 FIG00451416: hypothetical protein +FIG00451416 FIG00451420: hypothetical protein +FIG00451421 FIG00451422: hypothetical protein +FIG00451422 GcrA cell cycle regulator +FIG00451425 FIG00451426: hypothetical protein +FIG00451426 FIG00451428: hypothetical protein +FIG00451430 FIG00451432: hypothetical protein +FIG00451433 FIG00451435: hypothetical protein +FIG00451435 FIG00451437: hypothetical protein +FIG00451438 FIG00451441: hypothetical protein +FIG00451441 FIG00451442: hypothetical protein +FIG00451444 FIG00451446: hypothetical protein +FIG00451446 FIG00451447: hypothetical protein +FIG00451450 FIG00451451: hypothetical protein +FIG00451454 FIG00451455: hypothetical protein +FIG00451455 FIG00451457: hypothetical protein +FIG00451457 FIG00451459: hypothetical protein +FIG00451463 FIG00451468: hypothetical protein +FIG00451469 FIG00451470: hypothetical protein +FIG00451471 FIG00451472: hypothetical protein +FIG00451472 FIG00451477: hypothetical protein +FIG00451477 FIG00451480: hypothetical protein +FIG00451485 FIG00451488: hypothetical protein +FIG00451488 FIG00451490: hypothetical protein +FIG00451490 FIG00451491: hypothetical protein +FIG00451491 FIG00451492: hypothetical protein +FIG00451495 FIG00451496: hypothetical protein +FIG00451500 FIG00451502: hypothetical protein +FIG00451506 FIG00451508: hypothetical protein +FIG00451509 FIG00451510: hypothetical protein +FIG00451511 FIG00451512: hypothetical protein +FIG00451513 FIG00451514: hypothetical protein +FIG00451517 FIG00451518: hypothetical protein +FIG00451518 FIG00451519: hypothetical protein +FIG00451525 FIG00451526: hypothetical protein +FIG00451527 FIG00451530: hypothetical protein +FIG00451530 FIG00451531: hypothetical protein +FIG00451531 FIG00451532: hypothetical protein +FIG00451535 FIG00451538: hypothetical protein +FIG00451538 FIG00451540: hypothetical protein +FIG00451540 FIG00451545: hypothetical protein +FIG00451545 FIG00451546: hypothetical protein +FIG00451554 FIG00451557: hypothetical protein +FIG00451558 FIG00451561: hypothetical protein +FIG00451561 FIG00451563: hypothetical protein +FIG00451564 FIG00451565: hypothetical protein +FIG00451565 FIG00451566: hypothetical protein +FIG00451569 FIG00451570: hypothetical protein +FIG00451575 FIG00451576: hypothetical protein +FIG00451581 FIG00451585: hypothetical protein +FIG00451585 FIG00451590: hypothetical protein +FIG00451592 FIG00451593: hypothetical protein +FIG00451599 hypothetical protein +FIG00451600 FIG00451605: hypothetical protein +FIG00451605 hypothetical protein +FIG00451606 FIG00451608: hypothetical protein +FIG00451608 FIG00451610: hypothetical protein +FIG00451610 FIG00451611: hypothetical protein +FIG00451611 FIG00451613: hypothetical protein +FIG00451614 FIG00451616: hypothetical protein +FIG00451616 lipoprotein Omp19 +FIG00451617 FIG00451618: hypothetical protein +FIG00451621 FIG00451622: hypothetical protein +FIG00451622 FIG00451623: hypothetical protein +FIG00451623 FIG00451624: hypothetical protein +FIG00451625 TRANSPORTER, MFS superfamily +FIG00451627 FIG00451628: hypothetical protein +FIG00451629 FIG00451631: hypothetical protein +FIG00451631 Beta-lactamase class C and other penicillin binding proteins +FIG00451633 FIG00451636: hypothetical protein +FIG00451644 FIG00451648: hypothetical protein +FIG00451648 FIG00451652: hypothetical protein +FIG00451652 FIG00451654: hypothetical protein +FIG00451654 FIG00451655: hypothetical protein +FIG00451655 FIG00451656: hypothetical protein +FIG00451656 FIG00451659: hypothetical protein +FIG00451659 FIG00451662: hypothetical protein +FIG00451662 FIG00451666: hypothetical protein +FIG00451672 FIG00451675: hypothetical protein +FIG00451678 FIG00451680: hypothetical protein +FIG00451681 FIG00451682: hypothetical protein +FIG00451693 FIG00451699: hypothetical protein +FIG00451705 FIG00451708: hypothetical protein +FIG00451710 FIG00451711: Periplasmic sensor signal transduction histidine kinase +FIG00451714 FIG00451715: hypothetical protein +FIG00451715 FIG00451717: hypothetical protein +FIG00451717 FIG00451719: hypothetical protein +FIG00451719 FIG00451720: hypothetical protein +FIG00451722 FIG00451723: hypothetical protein +FIG00451726 Polyphosphate kinase 2 (EC 2.7.4.1) +FIG00451729 FIG00451730: hypothetical protein +FIG00451730 FIG00451737: hypothetical protein +FIG00451737 FIG00451738: hypothetical protein +FIG00451741 FIG00451743: hypothetical protein +FIG00451743 FIG00451745: hypothetical protein +FIG00451755 hypothetical protein +FIG00451756 FIG00451760: hypothetical protein +FIG00451770 FIG00451771: hypothetical protein +FIG00451775 FIG00451777: hypothetical protein +FIG00451777 FIG00451781: hypothetical protein +FIG00451781 FIG00451786: hypothetical protein +FIG00451786 FIG00451788: hypothetical protein +FIG00451788 hypothetical protein +FIG00451789 Putative iron-sulphur rieske protein +FIG00451792 hypothetical protein +FIG00451795 FIG00451796: hypothetical protein +FIG00451796 FIG00451801: hypothetical protein +FIG00451802 leucine-, isoleucine-, valine-, threonine-, and alanine-binding protein precursor BMEII0122 +FIG00451816 FIG00451818: hypothetical protein +FIG00451821 FIG00451822: hypothetical protein +FIG00451822 FIG00451823: hypothetical protein +FIG00451825 FIG00451826: hypothetical protein +FIG00451833 FIG00451836: hypothetical protein +FIG00451837 FIG00451842: hypothetical protein +FIG00451847 FIG00451856: hypothetical protein +FIG00451856 FIG00451857: hypothetical protein +FIG00451857 FIG00451865: hypothetical protein +FIG00451865 COG4779: ABC-type enterobactin transport system, permease component +FIG00451867 FIG00451868: hypothetical protein +FIG00451868 FIG00451871: hypothetical protein +FIG00451879 FIG00451881: hypothetical protein +FIG00451881 FIG00451885: hypothetical protein +FIG00451888 FIG00451894: hypothetical protein +FIG00451900 FIG00451901: hypothetical protein +FIG00451901 FIG00451905: hypothetical protein +FIG00451905 FIG00451906: hypothetical protein +FIG00451915 FIG00451916: hypothetical protein +FIG00451919 FIG00451921: hypothetical protein +FIG00451923 FIG00451924: hypothetical protein +FIG00451932 FIG00451936: hypothetical protein +FIG00451938 FIG00451939: hypothetical protein +FIG00451939 FIG00451944: hypothetical protein +FIG00451944 FIG00451945: hypothetical protein +FIG00451945 FIG00451948: hypothetical protein +FIG00451956 FIG00451957: hypothetical protein +FIG00451957 FIG00451958: hypothetical protein +FIG00451958 FIG00451963: hypothetical protein +FIG00451965 hypothetical protein +FIG00451969 FIG00451970: hypothetical protein +FIG00451971 FIG00451974: hypothetical protein +FIG00451976 RESPONSE REGULATOR PROTEIN +FIG00451979 FIG00451983: hypothetical protein +FIG00451989 FIG00451990: hypothetical protein +FIG00451990 FIG00451991: hypothetical protein +FIG00451992 FIG00451993: hypothetical protein +FIG00451999 FIG00452000: hypothetical protein +FIG00452006 FIG00452007: hypothetical protein +FIG00452027 FIG00452028: hypothetical protein +FIG00452028 FIG00452029: hypothetical protein +FIG00452031 hypothetical protein +FIG00452036 FIG00452038: hypothetical protein +FIG00452047 FIG00452049: hypothetical protein +FIG00452064 FIG00452065: hypothetical protein +FIG00452080 FIG00452083: hypothetical protein +FIG00452083 FIG00452084: hypothetical protein +FIG00452084 FIG00452090: hypothetical protein +FIG00452099 FIG00452101: hypothetical protein +FIG00452101 FIG00452104: hypothetical protein +FIG00452104 FIG00452105: hypothetical protein +FIG00452115 FIG00452118: hypothetical protein +FIG00452118 hypothetical protein +FIG00452119 FIG00452120: hypothetical protein +FIG00452124 FIG00452130: hypothetical protein +FIG00452132 FIG00452133: hypothetical protein +FIG00452150 FIG00452151: hypothetical protein +FIG00452155 FIG00452157: hypothetical protein +FIG00452157 FIG00452160: hypothetical protein +FIG00452160 FIG00452161: hypothetical protein +FIG00452176 hypothetical protein +FIG00452187 FIG00450420: hypothetical protein +FIG00452197 OLIGOPEPTIDE TRANSPORT ATP-BINDING PROTEIN OPPD +FIG00452213 hypothetical protein +FIG00452261 FIG00452263: hypothetical protein +FIG00452263 FIG00452264: hypothetical protein +FIG00452281 FIG00452288: hypothetical protein +FIG00452288 FIG00452292: hypothetical protein +FIG00452297 Endonuclease I precursor (EC 3.1.21.1) @ Extracellular deoxyribonuclease Dns (EC 3.1.21.-) +FIG00452304 FIG00452316: hypothetical protein +FIG00452332 Translation elongation factor P Lys34:lysine transferase +FIG00452336 FIG00452342: hypothetical protein +FIG00452342 cytidylate kinase( EC:2.7.4.14 ) +FIG00452345 FIG00452348: hypothetical protein +FIG00452359 FIG00452363: hypothetical protein +FIG00452394 FIG00452397: hypothetical protein +FIG00452397 FIG00452399: hypothetical protein +FIG00452401 FIG00452402: hypothetical protein +FIG00452405 FIG00452407: hypothetical protein +FIG00452407 FIG00452408: hypothetical protein +FIG00452408 FIG00452409: hypothetical protein +FIG00452409 FIG00452410: hypothetical protein +FIG00452410 FIG00452412: hypothetical protein +FIG00452412 FIG00452413: hypothetical protein +FIG00452413 FIG00452414: hypothetical protein +FIG00452416 Type III secretion protein, HrpB1 +FIG00452417 FIG00452418: hypothetical protein +FIG00452418 FIG00452419: hypothetical protein +FIG00452419 FIG00452424: hypothetical protein +FIG00452424 FIG00452426: hypothetical protein +FIG00452426 FIG00452428: hypothetical protein +FIG00452428 FIG00452429: hypothetical protein +FIG00452429 FIG00452430: hypothetical protein +FIG00452430 FIG00452431: hypothetical protein +FIG00452432 FIG00452433: hypothetical protein +FIG00452433 FIG00452437: hypothetical protein +FIG00452437 FIG00452439: hypothetical protein +FIG00452439 FIG00452440: hypothetical protein +FIG00452440 FIG00452441: hypothetical protein +FIG00452441 FIG00452442: hypothetical protein +FIG00452442 FIG00452443: hypothetical protein +FIG00452444 FIG00452445: hypothetical protein +FIG00452445 FIG00452446: hypothetical protein +FIG00452446 COG0028: Thiamine pyrophosphate-requiring enzymes +FIG00452447 FIG00452449: hypothetical protein +FIG00452449 FIG00452450: hypothetical protein +FIG00452450 FIG00452452: hypothetical protein +FIG00452453 FIG00452454: hypothetical protein +FIG00452454 FIG00452456: hypothetical protein +FIG00452456 FIG00452459: hypothetical protein +FIG00452459 FIG00452462: hypothetical protein +FIG00452462 FIG00452465: hypothetical protein +FIG00452465 FIG00452466: hypothetical protein +FIG00452468 FIG00452470: hypothetical protein +FIG00452470 FIG00452472: hypothetical protein +FIG00452472 FIG00452474: hypothetical protein +FIG00452474 FIG00452477: hypothetical protein +FIG00452477 FIG00452478: hypothetical protein +FIG00452478 FIG00452481: hypothetical protein +FIG00452481 FIG00452482: hypothetical protein +FIG00452482 FIG00452484: hypothetical protein +FIG00452484 FIG00452486: hypothetical protein +FIG00452487 FIG00452490: hypothetical protein +FIG00452491 FIG00452492: hypothetical protein +FIG00452492 FIG00452493: hypothetical protein +FIG00452493 FIG00452494: hypothetical protein +FIG00452495 FIG00452496: hypothetical protein +FIG00452496 FIG00452497: hypothetical protein +FIG00452499 FIG00452502: hypothetical protein +FIG00452502 FIG00452505: hypothetical protein +FIG00452505 FIG00452506: hypothetical protein +FIG00452507 Glycosyl transferase, group 1 family protein (EC 2.4.1.-) +FIG00452509 FIG00452510: hypothetical protein +FIG00452510 FIG00452513: hypothetical protein +FIG00452513 FIG00452515: hypothetical protein +FIG00452515 FIG00452516: hypothetical protein +FIG00452516 FIG00452517: hypothetical protein +FIG00452517 FIG00452520: hypothetical protein +FIG00452524 FIG00452526: hypothetical protein +FIG00452527 FIG00452529: hypothetical protein +FIG00452529 FIG00452530: hypothetical protein +FIG00452530 FIG00452533: hypothetical protein +FIG00452533 FIG00452539: hypothetical protein +FIG00452541 FIG00452542: hypothetical protein +FIG00452542 FIG00452543: hypothetical protein +FIG00452543 FIG00452546: hypothetical protein +FIG00452546 FIG00452548: hypothetical protein +FIG00452549 FIG00452550: hypothetical protein +FIG00452550 FIG00452552: hypothetical protein +FIG00452552 FIG00452553: hypothetical protein +FIG00452553 FIG00452555: hypothetical protein +FIG00452555 FIG00452559: hypothetical protein +FIG00452559 FIG00452560: hypothetical protein +FIG00452562 FIG00452563: hypothetical protein +FIG00452563 FIG00452566: hypothetical protein +FIG00452566 FIG00452568: hypothetical protein +FIG00452570 protein of unknown function DUF190 +FIG00452571 FIG00452573: hypothetical protein +FIG00452574 FIG00452577: hypothetical protein +FIG00452577 ATPase associated with various cellular activities, AAA_5 +FIG00452581 FIG00452583: hypothetical protein +FIG00452583 FIG00452584: hypothetical protein +FIG00452584 FIG00452587: hypothetical protein +FIG00452587 FIG00452589: hypothetical protein +FIG00452589 FIG00452590: hypothetical protein +FIG00452590 FIG00452591: hypothetical protein +FIG00452593 FIG00452594: hypothetical protein +FIG00452596 FIG00452597: hypothetical protein +FIG00452598 FIG00452600: hypothetical protein +FIG00452600 FIG00452601: hypothetical protein +FIG00452601 FIG00452602: hypothetical protein +FIG00452603 FIG00452605: hypothetical protein +FIG00452605 FIG00452609: hypothetical protein +FIG00452609 FIG00452610: hypothetical protein +FIG00452610 ABC-type multidrug transport system ATP-binding component YhiH +FIG00452612 FIG00452614: hypothetical protein +FIG00452614 ABC-type spermidine/putrescine transport system, permease component II +FIG00452615 FIG00452616: hypothetical protein +FIG00452617 FIG00452618: hypothetical protein +FIG00452618 FIG00452619: hypothetical protein +FIG00452619 FIG00452620: hypothetical protein +FIG00452621 FIG00452626: hypothetical protein +FIG00452628 FIG00452629: hypothetical protein +FIG00452629 FIG00452630: hypothetical protein +FIG00452630 FIG00452632: hypothetical protein +FIG00452632 FIG00452635: hypothetical protein +FIG00452636 FIG00452638: hypothetical protein +FIG00452638 FIG00452639: hypothetical protein +FIG00452639 FIG00452640: hypothetical protein +FIG00452641 Cyd operon protein YbgT +FIG00452644 FIG00452645: hypothetical protein +FIG00452645 FIG00452646: hypothetical protein +FIG00452646 FIG00452648: hypothetical protein +FIG00452648 FIG00452649: hypothetical protein +FIG00452649 FIG00452650: hypothetical protein +FIG00452650 FIG00452652: hypothetical protein +FIG00452652 FIG00452653: hypothetical protein +FIG00452653 FIG00452654: hypothetical protein +FIG00452654 FIG00452655: hypothetical protein +FIG00452657 FIG00452660: hypothetical protein +FIG00452660 FIG00452664: hypothetical protein +FIG00452664 protein of unknown function DUF296 +FIG00452665 FIG00452667: hypothetical protein +FIG00452667 FIG00452671: hypothetical protein +FIG00452672 FIG00452673: hypothetical protein +FIG00452673 FIG00452675: hypothetical protein +FIG00452675 Putative alkanesulfonate metabolism utilization regulator +FIG00452677 FIG00452678: hypothetical protein +FIG00452681 FIG00452682: hypothetical protein +FIG00452682 FIG00452683: hypothetical protein +FIG00452685 FIG00452686: hypothetical protein +FIG00452686 FIG00452687: hypothetical protein +FIG00452687 Periplasmic serine proteases (ClpP class) +FIG00452689 FIG00452691: hypothetical protein +FIG00452691 FIG00452693: hypothetical protein +FIG00452693 FIG00452694: hypothetical protein +FIG00452694 FIG00452696: hypothetical protein +FIG00452698 FIG00452699: hypothetical protein +FIG00452699 FIG00452700: hypothetical protein +FIG00452701 FIG00452702: hypothetical protein +FIG00452704 FIG00452706: hypothetical protein +FIG00452707 FIG00452708: hypothetical protein +FIG00452708 FIG00452709: hypothetical protein +FIG00452709 FIG00452711: hypothetical protein +FIG00452711 FIG00452712: hypothetical protein +FIG00452712 FIG00452715: hypothetical protein +FIG00452715 FIG00452719: hypothetical protein +FIG00452719 FIG00452720: hypothetical protein +FIG00452720 FIG00452721: hypothetical protein +FIG00452722 FIG00452723: hypothetical protein +FIG00452723 FIG00452724: hypothetical protein +FIG00452727 ABC transporter, periplasmic sugar-binding protein precursor +FIG00452728 FIG00452729: hypothetical protein +FIG00452729 FIG00452731: hypothetical protein +FIG00452732 FIG00452733: hypothetical protein +FIG00452733 FIG00452734: hypothetical protein +FIG00452734 FIG00452735: hypothetical protein +FIG00452735 FIG00452738: hypothetical protein +FIG00452738 FIG00452742: hypothetical protein +FIG00452745 FIG00452746: hypothetical protein +FIG00452746 FIG00452747: hypothetical protein +FIG00452747 FIG00452749: hypothetical protein +FIG00452749 FIG00452751: hypothetical protein +FIG00452751 FIG00452753: hypothetical protein +FIG00452753 FIG00452754: hypothetical protein +FIG00452756 FIG00452758: hypothetical protein +FIG00452758 FIG00452760: hypothetical protein +FIG00452760 FIG00452761: hypothetical protein +FIG00452761 FIG00452762: hypothetical protein +FIG00452762 FIG00452763: hypothetical protein +FIG00452764 FIG00452767: hypothetical protein +FIG00452767 FIG00452769: hypothetical protein +FIG00452769 Nitrogen regulation protein NtrY (EC 2.7.3.-) +FIG00452770 FIG00452772: hypothetical protein +FIG00452772 FIG00452773: hypothetical protein +FIG00452773 FIG00452774: hypothetical protein +FIG00452774 FIG00452775: hypothetical protein +FIG00452776 FIG00975806: hypothetical protein +FIG00452779 FIG00452780: hypothetical protein +FIG00452780 FIG00452783: hypothetical protein +FIG00452783 FIG00452784: hypothetical protein +FIG00452784 FIG00452786: hypothetical protein +FIG00452786 Bicyclomycin resistance protein +FIG00452787 FIG00452788: hypothetical protein +FIG00452788 Putative cysteine dioxygenase, type I +FIG00452791 FIG00452792: hypothetical protein +FIG00452792 FIG00452793: hypothetical protein +FIG00452793 FIG00452794: hypothetical protein +FIG00452794 FIG00452795: hypothetical protein +FIG00452795 FIG00452798: hypothetical protein +FIG00452798 FIG00452799: hypothetical protein +FIG00452799 FIG00452800: hypothetical protein +FIG00452800 FIG00452801: hypothetical protein +FIG00452802 Transcriptional regulator of mannitol utilization, DeoR family protein +FIG00452804 FIG00452805: hypothetical protein +FIG00452805 FIG00452806: hypothetical protein +FIG00452806 FIG00452807: hypothetical protein +FIG00452807 FIG00452811: hypothetical protein +FIG00452814 FIG00452815: hypothetical protein +FIG00452815 FIG00452816: hypothetical protein +FIG00452816 FIG00452817: hypothetical protein +FIG00452817 FIG00452818: hypothetical protein +FIG00452818 FIG00452821: hypothetical protein +FIG00452825 FIG00452826: hypothetical protein +FIG00452826 FIG00452827: hypothetical protein +FIG00452828 FIG00452830: hypothetical protein +FIG00452830 FIG00452832: hypothetical protein +FIG00452832 FIG00452833: hypothetical protein +FIG00452833 FIG00452835: hypothetical protein +FIG00452835 FIG00452836: hypothetical protein +FIG00452836 FIG00452838: hypothetical protein +FIG00452840 FIG00452841: hypothetical protein +FIG00452841 Aminotransferase, DegT/DnrJ/EryC1/StrS family +FIG00452842 FIG00452843: hypothetical protein +FIG00452843 hypothetical protein +FIG00452844 FIG00452845: hypothetical protein +FIG00452845 FIG00452846: hypothetical protein +FIG00452846 FIG00452848: hypothetical protein +FIG00452849 FIG00452850: hypothetical protein +FIG00452850 FIG00452853: hypothetical protein +FIG00452853 FIG00452854: hypothetical protein +FIG00452855 FIG00452856: hypothetical protein +FIG00452856 FIG00452857: hypothetical protein +FIG00452857 FIG00452860: hypothetical protein +FIG00452860 FIG00452862: hypothetical protein +FIG00452862 FIG00452863: hypothetical protein +FIG00452863 FIG00452864: hypothetical protein +FIG00452864 FIG00452869: hypothetical protein +FIG00452872 Multidrug and toxin extrusion (MATE) family efflux pump YdhE/NorM, homolog +FIG00452878 FIG00452879: hypothetical protein +FIG00452879 HrpD6 protein +FIG00452883 FIG00452884: hypothetical protein +FIG00452884 FIG00452885: hypothetical protein +FIG00452885 FIG00452886: hypothetical protein +FIG00452886 FIG00452887: hypothetical protein +FIG00452887 2-polyprenyl-6-methoxyphenol hydroxylase and related FAD-dependent oxidoreductases +FIG00452889 FIG00452891: hypothetical protein +FIG00452891 FIG00452893: hypothetical protein +FIG00452893 FIG00452894: hypothetical protein +FIG00452895 FIG00452896: hypothetical protein +FIG00452896 FIG00452898: hypothetical protein +FIG00452898 FIG00452899: hypothetical protein +FIG00452899 FIG00452900: hypothetical protein +FIG00452900 FIG00452901: hypothetical protein +FIG00452901 FIG00459859: hypothetical protein +FIG00452902 hypothetical protein +FIG00452903 FIG00452906: hypothetical protein +FIG00452906 FIG00452907: hypothetical protein +FIG00452907 FIG00452908: hypothetical protein +FIG00452908 FIG00452909: hypothetical protein +FIG00452909 FIG00452911: hypothetical protein +FIG00452911 FIG00452912: hypothetical protein +FIG00452914 FIG00452915: hypothetical protein +FIG00452915 FIG00452916: hypothetical protein +FIG00452916 FIG00452917: hypothetical protein +FIG00452917 FIG00452921: hypothetical protein +FIG00452921 FIG00452922: hypothetical protein +FIG00452922 FIG00452923: hypothetical protein +FIG00452923 FIG00452924: hypothetical protein +FIG00452924 FIG00452927: hypothetical protein +FIG00452927 FIG00452928: hypothetical protein +FIG00452928 FIG00452929: hypothetical protein +FIG00452929 FIG00452930: hypothetical protein +FIG00452930 FIG00452931: hypothetical protein +FIG00452935 endonuclease Nuc +FIG00452936 FIG00452939: hypothetical protein +FIG00452939 FIG00452940: hypothetical protein +FIG00452940 FIG00452941: hypothetical protein +FIG00452942 FIG00452943: hypothetical protein +FIG00452943 FIG00452946: hypothetical protein +FIG00452946 FIG00452947: hypothetical protein +FIG00452947 FIG00452952: hypothetical protein +FIG00452952 FIG00452953: hypothetical protein +FIG00452953 FIG00452954: hypothetical protein +FIG00452954 FIG00452956: hypothetical protein +FIG00452956 FIG00452957: hypothetical protein +FIG00452957 FIG00452958: hypothetical protein +FIG00452964 FIG00452965: hypothetical protein +FIG00452965 FIG00452966: hypothetical protein +FIG00452967 FIG00452968: hypothetical protein +FIG00452968 FIG00452969: hypothetical protein +FIG00452969 FIG00452970: hypothetical protein +FIG00452970 FIG00452972: hypothetical protein +FIG00452972 FIG00452973: hypothetical protein +FIG00452976 FIG00452978: hypothetical protein +FIG00452982 Polyphosphate kinase 2 family +FIG00452985 FIG00452986: hypothetical protein +FIG00452986 FIG00452988: hypothetical protein +FIG00452990 FIG00452992: hypothetical protein +FIG00452992 FIG004891: hypothetical protein in carnitine cluster +FIG00452993 FIG00452994: hypothetical protein +FIG00452994 FIG00452996: hypothetical protein +FIG00452996 FIG00452997: hypothetical protein +FIG00452997 FIG00452999: hypothetical protein +FIG00452999 FIG00453000: hypothetical protein +FIG00453000 FIG00453002: hypothetical protein +FIG00453002 FIG00453003: hypothetical protein +FIG00453004 FIG00453006: hypothetical protein +FIG00453007 FIG00453008: hypothetical protein +FIG00453008 FIG00453010: hypothetical protein +FIG00453016 FIG00453017: hypothetical protein +FIG00453017 Hippurate hydrolase (EC 3.5.1.32) +FIG00453020 FIG00453021: hypothetical protein +FIG00453021 FIG00453022: hypothetical protein +FIG00453022 FIG00453023: hypothetical protein +FIG00453023 FIG00453026: hypothetical protein +FIG00453026 FIG00857989: hypothetical protein +FIG00453028 FIG00453029: hypothetical protein +FIG00453029 FIG00453030: hypothetical protein +FIG00453031 FIG00453032: hypothetical protein +FIG00453032 FIG00453033: hypothetical protein +FIG00453033 FIG00453034: hypothetical protein +FIG00453034 FIG00453035: hypothetical protein +FIG00453035 FIG00453037: hypothetical protein +FIG00453037 FIG00453041: hypothetical protein +FIG00453041 FIG00453043: hypothetical protein +FIG00453043 FIG00453044: hypothetical protein +FIG00453044 FIG00453045: hypothetical protein +FIG00453045 FIG00453046: hypothetical protein +FIG00453046 FIG00453047: hypothetical protein +FIG00453049 FIG00453050: hypothetical protein +FIG00453050 FIG00453052: hypothetical protein +FIG00453052 FIG00453053: hypothetical protein +FIG00453053 FIG00453057: hypothetical protein +FIG00453059 FIG00453060: hypothetical protein +FIG00453060 Protein containing transglutaminase-like domain, putative cysteine protease +FIG00453063 FIG00453064: hypothetical protein +FIG00453064 FIG00453066: hypothetical protein +FIG00453066 FIG00453067: hypothetical protein +FIG00453067 FIG00453068: hypothetical protein +FIG00453070 FIG00453071: hypothetical protein +FIG00453071 FIG00453073: hypothetical protein +FIG00453073 FIG00453074: hypothetical protein +FIG00453074 FIG00453075: hypothetical protein +FIG00453079 FIG00453080: hypothetical protein +FIG00453085 FIG00453086: hypothetical protein +FIG00453086 FIG00453087: hypothetical protein +FIG00453087 FIG00453088: hypothetical protein +FIG00453089 FIG00453090: hypothetical protein +FIG00453090 FIG00453092: hypothetical protein +FIG00453093 Putative lipopolysaccharide heptosyltransferase I +FIG00453096 FIG00453098: hypothetical protein +FIG00453098 FIG00453100: hypothetical protein +FIG00453101 FIG00453104: hypothetical protein +FIG00453110 FIG00453112: hypothetical protein +FIG00453112 FIG00453113: hypothetical protein +FIG00453113 FIG00453114: hypothetical protein +FIG00453114 FIG00453115: hypothetical protein +FIG00453115 Putative transport protein +FIG00453117 FIG00453118: hypothetical protein +FIG00453119 FIG00453121: hypothetical protein +FIG00453121 FIG00453122: hypothetical protein +FIG00453122 FIG00453123: hypothetical protein +FIG00453123 FAD/FMN-containing dehydrogenases +FIG00453125 FIG00453126: hypothetical protein +FIG00453127 FIG00453128: hypothetical protein +FIG00453130 FIG00453131: hypothetical protein +FIG00453131 FIG00453132: hypothetical protein +FIG00453132 FIG00453133: hypothetical protein +FIG00453133 FIG00453134: hypothetical protein +FIG00453134 FIG00453135: hypothetical protein +FIG00453135 FIG00453137: hypothetical protein +FIG00453139 FIG00453141: hypothetical protein +FIG00453141 FIG00453142: hypothetical protein +FIG00453145 FIG00433101: hypothetical protein +FIG00453147 FIG00453148: hypothetical protein +FIG00453148 FIG00453149: hypothetical protein +FIG00453149 FIG00453150: hypothetical protein +FIG00453150 FIG00453151: hypothetical protein +FIG00453151 FIG00453152: hypothetical protein +FIG00453152 FIG00453154: hypothetical protein +FIG00453154 FIG00453156: hypothetical protein +FIG00453156 FIG00453157: hypothetical protein +FIG00453159 FIG00453162: hypothetical protein +FIG00453162 FIG00453163: hypothetical protein +FIG00453163 FIG00453165: hypothetical protein +FIG00453165 FIG00453166: hypothetical protein +FIG00453173 FIG00453175: hypothetical protein +FIG00453175 FIG00453176: hypothetical protein +FIG00453176 FIG00453177: hypothetical protein +FIG00453178 FIG00453181: hypothetical protein +FIG00453182 FIG00453183: hypothetical protein +FIG00453183 FIG00453185: hypothetical protein +FIG00453185 FIG00453186: hypothetical protein +FIG00453186 FIG00453187: hypothetical protein +FIG00453187 FIG00453189: hypothetical protein +FIG00453189 Multidrug and toxin extrusion (MATE) family efflux pump YdhE/NorM +FIG00453191 hypothetical protein +FIG00453192 FIG00453193: hypothetical protein +FIG00453193 FIG00453194: hypothetical protein +FIG00453194 FIG00453195: hypothetical protein +FIG00453195 FIG00453197: hypothetical protein +FIG00453197 FIG00453198: hypothetical protein +FIG00453198 FIG00453199: hypothetical protein +FIG00453199 FIG00453200: hypothetical protein +FIG00453200 FIG00453202: hypothetical protein +FIG00453202 FIG00453203: hypothetical protein +FIG00453203 FIG00453204: hypothetical protein +FIG00453204 FIG00453206: hypothetical protein +FIG00453206 FIG00453207: hypothetical protein +FIG00453209 Predicted extracellular endo alpha-1,4 polygalactosaminidase or related polysaccharide hydrolase +FIG00453212 FIG00453214: hypothetical protein +FIG00453214 FIG00453215: hypothetical protein +FIG00453215 FIG00453217: hypothetical protein +FIG00453217 FIG00453218: hypothetical protein +FIG00453220 FIG00453221: hypothetical protein +FIG00453221 FIG00453222: hypothetical protein +FIG00453222 FIG00453223: hypothetical protein +FIG00453223 FIG00453225: hypothetical protein +FIG00453225 FIG00453226: hypothetical protein +FIG00453226 FIG00453227: hypothetical protein +FIG00453227 FIG00453229: hypothetical protein +FIG00453229 FIG00453230: hypothetical protein +FIG00453230 FIG00453231: hypothetical protein +FIG00453231 FIG00453232: hypothetical protein +FIG00453232 FIG00453234: hypothetical protein +FIG00453234 FIG00453236: hypothetical protein +FIG00453236 FIG00453237: hypothetical protein +FIG00453237 FIG00453238: hypothetical protein +FIG00453238 FIG00453242: hypothetical protein +FIG00453242 FIG00453243: hypothetical protein +FIG00453243 FIG00453245: hypothetical protein +FIG00453245 FIG00453246: hypothetical protein +FIG00453246 FIG00453247: hypothetical protein +FIG00453247 FIG00453248: hypothetical protein +FIG00453248 Phosphoenolpyruvate-protein phosphotransferase of PTS system (EC 2.7.3.9) / PTS system, glucose-specific IIA component (EC 2.7.1.69) +FIG00453249 FIG00453250: hypothetical protein +FIG00453250 FIG00453251: hypothetical protein +FIG00453251 FIG00453253: hypothetical protein +FIG00453254 FIG00453257: hypothetical protein +FIG00453258 FIG00453259: hypothetical protein +FIG00453259 Sorbitol dehydrogenase (EC 1.1.1.14) +FIG00453262 FIG00453263: hypothetical protein +FIG00453263 FIG00453266: hypothetical protein +FIG00453270 FIG00453271: hypothetical protein +FIG00453276 FIG00453278: hypothetical protein +FIG00453279 2-polyprenyl-6-methoxyphenol hydroxylase and related FAD-dependent oxidoreductases +FIG00453280 FIG00453281: hypothetical protein +FIG00453281 FIG00453282: hypothetical protein +FIG00453282 FIG00453284: hypothetical protein +FIG00453284 FIG00453286: hypothetical protein +FIG00453286 FIG00453289: hypothetical protein +FIG00453290 FIG00453291: hypothetical protein +FIG00453291 FIG00453292: hypothetical protein +FIG00453293 Lipase activator protein, Lipase-specific foldase +FIG00453294 ABC transporter amino acid-binding protein +FIG00453296 FIG00453297: hypothetical protein +FIG00453297 PAAR motif family +FIG00453300 FIG00453302: hypothetical protein +FIG00453302 FIG00453303: hypothetical protein +FIG00453303 FIG00453304: hypothetical protein +FIG00453304 FIG00453306: hypothetical protein +FIG00453306 FIG00453308: hypothetical protein +FIG00453309 FIG00453310: hypothetical protein +FIG00453311 FIG00453314: hypothetical protein +FIG00453314 FIG00453316: hypothetical protein +FIG00453316 FIG00453317: hypothetical protein +FIG00453317 FIG00453318: hypothetical protein +FIG00453318 hypothetical protein +FIG00453321 FIG00453322: hypothetical protein +FIG00453322 FIG00453323: hypothetical protein +FIG00453323 FIG00453325: hypothetical protein +FIG00453327 FIG00453328: hypothetical protein +FIG00453328 FIG00453331: hypothetical protein +FIG00453331 FIG00453334: hypothetical protein +FIG00453335 FIG00453337: hypothetical protein +FIG00453340 FIG00453341: hypothetical protein +FIG00453341 FIG00453342: hypothetical protein +FIG00453342 hypothetical protein +FIG00453347 FIG00453348: hypothetical protein +FIG00453351 FIG00453354: hypothetical protein +FIG00453354 FIG00453356: hypothetical protein +FIG00453356 FIG00453357: hypothetical protein +FIG00453357 FIG00453358: hypothetical protein +FIG00453358 FIG00453359: hypothetical protein +FIG00453359 FIG00453360: hypothetical protein +FIG00453360 FIG00453362: hypothetical protein +FIG00453362 FIG00453363: hypothetical protein +FIG00453367 FIG00453368: hypothetical protein +FIG00453368 FIG00453369: hypothetical protein +FIG00453371 FIG00453372: hypothetical protein +FIG00453372 FIG00453375: hypothetical protein +FIG00453375 FIG00453376: hypothetical protein +FIG00453376 FIG00453378: hypothetical protein +FIG00453378 FIG00453379: hypothetical protein +FIG00453380 hypothetical protein +FIG00453384 FIG00453387: hypothetical protein +FIG00453388 hypothetical protein +FIG00453390 FIG00453391: hypothetical protein +FIG00453391 FIG00453392: hypothetical protein +FIG00453392 FIG00453394: hypothetical protein +FIG00453395 FIG00453396: hypothetical protein +FIG00453396 FIG00453397: hypothetical protein +FIG00453397 FIG00453398: hypothetical protein +FIG00453398 FIG00453399: hypothetical protein +FIG00453399 COG1172: Ribose/xylose/arabinose/galactoside ABC-type transport systems, permease components +FIG00453400 FIG00453401: hypothetical protein +FIG00453401 FIG00453404: hypothetical protein +FIG00453408 FIG00453411: hypothetical protein +FIG00453411 FIG00453412: hypothetical protein +FIG00453412 FIG00453413: hypothetical protein +FIG00453413 FIG00453415: hypothetical protein +FIG00453415 FIG00453416: hypothetical protein +FIG00453418 FIG00453420: hypothetical protein +FIG00453420 FIG00453421: hypothetical protein +FIG00453421 FIG00453422: hypothetical protein +FIG00453422 FIG00453423: hypothetical protein +FIG00453423 FIG00453424: hypothetical protein +FIG00453425 FIG00453428: hypothetical protein +FIG00453428 FIG00453432: hypothetical protein +FIG00453432 FIG00453433: hypothetical protein +FIG00453433 FIG00453435: hypothetical protein +FIG00453435 FIG00453438: hypothetical protein +FIG00453438 FIG00453439: hypothetical protein +FIG00453440 FIG00453441: hypothetical protein +FIG00453441 FIG00453443: hypothetical protein +FIG00453446 FIG00453449: hypothetical protein +FIG00453449 Flp pilus assembly protein TadD, contains TPR repeats +FIG00453453 FIG00453454: hypothetical protein +FIG00453454 FIG00453455: hypothetical protein +FIG00453458 FIG00453463: hypothetical protein +FIG00453463 FIG00453465: hypothetical protein +FIG00453465 FIG00453468: hypothetical protein +FIG00453468 FIG00453469: hypothetical protein +FIG00453469 FIG00453471: hypothetical protein +FIG00453471 FIG00453473: hypothetical protein +FIG00453473 FIG00453474: hypothetical protein +FIG00453474 FIG00453477: hypothetical protein +FIG00453477 ABC glycine betaine/choline transporter, periplasmic ligand binding protein +FIG00453478 FIG00453479: hypothetical protein +FIG00453481 FIG00453483: hypothetical protein +FIG00453483 FIG00453484: hypothetical protein +FIG00453484 FIG00453485: hypothetical protein +FIG00453492 FIG00453493: hypothetical protein +FIG00453495 FIG00453496: hypothetical protein +FIG00453496 FIG00453497: hypothetical protein +FIG00453497 FIG00453499: hypothetical protein +FIG00453499 FIG00453500: hypothetical protein +FIG00453500 FIG00453501: hypothetical protein +FIG00453501 FIG00453502: hypothetical protein +FIG00453502 FIG01211190: hypothetical protein +FIG00453504 FIG00453505: hypothetical protein +FIG00453506 FIG00453507: hypothetical protein +FIG00453512 FIG00453513: hypothetical protein +FIG00453513 FIG00453514: hypothetical protein +FIG00453514 FIG00453517: hypothetical protein +FIG00453517 FIG00453518: hypothetical protein +FIG00453518 FIG00453519: hypothetical protein +FIG00453519 FIG00977343: hypothetical protein +FIG00453523 FIG00453525: hypothetical protein +FIG00453525 FIG00453526: hypothetical protein +FIG00453526 FIG00453527: hypothetical protein +FIG00453527 FIG00453529: hypothetical protein +FIG00453529 FIG00453530: hypothetical protein +FIG00453530 FIG00453531: hypothetical protein +FIG00453531 FIG00453532: hypothetical protein +FIG00453532 FIG00453537: hypothetical protein +FIG00453537 FIG00453538: hypothetical protein +FIG00453538 FIG00453539: hypothetical protein +FIG00453539 FIG00453540: hypothetical protein +FIG00453540 FIG00453544: hypothetical protein +FIG00453544 FIG00453547: hypothetical protein +FIG00453553 FIG00453555: hypothetical protein +FIG00453555 FIG00453556: hypothetical protein +FIG00453556 FIG00453557: hypothetical protein +FIG00453557 FIG00453560: hypothetical protein +FIG00453560 FIG00453563: hypothetical protein +FIG00453563 FIG00453564: hypothetical protein +FIG00453564 FIG00453565: hypothetical protein +FIG00453568 FIG00453569: hypothetical protein +FIG00453569 FIG00453570: hypothetical protein +FIG00453570 FIG00453571: hypothetical protein +FIG00453571 FIG00453572: hypothetical protein +FIG00453572 FIG00453573: hypothetical protein +FIG00453576 FIG00453579: hypothetical protein +FIG00453579 FIG00453580: hypothetical protein +FIG00453580 FIG00453582: hypothetical protein +FIG00453583 FIG00453584: hypothetical protein +FIG00453585 FIG00453586: hypothetical protein +FIG00453587 FIG00453589: hypothetical protein +FIG00453589 FIG00453591: hypothetical protein +FIG00453591 FIG00453592: hypothetical protein +FIG00453592 FIG00453593: hypothetical protein +FIG00453594 FIG00453595: hypothetical protein +FIG00453596 FIG00453597: hypothetical protein +FIG00453597 FIG00453598: hypothetical protein +FIG00453598 FIG00453600: hypothetical protein +FIG00453600 FIG00453601: hypothetical protein +FIG00453601 FIG00453602: hypothetical protein +FIG00453602 FIG00453605: hypothetical protein +FIG00453605 FIG00453606: hypothetical protein +FIG00453606 FIG00453608: hypothetical protein +FIG00453608 FIG00453609: hypothetical protein +FIG00453611 FIG00453612: hypothetical protein +FIG00453612 FIG00453614: hypothetical protein +FIG00453614 FIG00453615: hypothetical protein +FIG00453615 FIG00453616: hypothetical protein +FIG00453616 FIG00453617: hypothetical protein +FIG00453617 FIG00453618: hypothetical protein +FIG00453618 FIG00453619: hypothetical protein +FIG00453624 FIG00453627: hypothetical protein +FIG00453630 FIG00453631: hypothetical protein +FIG00453631 FIG00453632: hypothetical protein +FIG00453633 FIG00453635: hypothetical protein +FIG00453635 FIG00453636: hypothetical protein +FIG00453637 FIG00453639: hypothetical protein +FIG00453639 FIG00453642: hypothetical protein +FIG00453648 FIG00453649: hypothetical protein +FIG00453649 FIG00453651: hypothetical protein +FIG00453664 FIG00453665: hypothetical protein +FIG00453665 FAD dependent oxidoreductase +FIG00453666 FIG00453667: hypothetical protein +FIG00453667 FIG00453669: hypothetical protein +FIG00453669 FIG00453670: hypothetical protein +FIG00453670 FIG00453671: hypothetical protein +FIG00453671 FIG00453674: hypothetical protein +FIG00453675 FIG00453679: hypothetical protein +FIG00453679 FIG00453680: hypothetical protein +FIG00453680 FIG00453681: hypothetical protein +FIG00453681 FIG00453682: hypothetical protein +FIG00453682 FIG00453684: hypothetical protein +FIG00453693 FIG00453694: hypothetical protein +FIG00453694 FIG00453696: hypothetical protein +FIG00453696 FIG00453697: hypothetical protein +FIG00453697 FIG00453698: hypothetical protein +FIG00453698 FIG00453699: hypothetical protein +FIG00453699 FIG00453700: hypothetical protein +FIG00453700 FIG00453704: hypothetical protein +FIG00453704 FIG00453705: hypothetical protein +FIG00453705 FIG00453708: hypothetical protein +FIG00453708 FIG00453709: hypothetical protein +FIG00453709 FIG00453710: hypothetical protein +FIG00453710 FIG00453712: hypothetical protein +FIG00453715 FIG00453716: hypothetical protein +FIG00453716 FIG00453717: hypothetical protein +FIG00453717 FIG00453718: hypothetical protein +FIG00453718 FIG00453721: hypothetical protein +FIG00453721 FIG00453722: hypothetical protein +FIG00453725 FIG00453727: hypothetical protein +FIG00453727 FIG00453728: hypothetical protein +FIG00453728 FIG00453729: hypothetical protein +FIG00453729 FIG00453731: hypothetical protein +FIG00453734 FIG00453736: hypothetical protein +FIG00453737 FIG00453740: hypothetical protein +FIG00453740 FIG00453741: hypothetical protein +FIG00453741 FIG011069: putative type III secretion protein +FIG00453742 FIG00453744: hypothetical protein +FIG00453744 FIG00453745: hypothetical protein +FIG00453749 FIG00453751: hypothetical protein +FIG00453751 methyltransferase FkbM family +FIG00453752 FIG00453754: hypothetical protein +FIG00453759 FIG00453760: hypothetical protein +FIG00453762 FIG00453763: hypothetical protein +FIG00453763 FIG00453766: hypothetical protein +FIG00453766 FIG00453767: hypothetical protein +FIG00453767 FIG00453768: hypothetical protein +FIG00453770 FIG00453772: hypothetical protein +FIG00453774 FIG00453775: hypothetical protein +FIG00453775 FIG00453777: hypothetical protein +FIG00453783 FIG00453784: hypothetical protein +FIG00453784 FIG00453785: hypothetical protein +FIG00453785 FIG00453786: hypothetical protein +FIG00453788 FIG00453789: hypothetical protein +FIG00453789 FIG00453790: hypothetical protein +FIG00453790 FIG00453791: hypothetical protein +FIG00453793 FIG00453794: hypothetical protein +FIG00453794 FIG00453797: hypothetical protein +FIG00453797 FIG00453798: hypothetical protein +FIG00453798 FIG00453799: hypothetical protein +FIG00453800 FIG00453801: hypothetical protein +FIG00453801 FIG00453804: hypothetical protein +FIG00453804 ABC polar amino acid family transporter, innermembrane subunit +FIG00453806 FIG00453808: hypothetical protein +FIG00453808 FIG00453810: hypothetical protein +FIG00453812 FIG00453813: hypothetical protein +FIG00453813 FIG00453815: hypothetical protein +FIG00453815 FIG00453816: hypothetical protein +FIG00453816 FIG00453817: hypothetical protein +FIG00453822 Entericidin +FIG00453826 FIG00453827: hypothetical protein +FIG00453827 FIG00453828: hypothetical protein +FIG00453828 FIG00453830: hypothetical protein +FIG00453830 FIG00453831: hypothetical protein +FIG00453831 hypothetical protein +FIG00453834 FIG00453836: hypothetical protein +FIG00453836 FIG00453837: hypothetical protein +FIG00453837 FIG00453839: hypothetical protein +FIG00453839 FIG00453840: hypothetical protein +FIG00453840 FIG00453841: hypothetical protein +FIG00453843 FIG00453844: hypothetical protein +FIG00453844 FIG00453845: hypothetical protein +FIG00453847 FIG00453852: hypothetical protein +FIG00453856 FIG00453857: hypothetical protein +FIG00453857 Tellurium resistance protein +FIG00453861 FIG00453862: hypothetical protein +FIG00453863 FIG00453864: hypothetical protein +FIG00453864 FIG00453866: hypothetical protein +FIG00453866 FIG00453867: hypothetical protein +FIG00453867 FIG00453868: hypothetical protein +FIG00453868 FIG00453870: hypothetical protein +FIG00453870 Type III secretion protein HrpB2 +FIG00453871 FIG00453873: hypothetical protein +FIG00453875 FIG00453876: hypothetical protein +FIG00453876 FIG00453877: hypothetical protein +FIG00453877 FIG00453878: hypothetical protein +FIG00453878 FIG00453879: hypothetical protein +FIG00453879 FIG005274: hypothetical protein +FIG00453880 FIG00453881: hypothetical protein +FIG00453881 FIG00453882: hypothetical protein +FIG00453882 FIG00453884: hypothetical protein +FIG00453884 FIG00453885: hypothetical protein +FIG00453885 Rhodanese domain protein UPF0176, Betaproteobacterial subgroup +FIG00453886 FIG00453891: hypothetical protein +FIG00453891 FIG00453894: hypothetical protein +FIG00453894 FIG00453898: hypothetical protein +FIG00453898 Type III secretion protein HrpB7 +FIG00453900 FIG00453902: hypothetical protein +FIG00453903 fimbrial assembly chaperone +FIG00453905 FIG00453907: hypothetical protein +FIG00453910 FIG00453912: hypothetical protein +FIG00453912 FIG00453914: hypothetical protein +FIG00453914 FIG00453917: hypothetical protein +FIG00453917 FIG00453918: hypothetical protein +FIG00453918 FIG00453919: hypothetical protein +FIG00453919 FIG00453920: hypothetical protein +FIG00453920 FIG00453921: hypothetical protein +FIG00453921 FIG00453922: hypothetical protein +FIG00453927 FIG00977558: hypothetical protein +FIG00453928 FIG00453930: hypothetical protein +FIG00453930 FIG00453931: hypothetical protein +FIG00453932 FIG00453933: hypothetical protein +FIG00453933 FIG00453934: hypothetical protein +FIG00453935 FIG00453936: hypothetical protein +FIG00453936 FIG00453938: hypothetical protein +FIG00453938 FIG00453939: hypothetical protein +FIG00453940 FIG00453942: hypothetical protein +FIG00453942 FIG00453943: hypothetical protein +FIG00453943 FIG00453945: hypothetical protein +FIG00453945 FIG00453946: hypothetical protein +FIG00453946 FIG00453947: hypothetical protein +FIG00453947 FIG00453948: hypothetical protein +FIG00453948 FIG00453949: hypothetical protein +FIG00453949 FIG00453950: hypothetical protein +FIG00453950 FIG00453951: hypothetical protein +FIG00453951 FIG00453953: hypothetical protein +FIG00453954 FIG00453955: hypothetical protein +FIG00453955 FIG00453957: hypothetical protein +FIG00453958 FIG00453960: hypothetical protein +FIG00453960 macromolecule metabolism; macromolecule synthesis, modification; dna - replication, repair, restr./modif. +FIG00453961 FIG00453962: hypothetical protein +FIG00453962 FIG00453963: hypothetical protein +FIG00453964 FIG00453965: hypothetical protein +FIG00453965 FIG00453968: hypothetical protein +FIG00453969 FIG00453970: hypothetical protein +FIG00453972 FIG00453973: hypothetical protein +FIG00453973 Uncharacterized homolog of gamma-carboxymuconolactone decarboxylase subunit +FIG00453974 FIG00453977: hypothetical protein +FIG00453977 FIG00459104: hypothetical protein +FIG00453981 FIG00453983: hypothetical protein +FIG00453986 FIG00453987: hypothetical protein +FIG00453987 FIG00453989: hypothetical protein +FIG00453989 FIG00453990: hypothetical protein +FIG00453990 FIG00453991: hypothetical protein +FIG00453991 FIG00453992: hypothetical protein +FIG00453992 FIG00453993: hypothetical protein +FIG00453993 FIG00453996: hypothetical protein +FIG00453996 FIG00453997: hypothetical protein +FIG00453997 FIG00454000: hypothetical protein +FIG00454000 FIG00454001: hypothetical protein +FIG00454005 FIG00454006: hypothetical protein +FIG00454006 FIG00454007: hypothetical protein +FIG00454008 Sugar transferase (EC 2.7.8.6) +FIG00454009 FIG00454010: hypothetical protein +FIG00454010 FIG00454013: hypothetical protein +FIG00454013 Phage Transcriptional regulator, AlpA +FIG00454019 FIG00454020: hypothetical protein +FIG00454020 Hcp +FIG00454022 FIG00454024: hypothetical protein +FIG00454024 Rossmann fold nucleotide-binding protein-like +FIG00454025 FIG00454028: hypothetical protein +FIG00454028 FIG00454029: hypothetical protein +FIG00454029 FIG00454030: hypothetical protein +FIG00454030 FIG00454031: hypothetical protein +FIG00454031 FIG00454032: hypothetical protein +FIG00454032 methyltransferase family protein +FIG00454034 FIG00454035: hypothetical protein +FIG00454035 FIG00454036: hypothetical protein +FIG00454036 FIG00454037: hypothetical protein +FIG00454037 FIG00454038: hypothetical protein +FIG00454038 FIG00454039: hypothetical protein +FIG00454039 FIG00454040: hypothetical protein +FIG00454040 FIG00454041: hypothetical protein +FIG00454041 FIG00454042: hypothetical protein +FIG00454042 FIG00454043: hypothetical protein +FIG00454043 FIG00454046: hypothetical protein +FIG00454046 hypothetical protein +FIG00454050 FIG00454052: hypothetical protein +FIG00454052 FIG00454053: hypothetical protein +FIG00454053 FIG00454055: hypothetical protein +FIG00454055 FIG00454056: hypothetical protein +FIG00454056 FIG00454057: hypothetical protein +FIG00454058 FIG00454059: hypothetical protein +FIG00454059 FIG00454061: hypothetical protein +FIG00454061 FIG00454062: hypothetical protein +FIG00454064 FIG00454066: hypothetical protein +FIG00454066 FIG00454067: hypothetical protein +FIG00454075 FIG00454077: hypothetical protein +FIG00454077 FIG00454079: hypothetical protein +FIG00454079 FIG00454081: hypothetical protein +FIG00454083 FIG00454084: hypothetical protein +FIG00454084 FIG00454085: hypothetical protein +FIG00454088 FIG00454089: hypothetical protein +FIG00454089 FIG00454091: hypothetical protein +FIG00454091 Transcriptional activator of acetoin/glycerol metabolism +FIG00454092 FIG00454094: hypothetical protein +FIG00454094 FIG00454095: hypothetical protein +FIG00454095 FIG00454096: hypothetical protein +FIG00454096 FIG00454097: hypothetical protein +FIG00454097 FIG00454098: hypothetical protein +FIG00454098 FIG00454099: hypothetical protein +FIG00454104 FIG00454105: hypothetical protein +FIG00454108 FIG00454111: hypothetical protein +FIG00454111 FIG00454112: hypothetical protein +FIG00454112 FIG00454113: hypothetical protein +FIG00454113 FIG00454114: hypothetical protein +FIG00454114 FIG00454115: hypothetical protein +FIG00454115 FIG00454116: hypothetical protein +FIG00454119 FIG00454120: hypothetical protein +FIG00454123 FIG00454124: hypothetical protein +FIG00454124 FIG00454129: hypothetical protein +FIG00454129 FIG00454130: hypothetical protein +FIG00454130 FIG00454131: hypothetical protein +FIG00454131 FIG00454132: hypothetical protein +FIG00454132 FIG00454134: hypothetical protein +FIG00454135 FIG00454136: hypothetical protein +FIG00454136 FIG00454141: hypothetical protein +FIG00454141 FIG00454142: hypothetical protein +FIG00454142 FIG00454145: hypothetical protein +FIG00454146 FIG00454148: hypothetical protein +FIG00454148 FIG00454149: hypothetical protein +FIG00454150 FIG00454151: hypothetical protein +FIG00454151 FIG00454154: hypothetical protein +FIG00454157 FIG00454158: hypothetical protein +FIG00454158 Amidase (EC 3.5.1.4) +FIG00454160 FIG00454161: hypothetical protein +FIG00454162 FIG00454163: hypothetical protein +FIG00454166 FIG00454167: hypothetical protein +FIG00454167 FIG00454169: hypothetical protein +FIG00454170 FIG00454172: hypothetical protein +FIG00454172 FIG00454174: hypothetical protein +FIG00454174 FIG00454178: hypothetical protein +FIG00454180 FIG00454181: hypothetical protein +FIG00454181 FIG00454182: hypothetical protein +FIG00454182 FIG00454183: hypothetical protein +FIG00454183 FIG00454185: hypothetical protein +FIG00454185 Pyrrolnitrin biosynthesis enzyme PrnB from tryptophan dioxygenase family +FIG00454186 FIG00454187: hypothetical protein +FIG00454187 FIG00454188: hypothetical protein +FIG00454188 FIG00454189: hypothetical protein +FIG00454189 FIG00454190: hypothetical protein +FIG00454190 Gll2745 protein +FIG00454194 hypothetical protein +FIG00454195 FIG00454196: hypothetical protein +FIG00454199 FIG00454200: hypothetical protein +FIG00454200 FIG00454201: hypothetical protein +FIG00454202 FIG00454203: hypothetical protein +FIG00454203 FIG00454205: hypothetical protein +FIG00454205 FIG00454206: hypothetical protein +FIG00454206 FIG00454207: hypothetical protein +FIG00454207 FIG00454208: hypothetical protein +FIG00454208 FIG00454210: hypothetical protein +FIG00454210 FIG00454212: hypothetical protein +FIG00454213 FIG00454215: hypothetical protein +FIG00454215 FIG00454216: hypothetical protein +FIG00454218 FIG00454220: hypothetical protein +FIG00454220 macromolecule metabolism; macromolecule degradation; degradation of proteins, peptides, glycopeptides +FIG00454221 FIG00454226: hypothetical protein +FIG00454227 FIG00454228: hypothetical protein +FIG00454228 FIG00454229: hypothetical protein +FIG00454231 FIG00454234: hypothetical protein +FIG00454236 FIG00454237: hypothetical protein +FIG00454238 FIG00454239: hypothetical protein +FIG00454241 FIG00454242: hypothetical protein +FIG00454242 FIG00454244: hypothetical protein +FIG00454244 FIG00454248: hypothetical protein +FIG00454248 FIG00454249: hypothetical protein +FIG00454251 hypothetical protein +FIG00454253 FIG00454254: hypothetical protein +FIG00454254 FIG00454255: hypothetical protein +FIG00454255 Heat shock protein Hsp20 +FIG00454256 FIG00454257: hypothetical protein +FIG00454259 FIG00454260: hypothetical protein +FIG00454260 FIG00454261: hypothetical protein +FIG00454261 FIG00454262: hypothetical protein +FIG00454262 FIG00454264: hypothetical protein +FIG00454264 FIG00454265: hypothetical protein +FIG00454265 FIG00454267: hypothetical protein +FIG00454267 FIG00454268: hypothetical protein +FIG00454268 integrase, catalytic region +FIG00454270 FIG00454272: hypothetical protein +FIG00454272 FIG00454273: hypothetical protein +FIG00454273 FIG00454274: hypothetical protein +FIG00454274 FIG00454277: hypothetical protein +FIG00454277 FIG00454279: hypothetical protein +FIG00454279 FIG00454281: hypothetical protein +FIG00454281 FIG00454284: hypothetical protein +FIG00454287 FIG00454288: hypothetical protein +FIG00454288 Dihydrodipicolinate synthase family +FIG00454289 FIG00454290: hypothetical protein +FIG00454290 FIG00454292: hypothetical protein +FIG00454296 FIG00454297: hypothetical protein +FIG00454297 FIG00454298: hypothetical protein +FIG00454298 FIG00454299: hypothetical protein +FIG00454300 FIG00454301: hypothetical protein +FIG00454302 FIG00454303: hypothetical protein +FIG00454303 FIG00454304: hypothetical protein +FIG00454304 FIG00464095: hypothetical protein +FIG00454306 FIG00454308: hypothetical protein +FIG00454309 FIG00454312: hypothetical protein +FIG00454312 FIG00454313: hypothetical protein +FIG00454313 FIG00454315: hypothetical protein +FIG00454318 FIG00454321: hypothetical protein +FIG00454322 FIG00454323: hypothetical protein +FIG00454324 FIG00454325: hypothetical protein +FIG00454325 FIG00454326: hypothetical protein +FIG00454327 FIG00454328: hypothetical protein +FIG00454328 FIG00454330: hypothetical protein +FIG00454330 FIG00454331: hypothetical protein +FIG00454331 FIG00454332: hypothetical protein +FIG00454332 FIG00454337: hypothetical protein +FIG00454337 FIG00454338: hypothetical protein +FIG00454339 FIG00454342: hypothetical protein +FIG00454345 FIG00454348: hypothetical protein +FIG00454348 FIG00454349: hypothetical protein +FIG00454349 FIG00454356: hypothetical protein +FIG00454356 FIG00454357: hypothetical protein +FIG00454360 Dehydrogenases (flavoproteins) +FIG00454361 FIG00999102: hypothetical protein +FIG00454363 FIG00454364: hypothetical protein +FIG00454367 FIG00454369: hypothetical protein +FIG00454369 FIG001767: L-rhamnose operon transcriptional activator RhaR +FIG00454370 FIG00454373: hypothetical protein +FIG00454376 FIG00454377: hypothetical protein +FIG00454377 FIG00454378: hypothetical protein +FIG00454380 FIG00454381: hypothetical protein +FIG00454381 FIG00454382: hypothetical protein +FIG00454385 FIG00454388: hypothetical protein +FIG00454388 FIG00454389: hypothetical protein +FIG00454389 FIG00454392: hypothetical protein +FIG00454393 FIG00454394: hypothetical protein +FIG00454394 FIG00454395: hypothetical protein +FIG00454397 FIG00454399: hypothetical protein +FIG00454399 FIG00454400: hypothetical protein +FIG00454400 FIG00454402: hypothetical protein +FIG00454402 FIG00454404: hypothetical protein +FIG00454404 FIG00454405: hypothetical protein +FIG00454405 FIG00454406: hypothetical protein +FIG00454406 FIG00454408: hypothetical protein +FIG00454408 FIG00454409: hypothetical protein +FIG00454410 FIG00454411: hypothetical protein +FIG00454411 FIG00454412: hypothetical protein +FIG00454413 FIG00454415: hypothetical protein +FIG00454417 FIG00454418: hypothetical protein +FIG00454418 FIG00454419: hypothetical protein +FIG00454419 FIG00454420: hypothetical protein +FIG00454420 FIG00454422: hypothetical protein +FIG00454422 FIG00454424: hypothetical protein +FIG00454430 FIG00454431: hypothetical protein +FIG00454431 Amidinotransferase family protein +FIG00454433 FIG00454434: hypothetical protein +FIG00454434 FIG00454435: hypothetical protein +FIG00454435 FIG00454436: hypothetical protein +FIG00454436 FIG00454437: hypothetical protein +FIG00454437 FIG00454439: hypothetical protein +FIG00454439 FIG00454442: hypothetical protein +FIG00454443 FIG00454445: hypothetical protein +FIG00454445 FIG00454446: hypothetical protein +FIG00454448 FIG00454450: hypothetical protein +FIG00454450 FIG00454451: hypothetical protein +FIG00454451 FIG00454454: hypothetical protein +FIG00454454 FIG00454455: hypothetical protein +FIG00454455 FIG00454457: hypothetical protein +FIG00454457 FIG00454460: hypothetical protein +FIG00454460 FIG00454461: hypothetical protein +FIG00454462 FIG00454463: hypothetical protein +FIG00454464 FIG00454465: hypothetical protein +FIG00454465 FIG00454466: hypothetical protein +FIG00454466 FIG00454467: hypothetical protein +FIG00454467 FIG00454469: hypothetical protein +FIG00454469 FIG00454470: hypothetical protein +FIG00454470 FIG00454471: hypothetical protein +FIG00454473 FIG00454474: hypothetical protein +FIG00454474 FIG00454476: hypothetical protein +FIG00454476 FIG00454477: hypothetical protein +FIG00454477 FIG00454478: hypothetical protein +FIG00454478 FIG00454479: hypothetical protein +FIG00454479 FIG00454483: hypothetical protein +FIG00454484 FIG00454485: hypothetical protein +FIG00454485 FIG00454487: hypothetical protein +FIG00454487 FIG00454489: hypothetical protein +FIG00454489 FIG00454491: hypothetical protein +FIG00454491 FIG00454493: hypothetical protein +FIG00454493 FIG00454494: hypothetical protein +FIG00454494 FIG00454495: hypothetical protein +FIG00454495 FIG00454496: hypothetical protein +FIG00454496 FIG00454497: hypothetical protein +FIG00454498 AraC-type DNA-binding domain-containing proteins +FIG00454499 FIG00454500: hypothetical protein +FIG00454500 FIG00454502: hypothetical protein +FIG00454503 FIG00454504: hypothetical protein +FIG00454504 FIG00454505: hypothetical protein +FIG00454508 FIG00454510: hypothetical protein +FIG00454510 FIG00454511: hypothetical protein +FIG00454515 FIG00808917: hypothetical protein +FIG00454518 FIG00454520: hypothetical protein +FIG00454520 FIG00454522: hypothetical protein +FIG00454522 FIG00454523: hypothetical protein +FIG00454523 FIG00454524: hypothetical protein +FIG00454527 FIG00454528: hypothetical protein +FIG00454529 FIG00454530: hypothetical protein +FIG00454531 FIG00454535: hypothetical protein +FIG00454536 FIG00454540: hypothetical protein +FIG00454543 FIG00454545: hypothetical protein +FIG00454545 FIG00454547: hypothetical protein +FIG00454548 FIG00454549: hypothetical protein +FIG00454549 FIG00454550: hypothetical protein +FIG00454551 FIG00454553: hypothetical protein +FIG00454553 FIG00454554: hypothetical protein +FIG00454554 FIG00454555: hypothetical protein +FIG00454555 FIG00454557: hypothetical protein +FIG00454557 FIG00454558: hypothetical protein +FIG00454560 FIG00454561: hypothetical protein +FIG00454561 FIG00454565: hypothetical protein +FIG00454565 hypothetical protein +FIG00454573 FIG00454574: hypothetical protein +FIG00454575 FIG00454576: hypothetical protein +FIG00454576 FIG00454577: hypothetical protein +FIG00454578 FIG00454579: hypothetical protein +FIG00454579 FIG00454580: hypothetical protein +FIG00454580 FIG00454582: hypothetical protein +FIG00454582 FIG00454583: hypothetical protein +FIG00454583 FIG00454586: hypothetical protein +FIG00454586 FIG00454588: hypothetical protein +FIG00454588 FIG00454589: hypothetical protein +FIG00454589 FIG00454591: hypothetical protein +FIG00454591 Putative 4-hydroxybenzoyl CoA thioesterase (EC 3.1.2.23) +FIG00454593 FIG00454594: hypothetical protein +FIG00454594 FIG00454595: hypothetical protein +FIG00454595 FIG00454596: hypothetical protein +FIG00454597 FIG00454600: hypothetical protein +FIG00454600 FIG00454602: hypothetical protein +FIG00454602 FIG00454603: hypothetical protein +FIG00454603 FIG00454606: hypothetical protein +FIG00454609 FIG00454610: hypothetical protein +FIG00454612 FIG00454613: hypothetical protein +FIG00454616 FIG00454617: hypothetical protein +FIG00454617 FIG00454618: hypothetical protein +FIG00454620 FIG00454621: hypothetical protein +FIG00454621 PROBABLE HYDROLASE PROTEIN +FIG00454627 FIG00454628: hypothetical protein +FIG00454628 FIG00454629: hypothetical protein +FIG00454632 FIG00454633: hypothetical protein +FIG00454633 FIG00454635: hypothetical protein +FIG00454635 FIG00454636: hypothetical protein +FIG00454637 FIG00454638: hypothetical protein +FIG00454640 FIG00454641: hypothetical protein +FIG00454641 FIG00454642: hypothetical protein +FIG00454642 FIG00454643: hypothetical protein +FIG00454643 FIG00454644: hypothetical protein +FIG00454644 FIG00454645: hypothetical protein +FIG00454646 FIG00454648: hypothetical protein +FIG00454648 FIG00454649: hypothetical protein +FIG00454657 FIG00454660: hypothetical protein +FIG00454660 FIG00454661: hypothetical protein +FIG00454661 FIG00459599: hypothetical protein +FIG00454664 FIG00454667: hypothetical protein +FIG00454667 FIG00454669: hypothetical protein +FIG00454669 FIG00454670: hypothetical protein +FIG00454670 FIG00454673: hypothetical protein +FIG00454673 FIG00454676: hypothetical protein +FIG00454676 FIG00454677: hypothetical protein +FIG00454679 FIG00454680: hypothetical protein +FIG00454680 FIG00454683: hypothetical protein +FIG00454683 FIG00454685: hypothetical protein +FIG00454685 FIG00454686: hypothetical protein +FIG00454686 FIG00454687: hypothetical protein +FIG00454689 FIG00454690: hypothetical protein +FIG00454691 FIG00454693: hypothetical protein +FIG00454693 FIG00454694: hypothetical protein +FIG00454694 FIG00454695: hypothetical protein +FIG00454695 FAD linked oxidase, C-terminal:FAD linked oxidase, N-terminal +FIG00454696 FIG00454697: hypothetical protein +FIG00454697 FIG00454699: hypothetical protein +FIG00454699 FIG00454702: hypothetical protein +FIG00454704 FIG00454706: hypothetical protein +FIG00454706 FIG00454707: hypothetical protein +FIG00454707 FIG00454708: hypothetical protein +FIG00454708 FIG00454709: hypothetical protein +FIG00454709 FIG00454710: hypothetical protein +FIG00454710 FIG00454712: hypothetical protein +FIG00454712 FIG00454714: hypothetical protein +FIG00454717 FIG00454719: hypothetical protein +FIG00454719 FIG00454721: hypothetical protein +FIG00454721 FIG00454722: hypothetical protein +FIG00454722 FIG00454724: hypothetical protein +FIG00454725 FIG00454726: hypothetical protein +FIG00454726 FIG00454727: hypothetical protein +FIG00454739 FIG00454740: hypothetical protein +FIG00454741 FIG00454742: hypothetical protein +FIG00454742 FIG00454744: hypothetical protein +FIG00454744 FIG00454745: hypothetical protein +FIG00454746 FIG00454748: hypothetical protein +FIG00454750 FIG00454751: hypothetical protein +FIG00454752 FIG00454753: hypothetical protein +FIG00454753 FIG00454754: hypothetical protein +FIG00454754 FIG00454755: hypothetical protein +FIG00454755 FIG00454756: hypothetical protein +FIG00454756 FIG00454757: hypothetical protein +FIG00454758 FIG00454759: hypothetical protein +FIG00454762 FIG00454763: hypothetical protein +FIG00454763 FIG00454764: hypothetical protein +FIG00454770 FIG00454772: hypothetical protein +FIG00454772 FIG00454774: hypothetical protein +FIG00454775 1 TMS, 191aa DUF2780 hypothetical protein +FIG00454778 FIG00454779: hypothetical protein +FIG00454780 FIG00641944: hypothetical protein +FIG00454783 FIG00454785: hypothetical protein +FIG00454785 FIG00454787: hypothetical protein +FIG00454787 FIG00454788: hypothetical protein +FIG00454788 FIG00454789: hypothetical protein +FIG00454789 FIG00454793: hypothetical protein +FIG00454793 FIG00454796: hypothetical protein +FIG00454796 FIG00454797: hypothetical protein +FIG00454798 FIG00454799: hypothetical protein +FIG00454799 FIG00454803: hypothetical protein +FIG00454803 FIG00454804: hypothetical protein +FIG00454804 FIG00454812: hypothetical protein +FIG00454812 FIG00454814: hypothetical protein +FIG00454814 FIG00454815: hypothetical protein +FIG00454818 FIG00454819: hypothetical protein +FIG00454819 FIG00454821: hypothetical protein +FIG00454823 FIG00454824: hypothetical protein +FIG00454824 FIG00454825: hypothetical protein +FIG00454825 FIG00454828: hypothetical protein +FIG00454828 FIG00454830: hypothetical protein +FIG00454831 FIG00454832: hypothetical protein +FIG00454832 FIG00454833: hypothetical protein +FIG00454833 FIG00454834: hypothetical protein +FIG00454837 FIG00454839: hypothetical protein +FIG00454839 FIG00454841: hypothetical protein +FIG00454841 FIG00454842: hypothetical protein +FIG00454842 FIG00454849: hypothetical protein +FIG00454850 FIG00454851: hypothetical protein +FIG00454853 FIG00454854: hypothetical protein +FIG00454854 FIG00454855: hypothetical protein +FIG00454855 FIG00454856: hypothetical protein +FIG00454856 FIG00454857: hypothetical protein +FIG00454857 FIG00454860: hypothetical protein +FIG00454860 COG3801: Uncharacterized protein conserved in bacteria +FIG00454861 FIG00454862: hypothetical protein +FIG00454867 FIG00467731: hypothetical protein +FIG00454868 3-hydroxyisobutyrate dehydrogenase and related beta-hydroxyacid dehydrogenases +FIG00454870 FIG00454871: hypothetical protein +FIG00454871 FIG00454873: hypothetical protein +FIG00454873 FIG00454874: hypothetical protein +FIG00454876 FIG00454878: hypothetical protein +FIG00454880 FIG00454881: hypothetical protein +FIG00454881 FIG00454882: hypothetical protein +FIG00454883 FIG00454885: hypothetical protein +FIG00454886 FIG00454887: hypothetical protein +FIG00454889 Predicted methyltransferase +FIG00454890 FIG00454891: hypothetical protein +FIG00454891 FIG00454895: hypothetical protein +FIG00454895 FIG00454896: hypothetical protein +FIG00454896 FIG00454897: hypothetical protein +FIG00454897 FIG00454898: hypothetical protein +FIG00454898 FIG00454899: hypothetical protein +FIG00454899 FIG00454900: hypothetical protein +FIG00454900 FIG00454901: hypothetical protein +FIG00454901 FIG00454902: hypothetical protein +FIG00454902 FIG00454906: hypothetical protein +FIG00454907 FIG00454908: hypothetical protein +FIG00454908 FIG00454910: hypothetical protein +FIG00454911 FIG00454913: hypothetical protein +FIG00454915 FIG00454916: hypothetical protein +FIG00454917 Glycosyl transferase, family 2 +FIG00454918 FIG00454919: hypothetical protein +FIG00454921 FIG00454922: hypothetical protein +FIG00454926 FIG00454927: hypothetical protein +FIG00454927 FIG00454930: hypothetical protein +FIG00454930 FIG00454931: hypothetical protein +FIG00454931 FIG00454932: hypothetical protein +FIG00454932 FIG00454934: hypothetical protein +FIG00454934 FIG00454936: hypothetical protein +FIG00454936 DnaK-related protein +FIG00454937 FIG00454939: hypothetical protein +FIG00454939 FIG00454940: hypothetical protein +FIG00454940 FIG00454945: hypothetical protein +FIG00454945 FIG00454946: hypothetical protein +FIG00454946 FIG00454947: hypothetical protein +FIG00454947 FIG00454949: hypothetical protein +FIG00454949 FIG00454950: hypothetical protein +FIG00454950 FIG00454952: hypothetical protein +FIG00454952 FIG00454953: hypothetical protein +FIG00454953 FIG00454955: hypothetical protein +FIG00454955 FIG00454956: hypothetical protein +FIG00454956 FIG00454957: hypothetical protein +FIG00454957 FIG00454958: hypothetical protein +FIG00454958 Opine oxidase subunit B +FIG00454961 hypothetical protein +FIG00454962 FIG00454966: hypothetical protein +FIG00454966 hypothetical protein +FIG00454969 FIG00454972: hypothetical protein +FIG00454972 FIG00454974: hypothetical protein +FIG00454974 FIG00454976: hypothetical protein +FIG00454976 FIG00454979: hypothetical protein +FIG00454979 FIG00454980: hypothetical protein +FIG00454980 FIG00454981: hypothetical protein +FIG00454981 hypothetical protein +FIG00454982 FIG00454983: hypothetical protein +FIG00454983 FIG00454984: hypothetical protein +FIG00454984 FIG00454985: hypothetical protein +FIG00454985 FIG00454988: hypothetical protein +FIG00454988 FIG00454989: hypothetical protein +FIG00454990 FIG00454991: hypothetical protein +FIG00454991 FIG00454992: hypothetical protein +FIG00454992 FIG00454993: hypothetical protein +FIG00454993 FIG00454994: hypothetical protein +FIG00454994 FIG00454995: hypothetical protein +FIG00454995 FIG00454997: hypothetical protein +FIG00454997 FIG00455001: hypothetical protein +FIG00455001 FIG00455002: hypothetical protein +FIG00455002 FIG00455003: hypothetical protein +FIG00455003 FIG00455005: hypothetical protein +FIG00455006 FIG00455007: hypothetical protein +FIG00455009 FIG00455010: hypothetical protein +FIG00455010 FIG00455012: hypothetical protein +FIG00455012 FIG00455013: hypothetical protein +FIG00455013 FIG00455014: hypothetical protein +FIG00455014 FIG00455015: hypothetical protein +FIG00455015 FIG00455016: hypothetical protein +FIG00455016 FIG00455017: hypothetical protein +FIG00455020 FIG00455022: hypothetical protein +FIG00455022 FIG00455023: hypothetical protein +FIG00455023 FIG00455024: hypothetical protein +FIG00455024 FIG00455025: hypothetical protein +FIG00455025 FIG00455027: hypothetical protein +FIG00455027 FIG00455028: hypothetical protein +FIG00455028 Alkanal monooxygenase alpha chain (EC 1.14.14.3) +FIG00455032 FIG00455037: hypothetical protein +FIG00455037 FIG00455038: hypothetical protein +FIG00455040 FIG00455041: hypothetical protein +FIG00455041 FIG00455043: hypothetical protein +FIG00455043 FIG00455045: hypothetical protein +FIG00455047 FIG00455048: hypothetical protein +FIG00455048 FIG00455050: hypothetical protein +FIG00455050 FIG00455051: hypothetical protein +FIG00455053 FIG00455055: hypothetical protein +FIG00455055 FIG00455058: hypothetical protein +FIG00455058 FIG00455059: hypothetical protein +FIG00455059 FIG00455060: hypothetical protein +FIG00455060 FIG00455062: hypothetical protein +FIG00455062 Benzaldehyde dehydrogenase +FIG00455063 FIG00455065: hypothetical protein +FIG00455065 FIG00455067: hypothetical protein +FIG00455071 FIG00455072: hypothetical protein +FIG00455072 FIG00455074: hypothetical protein +FIG00455078 FIG00455079: hypothetical protein +FIG00455079 FIG00455080: hypothetical protein +FIG00455080 FIG00455083: hypothetical protein +FIG00455084 FIG00455085: hypothetical protein +FIG00455085 hypothetical protein +FIG00455088 FIG00455091: hypothetical protein +FIG00455091 FIG00455092: hypothetical protein +FIG00455092 FIG00455093: hypothetical protein +FIG00455094 FIG00455095: hypothetical protein +FIG00455095 FIG00455098: hypothetical protein +FIG00455099 FIG00455100: hypothetical protein +FIG00455100 FIG00455102: hypothetical protein +FIG00455102 FIG00455103: hypothetical protein +FIG00455103 FIG00455105: hypothetical protein +FIG00455105 FIG00455106: hypothetical protein +FIG00455114 FIG00455116: hypothetical protein +FIG00455117 L-proline glycine betaine binding ABC transporter protein ProX (TC 3.A.1.12.1) / Osmotic adaptation +FIG00455120 FIG00455121: hypothetical protein +FIG00455122 FIG00455123: hypothetical protein +FIG00455123 FIG00455124: hypothetical protein +FIG00455124 FIG00455126: hypothetical protein +FIG00455126 FIG00455127: hypothetical protein +FIG00455128 FIG00455129: hypothetical protein +FIG00455130 FIG00455133: hypothetical protein +FIG00455133 FIG00455134: hypothetical protein +FIG00455134 FIG00455135: hypothetical protein +FIG00455135 FIG00455137: hypothetical protein +FIG00455137 FIG00455138: hypothetical protein +FIG00455138 FIG00455139: hypothetical protein +FIG00455139 FIG00455140: hypothetical protein +FIG00455140 FIG00455141: hypothetical protein +FIG00455141 Uncharacterized protein Mlr1045 +FIG00455143 FIG00455144: hypothetical protein +FIG00455146 FIG00455147: hypothetical protein +FIG00455147 FIG00455150: hypothetical protein +FIG00455153 FIG00455155: hypothetical protein +FIG00455155 FIG00455156: hypothetical protein +FIG00455156 FIG00455159: hypothetical protein +FIG00455161 FIG00455162: hypothetical protein +FIG00455162 FIG00455163: hypothetical protein +FIG00455163 FIG00455164: hypothetical protein +FIG00455164 FIG00455165: hypothetical protein +FIG00455167 FIG00455168: hypothetical protein +FIG00455168 FIG00455169: hypothetical protein +FIG00455170 FIG00455172: hypothetical protein +FIG00455175 Probable dyhydroflavanol-4-reductase +FIG00455177 FIG00455179: hypothetical protein +FIG00455179 FIG00455182: hypothetical protein +FIG00455182 FIG00455183: hypothetical protein +FIG00455183 FIG00455184: hypothetical protein +FIG00455184 FIG00455185: hypothetical protein +FIG00455185 FIG00455186: hypothetical protein +FIG00455188 FIG00455190: hypothetical protein +FIG00455190 FIG00455191: hypothetical protein +FIG00455192 FIG00455193: hypothetical protein +FIG00455193 FIG00455197: hypothetical protein +FIG00455197 FIG00455198: hypothetical protein +FIG00455198 FIG00455199: hypothetical protein +FIG00455199 FIG00455200: hypothetical protein +FIG00455200 FIG00455201: hypothetical protein +FIG00455202 FIG00455204: hypothetical protein +FIG00455206 FIG00455209: hypothetical protein +FIG00455209 FIG00455210: hypothetical protein +FIG00455210 FIG00455211: hypothetical protein +FIG00455211 FIG00455213: hypothetical protein +FIG00455213 FIG00455214: hypothetical protein +FIG00455214 FIG00455215: hypothetical protein +FIG00455216 High-affinity iron permease +FIG00455217 FIG00455218: hypothetical protein +FIG00455218 FIG00455219: hypothetical protein +FIG00455219 FIG00455220: hypothetical protein +FIG00455220 FIG00455221: hypothetical protein +FIG00455221 FIG00455223: hypothetical protein +FIG00455225 FIG00455226: hypothetical protein +FIG00455226 FIG00455230: hypothetical protein +FIG00455236 FIG00455238: hypothetical protein +FIG00455238 FIG00455240: hypothetical protein +FIG00455240 FIG00455241: hypothetical protein +FIG00455241 Phage replication protein +FIG00455242 FIG00455243: hypothetical protein +FIG00455243 FIG00455244: hypothetical protein +FIG00455244 FIG00455245: hypothetical protein +FIG00455245 FIG00455249: hypothetical protein +FIG00455249 FIG00455250: hypothetical protein +FIG00455250 FIG00455251: hypothetical protein +FIG00455251 FIG00455252: hypothetical protein +FIG00455252 FIG00455253: hypothetical protein +FIG00455253 FIG00455254: hypothetical protein +FIG00455255 Acriflavin resistance plasma membrane protein +FIG00455257 FIG00455258: hypothetical protein +FIG00455258 FIG00455261: hypothetical protein +FIG00455261 FIG00455263: hypothetical protein +FIG00455263 FIG00455264: hypothetical protein +FIG00455269 FIG00455273: hypothetical protein +FIG00455273 FIG00455274: hypothetical protein +FIG00455275 FIG00455276: hypothetical protein +FIG00455276 FIG00455280: hypothetical protein +FIG00455280 FIG00455284: hypothetical protein +FIG00455284 FIG00455285: hypothetical protein +FIG00455285 FIG00455287: hypothetical protein +FIG00455287 FIG00455288: hypothetical protein +FIG00455291 FIG00455294: hypothetical protein +FIG00455294 probable membrane protein YPO1482 +FIG00455297 FIG00455298: hypothetical protein +FIG00455300 FIG00455301: hypothetical protein +FIG00455303 FIG00455304: hypothetical protein +FIG00455304 KlcA protein +FIG00455305 FIG00455307: hypothetical protein +FIG00455307 FIG00455313: hypothetical protein +FIG00455313 FIG00455314: hypothetical protein +FIG00455314 FIG00455315: hypothetical protein +FIG00455315 FIG00455317: hypothetical protein +FIG00455317 FIG00455318: hypothetical protein +FIG00455318 FIG00455323: hypothetical protein +FIG00455324 FIG00455325: hypothetical protein +FIG00455325 FIG00455327: hypothetical protein +FIG00455327 FIG00455328: hypothetical protein +FIG00455329 FIG00455331: hypothetical protein +FIG00455331 FIG00455333: hypothetical protein +FIG00455333 FIG00455334: hypothetical protein +FIG00455335 FIG00455337: hypothetical protein +FIG00455338 FIG00455339: hypothetical protein +FIG00455341 FIG00455342: hypothetical protein +FIG00455342 FIG00455343: hypothetical protein +FIG00455343 FIG00455345: hypothetical protein +FIG00455345 FIG00455347: hypothetical protein +FIG00455348 FIG00455351: hypothetical protein +FIG00455354 Bll7990 protein +FIG00455360 FIG00455361: hypothetical protein +FIG00455361 FIG00455362: hypothetical protein +FIG00455364 FIG00455365: hypothetical protein +FIG00455365 FIG00455366: hypothetical protein +FIG00455366 FIG00455368: hypothetical protein +FIG00455373 FIG00455374: hypothetical protein +FIG00455374 FIG00455375: hypothetical protein +FIG00455375 FIG00455376: hypothetical protein +FIG00455376 FIG00455379: hypothetical protein +FIG00455382 FIG00455383: hypothetical protein +FIG00455384 FIG00455386: hypothetical protein +FIG00455386 FIG00455388: hypothetical protein +FIG00455388 FIG00455389: hypothetical protein +FIG00455389 FIG00455391: hypothetical protein +FIG00455393 FIG00455396: hypothetical protein +FIG00455396 FIG00455397: hypothetical protein +FIG00455397 FIG00455398: hypothetical protein +FIG00455401 FIG00455402: hypothetical protein +FIG00455402 FIG00455403: hypothetical protein +FIG00455404 FIG00455406: hypothetical protein +FIG00455406 FIG00455408: hypothetical protein +FIG00455408 FIG00455409: hypothetical protein +FIG00455411 FIG00455412: hypothetical protein +FIG00455413 FIG00455414: hypothetical protein +FIG00455414 FIG00455415: hypothetical protein +FIG00455415 FIG00455417: hypothetical protein +FIG00455419 FIG00455420: hypothetical protein +FIG00455422 FIG00455424: hypothetical protein +FIG00455424 FIG00455425: hypothetical protein +FIG00455425 FIG00455426: hypothetical protein +FIG00455426 FIG00455427: hypothetical protein +FIG00455427 FIG00455430: hypothetical protein +FIG00455431 FIG00455432: hypothetical protein +FIG00455432 FIG00455434: hypothetical protein +FIG00455434 FIG00455435: hypothetical protein +FIG00455435 FIG00455437: hypothetical protein +FIG00455437 FIG00455439: hypothetical protein +FIG00455439 ABC-type spermidine/putrescine transport system, permease component I +FIG00455440 FIG00455441: hypothetical protein +FIG00455441 FIG00455442: hypothetical protein +FIG00455442 FIG00455447: hypothetical protein +FIG00455447 FIG00455448: hypothetical protein +FIG00455449 FIG00455451: hypothetical protein +FIG00455453 FIG00455454: hypothetical protein +FIG00455455 FIG00455458: hypothetical protein +FIG00455461 FIG00455463: hypothetical protein +FIG00455463 FIG00455464: hypothetical protein +FIG00455469 FIG00455470: hypothetical protein +FIG00455470 FIG00455471: hypothetical protein +FIG00455472 FIG00455473: hypothetical protein +FIG00455473 FIG00455474: hypothetical protein +FIG00455474 FIG00455475: hypothetical protein +FIG00455475 FIG00455476: hypothetical protein +FIG00455476 FIG00455477: hypothetical protein +FIG00455477 FIG00455480: hypothetical protein +FIG00455480 hypothetical protein +FIG00455482 FIG00455483: hypothetical protein +FIG00455483 FIG00455486: hypothetical protein +FIG00455487 FIG00455488: hypothetical protein +FIG00455488 Uncharacterized protein conserved in bacteria, putative lipoprotein +FIG00455489 FIG00455490: hypothetical protein +FIG00455490 FIG00455491: hypothetical protein +FIG00455491 FIG00455492: hypothetical protein +FIG00455492 FIG00455493: hypothetical protein +FIG00455496 FIG00455499: hypothetical protein +FIG00455499 FIG00455500: hypothetical protein +FIG00455500 FIG00455501: hypothetical protein +FIG00455504 FIG00455505: hypothetical protein +FIG00455505 FIG00455507: hypothetical protein +FIG00455514 FIG00455516: hypothetical protein +FIG00455516 FIG00455517: hypothetical protein +FIG00455517 FIG00455518: hypothetical protein +FIG00455518 FIG00455520: hypothetical protein +FIG00455520 FIG00455521: hypothetical protein +FIG00455521 FIG00455522: hypothetical protein +FIG00455522 FIG00455523: hypothetical protein +FIG00455523 FIG00455525: hypothetical protein +FIG00455525 FIG00455527: hypothetical protein +FIG00455528 FIG00455530: hypothetical protein +FIG00455530 FIG00455531: hypothetical protein +FIG00455531 FIG00455533: hypothetical protein +FIG00455533 VrlR-like protein +FIG00455534 FIG00455535: hypothetical protein +FIG00455535 FIG00455536: hypothetical protein +FIG00455536 FIG00455537: hypothetical protein +FIG00455544 FIG00455545: hypothetical protein +FIG00455545 FIG00455546: hypothetical protein +FIG00455546 FIG00455547: hypothetical protein +FIG00455547 FIG00455548: hypothetical protein +FIG00455564 FIG00455565: hypothetical protein +FIG00455565 FIG00455568: hypothetical protein +FIG00455568 FIG00455569: hypothetical protein +FIG00455569 FIG00455571: hypothetical protein +FIG00455575 FIG00455577: hypothetical protein +FIG00455577 FIG00455579: hypothetical protein +FIG00455579 FIG00455581: hypothetical protein +FIG00455581 FIG00455582: hypothetical protein +FIG00455584 FIG00455585: hypothetical protein +FIG00455585 Membrane carboxypeptidase (penicillin-binding protein) +FIG00455587 FIG00455589: hypothetical protein +FIG00455589 FIG00455590: hypothetical protein +FIG00455591 FIG00455592: hypothetical protein +FIG00455592 FIG00455595: hypothetical protein +FIG00455595 FIG00455597: hypothetical protein +FIG00455598 FIG00455599: hypothetical protein +FIG00455599 Type III secretion outermembrane pore forming protein (YscC,MxiD,HrcC, InvG) +FIG00455600 FIG00455603: hypothetical protein +FIG00455603 FIG00455606: hypothetical protein +FIG00455606 FIG00455607: hypothetical protein +FIG00455608 FIG00455609: hypothetical protein +FIG00455612 FIG00455613: hypothetical protein +FIG00455613 FIG00455617: hypothetical protein +FIG00455618 FIG00455621: hypothetical protein +FIG00455621 FIG00455622: hypothetical protein +FIG00455623 FIG00455624: hypothetical protein +FIG00455624 FIG00455628: hypothetical protein +FIG00455628 FIG00455630: hypothetical protein +FIG00455630 FIG00455632: hypothetical protein +FIG00455632 FIG00455635: hypothetical protein +FIG00455635 FIG00455638: hypothetical protein +FIG00455638 hypothetical protein +FIG00455639 FIG00455646: hypothetical protein +FIG00455647 FIG00455649: hypothetical protein +FIG00455649 FIG00455651: hypothetical protein +FIG00455652 FIG00455653: hypothetical protein +FIG00455653 FIG00455654: hypothetical protein +FIG00455656 FIG00455657: hypothetical protein +FIG00455657 FIG00455658: hypothetical protein +FIG00455658 FIG00455659: hypothetical protein +FIG00455659 FIG00455660: hypothetical protein +FIG00455662 Transcriptional regulator containing PAS, AAA-type ATPase, and DNA-binding domains +FIG00455664 FIG00455665: hypothetical protein +FIG00455665 hypothetical protein +FIG00455669 FIG00455674: hypothetical protein +FIG00455674 FIG00455675: hypothetical protein +FIG00455675 FIG00455677: hypothetical protein +FIG00455677 FIG00455681: hypothetical protein +FIG00455681 FIG00455682: hypothetical protein +FIG00455682 FIG00455683: hypothetical protein +FIG00455683 FIG00455684: hypothetical protein +FIG00455684 FIG00455688: hypothetical protein +FIG00455689 FIG00455690: hypothetical protein +FIG00455692 FIG00455693: hypothetical protein +FIG00455693 FIG00455694: hypothetical protein +FIG00455695 FIG00455696: hypothetical protein +FIG00455700 FIG00455702: hypothetical protein +FIG00455703 FIG00455704: hypothetical protein +FIG00455704 FIG00983807: hypothetical protein +FIG00455706 FIG00455707: hypothetical protein +FIG00455707 FIG00455708: hypothetical protein +FIG00455709 FIG00455710: hypothetical protein +FIG00455713 FIG00455714: hypothetical protein +FIG00455715 FIG00455717: hypothetical protein +FIG00455718 FIG00455720: hypothetical protein +FIG00455720 FIG00455722: hypothetical protein +FIG00455722 FIG00455724: hypothetical protein +FIG00455724 DNA methylase +FIG00455725 FIG00455727: hypothetical protein +FIG00455727 FIG00455728: hypothetical protein +FIG00455728 FIG00455729: hypothetical protein +FIG00455729 FIG00455730: hypothetical protein +FIG00455730 FIG00455731: hypothetical protein +FIG00455732 FIG00455733: hypothetical protein +FIG00455733 FIG00455734: hypothetical protein +FIG00455734 Mg2+ and Co2+ transporters +FIG00455735 FIG00455736: hypothetical protein +FIG00455736 FIG00455737: hypothetical protein +FIG00455737 FIG00455739: hypothetical protein +FIG00455742 FIG00455744: hypothetical protein +FIG00455744 FIG00455746: hypothetical protein +FIG00455746 FIG00455747: hypothetical protein +FIG00455747 FIG00455750: hypothetical protein +FIG00455750 FIG00455751: hypothetical protein +FIG00455751 FIG00455753: hypothetical protein +FIG00455753 FIG00455754: hypothetical protein +FIG00455754 FIG00455758: hypothetical protein +FIG00455758 FIG00455760: hypothetical protein +FIG00455760 FIG00455761: hypothetical protein +FIG00455761 probable membrane protein STY4566 +FIG00455763 FIG00455764: hypothetical protein +FIG00455764 FIG00455766: hypothetical protein +FIG00455766 FIG00455767: hypothetical protein +FIG00455767 FIG00455768: hypothetical protein +FIG00455768 FIG00455769: hypothetical protein +FIG00455769 FIG00455770: hypothetical protein +FIG00455770 FIG00455772: hypothetical protein +FIG00455773 FIG00455774: hypothetical protein +FIG00455776 FIG00455777: hypothetical protein +FIG00455777 FIG00455778: hypothetical protein +FIG00455778 FIG00455779: hypothetical protein +FIG00455786 FIG00455787: hypothetical protein +FIG00455788 FIG00455789: hypothetical protein +FIG00455789 FIG00455793: hypothetical protein +FIG00455793 FIG00455795: hypothetical protein +FIG00455795 FIG00455796: hypothetical protein +FIG00455805 FIG00455807: hypothetical protein +FIG00455807 FIG00455809: hypothetical protein +FIG00455809 FIG00455815: hypothetical protein +FIG00455815 FIG00455816: hypothetical protein +FIG00455816 FIG00455818: hypothetical protein +FIG00455818 FIG00455819: hypothetical protein +FIG00455820 FIG00455821: hypothetical protein +FIG00455821 FIG00455822: hypothetical protein +FIG00455823 Endonuclease G, mitochondrial precursor (EC 3.1.30.-) +FIG00455824 FIG00455825: hypothetical protein +FIG00455826 FIG00455827: hypothetical protein +FIG00455832 FIG00455833: hypothetical protein +FIG00455833 FIG00455834: hypothetical protein +FIG00455834 FIG00455835: hypothetical protein +FIG00455835 FIG00455836: hypothetical protein +FIG00455836 FIG00455837: hypothetical protein +FIG00455837 FIG00455838: hypothetical protein +FIG00455838 FIG00455839: hypothetical protein +FIG00455839 FIG01046817: hypothetical protein +FIG00455842 Probable RNA polymerase sigma factor +FIG00455846 FIG00455847: hypothetical protein +FIG00455848 FIG00455853: hypothetical protein +FIG00455853 Oligopeptide transport system permease protein OppC (TC 3.A.1.5.1) +FIG00455857 FIG00455858: hypothetical protein +FIG00455858 FIG00455860: hypothetical protein +FIG00455860 FIG00455863: hypothetical protein +FIG00455864 FIG00455865: hypothetical protein +FIG00455865 FIG00455866: hypothetical protein +FIG00455867 FIG00455868: hypothetical protein +FIG00455868 FIG00455869: hypothetical protein +FIG00455869 FIG00455870: hypothetical protein +FIG00455870 FIG00455871: hypothetical protein +FIG00455871 FIG00455872: hypothetical protein +FIG00455872 FIG00455873: hypothetical protein +FIG00455873 FIG00455874: hypothetical protein +FIG00455877 FIG00455878: hypothetical protein +FIG00455880 FIG00455881: hypothetical protein +FIG00455881 FIG00455884: hypothetical protein +FIG00455886 FIG00455890: hypothetical protein +FIG00455891 FIG00455892: hypothetical protein +FIG00455892 FIG00455893: hypothetical protein +FIG00455893 FIG00455894: hypothetical protein +FIG00455896 FIG00455898: hypothetical protein +FIG00455898 FIG00455900: hypothetical protein +FIG00455902 FIG00455903: hypothetical protein +FIG00455903 FIG00455904: hypothetical protein +FIG00455904 FIG00455906: hypothetical protein +FIG00455906 FIG00455907: hypothetical protein +FIG00455908 Bona fide RidA/YjgF/TdcF/RutC subgroup +FIG00455911 FIG00455912: hypothetical protein +FIG00455914 FIG00455915: hypothetical protein +FIG00455916 FIG00455917: hypothetical protein +FIG00455917 Tubuliform spidroin 1 +FIG00455919 FIG00455920: hypothetical protein +FIG00455920 FIG00455922: hypothetical protein +FIG00455924 FIG00455925: hypothetical protein +FIG00455925 FIG00455926: hypothetical protein +FIG00455926 FIG00455927: hypothetical protein +FIG00455927 FIG00455928: hypothetical protein +FIG00455929 FIG00455931: hypothetical protein +FIG00455931 FIG00455932: hypothetical protein +FIG00455932 FIG00455933: hypothetical protein +FIG00455935 FIG00455936: hypothetical protein +FIG00455936 hypothetical protein +FIG00455942 FIG00455943: hypothetical protein +FIG00455943 FIG00455945: hypothetical protein +FIG00455946 FIG00455949: hypothetical protein +FIG00455949 FIG00455950: hypothetical protein +FIG00455954 FIG00455955: hypothetical protein +FIG00455955 FIG00455957: hypothetical protein +FIG00455959 FIG00455960: hypothetical protein +FIG00455960 FIG00455962: hypothetical protein +FIG00455964 FIG00455968: hypothetical protein +FIG00455968 FIG00455969: hypothetical protein +FIG00455969 FIG00455970: hypothetical protein +FIG00455970 FIG00455971: hypothetical protein +FIG00455975 FIG00455976: hypothetical protein +FIG00455979 FIG00455980: hypothetical protein +FIG00455980 FIG00455984: hypothetical protein +FIG00455985 FIG00455986: hypothetical protein +FIG00455986 FIG00455989: hypothetical protein +FIG00455990 FIG00455992: hypothetical protein +FIG00455996 FIG00455997: hypothetical protein +FIG00455997 FIG00456001: hypothetical protein +FIG00456001 FIG00456004: hypothetical protein +FIG00456004 FIG00456006: hypothetical protein +FIG00456006 FIG00456007: hypothetical protein +FIG00456007 FIG00456008: hypothetical protein +FIG00456008 Non-ribosomal peptide synthetase modules and related proteins-like, putative +FIG00456011 FIG00456013: hypothetical protein +FIG00456013 FIG00456015: hypothetical protein +FIG00456015 FIG00456016: hypothetical protein +FIG00456016 FIG00456018: hypothetical protein +FIG00456018 FIG00456019: hypothetical protein +FIG00456020 FIG00456023: hypothetical protein +FIG00456025 ABC transporter, periplasmic substrate-binding protein +FIG00456027 hypothetical protein +FIG00456029 FIG00456031: hypothetical protein +FIG00456031 FIG00456032: hypothetical protein +FIG00456035 FIG00456037: hypothetical protein +FIG00456037 FIG00456038: hypothetical protein +FIG00456039 FIG00456040: hypothetical protein +FIG00456042 FIG00456043: hypothetical protein +FIG00456043 FIG00456045: hypothetical protein +FIG00456045 FIG00456046: hypothetical protein +FIG00456046 FIG00456048: hypothetical protein +FIG00456048 FIG00456050: hypothetical protein +FIG00456050 FIG00456051: hypothetical protein +FIG00456052 FIG00456053: hypothetical protein +FIG00456058 FIG00456059: hypothetical protein +FIG00456059 FIG00456060: hypothetical protein +FIG00456060 FIG00456062: hypothetical protein +FIG00456062 FIG00456068: hypothetical protein +FIG00456068 FIG00456071: hypothetical protein +FIG00456073 FIG00456074: hypothetical protein +FIG00456076 FIG00456077: hypothetical protein +FIG00456077 FIG00456078: hypothetical protein +FIG00456078 FIG00456079: hypothetical protein +FIG00456079 FIG00456081: hypothetical protein +FIG00456082 FIG00456083: hypothetical protein +FIG00456083 FIG00456084: hypothetical protein +FIG00456084 FIG00456086: hypothetical protein +FIG00456090 FIG00456091: hypothetical protein +FIG00456091 FIG00456093: hypothetical protein +FIG00456093 FIG00456094: hypothetical protein +FIG00456095 FIG00456097: hypothetical protein +FIG00456097 FIG00456103: hypothetical protein +FIG00456103 FIG00456104: hypothetical protein +FIG00456109 FIG00456110: hypothetical protein +FIG00456112 FIG00456113: hypothetical protein +FIG00456113 FIG00456114: hypothetical protein +FIG00456114 FIG00456117: hypothetical protein +FIG00456117 FIG00456118: hypothetical protein +FIG00456118 FIG00456119: hypothetical protein +FIG00456121 FIG00456123: hypothetical protein +FIG00456124 FIG00456125: hypothetical protein +FIG00456127 FIG00456129: hypothetical protein +FIG00456131 FIG00456133: hypothetical protein +FIG00456135 FIG00456136: hypothetical protein +FIG00456141 FIG00456142: hypothetical protein +FIG00456142 FIG00456143: hypothetical protein +FIG00456144 FIG00456145: hypothetical protein +FIG00456145 FIG00456150: hypothetical protein +FIG00456150 FIG00456151: hypothetical protein +FIG00456151 FIG00456152: hypothetical protein +FIG00456152 FIG00456153: hypothetical protein +FIG00456153 FIG00456154: hypothetical protein +FIG00456154 spermidine n1-acetyltransferase +FIG00456156 FIG00456158: hypothetical protein +FIG00456162 FIG00456164: hypothetical protein +FIG00456165 FIG00456168: hypothetical protein +FIG00456169 FIG00456170: hypothetical protein +FIG00456171 FIG00456172: hypothetical protein +FIG00456172 FIG00456173: hypothetical protein +FIG00456173 FIG00456177: hypothetical protein +FIG00456177 FIG00456181: hypothetical protein +FIG00456184 FIG00456185: hypothetical protein +FIG00456185 FIG00456186: hypothetical protein +FIG00456186 FIG00456188: hypothetical protein +FIG00456188 FIG00456189: hypothetical protein +FIG00456189 FIG00456194: hypothetical protein +FIG00456196 FIG00456198: hypothetical protein +FIG00456198 FIG00456202: hypothetical protein +FIG00456202 FIG00456203: hypothetical protein +FIG00456203 FIG00456204: hypothetical protein +FIG00456204 FIG00456205: hypothetical protein +FIG00456205 FIG00456208: hypothetical protein +FIG00456209 FIG00456211: hypothetical protein +FIG00456211 FIG00456212: hypothetical protein +FIG00456213 FIG00456214: hypothetical protein +FIG00456216 FIG00456217: hypothetical protein +FIG00456218 FIG00456221: hypothetical protein +FIG00456221 FIG00456222: hypothetical protein +FIG00456222 FIG00456223: hypothetical protein +FIG00456223 FIG00456225: hypothetical protein +FIG00456230 FIG00456232: hypothetical protein +FIG00456232 FIG00456234: hypothetical protein +FIG00456236 FIG00456237: hypothetical protein +FIG00456237 FIG00456238: hypothetical protein +FIG00456238 FIG00456240: hypothetical protein +FIG00456240 FIG00456242: hypothetical protein +FIG00456242 FIG00456245: hypothetical protein +FIG00456248 FIG00456249: hypothetical protein +FIG00456249 FIG00456250: hypothetical protein +FIG00456250 FIG00456252: hypothetical protein +FIG00456252 Response regulator receiver (CheY) and ANTAR domain protein +FIG00456254 FIG00456255: hypothetical protein +FIG00456259 FIG00456260: hypothetical protein +FIG00456262 FIG00456266: hypothetical protein +FIG00456273 FIG00456275: hypothetical protein +FIG00456275 FIG00456276: hypothetical protein +FIG00456278 hypothetical protein +FIG00456285 FIG00456287: hypothetical protein +FIG00456287 FIG00456288: hypothetical protein +FIG00456289 FIG00456293: hypothetical protein +FIG00456295 Type III secretion cytoplasmic protein (YscK) +FIG00456296 FIG00456299: hypothetical protein +FIG00456299 HrpB4 protein +FIG00456300 FIG00456302: hypothetical protein +FIG00456302 FIG00456306: hypothetical protein +FIG00456306 FIG00456307: hypothetical protein +FIG00456307 FIG00456308: hypothetical protein +FIG00456308 FIG00456311: hypothetical protein +FIG00456312 FIG00456313: hypothetical protein +FIG00456316 FIG00456317: hypothetical protein +FIG00456317 FIG00456319: hypothetical protein +FIG00456320 FIG00456321: hypothetical protein +FIG00456321 hypothetical protein +FIG00456322 FIG00456323: hypothetical protein +FIG00456323 FIG00456324: hypothetical protein +FIG00456324 FIG00456326: hypothetical protein +FIG00456326 FIG00456327: hypothetical protein +FIG00456327 FIG00456328: hypothetical protein +FIG00456328 FIG00456331: hypothetical protein +FIG00456331 FIG00456332: hypothetical protein +FIG00456334 FIG00456335: hypothetical protein +FIG00456335 FIG00456336: hypothetical protein +FIG00456336 FIG00456337: hypothetical protein +FIG00456337 FIG00456338: hypothetical protein +FIG00456338 FIG00456341: hypothetical protein +FIG00456344 FIG00456345: hypothetical protein +FIG00456346 FIG00456347: hypothetical protein +FIG00456347 FIG00456351: hypothetical protein +FIG00456351 FIG00456352: hypothetical protein +FIG00456355 FIG00456357: hypothetical protein +FIG00456357 FIG00456359: hypothetical protein +FIG00456359 FIG00456360: hypothetical protein +FIG00456360 FIG00456361: hypothetical protein +FIG00456361 FIG00456365: hypothetical protein +FIG00456366 FIG00456367: hypothetical protein +FIG00456368 FIG00456369: hypothetical protein +FIG00456369 FIG00456370: hypothetical protein +FIG00456371 FIG00456373: hypothetical protein +FIG00456373 FIG00456375: hypothetical protein +FIG00456375 FIG00456379: hypothetical protein +FIG00456379 FIG00456380: hypothetical protein +FIG00456382 FIG00456384: hypothetical protein +FIG00456384 FIG00456387: hypothetical protein +FIG00456388 FIG00456389: hypothetical protein +FIG00456389 FIG00456390: hypothetical protein +FIG00456390 FIG00456391: hypothetical protein +FIG00456391 FIG00456392: hypothetical protein +FIG00456393 FIG00456394: hypothetical protein +FIG00456394 FIG00456396: hypothetical protein +FIG00456396 FIG00456397: hypothetical protein +FIG00456397 FIG00456398: hypothetical protein +FIG00456398 FIG00456400: hypothetical protein +FIG00456400 FIG00456401: hypothetical protein +FIG00456401 FIG00456405: hypothetical protein +FIG00456405 FIG00456409: hypothetical protein +FIG00456409 FIG00456410: hypothetical protein +FIG00456411 FIG00456413: hypothetical protein +FIG00456416 FIG00456417: hypothetical protein +FIG00456417 FIG00456418: hypothetical protein +FIG00456420 FIG00456422: hypothetical protein +FIG00456422 FIG00456423: hypothetical protein +FIG00456423 FIG00456424: hypothetical protein +FIG00456424 FIG00456425: hypothetical protein +FIG00456425 FIG00456428: hypothetical protein +FIG00456429 FIG00456432: hypothetical protein +FIG00456432 FIG00456434: hypothetical protein +FIG00456436 FIG00456440: hypothetical protein +FIG00456440 FIG00456443: hypothetical protein +FIG00456443 FIG00456444: hypothetical protein +FIG00456445 FIG00456446: hypothetical protein +FIG00456448 FIG00456453: hypothetical protein +FIG00456453 FIG00456454: hypothetical protein +FIG00456454 FIG00456461: hypothetical protein +FIG00456461 FIG00456462: hypothetical protein +FIG00456463 FIG00464943: hypothetical protein +FIG00456464 FIG00456465: hypothetical protein +FIG00456466 FIG00456468: hypothetical protein +FIG00456468 FIG00456470: hypothetical protein +FIG00456472 FIG00456473: hypothetical protein +FIG00456475 FIG00456476: hypothetical protein +FIG00456479 FIG00456480: hypothetical protein +FIG00456480 FIG00456482: hypothetical protein +FIG00456483 FIG00456485: hypothetical protein +FIG00456487 FIG00456488: hypothetical protein +FIG00456489 FIG00456495: hypothetical protein +FIG00456495 FIG00456497: hypothetical protein +FIG00456499 Transcriptional activator protein CopR +FIG00456507 FIG00456508: hypothetical protein +FIG00456511 FIG00456513: hypothetical protein +FIG00456513 FIG00456514: hypothetical protein +FIG00456514 FIG00456515: hypothetical protein +FIG00456515 FIG00456516: hypothetical protein +FIG00456518 FIG00456519: hypothetical protein +FIG00456519 FIG00456521: hypothetical protein +FIG00456524 FIG00456525: hypothetical protein +FIG00456525 FIG005429: hypothetical protein +FIG00456527 FIG00456530: hypothetical protein +FIG00456531 FIG00456532: hypothetical protein +FIG00456533 FIG00456534: hypothetical protein +FIG00456534 FIG00456538: hypothetical protein +FIG00456538 FIG00456539: hypothetical protein +FIG00456539 FIG00456544: hypothetical protein +FIG00456544 FIG00456546: hypothetical protein +FIG00456546 FIG00456547: hypothetical protein +FIG00456547 FIG00456548: hypothetical protein +FIG00456553 FIG00456554: hypothetical protein +FIG00456554 FIG00456556: hypothetical protein +FIG00456560 FIG00456563: hypothetical protein +FIG00456563 FIG00456565: hypothetical protein +FIG00456567 FIG00456569: hypothetical protein +FIG00456572 FIG00456573: hypothetical protein +FIG00456573 FIG00456574: hypothetical protein +FIG00456574 FIG00456577: hypothetical protein +FIG00456578 FIG00456579: hypothetical protein +FIG00456583 FIG00456584: hypothetical protein +FIG00456584 FIG00456585: hypothetical protein +FIG00456586 FIG00456587: hypothetical protein +FIG00456587 FIG00459878: hypothetical protein +FIG00456597 FIG00456598: hypothetical protein +FIG00456600 FIG00456601: hypothetical protein +FIG00456602 FIG00456603: hypothetical protein +FIG00456604 FIG00456609: hypothetical protein +FIG00456609 FIG00456610: hypothetical protein +FIG00456610 FIG00456611: hypothetical protein +FIG00456611 FIG00456614: hypothetical protein +FIG00456614 FIG00456616: hypothetical protein +FIG00456616 FIG00456617: hypothetical protein +FIG00456619 FIG00456620: hypothetical protein +FIG00456622 FIG00456623: hypothetical protein +FIG00456623 FIG00456626: hypothetical protein +FIG00456626 FIG00456629: hypothetical protein +FIG00456629 hypothetical protein +FIG00456631 FIG00456633: hypothetical protein +FIG00456633 FIG00456634: hypothetical protein +FIG00456634 FIG00456636: hypothetical protein +FIG00456636 Putative ATPase, AFG1-like +FIG00456641 FIG00456642: hypothetical protein +FIG00456642 FIG00456644: hypothetical protein +FIG00456650 hypothetical protein +FIG00456652 FIG00456657: hypothetical protein +FIG00456657 FIG00456658: hypothetical protein +FIG00456658 FIG00456659: hypothetical protein +FIG00456659 FIG00456660: hypothetical protein +FIG00456663 FIG00456664: hypothetical protein +FIG00456668 FIG00456670: hypothetical protein +FIG00456675 FIG00456676: hypothetical protein +FIG00456676 FIG00456685: hypothetical protein +FIG00456685 FIG00456686: hypothetical protein +FIG00456687 FIG00456689: hypothetical protein +FIG00456689 FIG00456691: hypothetical protein +FIG00456691 FIG00456693: hypothetical protein +FIG00456693 4-oxalomesaconate hydratase +FIG00456694 FIG00456695: hypothetical protein +FIG00456697 Carboxyl-ester lipase +FIG00456698 FIG00456699: hypothetical protein +FIG00456699 FIG00456702: hypothetical protein +FIG00456702 FIG00456703: hypothetical protein +FIG00456703 putative histidinol-phosphate aminotransferase( EC:2.6.1.5,EC:2.6.1.9 ) +FIG00456704 FIG00456705: hypothetical protein +FIG00456705 FIG00456706: hypothetical protein +FIG00456706 FIG00456710: hypothetical protein +FIG00456710 FIG00456711: hypothetical protein +FIG00456714 FIG00456716: hypothetical protein +FIG00456716 FIG00456717: hypothetical protein +FIG00456717 FIG00456719: hypothetical protein +FIG00456719 FIG00456720: hypothetical protein +FIG00456720 FIG00456721: hypothetical protein +FIG00456721 FIG00456722: hypothetical protein +FIG00456722 FIG00456723: hypothetical protein +FIG00456723 FIG00456725: hypothetical protein +FIG00456730 FIG00456731: hypothetical protein +FIG00456731 FIG00456732: hypothetical protein +FIG00456732 FIG00456734: hypothetical protein +FIG00456734 FIG00456737: hypothetical protein +FIG00456737 FIG00456738: hypothetical protein +FIG00456738 FIG00456739: hypothetical protein +FIG00456739 FIG00456740: hypothetical protein +FIG00456740 FIG00456742: hypothetical protein +FIG00456742 FIG00456743: hypothetical protein +FIG00456743 FIG00456745: hypothetical protein +FIG00456745 FIG00456747: hypothetical protein +FIG00456751 FIG00456754: hypothetical protein +FIG00456754 FIG00464823: hypothetical protein +FIG00456755 probable membrane protein YPO2297 +FIG00456760 FIG00456762: hypothetical protein +FIG00456762 FIG00456765: hypothetical protein +FIG00456766 FIG00456767: hypothetical protein +FIG00456768 FIG00456770: hypothetical protein +FIG00456770 FIG00456772: hypothetical protein +FIG00456774 Putative uncharacterized protein STY3991 +FIG00456776 FIG00456779: hypothetical protein +FIG00456779 FIG00456780: hypothetical protein +FIG00456780 FIG00456783: hypothetical protein +FIG00456783 FIG00456786: hypothetical protein +FIG00456786 FIG00456787: hypothetical protein +FIG00456793 FIG00456794: hypothetical protein +FIG00456794 FIG00456795: hypothetical protein +FIG00456795 FIG00456796: hypothetical protein +FIG00456796 FIG00456797: hypothetical protein +FIG00456797 FIG00456798: hypothetical protein +FIG00456800 FIG00456801: hypothetical protein +FIG00456804 FIG00456805: hypothetical protein +FIG00456805 FIG00456806: hypothetical protein +FIG00456806 FIG00456807: hypothetical protein +FIG00456807 FIG00456810: hypothetical protein +FIG00456816 FIG00456818: hypothetical protein +FIG00456818 FIG00456819: hypothetical protein +FIG00456819 FIG00456820: hypothetical protein +FIG00456820 FIG00456824: hypothetical protein +FIG00456825 FIG00456826: hypothetical protein +FIG00456826 FIG00456829: hypothetical protein +FIG00456831 FIG00456834: hypothetical protein +FIG00456838 FIG00456839: hypothetical protein +FIG00456839 Transcriptional regulatory protein qseB +FIG00456843 FIG00456844: hypothetical protein +FIG00456844 FIG00456846: hypothetical protein +FIG00456846 FIG00456849: hypothetical protein +FIG00456854 FIG00456855: hypothetical protein +FIG00456855 FIG00456857: hypothetical protein +FIG00456858 FIG00456860: hypothetical protein +FIG00456860 FIG00456862: hypothetical protein +FIG00456863 FIG00456864: hypothetical protein +FIG00456865 FIG00456869: hypothetical protein +FIG00456869 FIG00456874: hypothetical protein +FIG00456874 FIG00456875: hypothetical protein +FIG00456875 FIG00456876: hypothetical protein +FIG00456876 FIG00456878: hypothetical protein +FIG00456879 FIG00456880: hypothetical protein +FIG00456880 FIG00456882: hypothetical protein +FIG00456882 FIG00456883: hypothetical protein +FIG00456883 FIG00456884: hypothetical protein +FIG00456884 FIG00456886: hypothetical protein +FIG00456886 FIG00638373: hypothetical protein +FIG00456888 FIG00456890: hypothetical protein +FIG00456890 FIG00456892: hypothetical protein +FIG00456893 FIG00456894: hypothetical protein +FIG00456894 FIG00456896: hypothetical protein +FIG00456897 FIG00456900: hypothetical protein +FIG00456901 FIG00456902: hypothetical protein +FIG00456902 FIG00456903: hypothetical protein +FIG00456903 FIG00456904: hypothetical protein +FIG00456904 FIG00456905: hypothetical protein +FIG00456905 FIG00456906: hypothetical protein +FIG00456906 FIG00456907: hypothetical protein +FIG00456908 FIG00456911: hypothetical protein +FIG00456913 FIG00456914: hypothetical protein +FIG00456918 FIG00456919: hypothetical protein +FIG00456919 FIG00456920: hypothetical protein +FIG00456920 FIG00456921: hypothetical protein +FIG00456924 FIG00456925: hypothetical protein +FIG00456926 FIG00456927: hypothetical protein +FIG00456927 FIG00456928: hypothetical protein +FIG00456928 FIG00456930: hypothetical protein +FIG00456930 Putative phosphoglycerate mutase( EC:5.4.2.1 ) +FIG00456932 FIG00456933: hypothetical protein +FIG00456933 FIG00456934: hypothetical protein +FIG00456934 Glycine betaine/carnitine/choline ABC transporter, permease protein +FIG00456935 FIG00456937: hypothetical protein +FIG00456937 FIG00456938: hypothetical protein +FIG00456938 FIG00456939: hypothetical protein +FIG00456943 FIG00456944: hypothetical protein +FIG00456944 FIG00456945: hypothetical protein +FIG00456945 FIG00456948: hypothetical protein +FIG00456948 FIG00456951: hypothetical protein +FIG00456951 FIG00456952: hypothetical protein +FIG00456952 FIG00456953: hypothetical protein +FIG00456953 FIG00456954: hypothetical protein +FIG00456954 hypothetical protein +FIG00456957 FIG00456958: hypothetical protein +FIG00456958 FIG00456959: hypothetical protein +FIG00456959 FIG00456963: hypothetical protein +FIG00456965 FIG00456966: hypothetical protein +FIG00456966 FIG00456968: hypothetical protein +FIG00456968 FIG00456969: hypothetical protein +FIG00456969 FIG00456974: hypothetical protein +FIG00456974 FIG00456975: hypothetical protein +FIG00456975 FIG00456976: hypothetical protein +FIG00456976 FIG00456977: hypothetical protein +FIG00456977 FIG00456978: hypothetical protein +FIG00456978 FIG00456979: hypothetical protein +FIG00456980 FIG00456981: hypothetical protein +FIG00456981 FIG00456982: hypothetical protein +FIG00456982 FIG00456986: hypothetical protein +FIG00456986 FIG00456987: hypothetical protein +FIG00456992 FIG00456993: hypothetical protein +FIG00456993 FIG00456994: hypothetical protein +FIG00456994 FIG00456995: hypothetical protein +FIG00456995 FIG00456996: hypothetical protein +FIG00456996 FIG00456997: hypothetical protein +FIG00456997 FIG00456999: hypothetical protein +FIG00457002 FIG00457004: hypothetical protein +FIG00457004 FIG00457005: hypothetical protein +FIG00457009 FIG00457011: hypothetical protein +FIG00457011 FIG00457012: hypothetical protein +FIG00457012 Autoinducer-binding transcriptional regulator BpsR +FIG00457013 Peptidyl-glycine alpha-amidating monooxygenase precursor (EC 1.14.17.3) +FIG00457025 FIG00457026: hypothetical protein +FIG00457029 FIG00457030: hypothetical protein +FIG00457031 FIG00457032: hypothetical protein +FIG00457032 FIG00457033: hypothetical protein +FIG00457033 FIG00457034: hypothetical protein +FIG00457034 FIG00457036: hypothetical protein +FIG00457036 FIG00457037: hypothetical protein +FIG00457037 FIG00457039: hypothetical protein +FIG00457042 FIG00457043: hypothetical protein +FIG00457045 FIG00457047: hypothetical protein +FIG00457050 FIG00457052: hypothetical protein +FIG00457052 FIG00457053: hypothetical protein +FIG00457053 FIG00457054: hypothetical protein +FIG00457054 FIG00457057: hypothetical protein +FIG00457057 corresponds to STY4569 from Accession AL513382: Salmonella typhi CT18 +FIG00457065 FIG00457072: hypothetical protein +FIG00457073 FIG00457074: hypothetical protein +FIG00457074 FIG00457076: hypothetical protein +FIG00457077 FIG00457079: hypothetical protein +FIG00457080 FAD-binding monooxygenase, PheA/TfdB family, similarity to 2,4-dichlorophenol 6-monooxygenase +FIG00457083 FIG00457084: hypothetical protein +FIG00457084 putative nucleoside 2-deoxyribosyltransferase +FIG00457085 FIG00457088: hypothetical protein +FIG00457088 FIG00457089: hypothetical protein +FIG00457089 FIG00457092: hypothetical protein +FIG00457093 FIG00457095: hypothetical protein +FIG00457096 FIG00457098: hypothetical protein +FIG00457098 FIG00457101: hypothetical protein +FIG00457101 FIG00457102: hypothetical protein +FIG00457102 FIG00457103: hypothetical protein +FIG00457103 FIG00457104: hypothetical protein +FIG00457104 FIG00457105: hypothetical protein +FIG00457108 FIG00457109: hypothetical protein +FIG00457109 FIG00457110: hypothetical protein +FIG00457110 FIG00457114: hypothetical protein +FIG00457114 FIG00457115: hypothetical protein +FIG00457115 FIG00457117: hypothetical protein +FIG00457117 Hypothetical secreted protein +FIG00457120 FIG00457121: hypothetical protein +FIG00457125 FIG00457126: hypothetical protein +FIG00457126 FIG00457127: hypothetical protein +FIG00457127 FIG00457129: hypothetical protein +FIG00457130 FIG00457133: hypothetical protein +FIG00457134 FIG00457137: hypothetical protein +FIG00457137 FIG00457140: hypothetical protein +FIG00457142 FIG00457143: hypothetical protein +FIG00457143 FIG00457144: hypothetical protein +FIG00457144 FIG00457146: hypothetical protein +FIG00457152 FIG00457154: hypothetical protein +FIG00457155 FIG00457156: hypothetical protein +FIG00457157 FIG00457158: hypothetical protein +FIG00457158 FIG00457159: hypothetical protein +FIG00457159 FIG00457165: hypothetical protein +FIG00457165 FIG00457166: hypothetical protein +FIG00457169 FIG00457170: hypothetical protein +FIG00457170 FIG00457171: hypothetical protein +FIG00457173 FIG00457175: hypothetical protein +FIG00457175 Predicted signal transduction protein containing a membrane domain, an EAL and a GGDEF domain +FIG00457182 FIG00457183: hypothetical protein +FIG00457183 FIG00457184: hypothetical protein +FIG00457184 FIG00457185: hypothetical protein +FIG00457185 FIG00457188: hypothetical protein +FIG00457189 FIG00457190: hypothetical protein +FIG00457190 FIG00457192: hypothetical protein +FIG00457192 FIG00457195: hypothetical protein +FIG00457195 FIG00457199: hypothetical protein +FIG00457199 FIG00457200: hypothetical protein +FIG00457200 FIG00457201: hypothetical protein +FIG00457201 hypothetical protein +FIG00457205 FIG00457210: hypothetical protein +FIG00457211 FIG00457213: hypothetical protein +FIG00457213 FIG00457215: hypothetical protein +FIG00457223 FIG00457225: hypothetical protein +FIG00457225 FIG00457226: hypothetical protein +FIG00457226 FIG00457227: hypothetical protein +FIG00457228 FIG00457232: hypothetical protein +FIG00457232 FIG00457233: hypothetical protein +FIG00457233 FIG00457234: hypothetical protein +FIG00457234 FIG00457235: hypothetical protein +FIG00457235 FIG00457237: hypothetical protein +FIG00457238 FIG00457239: hypothetical protein +FIG00457239 FIG00457240: hypothetical protein +FIG00457241 FIG00457242: hypothetical protein +FIG00457245 FIG00457246: hypothetical protein +FIG00457246 FIG00457248: hypothetical protein +FIG00457252 FIG00457254: hypothetical protein +FIG00457254 FIG00457256: hypothetical protein +FIG00457256 FIG00457257: hypothetical protein +FIG00457260 FIG00457261: hypothetical protein +FIG00457261 FIG00457263: hypothetical protein +FIG00457263 FIG00457265: hypothetical protein +FIG00457266 FIG00457267: hypothetical protein +FIG00457268 FIG00457269: hypothetical protein +FIG00457270 FIG00457272: hypothetical protein +FIG00457272 FIG00457274: hypothetical protein +FIG00457274 FIG00457277: hypothetical protein +FIG00457282 FIG00457285: hypothetical protein +FIG00457286 Phage lysin +FIG00457288 FIG00457291: hypothetical protein +FIG00457291 FIG00457292: hypothetical protein +FIG00457294 FIG00457297: hypothetical protein +FIG00457297 FIG00457299: hypothetical protein +FIG00457299 FIG00457301: hypothetical protein +FIG00457301 FIG00457302: hypothetical protein +FIG00457302 FIG00457303: hypothetical protein +FIG00457304 FIG00457305: hypothetical protein +FIG00457305 FIG00457308: hypothetical protein +FIG00457311 FIG00457314: hypothetical protein +FIG00457315 FIG00457316: hypothetical protein +FIG00457316 FIG00457320: hypothetical protein +FIG00457320 FIG00457321: hypothetical protein +FIG00457321 FIG00457322: hypothetical protein +FIG00457324 porin protein +FIG00457325 FIG00457326: hypothetical protein +FIG00457326 FIG00457328: hypothetical protein +FIG00457328 FIG00457330: hypothetical protein +FIG00457330 FIG00457331: hypothetical protein +FIG00457332 FIG00457333: hypothetical protein +FIG00457333 hypothetical protein +FIG00457335 FIG00457337: hypothetical protein +FIG00457341 FIG00457342: hypothetical protein +FIG00457342 FIG00457344: hypothetical protein +FIG00457347 FIG00457348: hypothetical protein +FIG00457348 FIG00457349: hypothetical protein +FIG00457350 FIG00457352: hypothetical protein +FIG00457352 FIG00457353: hypothetical protein +FIG00457355 FIG00457356: hypothetical protein +FIG00457356 FIG00457359: hypothetical protein +FIG00457359 FIG00457360: hypothetical protein +FIG00457364 FIG00457365: hypothetical protein +FIG00457370 FIG00457372: hypothetical protein +FIG00457376 FIG00457377: hypothetical protein +FIG00457381 FIG00457383: hypothetical protein +FIG00457383 FIG00457384: hypothetical protein +FIG00457384 FIG00457388: hypothetical protein +FIG00457388 FIG00457390: hypothetical protein +FIG00457390 FIG00457391: hypothetical protein +FIG00457391 FIG00977391: hypothetical protein +FIG00457402 FIG00457404: hypothetical protein +FIG00457404 FIG00457405: hypothetical protein +FIG00457406 FIG00457408: hypothetical protein +FIG00457408 FIG00457409: hypothetical protein +FIG00457412 FIG00457416: hypothetical protein +FIG00457417 FIG00457418: hypothetical protein +FIG00457419 FIG00457420: hypothetical protein +FIG00457420 FIG00457421: hypothetical protein +FIG00457421 Opine oxidase subunit A +FIG00457428 FIG00457430: hypothetical protein +FIG00457430 FIG00457431: hypothetical protein +FIG00457436 FIG00457438: hypothetical protein +FIG00457438 FIG00457443: hypothetical protein +FIG00457443 FIG00457444: hypothetical protein +FIG00457445 FIG00457450: hypothetical protein +FIG00457450 FIG00457451: hypothetical protein +FIG00457455 FIG00457457: hypothetical protein +FIG00457468 FIG00457469: hypothetical protein +FIG00457469 FIG00457471: hypothetical protein +FIG00457471 FIG00457472: hypothetical protein +FIG00457472 FIG00457475: hypothetical protein +FIG00457479 FIG00457480: hypothetical protein +FIG00457480 FIG00457483: hypothetical protein +FIG00457490 FIG00457491: hypothetical protein +FIG00457491 FIG00457493: hypothetical protein +FIG00457495 FIG00457496: hypothetical protein +FIG00457500 Putative FAD dependent oxidoreductase +FIG00457501 FIG00457502: hypothetical protein +FIG00457502 FIG00457503: hypothetical protein +FIG00457503 FIG00457504: hypothetical protein +FIG00457504 FIG00457508: hypothetical protein +FIG00457508 Phage protein +FIG00457510 FIG00457511: hypothetical protein +FIG00457517 hypothetical protein +FIG00457520 FIG00457521: hypothetical protein +FIG00457521 FIG00457530: hypothetical protein +FIG00457530 FIG00457532: hypothetical protein +FIG00457532 FIG00457533: hypothetical protein +FIG00457537 FIG00457540: hypothetical protein +FIG00457540 FadE30 +FIG00457544 FIG00457545: hypothetical protein +FIG00457545 FIG00457547: hypothetical protein +FIG00457547 FIG00457548: hypothetical protein +FIG00457548 FIG00457549: hypothetical protein +FIG00457549 FIG00457551: hypothetical protein +FIG00457555 FIG00457556: hypothetical protein +FIG00457556 FIG00457559: hypothetical protein +FIG00457566 FIG00457569: hypothetical protein +FIG00457570 FIG00457571: hypothetical protein +FIG00457571 FIG00457572: hypothetical protein +FIG00457575 FIG00457576: hypothetical protein +FIG00457579 hypothetical protein +FIG00457584 FIG00457585: hypothetical protein +FIG00457585 FIG00457588: hypothetical protein +FIG00457591 FIG00457592: hypothetical protein +FIG00457592 FIG00457593: hypothetical protein +FIG00457593 FIG00457596: hypothetical protein +FIG00457596 FIG00457599: hypothetical protein +FIG00457599 FIG00457601: hypothetical protein +FIG00457601 FIG00457602: hypothetical protein +FIG00457613 FIG00457614: hypothetical protein +FIG00457615 hypothetical protein +FIG00457616 FIG00457617: hypothetical protein +FIG00457617 FIG00457618: hypothetical protein +FIG00457618 FIG00457619: hypothetical protein +FIG00457619 FIG00457620: hypothetical protein +FIG00457621 FIG00457622: hypothetical protein +FIG00457622 FIG00457623: hypothetical protein +FIG00457623 FIG00457627: hypothetical protein +FIG00457627 FIG00457628: hypothetical protein +FIG00457628 FIG00457629: hypothetical protein +FIG00457629 FIG00457636: hypothetical protein +FIG00457637 FIG00457638: hypothetical protein +FIG00457638 FIG00457639: hypothetical protein +FIG00457640 FIG00457641: hypothetical protein +FIG00457641 FIG00457644: hypothetical protein +FIG00457647 FIG00457649: hypothetical protein +FIG00457649 FIG00457650: hypothetical protein +FIG00457651 FIG00457652: hypothetical protein +FIG00457652 FIG00457654: hypothetical protein +FIG00457654 FIG00457655: hypothetical protein +FIG00457655 FIG00457656: hypothetical protein +FIG00457656 FIG00457657: hypothetical protein +FIG00457660 type I restriction-modification system, M subunit (EC 2.1.1.72) +FIG00457663 FIG00457664: hypothetical protein +FIG00457664 FIG00457665: hypothetical protein +FIG00457665 FIG00457666: hypothetical protein +FIG00457668 protein of unknown function DUF417 +FIG00457669 FIG00457671: hypothetical protein +FIG00457675 FIG00457676: hypothetical protein +FIG00457678 FIG00457679: hypothetical protein +FIG00457679 FIG00457681: hypothetical protein +FIG00457687 FIG00457688: hypothetical protein +FIG00457691 FIG00457692: hypothetical protein +FIG00457692 FIG00457693: hypothetical protein +FIG00457693 FIG00457694: hypothetical protein +FIG00457694 FIG00457696: hypothetical protein +FIG00457696 FIG00457697: hypothetical protein +FIG00457698 FIG00457701: hypothetical protein +FIG00457701 FIG00457702: hypothetical protein +FIG00457705 FIG00457706: hypothetical protein +FIG00457707 FIG00457708: hypothetical protein +FIG00457708 FIG00457709: hypothetical protein +FIG00457710 FIG00457712: hypothetical protein +FIG00457712 FIG00457713: hypothetical protein +FIG00457715 FIG00457719: hypothetical protein +FIG00457720 FIG00457721: hypothetical protein +FIG00457722 FIG00457724: hypothetical protein +FIG00457724 FIG00457725: hypothetical protein +FIG00457725 FIG00457728: hypothetical protein +FIG00457729 FIG00457730: hypothetical protein +FIG00457730 FIG00457734: hypothetical protein +FIG00457738 FIG00457739: hypothetical protein +FIG00457739 FIG00457740: hypothetical protein +FIG00457743 FIG00457746: hypothetical protein +FIG00457748 FIG00457749: hypothetical protein +FIG00457751 FIG00457752: hypothetical protein +FIG00457754 FIG00457755: hypothetical protein +FIG00457755 FIG00457758: hypothetical protein +FIG00457760 FIG00457761: hypothetical protein +FIG00457774 FIG00457775: hypothetical protein +FIG00457775 FIG00457777: hypothetical protein +FIG00457777 FIG00457778: hypothetical protein +FIG00457778 FIG00457779: hypothetical protein +FIG00457779 FIG00457780: hypothetical protein +FIG00457780 FIG00457781: hypothetical protein +FIG00457781 FIG00457782: hypothetical protein +FIG00457782 FIG00457783: hypothetical protein +FIG00457783 FIG00457784: hypothetical protein +FIG00457785 FIG00457790: hypothetical protein +FIG00457790 FIG00457791: hypothetical protein +FIG00457793 FIG00457794: hypothetical protein +FIG00457794 FIG00457795: hypothetical protein +FIG00457796 FIG00457797: hypothetical protein +FIG00457797 FIG00457801: hypothetical protein +FIG00457801 FIG00457807: hypothetical protein +FIG00457807 FIG00457810: hypothetical protein +FIG00457818 Peptide ABC transporter, permease protein +FIG00457821 FIG00457822: hypothetical protein +FIG00457822 FIG00457824: hypothetical protein +FIG00457824 FIG00457825: hypothetical protein +FIG00457826 FIG00457827: hypothetical protein +FIG00457827 FIG00457829: hypothetical protein +FIG00457831 FIG00457832: hypothetical protein +FIG00457832 FIG00457833: hypothetical protein +FIG00457833 FIG00457835: hypothetical protein +FIG00457835 FIG00457836: hypothetical protein +FIG00457836 FIG00457837: hypothetical protein +FIG00457837 FIG00457839: hypothetical protein +FIG00457839 FIG00457840: hypothetical protein +FIG00457841 FIG00457842: hypothetical protein +FIG00457845 FIG00457846: hypothetical protein +FIG00457847 FIG00457848: hypothetical protein +FIG00457852 FIG00457854: hypothetical protein +FIG00457855 FIG00457857: hypothetical protein +FIG00457857 FIG00457858: hypothetical protein +FIG00457858 Cupin 2, conserved barrel +FIG00457859 FIG00457863: hypothetical protein +FIG00457863 FIG00457864: hypothetical protein +FIG00457865 FIG00457866: hypothetical protein +FIG00457866 Hydroxydechloroatrazine ethylaminohydrolase (EC 3.5.99.3) +FIG00457867 hypothetical protein +FIG00457870 FIG00457871: hypothetical protein +FIG00457872 outer membrane porin, OmpC family +FIG00457876 FIG00457877: hypothetical protein +FIG00457877 FIG00457880: hypothetical protein +FIG00457880 FIG00457881: hypothetical protein +FIG00457883 FIG00457886: hypothetical protein +FIG00457890 FIG00457893: hypothetical protein +FIG00457893 hypothetical protein +FIG00457896 FIG00457899: hypothetical protein +FIG00457905 FIG00457906: hypothetical protein +FIG00457906 FIG00457908: hypothetical protein +FIG00457912 FIG00457913: hypothetical protein +FIG00457913 FIG00457914: hypothetical protein +FIG00457914 FIG00457915: hypothetical protein +FIG00457915 FIG00457922: hypothetical protein +FIG00457922 FIG00457923: hypothetical protein +FIG00457923 FIG00457924: hypothetical protein +FIG00457924 FIG00457925: hypothetical protein +FIG00457925 FIG00457927: hypothetical protein +FIG00457928 FIG00457931: hypothetical protein +FIG00457934 hypothetical protein +FIG00457935 FIG00457936: hypothetical protein +FIG00457938 FIG00457940: hypothetical protein +FIG00457941 FIG00457943: hypothetical protein +FIG00457943 FIG00457946: hypothetical protein +FIG00457948 FIG00457950: hypothetical protein +FIG00457950 FIG00457951: hypothetical protein +FIG00457951 FIG00457952: hypothetical protein +FIG00457952 FIG00457955: hypothetical protein +FIG00457955 FIG00457956: hypothetical protein +FIG00457960 FIG00457962: hypothetical protein +FIG00457968 FIG00457969: hypothetical protein +FIG00457974 FIG00457976: hypothetical protein +FIG00457976 FIG00457978: hypothetical protein +FIG00457978 FIG00457980: hypothetical protein +FIG00457980 Probable amino acid ABC transporter protein, solute-binding component +FIG00457981 FIG00457982: hypothetical protein +FIG00457986 FIG00457988: hypothetical protein +FIG00457988 FIG00457990: hypothetical protein +FIG00457992 FIG00457993: hypothetical protein +FIG00457993 FIG00457994: hypothetical protein +FIG00457994 FIG00457995: hypothetical protein +FIG00457995 FIG00457997: hypothetical protein +FIG00457997 FIG00457998: hypothetical protein +FIG00457998 FIG00457999: hypothetical protein +FIG00457999 FIG00458001: hypothetical protein +FIG00458001 FIG00458003: hypothetical protein +FIG00458007 FIG00458008: hypothetical protein +FIG00458009 FIG00458010: hypothetical protein +FIG00458013 FIG00458014: hypothetical protein +FIG00458014 FIG00458016: hypothetical protein +FIG00458030 FIG00458031: hypothetical protein +FIG00458038 FIG00458039: hypothetical protein +FIG00458039 FIG00458041: hypothetical protein +FIG00458041 FIG00458042: hypothetical protein +FIG00458042 FIG00458044: hypothetical protein +FIG00458044 FIG00458045: hypothetical protein +FIG00458051 FIG00458052: hypothetical protein +FIG00458052 FIG00458055: hypothetical protein +FIG00458055 FIG00458056: hypothetical protein +FIG00458058 FIG00458059: hypothetical protein +FIG00458059 FIG00458060: hypothetical protein +FIG00458061 FIG00458063: hypothetical protein +FIG00458069 FIG00458071: hypothetical protein +FIG00458072 FIG00458073: hypothetical protein +FIG00458073 FIG00458074: hypothetical protein +FIG00458076 FIG00458077: hypothetical protein +FIG00458078 FIG00458079: hypothetical protein +FIG00458080 FIG00458081: hypothetical protein +FIG00458081 FIG00458082: hypothetical protein +FIG00458082 FIG00458086: hypothetical protein +FIG00458086 FIG00458087: hypothetical protein +FIG00458087 Y4wH +FIG00458094 FIG00458095: hypothetical protein +FIG00458095 FIG00458096: hypothetical protein +FIG00458096 FIG00458102: hypothetical protein +FIG00458116 FIG00458117: hypothetical protein +FIG00458119 FIG00458121: hypothetical protein +FIG00458121 FIG00458124: hypothetical protein +FIG00458125 FIG00458126: hypothetical protein +FIG00458128 FIG00450095: hypothetical protein +FIG00458129 FIG00458130: hypothetical protein +FIG00458130 FIG00458131: hypothetical protein +FIG00458131 Isoprenylcysteine carboxyl methyltransferase +FIG00458132 FIG00458133: hypothetical protein +FIG00458133 FIG00458134: hypothetical protein +FIG00458134 FIG00458135: hypothetical protein +FIG00458142 FIG00458145: hypothetical protein +FIG00458145 FIG00458148: hypothetical protein +FIG00458148 FIG00458150: hypothetical protein +FIG00458151 FIG00458153: hypothetical protein +FIG00458154 FIG00458155: hypothetical protein +FIG00458155 FIG00458156: hypothetical protein +FIG00458160 FIG00458164: hypothetical protein +FIG00458165 Sulfate permease and related transporters (MFS superfamily) +FIG00458167 FIG00458168: hypothetical protein +FIG00458168 FIG00458170: hypothetical protein +FIG00458174 FIG00458175: hypothetical protein +FIG00458176 FIG00458177: hypothetical protein +FIG00458177 FIG00458178: hypothetical protein +FIG00458178 FIG00458182: hypothetical protein +FIG00458182 FIG00458184: hypothetical protein +FIG00458189 FIG00458190: hypothetical protein +FIG00458193 FIG00458194: hypothetical protein +FIG00458194 FIG00458196: hypothetical protein +FIG00458199 FIG00458201: hypothetical protein +FIG00458201 FIG00458208: hypothetical protein +FIG00458209 FIG00458210: hypothetical protein +FIG00458211 FIG00458212: hypothetical protein +FIG00458212 FIG00458213: hypothetical protein +FIG00458213 FIG00458214: hypothetical protein +FIG00458214 FIG00458215: hypothetical protein +FIG00458215 FIG00458216: hypothetical protein +FIG00458217 FIG00458218: hypothetical protein +FIG00458222 FIG00458223: hypothetical protein +FIG00458223 FIG00458225: hypothetical protein +FIG00458225 FIG00458226: hypothetical protein +FIG00458226 FIG00458227: hypothetical protein +FIG00458227 FIG00458228: hypothetical protein +FIG00458228 FIG00458230: hypothetical protein +FIG00458230 FIG00458233: hypothetical protein +FIG00458233 FIG00458236: hypothetical protein +FIG00458236 FIG00458237: hypothetical protein +FIG00458237 FIG00458238: hypothetical protein +FIG00458245 FIG00458247: hypothetical protein +FIG00458249 FIG00458251: hypothetical protein +FIG00458251 FIG00458252: hypothetical protein +FIG00458253 FIG00458254: hypothetical protein +FIG00458256 FIG00458257: hypothetical protein +FIG00458257 FIG00458259: hypothetical protein +FIG00458259 FIG00458260: hypothetical protein +FIG00458260 FIG00458261: hypothetical protein +FIG00458261 FIG00458262: hypothetical protein +FIG00458262 FIG00458265: hypothetical protein +FIG00458265 FIG00458266: hypothetical protein +FIG00458266 FIG00458267: hypothetical protein +FIG00458272 FIG00458273: hypothetical protein +FIG00458273 FIG00458274: hypothetical protein +FIG00458274 FIG00458275: hypothetical protein +FIG00458275 FIG00458276: hypothetical protein +FIG00458277 FIG00458278: hypothetical protein +FIG00458278 FIG00458281: hypothetical protein +FIG00458281 FIG00458283: hypothetical protein +FIG00458283 FIG00458285: hypothetical protein +FIG00458287 FIG00458288: hypothetical protein +FIG00458288 FIG00458290: hypothetical protein +FIG00458290 FIG00458293: hypothetical protein +FIG00458293 FIG00458294: hypothetical protein +FIG00458300 FIG00458302: hypothetical protein +FIG00458303 FIG00458304: hypothetical protein +FIG00458304 FIG00458305: hypothetical protein +FIG00458305 1185 +FIG00458308 FIG00458309: hypothetical protein +FIG00458309 FIG00458311: hypothetical protein +FIG00458311 FIG00458312: hypothetical protein +FIG00458313 FIG00458315: hypothetical protein +FIG00458315 FIG00458316: hypothetical protein +FIG00458317 FIG00458318: hypothetical protein +FIG00458318 FIG00458320: hypothetical protein +FIG00458325 FIG00458326: hypothetical protein +FIG00458327 FIG00458328: hypothetical protein +FIG00458328 FIG00458329: hypothetical protein +FIG00458329 FIG00458335: hypothetical protein +FIG00458337 FIG00458339: hypothetical protein +FIG00458340 FIG00458343: hypothetical protein +FIG00458354 FIG00458357: hypothetical protein +FIG00458357 FIG00440100: hypothetical protein +FIG00458359 FIG00458362: hypothetical protein +FIG00458362 FIG00458363: hypothetical protein +FIG00458363 FIG00458364: hypothetical protein +FIG00458368 FIG00458369: hypothetical protein +FIG00458370 FIG00458371: hypothetical protein +FIG00458381 FIG00458382: hypothetical protein +FIG00458382 FIG00458384: hypothetical protein +FIG00458384 FIG00458385: hypothetical protein +FIG00458385 FIG00458387: hypothetical protein +FIG00458387 FIG00458388: hypothetical protein +FIG00458388 FIG00458389: hypothetical protein +FIG00458389 FIG00458390: hypothetical protein +FIG00458392 FIG00458394: hypothetical protein +FIG00458394 FIG00458397: hypothetical protein +FIG00458397 FIG00458399: hypothetical protein +FIG00458400 FIG00458401: hypothetical protein +FIG00458402 FIG00458405: hypothetical protein +FIG00458405 FIG00458407: hypothetical protein +FIG00458408 FIG00458415: hypothetical protein +FIG00458415 FIG00458416: hypothetical protein +FIG00458417 FIG00458419: hypothetical protein +FIG00458423 FIG00458426: hypothetical protein +FIG00458426 FIG00458428: hypothetical protein +FIG00458431 FIG00458432: hypothetical protein +FIG00458432 FIG00458433: hypothetical protein +FIG00458433 FIG00458435: hypothetical protein +FIG00458435 FIG00458436: hypothetical protein +FIG00458436 FIG00458437: hypothetical protein +FIG00458439 FIG00458444: hypothetical protein +FIG00458444 FIG00458445: hypothetical protein +FIG00458445 FIG00458452: hypothetical protein +FIG00458452 FIG00458453: hypothetical protein +FIG00458455 Major facilitator family transporter +FIG00458456 FIG00458458: hypothetical protein +FIG00458458 FIG00458460: hypothetical protein +FIG00458460 FIG00458461: hypothetical protein +FIG00458464 Polyketide synthase +FIG00458465 FIG00458467: hypothetical protein +FIG00458467 FIG00458468: hypothetical protein +FIG00458468 FIG00458470: hypothetical protein +FIG00458470 FIG00458471: hypothetical protein +FIG00458471 FIG00458472: hypothetical protein +FIG00458472 FIG00458473: hypothetical protein +FIG00458478 FIG00458480: hypothetical protein +FIG00458480 FIG00458486: hypothetical protein +FIG00458487 FIG00458488: hypothetical protein +FIG00458488 FIG00458494: hypothetical protein +FIG00458499 FIG00458500: hypothetical protein +FIG00458500 FIG00458501: hypothetical protein +FIG00458503 FIG00458506: hypothetical protein +FIG00458509 FIG00458510: hypothetical protein +FIG00458513 FIG00458514: hypothetical protein +FIG00458516 FIG00458517: hypothetical protein +FIG00458518 FIG00458519: hypothetical protein +FIG00458519 FIG00458523: hypothetical protein +FIG00458524 FIG00458525: hypothetical protein +FIG00458525 FIG00458526: hypothetical protein +FIG00458526 FIG00458528: hypothetical protein +FIG00458529 Thiaminase I precursor (EC 2.5.1.2) +FIG00458531 FIG00458534: hypothetical protein +FIG00458534 FIG00458535: hypothetical protein +FIG00458535 FIG00458538: hypothetical protein +FIG00458545 FIG00458546: hypothetical protein +FIG00458556 FIG00458557: hypothetical protein +FIG00458557 FIG00458558: hypothetical protein +FIG00458558 FIG00458564: hypothetical protein +FIG00458564 FIG00458566: hypothetical protein +FIG00458566 FIG00458567: hypothetical protein +FIG00458569 FIG00458571: hypothetical protein +FIG00458571 FIG00458572: hypothetical protein +FIG00458575 FIG00458578: hypothetical protein +FIG00458578 FIG00458579: hypothetical protein +FIG00458579 YbhB and YbcL +FIG00458582 FIG00458585: hypothetical protein +FIG00458585 FIG00458586: hypothetical protein +FIG00458586 FIG00458591: hypothetical protein +FIG00458591 FIG00458592: hypothetical protein +FIG00458592 FIG00458593: hypothetical protein +FIG00458593 FIG00458594: hypothetical protein +FIG00458604 FIG00458605: hypothetical protein +FIG00458609 FIG00458612: hypothetical protein +FIG00458616 FIG00458617: hypothetical protein +FIG00458617 FIG00458618: hypothetical protein +FIG00458618 FIG00458620: hypothetical protein +FIG00458620 FIG00458624: hypothetical protein +FIG00458629 FIG00458632: hypothetical protein +FIG00458632 FIG00456209: hypothetical protein +FIG00458639 FIG00458640: hypothetical protein +FIG00458640 FIG00458641: hypothetical protein +FIG00458641 FIG00458642: hypothetical protein +FIG00458643 FIG00458645: hypothetical protein +FIG00458645 Bacterial lipocalin +FIG00458646 FIG00458648: hypothetical protein +FIG00458648 COG0745: Response regulators consisting of a CheY-like receiver domain and a winged-helix DNA-binding domain +FIG00458650 FIG00458652: hypothetical protein +FIG00458656 FIG00458658: hypothetical protein +FIG00458658 FIG00458660: hypothetical protein +FIG00458661 FIG00458665: hypothetical protein +FIG00458666 FIG00458670: hypothetical protein +FIG00458670 FIG00458672: hypothetical protein +FIG00458684 FIG00458685: hypothetical protein +FIG00458685 FIG00458689: hypothetical protein +FIG00458699 FIG00458700: hypothetical protein +FIG00458700 FIG00458703: hypothetical protein +FIG00458703 FIG00458705: hypothetical protein +FIG00458707 FIG00458708: hypothetical protein +FIG00458708 FIG00458709: hypothetical protein +FIG00458709 virulence factor MVIN family protein +FIG00458712 FIG00458715: hypothetical protein +FIG00458715 FIG00458716: hypothetical protein +FIG00458716 FIG00458717: hypothetical protein +FIG00458717 FIG00458719: hypothetical protein +FIG00458720 FIG00458721: hypothetical protein +FIG00458721 FIG00458722: hypothetical protein +FIG00458722 FIG00458724: hypothetical protein +FIG00458724 FIG00458725: hypothetical protein +FIG00458726 FIG00458728: hypothetical protein +FIG00458728 FIG00458731: hypothetical protein +FIG00458732 FIG00458733: hypothetical protein +FIG00458733 FIG00458736: hypothetical protein +FIG00458740 FIG00458741: hypothetical protein +FIG00458741 FIG00458742: hypothetical protein +FIG00458742 FIG00458743: hypothetical protein +FIG00458743 FIG00458747: hypothetical protein +FIG00458753 FIG00458755: hypothetical protein +FIG00458755 FIG00458759: hypothetical protein +FIG00458764 FIG00458767: hypothetical protein +FIG00458767 FIG00458769: hypothetical protein +FIG00458769 sulfite:cytochrome c oxidoreductase subunit A +FIG00458772 FIG00458775: hypothetical protein +FIG00458775 FIG00458778: hypothetical protein +FIG00458778 FIG00458782: hypothetical protein +FIG00458782 FIG00458786: hypothetical protein +FIG00458786 FIG00458787: hypothetical protein +FIG00458787 FIG00458791: hypothetical protein +FIG00458791 FIG00458792: hypothetical protein +FIG00458793 FIG00458795: hypothetical protein +FIG00458796 Two-component hybrid sensor and regulator +FIG00458798 FIG00458799: hypothetical protein +FIG00458799 FIG00458800: hypothetical protein +FIG00458800 FIG00458801: hypothetical protein +FIG00458801 FIG00458802: hypothetical protein +FIG00458803 FIG00458805: hypothetical protein +FIG00458809 Possible FusB/FusC Fusaric Acid resistance pump +FIG00458810 FIG00458811: hypothetical protein +FIG00458816 FIG00458818: hypothetical protein +FIG00458819 FIG00458820: hypothetical protein +FIG00458822 FIG00458828: hypothetical protein +FIG00458828 FIG00458831: hypothetical protein +FIG00458832 FIG00458833: hypothetical protein +FIG00458836 hypothetical protein +FIG00458837 FIG00458839: hypothetical protein +FIG00458842 HpaP protein; Type III secretion protein (YscP) +FIG00458846 FIG00458849: hypothetical protein +FIG00458851 FIG00458852: hypothetical protein +FIG00458852 FIG00458853: hypothetical protein +FIG00458855 FIG00458856: hypothetical protein +FIG00458857 FIG00458858: hypothetical protein +FIG00458858 FIG00458861: hypothetical protein +FIG00458861 FIG00458862: hypothetical protein +FIG00458862 Pathogenicity 1 island effector protein +FIG00458863 FIG00458864: hypothetical protein +FIG00458868 FIG00458869: hypothetical protein +FIG00458869 FIG00458874: hypothetical protein +FIG00458874 FIG00458876: hypothetical protein +FIG00458886 FIG00458889: hypothetical protein +FIG00458889 FIG00458891: hypothetical protein +FIG00458891 FIG00458892: hypothetical protein +FIG00458892 hypothetical protein +FIG00458895 FIG00458896: hypothetical protein +FIG00458901 FIG00458904: hypothetical protein +FIG00458904 FIG00458905: hypothetical protein +FIG00458913 FIG00458915: hypothetical protein +FIG00458915 FIG00458918: hypothetical protein +FIG00458918 FIG00458920: hypothetical protein +FIG00458920 FIG00458921: hypothetical protein +FIG00458921 FIG00458926: hypothetical protein +FIG00458928 FIG00458929: hypothetical protein +FIG00458929 FIG00458932: hypothetical protein +FIG00458932 FIG00458935: hypothetical protein +FIG00458935 FIG00458941: hypothetical protein +FIG00458941 FIG00458942: hypothetical protein +FIG00458946 FIG00458947: hypothetical protein +FIG00458954 FIG00458956: hypothetical protein +FIG00458956 cAMP-dependent 3',5'-cyclic phosphodiesterase 4A( EC:3.1.4.17 ) +FIG00458959 FIG00458960: hypothetical protein +FIG00458960 FIG00458963: hypothetical protein +FIG00458964 FIG00458965: hypothetical protein +FIG00458966 FIG00458967: hypothetical protein +FIG00458967 FIG00458968: hypothetical protein +FIG00458968 FIG00458971: hypothetical protein +FIG00458972 FIG00458975: hypothetical protein +FIG00458975 hypothetical protein +FIG00458981 FIG00458982: hypothetical protein +FIG00458982 FIG00458983: hypothetical protein +FIG00458987 FIG00458988: hypothetical protein +FIG00458988 FIG00458989: hypothetical protein +FIG00458997 FIG00458998: hypothetical protein +FIG00458998 FIG00459000: hypothetical protein +FIG00459000 FIG00459002: hypothetical protein +FIG00459004 FIG00459007: hypothetical protein +FIG00459007 FIG00459008: hypothetical protein +FIG00459009 FIG00459011: hypothetical protein +FIG00459011 hypothetical protein +FIG00459017 FIG00459025: hypothetical protein +FIG00459030 FIG00459032: hypothetical protein +FIG00459032 FIG00459037: hypothetical protein +FIG00459037 FIG00459038: hypothetical protein +FIG00459040 Possible fucose ABC transporter, substrate-binding component +FIG00459042 FIG00459043: hypothetical protein +FIG00459043 FIG00459044: hypothetical protein +FIG00459044 FIG00459047: hypothetical protein +FIG00459047 FIG00459051: hypothetical protein +FIG00459051 FIG00459052: hypothetical protein +FIG00459052 FIG00459053: hypothetical protein +FIG00459053 FIG00459057: hypothetical protein +FIG00459057 FIG00459058: hypothetical protein +FIG00459059 FIG00459061: hypothetical protein +FIG00459061 FIG00459065: hypothetical protein +FIG00459067 FIG00459069: hypothetical protein +FIG00459071 FIG00459074: hypothetical protein +FIG00459077 FIG00459078: hypothetical protein +FIG00459078 FIG00459080: hypothetical protein +FIG00459080 FIG00459081: hypothetical protein +FIG00459081 FIG00459083: hypothetical protein +FIG00459083 FIG00459084: hypothetical protein +FIG00459086 FIG00459087: hypothetical protein +FIG00459087 FIG00459088: hypothetical protein +FIG00459088 FIG00459091: hypothetical protein +FIG00459091 FIG00459093: hypothetical protein +FIG00459093 FIG00459097: hypothetical protein +FIG00459100 FIG00459102: hypothetical protein +FIG00459109 FIG00459116: hypothetical protein +FIG00459116 FIG00459118: hypothetical protein +FIG00459119 FIG00459120: hypothetical protein +FIG00459122 FIG00459124: hypothetical protein +FIG00459124 FIG00459125: hypothetical protein +FIG00459125 FIG00459127: hypothetical protein +FIG00459131 D-threo-aldose 1-dehydrogenase (EC 1.1.1.122) +FIG00459132 FIG00459135: hypothetical protein +FIG00459136 FIG00459137: hypothetical protein +FIG00459139 FIG00459141: hypothetical protein +FIG00459145 FIG00459146: hypothetical protein +FIG00459149 FIG00459151: hypothetical protein +FIG00459154 FIG00459155: hypothetical protein +FIG00459155 ABC-type branched-chain amino acid transport system, permease component +FIG00459158 FIG00459165: hypothetical protein +FIG00459166 FIG00459167: hypothetical protein +FIG00459167 FIG00459169: hypothetical protein +FIG00459169 FIG00459172: hypothetical protein +FIG00459173 FIG00459175: hypothetical protein +FIG00459176 FIG00459181: hypothetical protein +FIG00459181 FIG00459182: hypothetical protein +FIG00459182 Putative diguanylate cyclase/phosphodiesterase (GGDEF & EAL domains) +FIG00459183 FIG00459186: hypothetical protein +FIG00459191 FIG00459192: hypothetical protein +FIG00459195 FIG00459196: hypothetical protein +FIG00459196 FIG00459198: hypothetical protein +FIG00459198 FIG00459200: hypothetical protein +FIG00459207 FIG00459208: hypothetical protein +FIG00459208 FIG00459209: hypothetical protein +FIG00459209 FIG00459210: hypothetical protein +FIG00459210 FIG00459211: hypothetical protein +FIG00459212 FIG00459216: hypothetical protein +FIG00459216 FIG00459217: hypothetical protein +FIG00459217 FIG00459219: hypothetical protein +FIG00459219 FIG00459223: hypothetical protein +FIG00459223 FIG00459224: hypothetical protein +FIG00459225 FIG00459229: hypothetical protein +FIG00459229 FIG00459231: hypothetical protein +FIG00459231 FIG00459236: hypothetical protein +FIG00459239 FIG00459240: hypothetical protein +FIG00459240 FIG00459242: hypothetical protein +FIG00459242 FIG00459243: hypothetical protein +FIG00459243 FIG00459248: hypothetical protein +FIG00459248 FIG00459251: hypothetical protein +FIG00459251 FIG00459252: hypothetical protein +FIG00459253 FIG00459254: hypothetical protein +FIG00459254 FIG00459255: hypothetical protein +FIG00459264 FIG00459265: hypothetical protein +FIG00459267 FIG00459268: hypothetical protein +FIG00459270 FIG00459271: hypothetical protein +FIG00459271 FIG00459275: hypothetical protein +FIG00459275 FIG00459277: hypothetical protein +FIG00459279 FIG00459280: hypothetical protein +FIG00459280 FIG00459282: hypothetical protein +FIG00459284 FIG00459287: hypothetical protein +FIG00459292 FIG00459296: hypothetical protein +FIG00459296 FIG00459298: hypothetical protein +FIG00459299 hypothetical protein +FIG00459301 FIG00459302: hypothetical protein +FIG00459302 FIG00459303: hypothetical protein +FIG00459303 FIG00459304: hypothetical protein +FIG00459304 FIG00459310: hypothetical protein +FIG00459310 FIG00459311: hypothetical protein +FIG00459315 FIG00459317: hypothetical protein +FIG00459317 FIG00459319: hypothetical protein +FIG00459319 FIG00459321: hypothetical protein +FIG00459323 FIG00459325: hypothetical protein +FIG00459329 FIG00459330: hypothetical protein +FIG00459330 FIG00459331: hypothetical protein +FIG00459334 FIG00459336: hypothetical protein +FIG00459336 FIG00459337: hypothetical protein +FIG00459337 FIG00459340: hypothetical protein +FIG00459343 FIG00459344: hypothetical protein +FIG00459354 FIG00459357: hypothetical protein +FIG00459357 FIG00459358: hypothetical protein +FIG00459358 FIG00459359: hypothetical protein +FIG00459360 FIG00459361: hypothetical protein +FIG00459361 FIG00459362: hypothetical protein +FIG00459362 FIG00459363: hypothetical protein +FIG00459363 FIG00459364: hypothetical protein +FIG00459365 FIG00459367: hypothetical protein +FIG00459367 FIG00976670: hypothetical protein +FIG00459368 FIG00459369: hypothetical protein +FIG00459369 FIG00459371: hypothetical protein +FIG00459377 FIG00459378: hypothetical protein +FIG00459378 FIG00459380: hypothetical protein +FIG00459380 FIG00459382: hypothetical protein +FIG00459383 FIG00459385: hypothetical protein +FIG00459385 FIG00459386: hypothetical protein +FIG00459386 FIG00459388: hypothetical protein +FIG00459388 FIG00459391: hypothetical protein +FIG00459395 FIG00459397: hypothetical protein +FIG00459398 FIG00459400: hypothetical protein +FIG00459400 FIG00459401: hypothetical protein +FIG00459401 FIG00459404: hypothetical protein +FIG00459404 FIG00459406: hypothetical protein +FIG00459406 FIG00459408: hypothetical protein +FIG00459416 FIG00459417: hypothetical protein +FIG00459421 FIG00459423: hypothetical protein +FIG00459423 FIG00459424: hypothetical protein +FIG00459424 Signal transduction response regulator / Disease resistance domain-containing protein / Tetratricopeptide repeat-containing protein +FIG00459428 FIG00459429: hypothetical protein +FIG00459429 FIG00459431: hypothetical protein +FIG00459433 FIG00459434: hypothetical protein +FIG00459434 FIG00459435: hypothetical protein +FIG00459435 FIG00459436: hypothetical protein +FIG00459436 Mn-containing catalase +FIG00459444 FIG00459446: hypothetical protein +FIG00459446 FIG00459447: hypothetical protein +FIG00459447 FIG00459448: hypothetical protein +FIG00459448 FIG00459449: hypothetical protein +FIG00459449 FIG00459452: hypothetical protein +FIG00459454 FIG00459458: hypothetical protein +FIG00459458 FIG00459461: hypothetical protein +FIG00459461 FIG00459462: hypothetical protein +FIG00459466 FIG00459467: hypothetical protein +FIG00459467 FIG00459469: hypothetical protein +FIG00459473 FIG00459474: hypothetical protein +FIG00459474 FIG00459476: hypothetical protein +FIG00459477 FIG00459481: hypothetical protein +FIG00459487 FIG00459489: hypothetical protein +FIG00459493 FIG00459494: hypothetical protein +FIG00459495 FIG00459497: hypothetical protein +FIG00459497 FIG00459499: hypothetical protein +FIG00459499 Domain of unknown function DUF1537 +FIG00459503 FIG00459505: hypothetical protein +FIG00459506 FIG00459507: hypothetical protein +FIG00459509 FIG00459510: hypothetical protein +FIG00459512 FIG00459513: hypothetical protein +FIG00459513 FIG00459514: hypothetical protein +FIG00459514 FIG00459515: hypothetical protein +FIG00459518 FIG00459519: hypothetical protein +FIG00459526 FIG00459529: hypothetical protein +FIG00459532 FIG00459534: hypothetical protein +FIG00459539 FIG00459540: hypothetical protein +FIG00459543 FIG00459544: hypothetical protein +FIG00459549 FIG00459550: hypothetical protein +FIG00459551 FIG00459553: hypothetical protein +FIG00459557 major pilin protein fimA +FIG00459558 FIG00459560: hypothetical protein +FIG00459560 FIG00459563: hypothetical protein +FIG00459567 FIG00459569: hypothetical protein +FIG00459569 FIG00459572: hypothetical protein +FIG00459572 FIG00459574: hypothetical protein +FIG00459576 FIG00459578: hypothetical protein +FIG00459586 hypothetical protein +FIG00459587 FIG00459588: hypothetical protein +FIG00459588 FIG00459591: hypothetical protein +FIG00459600 FIG00459602: hypothetical protein +FIG00459605 FIG00459606: hypothetical protein +FIG00459606 FIG00459608: hypothetical protein +FIG00459610 FIG00459611: hypothetical protein +FIG00459611 FIG00459612: hypothetical protein +FIG00459618 FIG00459619: hypothetical protein +FIG00459620 FIG00459622: hypothetical protein +FIG00459625 FIG00459626: hypothetical protein +FIG00459627 FIG00459629: hypothetical protein +FIG00459633 FIG00459634: hypothetical protein +FIG00459636 FIG00459638: hypothetical protein +FIG00459638 FIG00459640: hypothetical protein +FIG00459641 FIG00459642: hypothetical protein +FIG00459644 FIG00459645: hypothetical protein +FIG00459652 FIG00459655: hypothetical protein +FIG00459655 FIG00459656: hypothetical protein +FIG00459656 FIG00459658: hypothetical protein +FIG00459660 FIG00459665: hypothetical protein +FIG00459668 hypothetical protein +FIG00459674 FIG00459677: hypothetical protein +FIG00459681 FIG00459682: hypothetical protein +FIG00459682 Acyl-coenzyme A:6-aminopenicillanic-acid-acyltransferase 40 kDa form (EC 2.3.1.164) +FIG00459684 FIG00459685: hypothetical protein +FIG00459685 FIG00459689: hypothetical protein +FIG00459691 Serine--pyruvate aminotransferase, mitochondrial precursor (EC 2.6.1.51) (SPT) (Alanine--glyoxylate aminotransferase) (EC 2.6.1.44) (AGT) +FIG00459692 FIG00459693: hypothetical protein +FIG00459693 FIG00459694: hypothetical protein +FIG00459701 FIG00459704: hypothetical protein +FIG00459704 FIG00459707: hypothetical protein +FIG00459710 FIG00459713: hypothetical protein +FIG00459713 FIG00459714: hypothetical protein +FIG00459714 FIG00459715: hypothetical protein +FIG00459716 FIG00459717: hypothetical protein +FIG00459717 Phage-related tail protein +FIG00459722 FIG00459723: hypothetical protein +FIG00459723 FIG00459724: hypothetical protein +FIG00459724 FIG00459726: hypothetical protein +FIG00459731 FIG00459733: hypothetical protein +FIG00459735 FIG00459736: hypothetical protein +FIG00459736 FIG00459737: hypothetical protein +FIG00459737 FIG00459742: hypothetical protein +FIG00459747 FIG00459749: hypothetical protein +FIG00459749 FIG00459750: hypothetical protein +FIG00459752 hrp protein, putative +FIG00459755 FIG00459756: hypothetical protein +FIG00459765 FIG00459769: hypothetical protein +FIG00459769 FIG00459776: hypothetical protein +FIG00459776 FIG00459778: hypothetical protein +FIG00459778 Ferredoxin +FIG00459780 LysE family protein +FIG00459782 FIG00459784: hypothetical protein +FIG00459784 FIG00459785: hypothetical protein +FIG00459786 FIG00459788: hypothetical protein +FIG00459792 FIG00459794: hypothetical protein +FIG00459794 FIG00459795: hypothetical protein +FIG00459795 FIG00459796: hypothetical protein +FIG00459799 FIG00459800: hypothetical protein +FIG00459802 FIG00459803: hypothetical protein +FIG00459807 FIG00459808: hypothetical protein +FIG00459811 FIG00459815: hypothetical protein +FIG00459820 FIG00459822: hypothetical protein +FIG00459840 FIG00459841: hypothetical protein +FIG00459843 FIG00459845: hypothetical protein +FIG00459846 FIG00459847: hypothetical protein +FIG00459849 FIG00459851: hypothetical protein +FIG00459868 FIG00459869: hypothetical protein +FIG00459871 FIG00459874: hypothetical protein +FIG00459874 FIG00459876: hypothetical protein +FIG00459878 FIG00459879: hypothetical protein +FIG00459879 FIG00459880: hypothetical protein +FIG00459881 FIG00459882: hypothetical protein +FIG00459888 FIG00459889: hypothetical protein +FIG00459889 FIG00459890: hypothetical protein +FIG00459890 FIG00459891: hypothetical protein +FIG00459891 FIG00459892: hypothetical protein +FIG00459893 FIG00459894: hypothetical protein +FIG00459896 FIG00459897: hypothetical protein +FIG00459897 FIG00459899: hypothetical protein +FIG00459903 FIG00459904: hypothetical protein +FIG00459906 FIG00459907: hypothetical protein +FIG00459909 FIG00459911: hypothetical protein +FIG00459911 FIG00459912: hypothetical protein +FIG00459912 FIG00459914: hypothetical protein +FIG00459918 FIG00459919: hypothetical protein +FIG00459934 FIG00459936: hypothetical protein +FIG00459936 FIG00459939: hypothetical protein +FIG00459940 FIG00459941: hypothetical protein +FIG00459942 FIG00459943: hypothetical protein +FIG00459943 FIG00459944: hypothetical protein +FIG00459944 FIG00459946: hypothetical protein +FIG00459946 FIG00459947: hypothetical protein +FIG00459947 FIG00459948: hypothetical protein +FIG00459949 FIG00459950: hypothetical protein +FIG00459950 FIG00459952: hypothetical protein +FIG00459952 FIG00459954: hypothetical protein +FIG00459954 FIG00459956: hypothetical protein +FIG00459958 FIG00459959: hypothetical protein +FIG00459959 FIG00459960: hypothetical protein +FIG00459961 ribosomal RNA small subunit methyltransferase B( EC:2.1.1.- ) +FIG00459963 FIG00459965: hypothetical protein +FIG00459974 FIG00459976: hypothetical protein +FIG00459976 FIG00459977: hypothetical protein +FIG00459978 FIG00459981: hypothetical protein +FIG00459982 FIG00459983: hypothetical protein +FIG00459983 FIG00459984: hypothetical protein +FIG00459989 FIG00459990: hypothetical protein +FIG00459996 FIG00459998: hypothetical protein +FIG00459998 FIG00459999: hypothetical protein +FIG00460003 FIG00460005: hypothetical protein +FIG00460008 FIG00460009: hypothetical protein +FIG00460023 FIG00460025: hypothetical protein +FIG00460028 FIG00460030: hypothetical protein +FIG00460045 FIG00460047: hypothetical protein +FIG00460053 FIG00460054: hypothetical protein +FIG00460054 FIG00460055: hypothetical protein +FIG00460066 FIG00460075: hypothetical protein +FIG00460075 FIG00460078: hypothetical protein +FIG00460085 FIG00460086: hypothetical protein +FIG00460091 Polyketide non-ribosomal peptide synthase +FIG00460093 FIG00460094: hypothetical protein +FIG00460094 FIG00460095: hypothetical protein +FIG00460095 FIG00460097: hypothetical protein +FIG00460098 FIG00460101: hypothetical protein +FIG00460107 FIG00460108: hypothetical protein +FIG00460108 FIG00460109: hypothetical protein +FIG00460109 FIG00460111: hypothetical protein +FIG00460122 FIG00460128: hypothetical protein +FIG00460130 FIG00460132: hypothetical protein +FIG00460133 FIG00460134: hypothetical protein +FIG00460135 FIG01006017: hypothetical protein +FIG00460136 FIG00460140: hypothetical protein +FIG00460140 FIG00460141: hypothetical protein +FIG00460142 FIG00460143: hypothetical protein +FIG00460143 FIG00460146: hypothetical protein +FIG00460149 FIG00460152: hypothetical protein +FIG00460152 FIG00460153: hypothetical protein +FIG00460153 FIG00460155: hypothetical protein +FIG00460155 FIG00460156: hypothetical protein +FIG00460156 FIG00460159: hypothetical protein +FIG00460163 FIG00460165: hypothetical protein +FIG00460165 FIG00460167: hypothetical protein +FIG00460173 FIG00460174: hypothetical protein +FIG00460175 FIG00460177: hypothetical protein +FIG00460177 FIG00460179: hypothetical protein +FIG00460179 FIG00460180: hypothetical protein +FIG00460182 FIG00460183: hypothetical protein +FIG00460186 FIG00460187: hypothetical protein +FIG00460187 FIG00460188: hypothetical protein +FIG00460188 FIG00460190: hypothetical protein +FIG00460190 FIG00460192: hypothetical protein +FIG00460192 Peptidase S1, chymotrypsin:PDZ/DHR/GLGF domain precursor +FIG00460195 FIG00460196: hypothetical protein +FIG00460196 FIG00460197: hypothetical protein +FIG00460197 FIG00460199: hypothetical protein +FIG00460199 FIG00460200: hypothetical protein +FIG00460212 FIG00460213: hypothetical protein +FIG00460213 UDP-N-acetylglucosamine:LPS N-acetylglucosamine transferase +FIG00460214 FIG00460217: hypothetical protein +FIG00460217 FIG00460218: hypothetical protein +FIG00460218 FIG00460220: hypothetical protein +FIG00460220 FIG00460222: hypothetical protein +FIG00460222 FIG00460223: hypothetical protein +FIG00460223 FIG00460225: hypothetical protein +FIG00460226 FIG00460227: hypothetical protein +FIG00460236 FIG00460237: hypothetical protein +FIG00460237 FIG00460238: hypothetical protein +FIG00460240 FIG00460241: hypothetical protein +FIG00460242 FIG00460243: hypothetical protein +FIG00460254 FIG00460256: hypothetical protein +FIG00460256 FIG00460257: hypothetical protein +FIG00460260 hypothetical protein +FIG00460264 FIG00460265: hypothetical protein +FIG00460265 FIG00460269: hypothetical protein +FIG00460270 FIG00460271: hypothetical protein +FIG00460271 FIG00460272: hypothetical protein +FIG00460275 FIG00460277: hypothetical protein +FIG00460279 FIG00460280: hypothetical protein +FIG00460280 FIG00460281: hypothetical protein +FIG00460284 FIG00460286: hypothetical protein +FIG00460288 FIG00460293: hypothetical protein +FIG00460293 FIG00460294: hypothetical protein +FIG00460296 FIG00460298: hypothetical protein +FIG00460298 FIG00460299: hypothetical protein +FIG00460299 FIG00460300: hypothetical protein +FIG00460300 FIG00460301: hypothetical protein +FIG00460302 FIG00460303: hypothetical protein +FIG00460303 FIG00460304: hypothetical protein +FIG00460305 FIG00460307: hypothetical protein +FIG00460307 FIG00460308: hypothetical protein +FIG00460309 FIG00460310: hypothetical protein +FIG00460311 FIG00460312: hypothetical protein +FIG00460312 FIG00460316: hypothetical protein +FIG00460316 FIG00460317: hypothetical protein +FIG00460317 FIG00460318: hypothetical protein +FIG00460323 FIG00460324: hypothetical protein +FIG00460328 FIG00460329: hypothetical protein +FIG00460329 FIG00460331: hypothetical protein +FIG00460331 FIG00460336: hypothetical protein +FIG00460336 FIG00460344: hypothetical protein +FIG00460344 FIG00460350: hypothetical protein +FIG00460352 FIG00460353: hypothetical protein +FIG00460353 Hydroxymethylpyrimidine ABC transporter, substrate-binding component +FIG00460354 Antifreeze glycopeptide AFGP polyprotein precursor +FIG00460356 FIG00460357: hypothetical protein +FIG00460363 FIG00460365: hypothetical protein +FIG00460370 FIG00460371: hypothetical protein +FIG00460371 FIG00460375: hypothetical protein +FIG00460375 FIG00460376: hypothetical protein +FIG00460376 FIG00460377: hypothetical protein +FIG00460392 FIG00460393: hypothetical protein +FIG00460398 flp pilus assembly protein secretin CpaC +FIG00460402 FIG00460403: hypothetical protein +FIG00460405 FIG00460407: hypothetical protein +FIG00460407 FIG00460408: hypothetical protein +FIG00460409 FIG00460410: hypothetical protein +FIG00460411 FIG00460413: hypothetical protein +FIG00460413 FIG00460416: hypothetical protein +FIG00460416 FIG00460418: hypothetical protein +FIG00460418 Oxidoreductase, short chain dehydrogenase/reductase family +FIG00460422 FIG00460423: hypothetical protein +FIG00460424 FIG00460426: hypothetical protein +FIG00460427 hypothetical protein +FIG00460429 FIG00460430: hypothetical protein +FIG00460430 FIG00460431: hypothetical protein +FIG00460433 FIG00460436: hypothetical protein +FIG00460437 FIG00460441: hypothetical protein +FIG00460441 FIG00460443: hypothetical protein +FIG00460445 FIG00460450: hypothetical protein +FIG00460450 FIG00460453: hypothetical protein +FIG00460453 FIG00460457: hypothetical protein +FIG00460457 hypothetical protein +FIG00460468 FIG00460469: hypothetical protein +FIG00460473 FIG00460474: hypothetical protein +FIG00460476 FIG00460479: hypothetical protein +FIG00460481 FIG00460482: hypothetical protein +FIG00460490 hypothetical protein +FIG00460491 FIG00460492: hypothetical protein +FIG00460492 FIG00460494: hypothetical protein +FIG00460494 Putative signal peptide transmembrane protein +FIG00460496 FIG00460497: hypothetical protein +FIG00460499 FIG00460500: hypothetical protein +FIG00460501 FIG00460502: hypothetical protein +FIG00460502 FIG00460503: hypothetical protein +FIG00460503 FIG00460506: hypothetical protein +FIG00460506 prophage CP4-57 regulatory protein (AlpA) +FIG00460507 FIG00460508: hypothetical protein +FIG00460510 FIG00460511: hypothetical protein +FIG00460516 FIG00460518: hypothetical protein +FIG00460520 FIG00460521: hypothetical protein +FIG00460521 FIG00460524: hypothetical protein +FIG00460525 FIG00460529: hypothetical protein +FIG00460529 FIG00460530: hypothetical protein +FIG00460532 FIG00460535: hypothetical protein +FIG00460539 FIG00460541: hypothetical protein +FIG00460541 FIG00460542: hypothetical protein +FIG00460543 FIG00460544: hypothetical protein +FIG00460546 FIG00460550: hypothetical protein +FIG00460550 FIG00460552: hypothetical protein +FIG00460552 FIG00460555: hypothetical protein +FIG00460555 FIG00460556: hypothetical protein +FIG00460556 UBA/THIF-type NAD/FAD binding fold +FIG00460561 FIG00460562: hypothetical protein +FIG00460562 FIG00460563: hypothetical protein +FIG00460572 FIG00460574: hypothetical protein +FIG00460580 FIG00460581: hypothetical protein +FIG00460582 FIG00460583: hypothetical protein +FIG00460583 FIG00460584: hypothetical protein +FIG00460584 hypothetical protein +FIG00460585 hypothetical protein +FIG00460588 FIG00460590: hypothetical protein +FIG00460590 FIG00460593: hypothetical protein +FIG00460593 2-polyprenylphenol hydroxylase and related flavodoxin oxidoreductases +FIG00460598 FIG00460602: hypothetical protein +FIG00460604 FIG00460607: hypothetical protein +FIG00460608 FIG00460609: hypothetical protein +FIG00460611 FIG00460612: hypothetical protein +FIG00460612 FIG00460613: hypothetical protein +FIG00460613 FIG00460616: hypothetical protein +FIG00460620 FIG00460622: hypothetical protein +FIG00460622 FIG00460623: hypothetical protein +FIG00460623 FIG00460628: hypothetical protein +FIG00460630 FIG00460632: hypothetical protein +FIG00460633 FIG00460634: hypothetical protein +FIG00460637 FIG00460639: hypothetical protein +FIG00460641 FIG00460643: hypothetical protein +FIG00460643 FIG00460644: hypothetical protein +FIG00460644 FIG00460645: hypothetical protein +FIG00460646 FIG00460648: hypothetical protein +FIG00460650 COG4773: Outer membrane receptor for ferric coprogen and ferric-rhodotorulic acid +FIG00460655 hypothetical protein +FIG00460656 FIG00460657: hypothetical protein +FIG00460657 FIG00460658: hypothetical protein +FIG00460661 FIG00460663: hypothetical protein +FIG00460663 FIG00460664: hypothetical protein +FIG00460664 FIG00460665: hypothetical protein +FIG00460671 FIG00460672: hypothetical protein +FIG00460674 FIG146805: Plasmid related protein +FIG00460676 FIG00460677: hypothetical protein +FIG00460677 FIG00460680: hypothetical protein +FIG00460689 FIG00460691: hypothetical protein +FIG00460691 FIG00460694: hypothetical protein +FIG00460707 FIG00460710: hypothetical protein +FIG00460710 FIG00460713: hypothetical protein +FIG00460713 FIG00460717: hypothetical protein +FIG00460717 FIG00460718: hypothetical protein +FIG00460718 FIG00460724: hypothetical protein +FIG00460724 FIG00460725: hypothetical protein +FIG00460725 FIG00453576: hypothetical protein +FIG00460728 2-hydroxymuconic semialdehyde hydrolase( EC:3.7.1.9 ) +FIG00460729 FIG00460733: hypothetical protein +FIG00460734 FIG00460736: hypothetical protein +FIG00460736 FIG00460742: hypothetical protein +FIG00460742 FIG00460743: hypothetical protein +FIG00460743 FIG00460745: hypothetical protein +FIG00460746 FIG00460747: hypothetical protein +FIG00460759 FIG00460761: hypothetical protein +FIG00460762 FIG00460764: hypothetical protein +FIG00460772 FIG00460773: hypothetical protein +FIG00460776 FIG00460777: hypothetical protein +FIG00460777 FIG00460778: hypothetical protein +FIG00460778 FIG00460780: hypothetical protein +FIG00460780 FIG00460781: hypothetical protein +FIG00460781 FIG00460782: hypothetical protein +FIG00460782 FIG00460785: hypothetical protein +FIG00460786 FIG00460790: hypothetical protein +FIG00460791 FIG00460792: hypothetical protein +FIG00460793 FIG00460795: hypothetical protein +FIG00460795 FIG00460797: hypothetical protein +FIG00460797 FIG00460798: hypothetical protein +FIG00460798 FIG00460803: hypothetical protein +FIG00460803 FIG00460804: hypothetical protein +FIG00460809 FIG00460810: hypothetical protein +FIG00460813 FIG00460817: hypothetical protein +FIG00460817 FIG00460818: hypothetical protein +FIG00460831 FIG00460834: hypothetical protein +FIG00460834 FIG00460835: hypothetical protein +FIG00460835 FIG00460836: hypothetical protein +FIG00460836 putative deoxygenase +FIG00460842 FIG00460847: hypothetical protein +FIG00460861 FIG00460863: hypothetical protein +FIG00460867 FIG00460868: hypothetical protein +FIG00460868 FIG00460870: hypothetical protein +FIG00460883 Tagatose-6-phosphate kinase (EC 2.7.1.144) / 1-phosphofructokinase (EC 2.7.1.56) +FIG00460890 FIG00460893: hypothetical protein +FIG00460898 FIG00460900: hypothetical protein +FIG00460900 FIG00460902: hypothetical protein +FIG00460908 FIG00460915: hypothetical protein +FIG00460917 FIG00460920: hypothetical protein +FIG00460920 FIG00460924: hypothetical protein +FIG00460924 FIG00460926: hypothetical protein +FIG00460926 FIG00460927: hypothetical protein +FIG00460927 FIG00460929: hypothetical protein +FIG00460929 FIG00460930: hypothetical protein +FIG00460941 FIG00460948: hypothetical protein +FIG00460948 FIG00460949: hypothetical protein +FIG00460949 FIG00460951: hypothetical protein +FIG00460966 FIG00460967: hypothetical protein +FIG00460967 FIG00460969: hypothetical protein +FIG00460969 FIG00460970: hypothetical protein +FIG00460980 FIG00460981: hypothetical protein +FIG00460981 FIG00460982: hypothetical protein +FIG00460983 FIG00460984: hypothetical protein +FIG00460986 FIG00460987: hypothetical protein +FIG00460987 FIG00460990: hypothetical protein +FIG00460991 FIG00460993: hypothetical protein +FIG00460995 FIG00460997: hypothetical protein +FIG00460997 FIG00461004: hypothetical protein +FIG00461008 FIG00461010: hypothetical protein +FIG00461010 FIG00461012: hypothetical protein +FIG00461012 FIG00461013: hypothetical protein +FIG00461016 FIG00461019: hypothetical protein +FIG00461019 FIG00461021: hypothetical protein +FIG00461021 FIG00461023: hypothetical protein +FIG00461030 FIG00461031: hypothetical protein +FIG00461031 FIG00461033: hypothetical protein +FIG00461033 COG1172: Ribose/xylose/arabinose/galactoside ABC-type transport systems, permease components +FIG00461040 FIG00461042: hypothetical protein +FIG00461042 FIG00461046: hypothetical protein +FIG00461046 Exonuclease (EC 3.1.11.3) +FIG00461054 FIG00461055: hypothetical protein +FIG00461055 FIG00461056: hypothetical protein +FIG00461056 FIG00461057: hypothetical protein +FIG00461058 FIG00461060: hypothetical protein +FIG00461060 FIG00461062: hypothetical protein +FIG00461062 FIG00461063: hypothetical protein +FIG00461064 FIG00461065: hypothetical protein +FIG00461065 FIG00461066: hypothetical protein +FIG00461067 FIG00461068: hypothetical protein +FIG00461068 FIG00461071: hypothetical protein +FIG00461072 FIG00461073: hypothetical protein +FIG00461073 FIG00461077: hypothetical protein +FIG00461078 FIG00461079: hypothetical protein +FIG00461088 FIG00461089: hypothetical protein +FIG00461090 FIG00461091: hypothetical protein +FIG00461100 hypothetical protein +FIG00461102 FIG00461106: hypothetical protein +FIG00461106 FIG00461107: hypothetical protein +FIG00461107 Thiolase:Thiolase +FIG00461110 FIG00461112: hypothetical protein +FIG00461122 FIG00461124: hypothetical protein +FIG00461125 FIG00461131: hypothetical protein +FIG00461131 FIG00461133: hypothetical protein +FIG00461134 FIG00461135: hypothetical protein +FIG00461137 FIG00461140: hypothetical protein +FIG00461147 FIG00461150: hypothetical protein +FIG00461158 FIG00461159: hypothetical protein +FIG00461171 FIG00461174: hypothetical protein +FIG00461175 FIG00461176: hypothetical protein +FIG00461188 FIG00461189: hypothetical protein +FIG00461189 FIG00461190: hypothetical protein +FIG00461190 FIG00461191: hypothetical protein +FIG00461193 FIG00461195: hypothetical protein +FIG00461195 FIG00461198: hypothetical protein +FIG00461198 FIG00461199: hypothetical protein +FIG00461203 FIG00461205: hypothetical protein +FIG00461208 FIG00461209: hypothetical protein +FIG00461212 FIG00461217: hypothetical protein +FIG00461217 FIG00461223: hypothetical protein +FIG00461223 FIG00461226: hypothetical protein +FIG00461226 FIG00461227: hypothetical protein +FIG00461227 FIG00461228: hypothetical protein +FIG00461228 FIG00461230: hypothetical protein +FIG00461230 FIG00461233: hypothetical protein +FIG00461234 FIG00461236: hypothetical protein +FIG00461236 FIG00461241: hypothetical protein +FIG00461248 FIG00461252: hypothetical protein +FIG00461254 FIG00461256: hypothetical protein +FIG00461257 FIG00461258: hypothetical protein +FIG00461260 FIG00461261: hypothetical protein +FIG00461261 FIG00461265: hypothetical protein +FIG00461268 FIG00461270: hypothetical protein +FIG00461270 FIG00461271: hypothetical protein +FIG00461271 FIG00461272: hypothetical protein +FIG00461273 FIG00461274: hypothetical protein +FIG00461275 FIG00461278: hypothetical protein +FIG00461278 FIG00461279: hypothetical protein +FIG00461279 FIG00461280: hypothetical protein +FIG00461280 FIG00461284: hypothetical protein +FIG00461284 FIG00461288: hypothetical protein +FIG00461288 FIG00461289: hypothetical protein +FIG00461289 FIG00461291: hypothetical protein +FIG00461295 FIG00461296: hypothetical protein +FIG00461296 FIG00461298: hypothetical protein +FIG00461298 FIG00461301: hypothetical protein +FIG00461303 FIG00461307: hypothetical protein +FIG00461307 FIG00461308: hypothetical protein +FIG00461308 FIG00461312: hypothetical protein +FIG00461312 FIG00461316: hypothetical protein +FIG00461319 FIG00461320: hypothetical protein +FIG00461320 FIG00461321: hypothetical protein +FIG00461325 FIG00461326: hypothetical protein +FIG00461329 FIG00461332: hypothetical protein +FIG00461340 FIG00461342: hypothetical protein +FIG00461342 FIG00461343: hypothetical protein +FIG00461350 FIG00461351: hypothetical protein +FIG00461352 FIG00461353: hypothetical protein +FIG00461354 FIG00461355: hypothetical protein +FIG00461360 FIG00461361: hypothetical protein +FIG00461363 FIG00461365: hypothetical protein +FIG00461365 FIG00461369: hypothetical protein +FIG00461369 FIG00461371: hypothetical protein +FIG00461375 FIG00461378: hypothetical protein +FIG00461378 FIG00461380: hypothetical protein +FIG00461391 FIG00461393: hypothetical protein +FIG00461393 FIG00461394: hypothetical protein +FIG00461395 FIG00461396: hypothetical protein +FIG00461400 FIG00461401: hypothetical protein +FIG00461411 FIG00461412: hypothetical protein +FIG00461418 FIG00461420: hypothetical protein +FIG00461426 FIG00461427: hypothetical protein +FIG00461427 FIG00461430: hypothetical protein +FIG00461431 FIG00461432: hypothetical protein +FIG00461432 FIG00461433: hypothetical protein +FIG00461447 FIG00461448: hypothetical protein +FIG00461448 FIG00461450: hypothetical protein +FIG00461450 FIG00461453: hypothetical protein +FIG00461455 FIG00461456: hypothetical protein +FIG00461459 FIG00461460: hypothetical protein +FIG00461460 FIG00461464: hypothetical protein +FIG00461465 FIG00461467: hypothetical protein +FIG00461467 FIG00461468: hypothetical protein +FIG00461468 FIG00461469: hypothetical protein +FIG00461477 FIG00461478: hypothetical protein +FIG00461497 FIG00461500: hypothetical protein +FIG00461506 FIG00461507: hypothetical protein +FIG00461509 SyrP-like protein +FIG00461510 FIG00461514: hypothetical protein +FIG00461520 FIG00461521: hypothetical protein +FIG00461521 FIG00461523: hypothetical protein +FIG00461526 FIG00461527: hypothetical protein +FIG00461527 FIG00461530: hypothetical protein +FIG00461530 FIG00461532: hypothetical protein +FIG00461532 FIG00461533: hypothetical protein +FIG00461533 FIG00461537: hypothetical protein +FIG00461542 FIG00461543: hypothetical protein +FIG00461544 FIG00461545: hypothetical protein +FIG00461546 FIG00461548: hypothetical protein +FIG00461548 FIG00461549: hypothetical protein +FIG00461549 FIG00461550: hypothetical protein +FIG00461557 FIG00461559: hypothetical protein +FIG00461559 FIG00461561: hypothetical protein +FIG00461567 FIG00461568: hypothetical protein +FIG00461568 hypothetical protein +FIG00461571 FIG00461572: hypothetical protein +FIG00461573 FIG00461576: hypothetical protein +FIG00461576 FIG00461578: hypothetical protein +FIG00461578 amidase +FIG00461592 hypothetical protein +FIG00461597 FIG00461598: hypothetical protein +FIG00461600 FIG00461602: hypothetical protein +FIG00461602 FIG00461609: hypothetical protein +FIG00461610 FIG00461614: hypothetical protein +FIG00461614 Arsenate reductase (Azurin) (EC 1.20.98.1) +FIG00461615 FIG00461619: hypothetical protein +FIG00461625 FIG00461626: hypothetical protein +FIG00461627 FIG00461631: hypothetical protein +FIG00461631 FIG00461635: hypothetical protein +FIG00461637 FIG00461639: hypothetical protein +FIG00461639 FIG00461641: hypothetical protein +FIG00461649 FIG00461650: hypothetical protein +FIG00461652 Major facilitator superfamily (MFS) metabolite/H+ symporter +FIG00461654 FIG00461656: hypothetical protein +FIG00461661 FIG00461662: hypothetical protein +FIG00461662 FIG00461665: hypothetical protein +FIG00461680 FIG00461681: hypothetical protein +FIG00461681 FIG00461683: hypothetical protein +FIG00461690 FIG00461692: hypothetical protein +FIG00461695 FIG00461698: hypothetical protein +FIG00461698 FIG00461699: hypothetical protein +FIG00461708 FIG00461710: hypothetical protein +FIG00461716 FIG00461718: hypothetical protein +FIG00461724 FIG00461727: hypothetical protein +FIG00461727 FIG00461728: hypothetical protein +FIG00461728 FIG00461729: hypothetical protein +FIG00461739 FIG00461740: hypothetical protein +FIG00461740 FIG00461741: hypothetical protein +FIG00461741 FIG00461742: hypothetical protein +FIG00461742 FIG00461743: hypothetical protein +FIG00461743 FIG00461748: hypothetical protein +FIG00461749 FIG00461750: hypothetical protein +FIG00461760 hypothetical protein +FIG00461765 FIG00461769: hypothetical protein +FIG00461774 FIG00461775: hypothetical protein +FIG00461777 FIG00461779: hypothetical protein +FIG00461785 FIG00461786: hypothetical protein +FIG00461791 Ferredoxin:4Fe-4S ferredoxin, iron-sulfur binding +FIG00461798 FIG00461800: hypothetical protein +FIG00461800 FIG00461801: hypothetical protein +FIG00461807 FIG00461813: hypothetical protein +FIG00461813 NAD(P)H dehydrogenase (quinone) +FIG00461820 FIG00461824: hypothetical protein +FIG00461827 FIG00461829: hypothetical protein +FIG00461829 FIG00461830: hypothetical protein +FIG00461838 FIG00461844: hypothetical protein +FIG00461846 FIG00461847: hypothetical protein +FIG00461847 FIG00461849: hypothetical protein +FIG00461851 FIG00461852: hypothetical protein +FIG00461852 FIG00461853: hypothetical protein +FIG00461858 FIG00461860: hypothetical protein +FIG00461860 FIG00461861: hypothetical protein +FIG00461862 FIG00461863: hypothetical protein +FIG00461865 FIG00461868: hypothetical protein +FIG00461869 FIG00461870: hypothetical protein +FIG00461873 FIG00461874: hypothetical protein +FIG00461874 FIG00461875: hypothetical protein +FIG00461878 FIG00461880: hypothetical protein +FIG00461880 FIG00461881: hypothetical protein +FIG00461882 FIG00461883: hypothetical protein +FIG00461891 FIG00461894: hypothetical protein +FIG00461897 FIG00461898: hypothetical protein +FIG00461898 FIG00461899: hypothetical protein +FIG00461901 FIG00461903: hypothetical protein +FIG00461903 FIG00461904: hypothetical protein +FIG00461904 FIG00461905: hypothetical protein +FIG00461905 FIG00461906: hypothetical protein +FIG00461915 FIG00461917: hypothetical protein +FIG00461918 FIG00461922: hypothetical protein +FIG00461922 FIG00461923: hypothetical protein +FIG00461928 FIG00461931: hypothetical protein +FIG00461931 FIG00461932: hypothetical protein +FIG00461935 FIG00461937: hypothetical protein +FIG00461940 FIG00461942: hypothetical protein +FIG00461948 FIG00461950: hypothetical protein +FIG00461950 FIG00461951: hypothetical protein +FIG00461951 FIG00461958: hypothetical protein +FIG00461961 FIG00461962: hypothetical protein +FIG00461962 FIG00461963: hypothetical protein +FIG00461966 FIG00461967: hypothetical protein +FIG00461967 FIG00461974: hypothetical protein +FIG00461982 FIG00461985: hypothetical protein +FIG00461985 FIG00461991: hypothetical protein +FIG00462005 FIG00462006: hypothetical protein +FIG00462006 FIG00462013: hypothetical protein +FIG00462014 FIG00462017: hypothetical protein +FIG00462017 FIG00462019: hypothetical protein +FIG00462021 FIG00462023: hypothetical protein +FIG00462023 FIG00462026: hypothetical protein +FIG00462027 FIG00462029: hypothetical protein +FIG00462029 FIG00462030: hypothetical protein +FIG00462031 FIG00462033: hypothetical protein +FIG00462033 FIG00462036: hypothetical protein +FIG00462036 FIG00462039: hypothetical protein +FIG00462041 FIG00462042: hypothetical protein +FIG00462042 FIG00462043: hypothetical protein +FIG00462043 FIG00462052: hypothetical protein +FIG00462063 FIG00462064: hypothetical protein +FIG00462064 FIG00462065: hypothetical protein +FIG00462066 FIG00462069: hypothetical protein +FIG00462070 FIG00462077: hypothetical protein +FIG00462077 FIG00462080: hypothetical protein +FIG00462089 FIG00462091: hypothetical protein +FIG00462099 FIG00462100: hypothetical protein +FIG00462104 FIG00462110: hypothetical protein +FIG00462116 hypothetical protein +FIG00462118 FIG00462120: hypothetical protein +FIG00462120 FIG00462121: hypothetical protein +FIG00462127 FIG00462130: hypothetical protein +FIG00462130 FIG00462132: hypothetical protein +FIG00462132 FIG00462133: hypothetical protein +FIG00462136 FIG00462141: hypothetical protein +FIG00462141 FIG00462142: hypothetical protein +FIG00462145 FIG00462146: hypothetical protein +FIG00462148 FIG00462157: hypothetical protein +FIG00462157 FIG00462158: hypothetical protein +FIG00462160 FIG00462161: hypothetical protein +FIG00462163 FIG00462164: hypothetical protein +FIG00462168 FIG00462169: hypothetical protein +FIG00462169 FIG00462171: hypothetical protein +FIG00462171 FIG00462172: hypothetical protein +FIG00462172 FIG00462173: hypothetical protein +FIG00462174 FIG00462177: hypothetical protein +FIG00462180 FIG00462182: hypothetical protein +FIG00462183 FIG00462185: hypothetical protein +FIG00462186 FIG00462187: hypothetical protein +FIG00462193 FIG00462194: hypothetical protein +FIG00462195 FIG00462196: hypothetical protein +FIG00462197 FIG00462198: hypothetical protein +FIG00462201 D-tagatose 3-epimerase (EC 5.3.1.-) +FIG00462203 FIG00462207: hypothetical protein +FIG00462210 Mlr3463 protein +FIG00462219 FIG00462220: hypothetical protein +FIG00462220 FIG00462221: hypothetical protein +FIG00462221 FIG00462223: hypothetical protein +FIG00462229 FIG00462230: hypothetical protein +FIG00462230 Uncharacterized protein, homolog of Cu resistance protein CopC +FIG00462233 FIG00462234: hypothetical protein +FIG00462234 FIG00462235: hypothetical protein +FIG00462236 FIG00462239: hypothetical protein +FIG00462239 FIG00462242: hypothetical protein +FIG00462243 FIG00462247: hypothetical protein +FIG00462247 FIG00462249: hypothetical protein +FIG00462249 FIG00462250: hypothetical protein +FIG00462250 FIG00462252: hypothetical protein +FIG00462257 FIG00462261: hypothetical protein +FIG00462262 FIG00462263: hypothetical protein +FIG00462263 FIG00462264: hypothetical protein +FIG00462266 FIG00462270: hypothetical protein +FIG00462271 FIG00462272: hypothetical protein +FIG00462272 FIG00462274: hypothetical protein +FIG00462276 FIG00462279: hypothetical protein +FIG00462280 FIG00462282: hypothetical protein +FIG00462282 FIG00462283: hypothetical protein +FIG00462283 FIG00462286: hypothetical protein +FIG00462286 FIG00462288: hypothetical protein +FIG00462288 FIG00462290: hypothetical protein +FIG00462300 FIG00462301: hypothetical protein +FIG00462301 FIG00462304: hypothetical protein +FIG00462304 FIG00462308: hypothetical protein +FIG00462308 FIG00462311: hypothetical protein +FIG00462327 FIG00462328: hypothetical protein +FIG00462328 FIG00462332: hypothetical protein +FIG00462332 FIG00462333: hypothetical protein +FIG00462333 FIG00462334: hypothetical protein +FIG00462335 FIG00462336: hypothetical protein +FIG00462342 FIG00462343: hypothetical protein +FIG00462343 FIG00462347: hypothetical protein +FIG00462347 FIG00462348: hypothetical protein +FIG00462348 FIG00462349: hypothetical protein +FIG00462353 FIG00462355: hypothetical protein +FIG00462355 FIG00462357: hypothetical protein +FIG00462369 FIG00462371: hypothetical protein +FIG00462371 Phasin +FIG00462375 FIG00462377: hypothetical protein +FIG00462404 FIG00462407: hypothetical protein +FIG00462411 FIG00462412: hypothetical protein +FIG00462424 FIG00462426: hypothetical protein +FIG00462426 FIG00462429: hypothetical protein +FIG00462429 FIG00462431: hypothetical protein +FIG00462431 FIG00462440: hypothetical protein +FIG00462444 FIG00462445: hypothetical protein +FIG00462445 FIG00462446: hypothetical protein +FIG00462448 FIG00462451: hypothetical protein +FIG00462452 FIG00462454: hypothetical protein +FIG00462455 FIG00462458: hypothetical protein +FIG00462460 FIG00462461: hypothetical protein +FIG00462463 FIG00462467: hypothetical protein +FIG00462467 FIG00462469: hypothetical protein +FIG00462477 FIG00462478: hypothetical protein +FIG00462489 FIG00462491: hypothetical protein +FIG00462495 FIG00462497: hypothetical protein +FIG00462500 FIG00462502: hypothetical protein +FIG00462508 FIG00462516: hypothetical protein +FIG00462516 FIG00462522: hypothetical protein +FIG00462522 FIG00462526: hypothetical protein +FIG00462531 Galactose oxidase-related protein +FIG00462533 FIG00462535: hypothetical protein +FIG00462542 FIG00462544: hypothetical protein +FIG00462569 FIG00462572: hypothetical protein +FIG00462575 FIG00462576: hypothetical protein +FIG00462588 FIG00462590: hypothetical protein +FIG00462590 FIG00462593: hypothetical protein +FIG00462606 FIG00462608: hypothetical protein +FIG00462611 FIG00462612: hypothetical protein +FIG00462612 FIG00462614: hypothetical protein +FIG00462616 aminotransferase class-III +FIG00462617 FIG00462619: hypothetical protein +FIG00462628 FIG00462629: hypothetical protein +FIG00462629 FIG00462631: hypothetical protein +FIG00462631 FIG00462633: hypothetical protein +FIG00462634 FIG00462635: hypothetical protein +FIG00462635 FIG00462636: hypothetical protein +FIG00462638 FIG00462639: hypothetical protein +FIG00462639 FIG00462641: hypothetical protein +FIG00462641 FIG00462642: hypothetical protein +FIG00462642 FIG00462644: hypothetical protein +FIG00462645 FIG00462646: hypothetical protein +FIG00462646 FIG00462647: hypothetical protein +FIG00462653 FIG00462656: hypothetical protein +FIG00462657 FIG00462658: hypothetical protein +FIG00462659 FIG00462660: hypothetical protein +FIG00462662 FIG00462664: hypothetical protein +FIG00462664 FIG00462665: hypothetical protein +FIG00462665 FIG00462666: hypothetical protein +FIG00462666 FIG00462667: hypothetical protein +FIG00462669 FIG00462670: hypothetical protein +FIG00462675 FIG00462680: hypothetical protein +FIG00462682 Putative periplasmic substrate-binding transport protein +FIG00462691 FIG00462694: hypothetical protein +FIG00462694 FIG00462698: hypothetical protein +FIG00462698 hypothetical protein +FIG00462714 FIG00462715: hypothetical protein +FIG00462720 FIG00462726: hypothetical protein +FIG00462726 FIG00462727: hypothetical protein +FIG00462727 FIG00462729: hypothetical protein +FIG00462729 FIG00462732: hypothetical protein +FIG00462733 FIG00462734: hypothetical protein +FIG00462734 FIG00462735: hypothetical protein +FIG00462735 FIG00462738: hypothetical protein +FIG00462750 FIG00462751: hypothetical protein +FIG00462754 FIG00462755: hypothetical protein +FIG00462768 FIG00462769: hypothetical protein +FIG00462769 FIG00462770: hypothetical protein +FIG00462770 FIG00462771: hypothetical protein +FIG00462771 sodium/sulphate symporter +FIG00462772 FIG00462774: hypothetical protein +FIG00462783 Two component transcriptional regulator, winged helix family precursor +FIG00462784 FIG00462785: hypothetical protein +FIG00462786 FIG00462791: hypothetical protein +FIG00462805 Major fimbrial subunit precursor +FIG00462806 FIG00462809: hypothetical protein +FIG00462811 FIG00462812: hypothetical protein +FIG00462824 FIG00462825: hypothetical protein +FIG00462825 FIG00462827: hypothetical protein +FIG00462827 FIG00462828: hypothetical protein +FIG00462830 FIG00462831: hypothetical protein +FIG00462844 FIG00462845: hypothetical protein +FIG00462845 FIG00462846: hypothetical protein +FIG00462846 FIG00462847: hypothetical protein +FIG00462847 FIG00462849: hypothetical protein +FIG00462849 FIG00462851: hypothetical protein +FIG00462853 FIG00462854: hypothetical protein +FIG00462861 FIG00462862: hypothetical protein +FIG00462865 FIG00462866: hypothetical protein +FIG00462874 FIG00462877: hypothetical protein +FIG00462877 FIG00462878: hypothetical protein +FIG00462878 FIG00462882: hypothetical protein +FIG00462882 hypothetical protein +FIG00462885 FIG00462887: hypothetical protein +FIG00462893 FIG00462895: hypothetical protein +FIG00462895 FIG00462896: hypothetical protein +FIG00462896 FIG00462897: hypothetical protein +FIG00462915 FIG00462916: hypothetical protein +FIG00462916 FIG00462917: hypothetical protein +FIG00462917 FIG00462919: hypothetical protein +FIG00462919 probable GstR transcriptional regulator +FIG00462920 FIG00462931: hypothetical protein +FIG00462938 FIG00462939: hypothetical protein +FIG00462943 Terminase +FIG00462948 FIG00462949: hypothetical protein +FIG00462949 FIG00462950: hypothetical protein +FIG00462952 Uncharacterized protein with a C-terminal OMP (outer membrane protein) domain +FIG00462956 FIG00462958: hypothetical protein +FIG00462974 FIG00462976: hypothetical protein +FIG00462976 FIG00462982: hypothetical protein +FIG00462987 FIG00462989: hypothetical protein +FIG00462989 FIG00462993: hypothetical protein +FIG00462998 FIG00462999: hypothetical protein +FIG00463000 FIG00463001: hypothetical protein +FIG00463001 FIG00463002: hypothetical protein +FIG00463007 FIG00463010: hypothetical protein +FIG00463012 FIG00463013: hypothetical protein +FIG00463013 FIG00463014: hypothetical protein +FIG00463020 FIG00463021: hypothetical protein +FIG00463023 FIG00463193: hypothetical protein +FIG00463030 hypothetical protein +FIG00463033 FIG00463034: hypothetical protein +FIG00463042 FIG00463046: hypothetical protein +FIG00463048 FIG00463050: hypothetical protein +FIG00463051 FIG00463055: hypothetical protein +FIG00463055 FIG00463058: hypothetical protein +FIG00463059 FIG00463062: hypothetical protein +FIG00463062 ABC transporter binding protein +FIG00463064 FIG00463065: hypothetical protein +FIG00463065 FIG00463066: hypothetical protein +FIG00463076 FIG00463077: hypothetical protein +FIG00463083 ABC transporter, substrate binding protein [glutamine] +FIG00463102 FIG00463106: hypothetical protein +FIG00463112 Repressor homolog +FIG00463119 FIG00463120: hypothetical protein +FIG00463120 FIG00463121: hypothetical protein +FIG00463124 FIG00463125: hypothetical protein +FIG00463141 FIG00463142: hypothetical protein +FIG00463146 FIG00463151: hypothetical protein +FIG00463151 FIG00463152: hypothetical protein +FIG00463159 FIG00463163: hypothetical protein +FIG00463163 FIG00463164: hypothetical protein +FIG00463165 FIG00463166: hypothetical protein +FIG00463166 FIG00463167: hypothetical protein +FIG00463167 FIG00463173: hypothetical protein +FIG00463178 FIG00463183: hypothetical protein +FIG00463184 FIG00463185: hypothetical protein +FIG00463185 FIG00463186: hypothetical protein +FIG00463186 FIG00463188: hypothetical protein +FIG00463188 FIG00463189: hypothetical protein +FIG00463190 FIG00463191: hypothetical protein +FIG00463201 FIG00463202: hypothetical protein +FIG00463202 FIG00463203: hypothetical protein +FIG00463204 FIG00463206: hypothetical protein +FIG00463212 FIG00463219: hypothetical protein +FIG00463219 FIG00463223: hypothetical protein +FIG00463223 FIG00463225: hypothetical protein +FIG00463226 FIG00463227: hypothetical protein +FIG00463227 FIG00463231: hypothetical protein +FIG00463231 FIG00463232: hypothetical protein +FIG00463232 Dehydratase, IlvD/Edd family +FIG00463233 FIG00463234: hypothetical protein +FIG00463234 FIG00463238: hypothetical protein +FIG00463238 FIG00463242: hypothetical protein +FIG00463244 FIG00463247: hypothetical protein +FIG00463250 FIG00463251: hypothetical protein +FIG00463251 FIG00463252: hypothetical protein +FIG00463272 FIG00463274: hypothetical protein +FIG00463281 putative chloride channel +FIG00463282 FIG00463285: hypothetical protein +FIG00463285 FIG00463289: hypothetical protein +FIG00463293 FIG00463294: hypothetical protein +FIG00463298 FIG00463299: hypothetical protein +FIG00463302 FIG00463304: hypothetical protein +FIG00463310 FIG00463311: hypothetical protein +FIG00463335 FIG00463338: hypothetical protein +FIG00463338 FIG00463339: hypothetical protein +FIG00463339 ABC polar amino acid family transporter, ATPase subunit +FIG00463341 FIG00463343: hypothetical protein +FIG00463345 FIG00463346: hypothetical protein +FIG00463347 FIG00463348: hypothetical protein +FIG00463348 FIG00463349: hypothetical protein +FIG00463356 FIG00463358: hypothetical protein +FIG00463360 FIG00463362: hypothetical protein +FIG00463367 FIG00463372: hypothetical protein +FIG00463375 FIG00463376: hypothetical protein +FIG00463379 FIG00463380: hypothetical protein +FIG00463383 FIG00463384: hypothetical protein +FIG00463384 FIG00463389: hypothetical protein +FIG00463389 FIG00463390: hypothetical protein +FIG00463390 FIG00463391: hypothetical protein +FIG00463391 FIG00463402: hypothetical protein +FIG00463404 FIG00463409: hypothetical protein +FIG00463421 Outer membrane porin protein +FIG00463424 FIG00463429: hypothetical protein +FIG00463433 FIG00463434: hypothetical protein +FIG00463434 FIG00463436: hypothetical protein +FIG00463440 FIG00463445: hypothetical protein +FIG00463445 FIG00463449: hypothetical protein +FIG00463449 FIG00463450: hypothetical protein +FIG00463451 FIG00463452: hypothetical protein +FIG00463452 Putative symporter yjcG +FIG00463471 FIG00463472: hypothetical protein +FIG00463472 FIG00463476: hypothetical protein +FIG00463481 FIG00463482: hypothetical protein +FIG00463485 FIG00463487: hypothetical protein +FIG00463492 FIG00463496: hypothetical protein +FIG00463502 FIG00463508: hypothetical protein +FIG00463508 FIG00463509: hypothetical protein +FIG00463511 FIG00463515: hypothetical protein +FIG00463526 FIG00463529: hypothetical protein +FIG00463533 FIG00463536: hypothetical protein +FIG00463540 FIG00463541: hypothetical protein +FIG00463541 FIG00463542: hypothetical protein +FIG00463546 FIG00463551: hypothetical protein +FIG00463552 FIG00463553: hypothetical protein +FIG00463553 FIG00463558: hypothetical protein +FIG00463558 FIG00463559: hypothetical protein +FIG00463561 FIG00463563: hypothetical protein +FIG00463565 FIG00463566: hypothetical protein +FIG00463566 Predicted N-Acetyl-D-galactosamine oligosaccharide permease +FIG00463570 FIG00463571: hypothetical protein +FIG00463574 FIG00463576: hypothetical protein +FIG00463578 FIG00463580: hypothetical protein +FIG00463589 FIG00463591: hypothetical protein +FIG00463591 FIG00463592: hypothetical protein +FIG00463592 FIG00463595: hypothetical protein +FIG00463595 FIG00463596: hypothetical protein +FIG00463596 FIG00463598: hypothetical protein +FIG00463599 FIG00463602: hypothetical protein +FIG00463611 FIG00463615: hypothetical protein +FIG00463617 FIG00463618: hypothetical protein +FIG00463625 FIG00463626: hypothetical protein +FIG00463626 FIG00463628: hypothetical protein +FIG00463629 FIG00463633: hypothetical protein +FIG00463633 FIG00463639: hypothetical protein +FIG00463639 Phospholipase C( EC:3.1.4.3 ) +FIG00463652 FIG00463653: hypothetical protein +FIG00463653 FIG00463658: hypothetical protein +FIG00463658 FIG00463661: hypothetical protein +FIG00463663 FIG00463664: hypothetical protein +FIG00463664 FIG00463665: hypothetical protein +FIG00463668 FIG00463669: hypothetical protein +FIG00463673 FIG00463674: hypothetical protein +FIG00463686 Lrp-like regulator +FIG00463689 FIG00463690: hypothetical protein +FIG00463690 FIG00463697: hypothetical protein +FIG00463700 FIG00463701: hypothetical protein +FIG00463705 FIG00463706: hypothetical protein +FIG00463710 FIG00463711: hypothetical protein +FIG00463720 FIG00463726: hypothetical protein +FIG00463731 FIG00463732: hypothetical protein +FIG00463732 FIG00463733: hypothetical protein +FIG00463733 FIG00463738: hypothetical protein +FIG00463740 FIG00463742: hypothetical protein +FIG00463743 FIG00463744: hypothetical protein +FIG00463744 FIG00463746: hypothetical protein +FIG00463755 FIG00463756: hypothetical protein +FIG00463769 FIG00463774: hypothetical protein +FIG00463774 FIG00463775: hypothetical protein +FIG00463775 FIG00463780: hypothetical protein +FIG00463780 FIG00463782: hypothetical protein +FIG00463783 FIG00463786: hypothetical protein +FIG00463793 FIG00463794: hypothetical protein +FIG00463800 FIG00463802: hypothetical protein +FIG00463805 FIG00463807: hypothetical protein +FIG00463807 FIG00463808: hypothetical protein +FIG00463808 FIG00463810: hypothetical protein +FIG00463812 FIG00463813: hypothetical protein +FIG00463813 FIG00463815: hypothetical protein +FIG00463817 FIG00463818: hypothetical protein +FIG00463824 FIG00463826: hypothetical protein +FIG00463828 FIG00463829: hypothetical protein +FIG00463834 NADH:flavin oxidoreductase/NADH oxidase family protein +FIG00463835 FIG00463839: hypothetical protein +FIG00463841 FIG00463844: hypothetical protein +FIG00463871 FIG00463872: hypothetical protein +FIG00463872 FIG00463875: hypothetical protein +FIG00463887 FIG00463888: hypothetical protein +FIG00463888 FIG00463889: hypothetical protein +FIG00463889 FIG00463890: hypothetical protein +FIG00463894 FIG00463896: hypothetical protein +FIG00463899 FIG00463900: hypothetical protein +FIG00463900 FIG00463902: hypothetical protein +FIG00463909 FIG00463911: hypothetical protein +FIG00463911 FIG00463912: hypothetical protein +FIG00463912 FIG00463913: hypothetical protein +FIG00463916 FIG00463919: hypothetical protein +FIG00463919 FIG00463920: hypothetical protein +FIG00463920 FIG00463926: hypothetical protein +FIG00463932 FIG00463938: hypothetical protein +FIG00463940 FIG00463945: hypothetical protein +FIG00463945 FIG00463946: hypothetical protein +FIG00463946 FIG00463947: hypothetical protein +FIG00463953 FIG00463954: hypothetical protein +FIG00463957 FIG00463959: hypothetical protein +FIG00463963 FIG00463964: hypothetical protein +FIG00463966 FIG00463968: hypothetical protein +FIG00463968 FIG00463970: hypothetical protein +FIG00463973 FIG00463979: hypothetical protein +FIG00463979 FIG00463981: hypothetical protein +FIG00463981 FIG00463982: hypothetical protein +FIG00463982 FIG00463984: hypothetical protein +FIG00464002 FIG00464003: hypothetical protein +FIG00464003 FIG00464005: hypothetical protein +FIG00464013 FIG00983866: hypothetical protein +FIG00464032 FIG00464034: hypothetical protein +FIG00464039 FIG00464041: hypothetical protein +FIG00464041 FIG00464043: hypothetical protein +FIG00464053 FIG00464059: hypothetical protein +FIG00464060 FIG00464064: hypothetical protein +FIG00464071 FIG00464072: hypothetical protein +FIG00464072 FIG00464076: hypothetical protein +FIG00464076 FIG00464077: hypothetical protein +FIG00464080 FIG00464084: hypothetical protein +FIG00464085 FIG00464087: hypothetical protein +FIG00464091 FIG00464097: hypothetical protein +FIG00464106 Putative non-ribosomal peptide synthetase +FIG00464107 FIG00464108: hypothetical protein +FIG00464113 FIG00464118: hypothetical protein +FIG00464119 FIG00464122: hypothetical protein +FIG00464135 FIG00464136: hypothetical protein +FIG00464137 FIG00464138: hypothetical protein +FIG00464146 FIG00464148: hypothetical protein +FIG00464149 FIG00464150: hypothetical protein +FIG00464150 FIG00464151: hypothetical protein +FIG00464151 FIG00464152: hypothetical protein +FIG00464168 Low-affinity zinc transport protein +FIG00464180 FIG00464182: hypothetical protein +FIG00464184 FIG00453908: hypothetical protein +FIG00464192 FIG00464193: hypothetical protein +FIG00464193 FIG00464195: hypothetical protein +FIG00464208 FIG00464213: hypothetical protein +FIG00464218 FIG00464222: hypothetical protein +FIG00464231 FIG00464234: hypothetical protein +FIG00464234 FIG00464237: hypothetical protein +FIG00464242 FIG00464243: hypothetical protein +FIG00464246 FIG00464248: hypothetical protein +FIG00464253 Acetyltransferase (isoleucine patch superfamily)-like +FIG00464257 FIG00464259: hypothetical protein +FIG00464262 FIG00464263: hypothetical protein +FIG00464264 FIG00464265: hypothetical protein +FIG00464270 FIG00464271: hypothetical protein +FIG00464271 FIG00464272: hypothetical protein +FIG00464284 Squalene synthase (EC 2.5.1.21) +FIG00464285 hypothetical protein +FIG00464287 FIG00464289: hypothetical protein +FIG00464289 Ceramide glucosyltransferase (EC 2.4.1.80) +FIG00464297 FIG00464299: hypothetical protein +FIG00464300 FIG00464306: hypothetical protein +FIG00464313 FIG00464314: hypothetical protein +FIG00464314 FIG00464316: hypothetical protein +FIG00464324 FIG00464327: hypothetical protein +FIG00464327 FIG00464329: hypothetical protein +FIG00464336 FIG00464337: hypothetical protein +FIG00464338 FIG00464340: hypothetical protein +FIG00464340 FIG00464343: hypothetical protein +FIG00464345 FIG00464347: hypothetical protein +FIG00464347 FIG00464349: hypothetical protein +FIG00464357 FIG00464358: hypothetical protein +FIG00464359 FIG00464362: hypothetical protein +FIG00464368 FIG00464369: hypothetical protein +FIG00464374 FIG00464375: hypothetical protein +FIG00464375 FIG00464377: hypothetical protein +FIG00464377 FIG00464378: hypothetical protein +FIG00464378 FIG00464381: hypothetical protein +FIG00464382 BcepNY3gp60 +FIG00464386 FIG00464390: hypothetical protein +FIG00464402 FIG00464403: hypothetical protein +FIG00464412 Putative bacteriophage protein +FIG00464416 FIG00464419: hypothetical protein +FIG00464423 glycoside hydrolase, family 3-like +FIG00464436 FIG00464437: hypothetical protein +FIG00464444 FIG00464446: hypothetical protein +FIG00464454 FIG00464455: hypothetical protein +FIG00464460 FIG00464464: hypothetical protein +FIG00464464 FIG00464465: hypothetical protein +FIG00464478 FIG00464480: hypothetical protein +FIG00464482 FIG00464483: hypothetical protein +FIG00464484 FIG00464488: hypothetical protein +FIG00464507 FIG00464513: hypothetical protein +FIG00464513 FIG00464515: hypothetical protein +FIG00464518 FIG00464519: hypothetical protein +FIG00464526 FIG00464527: hypothetical protein +FIG00464528 FIG00464531: hypothetical protein +FIG00464536 FIG00464537: hypothetical protein +FIG00464546 FIG00464547: hypothetical protein +FIG00464551 FIG00464553: hypothetical protein +FIG00464555 FIG00464558: hypothetical protein +FIG00464558 FIG00464560: hypothetical protein +FIG00464567 FIG00464568: hypothetical protein +FIG00464568 FIG00464569: hypothetical protein +FIG00464582 FIG00464585: hypothetical protein +FIG00464604 FIG00464606: hypothetical protein +FIG00464614 FIG00464616: hypothetical protein +FIG00464633 Pyruvate/2-oxoglutarate dehydrogenase complex, dihydrolipoamide dehydrogenase (E3) component, and related enzymes +FIG00464636 FIG00464639: hypothetical protein +FIG00464640 FIG00464641: hypothetical protein +FIG00464642 FIG00464643: hypothetical protein +FIG00464648 hypothetical protein +FIG00464649 FIG00464652: hypothetical protein +FIG00464652 FIG00464659: hypothetical protein +FIG00464660 FIG00464662: hypothetical protein +FIG00464662 Putative cytoplasmic protein USSDB7A +FIG00464670 FIG00464671: hypothetical protein +FIG00464672 FIG00464676: hypothetical protein +FIG00464678 FIG00464681: hypothetical protein +FIG00464683 FIG00464684: hypothetical protein +FIG00464689 FIG00464690: hypothetical protein +FIG00464699 FIG00464701: hypothetical protein +FIG00464704 HpaP protein; Type III secretion protein (YscP) +FIG00464705 FIG00464707: hypothetical protein +FIG00464708 FIG00464709: hypothetical protein +FIG00464712 FIG00464713: hypothetical protein +FIG00464713 FIG00464716: hypothetical protein +FIG00464740 FIG00464742: hypothetical protein +FIG00464746 FIG00464747: hypothetical protein +FIG00464747 FIG00464748: hypothetical protein +FIG00464750 FIG00464751: hypothetical protein +FIG00464759 FIG00464760: hypothetical protein +FIG00464760 FIG00464761: hypothetical protein +FIG00464763 FIG00464764: hypothetical protein +FIG00464764 FIG00464765: hypothetical protein +FIG00464785 FIG00464790: hypothetical protein +FIG00464792 FIG00464793: hypothetical protein +FIG00464795 FIG00464796: hypothetical protein +FIG00464797 FIG00464800: hypothetical protein +FIG00464802 FIG00464805: hypothetical protein +FIG00464805 FIG00464807: hypothetical protein +FIG00464825 FIG00464830: hypothetical protein +FIG00464834 COGs COG2002 +FIG00464840 Acyl protein synthase/acyl-CoA reductase RfbN +FIG00464841 FIG00464846: hypothetical protein +FIG00464846 FIG00464848: hypothetical protein +FIG00464855 FIG00464856: hypothetical protein +FIG00464857 FIG00464862: hypothetical protein +FIG00464862 FIG00464863: hypothetical protein +FIG00464863 FIG00464866: hypothetical protein +FIG00464866 FIG00464870: hypothetical protein +FIG00464875 FIG00464877: hypothetical protein +FIG00464879 COG3707: Response regulator with putative antiterminator output domain +FIG00464889 FIG00464892: hypothetical protein +FIG00464912 FIG00464913: hypothetical protein +FIG00464928 FIG00464933: hypothetical protein +FIG00464933 FIG00464934: hypothetical protein +FIG00464951 FIG00464954: hypothetical protein +FIG00464954 FIG00464956: hypothetical protein +FIG00464983 FIG00464985: hypothetical protein +FIG00464986 FIG00464989: hypothetical protein +FIG00464989 FIG00464995: hypothetical protein +FIG00464998 FIG00465000: hypothetical protein +FIG00465023 FIG00465025: hypothetical protein +FIG00465031 FIG00465035: hypothetical protein +FIG00465045 FIG00465048: hypothetical protein +FIG00465054 FIG00465055: hypothetical protein +FIG00465071 FIG00465072: hypothetical protein +FIG00465072 FIG00465075: hypothetical protein +FIG00465078 FIG00465082: hypothetical protein +FIG00465084 FIG00465086: hypothetical protein +FIG00465090 FIG00465097: hypothetical protein +FIG00465097 FIG00465099: hypothetical protein +FIG00465109 FIG00465110: hypothetical protein +FIG00465110 FIG00465114: hypothetical protein +FIG00465119 FIG00465123: hypothetical protein +FIG00465132 FIG00465133: hypothetical protein +FIG00465138 FIG00465139: hypothetical protein +FIG00465144 Polyketide non-ribosomal peptide synthase +FIG00465146 FIG00465147: hypothetical protein +FIG00465154 mutT/NUDIX family protein +FIG00465163 FIG00465168: hypothetical protein +FIG00465177 FIG00465178: hypothetical protein +FIG00465185 FIG00465187: hypothetical protein +FIG00465191 FIG00465192: hypothetical protein +FIG00465192 FIG00465194: hypothetical protein +FIG00465194 FIG00465196: hypothetical protein +FIG00465202 FIG00465203: hypothetical protein +FIG00465204 FIG00465206: hypothetical protein +FIG00465207 FIG00465208: hypothetical protein +FIG00465208 FIG00465213: hypothetical protein +FIG00465214 FIG00465215: hypothetical protein +FIG00465236 FIG00465238: hypothetical protein +FIG00465238 FIG00465240: hypothetical protein +FIG00465241 capsula synthesis response regulator transcription regulator protein +FIG00465245 Coenzyme F420-dependent N5,N10-methylene tetrahydromethanopterin reductase and related flavin-dependent oxidoreductases +FIG00465267 FIG00465268: hypothetical protein +FIG00465273 FIG00465275: hypothetical protein +FIG00465280 FIG00465281: hypothetical protein +FIG00465281 FIG00465283: hypothetical protein +FIG00465283 KluA regulatory protein +FIG00465326 FIG00465332: hypothetical protein +FIG00465334 FIG00465336: hypothetical protein +FIG00465347 FIG00465348: hypothetical protein +FIG00465349 FIG00465351: hypothetical protein +FIG00465354 FIG00465356: hypothetical protein +FIG00465388 putative dimethylmenaquinone methyltransferase +FIG00465403 FIG00453007: hypothetical protein +FIG00465416 FIG00465417: hypothetical protein +FIG00465422 FIG00465426: hypothetical protein +FIG00465429 hypothetical protein +FIG00465443 FIG00465444: hypothetical protein +FIG00465444 FIG00465445: hypothetical protein +FIG00465445 FIG00465446: hypothetical protein +FIG00465446 FIG00465449: hypothetical protein +FIG00465450 FIG00465452: hypothetical protein +FIG00465452 FIG00465453: hypothetical protein +FIG00465458 FIG00465459: hypothetical protein +FIG00465467 FIG00465470: hypothetical protein +FIG00465492 FIG00465495: hypothetical protein +FIG00465501 FIG00465503: hypothetical protein +FIG00465518 FIG00465520: hypothetical protein +FIG00465528 FIG00465529: hypothetical protein +FIG00465529 FIG00465530: hypothetical protein +FIG00465530 FIG00465537: hypothetical protein +FIG00465537 FIG00465540: hypothetical protein +FIG00465547 FIG00465548: hypothetical protein +FIG00465590 FIG00465595: hypothetical protein +FIG00465596 FIG00465598: hypothetical protein +FIG00465617 FIG00465618: hypothetical protein +FIG00465619 FIG00465620: hypothetical protein +FIG00465620 FIG00465623: hypothetical protein +FIG00465623 FIG00465627: hypothetical protein +FIG00465630 FIG00465631: hypothetical protein +FIG00465632 FIG00465633: hypothetical protein +FIG00465633 FIG00465634: hypothetical protein +FIG00465636 hypoyhetical protein +FIG00465640 FIG00465642: hypothetical protein +FIG00465691 FIG00465693: hypothetical protein +FIG00465708 ArsR family transcriptional regulator +FIG00465711 FIG00465717: hypothetical protein +FIG00465717 FIG00465719: hypothetical protein +FIG00465722 IncC protein +FIG00465726 Probable amino-acid ABC transporter ATP-binding protein y4tH +FIG00465731 FIG00465739: hypothetical protein +FIG00465739 FIG00465740: hypothetical protein +FIG00465751 FIG00465754: hypothetical protein +FIG00465763 FIG00465767: hypothetical protein +FIG00465789 FIG00465790: hypothetical protein +FIG00465804 FIG00465806: hypothetical protein +FIG00465806 FIG00465808: hypothetical protein +FIG00465810 FIG00465815: hypothetical protein +FIG00465817 FIG101079: Lytic enzyme +FIG00465818 transport-associated +FIG00465820 FIG00465823: hypothetical protein +FIG00465823 FIG00465826: hypothetical protein +FIG00465837 FIG00465841: hypothetical protein +FIG00465848 FIG00465849: hypothetical protein +FIG00465855 FIG00465858: hypothetical protein +FIG00465871 FIG00465873: hypothetical protein +FIG00465873 FIG00465875: hypothetical protein +FIG00465886 FIG00465888: hypothetical protein +FIG00465888 FIG00465890: hypothetical protein +FIG00465902 HTH-type transcriptional regulator dgdR +FIG00465907 FIG00465912: hypothetical protein +FIG00465912 FIG00465913: hypothetical protein +FIG00465946 FIG00465948: hypothetical protein +FIG00465949 FIG00465953: hypothetical protein +FIG00465963 FIG00465967: hypothetical protein +FIG00465970 FIG00465978: hypothetical protein +FIG00465978 biopolymer transport protein, MotA/TolQ/ExbB proton channel family +FIG00465979 FIG00465980: hypothetical protein +FIG00465997 FIG00465998: hypothetical protein +FIG00465998 FIG00465999: hypothetical protein +FIG00466000 FIG00466002: hypothetical protein +FIG00466002 FIG00466003: hypothetical protein +FIG00466007 FIG00466008: hypothetical protein +FIG00466008 FIG00466010: hypothetical protein +FIG00466012 FIG00466015: hypothetical protein +FIG00466019 FIG00466020: hypothetical protein +FIG00466025 FIG00466027: hypothetical protein +FIG00466027 FIG00466031: hypothetical protein +FIG00466031 FIG00466032: hypothetical protein +FIG00466053 FIG00466054: hypothetical protein +FIG00466085 FIG00466089: hypothetical protein +FIG00466091 FIG00466094: hypothetical protein +FIG00466094 FIG00466098: hypothetical protein +FIG00466102 FIG00466105: hypothetical protein +FIG00466125 FIG00466127: hypothetical protein +FIG00466153 FIG00466158: hypothetical protein +FIG00466159 FIG00466161: hypothetical protein +FIG00466166 FIG00466167: hypothetical protein +FIG00466168 FIG00466171: hypothetical protein +FIG00466171 FIG00466172: hypothetical protein +FIG00466178 FIG00466181: hypothetical protein +FIG00466181 FIG00466185: hypothetical protein +FIG00466185 FIG00466186: hypothetical protein +FIG00466187 COG4409: Neuraminidase (sialidase) +FIG00466195 ABC-type dipeptide/oligopeptide/nickel transport system, ATPase component +FIG00466221 FIG00466223: hypothetical protein +FIG00466230 FIG00466236: hypothetical protein +FIG00466258 FIG00466259: hypothetical protein +FIG00466259 FIG00466261: hypothetical protein +FIG00466272 FIG00466276: hypothetical protein +FIG00466278 FIG00466280: hypothetical protein +FIG00466281 Predicted nucleic-acid-binding protein containing a Zn-ribbon +FIG00466289 FIG00466290: hypothetical protein +FIG00466290 FIG00466291: hypothetical protein +FIG00466293 FIG00466294: hypothetical protein +FIG00466304 FIG00466305: hypothetical protein +FIG00466308 FIG00466311: hypothetical protein +FIG00466319 FIG00466321: hypothetical protein +FIG00466325 FIG00466327: hypothetical protein +FIG00466344 Nodulation protein C +FIG00466367 FIG00466368: hypothetical protein +FIG00466381 FIG00466393: hypothetical protein +FIG00466394 FIG00466395: hypothetical protein +FIG00466400 FIG00466403: hypothetical protein +FIG00466410 glutamine ABC transporter ATP-binding protein glnQ +FIG00466414 FIG01048949: hypothetical protein +FIG00466428 FIG00466432: hypothetical protein +FIG00466437 FIG00466444: hypothetical protein +FIG00466444 FIG00466447: hypothetical protein +FIG00466453 FIG00466454: hypothetical protein +FIG00466463 FIG00466464: hypothetical protein +FIG00466465 FIG00466466: hypothetical protein +FIG00466491 FIG00466492: hypothetical protein +FIG00466492 FIG00466496: hypothetical protein +FIG00466499 FIG00466501: hypothetical protein +FIG00466510 FIG00466511: hypothetical protein +FIG00466511 FIG00466512: hypothetical protein +FIG00466514 FIG00464776: hypothetical protein +FIG00466526 FIG00466528: hypothetical protein +FIG00466530 FIG00466534: hypothetical protein +FIG00466538 FIG00466539: hypothetical protein +FIG00466541 FIG00466548: hypothetical protein +FIG00466557 FIG00466558: hypothetical protein +FIG00466558 FIG00466559: hypothetical protein +FIG00466581 FIG00466585: hypothetical protein +FIG00466592 FIG00466593: hypothetical protein +FIG00466593 FIG00466594: hypothetical protein +FIG00466598 FIG00466599: hypothetical protein +FIG00466599 FIG00466600: hypothetical protein +FIG00466600 FIG00466601: hypothetical protein +FIG00466601 FIG00466604: hypothetical protein +FIG00466604 FIG00466605: hypothetical protein +FIG00466605 FIG00466606: hypothetical protein +FIG00466613 FIG00466617: hypothetical protein +FIG00466617 FIG00466619: hypothetical protein +FIG00466628 gp4 +FIG00466670 FIG00466675: hypothetical protein +FIG00466677 FIG00466678: hypothetical protein +FIG00466680 FIG00466681: hypothetical protein +FIG00466689 FIG00466693: hypothetical protein +FIG00466697 FIG00466700: hypothetical protein +FIG00466703 FIG00466705: hypothetical protein +FIG00466705 Predicted deacylase +FIG00466709 FIG00466710: hypothetical protein +FIG00466710 FIG00466713: hypothetical protein +FIG00466721 FIG00466726: hypothetical protein +FIG00466728 FIG00466729: hypothetical protein +FIG00466734 FIG00466736: hypothetical protein +FIG00466744 FIG00466747: hypothetical protein +FIG00466747 putative isobutylamine N-hydroxylase +FIG00466751 FIG00466752: hypothetical protein +FIG00466775 FIG00466776: hypothetical protein +FIG00466776 FIG00466777: hypothetical protein +FIG00466779 FIG00466780: hypothetical protein +FIG00466797 FIG00466798: hypothetical protein +FIG00466822 FIG00466823: hypothetical protein +FIG00466834 FIG00466837: hypothetical protein +FIG00466837 FIG00466839: hypothetical protein +FIG00466854 FIG00466855: hypothetical protein +FIG00466861 FIG00466862: hypothetical protein +FIG00466875 FIG00466881: hypothetical protein +FIG00466897 FIG00466898: hypothetical protein +FIG00466911 FIG00466913: hypothetical protein +FIG00466916 FIG00466917: hypothetical protein +FIG00466917 FIG00452579: hypothetical protein +FIG00466931 FIG00466935: hypothetical protein +FIG00466936 FIG00466938: hypothetical protein +FIG00466940 FIG00466942: hypothetical protein +FIG00466942 FIG00466949: hypothetical protein +FIG00466983 FIG00466984: hypothetical protein +FIG00466988 FIG00466990: hypothetical protein +FIG00466997 FIG00466999: hypothetical protein +FIG00467002 FIG00467003: hypothetical protein +FIG00467003 FIG00467010: hypothetical protein +FIG00467017 FIG00467019: hypothetical protein +FIG00467034 FIG00467040: hypothetical protein +FIG00467040 FIG00467042: hypothetical protein +FIG00467042 FIG00467045: hypothetical protein +FIG00467047 FIG00467050: hypothetical protein +FIG00467052 FIG00467053: hypothetical protein +FIG00467058 FIG00467059: hypothetical protein +FIG00467063 FIG00467065: hypothetical protein +FIG00467072 FIG00467073: hypothetical protein +FIG00467079 FIG00467081: hypothetical protein +FIG00467088 FIG00467095: hypothetical protein +FIG00467097 FIG00467098: hypothetical protein +FIG00467098 FIG00467104: hypothetical protein +FIG00467104 FIG00467105: hypothetical protein +FIG00467105 FIG00467106: hypothetical protein +FIG00467106 FIG00467107: hypothetical protein +FIG00467128 FIG00467130: hypothetical protein +FIG00467151 FIG00467155: hypothetical protein +FIG00467165 FIG00467166: hypothetical protein +FIG00467167 FIG00467168: hypothetical protein +FIG00467182 FIG00467184: hypothetical protein +FIG00467185 FIG00467188: hypothetical protein +FIG00467201 FIG00467205: hypothetical protein +FIG00467215 putative NAD(P)H-dependent xylose reductase +FIG00467218 FIG00467219: hypothetical protein +FIG00467222 FIG00467223: hypothetical protein +FIG00467234 FIG00467236: hypothetical protein +FIG00467249 FIG00467251: hypothetical protein +FIG00467251 FIG00467252: hypothetical protein +FIG00467268 FIG00467269: hypothetical protein +FIG00467275 FIG00467277: hypothetical protein +FIG00467277 FIG00467278: hypothetical protein +FIG00467289 Major facilitator superfamily (MFS)metabolite/H+ symporter +FIG00467301 FIG00467308: hypothetical protein +FIG00467313 FIG00467315: hypothetical protein +FIG00467333 FIG00467335: hypothetical protein +FIG00467350 FIG00467353: hypothetical protein +FIG00467355 FIG00467357: hypothetical protein +FIG00467370 FIG00467373: hypothetical protein +FIG00467385 FIG00467386: hypothetical protein +FIG00467386 FIG00467395: hypothetical protein +FIG00467395 PROBABLE CONSERVED TWO-DOMAIN MEMBRANE PROTEIN +FIG00467403 FIG00467404: hypothetical protein +FIG00467414 FIG00467415: hypothetical protein +FIG00467418 FIG00467420: hypothetical protein +FIG00467425 FIG00467429: hypothetical protein +FIG00467434 Bacteriophage Lambda NinG +FIG00467443 FIG00467444: hypothetical protein +FIG00467444 FIG00467445: hypothetical protein +FIG00467449 FIG00467450: hypothetical protein +FIG00467450 FIG00467451: hypothetical protein +FIG00467454 FIG00467456: hypothetical protein +FIG00467471 FIG00467476: hypothetical protein +FIG00467483 FIG00467484: hypothetical protein +FIG00467484 FIG00467485: hypothetical protein +FIG00467521 FIG00467522: hypothetical protein +FIG00467622 FIG00467626: hypothetical protein +FIG00467635 FIG00467636: hypothetical protein +FIG00467668 FIG00467671: hypothetical protein +FIG00467715 FIG00467717: hypothetical protein +FIG00467730 FIG00467733: hypothetical protein +FIG00467754 FIG00467755: hypothetical protein +FIG00467755 hypothetical protein +FIG00467768 Plasmid-related protein +FIG00467798 FIG00467802: hypothetical protein +FIG00467815 FIG00467819: hypothetical protein +FIG00467822 FIG00467823: hypothetical protein +FIG00467841 FIG00467843: hypothetical protein +FIG00467878 FIG00467881: hypothetical protein +FIG00467881 FIG00467883: hypothetical protein +FIG00467901 FIG00467904: hypothetical protein +FIG00467970 FIG00467972: hypothetical protein +FIG00468008 FIG00468011: hypothetical protein +FIG00468047 FIG00468055: hypothetical protein +FIG00468055 FIG00468057: hypothetical protein +FIG00468059 As reductase( EC:1.20.4.1 ) +FIG00468083 FIG00468085: hypothetical protein +FIG00468155 FIG00468159: hypothetical protein +FIG00468187 Gll2564 protein +FIG00468188 FIG00468189: hypothetical protein +FIG00468271 FIG00468281: hypothetical protein +FIG00468281 Late competence protein ComC, processing protease +FIG00468329 FIG00468340: hypothetical protein +FIG00468340 FIG00468352: hypothetical protein +FIG00468362 FIG00468371: hypothetical protein +FIG00468372 FIG00468379: hypothetical protein +FIG00468427 FIG00468444: hypothetical protein +FIG00468444 FIG00468446: hypothetical protein +FIG00468460 FIG00468462: hypothetical protein +FIG00468462 FIG00468478: hypothetical protein +FIG00468478 FIG00468482: hypothetical protein +FIG00468527 FIG00468537: hypothetical protein +FIG00468563 FIG00468578: hypothetical protein +FIG00468590 FIG00468596: hypothetical protein +FIG00468599 lipolytic enzyme, G-D-S-L family +FIG00468602 FIG00468605: hypothetical protein +FIG00468608 FIG00468617: hypothetical protein +FIG00468617 FIG00468635: hypothetical protein +FIG00468650 FIG00468656: hypothetical protein +FIG00468673 FIG00468674: hypothetical protein +FIG00468707 FIG00468712: hypothetical protein +FIG00468712 Alcohol dehydrogenase, zinc-dependent +FIG00468741 FIG00468744: hypothetical protein +FIG00468826 Regulators of stationary/sporulation gene expression +FIG00468847 FIG00468852: hypothetical protein +FIG00468855 Lin1455 protein +FIG00468856 Coat F domain protein +FIG00468861 FIG00468862: hypothetical protein +FIG00468862 Uncharacterized protein MA0381 +FIG00468866 FIG00468890: hypothetical protein +FIG00468894 FIG00468900: hypothetical protein +FIG00468959 FIG00468968: hypothetical protein +FIG00468979 xylan degradation +FIG00468983 HesA/MoeB/ThiF family protein +FIG00469023 FIG00469025: hypothetical protein +FIG00469052 FIG00469083: hypothetical protein +FIG00469083 FIG00469094: hypothetical protein +FIG00469121 FIG00469130: hypothetical protein +FIG00469130 FIG00469139: hypothetical protein +FIG00469139 SAF domain protein +FIG00469149 FIG00469151: hypothetical protein +FIG00469176 FIG00469178: hypothetical protein +FIG00469211 Hydrolase, haloacid dehalogenase-like family (EC 3.8.1.-) +FIG00469246 FIG00469248: hypothetical protein +FIG00469249 FIG00469282: hypothetical protein +FIG00469283 FIG00469284: hypothetical protein +FIG00469286 FIG00469293: hypothetical protein +FIG00469295 FIG00469306: hypothetical protein +FIG00469318 FIG00469321: hypothetical protein +FIG00469321 FIG00469329: hypothetical protein +FIG00469351 Uncharacterized protein aq_aa25 +FIG00469369 FIG00469370: hypothetical protein +FIG00469370 FIG00469373: hypothetical protein +FIG00469373 FIG00469375: hypothetical protein +FIG00469378 FIG00469380: hypothetical protein +FIG00469380 FIG00469381: hypothetical protein +FIG00469381 FIG00469382: hypothetical protein +FIG00469382 FIG00469383: hypothetical protein +FIG00469383 FIG00469384: hypothetical protein +FIG00469384 FIG00469385: hypothetical protein +FIG00469385 FIG00469386: hypothetical protein +FIG00469386 FIG00469387: hypothetical protein +FIG00469398 FIG00469399: hypothetical protein +FIG00469399 FIG00469400: hypothetical protein +FIG00469400 FIG00469406: hypothetical protein +FIG00469409 FIG00469410: hypothetical protein +FIG00469410 FIG00469412: hypothetical protein +FIG00469412 FIG00469414: hypothetical protein +FIG00469414 FIG00469415: hypothetical protein +FIG00469415 identified by match to protein family HMM PF00535 +FIG00469419 FIG00469420: hypothetical protein +FIG00469420 FIG00469421: hypothetical protein +FIG00469421 FIG00469422: hypothetical protein +FIG00469422 FIG00469423: hypothetical protein +FIG00469426 FIG00469427: hypothetical protein +FIG00469430 FIG00469431: hypothetical protein +FIG00469431 FIG00469432: hypothetical protein +FIG00469435 FIG00469439: hypothetical protein +FIG00469439 FIG00469442: hypothetical protein +FIG00469442 FIG00469447: hypothetical protein +FIG00469449 FIG00469453: hypothetical protein +FIG00469455 FIG00469456: hypothetical protein +FIG00469460 FIG00469462: hypothetical protein +FIG00469462 FIG00469464: hypothetical protein +FIG00469464 FIG00469465: hypothetical protein +FIG00469465 FIG00469466: hypothetical protein +FIG00469466 FIG00469468: hypothetical protein +FIG00469468 FIG00469472: hypothetical protein +FIG00469472 FIG00469474: hypothetical protein +FIG00469474 FIG00469478: hypothetical protein +FIG00469478 FIG00469482: hypothetical protein +FIG00469482 FIG00469484: hypothetical protein +FIG00469485 Hypothetical protein pVir0029, glutamine-rich +FIG00469486 FIG00469487: hypothetical protein +FIG00469487 FIG00469490: hypothetical protein +FIG00469490 FIG00469491: hypothetical protein +FIG00469492 FIG00469493: hypothetical protein +FIG00469494 FIG00469502: hypothetical protein +FIG00469504 FIG00469506: hypothetical protein +FIG00469506 FIG00469507: hypothetical protein +FIG00469507 FIG00469509: hypothetical protein +FIG00469509 FIG00469510: hypothetical protein +FIG00469510 FIG00469513: hypothetical protein +FIG00469516 FIG00469522: hypothetical protein +FIG00469522 FIG00469524: hypothetical protein +FIG00469524 FIG00469526: hypothetical protein +FIG00469526 FIG00469527: hypothetical protein +FIG00469529 FIG00469530: hypothetical protein +FIG00469530 FIG022708: hypothetical protein +FIG00469531 FIG00388607: hypothetical protein +FIG00469532 FIG00469538: hypothetical protein +FIG00469538 FIG00469540: hypothetical protein +FIG00469540 FIG00469541: hypothetical protein +FIG00469541 FIG00387922: hypothetical protein +FIG00469543 FIG00469544: hypothetical protein +FIG00469544 FIG00469546: hypothetical protein +FIG00469550 FIG00469551: hypothetical protein +FIG00469551 FIG00469556: hypothetical protein +FIG00469556 FIG00469557: hypothetical protein +FIG00469557 FIG00469560: hypothetical protein +FIG00469560 FIG00469561: hypothetical protein +FIG00469565 Type IV secretion/competence protein (VirB9) +FIG00469566 FIG00469567: hypothetical protein +FIG00469567 FIG00469568: hypothetical protein +FIG00469569 FIG00469571: hypothetical protein +FIG00469577 FIG00469578: hypothetical protein +FIG00469578 FIG00469579: hypothetical protein +FIG00469579 FIG00469581: hypothetical protein +FIG00469583 FIG00469585: hypothetical protein +FIG00469586 FIG00469590: hypothetical protein +FIG00469594 FIG00469595: hypothetical protein +FIG00469598 FIG00469601: hypothetical protein +FIG00469602 FIG00469603: hypothetical protein +FIG00469603 FIG00387915: hypothetical protein +FIG00469606 FIG00469607: hypothetical protein +FIG00469609 FIG00469610: hypothetical protein +FIG00469610 FIG00469612: hypothetical protein +FIG00469616 FIG00469618: hypothetical protein +FIG00469618 Type II secretion system protein +FIG00469619 FIG00469622: hypothetical protein +FIG00469622 FIG00469623: hypothetical protein +FIG00469623 FIG00469624: hypothetical protein +FIG00469626 FIG00469627: hypothetical protein +FIG00469627 FIG00469629: hypothetical protein +FIG00469637 FIG00469638: hypothetical protein +FIG00469638 FIG00469640: hypothetical protein +FIG00469640 FIG00469642: hypothetical protein +FIG00469643 FIG00469644: hypothetical protein +FIG00469644 Domain of unknown function (DUF332) superfamily +FIG00469646 FIG00469647: hypothetical protein +FIG00469647 FIG00469648: hypothetical protein +FIG00469648 FIG00388203: hypothetical protein +FIG00469655 FIG00469657: hypothetical protein +FIG00469657 FIG00469658: hypothetical protein +FIG00469658 FIG00469659: hypothetical protein +FIG00469663 FIG00469664: hypothetical protein +FIG00469664 FIG00469665: hypothetical protein +FIG00469665 FIG00469667: hypothetical protein +FIG00469667 Putative hemolysin activation/secretion protein +FIG00469672 FIG00469675: hypothetical protein +FIG00469683 FIG00469686: hypothetical protein +FIG00469686 FIG00469687: hypothetical protein +FIG00469687 FIG00469690: hypothetical protein +FIG00469690 DNA replication regulator family +FIG00469695 FIG00469696: hypothetical protein +FIG00469696 Phosphatidylserine decarboxylase-related protein +FIG00469698 FIG00469699: hypothetical protein +FIG00469701 FIG00469705: hypothetical protein +FIG00469705 FIG00469707: hypothetical protein +FIG00469710 FIG00469712: hypothetical protein +FIG00469712 FIG00469713: hypothetical protein +FIG00469716 FIG00469719: hypothetical protein +FIG00469719 FIG00469721: hypothetical protein +FIG00469721 FIG00469723: hypothetical protein +FIG00469723 FIG00469724: hypothetical protein +FIG00469724 FIG00469727: hypothetical protein +FIG00469727 FIG00469729: hypothetical protein +FIG00469729 Putative ATP /GTP binding protein +FIG00469733 FIG00469741: hypothetical protein +FIG00469741 FIG00469742: hypothetical protein +FIG00469742 FIG00469743: hypothetical protein +FIG00469743 FIG00469744: hypothetical protein +FIG00469748 FIG00469749: hypothetical protein +FIG00469749 FIG00469751: hypothetical protein +FIG00469751 FIG00469756: hypothetical protein +FIG00469756 FIG00469759: hypothetical protein +FIG00469760 FIG00469761: hypothetical protein +FIG00469761 FIG00469765: hypothetical protein +FIG00469765 FIG00469766: hypothetical protein +FIG00469766 FIG00469769: hypothetical protein +FIG00469769 FIG00469770: hypothetical protein +FIG00469770 FIG00469771: hypothetical protein +FIG00469772 FIG00469773: hypothetical protein +FIG00469774 FIG00469775: hypothetical protein +FIG00469775 FIG00469776: hypothetical protein +FIG00469776 FIG00469777: hypothetical protein +FIG00469777 FIG00469778: hypothetical protein +FIG00469778 FIG00469779: hypothetical protein +FIG00469779 FIG00469781: hypothetical protein +FIG00469781 FIG00469784: hypothetical protein +FIG00469784 FIG00469787: hypothetical protein +FIG00469787 FIG00469788: hypothetical protein +FIG00469788 FIG00469792: hypothetical protein +FIG00469792 Hypothetical protein pVir0015 +FIG00469793 FIG00469794: hypothetical protein +FIG00469794 FIG00469797: hypothetical protein +FIG00469797 FIG00469799: hypothetical protein +FIG00469800 FIG00469804: hypothetical protein +FIG00469816 FIG00469817: hypothetical protein +FIG00469817 FIG00469819: hypothetical protein +FIG00469820 FIG00469821: hypothetical protein +FIG00469821 FIG00469824: hypothetical protein +FIG00469824 FIG00470444: hypothetical protein +FIG00469825 FIG00469826: hypothetical protein +FIG00469826 Ecotin precursor +FIG00469827 FIG00469833: hypothetical protein +FIG00469833 FIG00469834: hypothetical protein +FIG00469834 FIG00469836: hypothetical protein +FIG00469836 FIG00469838: hypothetical protein +FIG00469838 FIG00469839: hypothetical protein +FIG00469839 FIG00469840: hypothetical protein +FIG00469840 FIG00469843: hypothetical protein +FIG00469843 FIG00469845: hypothetical protein +FIG00469846 FIG00469849: hypothetical protein +FIG00469853 FIG00469856: hypothetical protein +FIG00469858 FIG00469861: hypothetical protein +FIG00469864 FIG00469865: hypothetical protein +FIG00469865 FIG00469868: hypothetical protein +FIG00469868 FIG00469877: hypothetical protein +FIG00469877 FIG00469879: hypothetical protein +FIG00469882 FIG00469884: hypothetical protein +FIG00469884 FIG00469885: hypothetical protein +FIG00469885 FIG00469889: hypothetical protein +FIG00469889 FIG00469890: hypothetical protein +FIG00469890 FIG00469891: hypothetical protein +FIG00469891 FIG00469892: hypothetical protein +FIG00469893 FIG00469895: hypothetical protein +FIG00469895 FIG00469896: hypothetical protein +FIG00469896 FIG00469898: hypothetical protein +FIG00469898 FIG00469900: hypothetical protein +FIG00469900 FIG00469903: hypothetical protein +FIG00469903 FIG00469906: hypothetical protein +FIG00469907 FIG00469908: hypothetical protein +FIG00469908 Possible periplasmic thiredoxin +FIG00469912 FIG00469913: hypothetical protein +FIG00469914 FIG00469916: hypothetical protein +FIG00469916 FIG00469919: hypothetical protein +FIG00469919 FIG00469920: hypothetical protein +FIG00469920 FIG00469921: hypothetical protein +FIG00469921 FIG00469922: hypothetical protein +FIG00469922 FIG00469923: hypothetical protein +FIG00469923 FIG00469924: hypothetical protein +FIG00469927 FIG00469930: hypothetical protein +FIG00469951 FIG00469954: hypothetical protein +FIG00469954 hypothetical protein CCC13826_0379 +FIG00469956 FIG00469957: hypothetical protein +FIG00469957 FIG00469958: hypothetical protein +FIG00469960 FIG00469961: hypothetical protein +FIG00469964 FIG00469965: hypothetical protein +FIG00469965 FIG00469967: hypothetical protein +FIG00469974 FIG00469978: hypothetical protein +FIG00469981 FIG00469983: hypothetical protein +FIG00469983 FIG00469984: hypothetical protein +FIG00469985 UDP-2-acetamido-2-deoxy-D-glucose dehydrogenase (NAD+) +FIG00469987 FIG00469988: hypothetical protein +FIG00469989 FIG00469991: hypothetical protein +FIG00469991 FIG00469996: hypothetical protein +FIG00469996 FIG00470000: hypothetical protein +FIG00470006 FIG00470011: hypothetical protein +FIG00470011 FIG00470012: hypothetical protein +FIG00470012 FIG00470017: hypothetical protein +FIG00470017 FIG00470019: hypothetical protein +FIG00470028 FIG00470029: hypothetical protein +FIG00470037 FIG00470038: hypothetical protein +FIG00470038 FIG00470039: hypothetical protein +FIG00470039 FIG00470041: hypothetical protein +FIG00470041 FIG00470045: hypothetical protein +FIG00470045 FIG00470047: hypothetical protein +FIG00470047 FIG00470048: hypothetical protein +FIG00470048 FIG00470049: hypothetical protein +FIG00470049 FIG00470053: hypothetical protein +FIG00470063 FIG00470064: hypothetical protein +FIG00470064 FIG00470065: hypothetical protein +FIG00470065 FIG00470066: hypothetical protein +FIG00470066 FIG00470070: hypothetical protein +FIG00470070 FIG00470071: hypothetical protein +FIG00470072 FIG00470074: hypothetical protein +FIG00470074 FIG00470075: hypothetical protein +FIG00470075 FIG00470079: hypothetical protein +FIG00470079 FIG00470080: hypothetical protein +FIG00470080 FIG00470088: hypothetical protein +FIG00470088 FIG00470092: hypothetical protein +FIG00470101 Transamidase GatB domain protein +FIG00470109 CRISPR-associated protein, Csh2 family +FIG00470114 FIG00470116: hypothetical protein +FIG00470116 FIG00470117: hypothetical protein +FIG00470117 FIG00470118: hypothetical protein +FIG00470118 FIG00470120: hypothetical protein +FIG00470120 CpsC +FIG00470121 FIG00470123: hypothetical protein +FIG00470123 FIG00470126: hypothetical protein +FIG00470128 FIG00470129: hypothetical protein +FIG00470129 FIG00470131: hypothetical protein +FIG00470131 FIG00470133: hypothetical protein +FIG00470134 FIG00470135: hypothetical protein +FIG00470141 FIG00470143: hypothetical protein +FIG00470156 FIG00470159: hypothetical protein +FIG00470159 FIG00470160: hypothetical protein +FIG00470160 FIG00470162: hypothetical protein +FIG00470162 FIG00470163: hypothetical protein +FIG00470163 FIG00470164: hypothetical protein +FIG00470171 FIG00470172: hypothetical protein +FIG00470174 FIG00470179: hypothetical protein +FIG00470195 FIG00470200: hypothetical protein +FIG00470208 FIG00470210: hypothetical protein +FIG00470210 FIG00470215: hypothetical protein +FIG00470215 FIG00470219: hypothetical protein +FIG00470219 FIG00470222: hypothetical protein +FIG00470222 FIG00470223: hypothetical protein +FIG00470228 FIG00470229: hypothetical protein +FIG00470229 FIG00470232: hypothetical protein +FIG00470233 FIG00470236: hypothetical protein +FIG00470245 FIG00470246: hypothetical protein +FIG00470256 FIG00470257: hypothetical protein +FIG00470258 FIG00470265: hypothetical protein +FIG00470265 FIG00470268: hypothetical protein +FIG00470268 FIG00470270: hypothetical protein +FIG00470270 FIG00470273: hypothetical protein +FIG00470273 FIG00470276: hypothetical protein +FIG00470276 FIG00470277: hypothetical protein +FIG00470277 FIG00470281: hypothetical protein +FIG00470281 FIG00470282: hypothetical protein +FIG00470283 FIG00470286: hypothetical protein +FIG00470294 FIG00470297: hypothetical protein +FIG00470297 FIG00470299: hypothetical protein +FIG00470300 FIG00470301: hypothetical protein +FIG00470301 FIG00470303: hypothetical protein +FIG00470311 FIG00470314: hypothetical protein +FIG00470314 FIG00470316: hypothetical protein +FIG00470334 FIG00470336: hypothetical protein +FIG00470339 Hypothetical protein pVir0008 +FIG00470340 FIG00470343: hypothetical protein +FIG00470344 FIG00470345: hypothetical protein +FIG00470348 FIG00470350: hypothetical protein +FIG00470352 FIG00470355: hypothetical protein +FIG00470355 FIG00470359: hypothetical protein +FIG00470375 FIG00470376: hypothetical protein +FIG00470389 FIG00470390: hypothetical protein +FIG00470392 FIG00470397: hypothetical protein +FIG00470406 FIG00470408: hypothetical protein +FIG00470408 FIG00470409: hypothetical protein +FIG00470410 FIG00470411: hypothetical protein +FIG00470411 FIG00470412: hypothetical protein +FIG00470419 FIG00470423: hypothetical protein +FIG00470423 FIG00470425: hypothetical protein +FIG00470429 FIG00470431: hypothetical protein +FIG00470445 FIG00470447: hypothetical protein +FIG00470454 FIG00470457: hypothetical protein +FIG00470457 FIG00470458: hypothetical protein +FIG00470458 FIG00470461: hypothetical protein +FIG00470464 FIG00470467: hypothetical protein +FIG00470467 FIG00470472: hypothetical protein +FIG00470472 FIG00470474: hypothetical protein +FIG00470474 FIG00470476: hypothetical protein +FIG00470476 FIG00470478: hypothetical protein +FIG00470478 radical SAM domain protein protein +FIG00470482 hypothetical protein +FIG00470487 Ankyrin repeat-containing possible periplasmic protein +FIG00470491 FIG00470493: hypothetical protein +FIG00470493 FIG00470496: hypothetical protein +FIG00470500 FIG00470503: hypothetical protein +FIG00470503 FIG00470509: hypothetical protein +FIG00470520 FIG00470522: hypothetical protein +FIG00470524 FIG00470533: hypothetical protein +FIG00470533 FIG00470535: hypothetical protein +FIG00470536 FIG00470539: hypothetical protein +FIG00470543 FIG00470545: hypothetical protein +FIG00470545 FIG00470547: hypothetical protein +FIG00470562 FIG00470567: hypothetical protein +FIG00470567 FIG00470572: hypothetical protein +FIG00470572 Sensor kinase cusS (EC 2.7.3.-) +FIG00470577 FIG00470585: hypothetical protein +FIG00470585 Nicotinate-nucleotide adenylyltransferase (EC 2.7.7.18) / Iojap protein +FIG00470592 FIG00470593: hypothetical protein +FIG00470594 FIG00470597: hypothetical protein +FIG00470597 FIG00470600: hypothetical protein +FIG00470602 FIG00470604: hypothetical protein +FIG00470612 FIG00470615: hypothetical protein +FIG00470615 FIG00470625: hypothetical protein +FIG00470625 FIG00470627: hypothetical protein +FIG00470634 FIG00470635: hypothetical protein +FIG00470635 FIG00470638: hypothetical protein +FIG00470638 FIG00470640: hypothetical protein +FIG00470640 FIG00470651: hypothetical protein +FIG00470654 FIG00470655: hypothetical protein +FIG00470667 FIG00470671: hypothetical protein +FIG00470671 FIG00470673: hypothetical protein +FIG00470676 FIG00470679: hypothetical protein +FIG00470679 Phosphoglycerate transporter protein pgtP +FIG00470680 FIG00470684: hypothetical protein +FIG00470684 FIG00470685: hypothetical protein +FIG00470685 FIG00470688: hypothetical protein +FIG00470703 FIG00470704: hypothetical protein +FIG00470704 FIG00470709: hypothetical protein +FIG00470710 FIG00470712: hypothetical protein +FIG00470712 FIG00470714: hypothetical protein +FIG00470728 FIG00470730: hypothetical protein +FIG00470734 FIG00470735: hypothetical protein +FIG00470735 Cysteine synthase B (EC 2.5.1.47) +FIG00470743 FIG00470748: hypothetical protein +FIG00470748 FIG00470750: hypothetical protein +FIG00470750 FIG00470753: hypothetical protein +FIG00470753 FIG00470755: hypothetical protein +FIG00470755 FIG00470756: hypothetical protein +FIG00470760 FIG00470767: hypothetical protein +FIG00470768 FIG00470771: hypothetical protein +FIG00470776 solute carrier family 20 (phosphate transporter), member 1; Probable low-affinity inorganic phosphate transporter +FIG00470777 FIG00470778: hypothetical protein +FIG00470778 FIG00470782: hypothetical protein +FIG00470788 FIG00470789: hypothetical protein +FIG00470789 FIG00470790: hypothetical protein +FIG00470790 Hypothetical protein pVir0010 +FIG00470799 FIG00470807: hypothetical protein +FIG00470807 Protein containing aminopeptidase domain +FIG00470811 FIG00470816: hypothetical protein +FIG00470823 FIG00470824: hypothetical protein +FIG00470824 FIG00470826: hypothetical protein +FIG00470829 Hypothetical protein pVir0009 +FIG00470835 FIG00470836: hypothetical protein +FIG00470839 FIG00470841: hypothetical protein +FIG00470841 FIG00470843: hypothetical protein +FIG00470877 FIG00470881: hypothetical protein +FIG00470881 FIG00470882: hypothetical protein +FIG00470884 FIG00470885: hypothetical protein +FIG00470885 FIG00470890: hypothetical protein +FIG00470890 RepE replication protein, putative +FIG00470908 FIG00470909: hypothetical protein +FIG00470918 FIG00470931: hypothetical protein +FIG00470934 FIG00470940: hypothetical protein +FIG00470940 FIG00470941: hypothetical protein +FIG00470948 FIG00470952: hypothetical protein +FIG00470952 FIG00470956: hypothetical protein +FIG00470960 FIG00470965: hypothetical protein +FIG00470973 FIG00470976: hypothetical protein +FIG00470976 FIG00470977: hypothetical protein +FIG00470977 FIG00470979: hypothetical protein +FIG00470979 FIG00470982: hypothetical protein +FIG00470982 FIG00470987: hypothetical protein +FIG00470988 FIG00470991: hypothetical protein +FIG00470991 FIG00470993: hypothetical protein +FIG00470997 FIG00470998: hypothetical protein +FIG00470998 FIG00470999: hypothetical protein +FIG00470999 FIG00471002: hypothetical protein +FIG00471002 FIG00471003: hypothetical protein +FIG00471004 FIG00471005: hypothetical protein +FIG00471005 FIG00471008: hypothetical protein +FIG00471008 FIG00471011: hypothetical protein +FIG00471011 FIG00471014: hypothetical protein +FIG00471018 FIG00471024: hypothetical protein +FIG00471040 FIG00471048: hypothetical protein +FIG00471054 FIG00471055: hypothetical protein +FIG00471064 FIG00471065: hypothetical protein +FIG00471065 FIG00471069: hypothetical protein +FIG00471076 FIG00471083: hypothetical protein +FIG00471091 FIG00471093: hypothetical protein +FIG00471093 FIG00471111: hypothetical protein +FIG00471111 FIG00471113: hypothetical protein +FIG00471118 FIG00471123: hypothetical protein +FIG00471123 Hypothetical protein pVir0004 +FIG00471125 FIG00471126: hypothetical protein +FIG00471129 FIG00471130: hypothetical protein +FIG00471130 FIG00471133: hypothetical protein +FIG00471135 hypothetical protein +FIG00471153 acylneuraminate cytidylyltransferase, putative +FIG00471181 FIG00471184: hypothetical protein +FIG00471189 FIG00471195: hypothetical protein +FIG00471195 FIG00471198: hypothetical protein +FIG00471198 FIG00471203: hypothetical protein +FIG00471214 FIG00471217: hypothetical protein +FIG00471221 FIG00471236: hypothetical protein +FIG00471238 FIG00471239: hypothetical protein +FIG00471242 FIG00471243: hypothetical protein +FIG00471243 FIG00471244: hypothetical protein +FIG00471256 FIG00471264: hypothetical protein +FIG00471264 Glycosyl transferase family 8 family +FIG00471272 FIG00471280: hypothetical protein +FIG00471286 FIG00471287: hypothetical protein +FIG00471292 FIG00471296: hypothetical protein +FIG00471298 FIG00471302: hypothetical protein +FIG00471302 FIG00471303: hypothetical protein +FIG00471342 FIG00471348: hypothetical protein +FIG00471359 FIG00471361: hypothetical protein +FIG00471361 FIG00471362: hypothetical protein +FIG00471362 FIG00471369: hypothetical protein +FIG00471385 FIG00471392: hypothetical protein +FIG00471392 FIG00471393: hypothetical protein +FIG00471394 FIG00471396: hypothetical protein +FIG00471410 FIG00471415: hypothetical protein +FIG00471418 dna methylase-type I restriction-modification system +FIG00471434 FIG00471437: hypothetical protein +FIG00471510 FIG00471516: hypothetical protein +FIG00471527 FIG00471532: hypothetical protein +FIG00471532 Sugar phosphate permease of the Major Facilitator Superfamily +FIG00471538 FIG00471540: hypothetical protein +FIG00471540 FIG00471541: hypothetical protein +FIG00471541 FIG00471546: hypothetical protein +FIG00471561 FIG00471562: hypothetical protein +FIG00471562 FIG00471569: hypothetical protein +FIG00471569 FIG00471570: hypothetical protein +FIG00471572 FIG00471576: hypothetical protein +FIG00471614 FIG00471615: hypothetical protein +FIG00471622 FIG00471626: hypothetical protein +FIG00471626 FIG00471629: hypothetical protein +FIG00471631 FIG00471632: hypothetical protein +FIG00471632 FIG00471635: hypothetical protein +FIG00471635 Putative sugar transferase +FIG00471646 FIG00471651: hypothetical protein +FIG00471653 Type IV secretion/competence protein (VirB10) +FIG00471657 FIG00471660: hypothetical protein +FIG00471660 Hypothetical protein pVir0019/pVir0020 +FIG00471673 FIG00471674: hypothetical protein +FIG00471683 FIG00471688: hypothetical protein +FIG00471702 FIG00471707: hypothetical protein +FIG00471708 FIG00471711: hypothetical protein +FIG00471718 FIG00471719: hypothetical protein +FIG00471746 FIG00471751: hypothetical protein +FIG00471763 FIG00471770: hypothetical protein +FIG00471770 FIG00471772: hypothetical protein +FIG00471787 FIG00471788: hypothetical protein +FIG00471791 FIG00471792: hypothetical protein +FIG00471793 FIG00471794: hypothetical protein +FIG00471794 FIG00471796: hypothetical protein +FIG00471797 FIG00471799: hypothetical protein +FIG00471840 FIG00471841: hypothetical protein +FIG00471878 FIG00471882: hypothetical protein +FIG00471900 FIG00471901: hypothetical protein +FIG00471936 FIG00471942: hypothetical protein +FIG00471949 FIG00471950: hypothetical protein +FIG00471950 FIG00471953: hypothetical protein +FIG00471953 FIG00471955: hypothetical protein +FIG00471972 FIG00471980: hypothetical protein +FIG00471990 FIG00471999: hypothetical protein +FIG00472015 FIG00472019: hypothetical protein +FIG00472019 hypothetical protein +FIG00472022 METHYL-ACCEPTING CHEMOTAXIS PROTEIN +FIG00472071 FIG00472079: hypothetical protein +FIG00472084 FIG00472087: hypothetical protein +FIG00472103 FIG00472104: hypothetical protein +FIG00472114 FIG00472122: hypothetical protein +FIG00472122 FIG00472124: hypothetical protein +FIG00472125 FIG00472140: hypothetical protein +FIG00472140 FIG00472145: hypothetical protein +FIG00472145 FIG00472149: hypothetical protein +FIG00472150 Competence protein +FIG00472174 FIG00472177: hypothetical protein +FIG00472223 FIG00472226: hypothetical protein +FIG00472241 FIG00472242: hypothetical protein +FIG00472242 FIG00472252: hypothetical protein +FIG00472305 FIG00472306: hypothetical protein +FIG00472306 Polysaccharide deacetylase family +FIG00472314 FIG00472317: hypothetical protein +FIG00472337 FIG00472341: hypothetical protein +FIG00472372 FIG00472374: hypothetical protein +FIG00472411 Type I restriction modification DNA specificity domain, putative +FIG00472422 FIG00472425: hypothetical protein +FIG00472440 FIG00472444: hypothetical protein +FIG00472446 FIG00472447: hypothetical protein +FIG00472457 FIG00472464: hypothetical protein +FIG00472466 FIG00472472: hypothetical protein +FIG00472484 FIG00472491: hypothetical protein +FIG00472496 FIG00472501: hypothetical protein +FIG00472513 Gll1321 protein +FIG00472527 FIG00472540: hypothetical protein +FIG00472540 FIG00472546: hypothetical protein +FIG00472551 FIG00472557: hypothetical protein +FIG00472566 FIG00472569: hypothetical protein +FIG00472625 FIG00472637: hypothetical protein +FIG00472655 FIG00472656: hypothetical protein +FIG00472672 FIG00472678: hypothetical protein +FIG00472685 FIG00472687: hypothetical protein +FIG00472808 FIG00472811: hypothetical protein +FIG00472811 FIG00472828: hypothetical protein +FIG00472834 FIG00472848: hypothetical protein +FIG00472877 Exported serine protease SigA +FIG00472885 FIG00472886: hypothetical protein +FIG00472918 surface antigen BspA-like +FIG00472920 FIG00472921: hypothetical protein +FIG00472921 FIG00472922: hypothetical protein +FIG00472926 FIG00472927: hypothetical protein +FIG00472930 GldN +FIG00472937 FIG00472938: hypothetical protein +FIG00472938 FIG00472940: hypothetical protein +FIG00472942 FIG00472943: hypothetical protein +FIG00472946 FIG00472947: hypothetical protein +FIG00472948 FIG00472949: hypothetical protein +FIG00472949 FIG00472951: hypothetical protein +FIG00472951 DNA uptake lipoprotein-like protein +FIG00472955 FIG00472956: hypothetical protein +FIG00472956 FIG00472958: hypothetical protein +FIG00472962 FIG00472963: hypothetical protein +FIG00472964 FIG00472965: hypothetical protein +FIG00472965 FIG00472966: hypothetical protein +FIG00472967 FIG00472968: hypothetical protein +FIG00472970 FIG00472971: hypothetical protein +FIG00472971 FIG00472972: hypothetical protein +FIG00472974 FIG00472975: hypothetical protein +FIG00472976 FIG00472978: hypothetical protein +FIG00472978 FIG00472979: hypothetical protein +FIG00472981 FIG00472982: hypothetical protein +FIG00472985 FIG00472986: hypothetical protein +FIG00472993 FIG00472994: hypothetical protein +FIG00472994 FIG00472995: hypothetical protein +FIG00472995 FIG00472997: hypothetical protein +FIG00472997 ENSANGP00000000435 +FIG00472998 FIG00472999: hypothetical protein +FIG00473000 FIG00473001: hypothetical protein +FIG00473001 FIG00473002: hypothetical protein +FIG00473006 FIG00473007: hypothetical protein +FIG00473012 FIG00473013: hypothetical protein +FIG00473013 FIG00473014: hypothetical protein +FIG00473014 FIG00473015: hypothetical protein +FIG00473016 FIG00473018: hypothetical protein +FIG00473018 FIG00473019: hypothetical protein +FIG00473021 bacterial regulatory protein, DeoR family +FIG00473024 predicted nucleic acid-binding protein, containing PIN domain +FIG00473026 FIG00473027: hypothetical protein +FIG00473029 FIG00473031: hypothetical protein +FIG00473031 Possible Bacterial Ig-like domain (Group 1) precursor +FIG00473036 FIG00473038: hypothetical protein +FIG00473043 Similar to CDP-glucose 4,6-dehydratase (EC 4.2.1.45) +FIG00473044 FIG00473045: hypothetical protein +FIG00473046 FIG00473048: hypothetical protein +FIG00473048 FIG00473050: hypothetical protein +FIG00473051 FIG00473052: hypothetical protein +FIG00473052 FIG00473053: hypothetical protein +FIG00473053 FIG00473055: hypothetical protein +FIG00473055 FIG00473056: hypothetical protein +FIG00473058 FIG00473061: hypothetical protein +FIG00473062 FIG00473063: hypothetical protein +FIG00473064 FIG00473065: hypothetical protein +FIG00473065 FIG00473066: hypothetical protein +FIG00473066 FIG00473067: hypothetical protein +FIG00473067 FIG00473069: hypothetical protein +FIG00473069 FIG00473070: hypothetical protein +FIG00473070 FIG00473071: hypothetical protein +FIG00473072 FIG00473074: hypothetical protein +FIG00473077 FIG00473078: hypothetical protein +FIG00473086 FIG00473088: hypothetical protein +FIG00473088 FIG00473089: hypothetical protein +FIG00473089 Glycoside hydrolase, family 32 +FIG00473094 FIG00473095: hypothetical protein +FIG00473095 FIG00473096: hypothetical protein +FIG00473096 FIG00473097: hypothetical protein +FIG00473098 FIG00473100: hypothetical protein +FIG00473107 FIG00473108: hypothetical protein +FIG00473108 FIG00473110: hypothetical protein +FIG00473112 FIG00473113: hypothetical protein +FIG00473115 FIG00473116: hypothetical protein +FIG00473118 FIG00473119: hypothetical protein +FIG00473119 FIG00473120: hypothetical protein +FIG00473120 FIG00473121: hypothetical protein +FIG00473125 FIG00473127: hypothetical protein +FIG00473134 FIG00473135: hypothetical protein +FIG00473135 FIG00403304: hypothetical protein +FIG00473136 FIG00473137: hypothetical protein +FIG00473137 FIG00473138: hypothetical protein +FIG00473138 FIG00473139: hypothetical protein +FIG00473139 FIG00473140: hypothetical protein +FIG00473141 FIG00473142: hypothetical protein +FIG00473142 FIG00473144: hypothetical protein +FIG00473147 FIG00473148: hypothetical protein +FIG00473158 FIG00473159: hypothetical protein +FIG00473161 FIG00473162: hypothetical protein +FIG00473162 FIG00473163: hypothetical protein +FIG00473167 FIG00473168: hypothetical protein +FIG00473168 Dialkylrecorsinol condensing enzyme +FIG00473172 FIG00473173: hypothetical protein +FIG00473175 FIG00473177: hypothetical protein +FIG00473179 FIG00473180: hypothetical protein +FIG00473182 FIG00473183: hypothetical protein +FIG00473186 FIG00473187: hypothetical protein +FIG00473187 FIG00473188: hypothetical protein +FIG00473188 FIG00473189: hypothetical protein +FIG00473192 FIG00473193: hypothetical protein +FIG00473194 FIG00473195: hypothetical protein +FIG00473196 FIG00473198: hypothetical protein +FIG00473199 FIG00473200: hypothetical protein +FIG00473202 surface antigen BspA +FIG00473206 DNA polymerase III subunit gamma/tau +FIG00473208 FIG00473210: hypothetical protein +FIG00473210 FIG00473212: hypothetical protein +FIG00473216 FIG00473217: hypothetical protein +FIG00473217 FIG00473218: hypothetical protein +FIG00473218 FIG00473219: hypothetical protein +FIG00473219 FIG00473220: hypothetical protein +FIG00473221 FIG00473222: hypothetical protein +FIG00473223 FIG00473224: hypothetical protein +FIG00473224 FIG00473225: hypothetical protein +FIG00473225 FIG00473226: hypothetical protein +FIG00473226 FIG00473227: hypothetical protein +FIG00473227 FIG00473228: hypothetical protein +FIG00473228 FIG00473229: hypothetical protein +FIG00473229 FIG00473230: hypothetical protein +FIG00473231 FIG00473232: hypothetical protein +FIG00473232 FIG00473233: hypothetical protein +FIG00473237 FIG00473239: hypothetical protein +FIG00473239 FIG00473241: hypothetical protein +FIG00473248 FIG00473249: hypothetical protein +FIG00473249 FIG00473250: hypothetical protein +FIG00473252 FIG00473253: hypothetical protein +FIG00473254 FIG00473255: hypothetical protein +FIG00473256 FIG00473257: hypothetical protein +FIG00473259 FIG00473260: hypothetical protein +FIG00473261 FIG00473262: hypothetical protein +FIG00473263 FIG00473264: hypothetical protein +FIG00473264 FIG00473265: hypothetical protein +FIG00473265 FIG00473266: hypothetical protein +FIG00473267 FIG00473268: hypothetical protein +FIG00473270 FIG00473272: hypothetical protein +FIG00473272 FIG00473273: hypothetical protein +FIG00473337 CoB--CoM heterodisulfide reductase 2 iron-sulfur subunit D (EC 1.8.98.1) +FIG00473470 FIG00473472: hypothetical protein +FIG00473816 Polypeptide N-acetylgalactosaminyltransferase 8 (EC 2.4.1.41) +FIG00473854 FIG00473856: hypothetical protein +FIG00474135 integral membrane protein MviN +FIG00474174 Tungsten-containing aldehyde:ferredoxin oxidoreductase (EC 1.2.7.5) +FIG00474228 FIG00474239: hypothetical protein +FIG00474334 DedA family inner membrane protein YdjZ +FIG00474366 Putative zinc-binding dehydrogenase( EC:1.6.5.- ) +FIG00474642 possible transcriptional regulator, ArsR family +FIG00474664 FIG01126089: hypothetical protein +FIG00474668 FIG00474675: hypothetical protein +FIG00474682 FIG00474716: hypothetical protein +FIG00474902 Putative nitrile hydratase regulator clustered with urea transport +FIG00474989 FIG00821176: hypothetical protein +FIG00475103 ABC transporter integral membrane permease +FIG00475119 glucoamylase( EC:3.2.1.3 ) +FIG00475203 Endo-1,4-beta-xylanase A precursor (EC 3.2.1.8) +FIG00475217 Sugar ABC transporter, periplasmic binding protein +FIG00475620 PAS/PAC sensor signal transduction histidine kinase +FIG00475633 putative lyase +FIG00475778 binding protein dependent transport protein +FIG00476060 putative quinone reductase +FIG00476154 protein of unknown function DUF1254 +FIG00476163 probable sugar transporter membrane protein +FIG00476656 putative acyl-CoA dehydrogenase +FIG00476818 FIG01037614: hypothetical protein +FIG00476887 FIG00476951: hypothetical protein +FIG00477457 Esterase, PHB depolymerase precursor (EC 3.1.1.73) +FIG00477912 putative LuxAB-like Oxygenase +FIG00478152 conserved hypothetical protein( EC:3.2.1.55 ) +FIG00478413 putative ROK-family transcriptional regulator +FIG00478477 FIG01043484: hypothetical protein +FIG00479026 sigma factor, sigma 70 type, group 4 (ECF) +FIG00479660 Lanthionine biosynthesis protein LanB +FIG00479757 FIG00479770: hypothetical protein +FIG00479770 GlnR-family transcriptional regulator +FIG00479866 FIG00479870: hypothetical protein +FIG00479899 amylo-alpha-1,6-glucosidase +FIG00479922 FIG00479941: hypothetical protein +FIG00480039 GroES-family molecular chaperone +FIG00480234 FIG022199: FAD-binding protein +FIG00480382 FIG00480401: hypothetical protein +FIG00480522 neutral zinc metalloprotease +FIG00480581 FIG215594: Membrane spanning protein +FIG00480693 FIG00480694: hypothetical protein +FIG00480694 FIG00480695: hypothetical protein +FIG00480695 FIG00480696: hypothetical protein +FIG00480696 FIG00480697: hypothetical protein +FIG00480699 FIG00480701: hypothetical protein +FIG00480702 Peroxiredoxin +FIG00480709 FIG00480711: hypothetical protein +FIG00480711 FIG00480713: hypothetical protein +FIG00480714 flbE protein +FIG00480715 FIG00480716: hypothetical protein +FIG00480719 FIG00480720: hypothetical protein +FIG00480720 FIG00480722: hypothetical protein +FIG00480722 FIG00480723: hypothetical protein +FIG00480723 FIG00480724: hypothetical protein +FIG00480728 regulatory protein FlaEY +FIG00480732 FIG00480734: hypothetical protein +FIG00480734 FIG00480735: hypothetical protein +FIG00480736 FIG00480737: hypothetical protein +FIG00480737 FIG00480739: hypothetical protein +FIG00480741 FIG00480742: hypothetical protein +FIG00480742 FIG00480743: hypothetical protein +FIG00480743 FIG00480744: hypothetical protein +FIG00480744 FIG00480745: hypothetical protein +FIG00480745 FIG00480746: hypothetical protein +FIG00480747 ABC transporter, HlyB/MsbA family +FIG00480752 FIG00480755: hypothetical protein +FIG00480755 FIG00480758: hypothetical protein +FIG00480758 FIG00480759: hypothetical protein +FIG00480759 FIG00480760: hypothetical protein +FIG00480760 Tetratricopeptide TPR_1:Tetratricopeptide TPR_2 +FIG00480761 FIG00480764: hypothetical protein +FIG00480764 FIG00480766: hypothetical protein +FIG00480767 FIG00480768: hypothetical protein +FIG00480776 FIG00480777: hypothetical protein +FIG00480779 FIG00480780: hypothetical protein +FIG00480780 FIG00480783: hypothetical protein +FIG00480783 FIG00480784: hypothetical protein +FIG00480793 FIG00480794: hypothetical protein +FIG00480794 FIG00480797: hypothetical protein +FIG00480797 FIG00480798: hypothetical protein +FIG00480799 FIG00480802: hypothetical protein +FIG00480802 FIG00480804: hypothetical protein +FIG00480807 FIG00480808: hypothetical protein +FIG00480809 FIG00480811: hypothetical protein +FIG00480811 FIG00480812: hypothetical protein +FIG00480812 FIG00480813: hypothetical protein +FIG00480813 FIG00480814: hypothetical protein +FIG00480814 FIG00480818: hypothetical protein +FIG00480819 FIG00480822: hypothetical protein +FIG00480822 FIG00480823: hypothetical protein +FIG00480823 FIG00480825: hypothetical protein +FIG00480825 transcriptional regulator, internal deletion +FIG00480827 FIG00480828: hypothetical protein +FIG00480828 FIG00480830: hypothetical protein +FIG00480830 FIG00480831: hypothetical protein +FIG00480835 FIG00480836: hypothetical protein +FIG00480836 FIG00480837: hypothetical protein +FIG00480840 FIG00480841: hypothetical protein +FIG00480842 FIG00480843: hypothetical protein +FIG00480843 FIG00480844: hypothetical protein +FIG00480846 glutathione S-transferase, putative +FIG00480848 FIG00480851: hypothetical protein +FIG00480853 FIG00480854: hypothetical protein +FIG00480857 FIG00480858: hypothetical protein +FIG00480859 FIG00480860: hypothetical protein +FIG00480860 FIG00480861: hypothetical protein +FIG00480862 FIG00480864: hypothetical protein +FIG00480866 FIG00480867: hypothetical protein +FIG00480867 FIG00480868: hypothetical protein +FIG00480869 FIG00480871: hypothetical protein +FIG00480874 FIG00480875: hypothetical protein +FIG00480875 FIG00480876: hypothetical protein +FIG00480877 FIG00480878: hypothetical protein +FIG00480884 LysM domain / Lipoprotein NlpD +FIG00480890 membrane protein, MarC family protein +FIG00480891 FIG00480892: hypothetical protein +FIG00480892 FIG00480893: hypothetical protein +FIG00480895 FIG00480896: hypothetical protein +FIG00480896 FIG00480897: hypothetical protein +FIG00480898 FIG00480899: hypothetical protein +FIG00480905 FIG00480909: hypothetical protein +FIG00480914 FIG00480916: hypothetical protein +FIG00480917 FIG00480919: hypothetical protein +FIG00480919 FIG00480921: hypothetical protein +FIG00480922 chemotaxis protein cheYIII +FIG00480931 FIG00480932: hypothetical protein +FIG00480932 FIG00480934: hypothetical protein +FIG00480934 FIG00480935: hypothetical protein +FIG00480935 FIG00480936: hypothetical protein +FIG00480937 FIG00480941: hypothetical protein +FIG00480942 FIG00480944: hypothetical protein +FIG00480950 FIG00480951: hypothetical protein +FIG00480952 FIG00480953: hypothetical protein +FIG00480954 alkaline phosphatase D +FIG00480957 FIG00480959: hypothetical protein +FIG00480962 Flagellar FlaF +FIG00480964 FIG00480965: hypothetical protein +FIG00480970 FIG00480971: hypothetical protein +FIG00480974 FIG00480976: hypothetical protein +FIG00480976 FIG00480977: hypothetical protein +FIG00480977 FIG00480979: hypothetical protein +FIG00480979 FIG00480982: hypothetical protein +FIG00480982 FIG00480983: hypothetical protein +FIG00480987 FIG00480988: hypothetical protein +FIG00480988 FIG00480989: hypothetical protein +FIG00480989 FIG00480990: hypothetical protein +FIG00480990 FIG00480992: hypothetical protein +FIG00480996 FIG00480999: hypothetical protein +FIG00480999 FIG00481003: hypothetical protein +FIG00481004 COG2095: Multiple antibiotic transporter +FIG00481007 FIG00481014: hypothetical protein +FIG00481017 FIG00481018: hypothetical protein +FIG00481018 FIG00481019: hypothetical protein +FIG00481019 FIG00481022: hypothetical protein +FIG00481022 FIG00481024: hypothetical protein +FIG00481035 FIG00481037: hypothetical protein +FIG00481037 FIG00481039: hypothetical protein +FIG00481039 FIG00481043: hypothetical protein +FIG00481045 Aminotransferase class-III +FIG00481048 FIG00481050: hypothetical protein +FIG00481050 FIG00481051: hypothetical protein +FIG00481051 FIG00481052: hypothetical protein +FIG00481052 FIG00481053: hypothetical protein +FIG00481053 FIG00481055: hypothetical protein +FIG00481055 FIG00481062: hypothetical protein +FIG00481069 Beta-glucanase/Beta-glucan synthetase +FIG00481070 FIG00481071: hypothetical protein +FIG00481074 FIG00481075: hypothetical protein +FIG00481080 FIG00481082: hypothetical protein +FIG00481091 FIG00481093: hypothetical protein +FIG00481093 FIG00481097: hypothetical protein +FIG00481097 FIG00481098: hypothetical protein +FIG00481098 FIG00481100: hypothetical protein +FIG00481104 FIG00481105: hypothetical protein +FIG00481105 FIG00481109: hypothetical protein +FIG00481109 FIG00481111: hypothetical protein +FIG00481114 FIG00481115: hypothetical protein +FIG00481118 FIG00481119: hypothetical protein +FIG00481120 FIG00481128: hypothetical protein +FIG00481128 FIG00481131: hypothetical protein +FIG00481132 COG3533 secreted protein +FIG00481137 FIG00481138: hypothetical protein +FIG00481138 FIG00481142: hypothetical protein +FIG00481150 FIG00481151: hypothetical protein +FIG00481157 FIG00481159: hypothetical protein +FIG00481159 FIG00481161: hypothetical protein +FIG00481161 FIG00481162: hypothetical protein +FIG00481164 RTX toxins determinant A and related Ca2+-binding proteins +FIG00481168 FIG00481170: hypothetical protein +FIG00481177 FIG00481178: hypothetical protein +FIG00481186 FIG00481187: hypothetical protein +FIG00481188 FIG00481191: hypothetical protein +FIG00481191 sensory box histidine kinase, putative +FIG00481201 FIG00481202: hypothetical protein +FIG00481207 FIG00481210: hypothetical protein +FIG00481210 FIG00481211: hypothetical protein +FIG00481213 FIG00481216: hypothetical protein +FIG00481216 FIG00481219: hypothetical protein +FIG00481220 FIG00481222: hypothetical protein +FIG00481222 methyl-accepting chemotaxis protein McpB +FIG00481223 FIG00481228: hypothetical protein +FIG00481229 FIG00481231: hypothetical protein +FIG00481231 FIG00481235: hypothetical protein +FIG00481235 FIG00481236: hypothetical protein +FIG00481236 bll3749; probable carboxypeptidase G2 precursor (EC 3.4.17.11) +FIG00481237 FIG00481239: hypothetical protein +FIG00481247 FIG00481249: hypothetical protein +FIG00481249 chemotaxis protein CheYIII +FIG00481257 FIG00481260: hypothetical protein +FIG00481262 FIG00481264: hypothetical protein +FIG00481264 FIG00481266: hypothetical protein +FIG00481266 FIG00481269: hypothetical protein +FIG00481272 FIG00481273: hypothetical protein +FIG00481273 FIG00481275: hypothetical protein +FIG00481275 FIG00481276: hypothetical protein +FIG00481279 FIG00481280: hypothetical protein +FIG00481280 FIG00481281: hypothetical protein +FIG00481299 FIG00481300: hypothetical protein +FIG00481300 FIG00481301: hypothetical protein +FIG00481301 FIG00481302: hypothetical protein +FIG00481302 FIG00481306: hypothetical protein +FIG00481310 Transporter, membrane fusion protein (MFP) family +FIG00481314 beta/gamma crystallin family protein +FIG00481318 FIG00481319: hypothetical protein +FIG00481321 FIG00481326: hypothetical protein +FIG00481326 FIG00481327: hypothetical protein +FIG00481327 FIG00481331: hypothetical protein +FIG00481331 GcrA cell cycle regulator +FIG00481335 FIG00481336: hypothetical protein +FIG00481337 FIG00481338: hypothetical protein +FIG00481338 FIG00481339: hypothetical protein +FIG00481339 FIG00481340: hypothetical protein +FIG00481341 FIG00481344: hypothetical protein +FIG00481348 FIG00481350: hypothetical protein +FIG00481350 FIG00481351: hypothetical protein +FIG00481356 FIG00481357: hypothetical protein +FIG00481357 FIG00481358: hypothetical protein +FIG00481358 FIG00481359: hypothetical protein +FIG00481359 FIG00481360: hypothetical protein +FIG00481369 FIG00481370: hypothetical protein +FIG00481370 FIG00481371: hypothetical protein +FIG00481371 FIG00481372: hypothetical protein +FIG00481372 GumN +FIG00481373 3-demethylubiquinone-9 3-methyltransferase (EC 2.1.1.64) +FIG00481375 FIG00481376: hypothetical protein +FIG00481376 FIG00481381: hypothetical protein +FIG00481384 FIG00481388: hypothetical protein +FIG00481393 FIG00481398: hypothetical protein +FIG00481398 ParE toxin protein +FIG00481399 Acetoacetyl-CoA synthetase [leucine] (EC 6.2.1.16) +FIG00481403 FIG00481404: hypothetical protein +FIG00481405 FIG00481407: hypothetical protein +FIG00481407 FIG00481410: hypothetical protein +FIG00481410 FIG00481411: hypothetical protein +FIG00481411 FIG00481413: hypothetical protein +FIG00481413 FIG00481417: hypothetical protein +FIG00481417 FIG00481418: hypothetical protein +FIG00481418 FIG00481420: hypothetical protein +FIG00481420 FIG00481422: hypothetical protein +FIG00481435 FIG00481436: hypothetical protein +FIG00481439 FIG00481442: hypothetical protein +FIG00481442 FIG00481444: hypothetical protein +FIG00481444 FIG00481445: hypothetical protein +FIG00481445 FIG00481446: hypothetical protein +FIG00481447 putative intracellular PHB depolymerase +FIG00481449 FIG00481453: hypothetical protein +FIG00481456 FIG00481460: hypothetical protein +FIG00481460 glycosyl transferase, group 1 family protein LpsE +FIG00481463 FIG00481464: hypothetical protein +FIG00481464 FIG00481468: hypothetical protein +FIG00481471 FIG00481472: hypothetical protein +FIG00481473 FIG00481474: hypothetical protein +FIG00481474 FIG00481478: hypothetical protein +FIG00481480 FIG00481482: hypothetical protein +FIG00481482 FIG00481483: hypothetical protein +FIG00481483 FIG00481484: hypothetical protein +FIG00481492 tRNA 5-methylaminomethyl-2-thiouridine synthase TusA +FIG00481495 FIG00481497: hypothetical protein +FIG00481500 FIG010505: hypothetical protein +FIG00481504 FIG00481507: hypothetical protein +FIG00481507 FIG00481511: hypothetical protein +FIG00481511 FIG00481512: hypothetical protein +FIG00481513 FIG00481522: hypothetical protein +FIG00481522 FIG00481523: hypothetical protein +FIG00481523 FIG00481525: hypothetical protein +FIG00481529 FIG00481531: hypothetical protein +FIG00481531 FIG00481532: hypothetical protein +FIG00481532 FIG00481534: hypothetical protein +FIG00481535 FIG00481538: hypothetical protein +FIG00481540 FIG00481542: hypothetical protein +FIG00481543 FIG00481544: hypothetical protein +FIG00481545 FIG00481547: hypothetical protein +FIG00481553 FIG00481557: hypothetical protein +FIG00481558 FIG00481559: hypothetical protein +FIG00481559 FIG00481561: hypothetical protein +FIG00481565 FIG00481569: hypothetical protein +FIG00481570 Peptidase A2A, retrovirus, catalytic +FIG00481582 Gene Transfer Agent associated protein CC2787 +FIG00481586 FIG00481591: hypothetical protein +FIG00481592 FIG00481593: hypothetical protein +FIG00481598 FIG00481599: hypothetical protein +FIG00481599 Putative Zn-dependent protease, contains TPR repeats +FIG00481600 FIG00481601: hypothetical protein +FIG00481601 FIG00481602: hypothetical protein +FIG00481602 FIG00481604: hypothetical protein +FIG00481608 FIG00481610: hypothetical protein +FIG00481610 FIG00481611: hypothetical protein +FIG00481611 FIG00481612: hypothetical protein +FIG00481612 FIG00481613: hypothetical protein +FIG00481620 Probable lysozyme (EC 3.2.1.17) (Lysis protein) (Muramidase) (Endolysin) (P13) +FIG00481621 FIG00481622: hypothetical protein +FIG00481622 FIG00481630: hypothetical protein +FIG00481630 FIG00481635: hypothetical protein +FIG00481635 FIG00481636: hypothetical protein +FIG00481636 FIG00481637: hypothetical protein +FIG00481637 FIG00481638: hypothetical protein +FIG00481638 acyl-CoA dehydrogenase family protein +FIG00481640 FIG00481642: hypothetical protein +FIG00481642 flagellar basal-body protein FlbY +FIG00481648 FIG00481650: hypothetical protein +FIG00481650 1-acyl-sn-glycerol-3-phosphate acyltransferase (EC 2.3.1.51) +FIG00481652 methyl-accepting chemotaxis protein McpK +FIG00481654 Chemoreceptor mcpA (Methyl-accepting chemotaxis protein) +FIG00481658 FIG00481659: hypothetical protein +FIG00481665 FIG00481666: hypothetical protein +FIG00481666 FIG00481667: hypothetical protein +FIG00481670 FIG00481671: hypothetical protein +FIG00481671 FIG00481672: hypothetical protein +FIG00481674 FIG00481678: hypothetical protein +FIG00481679 FIG00481680: hypothetical protein +FIG00481680 Cell division protein FtsL +FIG00481682 FIG00481685: hypothetical protein +FIG00481687 FIG00481689: hypothetical protein +FIG00481689 FIG00481692: hypothetical protein +FIG00481692 FIG00481693: hypothetical protein +FIG00481693 FIG00481695: hypothetical protein +FIG00481695 FIG00481696: hypothetical protein +FIG00481696 FIG00481697: hypothetical protein +FIG00481705 FIG00481710: hypothetical protein +FIG00481710 FIG00481711: hypothetical protein +FIG00481712 FIG00481713: hypothetical protein +FIG00481713 FIG00481715: hypothetical protein +FIG00481718 FIG00481719: hypothetical protein +FIG00481723 FIG00481724: hypothetical protein +FIG00481729 FIG00481730: hypothetical protein +FIG00481730 FIG00481732: hypothetical protein +FIG00481734 FIG00481736: hypothetical protein +FIG00481736 Ubiquinol-cytochrome C chaperone +FIG00481743 FIG00481744: hypothetical protein +FIG00481746 FIG00481747: hypothetical protein +FIG00481747 FIG00481750: hypothetical protein +FIG00481751 FIG00481752: hypothetical protein +FIG00481754 FIG00481755: hypothetical protein +FIG00481755 FIG00481759: hypothetical protein +FIG00481760 FIG00481761: hypothetical protein +FIG00481763 FIG00481764: hypothetical protein +FIG00481764 FIG00481765: hypothetical protein +FIG00481765 FIG00481767: hypothetical protein +FIG00481767 negative regulator +FIG00481768 flagellin modification protein FlmH +FIG00481770 FIG00481771: hypothetical protein +FIG00481771 FIG00481773: hypothetical protein +FIG00481773 FIG00481774: hypothetical protein +FIG00481774 FIG00481779: hypothetical protein +FIG00481779 FIG00481780: hypothetical protein +FIG00481783 FIG00481784: hypothetical protein +FIG00481784 Gene Transfer Agent (GTA) ORFG08 +FIG00481787 FIG00481788: hypothetical protein +FIG00481788 FIG00481789: hypothetical protein +FIG00481789 FIG00481792: hypothetical protein +FIG00481792 FIG00481795: hypothetical protein +FIG00481800 FIG00481802: hypothetical protein +FIG00481802 FIG00481804: hypothetical protein +FIG00481805 FIG00481806: hypothetical protein +FIG00481813 FIG00481815: hypothetical protein +FIG00481817 FIG00481819: hypothetical protein +FIG00481820 FIG00481822: hypothetical protein +FIG00481822 FIG00481823: hypothetical protein +FIG00481825 FIG00481829: hypothetical protein +FIG00481829 Carboxylesterase, type B precursor +FIG00481830 FIG00481831: hypothetical protein +FIG00481832 FIG00481833: hypothetical protein +FIG00481841 cicA protein +FIG00481844 FIG00481846: hypothetical protein +FIG00481846 COG3866 Pectate lyase +FIG00481847 Ata8 protein +FIG00481858 FIG00481860: hypothetical protein +FIG00481860 FIG00481862: hypothetical protein +FIG00481863 FIG00481866: hypothetical protein +FIG00481866 Response regulator +FIG00481867 FIG00481871: hypothetical protein +FIG00481873 Restriction modification system DNA specificity domain +FIG00481877 FIG00481879: hypothetical protein +FIG00481879 FIG00481880: hypothetical protein +FIG00481880 FIG00481883: hypothetical protein +FIG00481883 FIG00481884: hypothetical protein +FIG00481884 FIG00481885: hypothetical protein +FIG00481889 FIG00481890: hypothetical protein +FIG00481890 FIG00481891: hypothetical protein +FIG00481891 HPr kinase/phosphatase-related protein +FIG00481894 FIG00481895: hypothetical protein +FIG00481895 FIG00481896: hypothetical protein +FIG00481899 FIG00481900: hypothetical protein +FIG00481901 FIG00481902: hypothetical protein +FIG00481902 FIG00481905: hypothetical protein +FIG00481905 FIG00481907: hypothetical protein +FIG00481909 FIG00481910: hypothetical protein +FIG00481910 FIG00481911: hypothetical protein +FIG00481911 FIG00481912: hypothetical protein +FIG00481912 FIG00481917: hypothetical protein +FIG00481922 FIG00481925: hypothetical protein +FIG00481925 proline imino-peptidase +FIG00481926 GcrA cell cycle regulator +FIG00481930 FIG00481931: hypothetical protein +FIG00481931 fliO protein +FIG00481936 FIG00481938: hypothetical protein +FIG00481938 FIG00481946: hypothetical protein +FIG00481946 FIG00481947: hypothetical protein +FIG00481955 FIG00481957: hypothetical protein +FIG00481957 FIG00481959: hypothetical protein +FIG00481959 FIG00481961: hypothetical protein +FIG00481961 FIG00481962: hypothetical protein +FIG00481964 FIG00481966: hypothetical protein +FIG00481966 FIG00481969: hypothetical protein +FIG00481969 FIG00481976: hypothetical protein +FIG00481976 FIG00481978: hypothetical protein +FIG00481978 FIG00481980: hypothetical protein +FIG00481983 FIG00985688: hypothetical protein +FIG00481986 FIG00481987: hypothetical protein +FIG00481987 FIG00481989: hypothetical protein +FIG00481989 FIG00481990: hypothetical protein +FIG00481994 FIG00481998: hypothetical protein +FIG00482002 FIG00482008: hypothetical protein +FIG00482012 FIG00482013: hypothetical protein +FIG00482013 FIG00482014: hypothetical protein +FIG00482014 FIG00482015: hypothetical protein +FIG00482018 FIG00482020: hypothetical protein +FIG00482021 FIG00482027: hypothetical protein +FIG00482027 FIG00482029: hypothetical protein +FIG00482029 FIG00482031: hypothetical protein +FIG00482031 FIG00482034: hypothetical protein +FIG00482036 FIG00482041: hypothetical protein +FIG00482042 FIG00482045: hypothetical protein +FIG00482050 FIG00482053: hypothetical protein +FIG00482056 FIG00482058: hypothetical protein +FIG00482058 FIG00482060: hypothetical protein +FIG00482060 FIG00482062: hypothetical protein +FIG00482062 FIG00482063: hypothetical protein +FIG00482063 FIG00482064: hypothetical protein +FIG00482064 FIG00482069: hypothetical protein +FIG00482071 FIG00482072: hypothetical protein +FIG00482073 FIG00482075: hypothetical protein +FIG00482075 FIG00482076: hypothetical protein +FIG00482076 FIG00482077: hypothetical protein +FIG00482077 FIG00482078: hypothetical protein +FIG00482078 FIG00482081: hypothetical protein +FIG00482081 FIG00482083: hypothetical protein +FIG00482084 FIG00482085: hypothetical protein +FIG00482087 FIG00482091: hypothetical protein +FIG00482099 FIG00482106: hypothetical protein +FIG00482106 FIG00482108: hypothetical protein +FIG00482110 FIG00482114: hypothetical protein +FIG00482115 FIG00482117: hypothetical protein +FIG00482117 FIG00482118: hypothetical protein +FIG00482118 FIG00482119: hypothetical protein +FIG00482120 FIG00482123: hypothetical protein +FIG00482123 FIG00482126: hypothetical protein +FIG00482126 FIG00482127: hypothetical protein +FIG00482127 FIG00482128: hypothetical protein +FIG00482128 FIG00482130: hypothetical protein +FIG00482139 FIG00482141: hypothetical protein +FIG00482142 FIG00482144: hypothetical protein +FIG00482144 FIG00482145: hypothetical protein +FIG00482145 FIG00482146: hypothetical protein +FIG00482146 FIG00482148: hypothetical protein +FIG00482148 Gll4423 protein +FIG00482154 FIG00482157: hypothetical protein +FIG00482163 FIG00482164: hypothetical protein +FIG00482164 FIG00482165: hypothetical protein +FIG00482169 FIG00482170: hypothetical protein +FIG00482170 FIG00482172: hypothetical protein +FIG00482174 FIG00482178: hypothetical protein +FIG00482178 FIG00482182: hypothetical protein +FIG00482185 FIG00482186: hypothetical protein +FIG00482187 FIG00482188: hypothetical protein +FIG00482189 FIG00482190: hypothetical protein +FIG00482193 FIG00482194: hypothetical protein +FIG00482194 NnrU +FIG00482195 Non-motile and phage-resistance protein (EC 2.7.13.3) +FIG00482199 FIG00482200: hypothetical protein +FIG00482203 FIG00482206: hypothetical protein +FIG00482207 flagellin modification protein, putative +FIG00482214 alkaline metalloproteinase, putative +FIG00482215 FIG00482216: hypothetical protein +FIG00482216 FIG00482217: hypothetical protein +FIG00482219 COG1872 +FIG00482225 FIG00482226: hypothetical protein +FIG00482226 FIG00482227: hypothetical protein +FIG00482227 FIG00482230: hypothetical protein +FIG00482230 FIG00482231: hypothetical protein +FIG00482233 DTDP-6-deoxy-L-hexose 3-O-methyltransferase +FIG00482246 FIG00482247: hypothetical protein +FIG00482247 FIG00482248: hypothetical protein +FIG00482249 ABC transporter permease protein +FIG00482252 FIG00482253: hypothetical protein +FIG00482253 FIG00482256: hypothetical protein +FIG00482256 FIG00482257: hypothetical protein +FIG00482267 FIG00482271: hypothetical protein +FIG00482271 FIG00482272: hypothetical protein +FIG00482276 FIG00482278: hypothetical protein +FIG00482278 FIG00482279: hypothetical protein +FIG00482279 FIG00482280: hypothetical protein +FIG00482286 FIG00482289: hypothetical protein +FIG00482290 FIG00482291: hypothetical protein +FIG00482291 FIG00482293: hypothetical protein +FIG00482302 FIG00482303: hypothetical protein +FIG00482304 FIG00482307: hypothetical protein +FIG00482307 Major capsid protein, HK97 family +FIG00482309 FIG00482310: hypothetical protein +FIG00482319 FIG00482322: hypothetical protein +FIG00482322 Nickel and cobalt resistance protein cnrR precursor +FIG00482325 FIG00482326: hypothetical protein +FIG00482332 FIG00482334: hypothetical protein +FIG00482334 FIG00482337: hypothetical protein +FIG00482340 FIG00482342: hypothetical protein +FIG00482344 FIG00482348: hypothetical protein +FIG00482350 FIG00482351: hypothetical protein +FIG00482354 FIG00482357: hypothetical protein +FIG00482358 FIG00482362: hypothetical protein +FIG00482362 FIG00482363: hypothetical protein +FIG00482364 ribonuclease T2 family protein +FIG00482365 DNA invertase, putative +FIG00482370 FIG00482371: hypothetical protein +FIG00482375 Non-hemolytic phospholipase C +FIG00482378 FIG00482380: hypothetical protein +FIG00482383 Gll2284 protein +FIG00482384 FIG00482386: hypothetical protein +FIG00482386 FIG00482387: hypothetical protein +FIG00482391 FIG00482397: hypothetical protein +FIG00482398 FIG00482399: hypothetical protein +FIG00482399 Rieske 2Fe-2S domain protein +FIG00482405 FIG00482406: hypothetical protein +FIG00482406 FIG00482415: hypothetical protein +FIG00482416 two-component response regulator, KdpE +FIG00482417 FIG00482421: hypothetical protein +FIG00482424 Protein of unknown function DUF1109 +FIG00482430 FIG00482431: hypothetical protein +FIG00482431 FIG00482433: hypothetical protein +FIG00482441 FIG00482442: hypothetical protein +FIG00482445 FIG00482446: hypothetical protein +FIG00482446 Acylneuraminate cytidylyltransferase +FIG00482447 FIG00482449: hypothetical protein +FIG00482449 FIG00482450: hypothetical protein +FIG00482450 FIG00482452: hypothetical protein +FIG00482452 FIG00482456: hypothetical protein +FIG00482456 FIG00482457: hypothetical protein +FIG00482458 FIG00482459: hypothetical protein +FIG00482459 FIG00482463: hypothetical protein +FIG00482464 FIG00482466: hypothetical protein +FIG00482466 FIG00482473: hypothetical protein +FIG00482475 FIG00482480: hypothetical protein +FIG00482480 FIG00482484: hypothetical protein +FIG00482489 FIG00482491: hypothetical protein +FIG00482491 FIG00482492: hypothetical protein +FIG00482494 FIG00482495: hypothetical protein +FIG00482496 FIG00482497: hypothetical protein +FIG00482497 FIG00482498: hypothetical protein +FIG00482498 FIG00482500: hypothetical protein +FIG00482503 FIG00482504: hypothetical protein +FIG00482504 FIG00482506: hypothetical protein +FIG00482506 cytochrome C6 +FIG00482520 FIG00482521: hypothetical protein +FIG00482521 FIG00482522: hypothetical protein +FIG00482522 FIG00482524: hypothetical protein +FIG00482525 FIG00482531: hypothetical protein +FIG00482531 FIG00482532: hypothetical protein +FIG00482532 FIG00482534: hypothetical protein +FIG00482538 FIG00482539: hypothetical protein +FIG00482539 FIG00482542: hypothetical protein +FIG00482542 FIG00482544: hypothetical protein +FIG00482547 FIG00482552: hypothetical protein +FIG00482552 FIG00482554: hypothetical protein +FIG00482554 FIG00482557: hypothetical protein +FIG00482557 Carboxylesterase type B +FIG00482562 PsbAd protein +FIG00482566 FIG00482569: hypothetical protein +FIG00482569 FIG00482572: hypothetical protein +FIG00482580 FIG00482581: hypothetical protein +FIG00482581 FIG00482582: hypothetical protein +FIG00482590 FIG00482592: hypothetical protein +FIG00482601 FIG00482602: hypothetical protein +FIG00482608 FIG00482611: hypothetical protein +FIG00482612 FIG00482622: hypothetical protein +FIG00482622 FIG00482624: hypothetical protein +FIG00482628 2-hydroxymuconic semialdehyde hydrolase (EC 3.1.1.-) +FIG00482632 FIG00482633: hypothetical protein +FIG00482656 FIG00482658: hypothetical protein +FIG00482658 FIG00482660: hypothetical protein +FIG00482670 FIG00482673: hypothetical protein +FIG00482678 Probable intracellular septation protein +FIG00482680 FIG00482681: hypothetical protein +FIG00482681 FIG00482682: hypothetical protein +FIG00482689 FIG00482692: hypothetical protein +FIG00482692 FIG00482696: hypothetical protein +FIG00482697 FIG00482698: hypothetical protein +FIG00482705 FIG00482706: hypothetical protein +FIG00482708 FIG00482710: hypothetical protein +FIG00482710 FIG00482711: hypothetical protein +FIG00482711 M20/M25/M40 family peptidase +FIG00482723 FIG00482724: hypothetical protein +FIG00482724 FIG00482728: hypothetical protein +FIG00482728 FIG00482729: hypothetical protein +FIG00482729 FIG00482732: hypothetical protein +FIG00482739 FIG00482742: hypothetical protein +FIG00482742 FIG00482751: hypothetical protein +FIG00482751 FIG00482753: hypothetical protein +FIG00482763 FIG00482764: hypothetical protein +FIG00482764 FIG00482765: hypothetical protein +FIG00482768 Bll5454 protein +FIG00482782 FIG00482784: hypothetical protein +FIG00482785 FIG00482786: hypothetical protein +FIG00482786 FIG00482787: hypothetical protein +FIG00482790 FIG00482791: hypothetical protein +FIG00482791 FIG00482792: hypothetical protein +FIG00482799 transcriptional regulator, MerR family +FIG00482800 FIG00482801: hypothetical protein +FIG00482818 FIG00482821: hypothetical protein +FIG00482825 FIG00482826: hypothetical protein +FIG00482826 FIG00482831: hypothetical protein +FIG00482834 FIG00482839: hypothetical protein +FIG00482842 FIG00482844: hypothetical protein +FIG00482844 FIG00482846: hypothetical protein +FIG00482846 FIG00482847: hypothetical protein +FIG00482860 FIG00482862: hypothetical protein +FIG00482870 FIG00482872: hypothetical protein +FIG00482872 FIG00482873: hypothetical protein +FIG00482873 FIG00482874: hypothetical protein +FIG00482874 FIG00482875: hypothetical protein +FIG00482876 FIG00482877: hypothetical protein +FIG00482877 Death on curing protein, Doc toxin +FIG00482881 FIG00482883: hypothetical protein +FIG00482890 Ribonuclease Z (EC 3.1.26.11) (RNase Z) (tRNase Z) (tRNA 3 endonuclease) +FIG00482891 VacJ-like lipoprotein +FIG00482892 FIG00482893: hypothetical protein +FIG00482899 FIG00482902: hypothetical protein +FIG00482902 FIG00482903: hypothetical protein +FIG00482903 FIG00482909: hypothetical protein +FIG00482911 FIG00482913: hypothetical protein +FIG00482914 FIG00482919: hypothetical protein +FIG00482920 conserved phage mega protein +FIG00482922 FIG00482925: hypothetical protein +FIG00482925 FIG00482926: hypothetical protein +FIG00482926 FIG00482928: hypothetical protein +FIG00482931 FIG00482934: hypothetical protein +FIG00482938 FIG00482940: hypothetical protein +FIG00482944 FIG00482946: hypothetical protein +FIG00482948 FIG00482949: hypothetical protein +FIG00482952 FIG00482954: hypothetical protein +FIG00482954 FIG00482961: hypothetical protein +FIG00482961 Protein of unknown function DUF1130 +FIG00482962 FIG00482968: hypothetical protein +FIG00482968 FIG00482970: hypothetical protein +FIG00482971 FIG00482972: hypothetical protein +FIG00482975 FIG00482976: hypothetical protein +FIG00482976 FIG00482977: hypothetical protein +FIG00482990 FIG00482992: hypothetical protein +FIG00482992 FIG00482993: hypothetical protein +FIG00482993 FIG00483002: hypothetical protein +FIG00483002 FIG00483005: hypothetical protein +FIG00483005 FIG00483006: hypothetical protein +FIG00483006 FIG00483008: hypothetical protein +FIG00483009 FIG00483010: hypothetical protein +FIG00483010 FIG00483011: hypothetical protein +FIG00483011 FIG00483013: hypothetical protein +FIG00483017 FIG00483019: hypothetical protein +FIG00483019 FIG00483020: hypothetical protein +FIG00483021 Bll4788 protein +FIG00483022 FIG00483023: hypothetical protein +FIG00483023 FIG00483030: hypothetical protein +FIG00483037 FIG00483042: hypothetical protein +FIG00483043 FIG00483044: hypothetical protein +FIG00483044 FIG00483045: hypothetical protein +FIG00483048 chemotaxis protein CheYI +FIG00483049 FIG00483051: hypothetical protein +FIG00483056 FIG00483058: hypothetical protein +FIG00483060 FIG00483061: hypothetical protein +FIG00483061 FIG00483063: hypothetical protein +FIG00483063 FIG00483066: hypothetical protein +FIG00483078 Sigma-70 region 2:Sigma-70 region 4:Sigma-70, region 4 type 2 +FIG00483081 FIG00483084: hypothetical protein +FIG00483085 FIG00483086: hypothetical protein +FIG00483087 FIG00483090: hypothetical protein +FIG00483093 FIG00483101: hypothetical protein +FIG00483101 FIG00483103: hypothetical protein +FIG00483103 FIG00483105: hypothetical protein +FIG00483105 FIG00483106: hypothetical protein +FIG00483109 FIG00483113: hypothetical protein +FIG00483115 FIG00483120: hypothetical protein +FIG00483123 FIG00483131: hypothetical protein +FIG00483131 FIG00483132: hypothetical protein +FIG00483132 FIG00483133: hypothetical protein +FIG00483133 FIG00483134: hypothetical protein +FIG00483135 FIG00483136: hypothetical protein +FIG00483136 FIG00483140: hypothetical protein +FIG00483140 FIG00483142: hypothetical protein +FIG00483142 FIG00483143: hypothetical protein +FIG00483143 FIG00483145: hypothetical protein +FIG00483145 FIG00483146: hypothetical protein +FIG00483146 FIG00483151: hypothetical protein +FIG00483151 FIG00483153: hypothetical protein +FIG00483156 FIG00483161: hypothetical protein +FIG00483161 FIG00483162: hypothetical protein +FIG00483162 FIG00483163: hypothetical protein +FIG00483164 FIG00483168: hypothetical protein +FIG00483170 FIG00483173: hypothetical protein +FIG00483173 Membrane protein of unknown function +FIG00483198 FIG00483200: hypothetical protein +FIG00483205 FIG00483207: hypothetical protein +FIG00483207 FIG00483208: hypothetical protein +FIG00483208 FIG00483209: hypothetical protein +FIG00483209 Gene Transfer Agent host specificity protein +FIG00483217 FIG00483221: hypothetical protein +FIG00483221 FIG00483222: hypothetical protein +FIG00483225 FIG00483227: hypothetical protein +FIG00483227 FIG00483230: hypothetical protein +FIG00483233 FIG00483235: hypothetical protein +FIG00483235 YghA protein +FIG00483242 FIG00483243: hypothetical protein +FIG00483259 FIG00483260: hypothetical protein +FIG00483271 FIG00483272: hypothetical protein +FIG00483274 hfaA protein +FIG00483278 acylase, putative +FIG00483285 FIG00483289: hypothetical protein +FIG00483294 FIG00483295: hypothetical protein +FIG00483295 FIG00483297: hypothetical protein +FIG00483297 FIG00483299: hypothetical protein +FIG00483308 Possible glycosyltransferase WbpX (EC 2.4.1.-) +FIG00483315 FIG00483317: hypothetical protein +FIG00483335 FIG00483338: hypothetical protein +FIG00483343 FIG00483344: hypothetical protein +FIG00483345 FIG00483346: hypothetical protein +FIG00483347 FIG00483355: hypothetical protein +FIG00483358 FIG00483359: hypothetical protein +FIG00483367 Bll7628 protein +FIG00483369 FIG00483371: hypothetical protein +FIG00483372 FIG00483373: hypothetical protein +FIG00483373 FIG00483376: hypothetical protein +FIG00483389 FIG00483392: hypothetical protein +FIG00483392 L-O-lysylphosphatidylglycerol synthase (EC 2.3.2.3) +FIG00483399 FIG00483400: hypothetical protein +FIG00483400 FIG00483402: hypothetical protein +FIG00483402 SAM dependent methyltransferase +FIG00483415 FIG00483416: hypothetical protein +FIG00483420 FIG00483421: hypothetical protein +FIG00483424 Succinoglycan biosynthesis protein exoA (EC 2.-.-.-) +FIG00483440 FIG00483441: hypothetical protein +FIG00483442 FIG00350678: hypothetical protein +FIG00483443 FIG00483445: hypothetical protein +FIG00483448 FIG00483452: hypothetical protein +FIG00483462 Surface polysaccharide biosynthesis protein, possible cytidylyltransferase +FIG00483469 FIG00483471: hypothetical protein +FIG00483471 FIG00483472: hypothetical protein +FIG00483495 FIG00483500: hypothetical protein +FIG00483504 FIG00483510: hypothetical protein +FIG00483510 FIG00483511: hypothetical protein +FIG00483511 FIG00483512: hypothetical protein +FIG00483515 FIG00483516: hypothetical protein +FIG00483519 FIG00483522: hypothetical protein +FIG00483525 FIG00483529: hypothetical protein +FIG00483530 FIG00483534: hypothetical protein +FIG00483534 FIG00483538: hypothetical protein +FIG00483540 FIG00483541: hypothetical protein +FIG00483541 FIG00483545: hypothetical protein +FIG00483546 FIG00483548: hypothetical protein +FIG00483550 FIG00483555: hypothetical protein +FIG00483557 FIG00483561: hypothetical protein +FIG00483565 FIG00483566: hypothetical protein +FIG00483570 FIG00483571: hypothetical protein +FIG00483573 FIG00483574: hypothetical protein +FIG00483574 FIG00483579: hypothetical protein +FIG00483580 FIG00483583: hypothetical protein +FIG00483595 FIG00483597: hypothetical protein +FIG00483615 FIG00483616: hypothetical protein +FIG00483616 amidase-related protein +FIG00483620 FIG00483625: hypothetical protein +FIG00483632 FIG00483637: hypothetical protein +FIG00483641 ferredoxin, Rieske 2Fe-2S family +FIG00483644 FIG00483648: hypothetical protein +FIG00483648 FIG00483650: hypothetical protein +FIG00483650 FIG00483651: hypothetical protein +FIG00483659 Replication protein A +FIG00483663 FIG00483664: hypothetical protein +FIG00483665 FIG00483667: hypothetical protein +FIG00483669 FIG00483671: hypothetical protein +FIG00483672 FIG00483676: hypothetical protein +FIG00483676 FIG00483682: hypothetical protein +FIG00483682 FIG00483683: hypothetical protein +FIG00483688 FIG00483690: hypothetical protein +FIG00483695 FIG00483696: hypothetical protein +FIG00483702 FIG00483704: hypothetical protein +FIG00483714 FIG00483725: hypothetical protein +FIG00483726 FIG00483728: hypothetical protein +FIG00483737 Xaa-Pro dipeptidase family enzyme +FIG00483740 FIG00483741: hypothetical protein +FIG00483741 FIG00483742: hypothetical protein +FIG00483745 FIG00483746: hypothetical protein +FIG00483746 FIG00483747: hypothetical protein +FIG00483752 FIG00483759: hypothetical protein +FIG00483765 FIG00483766: hypothetical protein +FIG00483782 FIG00483786: hypothetical protein +FIG00483786 FIG00483787: hypothetical protein +FIG00483787 FIG00483788: hypothetical protein +FIG00483790 FIG00483792: hypothetical protein +FIG00483795 sialic acid-specific 9-O-acetylesterase, putative +FIG00483806 FIG00483808: hypothetical protein +FIG00483808 FIG00483809: hypothetical protein +FIG00483835 FIG00483841: hypothetical protein +FIG00483846 FIG00483847: hypothetical protein +FIG00483847 Modification methylase +FIG00483854 FIG00483861: hypothetical protein +FIG00483877 FIG00483881: hypothetical protein +FIG00483881 FIG00483888: hypothetical protein +FIG00483891 FIG00483892: hypothetical protein +FIG00483892 FIG00483893: hypothetical protein +FIG00483899 FIG00483900: hypothetical protein +FIG00483909 FIG00483917: hypothetical protein +FIG00483944 FIG00483945: hypothetical protein +FIG00483945 FIG00483947: hypothetical protein +FIG00483948 glucose-fructose oxidoreductase +FIG00483950 FIG00483952: hypothetical protein +FIG00483953 FIG00483959: hypothetical protein +FIG00483965 FIG00483968: hypothetical protein +FIG00483979 FIG00483981: hypothetical protein +FIG00483983 FIG00483985: hypothetical protein +FIG00483989 FIG00483994: hypothetical protein +FIG00483998 Uncharacterized conserved small protein +FIG00484002 Glycosyl transferase, family 39 +FIG00484003 FIG00484004: hypothetical protein +FIG00484013 FIG00484014: hypothetical protein +FIG00484014 FIG00484016: hypothetical protein +FIG00484016 FIG00484017: hypothetical protein +FIG00484017 FIG00484020: hypothetical protein +FIG00484021 FIG00484024: hypothetical protein +FIG00484024 FIG00484025: hypothetical protein +FIG00484030 FIG00484033: hypothetical protein +FIG00484033 FIG00484038: hypothetical protein +FIG00484039 FIG00484044: hypothetical protein +FIG00484044 FIG00484046: hypothetical protein +FIG00484050 FIG00484051: hypothetical protein +FIG00484051 FIG00484054: hypothetical protein +FIG00484064 FIG00484065: hypothetical protein +FIG00484068 mannosyltransferase A (mtfA) +FIG00484069 FIG00484070: hypothetical protein +FIG00484073 FIG00484081: hypothetical protein +FIG00484083 FIG00484085: hypothetical protein +FIG00484091 FIG00484094: hypothetical protein +FIG00484094 FIG00484097: hypothetical protein +FIG00484097 FIG00484107: hypothetical protein +FIG00484107 FIG00484108: hypothetical protein +FIG00484112 FIG00484114: hypothetical protein +FIG00484127 FIG00484132: hypothetical protein +FIG00484150 glucose/galactose transporter +FIG00484154 FIG00484157: hypothetical protein +FIG00484187 FIG00484190: hypothetical protein +FIG00484197 FIG00484201: hypothetical protein +FIG00484201 FIG00484202: hypothetical protein +FIG00484220 FIG00484225: hypothetical protein +FIG00484239 FIG00484243: hypothetical protein +FIG00484265 FIG00484269: hypothetical protein +FIG00484269 FIG00484270: hypothetical protein +FIG00484285 FIG00484288: hypothetical protein +FIG00484304 FIG00484305: hypothetical protein +FIG00484305 FIG00484309: hypothetical protein +FIG00484311 FIG00484315: hypothetical protein +FIG00484328 FIG00484331: hypothetical protein +FIG00484331 FIG00484335: hypothetical protein +FIG00484348 FIG00484353: hypothetical protein +FIG00484356 FIG00484358: hypothetical protein +FIG00484370 FIG00484371: hypothetical protein +FIG00484373 FIG00484384: hypothetical protein +FIG00484419 Mlr5326 protein +FIG00484443 FIG00484448: hypothetical protein +FIG00484450 FIG00484453: hypothetical protein +FIG00484453 FIG00484454: hypothetical protein +FIG00484477 FIG00484479: hypothetical protein +FIG00484483 VapB family protein +FIG00484486 FIG00484488: hypothetical protein +FIG00484500 FIG00484509: hypothetical protein +FIG00484601 FIG00484608: hypothetical protein +FIG00484618 FIG00484640: hypothetical protein +FIG00484657 FIG002343: hypothetical protein +FIG00484682 FIG00484683: hypothetical protein +FIG00484705 FIG00484707: hypothetical protein +FIG00484707 FIG00484719: hypothetical protein +FIG00484719 FIG00484733: hypothetical protein +FIG00484733 FIG00484737: hypothetical protein +FIG00484740 hit family protein +FIG00484745 FIG00484759: hypothetical protein +FIG00484759 FIG00484777: hypothetical protein +FIG00484777 FIG00484780: hypothetical protein +FIG00484780 FIG00484782: hypothetical protein +FIG00484811 FIG00484821: hypothetical protein +FIG00484821 putative undecaprenyl-phosphate sugar phosphotransferase +FIG00484840 FIG00484847: hypothetical protein +FIG00484847 FIG00484853: hypothetical protein +FIG00484853 FIG00484860: hypothetical protein +FIG00484860 Probable cytochrome c oxidase polypeptide 4 (EC 1.9.3.1) +FIG00484868 FIG00484881: hypothetical protein +FIG00484881 FIG00484888: hypothetical protein +FIG00484888 FIG00484889: hypothetical protein +FIG00484889 FIG00484897: hypothetical protein +FIG00484897 FIG00484908: hypothetical protein +FIG00484915 FIG00484920: hypothetical protein +FIG00484935 FIG00484939: hypothetical protein +FIG00484939 FIG00484952: hypothetical protein +FIG00484952 FIG00484968: hypothetical protein +FIG00484969 FIG004853: possible toxin to DivIC +FIG00484988 FIG00484990: hypothetical protein +FIG00484990 FIG00484993: hypothetical protein +FIG00484993 Exoenzymes regulatory protein AepA precursor +FIG00485039 FIG00485041: hypothetical protein +FIG00485041 FIG00485059: hypothetical protein +FIG00485065 Peptidase M20D, amidohydrolase (EC 3.5.1.14) +FIG00485070 FIG00485087: hypothetical protein +FIG00485087 FIG00485089: hypothetical protein +FIG00485089 FIG00485100: hypothetical protein +FIG00485116 FIG00485125: hypothetical protein +FIG00485125 FIG00485126: hypothetical protein +FIG00485126 FIG00485138: hypothetical protein +FIG00485138 FIG00485171: hypothetical protein +FIG00485181 PTS system, glucose-specific component( EC:2.7.1.69 ) +FIG00485194 Cell division protein DivIC (FtsB), stabilizes FtsL against RasP cleavage +FIG00485214 FIG00485225: hypothetical protein +FIG00485225 FIG00485240: hypothetical protein +FIG00485244 predicted Co/Zn/Cd cation transporter +FIG00485260 FIG00485261: hypothetical protein +FIG00485270 FIG00485276: hypothetical protein +FIG00485276 FIG00485277: hypothetical protein +FIG00485297 FIG00485305: hypothetical protein +FIG00485323 FIG00485329: hypothetical protein +FIG00485335 FIG00485343: hypothetical protein +FIG00485357 FIG00485359: hypothetical protein +FIG00485361 Bifunctional xylanase/deacetylase precursor [Includes: Endo-1,4-beta-xylanase D (EC 3.2.1.8) (Xylanase D) (XYLD); Acetylated xylan deacetylase (EC 3.5.1.-)] +FIG00485370 FIG00485378: hypothetical protein +FIG00485378 FIG00485388: hypothetical protein +FIG00485388 FIG00485403: hypothetical protein +FIG00485403 FIG00485408: hypothetical protein +FIG00485413 FIG00485416: hypothetical protein +FIG00485434 FIG00485443: hypothetical protein +FIG00485455 FIG00485468: hypothetical protein +FIG00485468 FIG00485469: hypothetical protein +FIG00485469 FIG00485474: hypothetical protein +FIG00485493 FIG00485499: hypothetical protein +FIG00485509 FIG00485525: hypothetical protein +FIG00485525 FIG00485527: hypothetical protein +FIG00485528 FIG00485531: hypothetical protein +FIG00485531 FIG00485535: hypothetical protein +FIG00485535 FIG00485537: hypothetical protein +FIG00485540 FIG008913: Membrane-associated phospholipid phosphatase +FIG00485563 FIG00485564: hypothetical protein +FIG00485564 FIG00485576: hypothetical protein +FIG00485576 FIG00485582: hypothetical protein +FIG00485582 similar to Methylase of polypeptide chain release factors +FIG00485617 FIG00485619: hypothetical protein +FIG00485624 FIG00485632: hypothetical protein +FIG00485661 FIG00485666: hypothetical protein +FIG00485666 FIG00485671: hypothetical protein +FIG00485671 FIG00485690: hypothetical protein +FIG00485690 FIG00485721: hypothetical protein +FIG00485721 FIG00485738: hypothetical protein +FIG00485738 FIG00485739: hypothetical protein +FIG00485739 FIG00485745: hypothetical protein +FIG00485745 FIG00485748: hypothetical protein +FIG00485748 similar to UDP-N-acetylglucosamine:LPS N-acetylglucosamine transferase +FIG00485749 FIG00485750: hypothetical protein +FIG00485750 FIG00485756: hypothetical protein +FIG00485756 FIG00485771: hypothetical protein +FIG00485778 FIG00485794: hypothetical protein +FIG00485800 FIG00485822: hypothetical protein +FIG00485825 FIG00485849: hypothetical protein +FIG00485853 FIG00485854: hypothetical protein +FIG00485863 ABC transporter, ATP-binding subunit +FIG00485866 FIG00485872: hypothetical protein +FIG00485873 FIG00485881: hypothetical protein +FIG00485881 FIG00485885: hypothetical protein +FIG00485890 FIG00820327: hypothetical protein +FIG00485909 FIG00485912: hypothetical protein +FIG00485931 FIG00485941: hypothetical protein +FIG00485974 FIG00485975: hypothetical protein +FIG00485977 FIG00485988: hypothetical protein +FIG00485988 FIG00485992: hypothetical protein +FIG00485992 FIG00485995: hypothetical protein +FIG00485995 Nucleoside ABC transporter, periplasmic nucleoside-binding protein +FIG00485996 FIG00486000: hypothetical protein +FIG00486000 FIG00486001: hypothetical protein +FIG00486001 Larval mesenchyme specific protein +FIG00486016 FIG00486023: hypothetical protein +FIG00486023 COG1264: Phosphotransferase system IIB components +FIG00486061 FIG00486062: hypothetical protein +FIG00486062 FIG00486075: hypothetical protein +FIG00486075 FIG00486116: hypothetical protein +FIG00486116 FIG00486128: hypothetical protein +FIG00486128 FIG00486133: hypothetical protein +FIG00486133 FIG00486137: hypothetical protein +FIG00486137 FIG00486146: hypothetical protein +FIG00486146 FIG00486156: hypothetical protein +FIG00486158 FIG00486162: hypothetical protein +FIG00486185 FIG00486188: hypothetical protein +FIG00486189 FIG00486198: hypothetical protein +FIG00486198 FIG00486201: hypothetical protein +FIG00486202 FIG00486206: hypothetical protein +FIG00486212 FIG00486215: hypothetical protein +FIG00486223 FIG00486224: hypothetical protein +FIG00486224 FIG00486226: hypothetical protein +FIG00486230 FIG00486237: hypothetical protein +FIG00486279 FIG00486292: hypothetical protein +FIG00486292 FIG00486303: hypothetical protein +FIG00486327 FIG00486333: hypothetical protein +FIG00486333 FIG00486335: hypothetical protein +FIG00486370 FIG00486397: hypothetical protein +FIG00486416 FIG00486419: hypothetical protein +FIG00486445 FIG00486446: hypothetical protein +FIG00486447 FIG00486468: hypothetical protein +FIG00486468 FIG00486482: hypothetical protein +FIG00486482 FIG00486501: hypothetical protein +FIG00486501 Osmosensitive K+ channel histidine kinase kdpD (EC 2.7.3.-) +FIG00486540 FIG00486560: hypothetical protein +FIG00486560 FIG00486562: hypothetical protein +FIG00486562 FIG00486563: hypothetical protein +FIG00486563 FIG00486570: hypothetical protein +FIG00486570 FIG00486585: hypothetical protein +FIG00486585 FIG00486589: hypothetical protein +FIG00486589 FIG00486599: hypothetical protein +FIG00486690 FIG00486692: hypothetical protein +FIG00486710 Bll6545 protein +FIG00486794 Arabinogalactan endo-1,4-beta-galactosidase precursor (EC 3.2.1.89) (Endo-1,4-beta-galactanase) (Galactanase) +FIG00486841 FIG00486842: hypothetical protein +FIG00486892 FIG00912506: hypothetical protein +FIG00486906 rootletin +FIG00486944 FIG00486952: hypothetical protein +FIG00487007 FIG00702062: hypothetical protein +FIG00487044 FIG00487045: hypothetical protein +FIG00487050 FIG00487064: hypothetical protein +FIG00487081 FIG00487086: hypothetical protein +FIG00487107 Porin precursor +FIG00487125 FIG00487129: hypothetical protein +FIG00487145 Protease Do-like 1, chloroplast precursor (EC 3.4.21.-) +FIG00487195 Rhs family protein-like precursor +FIG00487280 Nuclease (SNase-like) precursor +FIG00487322 FIG00487329: hypothetical protein +FIG00487332 HD-GYP domain-like +FIG00487366 FIG01035535: hypothetical protein +FIG00487518 FIG00487527: hypothetical protein +FIG00487634 Ribosomal RNA small subunit methyltransferase C (EC 2.1.1.52) +FIG00487671 FIG00487673: hypothetical protein +FIG00487685 FIG00487687: hypothetical protein +FIG00487709 FIG00487711: hypothetical protein +FIG00487734 Sigma 54 modulation protein/ribosomal protein S30EA +FIG00487746 FIG00487748: hypothetical protein +FIG00487751 FIG00487752: hypothetical protein +FIG00487755 FIG00487759: hypothetical protein +FIG00487766 FIG00487771: hypothetical protein +FIG00487784 FIG00487788: hypothetical protein +FIG00487898 protein serine-threonine phosphatase +FIG00488147 modular polyketide synthase +FIG00488318 FIG00488337: hypothetical protein +FIG00488396 conserved hypothetical protein; possible biotin synthase related domain containing protein +FIG00488489 rteB, two-component system response regulator +FIG00488662 FIG00488685: hypothetical protein +FIG00489636 protein of unknown function DUF1105 +FIG00490096 FIG00490098: hypothetical protein +FIG00490113 FIG00490156: hypothetical protein +FIG00490156 possible DNA helicase +FIG00490201 FIG00490207: hypothetical protein +FIG00490220 FIG00490233: hypothetical protein +FIG00490269 outer membrane efflux protein/ immunoreative antigen +FIG00490334 FIG00490336: hypothetical protein +FIG00490336 FIG00490346: hypothetical protein +FIG00490440 FIG00877092: hypothetical protein +FIG00490504 FIG00490527: hypothetical protein +FIG00490545 Terpene synthase, metal-binding protein +FIG00490669 FIG00490691: hypothetical protein +FIG00491040 Predicted regulator of galactoside utilization, LacI family +FIG00491232 Phosphate regulon transcriptional regulatory protein phoB +FIG00491309 outer membrane efflux protein precursor +FIG00491653 thioredoxin C-2 +FIG00491686 FIG00648913: hypothetical protein +FIG00491770 thrombospondin type 3 repeat family +FIG00491913 FIG00491928: hypothetical protein +FIG00492020 two-component system sensor histidine kinase( EC:2.7.3.- ) +FIG00492191 similar to glycosyltransferase +FIG00492275 organophosphate pesticide hydrolase +FIG00492375 Outer membrane protein-like protein +FIG00492456 putative outer membrane protein probably involved in nutrient binding +FIG00492660 FIG00492683: hypothetical protein +FIG00493105 FIG00493885: hypothetical protein +FIG00493107 FIG00493108: hypothetical protein +FIG00493108 FIG00493109: hypothetical protein +FIG00493111 FIG00493981: hypothetical protein +FIG00493112 Inclusion membrane protein-14 +FIG00493113 FIG00494320: hypothetical protein +FIG00493114 FIG00494313: hypothetical protein +FIG00493115 Flagellar M-Ring Protein +FIG00493116 FIG00494286: hypothetical protein +FIG00493117 FIG00493118: hypothetical protein +FIG00493120 FIG00493122: hypothetical protein +FIG00493122 FIG00493124: hypothetical protein +FIG00493125 Cytosolic acyl-CoA thioester hydrolase family protein +FIG00493126 FIG00493863: hypothetical protein +FIG00493127 FIG00494461: hypothetical protein +FIG00493128 Tyrosine Transport +FIG00493129 ABC Amino Acid Transporter Permease +FIG00493130 FIG046930: Type III secretion protein +FIG00493131 FIG00493132: hypothetical protein +FIG00493132 FIG00493958: hypothetical protein +FIG00493135 FIG00493136: hypothetical protein +FIG00493136 FIG00493138: hypothetical protein +FIG00493138 FIG00494342: hypothetical protein +FIG00493139 Inclusion membrane protein-9 +FIG00493140 CT839 hypothetical protein +FIG00493142 Inclusion membrane protein-18 +FIG00493144 FIG00493908: hypothetical protein +FIG00493145 FIG00493146: hypothetical protein +FIG00493146 FIG00493147: hypothetical protein +FIG00493147 FIG00493997: hypothetical protein +FIG00493148 FIG00493149: hypothetical protein +FIG00493150 FIG00494069: hypothetical protein +FIG00493151 FIG00494161: hypothetical protein +FIG00493153 FIG00493846: hypothetical protein +FIG00493154 Metal dependent hydrolase +FIG00493156 FIG00494357: hypothetical protein +FIG00493158 FIG016943: Forkhead domain protein +FIG00493159 SET domain protein +FIG00493160 HTH Transcriptional Regulator +FIG00493161 DnaK Suppressor +FIG00493163 Inclusion membrane protein-28 +FIG00493165 FIG00494280: hypothetical protein +FIG00493166 FIG00493167: hypothetical protein +FIG00493167 FIG00493843: hypothetical protein +FIG00493168 FIG00493169: hypothetical protein +FIG00493169 Inclusion membrane protein-41 +FIG00493170 FIG00493171: hypothetical protein +FIG00493171 Inclusion membrane protein-16 +FIG00493173 FIG00493174: hypothetical protein +FIG00493175 FIG00493176: hypothetical protein +FIG00493176 FIG00494248: hypothetical protein +FIG00493178 Amino Group Acetyl Transferase +FIG00493179 Inclusion membrane protein-13 +FIG00493180 FIG00494354: hypothetical protein +FIG00493181 FIG00493182: hypothetical protein +FIG00493182 FIG00493183: hypothetical protein +FIG00493184 Methylated-DNA protein - cysteine methyltransferase +FIG00493188 FIG00494088: hypothetical protein +FIG00493191 FIG00494022: hypothetical protein +FIG00493193 FIG00493194: hypothetical protein +FIG00493194 CDP-alcohol phosphatidyltransferase +FIG00493196 DNA polymerase III subunits gamma and tau (EC 2.7.7.7) +FIG00493198 Inclusion membrane protein-20 +FIG00493199 FIG00494315: hypothetical protein +FIG00493201 FIG00493202: hypothetical protein +FIG00493202 Inclusion membrane protein-47 +FIG00493203 FIG00494310: hypothetical protein +FIG00493204 FIG00493205: hypothetical protein +FIG00493205 FIG00493206: hypothetical protein +FIG00493207 FIG00493208: hypothetical protein +FIG00493209 FIG00493210: hypothetical protein +FIG00493210 FIG00494057: hypothetical protein +FIG00493212 FIG00493213: hypothetical protein +FIG00493213 FIG00493214: hypothetical protein +FIG00493214 FIG00493215: hypothetical protein +FIG00493215 Probable outer membrane protein pmp14 precursor +FIG00493216 Inclusion membrane protein-15 +FIG00493217 FIG00493219: hypothetical protein +FIG00493219 Inclusion membrane protein-49 +FIG00493220 Inclusion membrane protein A +FIG00493226 FIG00493852: hypothetical protein +FIG00493227 FIG00493230: hypothetical protein +FIG00493233 FIG00493234: hypothetical protein +FIG00493235 polymorphic membrane protein D family +FIG00493236 FIG00494107: hypothetical protein +FIG00493237 Virulence plasmid replicative DNA helicase pGP1-D +FIG00493238 Sodium-dependent amino acid transporter +FIG00493239 FIG00493240: hypothetical protein +FIG00493240 FIG00494385: hypothetical protein +FIG00493241 Inclusion membrane protein-50 +FIG00493242 Virulence factor mviN +FIG00493243 FIG00494172: hypothetical protein +FIG00493246 Inclusion membrane protein-25 +FIG00493247 FIG00493248: hypothetical protein +FIG00493248 single-strand binding protein +FIG00493250 FIG016921: Type III secretion protein +FIG00493251 FIG00493867: hypothetical protein +FIG00493252 Inclusion membrane protein-34 +FIG00493253 FIG00493254: hypothetical protein +FIG00493254 FIG00493255: hypothetical protein +FIG00493255 FIG00493256: hypothetical protein +FIG00493257 FIG00493857: hypothetical protein +FIG00493261 Inclusion membrane protein-42 +FIG00493262 FIG00493992: hypothetical protein +FIG00493263 FIG00494291: hypothetical protein +FIG00493264 FIG00493265: hypothetical protein +FIG00493266 FIG00493915: hypothetical protein +FIG00493267 FIG00494197: hypothetical protein +FIG00493268 FIG00494102: hypothetical protein +FIG00493269 FIG00493271: hypothetical protein +FIG00493271 Inclusion membrane protein-23 +FIG00493272 FIG00493273: hypothetical protein +FIG00493273 FIG00493897: hypothetical protein +FIG00493274 FIG00493909: hypothetical protein +FIG00493275 FIG00493276: hypothetical protein +FIG00493276 FIG00493854: hypothetical protein +FIG00493277 FIG00493905: hypothetical protein +FIG00493278 FIG00494149: hypothetical protein +FIG00493284 Anti-sigma F factor antagonist (spoIIAA-2); Anti-sigma B factor antagonist RsbV +FIG00493286 FIG00494195: hypothetical protein +FIG00493288 CHLPS Euo Protein +FIG00493290 serine/threonine protein phosphatase, putative +FIG00493291 FIG00493292: hypothetical protein +FIG00493292 FIG00493293: hypothetical protein +FIG00493293 FIG00493895: hypothetical protein +FIG00493294 MAC/perforin family protein +FIG00493295 FIG00493824: hypothetical protein +FIG00493296 FIG00493894: hypothetical protein +FIG00493298 FIG00493299: hypothetical protein +FIG00493299 FIG00493300: hypothetical protein +FIG00493300 FIG00493950: hypothetical protein +FIG00493304 FIG00494192: hypothetical protein +FIG00493305 (predicted acyltransferase family) +FIG00493306 phospholipase D family protein +FIG00493307 FIG00494138: hypothetical protein +FIG00493308 FIG00494350: hypothetical protein +FIG00493310 Inclusion membrane protein-26 +FIG00493311 FIG00493859: hypothetical protein +FIG00493312 FIG00494231: hypothetical protein +FIG00493313 Serine/threonine kinase +FIG00493316 FIG00493317: hypothetical protein +FIG00493317 FIG00493318: hypothetical protein +FIG00493318 FIG00494163: hypothetical protein +FIG00493320 FIG00493978: hypothetical protein +FIG00493322 FIG00494164: hypothetical protein +FIG00493323 FIG00493324: hypothetical protein +FIG00493324 NifS-related protein +FIG00493325 site-specific tyrosine recombinase XerD +FIG00493326 FIG00493996: hypothetical protein +FIG00493328 Aromatic amino acid transport protein +FIG00493329 FIG00494389: hypothetical protein +FIG00493330 Glutamine Binding Protein +FIG00493331 FIG00493332: hypothetical protein +FIG00493332 FIG016647: Type III secretion protein +FIG00493335 Cationic Amino Acid Transporter +FIG00493336 type III secretion chaperone +FIG00493337 Inclusion membrane protein-12 +FIG00493339 FIG00493340: hypothetical protein +FIG00493340 FIG00494020: hypothetical protein +FIG00493342 Inclusion membrane protein-52 +FIG00493343 FIG00493345: hypothetical protein +FIG00493345 FIG00494112: hypothetical protein +FIG00493346 FIG00493348: hypothetical protein +FIG00493350 probable outer membrane leader peptide (omp) CT546 +FIG00493355 FIG00493969: hypothetical protein +FIG00493356 FIG00493826: hypothetical protein +FIG00493358 FIG00493359: hypothetical protein +FIG00493360 FIG00494338: hypothetical protein +FIG00493361 FIG137478: Hypothetical protein +FIG00493363 FIG00494309: hypothetical protein +FIG00493367 FIG00493368: hypothetical protein +FIG00493368 FIG00493369: hypothetical protein +FIG00493369 3`(2`),5`-bisphosphate nucleotidase, putative +FIG00493370 Protein CPn_0742/CP_0003/CPj0742/CpB0770 +FIG00493371 CHLPN 76 kDa Homolog_2 (CT623) +FIG00493372 Inclusion membrane protein-30 +FIG00493373 FIG00494093: hypothetical protein +FIG00493374 FIG00493375: hypothetical protein +FIG00493375 Major Outer Membrane Protein +FIG00493376 FIG042683: Type III secretion +FIG00493377 FIG00493378: hypothetical protein +FIG00493378 Inclusion membrane protein-39 +FIG00493379 Inclusion membrane protein-36 +FIG00493381 FIG00493382: hypothetical protein +FIG00493382 FIG00493383: hypothetical protein +FIG00493383 FIG00493384: hypothetical protein +FIG00493384 FIG00493385: hypothetical protein +FIG00493388 Disulfide bond Oxidoreductase +FIG00493389 Inclusion membrane protein-19 +FIG00493390 FIG00493391: hypothetical protein +FIG00493391 FIG00494028: hypothetical protein +FIG00493393 FIG00493394: hypothetical protein +FIG00493395 FIG00493396: hypothetical protein +FIG00493396 COG1872 +FIG00493397 FIG00494226: hypothetical protein +FIG00493400 FIG00494220: hypothetical protein +FIG00493401 FIG00493990: hypothetical protein +FIG00493402 FIG00494159: hypothetical protein +FIG00493403 FIG00493404: hypothetical protein +FIG00493404 FIG00493405: hypothetical protein +FIG00493405 FIG00494127: hypothetical protein +FIG00493407 FIG00493408: hypothetical protein +FIG00493408 60 kDa Cysteine-rich omp +FIG00493410 Hypothetical membrane-associated protein CTA_0465 +FIG00493411 Inclusion membrane protein-37 +FIG00493412 Streptococcal hemagglutinin protein +FIG00493420 Protease +FIG00493421 FIG00493422: hypothetical protein +FIG00493422 Inclusion membrane protein-21 +FIG00493423 Arginine Binding Protein +FIG00493427 FIG00493428: hypothetical protein +FIG00493428 FIG00493849: hypothetical protein +FIG00493430 Inclusion membrane protein-24 +FIG00493431 Type III secretion protein SctC +FIG00493433 FIG00494004: hypothetical protein +FIG00493436 FIG00493437: hypothetical protein +FIG00493439 serine esterase, putative +FIG00493440 Exodeoxyribonuclease V gamma chain (EC 3.1.11.5) +FIG00493441 FIG00494077: hypothetical protein +FIG00493445 FIG00494136: hypothetical protein +FIG00493452 FIG00493453: hypothetical protein +FIG00493453 polymorphic outer membrane protein +FIG00493455 amino acid antiporter +FIG00493457 FIG00493812: hypothetical protein +FIG00493459 FIG00494168: hypothetical protein +FIG00493460 FIG00493463: hypothetical protein +FIG00493464 hypothetical protein +FIG00493465 Phosphatidylserine decarboxylase proenzyme (EC 4.1.1.65) +FIG00493467 FIG00493468: hypothetical protein +FIG00493468 Inclusion membrane protein-46 +FIG00493469 FIG00494170: hypothetical protein +FIG00493472 FIG00493473: hypothetical protein +FIG00493473 Inclusion membrane protein-31 +FIG00493475 FIG00493476: hypothetical protein +FIG00493476 FKBP-type peptidyl-prolyl cis-trans isomerase +FIG00493478 FIG00493479: hypothetical protein +FIG00493479 FIG00493952: hypothetical protein +FIG00493480 Virulence plasmid protein pGP6-D +FIG00493481 FIG00493483: hypothetical protein +FIG00493485 Inclusion membrane protein-38 +FIG00493487 FIG00494024: hypothetical protein +FIG00493488 FIG00494421: hypothetical protein +FIG00493495 FIG00493496: hypothetical protein +FIG00493496 FIG00493497: hypothetical protein +FIG00493497 7 kDa reticulate body protein +FIG00493498 Inclusion membrane protein-22 +FIG00493503 LtuB protein +FIG00493504 FIG00493892: hypothetical protein +FIG00493507 Inclusion membrane protein-27 +FIG00493512 FIG00493514: hypothetical protein +FIG00493514 polymorphic membrane protein G family +FIG00493515 FIG00493516: hypothetical protein +FIG00493518 FIG00494145: hypothetical protein +FIG00493519 FIG00493943: hypothetical protein +FIG00493520 FIG00493521: hypothetical protein +FIG00493522 Inclusion membrane protein-27 +FIG00493524 FIG00493525: hypothetical protein +FIG00493525 Inclusion membrane protein-42 +FIG00493526 FIG00493527: hypothetical protein +FIG00493527 phosphatidylcholine-hydrolyzing phospholipase D (PLD) family +FIG00493529 Inclusion membrane protein-17 +FIG00493530 Inclusion membrane protein-8 +FIG00493535 FIG00494344: hypothetical protein +FIG00493536 FIG00493537: hypothetical protein +FIG00493537 FIG016943: Type III secretion +FIG00493538 aerobic respiration control sensor protein arcB +FIG00493539 Virulence plasmid protein pGP2-D +FIG00493540 FIG00494002: hypothetical protein +FIG00493542 Sigma regulatory family protein-PP2C phosphatase +FIG00493545 rRNA methylase (possible) +FIG00493546 FIG00493547: hypothetical protein +FIG00493547 Inclusion membrane protein-40 +FIG00493548 FIG00493549: hypothetical protein +FIG00493549 FIG00493887: hypothetical protein +FIG00493550 FIG00494045: hypothetical protein +FIG00493552 FIG00493553: hypothetical protein +FIG00493555 Acylglycerophosphoethanolamine Acyltransferase +FIG00493557 FIG00493558: hypothetical protein +FIG00493558 FIG00494327: hypothetical protein +FIG00493560 Inclusion membrane protein-21 +FIG00493561 Inclusion membrane protein-54 +FIG00493562 FIG00493563: hypothetical protein +FIG00493565 snGlycerol-3-P acyltransferase +FIG00493566 FIG00493567: hypothetical protein +FIG00493568 Inclusion membrane protein-29 +FIG00493570 carbohydrate isomerase, KpsF/GutQ family +FIG00493571 disulfide bond chaperone +FIG00493572 FIG00493574: hypothetical protein +FIG00493576 major outer membrane protein, putative +FIG00493582 DNA polymerase III, epsilon chain +FIG00493584 FIG00493585: hypothetical protein +FIG00493585 hypothetical protein +FIG00493588 FIG00493591: hypothetical protein +FIG00493593 Invasin repeat family phosphatase +FIG00493596 polymorphic membrane protein E/F family +FIG00493599 FIG00493973: hypothetical protein +FIG00493601 Inclusion membrane protein-43 +FIG00493603 FIG00494046: hypothetical protein +FIG00493605 FIG00493607: hypothetical protein +FIG00493607 FIG00493962: hypothetical protein +FIG00493611 FIG00493612: hypothetical protein +FIG00493614 FIG00493618: hypothetical protein +FIG00493618 FIG00493619: hypothetical protein +FIG00493619 FIG00493621: hypothetical protein +FIG00493621 FIG00493625: hypothetical protein +FIG00493625 adherence factor +FIG00493629 FIG00494150: hypothetical protein +FIG00493630 FIG00493631: hypothetical protein +FIG00493631 FIG00494090: hypothetical protein +FIG00493632 FIG00493911: hypothetical protein +FIG00493637 FIG00493639: hypothetical protein +FIG00493639 hypothetical protein +FIG00493642 FIG00493644: hypothetical protein +FIG00493645 putative cytotoxin +FIG00493646 Inclusion membrane protein-10 +FIG00493647 FIG00493648: hypothetical protein +FIG00493648 FIG00493651: hypothetical protein +FIG00493651 FIG00493652: hypothetical protein +FIG00493653 FIG00493655: hypothetical protein +FIG00493658 Inclusion membrane protein-7 +FIG00493661 FIG00494569: hypothetical protein +FIG00493677 FIG00493678: hypothetical protein +FIG00493678 FIG00493680: hypothetical protein +FIG00493682 FIG00493683: hypothetical protein +FIG00493683 FIG047302: Type III secretion S/T Protein Kinase +FIG00493688 FIG00493689: hypothetical protein +FIG00493689 FIG00493690: hypothetical protein +FIG00493691 FIG00493692: hypothetical protein +FIG00493692 FIG00493702: hypothetical protein +FIG00493702 FIG00494061: hypothetical protein +FIG00493703 FIG00494423: hypothetical protein +FIG00493707 FIG00493713: hypothetical protein +FIG00493715 FIG00493717: hypothetical protein +FIG00493717 Virulence plasmid integrase pGP8-D +FIG00493724 FIG00493730: hypothetical protein +FIG00493732 FIG00493734: hypothetical protein +FIG00493738 hypothetical protein +FIG00493743 hypothetical protein +FIG00493748 FIG00493750: hypothetical protein +FIG00493757 FIG00493758: hypothetical protein +FIG00493758 Inclusion membrane protein-13 +FIG00493760 FIG00493762: hypothetical protein +FIG00493774 FIG00493776: hypothetical protein +FIG00493798 hypothetical protein +FIG00493800 FIG00493802: hypothetical protein +FIG00493802 FIG00493804: hypothetical protein +FIG00493807 Nol1/Nop2/Sun family protein +FIG00493808 FIG00493809: hypothetical protein +FIG00493809 CPj0676 +FIG00493812 FIG00493815: hypothetical protein +FIG00493815 FIG00493818: hypothetical protein +FIG00493818 FIG00493819: hypothetical protein +FIG00493819 FIG00493820: hypothetical protein +FIG00493820 FIG00493821: hypothetical protein +FIG00493821 FIG00493822: hypothetical protein +FIG00493824 FIG00493825: hypothetical protein +FIG00493826 FIG00493827: hypothetical protein +FIG00493827 FIG00493828: hypothetical protein +FIG00493830 macromolecule metabolism; macromolecule synthesis, modification; rna synthesis, modification , dna transcription +FIG00493831 FIG00493832: hypothetical protein +FIG00493832 FIG00493833: hypothetical protein +FIG00493834 outer membrane protein 13 +FIG00493836 FIG00493837: hypothetical protein +FIG00493837 FIG00493838: hypothetical protein +FIG00493843 FIG00493844: hypothetical protein +FIG00493844 FIG00493845: hypothetical protein +FIG00493849 FIG00493850: hypothetical protein +FIG00493850 CHLPN 76 kDa Homolog_1 (CT622) +FIG00493852 FIG00493853: hypothetical protein +FIG00493854 FIG00493855: hypothetical protein +FIG00493855 Inclusion membrane protein-2 +FIG00493857 FIG00493858: hypothetical protein +FIG00493859 FIG00493861: hypothetical protein +FIG00493861 FIG00493862: hypothetical protein +FIG00493868 FIG00493870: hypothetical protein +FIG00493870 FIG00493872: hypothetical protein +FIG00493872 hypothetical protein +FIG00493876 CT651 hypothetical protein +FIG00493878 FIG00493882: hypothetical protein +FIG00493887 FIG00493889: hypothetical protein +FIG00493889 COG1872 +FIG00493890 major outer membrane protein, porin +FIG00493899 FIG00493901: hypothetical protein +FIG00493901 FIG00493902: hypothetical protein +FIG00493905 2-component regulator +FIG00493911 FIG00493912: hypothetical protein +FIG00493913 FIG00493914: hypothetical protein +FIG00493915 FIG00493916: hypothetical protein +FIG00493916 FIG00493918: hypothetical protein +FIG00493919 FIG00493922: hypothetical protein +FIG00493922 FIG00493923: hypothetical protein +FIG00493923 FIG00493925: hypothetical protein +FIG00493927 Inclusion membrane protein-20 +FIG00493928 Monooxygenase +FIG00493931 FIG00493933: hypothetical protein +FIG00493933 FIG00493934: hypothetical protein +FIG00493934 CT449 hypothetical protein +FIG00493936 FIG00493937: hypothetical protein +FIG00493937 FIG00493938: hypothetical protein +FIG00493938 FIG047466: hypothetical protein +FIG00493940 FIG00493942: hypothetical protein +FIG00493943 FIG00493944: hypothetical protein +FIG00493946 Thioredoxin Disulfide Isomerase +FIG00493950 FIG00493951: hypothetical protein +FIG00493952 FIG00493953: hypothetical protein +FIG00493953 CT345 hypothetical protein +FIG00493958 FIG00493960: hypothetical protein +FIG00493962 NifU-related protein +FIG00493963 FIG00493964: hypothetical protein +FIG00493965 FIG00493967: hypothetical protein +FIG00493967 FIG00493968: hypothetical protein +FIG00493969 Arginine Periplasmic Binding Protein +FIG00493970 nitrogen fixation protein +FIG00493974 outer membrane protein 5 +FIG00493975 FIG00493976: hypothetical protein +FIG00493976 FIG00493977: hypothetical protein +FIG00493978 FIG00493979: hypothetical protein +FIG00493979 FIG00493980: hypothetical protein +FIG00493982 FIG00493983: hypothetical protein +FIG00493983 FIG00493984: hypothetical protein +FIG00493984 FIG00493986: hypothetical protein +FIG00493986 Inclusion membrane protein-30 +FIG00493987 FIG00493989: hypothetical protein +FIG00493993 FIG00493995: hypothetical protein +FIG00493997 FIG00494000: hypothetical protein +FIG00494000 FIG00494001: hypothetical protein +FIG00494002 FIG00494003: hypothetical protein +FIG00494004 FIG00494005: hypothetical protein +FIG00494005 FIG00494006: hypothetical protein +FIG00494006 FIG00494008: hypothetical protein +FIG00494011 FIG00494013: hypothetical protein +FIG00494013 FIG00494014: hypothetical protein +FIG00494014 FIG00494016: hypothetical protein +FIG00494016 FIG00494018: hypothetical protein +FIG00494020 FIG00494021: hypothetical protein +FIG00494022 CPj0381 protein +FIG00494024 FIG00494026: hypothetical protein +FIG00494026 FIG00494027: hypothetical protein +FIG00494028 Inclusion membrane protein-40 +FIG00494029 Polymorphic Outer Membrane Protein (Frame-shift with CPn0469) +FIG00494031 FIG00494032: hypothetical protein +FIG00494032 ATPases of the PP superfamily +FIG00494036 CT853 hypothetical protein +FIG00494037 FIG00494038: hypothetical protein +FIG00494039 FIG00494040: hypothetical protein +FIG00494043 FIG00494044: hypothetical protein +FIG00494046 SnGlycerol-3-P acyltransferase +FIG00494051 FIG00494052: hypothetical protein +FIG00494052 DNA methyltransferase +FIG00494053 FIG00494054: hypothetical protein +FIG00494054 Inclusion membrane protein-39 +FIG00494061 FIG00494062: hypothetical protein +FIG00494062 FIG00494063: hypothetical protein +FIG00494069 polymorphic membrane protein B Family +FIG00494070 9kDa-Cysteine-Rich Lipoprotein +FIG00494071 FIG00494075: hypothetical protein +FIG00494077 FIG00494078: hypothetical protein +FIG00494078 outer membrane protein 6 +FIG00494080 Low Calcium Response Protein H +FIG00494081 FIG00494082: hypothetical protein +FIG00494082 FIG00494084: hypothetical protein +FIG00494084 FIG00494085: hypothetical protein +FIG00494093 FIG00494095: hypothetical protein +FIG00494095 FIG00494096: hypothetical protein +FIG00494096 FIG00494098: hypothetical protein +FIG00494098 FIG00494101: hypothetical protein +FIG00494104 FIG00494106: hypothetical protein +FIG00494107 FIG00494108: hypothetical protein +FIG00494109 N-Acetylmuramoyl-L-Ala Amidase +FIG00494112 FIG00494114: hypothetical protein +FIG00494114 FIG00494115: hypothetical protein +FIG00494115 FIG00494116: hypothetical protein +FIG00494116 FIG00494117: hypothetical protein +FIG00494118 FIG00494119: hypothetical protein +FIG00494119 FIG00494120: hypothetical protein +FIG00494120 sperm tail-specific-like protein +FIG00494131 FIG00494132: hypothetical protein +FIG00494138 FIG00494140: hypothetical protein +FIG00494140 FIG00494141: hypothetical protein +FIG00494141 FIG00494143: hypothetical protein +FIG00494145 Na-dependent Transporter +FIG00494151 FIG00494152: hypothetical protein +FIG00494152 FIG00494153: hypothetical protein +FIG00494153 FIG00494154: hypothetical protein +FIG00494154 FIG00494156: hypothetical protein +FIG00494156 FIG00494158: hypothetical protein +FIG00494161 Inclusion membrane protein-32 +FIG00494164 FIG00494165: hypothetical protein +FIG00494165 FIG00494166: hypothetical protein +FIG00494166 FIG00494167: hypothetical protein +FIG00494168 FIG00494169: hypothetical protein +FIG00494173 FIG00494175: hypothetical protein +FIG00494175 FIG00494177: hypothetical protein +FIG00494177 FIG00494178: hypothetical protein +FIG00494178 SAM-dependent methytransferase +FIG00494183 FIG00494184: hypothetical protein +FIG00494184 FIG00494186: hypothetical protein +FIG00494186 FIG00494187: hypothetical protein +FIG00494189 FIG00494190: hypothetical protein +FIG00494190 Inclusion membrane protein-42 +FIG00494192 Inclusion membrane protein-18 +FIG00494193 FIG00494194: hypothetical protein +FIG00494195 FIG00494196: hypothetical protein +FIG00494197 FIG00494198: hypothetical protein +FIG00494198 CT814 hypothetical protein +FIG00494200 FIG00494202: hypothetical protein +FIG00494202 FIG00494203: hypothetical protein +FIG00494203 CT552 hypothetical protein +FIG00494204 FIG00494205: hypothetical protein +FIG00494205 FIG00494206: hypothetical protein +FIG00494206 polymorphic outer membrane protein E/F family protein, putative +FIG00494207 FIG00494208: hypothetical protein +FIG00494208 FIG00494209: hypothetical protein +FIG00494211 FIG00494214: hypothetical protein +FIG00494214 GMP synthase +FIG00494216 FIG00494217: hypothetical protein +FIG00494217 FIG00494218: hypothetical protein +FIG00494220 FIG00494222: hypothetical protein +FIG00494222 FIG00494223: hypothetical protein +FIG00494223 FIG00494224: hypothetical protein +FIG00494224 CPj0426 +FIG00494232 CT105 hypothetical protein +FIG00494233 FIG00494234: hypothetical protein +FIG00494234 FIG00494235: hypothetical protein +FIG00494235 FIG00494237: hypothetical protein +FIG00494237 FIG00494238: hypothetical protein +FIG00494238 FIG00494240: hypothetical protein +FIG00494240 FIG00494241: hypothetical protein +FIG00494241 FIG00494243: hypothetical protein +FIG00494251 FIG00494253: hypothetical protein +FIG00494253 polymorphic membrane protein A Family +FIG00494254 bis (5'-nucleosyl)-tetraphosphatase +FIG00494256 FIG00494259: hypothetical protein +FIG00494262 FIG00494263: hypothetical protein +FIG00494263 FIG00494265: hypothetical protein +FIG00494265 FIG00494267: hypothetical protein +FIG00494267 FIG00494268: hypothetical protein +FIG00494270 FIG00494271: hypothetical protein +FIG00494271 Efflux Protein +FIG00494272 FIG00494273: hypothetical protein +FIG00494274 FIG00494275: hypothetical protein +FIG00494275 FIG00494277: hypothetical protein +FIG00494281 FIG00494282: hypothetical protein +FIG00494282 FIG00494283: hypothetical protein +FIG00494283 FIG00494285: hypothetical protein +FIG00494286 Virulence plasmid integrase pGP8-D +FIG00494291 FIG00494295: hypothetical protein +FIG00494295 FIG00494296: hypothetical protein +FIG00494296 FIG00494297: hypothetical protein +FIG00494297 FIG00494299: hypothetical protein +FIG00494299 FIG00494300: hypothetical protein +FIG00494300 FIG00494302: hypothetical protein +FIG00494302 FIG00494303: hypothetical protein +FIG00494304 FIG00494308: hypothetical protein +FIG00494310 FIG00494311: hypothetical protein +FIG00494311 FIG00494312: hypothetical protein +FIG00494313 hypothetical protein +FIG00494318 FIG00494319: hypothetical protein +FIG00494323 FIG00494325: hypothetical protein +FIG00494325 FIG00493629: hypothetical protein +FIG00494327 Polymorphic outer membrane protein +FIG00494329 FIG00494331: hypothetical protein +FIG00494331 FIG00494332: hypothetical protein +FIG00494333 FIG00494334: hypothetical protein +FIG00494334 putative sigma regulatory protein-pp2c phosphatase +FIG00494335 FIG00494337: hypothetical protein +FIG00494338 FIG00494339: hypothetical protein +FIG00494339 FIG00494341: hypothetical protein +FIG00494345 FIG00494347: hypothetical protein +FIG00494347 FIG00494349: hypothetical protein +FIG00494350 FIG00494351: hypothetical protein +FIG00494351 FIG00494352: hypothetical protein +FIG00494355 FIG00493188: hypothetical protein +FIG00494359 Inclusion membrane protein-29 +FIG00494361 hypothetical protein +FIG00494366 FIG00494370: hypothetical protein +FIG00494370 FIG00494371: hypothetical protein +FIG00494371 FIG00494372: hypothetical protein +FIG00494372 FIG00494375: hypothetical protein +FIG00494376 FIG00494377: hypothetical protein +FIG00494377 FIG00494380: hypothetical protein +FIG00494385 FIG00494386: hypothetical protein +FIG00494387 FIG00494388: hypothetical protein +FIG00494389 FIG00494390: hypothetical protein +FIG00494390 FIG00494392: hypothetical protein +FIG00494392 FIG00494393: hypothetical protein +FIG00494393 FIG00494394: hypothetical protein +FIG00494394 FIG00494395: hypothetical protein +FIG00494395 FIG00494398: hypothetical protein +FIG00494398 FIG00494399: hypothetical protein +FIG00494402 FIG00494403: hypothetical protein +FIG00494404 FIG00494406: hypothetical protein +FIG00494406 FIG00494407: hypothetical protein +FIG00494408 FIG00494409: hypothetical protein +FIG00494409 Inclusion membrane protein-37 +FIG00494411 FIG00494412: hypothetical protein +FIG00494412 FIG00494413: hypothetical protein +FIG00494413 FIG00494414: hypothetical protein +FIG00494414 FIG00494415: hypothetical protein +FIG00494415 Acylglycerophosphoethanolamine acyltransferase +FIG00494417 FIG00494420: hypothetical protein +FIG00494423 FIG00494425: hypothetical protein +FIG00494425 FIG00494426: hypothetical protein +FIG00494426 FIG00494427: hypothetical protein +FIG00494427 FIG00494429: hypothetical protein +FIG00494432 CT144 hypothetical protein_1 +FIG00494437 FIG00494438: hypothetical protein +FIG00494438 FIG00494440: hypothetical protein +FIG00494440 FIG00494442: hypothetical protein +FIG00494442 hypothetical protein +FIG00494444 FIG00494445: hypothetical protein +FIG00494445 FIG00494447: hypothetical protein +FIG00494447 Rod Shape Protein +FIG00494452 FIG00494455: hypothetical protein +FIG00494455 FIG00494457: hypothetical protein +FIG00494457 FIG00494458: hypothetical protein +FIG00494458 FIG00494459: hypothetical protein +FIG00494459 FIG00494460: hypothetical protein +FIG00494461 FIG00494463: hypothetical protein +FIG00494464 FIG00494465: hypothetical protein +FIG00494465 FIG00494467: hypothetical protein +FIG00494467 FIG00494468: hypothetical protein +FIG00494468 FIG00494469: hypothetical protein +FIG00494469 FIG00494470: hypothetical protein +FIG00494470 FIG00494471: hypothetical protein +FIG00494471 FIG00494474: hypothetical protein +FIG00494475 polymorphic outer membrane protein G family +FIG00494476 FIG00494478: hypothetical protein +FIG00494480 FIG00494482: hypothetical protein +FIG00494484 acyltransferase family +FIG00494487 FIG00494488: hypothetical protein +FIG00494489 FIG00494491: hypothetical protein +FIG00494491 FIG00494492: hypothetical protein +FIG00494492 FIG00494493: hypothetical protein +FIG00494494 FIG00494495: hypothetical protein +FIG00494495 FIG00494496: hypothetical protein +FIG00494496 FIG00494498: hypothetical protein +FIG00494498 FIG00494500: hypothetical protein +FIG00494500 FIG00494501: hypothetical protein +FIG00494501 Inclusion membrane protein-2 +FIG00494503 FIG00494504: hypothetical protein +FIG00494505 FIG00494513: hypothetical protein +FIG00494513 Orotate phosphoribosyltransferase (EC 2.4.2.10) / Orotidine 5'-phosphate decarboxylase (EC 4.1.1.23) +FIG00494516 FIG00494518: hypothetical protein +FIG00494519 FIG00494520: hypothetical protein +FIG00494520 FIG00494521: hypothetical protein +FIG00494521 FIG00494522: hypothetical protein +FIG00494522 FIG00494523: hypothetical protein +FIG00494523 Inclusion membrane protein-16 +FIG00494524 FIG00494525: hypothetical protein +FIG00494525 FIG00494529: hypothetical protein +FIG00494531 FIG00494532: hypothetical protein +FIG00494532 FIG00494533: hypothetical protein +FIG00494533 FIG00494535: hypothetical protein +FIG00494535 FIG00494536: hypothetical protein +FIG00494536 FIG00494537: hypothetical protein +FIG00494538 FIG00494539: hypothetical protein +FIG00494544 FIG00494545: hypothetical protein +FIG00494546 FIG00494547: hypothetical protein +FIG00494551 FIG00494555: hypothetical protein +FIG00494555 FIG00494556: hypothetical protein +FIG00494558 hypothetical protein +FIG00494563 FIG00494565: hypothetical protein +FIG00494569 FIG00494570: hypothetical protein +FIG00494570 FIG00494571: hypothetical protein +FIG00494575 CT360 hypothetical protein +FIG00494579 FIG00494580: hypothetical protein +FIG00494580 FIG00494583: hypothetical protein +FIG00494583 frame-shift with pmp_4_1_2 +FIG00494585 FIG00494588: hypothetical protein +FIG00494588 FIG00494589: hypothetical protein +FIG00494595 FIG00494596: hypothetical protein +FIG00494596 FIG00494598: hypothetical protein +FIG00494598 FIG00494601: hypothetical protein +FIG00494601 FIG00494604: hypothetical protein +FIG00494607 FIG00494610: hypothetical protein +FIG00494610 FIG00494614: hypothetical protein +FIG00494614 FIG00494616: hypothetical protein +FIG00494629 FIG00494631: hypothetical protein +FIG00494635 FIG00494636: hypothetical protein +FIG00494636 FIG00494640: hypothetical protein +FIG00494648 FIG00494649: hypothetical protein +FIG00494650 FIG00494651: hypothetical protein +FIG00494666 FIG00494669: hypothetical protein +FIG00494673 FIG00494695: hypothetical protein +FIG00494900 FIG00494913: hypothetical protein +FIG00494959 amine oxidase +FIG00495468 FIG00495469: hypothetical protein +FIG00495473 FIG00495477: hypothetical protein +FIG00495481 FIG00495486: hypothetical protein +FIG00495486 FIG00495489: hypothetical protein +FIG00495506 FIG00495508: hypothetical protein +FIG00495510 FIG00495511: hypothetical protein +FIG00495516 FIG00495517: hypothetical protein +FIG00495519 FIG00495521: hypothetical protein +FIG00495521 FIG00495524: hypothetical protein +FIG00495524 membrane protein of unknown function +FIG00495526 FIG00495531: hypothetical protein +FIG00495531 FIG00495535: hypothetical protein +FIG00495544 FIG00495545: hypothetical protein +FIG00495546 FIG00495551: hypothetical protein +FIG00495551 FIG00495552: hypothetical protein +FIG00495552 FIG00495557: hypothetical protein +FIG00495570 FIG00495573: hypothetical protein +FIG00495590 FIG00495591: hypothetical protein +FIG00495601 FIG00495606: hypothetical protein +FIG00495607 FIG00495613: hypothetical protein +FIG00495613 FIG00495614: hypothetical protein +FIG00495614 Bacteriochlorophyll a protein +FIG00495615 acetyl-CoA carboxylase alpha subunit-like protein +FIG00495619 FIG00495621: hypothetical protein +FIG00495625 FIG00495628: hypothetical protein +FIG00495628 FIG00495631: hypothetical protein +FIG00495641 FIG00495643: hypothetical protein +FIG00495643 FIG00495644: hypothetical protein +FIG00495645 FIG00495650: hypothetical protein +FIG00495655 Putative FixH +FIG00495657 FIG00495660: hypothetical protein +FIG00495660 FIG00495661: hypothetical protein +FIG00495663 Possible alpha/beta hydrolase superfamily, ct0524 homolog +FIG00495670 FIG00495671: hypothetical protein +FIG00495672 FIG00495674: hypothetical protein +FIG00495676 FIG00495678: hypothetical protein +FIG00495686 FIG00495688: hypothetical protein +FIG00495696 outer membrane efflux protein +FIG00495698 FIG00495699: hypothetical protein +FIG00495699 FIG00495700: hypothetical protein +FIG00495712 FIG00495717: hypothetical protein +FIG00495717 FIG00495719: hypothetical protein +FIG00495719 FIG00495720: hypothetical protein +FIG00495720 FIG00495722: hypothetical protein +FIG00495728 FIG00495730: hypothetical protein +FIG00495734 FIG00495737: hypothetical protein +FIG00495751 FIG00495753: hypothetical protein +FIG00495753 FIG00495756: hypothetical protein +FIG00495756 FIG00495757: hypothetical protein +FIG00495757 FIG00495758: hypothetical protein +FIG00495763 COG1872 +FIG00495766 FIG00495767: hypothetical protein +FIG00495776 FIG00495784: hypothetical protein +FIG00495784 FIG00495787: hypothetical protein +FIG00495787 FIG00495792: hypothetical protein +FIG00495792 FIG00495793: hypothetical protein +FIG00495793 FIG00495795: hypothetical protein +FIG00495795 FIG00495796: hypothetical protein +FIG00495799 FIG00495802: hypothetical protein +FIG00495806 internalin-related protein +FIG00495810 VpsC protein +FIG00495814 FIG00495815: hypothetical protein +FIG00495815 FIG00495817: hypothetical protein +FIG00495818 cytochrome c-555 +FIG00495824 FIG00495827: hypothetical protein +FIG00495827 Alpha-amylase family protein +FIG00495832 esterase/lipase, putative +FIG00495842 FIG00495843: hypothetical protein +FIG00495853 Heavy metal transport/detoxification protein +FIG00495864 Cell division protein DivIC (FtsB), stabilizes FtsL against RasP cleavage +FIG00495869 Dolichyl-phosphate beta-D-mannosyltransferase( EC:2.4.1.83 ) +FIG00495879 FIG00495880: hypothetical protein +FIG00495881 FIG00495883: hypothetical protein +FIG00495883 FIG00495885: hypothetical protein +FIG00495885 carboxylesterase family protein +FIG00495889 FIG00495890: hypothetical protein +FIG00495890 FIG00495891: hypothetical protein +FIG00495899 FIG00495900: hypothetical protein +FIG00495900 FIG00495902: hypothetical protein +FIG00495907 FIG00495910: hypothetical protein +FIG00495910 FIG00495911: hypothetical protein +FIG00495914 FIG00938133: hypothetical protein +FIG00495920 carboxyl-terminal protease( EC:3.4.21.102 ) +FIG00495922 FIG00495927: hypothetical protein +FIG00495927 FIG00495928: hypothetical protein +FIG00495928 FIG00495931: hypothetical protein +FIG00495938 FIG00495939: hypothetical protein +FIG00495942 FIG00495943: hypothetical protein +FIG00495944 FIG00495945: hypothetical protein +FIG00495945 FIG00495950: hypothetical protein +FIG00495954 FIG00495957: hypothetical protein +FIG00495969 FIG00495974: hypothetical protein +FIG00495974 FIG00495975: hypothetical protein +FIG00495975 FIG00495976: hypothetical protein +FIG00495977 peptidase M50 +FIG00495988 FIG00495990: hypothetical protein +FIG00495992 FIG00495993: hypothetical protein +FIG00495993 FIG00495994: hypothetical protein +FIG00495994 FIG00495995: hypothetical protein +FIG00495995 PASTA domain containing protein +FIG00495997 FIG00495998: hypothetical protein +FIG00496001 FIG00496002: hypothetical protein +FIG00496002 DNA helicase, putative +FIG00496007 FIG00496014: hypothetical protein +FIG00496014 FIG00496018: hypothetical protein +FIG00496021 FIG00496022: hypothetical protein +FIG00496034 FIG00496035: hypothetical protein +FIG00496037 FIG00496038: hypothetical protein +FIG00496038 FIG00496045: hypothetical protein +FIG00496047 3-beta hydroxysteroid dehydrogenase/isomerase family protein (EC 1.1.1.219) +FIG00496053 FIG00496057: hypothetical protein +FIG00496061 FIG00496062: hypothetical protein +FIG00496062 FIG00496064: hypothetical protein +FIG00496076 FIG00496077: hypothetical protein +FIG00496081 FIG00496086: hypothetical protein +FIG00496090 COG1836 / Phytol kinase +FIG00496094 surface antigen (D15) +FIG00496095 FIG00496098: hypothetical protein +FIG00496111 FIG00496112: hypothetical protein +FIG00496112 FIG00496113: hypothetical protein +FIG00496116 FIG00496120: hypothetical protein +FIG00496120 FIG00496122: hypothetical protein +FIG00496131 FIG00496133: hypothetical protein +FIG00496140 protein of unknown function DUF45 +FIG00496142 FIG00496143: hypothetical protein +FIG00496146 FIG00496152: hypothetical protein +FIG00496153 Endo-1,4-D-glucanase (EC 3.2.1.4) +FIG00496166 FIG00496167: hypothetical protein +FIG00496167 Type II site-specific deoxyribonuclease( EC:3.1.21.4 ) +FIG00496177 sigma54 specific transcriptional regulator, Fis family +FIG00496180 FIG00496182: hypothetical protein +FIG00496182 preprotein translocase, SecG subunit +FIG00496187 FIG00496188: hypothetical protein +FIG00496188 FIG00496197: hypothetical protein +FIG00496197 FIG00496204: hypothetical protein +FIG00496204 cytochrome c assembly protein +FIG00496207 FIG00496209: hypothetical protein +FIG00496216 FIG00496217: hypothetical protein +FIG00496221 FIG00496223: hypothetical protein +FIG00496225 FIG00496226: hypothetical protein +FIG00496226 FIG00496227: hypothetical protein +FIG00496227 FIG00496230: hypothetical protein +FIG00496239 FIG00496243: hypothetical protein +FIG00496243 tyrosine recombinase XerD +FIG00496251 FIG00496252: hypothetical protein +FIG00496257 FIG00496260: hypothetical protein +FIG00496271 FIG00496272: hypothetical protein +FIG00496291 protein of unknown function DUF374 +FIG00496292 FIG00496299: hypothetical protein +FIG00496300 FIG00496303: hypothetical protein +FIG00496307 FIG00496314: hypothetical protein +FIG00496314 FIG00496317: hypothetical protein +FIG00496319 FIG00496327: hypothetical protein +FIG00496327 FIG00496328: hypothetical protein +FIG00496328 FIG00496334: hypothetical protein +FIG00496342 FIG00496343: hypothetical protein +FIG00496358 FIG00496360: hypothetical protein +FIG00496360 Pyruvoyl-dependent arginine decarboxylase (EC 4.1.1.19) +FIG00496367 FIG00496372: hypothetical protein +FIG00496374 Abortive infection protein +FIG00496376 FIG00496378: hypothetical protein +FIG00496382 FIG00496383: hypothetical protein +FIG00496388 FIG00496390: hypothetical protein +FIG00496392 FIG00496393: hypothetical protein +FIG00496393 Putative transport system permease protein +FIG00496394 FIG00496399: hypothetical protein +FIG00496407 Basic membrane protein A +FIG00496415 ComEA-related protein +FIG00496421 FIG00496423: hypothetical protein +FIG00496426 FIG045915: WD-repeat protein +FIG00496438 FIG00496439: hypothetical protein +FIG00496440 FIG00496441: hypothetical protein +FIG00496447 FIG00496451: hypothetical protein +FIG00496458 FIG00496460: hypothetical protein +FIG00496489 FIG00496490: hypothetical protein +FIG00496502 FIG00496503: hypothetical protein +FIG00496503 FIG00496504: hypothetical protein +FIG00496504 FIG00496512: hypothetical protein +FIG00496512 FIG00496516: hypothetical protein +FIG00496518 FIG00496520: hypothetical protein +FIG00496529 FIG00496531: hypothetical protein +FIG00496535 FIG00496537: hypothetical protein +FIG00496561 signal transduction histidine-protein kinase BarA( EC:2.7.13.3 ) +FIG00496565 glutaredoxin 2 +FIG00496576 FIG00496580: hypothetical protein +FIG00496581 FIG00496585: hypothetical protein +FIG00496593 carbon-nitrogen hydrolase family protein +FIG00496596 FIG00496604: hypothetical protein +FIG00496604 FIG00496609: hypothetical protein +FIG00496609 FIG00496614: hypothetical protein +FIG00496625 FIG00496626: hypothetical protein +FIG00496627 glycosyl transferase family 9 +FIG00496634 Glycosyl transferase in Chlorophyll a cluster +FIG00496639 FIG00496642: hypothetical protein +FIG00496651 fic family protein +FIG00496654 FIG00496660: hypothetical protein +FIG00496660 Glycosyl transferase, family 2 +FIG00496661 FIG00496663: hypothetical protein +FIG00496663 FIG00496668: hypothetical protein +FIG00496673 FIG00496680: hypothetical protein +FIG00496680 FIG00496681: hypothetical protein +FIG00496682 FIG00496684: hypothetical protein +FIG00496684 FIG00496687: hypothetical protein +FIG00496687 transcription activator, effector binding +FIG00496692 FIG00496698: hypothetical protein +FIG00496703 FIG00496706: hypothetical protein +FIG00496706 drug resistance protein, putative +FIG00496718 FIG00496719: hypothetical protein +FIG00496721 FIG00496724: hypothetical protein +FIG00496724 FIG00496727: hypothetical protein +FIG00496733 FIG00496735: hypothetical protein +FIG00496735 FIG00496737: hypothetical protein +FIG00496737 FIG00496742: hypothetical protein +FIG00496745 FIG00496747: hypothetical protein +FIG00496772 FIG00496777: hypothetical protein +FIG00496778 FIG00496779: hypothetical protein +FIG00496780 FIG00496781: hypothetical protein +FIG00496782 Pentapeptide repeat precursor +FIG00496797 FIG00496801: hypothetical protein +FIG00496811 FIG00496818: hypothetical protein +FIG00496837 FIG00496842: hypothetical protein +FIG00496854 FIG00496858: hypothetical protein +FIG00496862 FIG00496864: hypothetical protein +FIG00496865 conserved hypothetical cytosolic protein +FIG00496874 site-specific recombinase, phage/XerD family +FIG00496876 FIG00496877: hypothetical protein +FIG00496885 FIG00496886: hypothetical protein +FIG00496886 FIG00496890: hypothetical protein +FIG00496890 FIG00496892: hypothetical protein +FIG00496892 FIG00496895: hypothetical protein +FIG00496895 FIG00496897: hypothetical protein +FIG00496897 FIG00496898: hypothetical protein +FIG00496898 zinc finger CDGSH-type domain protein +FIG00496928 FIG00496932: hypothetical protein +FIG00496942 FIG00496943: hypothetical protein +FIG00496943 FIG00496945: hypothetical protein +FIG00496952 Sulfide:quinone oxidoreductase +FIG00496960 FIG00496969: hypothetical protein +FIG00496975 Metallophosphoesterase +FIG00496995 FIG00496996: hypothetical protein +FIG00497041 FIG00497050: hypothetical protein +FIG00497054 FIG00497056: hypothetical protein +FIG00497056 FIG00497065: hypothetical protein +FIG00497065 FIG00497069: hypothetical protein +FIG00497069 FIG00497079: hypothetical protein +FIG00497079 FIG00497080: hypothetical protein +FIG00497084 FIG00497089: hypothetical protein +FIG00497090 FIG00497095: hypothetical protein +FIG00497109 FIG00497110: hypothetical protein +FIG00497121 FIG00497122: hypothetical protein +FIG00497135 FIG00497136: hypothetical protein +FIG00497144 FIG00497146: hypothetical protein +FIG00497146 FIG00497153: hypothetical protein +FIG00497153 FIG00497163: hypothetical protein +FIG00497167 FIG00497170: hypothetical protein +FIG00497170 FIG00497171: hypothetical protein +FIG00497175 FIG00497181: hypothetical protein +FIG00497182 FIG00497184: hypothetical protein +FIG00497184 FIG00497185: hypothetical protein +FIG00497193 FIG00497194: hypothetical protein +FIG00497195 FIG00497197: hypothetical protein +FIG00497237 FIG00497242: hypothetical protein +FIG00497249 FIG00497251: hypothetical protein +FIG00497251 FIG00497252: hypothetical protein +FIG00497252 FIG00497256: hypothetical protein +FIG00497256 FIG00497259: hypothetical protein +FIG00497259 FIG00497262: hypothetical protein +FIG00497262 FIG00497264: hypothetical protein +FIG00497275 FIG00497276: hypothetical protein +FIG00497282 FIG00497285: hypothetical protein +FIG00497285 FIG00497287: hypothetical protein +FIG00497287 superfamily I DNA and RNA helicase and helicase subunit +FIG00497288 FIG00497290: hypothetical protein +FIG00497290 FIG00497292: hypothetical protein +FIG00497301 FIG00497311: hypothetical protein +FIG00497344 FIG00497348: hypothetical protein +FIG00497348 FIG00497349: hypothetical protein +FIG00497349 FIG00497350: hypothetical protein +FIG00497385 FIG00497386: hypothetical protein +FIG00497403 FIG00497404: hypothetical protein +FIG00497404 C-type cytochrome, putative +FIG00497423 ATP-dependent DNA helicase recG +FIG00497473 FIG00497474: hypothetical protein +FIG00497480 RNP-1 like RNA-binding protein +FIG00497494 FIG00497495: hypothetical protein +FIG00497499 FIG00497501: hypothetical protein +FIG00497507 FIG00497510: hypothetical protein +FIG00497510 FIG00497516: hypothetical protein +FIG00497524 Tia invasion determinant-related protein precursor +FIG00497532 Acetyltransferase (EC 2.3.1.-) +FIG00497534 FIG00497538: hypothetical protein +FIG00497559 FIG00497566: hypothetical protein +FIG00497588 FIG00497591: hypothetical protein +FIG00497591 FIG00497592: hypothetical protein +FIG00497592 dihydroorotate dehydrogenase +FIG00497598 FIG00497602: hypothetical protein +FIG00497620 FIG00497623: hypothetical protein +FIG00497623 FIG00497627: hypothetical protein +FIG00497632 FIG00497633: hypothetical protein +FIG00497646 FIG00497647: hypothetical protein +FIG00497695 FIG00497699: hypothetical protein +FIG00497716 FIG00497720: hypothetical protein +FIG00497720 FIG00497734: hypothetical protein +FIG00497734 FIG00497742: hypothetical protein +FIG00497771 FIG00497772: hypothetical protein +FIG00497774 FIG00497775: hypothetical protein +FIG00497775 FIG00497783: hypothetical protein +FIG00497791 FIG00497792: hypothetical protein +FIG00497795 FIG00497798: hypothetical protein +FIG00497798 FIG00497803: hypothetical protein +FIG00497807 FIG00497811: hypothetical protein +FIG00497815 FIG00497818: hypothetical protein +FIG00497824 HhH-GPD +FIG00497851 FIG00497853: hypothetical protein +FIG00497899 FIG00497902: hypothetical protein +FIG00497906 FIG00497910: hypothetical protein +FIG00497954 FIG00497955: hypothetical protein +FIG00497967 FIG00497972: hypothetical protein +FIG00497982 FIG00497987: hypothetical protein +FIG00497987 FIG00497991: hypothetical protein +FIG00498025 FIG00498027: hypothetical protein +FIG00498055 FIG00498064: hypothetical protein +FIG00498103 FIG00498104: hypothetical protein +FIG00498108 FIG00498110: hypothetical protein +FIG00498185 type II DNA modification methyltransferase M.TdeIII +FIG00498209 FIG00498216: hypothetical protein +FIG00498216 glycosyl transferase group 1 +FIG00498241 peptidase M16 domain protein +FIG00498250 sterol desaturase, putative +FIG00498290 FIG00498291: hypothetical protein +FIG00498303 FIG00498311: hypothetical protein +FIG00498344 FIG00498347: hypothetical protein +FIG00498377 FIG00498383: hypothetical protein +FIG00498390 FIG00498393: hypothetical protein +FIG00498409 FIG00498415: hypothetical protein +FIG00498486 Type III restriction-modification enzyme, helicase subunit +FIG00498510 FIG00498514: hypothetical protein +FIG00498514 FIG00498518: hypothetical protein +FIG00498523 FIG00498528: hypothetical protein +FIG00498561 FIG00498563: hypothetical protein +FIG00498565 FIG00498566: hypothetical protein +FIG00498615 FIG00498620: hypothetical protein +FIG00498635 FIG00498638: hypothetical protein +FIG00498673 FIG00498674: hypothetical protein +FIG00498714 FIG00498720: hypothetical protein +FIG00498720 FIG00498723: hypothetical protein +FIG00498745 FAD linked oxidase domain protein +FIG00498773 RloB +FIG00498807 DNA polymerase, beta-like region +FIG00498820 FIG00498824: hypothetical protein +FIG00498824 methlytransferase, putative +FIG00498834 FIG00498839: hypothetical protein +FIG00498848 FIG00498854: hypothetical protein +FIG00498854 FIG00498857: hypothetical protein +FIG00498858 FIG00854906: hypothetical protein +FIG00498877 Arsenite oxidase small subunit precursor (EC 1.20.98.1) +FIG00498881 FIG00498883: hypothetical protein +FIG00498920 protein of unknown function DUF134 +FIG00498993 FIG00498995: hypothetical protein +FIG00498995 FIG00498997: hypothetical protein +FIG00499057 Excinuclease ABC, C subunit, N-terminal +FIG00499081 FIG00499083: hypothetical protein +FIG00499123 lytic murein transglycosylase, putative +FIG00499211 FIG00499215: hypothetical protein +FIG00499215 Glycosyltransferase-like +FIG00499234 FIG00499245: hypothetical protein +FIG00499296 FIG00499301: hypothetical protein +FIG00499357 FIG00499364: hypothetical protein +FIG00499398 similar to transcriptional regulator containing an HTH domain and an uncharacterized domain shared with the mammalian protein Schlafen +FIG00499434 FIG00499436: hypothetical protein +FIG00499449 FIG00499451: hypothetical protein +FIG00499451 CRISPR repeat RNA endoribonuclease Cas6 +FIG00499472 FIG00499473: hypothetical protein +FIG00499490 Ion transport 2 domain protein +FIG00499550 possible virulence-associated protein +FIG00499553 FIG00499560: hypothetical protein +FIG00499568 FIG00499572: hypothetical protein +FIG00499572 FIG00499578: hypothetical protein +FIG00499609 FIG00499611: hypothetical protein +FIG00499628 FIG00499630: hypothetical protein +FIG00499696 FIG00499698: hypothetical protein +FIG00499731 FIG00499736: hypothetical protein +FIG00499775 FIG00499777: hypothetical protein +FIG00499827 FIG00499836: hypothetical protein +FIG00499899 Ssr2962 protein +FIG00499943 FIG00499950: hypothetical protein +FIG00499950 FIG00499952: hypothetical protein +FIG00499961 FIG00499966: hypothetical protein +FIG00499985 FIG00499989: hypothetical protein +FIG00499991 FIG00499998: hypothetical protein +FIG00499998 FIG00499999: hypothetical protein +FIG00499999 FIG00500000: hypothetical protein +FIG00500000 FIG00500003: hypothetical protein +FIG00500003 PAS fold-4 +FIG00500005 FIG00500008: hypothetical protein +FIG00500010 FIG00500011: hypothetical protein +FIG00500011 FIG00500013: hypothetical protein +FIG00500013 Uncharacterized protein ORF2 +FIG00500019 FIG00500021: hypothetical protein +FIG00500021 FIG00500027: hypothetical protein +FIG00500027 FIG00500028: hypothetical protein +FIG00500030 FIG00500034: hypothetical protein +FIG00500034 FIG00500036: hypothetical protein +FIG00500037 FIG00500038: hypothetical protein +FIG00500038 FIG00500040: hypothetical protein +FIG00500040 4-vinyl reductase, 4VR +FIG00500045 FIG00500046: hypothetical protein +FIG00500046 Disulphide bond formation protein DsbB +FIG00500048 FIG00500049: hypothetical protein +FIG00500049 Amidase family protein BBta_1912 +FIG00500053 iron (metal) dependent repressor, DtxR family +FIG00500054 Acylamino-acid-releasing enzyme (EC 3.4.19.1) (AARE) (Acyl-peptide hydrolase) (APH) (Acylaminoacyl-peptidase) +FIG00500055 FIG00500056: hypothetical protein +FIG00500056 FIG00500058: hypothetical protein +FIG00500059 FIG00500062: hypothetical protein +FIG00500062 response regulator receiver modulated diguanylate cyclase +FIG00500063 UPF0173 metal-dependent hydrolase AF_1265 +FIG00500068 FIG00500071: hypothetical protein +FIG00500085 FIG00500086: hypothetical protein +FIG00500086 chloramphenicol acetyltransferase +FIG00500089 FIG00500092: hypothetical protein +FIG00500092 FIG00500093: hypothetical protein +FIG00500105 FIG00500106: hypothetical protein +FIG00500106 FIG00500109: hypothetical protein +FIG00500112 FIG00500115: hypothetical protein +FIG00500115 FIG00500116: hypothetical protein +FIG00500116 FIG00500119: hypothetical protein +FIG00500122 FIG00500124: hypothetical protein +FIG00500124 FIG00500125: hypothetical protein +FIG00500125 FIG00500126: hypothetical protein +FIG00500126 FIG00500127: hypothetical protein +FIG00500129 FIG00500130: hypothetical protein +FIG00500130 FIG00500132: hypothetical protein +FIG00500134 FIG00500135: hypothetical protein +FIG00500135 GAF +FIG00500140 FIG00500141: hypothetical protein +FIG00500141 FIG00500142: hypothetical protein +FIG00500142 FIG00500144: hypothetical protein +FIG00500144 integral membrane sensor signal transduction histidine kinase( EC:2.7.13.3 ) +FIG00500147 Putative regulatory protein, FmdB +FIG00500148 conserved hypothetical protein similar to Arabidopsis thaliana chromosome 4,At4g29590 +FIG00500154 FIG00500156: hypothetical protein +FIG00500156 FIG00500157: hypothetical protein +FIG00500158 FIG00500160: hypothetical protein +FIG00500163 FIG00500164: hypothetical protein +FIG00500168 FIG00500169: hypothetical protein +FIG00500169 FIG00500171: hypothetical protein +FIG00500173 FIG00500174: hypothetical protein +FIG00500174 FIG00500175: hypothetical protein +FIG00500178 FIG00500179: hypothetical protein +FIG00500179 FIG00500182: hypothetical protein +FIG00500188 Auracyanin-B precursor (Ac-B) [Contains: Auracyanin-B-1; Auracyanin-B-2] +FIG00500190 FIG00500194: hypothetical protein +FIG00500194 FIG00500195: hypothetical protein +FIG00500199 FIG00500203: hypothetical protein +FIG00500204 FIG00500205: hypothetical protein +FIG00500205 Substrate-specific component ThiW of predicted thiazole ECF transporter / Duplicated ATPase component of energizing module of predicted thiazole ECF transporter +FIG00500220 FIG00500221: hypothetical protein +FIG00500221 FIG00500223: hypothetical protein +FIG00500223 FIG00500226: hypothetical protein +FIG00500226 FIG00500229: hypothetical protein +FIG00500229 Mannan endo-1,4-beta-mannosidase precursor (EC 3.2.1.78) (Beta-mannanase) (Endo-beta-1,4-mannanase) (ManA) +FIG00500236 FIG00500237: hypothetical protein +FIG00500237 FIG00500238: hypothetical protein +FIG00500246 FIG00500249: hypothetical protein +FIG00500257 FIG00500258: hypothetical protein +FIG00500260 FIG00500266: hypothetical protein +FIG00500266 FIG00500270: hypothetical protein +FIG00500270 Predicted metal-dependent hydrolase of the TIM-barrel fold +FIG00500271 FIG00500272: hypothetical protein +FIG00500272 FIG00500274: hypothetical protein +FIG00500275 FIG00500276: hypothetical protein +FIG00500276 FIG00500278: hypothetical protein +FIG00500278 FIG00500279: hypothetical protein +FIG00500279 FIG00500283: hypothetical protein +FIG00500293 FIG00500294: hypothetical protein +FIG00500294 FIG00500295: hypothetical protein +FIG00500295 FIG00500296: hypothetical protein +FIG00500297 FIG00500299: hypothetical protein +FIG00500299 FIG00500301: hypothetical protein +FIG00500301 FIG00500302: hypothetical protein +FIG00500304 FIG00500305: hypothetical protein +FIG00500305 FIG00500306: hypothetical protein +FIG00500306 FIG00500307: hypothetical protein +FIG00500307 FIG00500309: hypothetical protein +FIG00500316 FIG00500317: hypothetical protein +FIG00500318 FIG00500320: hypothetical protein +FIG00500323 FIG00500324: hypothetical protein +FIG00500328 LmbE family protein +FIG00500335 FIG00500336: hypothetical protein +FIG00500338 FIG00500339: hypothetical protein +FIG00500339 FIG00500340: hypothetical protein +FIG00500346 FIG00500347: hypothetical protein +FIG00500353 FIG00500354: hypothetical protein +FIG00500354 FIG00500356: hypothetical protein +FIG00500356 FIG00500361: hypothetical protein +FIG00500361 FIG00500363: hypothetical protein +FIG00500363 FIG00500370: hypothetical protein +FIG00500370 FIG00500371: hypothetical protein +FIG00500371 putative two component transcriptional regulator, winged helix family +FIG00500372 FIG00500375: hypothetical protein +FIG00500375 FIG00500377: hypothetical protein +FIG00500378 Sulfate transporter/antisigma-factor antagonist STAS:Xanthine/uracil/vitamin C permease:Sulphate transporter +FIG00500379 FIG00500381: hypothetical protein +FIG00500384 FIG00500387: hypothetical protein +FIG00500387 FIG00500388: hypothetical protein +FIG00500388 FIG00500392: hypothetical protein +FIG00500394 FIG00500398: hypothetical protein +FIG00500399 FIG00500400: hypothetical protein +FIG00500400 FIG00500401: hypothetical protein +FIG00500401 FIG00500405: hypothetical protein +FIG00500406 FIG00500409: hypothetical protein +FIG00500409 FIG00500411: hypothetical protein +FIG00500411 FIG00500412: hypothetical protein +FIG00500412 FIG00500414: hypothetical protein +FIG00500414 FIG00500417: hypothetical protein +FIG00500417 FIG00500421: hypothetical protein +FIG00500421 FIG00500425: hypothetical protein +FIG00500425 FIG00500427: hypothetical protein +FIG00500427 FIG00500430: hypothetical protein +FIG00500430 FIG00500433: hypothetical protein +FIG00500443 FIG00500444: hypothetical protein +FIG00500453 FIG00500455: hypothetical protein +FIG00500455 initiation factor 2B related +FIG00500460 FIG00500462: hypothetical protein +FIG00500463 FIG00500471: hypothetical protein +FIG00500471 FIG00500474: hypothetical protein +FIG00500474 FIG00500475: hypothetical protein +FIG00500475 FIG00500480: hypothetical protein +FIG00500486 FIG00500487: hypothetical protein +FIG00500488 FIG00500492: hypothetical protein +FIG00500492 FIG00500494: hypothetical protein +FIG00500494 Cyanophycinase (EC 3.4.15.6) / Peptidase E (alpha-aspartyl dipeptidase) +FIG00500498 FIG00500499: hypothetical protein +FIG00500499 FIG00500502: hypothetical protein +FIG00500503 FIG00500505: hypothetical protein +FIG00500508 FIG00500510: hypothetical protein +FIG00500512 FIG00500517: hypothetical protein +FIG00500517 Two-component system sensory histidine kinase +FIG00500525 FIG00500530: hypothetical protein +FIG00500535 FIG00500536: hypothetical protein +FIG00500536 FIG00500540: hypothetical protein +FIG00500542 FIG00500544: hypothetical protein +FIG00500544 Extensin-like protein precursor +FIG00500545 FIG00500546: hypothetical protein +FIG00500546 FIG00500547: hypothetical protein +FIG00500555 Serine/threonine protein kinase fused to TPR repeats domain +FIG00500557 FIG00500561: hypothetical protein +FIG00500564 FIG00500569: hypothetical protein +FIG00500569 PemK-like protein +FIG00500575 FIG00500577: hypothetical protein +FIG00500577 FIG00500579: hypothetical protein +FIG00500579 FIG00500582: hypothetical protein +FIG00500584 FIG00500586: hypothetical protein +FIG00500590 FIG00500591: hypothetical protein +FIG00500592 FIG00500593: hypothetical protein +FIG00500601 protein of unknown function DUF1405 +FIG00500602 FIG00500605: hypothetical protein +FIG00500609 FIG00500611: hypothetical protein +FIG00500612 FIG00500614: hypothetical protein +FIG00500614 Integrins alpha chain +FIG00500615 FIG00500618: hypothetical protein +FIG00500618 FIG00500619: hypothetical protein +FIG00500619 FIG00500620: hypothetical protein +FIG00500622 FIG00500623: hypothetical protein +FIG00500623 FIG00500624: hypothetical protein +FIG00500631 FIG00500634: hypothetical protein +FIG00500634 FIG00500635: hypothetical protein +FIG00500635 FIG00500639: hypothetical protein +FIG00500640 Uncharacterized protein Mb1395 precursor +FIG00500647 FIG00500648: hypothetical protein +FIG00500652 FIG00500656: hypothetical protein +FIG00500656 FIG00500657: hypothetical protein +FIG00500662 FIG00500665: hypothetical protein +FIG00500665 FIG00500667: hypothetical protein +FIG00500667 FIG00500669: hypothetical protein +FIG00500669 FIG00500671: hypothetical protein +FIG00500677 FIG00500679: hypothetical protein +FIG00500680 FIG00500681: hypothetical protein +FIG00500681 FIG00500682: hypothetical protein +FIG00500684 FIG00500685: hypothetical protein +FIG00500689 FIG00500694: hypothetical protein +FIG00500694 FIG00500696: hypothetical protein +FIG00500697 FIG00500699: hypothetical protein +FIG00500699 FIG00500702: hypothetical protein +FIG00500710 FIG00500712: hypothetical protein +FIG00500713 FIG00500714: hypothetical protein +FIG00500714 FIG00500716: hypothetical protein +FIG00500716 FIG00500718: hypothetical protein +FIG00500718 FIG00500719: hypothetical protein +FIG00500720 FIG00500722: hypothetical protein +FIG00500722 FIG00500723: hypothetical protein +FIG00500726 FIG00500728: hypothetical protein +FIG00500728 FIG00500729: hypothetical protein +FIG00500731 FIG00500735: hypothetical protein +FIG00500735 FIG00500737: hypothetical protein +FIG00500737 FIG00500739: hypothetical protein +FIG00500753 FIG00500757: hypothetical protein +FIG00500757 FIG00500761: hypothetical protein +FIG00500770 FIG00500771: hypothetical protein +FIG00500771 FIG00500773: hypothetical protein +FIG00500780 FIG00500781: hypothetical protein +FIG00500781 FIG00500784: hypothetical protein +FIG00500784 FIG00500786: hypothetical protein +FIG00500786 FIG00500790: hypothetical protein +FIG00500790 FIG00500791: hypothetical protein +FIG00500791 FIG00500792: hypothetical protein +FIG00500792 phosphoribosyltransferase +FIG00500795 FIG00500796: hypothetical protein +FIG00500796 FIG00500797: hypothetical protein +FIG00500797 FIG00500804: hypothetical protein +FIG00500810 FIG00500811: hypothetical protein +FIG00500813 FIG00500818: hypothetical protein +FIG00500818 FIG00500826: hypothetical protein +FIG00500827 FIG00500830: hypothetical protein +FIG00500830 FIG00500831: hypothetical protein +FIG00500834 FIG00500835: hypothetical protein +FIG00500835 SAM radical enzyme +FIG00500841 FIG00500842: hypothetical protein +FIG00500848 FIG00500850: hypothetical protein +FIG00500850 FIG00500852: hypothetical protein +FIG00500852 Xanthine dehydrogenase (EC 1.17.1.4) +FIG00500853 FIG00500855: hypothetical protein +FIG00500855 FIG00500861: hypothetical protein +FIG00500861 FIG00500866: hypothetical protein +FIG00500866 FIG00500869: hypothetical protein +FIG00500875 FIG00500878: hypothetical protein +FIG00500878 FIG00500881: hypothetical protein +FIG00500883 FIG00500884: hypothetical protein +FIG00500884 FIG00500885: hypothetical protein +FIG00500885 FIG00500886: hypothetical protein +FIG00500888 FIG00500890: hypothetical protein +FIG00500890 FIG00500891: hypothetical protein +FIG00500903 FIG00500904: hypothetical protein +FIG00500904 FIG00500906: hypothetical protein +FIG00500906 FIG00500908: hypothetical protein +FIG00500908 FIG00500911: hypothetical protein +FIG00500911 FIG00500912: hypothetical protein +FIG00500917 FIG00500918: hypothetical protein +FIG00500918 FIG00500921: hypothetical protein +FIG00500931 FIG00500932: hypothetical protein +FIG00500934 FIG00500935: hypothetical protein +FIG00500935 Alpha-amylase/alpha-mannosidase +FIG00500936 FIG00500937: hypothetical protein +FIG00500937 FIG00500941: hypothetical protein +FIG00500941 FIG00500944: hypothetical protein +FIG00500944 FIG00500946: hypothetical protein +FIG00500951 FIG00500952: hypothetical protein +FIG00500952 FIG00500956: hypothetical protein +FIG00500963 FIG00500964: hypothetical protein +FIG00500964 FIG00500965: hypothetical protein +FIG00500965 FIG00500966: hypothetical protein +FIG00500966 FIG00500967: hypothetical protein +FIG00500967 FIG00500968: hypothetical protein +FIG00500968 FIG00500969: hypothetical protein +FIG00500971 band 7 protein +FIG00500972 FIG00500973: hypothetical protein +FIG00500973 FIG00500975: hypothetical protein +FIG00500975 FIG00500978: hypothetical protein +FIG00500978 FIG00500980: hypothetical protein +FIG00500981 FIG00500983: hypothetical protein +FIG00500983 FIG00500984: hypothetical protein +FIG00500989 Sensor protein fixL (EC 2.7.3.-) +FIG00500990 FIG00500991: hypothetical protein +FIG00500991 FIG00500994: hypothetical protein +FIG00501004 FIG00501006: hypothetical protein +FIG00501006 FIG00501008: hypothetical protein +FIG00501008 FIG00501011: hypothetical protein +FIG00501011 FIG00501012: hypothetical protein +FIG00501014 FIG00501016: hypothetical protein +FIG00501016 FIG00501019: hypothetical protein +FIG00501021 FIG00501025: hypothetical protein +FIG00501025 FIG00501028: hypothetical protein +FIG00501028 FIG00501030: hypothetical protein +FIG00501030 FIG00501033: hypothetical protein +FIG00501039 FIG00501041: hypothetical protein +FIG00501044 FIG00501050: hypothetical protein +FIG00501059 FIG00501060: hypothetical protein +FIG00501060 CRISPR-associated protein, Cst1 family +FIG00501062 FIG00501063: hypothetical protein +FIG00501063 FIG00501064: hypothetical protein +FIG00501065 FIG00501066: hypothetical protein +FIG00501071 FIG00501073: hypothetical protein +FIG00501073 FIG00501078: hypothetical protein +FIG00501078 FIG00501080: hypothetical protein +FIG00501080 FIG00501081: hypothetical protein +FIG00501082 Translin family protein +FIG00501084 FIG00501090: hypothetical protein +FIG00501094 FIG00501100: hypothetical protein +FIG00501100 FIG00501106: hypothetical protein +FIG00501106 FIG00501114: hypothetical protein +FIG00501114 FIG00501120: hypothetical protein +FIG00501120 FIG00501121: hypothetical protein +FIG00501121 FIG00501123: hypothetical protein +FIG00501123 FIG00501125: hypothetical protein +FIG00501125 FIG00501129: hypothetical protein +FIG00501129 FIG00501130: hypothetical protein +FIG00501130 contains Pfam domain, PF05193: Peptidase M16 inactive domain; go_function: metalloendopeptidase activity [goid 0004222]; go_process: proteolysis and peptidolysis [goid 0006508] / peptidase M16 family protein / insulinase family protein +FIG00501135 FIG00501137: hypothetical protein +FIG00501137 FIG00501138: hypothetical protein +FIG00501138 FIG00501141: hypothetical protein +FIG00501143 FIG00501146: hypothetical protein +FIG00501152 FIG00501156: hypothetical protein +FIG00501156 FIG00501158: hypothetical protein +FIG00501158 FIG00501160: hypothetical protein +FIG00501161 FIG00501164: hypothetical protein +FIG00501169 FIG00501174: hypothetical protein +FIG00501174 Similar to photosystem I assembly BtpA +FIG00501176 FIG00501177: hypothetical protein +FIG00501177 FIG00501179: hypothetical protein +FIG00501179 FIG00501181: hypothetical protein +FIG00501181 FIG00501184: hypothetical protein +FIG00501189 FIG00501197: hypothetical protein +FIG00501197 FIG00501198: hypothetical protein +FIG00501199 FIG00501200: hypothetical protein +FIG00501200 FIG00501201: hypothetical protein +FIG00501203 FIG00501204: hypothetical protein +FIG00501207 similar to Biotin carboxylase +FIG00501209 FIG00501213: hypothetical protein +FIG00501213 FIG00501214: hypothetical protein +FIG00501216 FIG00501218: hypothetical protein +FIG00501219 FIG00501221: hypothetical protein +FIG00501224 FIG00501226: hypothetical protein +FIG00501226 FIG00501228: hypothetical protein +FIG00501230 FIG00501237: hypothetical protein +FIG00501237 FIG00501243: hypothetical protein +FIG00501243 FIG00501244: hypothetical protein +FIG00501248 FIG00501249: hypothetical protein +FIG00501249 FIG00501250: hypothetical protein +FIG00501252 FIG00501255: hypothetical protein +FIG00501255 FIG00501256: hypothetical protein +FIG00501256 FIG00501258: hypothetical protein +FIG00501258 FIG00501262: hypothetical protein +FIG00501262 conserved hypothetical protein-putative transmembrane protein +FIG00501263 amidohydrolase 2 +FIG00501265 FIG00501266: hypothetical protein +FIG00501266 FIG00501271: hypothetical protein +FIG00501271 FIG00501278: hypothetical protein +FIG00501278 FIG00501281: hypothetical protein +FIG00501281 FIG00501284: hypothetical protein +FIG00501284 FIG00501288: hypothetical protein +FIG00501288 FIG00501290: hypothetical protein +FIG00501290 glycosyl transferase family 28 +FIG00501293 inner-membrane translocator +FIG00501298 FIG00501299: hypothetical protein +FIG00501299 FIG00501303: hypothetical protein +FIG00501307 FIG00501310: hypothetical protein +FIG00501310 Gll2048 protein +FIG00501312 FIG00501315: hypothetical protein +FIG00501319 FIG00501323: hypothetical protein +FIG00501324 FIG00501325: hypothetical protein +FIG00501326 FIG00501328: hypothetical protein +FIG00501329 FIG00501330: hypothetical protein +FIG00501331 FIG00501332: hypothetical protein +FIG00501332 FIG00501334: hypothetical protein +FIG00501335 FIG00501337: hypothetical protein +FIG00501337 Virulence factor MVIN-like +FIG00501338 FIG00501341: hypothetical protein +FIG00501341 FIG00501342: hypothetical protein +FIG00501355 FIG00501356: hypothetical protein +FIG00501356 FIG00501360: hypothetical protein +FIG00501361 FIG00501364: hypothetical protein +FIG00501364 FIG00501375: hypothetical protein +FIG00501378 FIG00501380: hypothetical protein +FIG00501380 FIG00501382: hypothetical protein +FIG00501382 FIG00501383: hypothetical protein +FIG00501383 FIG00501387: hypothetical protein +FIG00501393 FIG00501399: hypothetical protein +FIG00501399 TadE-like +FIG00501401 FIG00501402: hypothetical protein +FIG00501404 Molecular chaperone (small heat shock protein)-like +FIG00501408 Sortase (Surface protein transpeptidase) , YHCS B.subtilis ortholog +FIG00501409 methylated-DNA-(protein)-cysteine S-methyltransferase +FIG00501410 Diverged glycosyltransferase domain containing protein +FIG00501412 FIG00501415: hypothetical protein +FIG00501417 FIG00501419: hypothetical protein +FIG00501419 FIG00501422: hypothetical protein +FIG00501422 FIG00501423: hypothetical protein +FIG00501423 FIG00501425: hypothetical protein +FIG00501425 FIG00501426: hypothetical protein +FIG00501426 Protein of unknown function DUF11 +FIG00501428 Superfamily I DNA and RNA helicases and helicase subunits-like +FIG00501431 FIG00501432: hypothetical protein +FIG00501432 FIG00501433: hypothetical protein +FIG00501433 FIG00501439: hypothetical protein +FIG00501439 UV damage repair endonuclease-like +FIG00501440 FIG00501443: hypothetical protein +FIG00501448 FIG00501454: hypothetical protein +FIG00501461 FIG00501464: hypothetical protein +FIG00501468 Clostripain +FIG00501477 FIG00501478: hypothetical protein +FIG00501478 Formylmethanofuran dehydrogenase subunit E +FIG00501481 FIG00501486: hypothetical protein +FIG00501486 FIG00501490: hypothetical protein +FIG00501490 FIG00501492: hypothetical protein +FIG00501492 FIG00501494: hypothetical protein +FIG00501494 protein of unknown function DUF547 +FIG00501503 FIG00501504: hypothetical protein +FIG00501504 FIG00501505: hypothetical protein +FIG00501511 FIG00501513: hypothetical protein +FIG00501513 FIG00501514: hypothetical protein +FIG00501514 FIG00501515: hypothetical protein +FIG00501527 FIG00501534: hypothetical protein +FIG00501535 FIG00501540: hypothetical protein +FIG00501540 FIG00501542: hypothetical protein +FIG00501542 FIG00501543: hypothetical protein +FIG00501545 FIG00501554: hypothetical protein +FIG00501554 metallo-beta-lactamase-related protein +FIG00501558 FIG00501559: hypothetical protein +FIG00501559 FIG00501564: hypothetical protein +FIG00501564 FIG00501567: hypothetical protein +FIG00501567 FIG00501569: hypothetical protein +FIG00501569 FIG00501576: hypothetical protein +FIG00501576 FIG00501579: hypothetical protein +FIG00501583 FIG00501584: hypothetical protein +FIG00501584 FIG00501585: hypothetical protein +FIG00501589 FIG00501590: hypothetical protein +FIG00501591 FIG00501592: hypothetical protein +FIG00501595 FIG00501600: hypothetical protein +FIG00501600 FIG00501601: hypothetical protein +FIG00501603 FIG00501604: hypothetical protein +FIG00501604 FIG00501613: hypothetical protein +FIG00501616 FIG00501617: hypothetical protein +FIG00501622 FIG00501624: hypothetical protein +FIG00501625 FIG00501626: hypothetical protein +FIG00501628 FIG00501629: hypothetical protein +FIG00501632 FIG00501633: hypothetical protein +FIG00501633 transglutaminase-like +FIG00501638 FIG00501641: hypothetical protein +FIG00501641 FIG00501643: hypothetical protein +FIG00501655 FIG00501657: hypothetical protein +FIG00501658 FIG00501661: hypothetical protein +FIG00501673 FIG00501674: hypothetical protein +FIG00501677 FIG00501682: hypothetical protein +FIG00501682 FIG00501683: hypothetical protein +FIG00501683 FIG00501685: hypothetical protein +FIG00501685 FIG00501688: hypothetical protein +FIG00501688 FIG00501689: hypothetical protein +FIG00501689 putative glycosly transferase +FIG00501690 FIG00501692: hypothetical protein +FIG00501692 FIG00501693: hypothetical protein +FIG00501693 FIG00501695: hypothetical protein +FIG00501699 Uncharacterized Zn-dependent protease MJ0611 +FIG00501704 FIG00501705: hypothetical protein +FIG00501705 FIG00501706: hypothetical protein +FIG00501706 FIG00501708: hypothetical protein +FIG00501712 Dihydrolipoyllysine-residue acetyltransferase component of acetoin cleaving system (EC 2.3.1.12) (Acetoin dehydrogenase E2 component) (Dihydrolipoamide acetyltransferase component of acetoin cleaving system) +FIG00501732 FIG00501733: hypothetical protein +FIG00501733 FIG00501736: hypothetical protein +FIG00501737 FIG00501739: hypothetical protein +FIG00501741 FIG00501746: hypothetical protein +FIG00501748 FIG00501751: hypothetical protein +FIG00501751 FIG00501752: hypothetical protein +FIG00501755 FIG00501759: hypothetical protein +FIG00501759 FIG00501765: hypothetical protein +FIG00501768 FIG00501769: hypothetical protein +FIG00501776 FIG00501779: hypothetical protein +FIG00501780 FIG00501785: hypothetical protein +FIG00501785 FIG00501786: hypothetical protein +FIG00501786 FIG00501789: hypothetical protein +FIG00501792 FIG038648: MoaD and/or ThiS families +FIG00501794 Dolichol monophosphate mannose synthase +FIG00501800 FIG00501802: hypothetical protein +FIG00501805 FIG00501807: hypothetical protein +FIG00501809 Mannose-1-phosphate guanyltransferase +FIG00501810 FIG00501811: hypothetical protein +FIG00501811 FIG00501814: hypothetical protein +FIG00501829 FIG00501833: hypothetical protein +FIG00501836 FIG00501843: hypothetical protein +FIG00501860 FIG00501869: hypothetical protein +FIG00501869 YoaJ +FIG00501870 Response regulator domain +FIG00501877 FIG00501880: hypothetical protein +FIG00501880 FIG00501881: hypothetical protein +FIG00501881 FIG00501882: hypothetical protein +FIG00501885 FIG00501886: hypothetical protein +FIG00501889 FIG00501891: hypothetical protein +FIG00501891 FIG00501892: hypothetical protein +FIG00501899 FIG00501905: hypothetical protein +FIG00501906 FIG00501907: hypothetical protein +FIG00501922 FIG00501923: hypothetical protein +FIG00501923 N-Acetyl-D-glucosamine ABC transport system, permease protein 2 +FIG00501927 FIG00501931: hypothetical protein +FIG00501931 FIG00501933: hypothetical protein +FIG00501933 FIG00501937: hypothetical protein +FIG00501937 FIG00501938: hypothetical protein +FIG00501938 FIG00501943: hypothetical protein +FIG00501943 FIG00501947: hypothetical protein +FIG00501948 FIG00501951: hypothetical protein +FIG00501951 FIG00501952: hypothetical protein +FIG00501958 FIG00501959: hypothetical protein +FIG00501959 FIG00501962: hypothetical protein +FIG00501962 FIG00501963: hypothetical protein +FIG00501965 FIG00501969: hypothetical protein +FIG00501969 FIG00501971: hypothetical protein +FIG00501971 FIG00501975: hypothetical protein +FIG00501980 FIG00501981: hypothetical protein +FIG00501996 FIG00501998: hypothetical protein +FIG00502000 FIG00502001: hypothetical protein +FIG00502001 Glycoside hydrolase, family 16 precursor +FIG00502006 FIG00502007: hypothetical protein +FIG00502007 FIG00502009: hypothetical protein +FIG00502009 FIG00502011: hypothetical protein +FIG00502011 FIG00502012: hypothetical protein +FIG00502012 FIG00502013: hypothetical protein +FIG00502035 FIG00502042: hypothetical protein +FIG00502043 FIG00502047: hypothetical protein +FIG00502047 FIG00502051: hypothetical protein +FIG00502056 FIG00502061: hypothetical protein +FIG00502070 FIG00502080: hypothetical protein +FIG00502080 Sulfolipid sulfoquinovosyldiacylglycerol biosynthesis protein +FIG00502081 FIG00502084: hypothetical protein +FIG00502084 COG4597: ABC-type amino acid transport system, permease component +FIG00502086 FIG00502091: hypothetical protein +FIG00502097 FIG00502102: hypothetical protein +FIG00502102 FIG00502104: hypothetical protein +FIG00502104 FIG00502106: hypothetical protein +FIG00502106 FIG00502107: hypothetical protein +FIG00502109 FIG00502110: hypothetical protein +FIG00502110 FIG00502112: hypothetical protein +FIG00502113 CRISPR-associated protein, Cas5t family +FIG00502122 FIG00502126: hypothetical protein +FIG00502126 FIG00502129: hypothetical protein +FIG00502129 FIG00502131: hypothetical protein +FIG00502139 FIG00502140: hypothetical protein +FIG00502140 FIG00502141: hypothetical protein +FIG00502141 FIG00502143: hypothetical protein +FIG00502143 FIG00502145: hypothetical protein +FIG00502145 FIG00502147: hypothetical protein +FIG00502150 FIG00502152: hypothetical protein +FIG00502152 glycosyl transferase-related protein +FIG00502155 FIG00502158: hypothetical protein +FIG00502158 FIG00502159: hypothetical protein +FIG00502159 FIG00502160: hypothetical protein +FIG00502160 FIG00502165: hypothetical protein +FIG00502165 FIG00502170: hypothetical protein +FIG00502170 FIG00502172: hypothetical protein +FIG00502172 FIG00502173: hypothetical protein +FIG00502173 FIG00502175: hypothetical protein +FIG00502187 RNA-binding region RNP-1 (RNA recognition motif) +FIG00502188 FIG00502189: hypothetical protein +FIG00502195 FIG00502196: hypothetical protein +FIG00502196 FIG00502199: hypothetical protein +FIG00502199 protein of unknown function DUF86 +FIG00502202 FIG00502203: hypothetical protein +FIG00502226 FIG00502227: hypothetical protein +FIG00502239 FIG00502240: hypothetical protein +FIG00502246 FIG00502249: hypothetical protein +FIG00502253 FIG00502256: hypothetical protein +FIG00502257 FIG00502260: hypothetical protein +FIG00502276 FIG00502278: hypothetical protein +FIG00502278 FIG00502282: hypothetical protein +FIG00502283 FIG00502285: hypothetical protein +FIG00502286 Probable cyclophilin type peptidylprolyl isomerase (EC 5.2.1.8) +FIG00502288 coenzyme F420 hydrogenase/dehydrogenase family protein +FIG00502302 FIG00502306: hypothetical protein +FIG00502311 FIG00502315: hypothetical protein +FIG00502317 Possible restriction /modification enzyme +FIG00502320 FIG00502322: hypothetical protein +FIG00502325 FIG00502326: hypothetical protein +FIG00502326 FIG00502333: hypothetical protein +FIG00502333 FIG00502336: hypothetical protein +FIG00502336 probable deoxyribodipyrimidine photolyase +FIG00502338 SAM-dependent methyltransferase Dde_2880 (UbiE paralog) +FIG00502340 FIG00502345: hypothetical protein +FIG00502345 FIG00502347: hypothetical protein +FIG00502347 FIG00502349: hypothetical protein +FIG00502349 FIG00502351: hypothetical protein +FIG00502351 FIG00502356: hypothetical protein +FIG00502356 FIG00502358: hypothetical protein +FIG00502358 FIG00502362: hypothetical protein +FIG00502362 FIG00502365: hypothetical protein +FIG00502365 Competence protein ComEA helix-hairpin-helix region +FIG00502367 FIG00502368: hypothetical protein +FIG00502368 FIG00502369: hypothetical protein +FIG00502369 FIG00502375: hypothetical protein +FIG00502375 Sugar transport system permease +FIG00502376 FIG00502377: hypothetical protein +FIG00502383 FIG00502389: hypothetical protein +FIG00502389 FIG00502391: hypothetical protein +FIG00502393 FIG00502395: hypothetical protein +FIG00502395 FIG00502400: hypothetical protein +FIG00502400 FIG00502408: hypothetical protein +FIG00502408 FIG00502410: hypothetical protein +FIG00502410 FIG00502412: hypothetical protein +FIG00502417 uncharacterized peroxidase-related enzyme +FIG00502421 FIG00502423: hypothetical protein +FIG00502423 FIG00502433: hypothetical protein +FIG00502438 FIG00502441: hypothetical protein +FIG00502441 FIG00502447: hypothetical protein +FIG00502447 FIG00502451: hypothetical protein +FIG00502457 FIG00502460: hypothetical protein +FIG00502460 FIG00502461: hypothetical protein +FIG00502461 FIG00502468: hypothetical protein +FIG00502468 FIG00502469: hypothetical protein +FIG00502471 FIG00502472: hypothetical protein +FIG00502472 FIG00502479: hypothetical protein +FIG00502479 FIG00502483: hypothetical protein +FIG00502485 FIG00502489: hypothetical protein +FIG00502491 FIG00502492: hypothetical protein +FIG00502494 FIG00502500: hypothetical protein +FIG00502500 FIG00502501: hypothetical protein +FIG00502501 FIG00502506: hypothetical protein +FIG00502514 ComE-like competence protein +FIG00502528 alpha-1,6-glucosidase, pullulanase-type +FIG00502534 FIG00502535: hypothetical protein +FIG00502539 FIG00502540: hypothetical protein +FIG00502540 Scaffold protein for [4Fe-4S] cluster assembly, MRP-like, similar to chloroplast-targeted plant protein HCF101 +FIG00502544 FIG00502545: hypothetical protein +FIG00502545 FIG00502549: hypothetical protein +FIG00502550 FIG00502551: hypothetical protein +FIG00502551 FIG00502552: hypothetical protein +FIG00502553 FIG00502568: hypothetical protein +FIG00502568 FIG00502570: hypothetical protein +FIG00502575 FIG00502576: hypothetical protein +FIG00502576 FIG00502577: hypothetical protein +FIG00502577 FIG00502579: hypothetical protein +FIG00502579 FIG00502580: hypothetical protein +FIG00502587 FIG00502589: hypothetical protein +FIG00502589 FIG00502594: hypothetical protein +FIG00502597 FIG00502598: hypothetical protein +FIG00502603 hydrogenase maturation proteinase [imported] (hupD) +FIG00502605 MoaD, archaeal +FIG00502625 FIG00502629: hypothetical protein +FIG00502634 FIG00502639: hypothetical protein +FIG00502639 Multidrug efflux pump P55 +FIG00502656 FIG00502658: hypothetical protein +FIG00502664 FIG00502666: hypothetical protein +FIG00502674 FIG00502683: hypothetical protein +FIG00502688 FIG00502691: hypothetical protein +FIG00502691 FIG00502698: hypothetical protein +FIG00502711 FIG00502715: hypothetical protein +FIG00502721 FIG00502723: hypothetical protein +FIG00502723 FIG00502729: hypothetical protein +FIG00502743 FIG00502749: hypothetical protein +FIG00502751 FIG00502756: hypothetical protein +FIG00502756 FIG00502757: hypothetical protein +FIG00502776 FIG00502778: hypothetical protein +FIG00502781 FIG00502786: hypothetical protein +FIG00502786 FIG00502792: hypothetical protein +FIG00502796 FIG00502800: hypothetical protein +FIG00502800 FIG00502804: hypothetical protein +FIG00502804 FIG00502805: hypothetical protein +FIG00502805 FIG00502812: hypothetical protein +FIG00502813 FIG00502818: hypothetical protein +FIG00502818 PxORF73 peptide +FIG00502826 FIG00502832: hypothetical protein +FIG00502832 Serine-protein kinase RsbW (EC 2.7.11.1) / Anti-sigma F factor antagonist (spoIIAA-2); Anti-sigma B factor antagonist RsbV +FIG00502833 FIG00502834: hypothetical protein +FIG00502834 FIG00502835: hypothetical protein +FIG00502835 sensory box-containing diguanylate cyclase, putative +FIG00502838 FIG00502841: hypothetical protein +FIG00502841 FIG00502842: hypothetical protein +FIG00502846 FIG00502847: hypothetical protein +FIG00502847 FIG00502848: hypothetical protein +FIG00502848 FIG00502854: hypothetical protein +FIG00502854 Predicted ATPase (AAA+ superfamily) +FIG00502856 FIG00502860: hypothetical protein +FIG00502864 FIG00502869: hypothetical protein +FIG00502874 transcriptional regulator TrmB +FIG00502876 FIG00502883: hypothetical protein +FIG00502883 FIG00502887: hypothetical protein +FIG00502887 FIG00502889: hypothetical protein +FIG00502889 FIG00502893: hypothetical protein +FIG00502893 FIG00502901: hypothetical protein +FIG00502904 FIG00502906: hypothetical protein +FIG00502907 FIG00502912: hypothetical protein +FIG00502912 FIG00502917: hypothetical protein +FIG00502917 FIG00502918: hypothetical protein +FIG00502918 protein tyrosine phosphatase +FIG00502931 FIG00502937: hypothetical protein +FIG00502937 FIG00502941: hypothetical protein +FIG00502957 Arsenical resistance operon repressor / Arsenate reductase (EC 1.20.4.1) +FIG00502972 FIG00502973: hypothetical protein +FIG00502973 FIG00502975: hypothetical protein +FIG00502980 FIG00502986: hypothetical protein +FIG00502986 FIG00502991: hypothetical protein +FIG00502991 FIG00502993: hypothetical protein +FIG00502993 FIG00503008: hypothetical protein +FIG00503008 FIG00503013: hypothetical protein +FIG00503013 FIG00503016: hypothetical protein +FIG00503020 FIG00503039: hypothetical protein +FIG00503039 FIG00503047: hypothetical protein +FIG00503055 FIG00503064: hypothetical protein +FIG00503066 Transcriptional regulatory protein, C-terminal +FIG00503070 Gll3515 protein +FIG00503087 FIG00503089: hypothetical protein +FIG00503096 FIG00503097: hypothetical protein +FIG00503097 FIG00503101: hypothetical protein +FIG00503103 FIG00503109: hypothetical protein +FIG00503111 FIG00503114: hypothetical protein +FIG00503114 FIG00503117: hypothetical protein +FIG00503117 FIG00503118: hypothetical protein +FIG00503130 FIG00503133: hypothetical protein +FIG00503140 FIG00503143: hypothetical protein +FIG00503143 FIG00503144: hypothetical protein +FIG00503152 FIG00503155: hypothetical protein +FIG00503155 FIG00503159: hypothetical protein +FIG00503159 FIG00503168: hypothetical protein +FIG00503176 VrlJ +FIG00503180 FIG00503181: hypothetical protein +FIG00503181 FIG00503183: hypothetical protein +FIG00503191 FIG00503194: hypothetical protein +FIG00503194 FIG00503195: hypothetical protein +FIG00503195 FIG00503203: hypothetical protein +FIG00503212 FIG00503222: hypothetical protein +FIG00503222 FIG00503229: hypothetical protein +FIG00503229 FIG00503231: hypothetical protein +FIG00503231 FIG00503232: hypothetical protein +FIG00503232 FIG00503239: hypothetical protein +FIG00503239 FIG00503256: hypothetical protein +FIG00503256 FIG00503266: hypothetical protein +FIG00503266 FIG00503272: hypothetical protein +FIG00503277 FIG00503292: hypothetical protein +FIG00503292 FIG00503304: hypothetical protein +FIG00503317 FIG00503318: hypothetical protein +FIG00503321 FIG00503322: hypothetical protein +FIG00503322 probable comEA-related protein +FIG00503337 FIG00503358: hypothetical protein +FIG00503384 FIG00503388: hypothetical protein +FIG00503388 FIG00503389: hypothetical protein +FIG00503389 Sll0670 protein +FIG00503395 FIG00503398: hypothetical protein +FIG00503404 FIG00503421: hypothetical protein +FIG00503421 FIG00503426: hypothetical protein +FIG00503428 FIG00503443: hypothetical protein +FIG00503450 FIG00503463: hypothetical protein +FIG00503485 FIG00503495: hypothetical protein +FIG00503520 FIG00503527: hypothetical protein +FIG00503534 FIG00503548: hypothetical protein +FIG00503548 FIG00503561: hypothetical protein +FIG00503586 FIG00503588: hypothetical protein +FIG00503599 FIG00503614: hypothetical protein +FIG00503621 FIG00503624: hypothetical protein +FIG00503624 FIG00503626: hypothetical protein +FIG00503626 FIG00503629: hypothetical protein +FIG00503691 Cadmium-transporting ATPase (EC 3.6.3.3) +FIG00503707 FIG00503711: hypothetical protein +FIG00503711 Cellulose synthase catalytic subunit +FIG00503744 FIG00503757: hypothetical protein +FIG00503776 FIG00503798: hypothetical protein +FIG00503798 FIG00503837: hypothetical protein +FIG00503950 type II restriction endonuclease TdeIII +FIG00504548 tobe domain protein +FIG00504827 peptidyl-prolyl cis-trans isomerase, cyclophilin-type +FIG00504860 protein of unknown function DUF395 YeeE/YedE +FIG00504968 Phosphotransferase involved in threonylcarbamoyladenosine t(6)A37 formation in tRNA +FIG00505201 Possible HMGL-like family protein +FIG00505269 ABC transporter efflux protein +FIG00505545 Phosphoglyceromutase +FIG00505605 FIG00505639: hypothetical protein +FIG00505940 fimbrial subunit protein +FIG00505986 probable thermolabile hemolysin +FIG00505989 INTRACELLULAR PHB DEPOLYMERASE +FIG00506003 probable sensor/response regulator hybrid +FIG00506018 FIG00506028: hypothetical protein +FIG00506053 probable pyocin R2_PP, tail fiber protein +FIG00506120 FIG00726091: hypothetical protein +FIG00506131 probable cytochrome c5 +FIG00506172 FIG00506173: hypothetical protein +FIG00506226 Fap amyloid fiber secretin +FIG00506258 ABC superfamily (ATP-binding membrane) transport protein +FIG00506345 probable bacterioferritin +FIG00506353 FIG00506354: hypothetical protein +FIG00506360 y4mC gene in pNGR234a homolog +FIG00506402 Phenylacetic acid degradation protein paaA +FIG00506408 FIG00506409: hypothetical protein +FIG00506433 probable site-specific recombinase +FIG00506448 FIG00506450: hypothetical protein +FIG00506451 GMP synthase [glutamine-hydrolyzing] (EC 6.3.5.2) +FIG00506452 rtn like protein +FIG00506573 MuT/NUDIX protein +FIG00506601 FIG00506609: hypothetical protein +FIG00506636 FIG00506639: hypothetical protein +FIG00506649 FIG00506651: hypothetical protein +FIG00506651 two-component sensor histidine kinase protein +FIG00506667 FIG00506677: hypothetical protein +FIG00506695 probable two component system, transcriptional regulatory protein +FIG00506717 Ketopantoate reductase PanG (EC 1.1.1.169) +FIG00506743 FIG00506745: hypothetical protein +FIG00506771 probable porin protein +FIG00506820 probable dioxygenase, alpha subunit +FIG00506828 FIG00506846: hypothetical protein +FIG00506847 FIG00506850: hypothetical protein +FIG00506933 probable activation/secretion signal peptide protein +FIG00506943 FIG00506946: hypothetical protein +FIG00507121 FIG00507126: hypothetical protein +FIG00507141 FIG00507168: hypothetical protein +FIG00507235 probable phage baseplate component +FIG00507248 phosphodiesterase I +FIG00507249 amino acid ABC transporter, periplasmic-binding protein +FIG00507275 calcium/proton antiporter +FIG00507352 probable methyltransferase protein +FIG00507463 Glycine betaine-binding protein +FIG00507514 FIG00507517: hypothetical protein +FIG00507565 Secretion system effector SseC +FIG00507591 Ribosomal large subunit pseudouridine synthase E (EC 4.2.1.70) +FIG00507670 probable Fe-S oxidoreductase +FIG00507724 FIG00507729: hypothetical protein +FIG00507745 FIG00507748: hypothetical protein +FIG00507757 probable ATP-dependent RNA helicase +FIG00507761 probable transcriptional regulator LysR-family +FIG00507769 Anti-sigma F factor antagonist (spoIIAA-2); Anti-sigma B factor antagonist RsbV +FIG00507817 primosomal replication protein +FIG00507829 FIG00507830: hypothetical protein +FIG00507844 Polyphosphate kinase 2 (EC 2.7.4.1) +FIG00507926 FIG00507944: hypothetical protein +FIG00507944 FIG00507951: hypothetical protein +FIG00507966 probable ribonuclease precursor +FIG00508013 FIG00508016: hypothetical protein +FIG00508033 FIG00508034: hypothetical protein +FIG00508036 diguanylate cyclase/phosphodiesterase with PAS/PAC and GAF sensor(s) +FIG00508055 Gamma-butyrobetaine,2-oxoglutarate dioxygenase (EC 1.14.11.1) +FIG00508058 Phage tail protein +FIG00508074 protein of unknown function DUF1007 +FIG00508184 protein of unknown function DUF1043 +FIG00508199 FIG00508203: hypothetical protein +FIG00508219 conserved hypothetical protein 730 +FIG00508234 protein of unknown function DUF785 +FIG00508275 FIG00508282: hypothetical protein +FIG00508325 diguanylate phosphodiesterase with GAF sensor +FIG00508347 putative regulator protein +FIG00508376 lysine N6-hydroxylase/L-ornithine N5-oxygenase family protein +FIG00508396 FIG00508409: hypothetical protein +FIG00508409 FIG00508410: hypothetical protein +FIG00508463 Methionine synthase, vitamin-B12 independent +FIG00508477 FIG00508492: hypothetical protein +FIG00508728 hfaB protein +FIG00508797 oxidoreductase-like protein +FIG00508845 ABC-3 +FIG00508907 FIG00508910: hypothetical protein +FIG00508952 FIG00960493: hypothetical protein +FIG00508976 sodium:neurotransmitter symporter +FIG00509044 FIG00509047: hypothetical protein +FIG00509056 putative lipoprotein NlpC +FIG00509114 PvdE, pyoverdine ABC export system, fused ATPase and permease components @ ABC-type siderophore export system, fused ATPase and permease components +FIG00509171 succinate dehydrogenase cytochrome b subunit family protein +FIG00509295 FIG00509310: hypothetical protein +FIG00509391 FIG00509394: hypothetical protein +FIG00509431 FIG00509433: hypothetical protein +FIG00509463 FIG00509464: hypothetical protein +FIG00509464 protein of unknown function DUF1282 +FIG00509545 AsmA +FIG00509550 SH3-like region +FIG00509559 membrane protein, major facilitator transporter family +FIG00509733 FIG00509740: hypothetical protein +FIG00509773 Inner membrane thiol:disulfide oxidoreductase, DsbB-like +FIG00509778 FIG00509781: hypothetical protein +FIG00509782 FIG00509783: hypothetical protein +FIG00509786 FIG00626879: hypothetical protein +FIG00509787 FIG01200173: hypothetical protein +FIG00509788 FIG00638072: hypothetical protein +FIG00509796 SAM-dependent methyltransferase (EC 2.1.1.-) +FIG00509797 FIG00509798: hypothetical protein +FIG00509798 FIG00509799: hypothetical protein +FIG00509801 FIG00509805: hypothetical protein +FIG00509805 FIG00509806: hypothetical protein +FIG00509808 Phosphogluconate repressor HexR, RpiR family +FIG00509814 FIG00638433: Hypothetical protein YibL +FIG00509815 FIG00509816: hypothetical protein +FIG00509816 T1SS secreted agglutinin RTX +FIG00509819 rRNA small subunit methyltransferase J +FIG00509825 FIG00509829: hypothetical protein +FIG00509841 FIG00509847: hypothetical protein +FIG00509848 FIG00509851: hypothetical protein +FIG00509851 FIG00509852: hypothetical protein +FIG00509855 FIG00509857: hypothetical protein +FIG00509857 FIG00509860: hypothetical protein +FIG00509872 Outer membrane lipoprotein Blc +FIG00509877 FIG00509881: hypothetical protein +FIG00509882 FIG00509885: hypothetical protein +FIG00509885 FIG00509888: hypothetical protein +FIG00509888 FIG00509891: hypothetical protein +FIG00509892 FIG00509893: hypothetical protein +FIG00509893 FIG00509894: hypothetical protein +FIG00509896 FIG00509898: hypothetical protein +FIG00509898 FIG01199774: hypothetical protein +FIG00509901 FIG00509904: hypothetical protein +FIG00509904 FIG00509905: hypothetical protein +FIG00509905 FIG00509906: hypothetical protein +FIG00509906 FIG00509908: hypothetical protein +FIG00509908 FIG00509911: hypothetical protein +FIG00509912 FIG00509918: hypothetical protein +FIG00509918 FIG00509921: hypothetical protein +FIG00509921 Putative nucleotide di-P-sugar epimerase or dehydratase +FIG00509922 FIG01048220: hypothetical protein +FIG00509945 FIG00509946: hypothetical protein +FIG00509955 Putative S-transferase +FIG00509957 FIG00638902: hypothetical protein +FIG00509958 FIG00509962: hypothetical protein +FIG00509965 FIG00509966: hypothetical protein +FIG00509967 YaeQ protein +FIG00509972 FIG00509978: hypothetical protein +FIG00509978 COG3668: Plasmid stabilization system protein +FIG00509980 FIG00613320: hypothetical protein +FIG00509988 NAD(P)H-flavin oxidoreductase +FIG00509992 FIG00509993: hypothetical protein +FIG00510004 Lipase, GDXG family +FIG00510010 FIG00510011: hypothetical protein +FIG00510011 Outer membrane protein G precursor +FIG00510019 FIG00510021: hypothetical protein +FIG00510023 tRNA dihydrouridine synthase A (EC 1.-.-.-) +FIG00510025 FIG00638619: hypothetical protein +FIG00510026 FIG00510027: hypothetical protein +FIG00510029 FIG00510030: hypothetical protein +FIG00510030 FIG00510038: hypothetical protein +FIG00510038 Glutamine ABC transporter, periplasmic glutamine-binding protein (TC 3.A.1.3.2) +FIG00510039 Hypothetical lipoprotein yafL precursor +FIG00510042 Putative HlyD family secretion protein +FIG00510045 FIG00510048: hypothetical protein +FIG00510048 Entericidin A precursor +FIG00510049 FIG00510052: hypothetical protein +FIG00510053 FIG00639558: hypothetical protein +FIG00510055 Probable MFS transporter +FIG00510061 putative alpha helix protein +FIG00510065 FIG00614015: hypothetical protein +FIG00510069 FIG00510072: hypothetical protein +FIG00510076 FIG00510082: hypothetical protein +FIG00510083 FIG00510086: hypothetical protein +FIG00510086 FIG00510087: hypothetical protein +FIG00510087 Phosphosugar isomerase/binding protein +FIG00510089 FIG00510094: hypothetical protein +FIG00510094 FIG01220641: hypothetical protein +FIG00510095 FIG00510101: hypothetical protein +FIG00510113 FIG00510115: hypothetical protein +FIG00510117 FIG01219950: hypothetical protein +FIG00510123 FIG00510125: hypothetical protein +FIG00510130 Transcriptional regulator, AraC family +FIG00510137 FIG00510140: hypothetical protein +FIG00510143 FIG00510144: hypothetical protein +FIG00510144 FIG00510145: hypothetical protein +FIG00510147 Fimbriae W protein +FIG00510148 glutathione transporter ATP-binding protein +FIG00510149 FIG00510151: hypothetical protein +FIG00510151 autotransporter +FIG00510159 FIG00510160: hypothetical protein +FIG00510166 FIG00510169: hypothetical protein +FIG00510172 FIG00510173: hypothetical protein +FIG00510173 Putative cryptic C4-dicarboxylate transporter DcuD +FIG00510174 FIG00510175: hypothetical protein +FIG00510192 FIG00510195: hypothetical protein +FIG00510195 FIG00510196: hypothetical protein +FIG00510197 Protein fdrA +FIG00510200 FIG00510201: hypothetical protein +FIG00510207 Hydrolase (HAD superfamily) +FIG00510210 FIG00510213: hypothetical protein +FIG00510221 Fimbrial protein YadM-like +FIG00510222 Fimbrial protein YadN-like +FIG00510244 FIG00639395: hypothetical protein +FIG00510246 Inner membrane protein YiaB +FIG00510250 cyd operon protein YbgT +FIG00510254 FIG00510256: hypothetical protein +FIG00510256 Pi-fimbriae chaperone protein +FIG00510263 Complete genome; segment 2/17 +FIG00510276 FIG00510277: hypothetical protein +FIG00510279 FIG00510284: hypothetical protein +FIG00510285 FIG00510288: hypothetical protein +FIG00510288 FIG00510289: hypothetical protein +FIG00510290 probable regulatory protein YPO0736 +FIG00510293 FIG00510295: hypothetical protein +FIG00510299 FIG00510303: hypothetical protein +FIG00510303 FIG00510304: hypothetical protein +FIG00510309 FIG00638290: hypothetical protein +FIG00510313 FIG00639040: hypothetical protein +FIG00510314 FIG00510315: hypothetical protein +FIG00510320 FIG00510322: hypothetical protein +FIG00510322 FIG00510324: hypothetical protein +FIG00510324 FIG00510327: hypothetical protein +FIG00510327 FIG00510328: hypothetical protein +FIG00510333 FIG00510335: hypothetical protein +FIG00510335 FIG00510344: hypothetical protein +FIG00510350 FIG00510354: hypothetical protein +FIG00510354 FIG00638334: hypothetical protein +FIG00510359 Cystine-binding protein +FIG00510360 FIG00510365: hypothetical protein +FIG00510370 FIG01046856: hypothetical protein +FIG00510371 probable enzyme yhhN +FIG00510373 FIG00510374: hypothetical protein +FIG00510383 FIG00510384: hypothetical protein +FIG00510384 FIG00510385: hypothetical protein +FIG00510385 FIG00638672: hypothetical protein +FIG00510389 FIG00510390: hypothetical protein +FIG00510396 FIG00510401: hypothetical protein +FIG00510409 hypothetical protein +FIG00510410 PhfB +FIG00510412 Glutamate Aspartate periplasmic binding protein precursor gltI (TC 3.A.1.3.4) +FIG00510416 FIG00510417: hypothetical protein +FIG00510417 YdcH protein +FIG00510433 FIG00510434: hypothetical protein +FIG00510435 FIG00510436: hypothetical protein +FIG00510445 FIG00638134: hypothetical protein +FIG00510457 FIG00510464: hypothetical protein +FIG00510472 Putative membrane-bound metal-dependent hydrolases +FIG00510491 FIG01046325: hypothetical protein +FIG00510492 FIG01046288: hypothetical protein +FIG00510508 FIG00510510: hypothetical protein +FIG00510510 Putative fimbrial subunit protein +FIG00510514 FIG00510518: hypothetical protein +FIG00510518 FIG00638150: hypothetical protein +FIG00510522 Putative secreted protein +FIG00510527 Fusaric acid resistance protein fusE +FIG00510529 FIG00510530: hypothetical protein +FIG00510530 FIG00510534: hypothetical protein +FIG00510538 periplasmic solute binding protein +FIG00510542 FIG00510543: hypothetical protein +FIG00510551 FIG00510553: hypothetical protein +FIG00510553 FIG00510554: hypothetical protein +FIG00510554 General stress protein 18 +FIG00510556 FIG00510559: hypothetical protein +FIG00510559 FIG00637865: hypothetical protein +FIG00510563 FIG00510567: hypothetical protein +FIG00510567 FIG01045872: hypothetical protein +FIG00510571 FIG00510576: hypothetical protein +FIG00510578 FIG00510582: hypothetical protein +FIG00510582 FIG00510586: hypothetical protein +FIG00510592 putative outer membrane lipoprotein +FIG00510600 FIG00510603: hypothetical protein +FIG00510603 Methylmalonyl-CoA decarboxylase (EC 4.1.1.41) +FIG00510614 FIG00626197: hypothetical protein +FIG00510634 FIG00510638: hypothetical protein +FIG00510639 FIG00510640: hypothetical protein +FIG00510640 Osmotically inducible protein C +FIG00510642 putative outer membrane receptor for iron compound or colicin +FIG00510661 Type IV pilus biogenesis protein PilP +FIG00510678 putative permease of ferrichrome ABC transporter +FIG00510681 Phage-like lysozyme +FIG00510684 FIG00510687: hypothetical protein +FIG00510688 FIG00510689: hypothetical protein +FIG00510692 Putative virulence effector protein +FIG00510697 FIG00510698: hypothetical protein +FIG00510710 FIG00626276: hypothetical protein +FIG00510712 FIG00510715: hypothetical protein +FIG00510718 Transcriptional regulator SlyA +FIG00510719 FIG00922551: hypothetical protein +FIG00510728 FIG00510729: hypothetical protein +FIG00510729 FIG00510730: hypothetical protein +FIG00510730 PTS system, diacetylchitobiose-specific IIA component (EC 2.7.1.69) +FIG00510744 FIG00510756: hypothetical protein +FIG00510766 FIG00510767: hypothetical protein +FIG00510767 FIG00510771: hypothetical protein +FIG00510771 Transcriptional regulator CKO_02662, LacI family +FIG00510772 FIG00510779: hypothetical protein +FIG00510783 FIG00510787: hypothetical protein +FIG00510787 FIG00510789: hypothetical protein +FIG00510789 FIG00510790: hypothetical protein +FIG00510820 Hypothetical lipoprotein yehR +FIG00510827 FIG00510837: hypothetical protein +FIG00510854 FIG00731603: hypothetical protein +FIG00510862 MrfE +FIG00510864 FIG00637899: hypothetical protein +FIG00510869 FIG00510870: hypothetical protein +FIG00510873 Fermentation/respiration switch protein +FIG00510909 FIG00510911: hypothetical protein +FIG00510918 Qercetin 2,3-dioxygenase +FIG00510935 FIG00510936: hypothetical protein +FIG00510955 FIG01045728: hypothetical protein +FIG00510966 FIG00731433: hypothetical protein +FIG00510973 FIG00510974: hypothetical protein +FIG00510974 probable membrane protein YPO2654 +FIG00510982 FIG00510984: hypothetical protein +FIG00510987 FIG00510988: hypothetical protein +FIG00510994 FIG00638105: hypothetical protein +FIG00511006 ABC transporter, solute-binding protein +FIG00511011 FIG00511012: hypothetical protein +FIG00511019 FIG00511021: hypothetical protein +FIG00511023 FIG00511030: hypothetical protein +FIG00511038 Mechanosensitive ion channel +FIG00511050 Protein ydhR precursor +FIG00511057 MobB protein +FIG00511098 FIG00511099: hypothetical protein +FIG00511103 FIG00511106: hypothetical protein +FIG00511109 Serine phosphatase RsbU, regulator of sigma subunit +FIG00511111 FIG00511113: hypothetical protein +FIG00511116 FIG00511119: hypothetical protein +FIG00511120 FIG00511122: hypothetical protein +FIG00511122 FIG00511124: hypothetical protein +FIG00511124 FIG00511125: hypothetical protein +FIG00511127 FIG00511130: hypothetical protein +FIG00511131 FIG00511132: hypothetical protein +FIG00511134 FIG00511135: hypothetical protein +FIG00511135 FIG00511136: hypothetical protein +FIG00511137 FIG00511138: hypothetical protein +FIG00511138 FIG00511140: hypothetical protein +FIG00511143 FIG027937: secreted protein +FIG00511154 FIG00511158: hypothetical protein +FIG00511160 ABC transporter periplasmic binding protein +FIG00511161 putative ranscriptional regulator, LacI-family +FIG00511162 FIG00511163: hypothetical protein +FIG00511163 FIG00511164: hypothetical protein +FIG00511164 FIG00511165: hypothetical protein +FIG00511168 FIG00511170: hypothetical protein +FIG00511171 FIG00511172: hypothetical protein +FIG00511172 FIG00511173: hypothetical protein +FIG00511173 FIG00511174: hypothetical protein +FIG00511174 FIG00511175: hypothetical protein +FIG00511178 FIG00511179: hypothetical protein +FIG00511179 FIG00511183: hypothetical protein +FIG00511184 FIG00511185: hypothetical protein +FIG00511185 FIG00511186: hypothetical protein +FIG00511186 DUF2017 domain-containing protein +FIG00511187 Gb|AAF24581.1 +FIG00511193 Putative glycosyl hydrolase of unknown function (DUF1680) +FIG00511197 FIG00511198: hypothetical protein +FIG00511199 FIG00511200: hypothetical protein +FIG00511200 FIG00511202: hypothetical protein +FIG00511203 FIG00511204: hypothetical protein +FIG00511212 FIG00511216: hypothetical protein +FIG00511217 FIG00511219: hypothetical protein +FIG00511221 FIG00511223: hypothetical protein +FIG00511230 FIG00511233: hypothetical protein +FIG00511241 FIG00511242: hypothetical protein +FIG00511242 FIG00511245: hypothetical protein +FIG00511245 FIG00511247: hypothetical protein +FIG00511248 FIG00511249: hypothetical protein +FIG00511249 FIG00511250: hypothetical protein +FIG00511250 FIG00511251: hypothetical protein +FIG00511251 putative methylase( EC:2.1.1.- ) +FIG00511254 FIG00511255: hypothetical protein +FIG00511258 FIG00511259: hypothetical protein +FIG00511261 Sugar ABC transporter substrate-binding protein +FIG00511269 FIG00511270: hypothetical protein +FIG00511271 FIG00511275: hypothetical protein +FIG00511276 FIG00511277: hypothetical protein +FIG00511277 FIG00511279: hypothetical protein +FIG00511281 FIG00511282: hypothetical protein +FIG00511282 FIG00511283: hypothetical protein +FIG00511283 FIG00537953: hypothetical protein +FIG00511285 FIG00511286: hypothetical protein +FIG00511293 FIG00511294: hypothetical protein +FIG00511294 FIG00511297: hypothetical protein +FIG00511297 FIG00511298: hypothetical protein +FIG00511298 FIG00511299: hypothetical protein +FIG00511299 FIG00511300: hypothetical protein +FIG00511301 rhomboid family membrane protein +FIG00511311 FIG00511313: hypothetical protein +FIG00511319 FIG00511321: hypothetical protein +FIG00511323 FIG00511324: hypothetical protein +FIG00511324 FIG00511325: hypothetical protein +FIG00511325 FIG00511326: hypothetical protein +FIG00511326 FIG00511327: hypothetical protein +FIG00511327 putative transcriptional regulator, GntR family +FIG00511330 FIG00511331: hypothetical protein +FIG00511333 FIG00511334: hypothetical protein +FIG00511334 FIG00511336: hypothetical protein +FIG00511341 FIG00511343: hypothetical protein +FIG00511343 Conserved protein with diacylglycerol kinase catalytic domain +FIG00511344 FIG00511348: hypothetical protein +FIG00511348 FIG00511350: hypothetical protein +FIG00511350 FIG00511351: hypothetical protein +FIG00511352 FIG00511353: hypothetical protein +FIG00511353 FIG00511354: hypothetical protein +FIG00511357 FIG00511358: hypothetical protein +FIG00511359 Putative sarcosine oxidase (EC 1.5.3.1) +FIG00511361 FIG00511362: hypothetical protein +FIG00511362 FIG00511363: hypothetical protein +FIG00511367 Carboxymethylenebutenolidase (EC 3.1.1.45) +FIG00511373 FIG00511375: hypothetical protein +FIG00511375 FIG00511377: hypothetical protein +FIG00511377 FIG00511378: hypothetical protein +FIG00511378 FIG00511379: hypothetical protein +FIG00511381 FIG00511384: hypothetical protein +FIG00511384 Drug resistance transporter Bcr/CflA subfamily; possible bicyclomycin resistance protein +FIG00511394 FIG00511395: hypothetical protein +FIG00511403 FIG00511404: hypothetical protein +FIG00511404 FIG00511407: hypothetical protein +FIG00511419 Probable xylitol oxidase (EC 1.1.3.41) +FIG00511422 FIG00511423: hypothetical protein +FIG00511423 FIG00511424: hypothetical protein +FIG00511424 FIG00511425: hypothetical protein +FIG00511433 FIG00511434: hypothetical protein +FIG00511434 FIG00511435: hypothetical protein +FIG00511438 FIG00511442: hypothetical protein +FIG00511444 FIG00511445: hypothetical protein +FIG00511445 FIG00511446: hypothetical protein +FIG00511447 FIG00511448: hypothetical protein +FIG00511448 FIG00511449: hypothetical protein +FIG00511456 FIG00511458: hypothetical protein +FIG00511459 FIG00511460: hypothetical protein +FIG00511460 FIG00511461: hypothetical protein +FIG00511463 FIG00511464: hypothetical protein +FIG00511464 FIG00511465: hypothetical protein +FIG00511465 Probable transcriptional regulator protein +FIG00511466 FIG00511467: hypothetical protein +FIG00511467 FIG00511468: hypothetical protein +FIG00511468 FIG00511469: hypothetical protein +FIG00511473 FIG00511475: hypothetical protein +FIG00511483 FIG00511484: hypothetical protein +FIG00511484 FIG00511486: hypothetical protein +FIG00511489 FIG00511490: hypothetical protein +FIG00511491 FIG00511493: hypothetical protein +FIG00511496 FIG00511498: hypothetical protein +FIG00511498 Transcription regulator AmtR +FIG00511499 FIG00511500: hypothetical protein +FIG00511500 FAD-binding 9, siderophore-interacting domain protein +FIG00511504 FIG00511505: hypothetical protein +FIG00511505 FIG00511507: hypothetical protein +FIG00511508 FIG00511510: hypothetical protein +FIG00511511 putative peptidoglycan binding domain protein +FIG00511512 FIG00511513: hypothetical protein +FIG00511516 FIG00511517: hypothetical protein +FIG00511518 FIG00511519: hypothetical protein +FIG00511519 FIG00511521: hypothetical protein +FIG00511521 FIG00511523: hypothetical protein +FIG00511525 Cellulose synthase catalytic subunit +FIG00511527 FIG00511528: hypothetical protein +FIG00511532 FIG00511533: hypothetical protein +FIG00511533 FIG00511535: hypothetical protein +FIG00511535 conserved hypothetical protein, putative phosphohydrolase +FIG00511538 FIG00511539: hypothetical protein +FIG00511539 FIG00511541: hypothetical protein +FIG00511543 FIG00511544: hypothetical protein +FIG00511548 FIG00511549: hypothetical protein +FIG00511556 FIG00511557: hypothetical protein +FIG00511561 FIG00511562: hypothetical protein +FIG00511563 DNA polymerase III, epsilon subunit +FIG00511565 FIG00511566: hypothetical protein +FIG00511566 FIG00511567: hypothetical protein +FIG00511569 FIG00511571: hypothetical protein +FIG00511573 FIG00511574: hypothetical protein +FIG00511574 FIG00511576: hypothetical protein +FIG00511576 FIG00511577: hypothetical protein +FIG00511577 FIG00511578: hypothetical protein +FIG00511578 FIG00511582: hypothetical protein +FIG00511582 FIG00511586: hypothetical protein +FIG00511587 FIG00511588: hypothetical protein +FIG00511588 FIG00511589: hypothetical protein +FIG00511591 FIG00511593: hypothetical protein +FIG00511594 FIG00511595: hypothetical protein +FIG00511599 FIG00511601: hypothetical protein +FIG00511601 FIG00511602: hypothetical protein +FIG00511608 FIG00511609: hypothetical protein +FIG00511610 conserved protein, putative metal-dependent hydrolase +FIG00511614 FIG00511615: hypothetical protein +FIG00511618 FIG00511619: hypothetical protein +FIG00511619 FIG00511620: hypothetical protein +FIG00511621 FIG00511622: hypothetical protein +FIG00511623 FIG00511625: hypothetical protein +FIG00511631 FIG00511632: hypothetical protein +FIG00511632 FIG00511633: hypothetical protein +FIG00511640 FIG00511642: hypothetical protein +FIG00511646 FIG00511649: hypothetical protein +FIG00511652 FIG00511653: hypothetical protein +FIG00511655 FIG00511656: hypothetical protein +FIG00511656 FIG00511658: hypothetical protein +FIG00511660 FIG00511661: hypothetical protein +FIG00511663 FIG00511664: hypothetical protein +FIG00511678 FIG00511679: hypothetical protein +FIG00511679 FIG00511680: hypothetical protein +FIG00511680 FIG00511681: hypothetical protein +FIG00511684 FIG00511686: hypothetical protein +FIG00511686 FIG00511687: hypothetical protein +FIG00511694 FIG00511695: hypothetical protein +FIG00511695 putative membrane protein involved in chromosome condensation +FIG00511697 FIG00511698: hypothetical protein +FIG00511698 FIG00511699: hypothetical protein +FIG00511701 FIG00511703: hypothetical protein +FIG00511708 FIG00511709: hypothetical protein +FIG00511710 FIG00511712: hypothetical protein +FIG00511713 FIG00511715: hypothetical protein +FIG00511715 FIG00511716: hypothetical protein +FIG00511716 FIG00511717: hypothetical protein +FIG00511717 FIG00511718: hypothetical protein +FIG00511718 FIG00511719: hypothetical protein +FIG00511719 FIG00511721: hypothetical protein +FIG00511729 FIG00511730: hypothetical protein +FIG00511730 FIG00511731: hypothetical protein +FIG00511732 FIG00511733: hypothetical protein +FIG00511733 FIG00511736: hypothetical protein +FIG00511737 FIG00511739: hypothetical protein +FIG00511739 FIG00511740: hypothetical protein +FIG00511742 FIG00511743: hypothetical protein +FIG00511743 FIG00389664: hypothetical protein +FIG00511744 FIG00511745: hypothetical protein +FIG00511747 endopolygalacturonase +FIG00511750 FIG00511754: hypothetical protein +FIG00511754 FIG00511755: hypothetical protein +FIG00511755 FIG00511756: hypothetical protein +FIG00511759 FIG00511760: hypothetical protein +FIG00511760 Spermidine/putrescine transport system permease protein potB +FIG00511761 FIG00511762: hypothetical protein +FIG00511762 FIG00511763: hypothetical protein +FIG00511766 FIG00511767: hypothetical protein +FIG00511767 putative transcriptional regulator, LacI family +FIG00511772 FIG00511773: hypothetical protein +FIG00511782 FIG00511783: hypothetical protein +FIG00511783 FIG00511784: hypothetical protein +FIG00511784 FIG00511786: hypothetical protein +FIG00511786 FIG00511787: hypothetical protein +FIG00511787 putative transcriptional regulator, LysR-family +FIG00511788 FIG00511789: hypothetical protein +FIG00511789 FIG00511790: hypothetical protein +FIG00511790 FIG00511791: hypothetical protein +FIG00511791 FIG00511794: hypothetical protein +FIG00511794 FIG00511797: hypothetical protein +FIG00511798 FIG00511799: hypothetical protein +FIG00511801 FIG00511803: hypothetical protein +FIG00511806 FIG00511807: hypothetical protein +FIG00511808 conserved hypothetical alanine-rich protein +FIG00511810 FIG00511811: hypothetical protein +FIG00511815 FIG00511817: hypothetical protein +FIG00511818 FIG00511819: hypothetical protein +FIG00511821 FIG00511822: hypothetical protein +FIG00511822 FIG00511823: hypothetical protein +FIG00511826 FIG00511827: hypothetical protein +FIG00511827 FIG00511828: hypothetical protein +FIG00511828 FIG00511829: hypothetical protein +FIG00511829 FIG00511830: hypothetical protein +FIG00511831 FIG00511832: hypothetical protein +FIG00511832 FIG00511834: hypothetical protein +FIG00511839 FIG00511840: hypothetical protein +FIG00511843 putative carboxylesterase( EC:3.1.1.- ) +FIG00511844 FIG00511846: hypothetical protein +FIG00511846 FIG00511847: hypothetical protein +FIG00511849 FIG00511850: hypothetical protein +FIG00511850 FIG00511852: hypothetical protein +FIG00511855 FIG00511856: hypothetical protein +FIG00511858 FIG00511859: hypothetical protein +FIG00511864 FIG00511865: hypothetical protein +FIG00511865 FIG00511866: hypothetical protein +FIG00511866 FIG00511867: hypothetical protein +FIG00511867 FIG00511868: hypothetical protein +FIG00511868 FIG00511869: hypothetical protein +FIG00511870 FIG00511872: hypothetical protein +FIG00511872 FIG00511873: hypothetical protein +FIG00511873 FIG00511874: hypothetical protein +FIG00511874 FIG00511876: hypothetical protein +FIG00511876 Galactofuranosyl transferase (EC 2.-.-.-) +FIG00511881 FIG00511882: hypothetical protein +FIG00511882 Oligopeptide transport integral membrane protein +FIG00511886 FIG00511887: hypothetical protein +FIG00511887 FIG00511888: hypothetical protein +FIG00511888 FIG00511891: hypothetical protein +FIG00511894 FIG00511896: hypothetical protein +FIG00511897 Zinc ABC transporter, periplasmic-binding protein ZnuA +FIG00511899 FIG00511900: hypothetical protein +FIG00511905 conserved hypothetical protein, similar to LSR2 protein +FIG00511907 FIG00511908: hypothetical protein +FIG00511908 FIG00511910: hypothetical protein +FIG00511910 FIG00511911: hypothetical protein +FIG00511913 FIG00511916: hypothetical protein +FIG00511916 FIG00511917: hypothetical protein +FIG00511919 FIG00511923: hypothetical protein +FIG00511929 FIG00511930: hypothetical protein +FIG00511930 FIG00511931: hypothetical protein +FIG00511933 FIG00511935: hypothetical protein +FIG00511935 putative glyoxylase family protein +FIG00511937 FIG00511938: hypothetical protein +FIG00511944 FIG00511945: hypothetical protein +FIG00511946 FIG00511948: hypothetical protein +FIG00511948 FIG00511950: hypothetical protein +FIG00511951 FIG00511955: hypothetical protein +FIG00511955 invertase recombinase-like protein +FIG00511958 FIG00511959: hypothetical protein +FIG00511959 FIG00511960: hypothetical protein +FIG00511962 integral membrane binding-protein-dependent transport protein +FIG00511965 FIG00733871: hypothetical protein +FIG00511966 FIG00511967: hypothetical protein +FIG00511967 FIG00511969: hypothetical protein +FIG00511969 TOMM biosynthesis docking scaffold (protein D) +FIG00511970 Protein of unknown function DUF91 +FIG00511971 FIG00511972: hypothetical protein +FIG00511972 FIG00511973: hypothetical protein +FIG00511974 FIG00511976: hypothetical protein +FIG00511976 FIG00511977: hypothetical protein +FIG00511978 conserved hypothetical protein, putative DNA-binding protein +FIG00511980 FIG00511981: hypothetical protein +FIG00511982 FIG00511984: hypothetical protein +FIG00511984 FIG00511985: hypothetical protein +FIG00511985 FIG00511986: hypothetical protein +FIG00511986 FIG00511987: hypothetical protein +FIG00511988 FIG00511989: hypothetical protein +FIG00511995 putative aldehyde dehydrogenase +FIG00511997 FIG00733533: hypothetical protein +FIG00511999 FIG00512001: hypothetical protein +FIG00512003 FIG00512004: hypothetical protein +FIG00512008 putative serine/threonine protein kinase( EC:2.7.1.- ) +FIG00512010 FIG00512012: hypothetical protein +FIG00512012 FIG00512013: hypothetical protein +FIG00512013 FIG00512016: hypothetical protein +FIG00512016 FIG00512017: hypothetical protein +FIG00512017 FIG00512018: hypothetical protein +FIG00512018 FIG00512019: hypothetical protein +FIG00512024 FIG00512025: hypothetical protein +FIG00512025 FIG00512026: hypothetical protein +FIG00512034 FIG00512035: hypothetical protein +FIG00512035 FIG00512036: hypothetical protein +FIG00512037 phosphinothricin acetyltransferase protein +FIG00512038 FIG00512040: hypothetical protein +FIG00512053 FIG00512054: hypothetical protein +FIG00512057 FIG00512058: hypothetical protein +FIG00512058 FIG00512059: hypothetical protein +FIG00512059 FIG00512060: hypothetical protein +FIG00512062 FIG00512063: hypothetical protein +FIG00512065 FIG00512066: hypothetical protein +FIG00512066 FIG00512067: hypothetical protein +FIG00512067 FIG00512068: hypothetical protein +FIG00512070 FIG00512071: hypothetical protein +FIG00512073 FIG00512074: hypothetical protein +FIG00512074 FIG00512075: hypothetical protein +FIG00512075 FIG00512076: hypothetical protein +FIG00512076 FIG00512077: hypothetical protein +FIG00512077 FIG00512079: hypothetical protein +FIG00512081 FIG00512083: hypothetical protein +FIG00512088 FIG00512090: hypothetical protein +FIG00512093 FIG00512096: hypothetical protein +FIG00512096 FIG00512097: hypothetical protein +FIG00512098 FIG00512104: hypothetical protein +FIG00512105 FIG00512106: hypothetical protein +FIG00512106 FIG00512108: hypothetical protein +FIG00512109 FIG00512110: hypothetical protein +FIG00512113 FIG00512114: hypothetical protein +FIG00512115 FIG00512117: hypothetical protein +FIG00512120 FIG00512122: hypothetical protein +FIG00512122 FIG00512123: hypothetical protein +FIG00512123 FIG00512124: hypothetical protein +FIG00512125 FIG00512126: hypothetical protein +FIG00512128 FIG00512130: hypothetical protein +FIG00512135 Putrescine transport ATP-binding protein PotG (TC 3.A.1.11.2) +FIG00512140 FIG00512142: hypothetical protein +FIG00512142 GDSL-like Lipase/Acylhydrolase domain protein +FIG00512145 FIG00512146: hypothetical protein +FIG00512147 FIG00512149: hypothetical protein +FIG00512153 FIG00512154: hypothetical protein +FIG00512156 FIG00512157: hypothetical protein +FIG00512157 FIG00512158: hypothetical protein +FIG00512158 FIG00512159: hypothetical protein +FIG00512162 FIG00512163: hypothetical protein +FIG00512163 FIG00512164: hypothetical protein +FIG00512164 Mlr1763 protein +FIG00512167 FIG00512168: hypothetical protein +FIG00512171 FIG00512172: hypothetical protein +FIG00512174 FIG00512175: hypothetical protein +FIG00512177 FIG00512180: hypothetical protein +FIG00512182 FIG00512183: hypothetical protein +FIG00512185 conserved secreted protein +FIG00512190 FIG00512192: hypothetical protein +FIG00512193 FIG00512196: hypothetical protein +FIG00512196 COG0577: ABC-type antimicrobial peptide transport system, permease component +FIG00512197 putative glycosyl transferase, family 2 +FIG00512201 FIG00512202: hypothetical protein +FIG00512202 FIG00512203: hypothetical protein +FIG00512203 FIG00512204: hypothetical protein +FIG00512207 FIG00512209: hypothetical protein +FIG00512215 FIG00512217: hypothetical protein +FIG00512219 Sugar transport system permease protein +FIG00512227 hypothetical protein, putative partitioning protein +FIG00512232 FIG00512233: hypothetical protein +FIG00512235 FIG00512237: hypothetical protein +FIG00512243 FIG00512246: hypothetical protein +FIG00512246 FIG00512247: hypothetical protein +FIG00512249 FIG00512250: hypothetical protein +FIG00512251 FIG00512254: hypothetical protein +FIG00512257 FIG00512259: hypothetical protein +FIG00512261 FIG00512262: hypothetical protein +FIG00512262 FIG00512263: hypothetical protein +FIG00512263 FIG00512264: hypothetical protein +FIG00512269 FIG00512271: hypothetical protein +FIG00512276 FIG00512277: hypothetical protein +FIG00512277 FIG00512278: hypothetical protein +FIG00512278 FIG00512279: hypothetical protein +FIG00512280 FIG00512281: hypothetical protein +FIG00512285 FIG00512287: hypothetical protein +FIG00512289 FIG00512290: hypothetical protein +FIG00512293 FIG00512294: hypothetical protein +FIG00512299 FIG00512300: hypothetical protein +FIG00512305 putative sugar MFS-permease +FIG00512306 FIG00512307: hypothetical protein +FIG00512307 FIG00512308: hypothetical protein +FIG00512311 hypothetical protein, putative transcriptional regulator ArsR family +FIG00512314 putative cation efflux protein, CDF family +FIG00512316 FIG00512324: hypothetical protein +FIG00512327 putative Acetyltransferase, GNAT family( EC:2.3.1.- ) +FIG00512329 FIG00512330: hypothetical protein +FIG00512332 putative transcriptional activator +FIG00512337 FIG004853: possible toxin to DivIC +FIG00512339 FIG00512340: hypothetical protein +FIG00512342 FIG00512343: hypothetical protein +FIG00512346 FIG00512347: hypothetical protein +FIG00512349 FIG00512350: hypothetical protein +FIG00512355 FIG00512357: hypothetical protein +FIG00512359 FIG00512360: hypothetical protein +FIG00512360 Protein containing ATP/GTP-binding site motif A +FIG00512363 FIG00512364: hypothetical protein +FIG00512365 FIG00512366: hypothetical protein +FIG00512369 FIG00512370: hypothetical protein +FIG00512370 exopolysaccharide production protein +FIG00512372 Protein lsr2 precursor +FIG00512373 FIG00512377: hypothetical protein +FIG00512383 FIG00512384: hypothetical protein +FIG00512391 FIG00512393: hypothetical protein +FIG00512394 FIG00512395: hypothetical protein +FIG00512395 FIG00512397: hypothetical protein +FIG00512399 FIG00512401: hypothetical protein +FIG00512401 FIG00512403: hypothetical protein +FIG00512403 FIG00512404: hypothetical protein +FIG00512404 putative amino acid transporter protein +FIG00512406 FIG00512407: hypothetical protein +FIG00512418 FIG00512419: hypothetical protein +FIG00512420 FIG00512421: hypothetical protein +FIG00512424 FIG00512426: hypothetical protein +FIG00512426 FIG00512429: hypothetical protein +FIG00512436 FIG00512437: hypothetical protein +FIG00512437 FIG00512438: hypothetical protein +FIG00512438 FIG00512439: hypothetical protein +FIG00512458 TOMM biosynthesis dehydrogenase (protein B) +FIG00512463 FIG00512464: hypothetical protein +FIG00512466 FIG00512468: hypothetical protein +FIG00512468 FIG00512469: hypothetical protein +FIG00512470 FIG00512472: hypothetical protein +FIG00512472 FIG00512473: hypothetical protein +FIG00512473 curved DNA binding protein +FIG00512474 FIG00512475: hypothetical protein +FIG00512481 FIG00512484: hypothetical protein +FIG00512484 FIG00512486: hypothetical protein +FIG00512487 FIG00512488: hypothetical protein +FIG00512489 FIG00512491: hypothetical protein +FIG00512492 FIG00512493: hypothetical protein +FIG00512497 FIG00512500: hypothetical protein +FIG00512503 TOMM export ABC transporter, ATP-binding protein +FIG00512504 FIG00512505: hypothetical protein +FIG00512509 FIG00512510: hypothetical protein +FIG00512514 FIG00512517: hypothetical protein +FIG00512521 FIG00512522: hypothetical protein +FIG00512522 FIG00512523: hypothetical protein +FIG00512523 FIG00512524: hypothetical protein +FIG00512525 FIG00512526: hypothetical protein +FIG00512532 glycosyl transferase, group 1 family protein +FIG00512535 FIG00512538: hypothetical protein +FIG00512538 FIG00512539: hypothetical protein +FIG00512539 FIG00512540: hypothetical protein +FIG00512540 FIG00512542: hypothetical protein +FIG00512544 FIG00512545: hypothetical protein +FIG00512545 FIG00512546: hypothetical protein +FIG00512550 FIG00512552: hypothetical protein +FIG00512552 FIG00512553: hypothetical protein +FIG00512555 FIG00512556: hypothetical protein +FIG00512556 FIG00512561: hypothetical protein +FIG00512570 FIG00512571: hypothetical protein +FIG00512574 FIG00512575: hypothetical protein +FIG00512575 FIG00512576: hypothetical protein +FIG00512576 FIG00512577: hypothetical protein +FIG00512579 FIG00512580: hypothetical protein +FIG00512580 FIG00512582: hypothetical protein +FIG00512590 FIG00512591: hypothetical protein +FIG00512593 FIG00512599: hypothetical protein +FIG00512604 Single-strand binding protein homolog Ssb +FIG00512605 FIG00512606: hypothetical protein +FIG00512607 FIG00512609: hypothetical protein +FIG00512609 FIG00512610: hypothetical protein +FIG00512612 FIG00512614: hypothetical protein +FIG00512616 FIG00512617: hypothetical protein +FIG00512619 Protein phosphatase +FIG00512620 FIG00512624: hypothetical protein +FIG00512625 FIG00512626: hypothetical protein +FIG00512629 FIG00512629: secreted protein +FIG00512637 FIG00512639: hypothetical protein +FIG00512641 FIG00512642: hypothetical protein +FIG00512653 FIG00512659: hypothetical protein +FIG00512662 FIG00512663: hypothetical protein +FIG00512663 FIG00512664: hypothetical protein +FIG00512664 FIG00512666: hypothetical protein +FIG00512687 FIG00512688: hypothetical protein +FIG00512688 FIG00512690: hypothetical protein +FIG00512690 FIG00512691: hypothetical protein +FIG00512693 P-47 +FIG00512697 hypothetical protein +FIG00512701 FIG00512703: hypothetical protein +FIG00512703 Streptolysin S export transmembrane permease (SagH) +FIG00512705 NH2-acetyltransferase +FIG00512706 FIG00512707: hypothetical protein +FIG00512707 FIG00512708: hypothetical protein +FIG00512709 FIG00512710: hypothetical protein +FIG00512710 FIG00512711: hypothetical protein +FIG00512711 FIG00512713: hypothetical protein +FIG00512713 Iron-sulfur flavoprotein +FIG00512716 FIG00512717: hypothetical protein +FIG00512717 FIG00512718: hypothetical protein +FIG00512718 FIG00512719: hypothetical protein +FIG00512719 FIG00512721: hypothetical protein +FIG00512724 FIG00512725: hypothetical protein +FIG00512725 Small acid-soluble spore protein beta +FIG00512728 Putative flagellar hook associated protein +FIG00512729 FIG00512730: hypothetical protein +FIG00512730 FIG00512731: hypothetical protein +FIG00512731 FIG00512732: hypothetical protein +FIG00512733 FIG00512734: hypothetical protein +FIG00512735 FIG00512736: hypothetical protein +FIG00512736 FIG00512737: hypothetical protein +FIG00512737 FIG00512738: hypothetical protein +FIG00512738 FIG00512741: hypothetical protein +FIG00512742 protein of unknown function DUF477 +FIG00512744 probable transcriptional regulator YsmB +FIG00512745 FIG00512746: hypothetical protein +FIG00512746 FIG00512747: hypothetical protein +FIG00512747 FIG00512748: hypothetical protein +FIG00512748 FIG00512749: hypothetical protein +FIG00512749 FIG00512750: hypothetical protein +FIG00512752 FIG00512753: hypothetical protein +FIG00512754 FIG00512756: hypothetical protein +FIG00512759 FIG00512762: hypothetical protein +FIG00512762 RecA regulator RecX +FIG00512766 FIG00512767: hypothetical protein +FIG00512767 FIG00512768: hypothetical protein +FIG00512770 FIG00512772: hypothetical protein +FIG00512772 Type IV pilus biogenesis protein PilN +FIG00512773 FIG00512775: hypothetical protein +FIG00512775 FIG00512776: hypothetical protein +FIG00512776 FIG00512777: hypothetical protein +FIG00512777 FIG00512778: hypothetical protein +FIG00512779 FIG00512781: hypothetical protein +FIG00512783 FIG00512786: hypothetical protein +FIG00512786 FIG00512787: hypothetical protein +FIG00512787 FIG00512788: hypothetical protein +FIG00512788 FIG00512789: hypothetical protein +FIG00512790 FIG00512791: hypothetical protein +FIG00512791 FIG00512793: hypothetical protein +FIG00512794 FIG00512795: hypothetical protein +FIG00512795 FIG00512796: hypothetical protein +FIG00512796 FIG00512798: hypothetical protein +FIG00512798 FIG00512801: hypothetical protein +FIG00512801 FIG00512804: hypothetical protein +FIG00512804 FIG00512805: hypothetical protein +FIG00512805 Fe-S oxidoreductase, related to NifB/MoaA family with PDZ N-terminal domain +FIG00512806 FIG00512810: hypothetical protein +FIG00512810 FIG00512811: hypothetical protein +FIG00512811 FIG00512812: hypothetical protein +FIG00512812 FIG00512813: hypothetical protein +FIG00512813 FIG00512814: hypothetical protein +FIG00512814 FIG00512815: hypothetical protein +FIG00512815 Endopeptidase similar to E. coli YgjD +FIG00512817 FIG00512819: hypothetical protein +FIG00512824 FIG01240814: hypothetical protein +FIG00512825 FIG00512826: hypothetical protein +FIG00512826 FIG00512827: hypothetical protein +FIG00512827 FIG00512829: hypothetical protein +FIG00512829 FIG00512830: hypothetical protein +FIG00512832 FIG00512833: hypothetical protein +FIG00512836 FIG00512843: hypothetical protein +FIG00512843 putative lantibiotic ABC transporter, membrane protein +FIG00512844 FIG00512845: hypothetical protein +FIG00512845 FIG00512847: hypothetical protein +FIG00512850 MRP-family nucleotide-binding protein +FIG00512851 FIG00512857: hypothetical protein +FIG00512857 FIG00512859: hypothetical protein +FIG00512859 FIG00512860: hypothetical protein +FIG00512860 FIG00512862: hypothetical protein +FIG00512863 FIG00512864: hypothetical protein +FIG00512864 FIG00512865: hypothetical protein +FIG00512870 FIG00512871: hypothetical protein +FIG00512871 FIG00512873: hypothetical protein +FIG00512874 FIG00512879: hypothetical protein +FIG00512881 FIG00512884: hypothetical protein +FIG00512884 FIG00512885: hypothetical protein +FIG00512885 FIG00512886: hypothetical protein +FIG00512886 Phage-like element pbsx protein xkdT +FIG00512887 FIG00512889: hypothetical protein +FIG00512890 FIG00512891: hypothetical protein +FIG00512891 DNA polymerase I (EC 2.7.7.7) +FIG00512893 FIG00512894: hypothetical protein +FIG00512895 FIG00512899: hypothetical protein +FIG00512899 FIG00512901: hypothetical protein +FIG00512901 FIG00512903: hypothetical protein +FIG00512903 FIG00512904: hypothetical protein +FIG00512904 FIG00512905: hypothetical protein +FIG00512905 FIG00512906: hypothetical protein +FIG00512906 FIG00512907: hypothetical protein +FIG00512907 FIG00512908: hypothetical protein +FIG00512908 FIG00512910: hypothetical protein +FIG00512910 FIG00512911: hypothetical protein +FIG00512911 FIG00512912: hypothetical protein +FIG00512912 FIG00512915: hypothetical protein +FIG00512915 FIG00512917: hypothetical protein +FIG00512917 FIG00512919: hypothetical protein +FIG00512921 regulatory protein, MarR +FIG00512926 FIG00512927: hypothetical protein +FIG00512927 FIG00512929: hypothetical protein +FIG00512929 FIG00512931: hypothetical protein +FIG00512931 FIG00512932: hypothetical protein +FIG00512932 FIG00512934: hypothetical protein +FIG00512934 FIG00512937: hypothetical protein +FIG00512937 FIG00512939: hypothetical protein +FIG00512939 Small, acid-soluble spore protein gamma-type (SASP), putative +FIG00512941 Pectinesterase( EC:3.1.1.11 ) +FIG00512944 FIG00512945: hypothetical protein +FIG00512947 FIG00512949: hypothetical protein +FIG00512949 FIG00512951: hypothetical protein +FIG00512951 FIG00512952: hypothetical protein +FIG00512952 FIG00512953: hypothetical protein +FIG00512953 FIG00512954: hypothetical protein +FIG00512954 FIG00512957: hypothetical protein +FIG00512957 FIG00512961: hypothetical protein +FIG00512961 FIG00512962: hypothetical protein +FIG00512962 Carboxypeptidase G2 precursor (EC 3.4.17.11) +FIG00512963 FIG00512965: hypothetical protein +FIG00512967 FIG00512968: hypothetical protein +FIG00512968 FIG00512969: hypothetical protein +FIG00512969 FIG00512971: hypothetical protein +FIG00512972 FIG00512973: hypothetical protein +FIG00512975 FIG00512976: hypothetical protein +FIG00512976 CRISPR-associated protein Cas5 +FIG00512977 FIG00512978: hypothetical protein +FIG00512979 FIG00512980: hypothetical protein +FIG00512980 FIG00512981: hypothetical protein +FIG00512985 putative phage-related regulatory protein +FIG00512986 FIG00512987: hypothetical protein +FIG00512989 FIG00512990: hypothetical protein +FIG00512990 FIG00512991: hypothetical protein +FIG00512992 FIG00512993: hypothetical protein +FIG00512993 FIG00512995: hypothetical protein +FIG00512995 FIG00512997: hypothetical protein +FIG00512999 FIG00513000: hypothetical protein +FIG00513000 FIG00513002: hypothetical protein +FIG00513003 FIG00513004: hypothetical protein +FIG00513004 FIG00513006: hypothetical protein +FIG00513007 FIG00513010: hypothetical protein +FIG00513010 FIG00513011: hypothetical protein +FIG00513011 FIG00513012: hypothetical protein +FIG00513012 FIG00513013: hypothetical protein +FIG00513021 FIG00513023: hypothetical protein +FIG00513025 FIG00513028: hypothetical protein +FIG00513028 Re face-specific citrate synthase (EC 2.3.3.3) +FIG00513035 FIG00513036: hypothetical protein +FIG00513036 FIG00513038: hypothetical protein +FIG00513040 tyrosine site-specific recombinase +FIG00513041 FIG00513042: hypothetical protein +FIG00513042 FIG00513043: hypothetical protein +FIG00513044 FIG00513046: hypothetical protein +FIG00513046 FIG00513047: hypothetical protein +FIG00513047 FIG00513048: hypothetical protein +FIG00513048 FIG00513049: hypothetical protein +FIG00513049 FIG00513052: hypothetical protein +FIG00513058 FIG00513059: hypothetical protein +FIG00513059 FIG00513060: hypothetical protein +FIG00513060 Zn-finger containing protein, csfB B.subtilis homolog +FIG00513062 FIG00513064: hypothetical protein +FIG00513064 FIG00513067: hypothetical protein +FIG00513067 FIG00513068: hypothetical protein +FIG00513070 ProFAR isomerase associated superfamily +FIG00513073 FIG00513074: hypothetical protein +FIG00513076 FIG00513077: hypothetical protein +FIG00513078 FIG00513079: hypothetical protein +FIG00513079 FIG00513081: hypothetical protein +FIG00513081 FIG00513083: hypothetical protein +FIG00513083 FIG00513084: hypothetical protein +FIG00513086 FIG00513089: hypothetical protein +FIG00513089 FIG00513090: hypothetical protein +FIG00513090 Tungstate ABC transporter, ATP-binding protein WtpC +FIG00513093 Zn-dependent protease of MPP family +FIG00513096 FIG00513097: hypothetical protein +FIG00513097 glycosyl transferase CpsO(V) +FIG00513100 FIG00513101: hypothetical protein +FIG00513101 Protease (EC 3.4.-.-) +FIG00513103 FIG00513104: hypothetical protein +FIG00513105 FIG00513106: hypothetical protein +FIG00513106 FIG00513107: hypothetical protein +FIG00513107 sigma-L-dependent transcriptional regulator +FIG00513109 probable nucleotidyltransferase +FIG00513110 FIG00513111: hypothetical protein +FIG00513112 FIG00513113: hypothetical protein +FIG00513114 FIG00513115: hypothetical protein +FIG00513115 FIG00513117: hypothetical protein +FIG00513117 FIG00513119: hypothetical protein +FIG00513119 FIG00513120: hypothetical protein +FIG00513120 FIG00513121: hypothetical protein +FIG00513121 FIG00513122: hypothetical protein +FIG00513125 FIG00513126: hypothetical protein +FIG00513126 putative nuclease +FIG00513130 FIG00513136: hypothetical protein +FIG00513137 FIG00513138: hypothetical protein +FIG00513140 FIG00513143: hypothetical protein +FIG00513144 Monogalactosyldiacylglycerol synthase (EC 2.4.1.46) +FIG00513145 Positive regulator of sigma(E), RseC/MucC +FIG00513153 FIG00513154: hypothetical protein +FIG00513154 Ferrichrome-binding periplasmic protein precursor (TC 3.A.1.14.3) +FIG00513157 FIG00513158: hypothetical protein +FIG00513164 FIG00513168: hypothetical protein +FIG00513171 FIG00513172: hypothetical protein +FIG00513179 FIG00513180: hypothetical protein +FIG00513180 FIG00513181: hypothetical protein +FIG00513181 FIG00513186: hypothetical protein +FIG00513186 FIG00513191: hypothetical protein +FIG00513193 FIG00513194: hypothetical protein +FIG00513194 FIG00513195: hypothetical protein +FIG00513195 FIG00513196: hypothetical protein +FIG00513196 FIG00513197: hypothetical protein +FIG00513197 membrane protein, putative transporter +FIG00513199 FIG00513200: hypothetical protein +FIG00513201 FIG00513202: hypothetical protein +FIG00513203 FIG00513204: hypothetical protein +FIG00513204 FIG00513205: hypothetical protein +FIG00513205 FIG00513207: hypothetical protein +FIG00513207 neurotoxin type E +FIG00513209 FIG00513210: hypothetical protein +FIG00513210 FIG00513216: hypothetical protein +FIG00513219 FIG00513220: hypothetical protein +FIG00513220 FIG00513222: hypothetical protein +FIG00513222 FIG00513223: hypothetical protein +FIG00513226 FIG00513227: hypothetical protein +FIG00513227 FIG00513228: hypothetical protein +FIG00513238 FIG00627694: hypothetical protein +FIG00513240 FIG00513242: hypothetical protein +FIG00513243 endodeoxyribonuclease RusA family protein +FIG00513261 Related to ABC transporter permease component +FIG00513262 FIG00513270: hypothetical protein +FIG00513270 Uncharacterized phage related protein +FIG00513273 FIG00513275: hypothetical protein +FIG00513278 FIG00513279: hypothetical protein +FIG00513281 Probable glycolate oxidase +FIG00513283 FIG00513284: hypothetical protein +FIG00513284 FIG00513287: hypothetical protein +FIG00513287 hypothetical protein +FIG00513289 FIG00513290: hypothetical protein +FIG00513291 FIG00513294: hypothetical protein +FIG00513294 FIG00513295: hypothetical protein +FIG00513295 FIG00513297: hypothetical protein +FIG00513297 FIG00513299: hypothetical protein +FIG00513299 FIG00513300: hypothetical protein +FIG00513301 FIG00513302: hypothetical protein +FIG00513302 FIG00513304: hypothetical protein +FIG00513304 FIG00513305: hypothetical protein +FIG00513305 FIG00513306: hypothetical protein +FIG00513306 FIG00513307: hypothetical protein +FIG00513307 FIG00513308: hypothetical protein +FIG00513309 FIG00513310: hypothetical protein +FIG00513311 Uxu operon regulator +FIG00513313 FIG00513315: hypothetical protein +FIG00513318 FIG00513319: hypothetical protein +FIG00513319 FIG00513320: hypothetical protein +FIG00513322 FIG00513323: hypothetical protein +FIG00513323 FIG00513325: hypothetical protein +FIG00513325 FIG00513326: hypothetical protein +FIG00513326 FIG00513327: hypothetical protein +FIG00513327 FIG00513328: hypothetical protein +FIG00513329 FIG01266159: hypothetical protein +FIG00513330 N-terminal of elongation factor Ts +FIG00513331 FIG00513332: hypothetical protein +FIG00513332 FIG00513335: hypothetical protein +FIG00513338 putative solute-binding lipoprotein +FIG00513339 FIG00513340: hypothetical protein +FIG00513342 FIG00513343: hypothetical protein +FIG00513348 FIG00513349: hypothetical protein +FIG00513349 FIG00513350: hypothetical protein +FIG00513350 FIG00513352: hypothetical protein +FIG00513352 FIG00513354: hypothetical protein +FIG00513354 FIG00513357: hypothetical protein +FIG00513358 FIG00513359: hypothetical protein +FIG00513359 FIG00513361: hypothetical protein +FIG00513361 FIG00513362: hypothetical protein +FIG00513366 FIG00513367: hypothetical protein +FIG00513367 FIG00513369: hypothetical protein +FIG00513369 FIG00513370: hypothetical protein +FIG00513370 FIG00513372: hypothetical protein +FIG00513372 FIG00513373: hypothetical protein +FIG00513374 Transcriptional regulator (LacI family) +FIG00513376 FIG00513377: hypothetical protein +FIG00513379 FIG00513381: hypothetical protein +FIG00513381 FIG00513382: hypothetical protein +FIG00513382 FIG00513385: hypothetical protein +FIG00513385 FIG00513387: hypothetical protein +FIG00513387 FIG00513388: hypothetical protein +FIG00513388 FIG00513389: hypothetical protein +FIG00513389 FIG00513391: hypothetical protein +FIG00513393 Putative enzyme of poly-gamma-glutamate biosynthesis (capsule formation)-like protein +FIG00513397 FIG00513399: hypothetical protein +FIG00513399 FIG00513400: hypothetical protein +FIG00513401 FIG00513402: hypothetical protein +FIG00513409 FIG00513410: hypothetical protein +FIG00513412 FIG00513413: hypothetical protein +FIG00513413 putative capsular polysaccharide biosynthesis glycosyl transferase +FIG00513419 FIG00513420: hypothetical protein +FIG00513420 FIG00513425: hypothetical protein +FIG00513425 FIG00513426: hypothetical protein +FIG00513427 FIG00513430: hypothetical protein +FIG00513431 Molecular chaperone, DnaJ family (contain C-term. Zn finger domain) +FIG00513432 FIG00513433: hypothetical protein +FIG00513433 FIG00513434: hypothetical protein +FIG00513434 FIG00513436: hypothetical protein +FIG00513436 FIG00513440: hypothetical protein +FIG00513442 FIG00513445: hypothetical protein +FIG00513445 EffR +FIG00513446 FIG00513448: hypothetical protein +FIG00513448 FIG00513449: hypothetical protein +FIG00513449 FIG00513450: hypothetical protein +FIG00513450 FIG00513452: hypothetical protein +FIG00513456 FIG00513457: hypothetical protein +FIG00513457 ABC-type multidrug/protein/lipid transport system, ATPase component +FIG00513458 FIG00513461: hypothetical protein +FIG00513461 FIG00513465: hypothetical protein +FIG00513466 FIG00513467: hypothetical protein +FIG00513467 FIG00513469: hypothetical protein +FIG00513472 FIG00513477: hypothetical protein +FIG00513477 FIG00513482: hypothetical protein +FIG00513486 putative phage cell wall hydrolase +FIG00513488 FIG00513490: hypothetical protein +FIG00513490 FIG00513492: hypothetical protein +FIG00513492 FIG00513493: hypothetical protein +FIG00513493 FIG00513496: hypothetical protein +FIG00513502 FIG00513503: hypothetical protein +FIG00513503 FIG00513506: hypothetical protein +FIG00513506 FIG00513507: hypothetical protein +FIG00513510 FIG00513511: hypothetical protein +FIG00513511 FIG00513512: hypothetical protein +FIG00513512 protein of unknown function DUF161 +FIG00513513 FIG00513514: hypothetical protein +FIG00513514 MgtC/SapB transporter +FIG00513515 FIG00513517: hypothetical protein +FIG00513518 FIG00513519: hypothetical protein +FIG00513519 FIG00513520: hypothetical protein +FIG00513520 FIG00513521: hypothetical protein +FIG00513525 FIG00531192: hypothetical protein +FIG00513527 FIG00513528: hypothetical protein +FIG00513528 FIG00513529: hypothetical protein +FIG00513529 FIG00513530: hypothetical protein +FIG00513530 FIG00513532: hypothetical protein +FIG00513534 FIG00513535: hypothetical protein +FIG00513535 Phage-like element PBSX protein xkdS +FIG00513537 FIG00513538: hypothetical protein +FIG00513538 no significant homology 1 putative transmembrane region was found by PSORT +FIG00513540 FIG00513542: hypothetical protein +FIG00513542 FIG00513543: hypothetical protein +FIG00513543 FIG00513545: hypothetical protein +FIG00513545 FIG00513546: hypothetical protein +FIG00513546 FIG00513547: hypothetical protein +FIG00513547 FIG00513550: hypothetical protein +FIG00513550 FIG00513551: hypothetical protein +FIG00513552 FIG00513554: hypothetical protein +FIG00513554 FIG00513555: hypothetical protein +FIG00513555 FIG00513556: hypothetical protein +FIG00513556 FIG00513557: hypothetical protein +FIG00513558 FIG00513559: hypothetical protein +FIG00513559 FIG00513560: hypothetical protein +FIG00513560 FIG00513568: hypothetical protein +FIG00513568 FIG00513571: hypothetical protein +FIG00513571 Transglutaminase-like enzyme, putative cysteine protease +FIG00513574 FIG00513575: hypothetical protein +FIG00513575 FIG00513577: hypothetical protein +FIG00513577 FIG00513578: hypothetical protein +FIG00513578 FIG00513579: hypothetical protein +FIG00513579 FIG00513580: hypothetical protein +FIG00513580 FIG00513582: hypothetical protein +FIG00513582 FIG00513583: hypothetical protein +FIG00513583 Conserved membrane-associated protein +FIG00513588 FIG00513589: hypothetical protein +FIG00513589 FIG00513590: hypothetical protein +FIG00513590 FIG00513592: hypothetical protein +FIG00513592 FIG00513593: hypothetical protein +FIG00513593 FIG00513594: hypothetical protein +FIG00513594 Lipoprotein, Bmp family +FIG00513596 FIG00513598: hypothetical protein +FIG00513598 FIG00513602: hypothetical protein +FIG00513603 FIG00513604: hypothetical protein +FIG00513604 putative signaling protein +FIG00513611 FHA-domain containing secreted protein +FIG00513617 FIG00513618: hypothetical protein +FIG00513618 FIG00513619: hypothetical protein +FIG00513619 FIG00513621: hypothetical protein +FIG00513621 FIG00513623: hypothetical protein +FIG00513623 FIG00513626: hypothetical protein +FIG00513626 FIG00513632: hypothetical protein +FIG00513632 FIG00513635: hypothetical protein +FIG00513635 FIG00513636: hypothetical protein +FIG00513636 FIG00513637: hypothetical protein +FIG00513637 FIG00513638: hypothetical protein +FIG00513638 Botulinum neurotoxin type A precursor (EC 3.4.24.69) +FIG00513639 EutM/PduA/PduJ-like protein 3 clustered with pyruvate formate-lyase +FIG00513641 Prepilin peptidase +FIG00513646 FIG00513649: hypothetical protein +FIG00513649 FIG00513650: hypothetical protein +FIG00513650 FIG00513653: hypothetical protein +FIG00513653 FIG00513654: hypothetical protein +FIG00513654 Probable membrane-bound metal-dependent hydrolase +FIG00513655 FIG00513656: hypothetical protein +FIG00513656 FIG00513657: hypothetical protein +FIG00513658 transcription antiterminator +FIG00513659 FIG00513660: hypothetical protein +FIG00513660 FIG00513661: hypothetical protein +FIG00513661 FIG00513663: hypothetical protein +FIG00513663 FIG00513665: hypothetical protein +FIG00513666 FIG00513672: hypothetical protein +FIG00513673 FIG01165827: hypothetical protein +FIG00513676 cell surface protein +FIG00513682 FIG00513683: hypothetical protein +FIG00513685 FIG00513686: hypothetical protein +FIG00513688 FIG00513691: hypothetical protein +FIG00513691 Fe-S oxidoreductase, related to NifB/MoaA family +FIG00513692 Predicted membrane-associated metal-binding protein +FIG00513695 FIG00513696: hypothetical protein +FIG00513696 HupD +FIG00513697 FIG00513699: hypothetical protein +FIG00513699 FIG00513701: hypothetical protein +FIG00513701 FIG00513702: hypothetical protein +FIG00513702 FIG00513703: hypothetical protein +FIG00513704 FIG00513705: hypothetical protein +FIG00513705 FIG00513707: hypothetical protein +FIG00513709 FIG00513715: hypothetical protein +FIG00513716 FIG00513717: hypothetical protein +FIG00513717 FIG00513719: hypothetical protein +FIG00513719 FIG00513720: hypothetical protein +FIG00513720 putative type IV prepilin leader peptidase +FIG00513723 FIG00513724: hypothetical protein +FIG00513724 FIG00513725: hypothetical protein +FIG00513725 FIG00513726: hypothetical protein +FIG00513726 probable zinc protease +FIG00513727 FIG00513729: hypothetical protein +FIG00513730 FIG00513732: hypothetical protein +FIG00513733 FIG00513734: hypothetical protein +FIG00513734 FIG00513736: hypothetical protein +FIG00513736 FIG00513740: hypothetical protein +FIG00513745 FIG00513746: hypothetical protein +FIG00513746 FIG00513747: hypothetical protein +FIG00513747 FIG00513748: hypothetical protein +FIG00513748 hypothetical protein +FIG00513750 FIG00513752: hypothetical protein +FIG00513752 Uncharacterized ABC-type transport system, periplasmic component/surface lipoprotein +FIG00513753 FIG00513756: hypothetical protein +FIG00513758 FIG00513759: hypothetical protein +FIG00513759 FIG00513760: hypothetical protein +FIG00513764 FIG00513765: hypothetical protein +FIG00513769 FIG00513770: hypothetical protein +FIG00513771 FIG00513773: hypothetical protein +FIG00513774 transcriptional regulator (AraC/XylS family) +FIG00513776 FIG00513777: hypothetical protein +FIG00513783 FIG00513784: hypothetical protein +FIG00513791 predicted zinc-dependent protease, DUF45 family +FIG00513793 FIG00513796: hypothetical protein +FIG00513797 FIG00513798: hypothetical protein +FIG00513801 FIG00513802: hypothetical protein +FIG00513802 FIG00513803: hypothetical protein +FIG00513803 Probable cation efflux pump, multidrug resistance protein (FS) +FIG00513806 FIG00513807: hypothetical protein +FIG00513810 hypothetical protein +FIG00513811 phosphoesterase, putative subfamily +FIG00513813 FIG00513814: hypothetical protein +FIG00513814 FIG00513815: hypothetical protein +FIG00513815 FIG00513816: hypothetical protein +FIG00513816 FIG00513817: hypothetical protein +FIG00513819 FIG00513822: hypothetical protein +FIG00513822 probable amino-acid ABC transporter, permease protein +FIG00513824 Stage IV sporulation protein +FIG00513829 putative membrane protein (putative phage infection protein) +FIG00513832 FIG00513835: hypothetical protein +FIG00513835 FIG00513836: hypothetical protein +FIG00513836 FIG00513840: hypothetical protein +FIG00513840 FIG00513841: hypothetical protein +FIG00513841 FIG00513844: hypothetical protein +FIG00513845 FIG00513847: hypothetical protein +FIG00513849 FIG00513851: hypothetical protein +FIG00513854 FIG00513855: hypothetical protein +FIG00513855 FIG00513856: hypothetical protein +FIG00513859 Carbon monoxide dehydrogenase medium chain (EC 1.2.99.2) +FIG00513860 FIG00513861: hypothetical protein +FIG00513861 FIG00513862: hypothetical protein +FIG00513863 FIG00513866: hypothetical protein +FIG00513868 FIG00513869: hypothetical protein +FIG00513869 FIG00513874: hypothetical protein +FIG00513874 FIG00513875: hypothetical protein +FIG00513876 FIG00513879: hypothetical protein +FIG00513882 FIG00513883: hypothetical protein +FIG00513883 FIG00513884: hypothetical protein +FIG00513884 FIG00513885: hypothetical protein +FIG00513885 FIG00513888: hypothetical protein +FIG00513893 sigma-54 dependent regulatory protein +FIG00513894 FIG00513895: hypothetical protein +FIG00513895 FIG00513897: hypothetical protein +FIG00513897 FIG00513899: hypothetical protein +FIG00513899 FIG00513903: hypothetical protein +FIG00513904 FIG00513906: hypothetical protein +FIG00513906 FIG00513907: hypothetical protein +FIG00513908 FIG00513909: hypothetical protein +FIG00513909 FIG00513910: hypothetical protein +FIG00513912 FIG00513915: hypothetical protein +FIG00513915 FIG00513918: hypothetical protein +FIG00513918 FIG00513920: hypothetical protein +FIG00513920 FIG00513921: hypothetical protein +FIG00513925 FIG00513926: hypothetical protein +FIG00513926 FIG00513927: hypothetical protein +FIG00513927 FIG00513928: hypothetical protein +FIG00513929 FIG00513933: hypothetical protein +FIG00513933 FIG00513934: hypothetical protein +FIG00513934 FIG00513936: hypothetical protein +FIG00513936 FIG00513938: hypothetical protein +FIG00513939 FIG00513940: hypothetical protein +FIG00513940 FIG00513942: hypothetical protein +FIG00513942 FIG00513944: hypothetical protein +FIG00513946 CoA-binding +FIG00513950 FIG00513955: hypothetical protein +FIG00513955 Flagellar protein +FIG00513956 FIG00513958: hypothetical protein +FIG00513959 FIG00513960: hypothetical protein +FIG00513960 FIG00513962: hypothetical protein +FIG00513962 FIG00513963: hypothetical protein +FIG00513967 amino acid ABC transporter, substrate-binding protein +FIG00513969 FIG00513972: hypothetical protein +FIG00513973 FIG00513974: hypothetical protein +FIG00513974 putative transcription antiterminator +FIG00513975 FIG00513978: hypothetical protein +FIG00513979 FIG00513980: hypothetical protein +FIG00513980 FIG00513982: hypothetical protein +FIG00513982 FIG00513983: hypothetical protein +FIG00513983 FIG00513986: hypothetical protein +FIG00513986 FIG00513987: hypothetical protein +FIG00513987 FIG00513988: hypothetical protein +FIG00513988 FIG00513989: hypothetical protein +FIG00513989 FIG00513990: hypothetical protein +FIG00513991 FIG00513992: hypothetical protein +FIG00513992 FIG00513993: hypothetical protein +FIG00513993 Acyl-acyl carrier protein thioesterase (EC 3.1.2.14) +FIG00513996 FIG00513998: hypothetical protein +FIG00513998 FIG00514000: hypothetical protein +FIG00514000 FIG00514001: hypothetical protein +FIG00514001 FIG00627599: hypothetical protein +FIG00514002 FIG00514004: hypothetical protein +FIG00514004 FIG00514005: hypothetical protein +FIG00514005 FIG00514006: hypothetical protein +FIG00514010 putative phage tail fiber protein +FIG00514013 Export ABC transporter permease +FIG00514014 FIG00514015: hypothetical protein +FIG00514017 FIG00514018: hypothetical protein +FIG00514018 FIG00514020: hypothetical protein +FIG00514020 FIG00514021: hypothetical protein +FIG00514022 FIG00514023: hypothetical protein +FIG00514023 FIG00514025: hypothetical protein +FIG00514025 FIG00514026: hypothetical protein +FIG00514026 FIG00514030: hypothetical protein +FIG00514030 FIG00514031: hypothetical protein +FIG00514031 FIG00514032: hypothetical protein +FIG00514032 FIG00514033: hypothetical protein +FIG00514034 FIG00514035: hypothetical protein +FIG00514035 FIG00514037: hypothetical protein +FIG00514037 FIG00514039: hypothetical protein +FIG00514040 FIG00514041: hypothetical protein +FIG00514041 FIG00514044: hypothetical protein +FIG00514044 FIG00514046: hypothetical protein +FIG00514046 FIG00514048: hypothetical protein +FIG00514048 FIG00514051: hypothetical protein +FIG00514051 FIG00514052: hypothetical protein +FIG00514052 FIG00514054: hypothetical protein +FIG00514054 FIG00514059: hypothetical protein +FIG00514059 FIG00514060: hypothetical protein +FIG00514062 FIG00514064: hypothetical protein +FIG00514064 FIG00514065: hypothetical protein +FIG00514065 Scaffold protein +FIG00514066 FIG00514067: hypothetical protein +FIG00514067 FIG00514068: hypothetical protein +FIG00514072 Phage-like element PBSX protein xkdK +FIG00514075 FIG00514076: hypothetical protein +FIG00514076 FIG00514079: hypothetical protein +FIG00514079 Radical SAM-superfamily protein +FIG00514084 SCIFF radical SAM maturase +FIG00514086 FIG00514087: hypothetical protein +FIG00514087 FIG00514089: hypothetical protein +FIG00514089 comEC/Rec2 family protein +FIG00514090 conserved hypothetical protein +FIG00514093 hypothetical asperagine-rich protein +FIG00514098 FIG00514101: hypothetical protein +FIG00514101 Endoglucanase B precursor (EC 3.2.1.4) +FIG00514105 FIG00514106: hypothetical protein +FIG00514107 FIG00514108: hypothetical protein +FIG00514108 FIG00514112: hypothetical protein +FIG00514112 FIG00514113: hypothetical protein +FIG00514116 FIG00514117: hypothetical protein +FIG00514117 probable lysine-N-methylase +FIG00514118 FIG00514119: hypothetical protein +FIG00514119 FIG00514122: hypothetical protein +FIG00514122 FIG00514123: hypothetical protein +FIG00514123 FIG00514124: hypothetical protein +FIG00514124 FIG00514125: hypothetical protein +FIG00514125 Endo-1,3(4)-beta-glucanase 1 precursor (EC 3.2.1.6) +FIG00514134 probable transcription regulator, lacI/xre family +FIG00514135 FIG00514138: hypothetical protein +FIG00514138 Histidinol phosphatase and related hydrolases of the PHP family +FIG00514141 FIG00514142: hypothetical protein +FIG00514142 FIG00514143: hypothetical protein +FIG00514149 DNA adenine-specific methyltransferase +FIG00514152 FIG00514154: hypothetical protein +FIG00514154 FIG00514155: hypothetical protein +FIG00514157 FIG00514158: hypothetical protein +FIG00514158 FIG00514160: hypothetical protein +FIG00514160 FIG00514161: hypothetical protein +FIG00514161 FIG00514164: hypothetical protein +FIG00514164 FIG00514170: hypothetical protein +FIG00514170 FIG00514171: hypothetical protein +FIG00514171 FIG00514173: hypothetical protein +FIG00514176 FIG00514177: hypothetical protein +FIG00514177 PAS:GGDEF +FIG00514186 FIG00514187: hypothetical protein +FIG00514187 FIG00514190: hypothetical protein +FIG00514190 FIG00774117: hypothetical protein +FIG00514192 FIG00514194: hypothetical protein +FIG00514198 FIG00514199: hypothetical protein +FIG00514200 FIG00514202: hypothetical protein +FIG00514203 FIG00514204: hypothetical protein +FIG00514204 FIG00514207: hypothetical protein +FIG00514207 FIG00514210: hypothetical protein +FIG00514212 FIG00514215: hypothetical protein +FIG00514215 FIG00514216: hypothetical protein +FIG00514216 FIG00514217: hypothetical protein +FIG00514217 FIG00514220: hypothetical protein +FIG00514220 FIG176548: DRTGG domain-containing protein +FIG00514225 FIG00514227: hypothetical protein +FIG00514227 FIG00514228: hypothetical protein +FIG00514228 FIG00514229: hypothetical protein +FIG00514229 FIG00514230: hypothetical protein +FIG00514230 FIG00514232: hypothetical protein +FIG00514232 FIG00514233: hypothetical protein +FIG00514233 Lantibiotic transport permease protein +FIG00514235 FIG00514236: hypothetical protein +FIG00514236 putative lantibiotic ABC transporter, permease protein +FIG00514237 FIG00514240: hypothetical protein +FIG00514243 FIG00514248: hypothetical protein +FIG00514248 FIG00514249: hypothetical protein +FIG00514249 FIG00514251: hypothetical protein +FIG00514251 FIG00514254: hypothetical protein +FIG00514254 FIG00514255: hypothetical protein +FIG00514259 FIG00514261: hypothetical protein +FIG00514263 FIG00514264: hypothetical protein +FIG00514264 FIG00514265: hypothetical protein +FIG00514265 FIG00514266: hypothetical protein +FIG00514266 FIG00514268: hypothetical protein +FIG00514268 FIG00514269: hypothetical protein +FIG00514271 FIG00514274: hypothetical protein +FIG00514274 FIG00514275: hypothetical protein +FIG00514275 putative chromate transporter +FIG00514284 FIG00514286: hypothetical protein +FIG00514289 Membrane spanning protein +FIG00514291 FIG00514292: hypothetical protein +FIG00514294 FIG00514295: hypothetical protein +FIG00514296 FIG00514297: hypothetical protein +FIG00514297 no significant homology +FIG00514300 HAD-superfamily hydrolase, subfamily IA, variant 3:HAD-superfamily hydrolase, subfamily IA, variant 1 +FIG00514303 FIG00514304: hypothetical protein +FIG00514304 FIG00514305: hypothetical protein +FIG00514305 FIG00514309: hypothetical protein +FIG00514309 FIG00514310: hypothetical protein +FIG00514310 FIG00514311: hypothetical protein +FIG00514311 FIG00514312: hypothetical protein +FIG00514312 FIG00514313: hypothetical protein +FIG00514313 FIG00514315: hypothetical protein +FIG00514315 FIG00514318: hypothetical protein +FIG00514318 FIG00514322: hypothetical protein +FIG00514322 FIG00514325: hypothetical protein +FIG00514325 FIG00514326: hypothetical protein +FIG00514329 hypothetical protein +FIG00514333 FIG00514334: hypothetical protein +FIG00514334 FIG00514335: hypothetical protein +FIG00514335 FIG00514336: hypothetical protein +FIG00514336 FIG00514337: hypothetical protein +FIG00514337 FIG00514338: hypothetical protein +FIG00514338 FIG00514341: hypothetical protein +FIG00514341 FIG00514342: hypothetical protein +FIG00514342 FIG00514345: hypothetical protein +FIG00514345 FIG00514346: hypothetical protein +FIG00514346 FIG00514348: hypothetical protein +FIG00514348 FIG00514349: hypothetical protein +FIG00514349 FIG00514350: hypothetical protein +FIG00514361 FIG00514362: hypothetical protein +FIG00514362 putative amino acid racemase +FIG00514363 FIG00514366: hypothetical protein +FIG00514366 FIG00514367: hypothetical protein +FIG00514371 FIG00513411: hypothetical protein +FIG00514373 FIG00514374: hypothetical protein +FIG00514374 FIG00514376: hypothetical protein +FIG00514378 FIG00514379: hypothetical protein +FIG00514379 FIG00514381: hypothetical protein +FIG00514381 FIG00514382: hypothetical protein +FIG00514382 FIG00514383: hypothetical protein +FIG00514383 FIG00514384: hypothetical protein +FIG00514386 FIG00514391: hypothetical protein +FIG00514391 Antirestriction protein +FIG00514393 FIG00514397: hypothetical protein +FIG00514397 predicted ATPase +FIG00514398 FIG00514399: hypothetical protein +FIG00514400 FIG00514401: hypothetical protein +FIG00514401 FIG00514405: hypothetical protein +FIG00514405 FIG00514408: hypothetical protein +FIG00514408 FIG00514410: hypothetical protein +FIG00514412 FIG00514414: hypothetical protein +FIG00514414 UPF0182 protein AF1421 +FIG00514417 FIG00514418: hypothetical protein +FIG00514418 putative cell wall teichoic acid glycosylation protein +FIG00514420 Xre family DNA-binding domain and TPR-repeat-containing protein +FIG00514421 FIG00514422: hypothetical protein +FIG00514422 Streptolysin S biosynthesis protein (SagF) +FIG00514423 FIG00514426: hypothetical protein +FIG00514431 FIG00514432: hypothetical protein +FIG00514432 FIG00514433: hypothetical protein +FIG00514434 FIG00514435: hypothetical protein +FIG00514435 FIG00514436: hypothetical protein +FIG00514436 FIG00514440: hypothetical protein +FIG00514440 FIG00514444: hypothetical protein +FIG00514447 FIG00514452: hypothetical protein +FIG00514453 TPR repeats containing protein +FIG00514457 FIG00514459: hypothetical protein +FIG00514459 FIG00514462: hypothetical protein +FIG00514464 FIG00514467: hypothetical protein +FIG00514467 FIG00514471: hypothetical protein +FIG00514471 FIG00514472: hypothetical protein +FIG00514472 FIG00514474: hypothetical protein +FIG00514474 TcdC +FIG00514475 FIG00514476: hypothetical protein +FIG00514476 FIG00514480: hypothetical protein +FIG00514480 FIG00514482: hypothetical protein +FIG00514484 FIG00514487: hypothetical protein +FIG00514487 FIG00514488: hypothetical protein +FIG00514490 FIG00514492: hypothetical protein +FIG00514492 FIG00514494: hypothetical protein +FIG00514494 FIG00514496: hypothetical protein +FIG00514496 Six-cysteine peptide SCIFF +FIG00514499 FIG00514501: hypothetical protein +FIG00514501 FIG00514503: hypothetical protein +FIG00514503 FIG00514507: hypothetical protein +FIG00514509 FIG00514510: hypothetical protein +FIG00514510 no significant homology Putative N-terminal signal sequence and 2 putative transmembrane regions were found by PSORT. +FIG00514511 FIG00514512: hypothetical protein +FIG00514514 FIG00514516: hypothetical protein +FIG00514520 FIG00514521: hypothetical protein +FIG00514521 FIG00514522: hypothetical protein +FIG00514525 FIG00514528: hypothetical protein +FIG00514528 FIG00514529: hypothetical protein +FIG00514529 FIG00514532: hypothetical protein +FIG00514532 FIG00514534: hypothetical protein +FIG00514534 FIG00514536: hypothetical protein +FIG00514538 phosphodiesterase, MJ0936 family +FIG00514539 FIG00514540: hypothetical protein +FIG00514544 diguanylate cyclase (GGDEF domain) +FIG00514546 FIG00514548: hypothetical protein +FIG00514548 FIG00514549: hypothetical protein +FIG00514549 FIG00514552: hypothetical protein +FIG00514552 FIG00514553: hypothetical protein +FIG00514553 FIG00514554: hypothetical protein +FIG00514554 Histidine kinase, HAMP region:Bacterial chemotaxis sensory transducer +FIG00514558 FIG00514559: hypothetical protein +FIG00514559 FIG00514563: hypothetical protein +FIG00514563 FIG00514565: hypothetical protein +FIG00514565 FIG00514567: hypothetical protein +FIG00514567 FIG00514569: hypothetical protein +FIG00514570 FIG00514571: hypothetical protein +FIG00514571 FIG00514572: hypothetical protein +FIG00514575 FIG00514576: hypothetical protein +FIG00514576 FIG00514579: hypothetical protein +FIG00514579 FIG00514581: hypothetical protein +FIG00514581 FIG00514584: hypothetical protein +FIG00514584 FIG00514586: hypothetical protein +FIG00514586 FIG00514588: hypothetical protein +FIG00514589 FIG00514590: hypothetical protein +FIG00514590 FIG00514594: hypothetical protein +FIG00514594 Histidinol phosphatase and related hydrolases of the PHP family +FIG00514596 FIG00514598: hypothetical protein +FIG00514604 FIG00514605: hypothetical protein +FIG00514605 FIG00514606: hypothetical protein +FIG00514608 FIG00514609: hypothetical protein +FIG00514609 FIG00514610: hypothetical protein +FIG00514612 FIG00514615: hypothetical protein +FIG00514615 FIG00514618: hypothetical protein +FIG00514618 Conserved protein +FIG00514619 sensory box/GGDEF/EAL/CBS domain protein +FIG00514623 FIG00514624: hypothetical protein +FIG00514624 no significant homology. Putative N-terminal signal sequence and 6 putative transmembrane regions were found by PSORT. +FIG00514627 FIG00514628: hypothetical protein +FIG00514628 FIG00514630: hypothetical protein +FIG00514630 FIG00514631: hypothetical protein +FIG00514632 FIG00514634: hypothetical protein +FIG00514635 spore germination protein, gerKC +FIG00514642 FIG00514643: hypothetical protein +FIG00514643 FIG00514645: hypothetical protein +FIG00514645 FIG00514646: hypothetical protein +FIG00514646 FIG00514650: hypothetical protein +FIG00514650 FIG00514653: hypothetical protein +FIG00514662 FIG00514664: hypothetical protein +FIG00514665 FIG00514666: hypothetical protein +FIG00514666 FIG00514672: hypothetical protein +FIG00514677 FIG00514678: hypothetical protein +FIG00514679 FIG00514680: hypothetical protein +FIG00514681 FIG00514682: hypothetical protein +FIG00514687 FIG00514688: hypothetical protein +FIG00514688 FIG00514690: hypothetical protein +FIG00514690 FIG00514691: hypothetical protein +FIG00514691 FIG00514692: hypothetical protein +FIG00514692 FIG00514696: hypothetical protein +FIG00514696 FIG00671589: hypothetical protein +FIG00514702 FIG00514703: hypothetical protein +FIG00514703 FIG00514704: hypothetical protein +FIG00514704 hypothetical protein +FIG00514717 FIG00514718: hypothetical protein +FIG00514718 FIG00514721: hypothetical protein +FIG00514721 FIG00514722: hypothetical protein +FIG00514722 FIG00514725: hypothetical protein +FIG00514725 FIG00514726: hypothetical protein +FIG00514726 FIG00514727: hypothetical protein +FIG00514727 FIG00514732: hypothetical protein +FIG00514733 putative phage-related DNA-directed RNA polymerase 7 kDa polypeptide +FIG00514735 FIG00514737: hypothetical protein +FIG00514737 FIG00514740: hypothetical protein +FIG00514741 FIG00514742: hypothetical protein +FIG00514742 Oligopeptide transport system permease protein oppC (TC 3.A.1.5.1) +FIG00514743 FIG00514748: hypothetical protein +FIG00514751 FIG00514752: hypothetical protein +FIG00514752 FIG00514758: hypothetical protein +FIG00514761 FIG00514765: hypothetical protein +FIG00514766 prophage Lp4 protein 7, DNA replication +FIG00514767 FIG00514768: hypothetical protein +FIG00514769 FIG00514771: hypothetical protein +FIG00514775 FIG00514776: hypothetical protein +FIG00514776 FIG00514777: hypothetical protein +FIG00514777 FIG00514778: hypothetical protein +FIG00514778 FIG00514779: hypothetical protein +FIG00514779 FIG00514780: hypothetical protein +FIG00514780 FIG00514781: hypothetical protein +FIG00514784 FIG00514786: hypothetical protein +FIG00514786 FIG00514789: hypothetical protein +FIG00514789 FIG00514790: hypothetical protein +FIG00514790 FIG00514791: hypothetical protein +FIG00514791 FIG00514794: hypothetical protein +FIG00514796 FIG00514798: hypothetical protein +FIG00514798 FIG00514799: hypothetical protein +FIG00514799 FIG00514802: hypothetical protein +FIG00514802 Membrane-associated protein +FIG00514809 FIG00514812: hypothetical protein +FIG00514821 FIG00514824: hypothetical protein +FIG00514824 FIG00514825: hypothetical protein +FIG00514825 FIG00590975: hypothetical protein +FIG00514829 FIG00514830: hypothetical protein +FIG00514831 FIG00514832: hypothetical protein +FIG00514832 FIG00514833: hypothetical protein +FIG00514833 FIG00514834: hypothetical protein +FIG00514834 FIG00514835: hypothetical protein +FIG00514842 DeoR-family transcriptional regulator +FIG00514848 FIG00514853: hypothetical protein +FIG00514853 FIG00514855: hypothetical protein +FIG00514856 FIG00514857: hypothetical protein +FIG00514857 FIG00514860: hypothetical protein +FIG00514860 FIG00514861: hypothetical protein +FIG00514861 FIG00514862: hypothetical protein +FIG00514862 FIG00514863: hypothetical protein +FIG00514863 FIG00514864: hypothetical protein +FIG00514864 FIG00514865: hypothetical protein +FIG00514865 FIG00514866: hypothetical protein +FIG00514866 FIG00514868: hypothetical protein +FIG00514868 FIG00514869: hypothetical protein +FIG00514869 FIG00514870: hypothetical protein +FIG00514878 FIG00514880: hypothetical protein +FIG00514883 FIG00514886: hypothetical protein +FIG00514886 FIG00514888: hypothetical protein +FIG00514888 putative type IV pilin +FIG00514891 FIG00514893: hypothetical protein +FIG00514895 FIG00514896: hypothetical protein +FIG00514896 FIG00514897: hypothetical protein +FIG00514897 FIG00514898: hypothetical protein +FIG00514898 FIG00514899: hypothetical protein +FIG00514902 FIG00514903: hypothetical protein +FIG00514905 FIG00514907: hypothetical protein +FIG00514909 FIG00514910: hypothetical protein +FIG00514911 FIG00514912: hypothetical protein +FIG00514912 FIG00514915: hypothetical protein +FIG00514915 FIG00514916: hypothetical protein +FIG00514916 FIG00514917: hypothetical protein +FIG00514917 FIG00514919: hypothetical protein +FIG00514919 FIG00514920: hypothetical protein +FIG00514920 FIG00514922: hypothetical protein +FIG00514922 FIG00514923: hypothetical protein +FIG00514925 FIG00514928: hypothetical protein +FIG00514928 FIG00514929: hypothetical protein +FIG00514929 FIG00514931: hypothetical protein +FIG00514937 FIG00514938: hypothetical protein +FIG00514944 FIG00514945: hypothetical protein +FIG00514945 FIG00514948: hypothetical protein +FIG00514948 FIG00514949: hypothetical protein +FIG00514949 no significant homology 4 putative transmembrane regions were found by PSORT. +FIG00514950 FIG00514953: hypothetical protein +FIG00514953 FIG00514954: hypothetical protein +FIG00514954 FIG00514955: hypothetical protein +FIG00514958 FIG00514959: hypothetical protein +FIG00514959 OrfX +FIG00514960 FIG00514961: hypothetical protein +FIG00514961 FIG00514963: hypothetical protein +FIG00514963 Uncharacterized phage-associated protein-like protein +FIG00514966 FIG00514970: hypothetical protein +FIG00514970 FIG00514971: hypothetical protein +FIG00514971 FIG00514973: hypothetical protein +FIG00514974 FIG00514979: hypothetical protein +FIG00514979 FIG00514982: hypothetical protein +FIG00514982 FIG00514983: hypothetical protein +FIG00514983 FIG00514985: hypothetical protein +FIG00514985 FIG00514987: hypothetical protein +FIG00514987 FIG00518845: hypothetical protein +FIG00514993 FIG00514995: hypothetical protein +FIG00514995 FIG00514996: hypothetical protein +FIG00514996 FIG00514997: hypothetical protein +FIG00514998 FIG00514999: hypothetical protein +FIG00514999 FIG00515000: hypothetical protein +FIG00515002 FIG00515005: hypothetical protein +FIG00515005 FIG00515006: hypothetical protein +FIG00515006 FIG00515007: hypothetical protein +FIG00515007 FIG00515012: hypothetical protein +FIG00515012 FIG00515018: hypothetical protein +FIG00515018 FIG00515019: hypothetical protein +FIG00515019 FIG00515025: hypothetical protein +FIG00515025 FIG00515026: hypothetical protein +FIG00515028 FIG00515033: hypothetical protein +FIG00515033 FIG00515036: hypothetical protein +FIG00515038 FIG00515039: hypothetical protein +FIG00515039 FIG00515041: hypothetical protein +FIG00515041 ABC-type nitrate/sulfonate/bicarbonate transport system, permease component +FIG00515042 FIG00515043: hypothetical protein +FIG00515043 FIG00515049: hypothetical protein +FIG00515049 FIG00515050: hypothetical protein +FIG00515050 FIG00515051: hypothetical protein +FIG00515052 FIG00515054: hypothetical protein +FIG00515055 FIG00515056: hypothetical protein +FIG00515056 FIG00515058: hypothetical protein +FIG00515058 FIG00515059: hypothetical protein +FIG00515063 FIG00515065: hypothetical protein +FIG00515066 FIG00515072: hypothetical protein +FIG00515072 FIG00515074: hypothetical protein +FIG00515074 FIG00515075: hypothetical protein +FIG00515075 FIG00515076: hypothetical protein +FIG00515076 FIG00515077: hypothetical protein +FIG00515078 FIG00515086: hypothetical protein +FIG00515086 FIG00515087: hypothetical protein +FIG00515087 FIG00515090: hypothetical protein +FIG00515090 FIG00515092: hypothetical protein +FIG00515092 FIG00588672: hypothetical protein +FIG00515101 FIG00515103: hypothetical protein +FIG00515106 FIG00515107: hypothetical protein +FIG00515107 FIG00515108: hypothetical protein +FIG00515108 FIG00515109: hypothetical protein +FIG00515109 ribosomal-protein-alanine acetyltransferase +FIG00515111 FIG00515118: hypothetical protein +FIG00515122 FIG00515125: hypothetical protein +FIG00515125 FIG00515127: hypothetical protein +FIG00515127 FIG00515128: hypothetical protein +FIG00515130 FIG00515131: hypothetical protein +FIG00515133 FIG00515138: hypothetical protein +FIG00515140 FIG00515143: hypothetical protein +FIG00515143 FIG00515146: hypothetical protein +FIG00515146 FIG00515147: hypothetical protein +FIG00515147 FIG00515149: hypothetical protein +FIG00515149 FIG00515150: hypothetical protein +FIG00515150 FIG00515151: hypothetical protein +FIG00515151 FIG00515152: hypothetical protein +FIG00515153 FIG00515154: hypothetical protein +FIG00515154 FIG00515160: hypothetical protein +FIG00515160 FIG00515162: hypothetical protein +FIG00515165 FIG00515167: hypothetical protein +FIG00515168 FIG00515172: hypothetical protein +FIG00515172 FIG00515174: hypothetical protein +FIG00515177 FIG00515178: hypothetical protein +FIG00515179 Protein mrp homolog +FIG00515182 FIG00515188: hypothetical protein +FIG00515192 FIG00515195: hypothetical protein +FIG00515195 FIG00515197: hypothetical protein +FIG00515199 FIG00515201: hypothetical protein +FIG00515202 FIG00515204: hypothetical protein +FIG00515204 FIG00515205: hypothetical protein +FIG00515205 FIG00515210: hypothetical protein +FIG00515210 FIG00515212: hypothetical protein +FIG00515212 FIG00515213: hypothetical protein +FIG00515213 FIG00515214: hypothetical protein +FIG00515214 FIG00515215: hypothetical protein +FIG00515215 FIG00515216: hypothetical protein +FIG00515216 FIG00515219: hypothetical protein +FIG00515219 FIG00515221: hypothetical protein +FIG00515221 FIG00515223: hypothetical protein +FIG00515223 putative MutE +FIG00515224 FIG00515225: hypothetical protein +FIG00515225 FIG00515227: hypothetical protein +FIG00515227 FIG00515228: hypothetical protein +FIG00515230 putative radical SAM superfamily protein +FIG00515233 FIG00515235: hypothetical protein +FIG00515237 FIG00515238: hypothetical protein +FIG00515240 FIG00515241: hypothetical protein +FIG00515244 FIG00515245: hypothetical protein +FIG00515245 FIG00515250: hypothetical protein +FIG00515258 FIG00515259: hypothetical protein +FIG00515260 putative two-component response regulator with GGDEF domain +FIG00515261 Spore coat protein cotS related +FIG00515262 FIG00515263: hypothetical protein +FIG00515263 FIG00515267: hypothetical protein +FIG00515269 FIG00515271: hypothetical protein +FIG00515271 FIG00515272: hypothetical protein +FIG00515273 FIG00515274: hypothetical protein +FIG00515276 FIG00515277: hypothetical protein +FIG00515277 FIG00515278: hypothetical protein +FIG00515278 FIG00515279: hypothetical protein +FIG00515279 FIG00515284: hypothetical protein +FIG00515284 FIG00515286: hypothetical protein +FIG00515286 FIG00515287: hypothetical protein +FIG00515287 FIG00515288: hypothetical protein +FIG00515288 FIG00515289: hypothetical protein +FIG00515289 FIG00515291: hypothetical protein +FIG00515291 FIG00515292: hypothetical protein +FIG00515292 flagellar motor switch protein +FIG00515293 FIG00515295: hypothetical protein +FIG00515296 FIG00515298: hypothetical protein +FIG00515301 FIG00515303: hypothetical protein +FIG00515306 FIG00515307: hypothetical protein +FIG00515307 FIG00515308: hypothetical protein +FIG00515311 FIG00515312: hypothetical protein +FIG00515313 FIG00515314: hypothetical protein +FIG00515316 FIG00515317: hypothetical protein +FIG00515317 FIG00515319: hypothetical protein +FIG00515319 FIG00515320: hypothetical protein +FIG00515320 FIG00515321: hypothetical protein +FIG00515321 FIG00515325: hypothetical protein +FIG00515325 FIG00515328: hypothetical protein +FIG00515331 FIG00515333: hypothetical protein +FIG00515333 FIG00515335: hypothetical protein +FIG00515335 FIG00515341: hypothetical protein +FIG00515341 FIG00515342: hypothetical protein +FIG00515342 FIG00515346: hypothetical protein +FIG00515347 FIG00515354: hypothetical protein +FIG00515354 FIG00515356: hypothetical protein +FIG00515356 FIG00515357: hypothetical protein +FIG00515357 FIG00515358: hypothetical protein +FIG00515358 FIG00515359: hypothetical protein +FIG00515359 FIG00515363: hypothetical protein +FIG00515363 NADPH-dependent FMN reductase +FIG00515368 FIG00515369: hypothetical protein +FIG00515369 FIG00515372: hypothetical protein +FIG00515372 FIG00515373: hypothetical protein +FIG00515373 FIG00515374: hypothetical protein +FIG00515374 FIG00515375: hypothetical protein +FIG00515375 FIG00515376: hypothetical protein +FIG00515381 FIG00515382: hypothetical protein +FIG00515383 FIG00515385: hypothetical protein +FIG00515385 FIG00515387: hypothetical protein +FIG00515387 FIG00515389: hypothetical protein +FIG00515392 FIG00515394: hypothetical protein +FIG00515394 ABC-type multidrug transport system (3-component subtilin immunity exporter), ATPase component, putative +FIG00515397 FIG00515398: hypothetical protein +FIG00515398 FIG00515400: hypothetical protein +FIG00515405 FIG00515406: hypothetical protein +FIG00515406 FIG00515407: hypothetical protein +FIG00515407 FIG00515408: hypothetical protein +FIG00515408 FIG00515409: hypothetical protein +FIG00515410 FIG00515411: hypothetical protein +FIG00515413 FIG00515414: hypothetical protein +FIG00515418 FIG00515420: hypothetical protein +FIG00515421 FIG00515422: hypothetical protein +FIG00515422 FIG00522193: hypothetical protein +FIG00515430 FIG00515431: hypothetical protein +FIG00515431 FIG00515434: hypothetical protein +FIG00515434 FIG00515436: hypothetical protein +FIG00515436 FIG00515437: hypothetical protein +FIG00515437 FIG00515438: hypothetical protein +FIG00515438 Chitooligosaccharide deacetylase (EC 3.5.1.-) +FIG00515441 FIG00515444: hypothetical protein +FIG00515444 FIG00515447: hypothetical protein +FIG00515447 FIG00515449: hypothetical protein +FIG00515456 drug resistance transporter, EmrB/QacA family protein +FIG00515459 FIG00515461: hypothetical protein +FIG00515461 FIG00515462: hypothetical protein +FIG00515462 FIG00515463: hypothetical protein +FIG00515463 FIG00515465: hypothetical protein +FIG00515465 FIG00515466: hypothetical protein +FIG00515466 FIG00515467: hypothetical protein +FIG00515468 FIG00515474: hypothetical protein +FIG00515474 FIG00515476: hypothetical protein +FIG00515476 FIG00515477: hypothetical protein +FIG00515479 FIG00515483: hypothetical protein +FIG00515484 FIG00515485: hypothetical protein +FIG00515485 FIG00515486: hypothetical protein +FIG00515487 FIG00515492: hypothetical protein +FIG00515492 FIG00515493: hypothetical protein +FIG00515493 FIG00515494: hypothetical protein +FIG00515496 FIG00515497: hypothetical protein +FIG00515497 ABC transporter amino acid-binding protein / Amino acid ABC transporter permease protein +FIG00515499 FIG00515500: hypothetical protein +FIG00515500 FIG00515504: hypothetical protein +FIG00515504 FIG00515505: hypothetical protein +FIG00515505 FIG00515506: hypothetical protein +FIG00515506 FIG00515507: hypothetical protein +FIG00515507 FIG00515508: hypothetical protein +FIG00515508 coat protein +FIG00515512 FIG00515513: hypothetical protein +FIG00515513 FIG00515514: hypothetical protein +FIG00515524 FIG00515528: hypothetical protein +FIG00515528 FIG00515532: hypothetical protein +FIG00515535 FIG00515537: hypothetical protein +FIG00515537 FIG00515539: hypothetical protein +FIG00515539 Type III secretion proteins, related to flagellar biosynthesis protein FlhB +FIG00515541 FIG00515542: hypothetical protein +FIG00515542 FIG00515546: hypothetical protein +FIG00515546 FIG00515548: hypothetical protein +FIG00515549 FIG00515553: hypothetical protein +FIG00515554 FIG00515555: hypothetical protein +FIG00515555 FIG00515556: hypothetical protein +FIG00515557 diguanylate cyclase/phosphodiesterase (GGDEF & EAL domains) with PAS/PAC sensor(s) +FIG00515559 FIG00515560: hypothetical protein +FIG00515562 FIG00515564: hypothetical protein +FIG00515564 FIG00515566: hypothetical protein +FIG00515566 FIG00515567: hypothetical protein +FIG00515568 FIG00515572: hypothetical protein +FIG00515572 Inositol transport protein +FIG00515574 FIG00515578: hypothetical protein +FIG00515580 PduJ-like protein clustered with pyruvate formate-lyase +FIG00515585 FIG00515587: hypothetical protein +FIG00515587 Cell division topological determinant MinJ +FIG00515591 putative sodium extrusion ABC transporter,ATP-binding protein +FIG00515595 FIG00515596: hypothetical protein +FIG00515600 FIG00515602: hypothetical protein +FIG00515602 FIG00515603: hypothetical protein +FIG00515603 Response regulator (CheY-like receiver domain and HTH-type DNA-binding domain) +FIG00515604 FIG00515607: hypothetical protein +FIG00515607 FIG00515610: hypothetical protein +FIG00515610 FIG00515612: hypothetical protein +FIG00515613 Predicted regulatory protein +FIG00515622 FIG00515624: hypothetical protein +FIG00515628 FIG00513058: hypothetical protein +FIG00515630 FIG00515631: hypothetical protein +FIG00515631 sugar transporter +FIG00515632 FIG00515633: hypothetical protein +FIG00515633 FIG00515634: hypothetical protein +FIG00515635 FIG00515638: hypothetical protein +FIG00515638 FIG00515642: hypothetical protein +FIG00515642 FIG00515643: hypothetical protein +FIG00515643 prophage LambdaBa02, lipoprotein, putative +FIG00515647 FIG00515649: hypothetical protein +FIG00515649 FIG00515650: hypothetical protein +FIG00515650 FIG00515652: hypothetical protein +FIG00515652 FIG00515653: hypothetical protein +FIG00515653 FIG00515654: hypothetical protein +FIG00515654 FIG00515656: hypothetical protein +FIG00515656 FIG00515658: hypothetical protein +FIG00515658 FIG00515661: hypothetical protein +FIG00515661 FIG00515662: hypothetical protein +FIG00515662 FIG00515664: hypothetical protein +FIG00515665 Phage protein, HK97, gp10 +FIG00515669 FIG00515670: hypothetical protein +FIG00515674 putative phage positive regulator of late transcription +FIG00515675 FIG00515678: hypothetical protein +FIG00515678 FIG00515679: hypothetical protein +FIG00515679 FIG00515680: hypothetical protein +FIG00515681 FIG00515683: hypothetical protein +FIG00515683 FIG00515684: hypothetical protein +FIG00515684 cystine/glutamine-binding periplasmic protein +FIG00515685 FIG00515686: hypothetical protein +FIG00515687 FIG00515690: hypothetical protein +FIG00515690 FIG00515692: hypothetical protein +FIG00515692 FIG00515693: hypothetical protein +FIG00515693 FIG00515694: hypothetical protein +FIG00515694 FIG00515698: hypothetical protein +FIG00515699 FIG00515701: hypothetical protein +FIG00515701 FIG00515703: hypothetical protein +FIG00515706 FIG00515708: hypothetical protein +FIG00515708 FIG00515709: hypothetical protein +FIG00515710 FIG00515712: hypothetical protein +FIG00515712 FIG00515714: hypothetical protein +FIG00515714 UPF0261 protein mll9388 +FIG00515715 FIG00515718: hypothetical protein +FIG00515718 FIG00515723: hypothetical protein +FIG00515723 FIG00515724: hypothetical protein +FIG00515726 FIG00515727: hypothetical protein +FIG00515727 FIG00515730: hypothetical protein +FIG00515730 FIG00515732: hypothetical protein +FIG00515732 FIG00515736: hypothetical protein +FIG00515739 FIG01032115: hypothetical protein +FIG00515741 FIG00515743: hypothetical protein +FIG00515744 FIG00515745: hypothetical protein +FIG00515745 FIG00515746: hypothetical protein +FIG00515746 FIG00515747: hypothetical protein +FIG00515751 FIG00515757: hypothetical protein +FIG00515757 FIG00515760: hypothetical protein +FIG00515760 FIG00515762: hypothetical protein +FIG00515764 VanZ +FIG00515767 Uncharacterized protein, posible homoloh of YJFB B. subtilis +FIG00515769 FIG00515770: hypothetical protein +FIG00515770 FIG00515771: hypothetical protein +FIG00515771 FIG00515773: hypothetical protein +FIG00515773 FIG00515775: hypothetical protein +FIG00515781 FIG00515783: hypothetical protein +FIG00515783 FIG00515787: hypothetical protein +FIG00515787 FIG00515788: hypothetical protein +FIG00515788 FIG00515790: hypothetical protein +FIG00515792 FIG00515794: hypothetical protein +FIG00515794 FIG00515795: hypothetical protein +FIG00515799 FIG00515800: hypothetical protein +FIG00515800 FIG00515802: hypothetical protein +FIG00515802 FIG00515807: hypothetical protein +FIG00515807 FIG00515809: hypothetical protein +FIG00515809 FIG00515810: hypothetical protein +FIG00515810 FIG00515811: hypothetical protein +FIG00515814 FIG00515815: hypothetical protein +FIG00515816 FIG00515818: hypothetical protein +FIG00515818 Helix-turn-helix, AraC type:Response regulator receiver +FIG00515820 FIG00515821: hypothetical protein +FIG00515821 FIG00515822: hypothetical protein +FIG00515824 FIG00515825: hypothetical protein +FIG00515830 FIG00515835: hypothetical protein +FIG00515835 FIG00515836: hypothetical protein +FIG00515836 FIG00515839: hypothetical protein +FIG00515839 FIG00515840: hypothetical protein +FIG00515840 FIG00515841: hypothetical protein +FIG00515841 methyl-accepting chemotaxis protein BH1509 , putative +FIG00515846 FIG00515847: hypothetical protein +FIG00515847 hypothetical protein +FIG00515861 cyclic nucleotide-binding domain protein +FIG00515869 FIG00515870: hypothetical protein +FIG00515873 FIG00515874: hypothetical protein +FIG00515875 FIG00515880: hypothetical protein +FIG00515880 FIG00515881: hypothetical protein +FIG00515881 FIG00515882: hypothetical protein +FIG00515883 FIG00515884: hypothetical protein +FIG00515884 FIG00515889: hypothetical protein +FIG00515889 FIG00515890: hypothetical protein +FIG00515890 FIG00515893: hypothetical protein +FIG00515893 FIG00515894: hypothetical protein +FIG00515894 FIG00515899: hypothetical protein +FIG00515899 FIG00515900: hypothetical protein +FIG00515903 FIG00515905: hypothetical protein +FIG00515905 FIG00515906: hypothetical protein +FIG00515906 FIG00515910: hypothetical protein +FIG00515910 FIG00515912: hypothetical protein +FIG00515912 FIG00515913: hypothetical protein +FIG00515913 FIG00515914: hypothetical protein +FIG00515914 FIG00515915: hypothetical protein +FIG00515915 FIG00515916: hypothetical protein +FIG00515917 FIG00515918: hypothetical protein +FIG00515918 FIG00515919: hypothetical protein +FIG00515919 FIG00515920: hypothetical protein +FIG00515920 FIG00515921: hypothetical protein +FIG00515922 hypothetical protein +FIG00515929 FIG00515933: hypothetical protein +FIG00515936 FIG00515937: hypothetical protein +FIG00515940 FIG00515943: hypothetical protein +FIG00515945 Methyltransferase (EC 2.1.1.-) +FIG00515946 endo-beta-galactosidase, GlcNAc-alpha-1,4-Gal-releasing +FIG00515952 FIG00515953: hypothetical protein +FIG00515954 Transcriptional activator BmrR for multidrug resistance transporter +FIG00515955 N-acetylmuramoyl-L-alanine amidase/putative S-layer protein +FIG00515956 FIG00515957: hypothetical protein +FIG00515957 FIG00515958: hypothetical protein +FIG00515958 FIG00515961: hypothetical protein +FIG00515961 FIG00515963: hypothetical protein +FIG00515963 FIG00515964: hypothetical protein +FIG00515964 FIG00515965: hypothetical protein +FIG00515965 FIG00515967: hypothetical protein +FIG00515971 FIG00515973: hypothetical protein +FIG00515976 FIG00515979: hypothetical protein +FIG00515981 FIG00515982: hypothetical protein +FIG00515993 FIG00515994: hypothetical protein +FIG00515994 FIG00515996: hypothetical protein +FIG00515997 DNA binding domain, excisionase family protein +FIG00515998 FIG00515999: hypothetical protein +FIG00515999 FIG00516000: hypothetical protein +FIG00516000 FIG00516002: hypothetical protein +FIG00516002 FIG00516005: hypothetical protein +FIG00516008 FIG00774209: hypothetical protein +FIG00516009 Zinc transport protein ZntB +FIG00516011 FIG00516013: hypothetical protein +FIG00516014 FIG00516019: hypothetical protein +FIG00516019 FIG00516020: hypothetical protein +FIG00516020 FIG00516021: hypothetical protein +FIG00516021 FIG00516022: hypothetical protein +FIG00516024 FIG00516025: hypothetical protein +FIG00516025 FIG00516026: hypothetical protein +FIG00516026 FIG00516027: hypothetical protein +FIG00516027 FIG00516029: hypothetical protein +FIG00516029 FIG00516031: hypothetical protein +FIG00516031 FIG00516032: hypothetical protein +FIG00516032 protein related to MifH/DopD protein family, function in bacteria is unknown +FIG00516033 FIG00516034: hypothetical protein +FIG00516034 FIG00516038: hypothetical protein +FIG00516038 FIG00516043: hypothetical protein +FIG00516043 FIG00516046: hypothetical protein +FIG00516046 FIG00516049: hypothetical protein +FIG00516049 FIG00516050: hypothetical protein +FIG00516050 FIG00516051: hypothetical protein +FIG00516053 FIG00516055: hypothetical protein +FIG00516059 FIG00516060: hypothetical protein +FIG00516060 FIG00516061: hypothetical protein +FIG00516064 FIG00516068: hypothetical protein +FIG00516068 FIG00516069: hypothetical protein +FIG00516069 FIG00516071: hypothetical protein +FIG00516072 FIG00516073: hypothetical protein +FIG00516078 FIG00516082: hypothetical protein +FIG00516082 FIG00516083: hypothetical protein +FIG00516083 FIG00516084: hypothetical protein +FIG00516084 FIG00516085: hypothetical protein +FIG00516085 FIG00516087: hypothetical protein +FIG00516089 FIG00516092: hypothetical protein +FIG00516093 FIG00516095: hypothetical protein +FIG00516095 FIG00516096: hypothetical protein +FIG00516096 FIG00516098: hypothetical protein +FIG00516098 FIG00516100: hypothetical protein +FIG00516100 FIG00516103: hypothetical protein +FIG00516105 FIG00516108: hypothetical protein +FIG00516108 FIG00516110: hypothetical protein +FIG00516110 FIG00516113: hypothetical protein +FIG00516113 FIG00516115: hypothetical protein +FIG00516115 FIG00516117: hypothetical protein +FIG00516119 FIG00516120: hypothetical protein +FIG00516120 FIG00516121: hypothetical protein +FIG00516121 FIG00516124: hypothetical protein +FIG00516124 FIG00516125: hypothetical protein +FIG00516129 FIG00516130: hypothetical protein +FIG00516130 FIG00516132: hypothetical protein +FIG00516133 FIG00516135: hypothetical protein +FIG00516135 FIG00516138: hypothetical protein +FIG00516138 FIG00516143: hypothetical protein +FIG00516144 FIG00516145: hypothetical protein +FIG00516152 FIG00516164: hypothetical protein +FIG00516166 FIG00516169: hypothetical protein +FIG00516169 FIG00516170: hypothetical protein +FIG00516170 FIG00516171: hypothetical protein +FIG00516171 FIG00516172: hypothetical protein +FIG00516172 two-component sensor histidine kinase +FIG00516175 FIG00516177: hypothetical protein +FIG00516177 FIG00516178: hypothetical protein +FIG00516180 putative Mg2+ transport protein +FIG00516185 FIG00516187: hypothetical protein +FIG00516187 FIG00516188: hypothetical protein +FIG00516191 FIG00516194: hypothetical protein +FIG00516194 FIG00516195: hypothetical protein +FIG00516197 FIG00516198: hypothetical protein +FIG00516198 FIG00516201: hypothetical protein +FIG00516201 FIG00516203: hypothetical protein +FIG00516204 FIG00516205: hypothetical protein +FIG00516211 FIG00516213: hypothetical protein +FIG00516213 FIG00516216: hypothetical protein +FIG00516216 FIG00516217: hypothetical protein +FIG00516217 FIG00516218: hypothetical protein +FIG00516220 FIG00516221: hypothetical protein +FIG00516221 FIG00516222: hypothetical protein +FIG00516227 Conserved protein (EC 4.4.1.5) +FIG00516230 FIG00516231: hypothetical protein +FIG00516231 FIG00516233: hypothetical protein +FIG00516233 FIG00516234: hypothetical protein +FIG00516234 FIG00516240: hypothetical protein +FIG00516240 FIG00516246: hypothetical protein +FIG00516248 FIG00516249: hypothetical protein +FIG00516249 forespore-specific lipoprotein +FIG00516250 FIG00516251: hypothetical protein +FIG00516253 Type IV pilus biogenesis protein PilO +FIG00516257 FIG00516258: hypothetical protein +FIG00516258 Phosphoesterase (EC 3.1.-) +FIG00516259 FIG00516261: hypothetical protein +FIG00516262 two component transcriptional regulator, AraC family +FIG00516263 FIG00516266: hypothetical protein +FIG00516266 FIG00516269: hypothetical protein +FIG00516269 FIG00516270: hypothetical protein +FIG00516271 FIG00516272: hypothetical protein +FIG00516272 FIG00516273: hypothetical protein +FIG00516273 FIG00516274: hypothetical protein +FIG00516274 FIG00516275: hypothetical protein +FIG00516275 putative pilin protein +FIG00516276 FIG00516277: hypothetical protein +FIG00516278 FIG00516281: hypothetical protein +FIG00516281 FIG00516283: hypothetical protein +FIG00516287 FIG00516288: hypothetical protein +FIG00516288 FIG00516291: hypothetical protein +FIG00516305 FIG00516306: hypothetical protein +FIG00516306 FIG00516308: hypothetical protein +FIG00516309 Ion channel family +FIG00516311 FIG00516312: hypothetical protein +FIG00516312 FIG00516314: hypothetical protein +FIG00516314 FIG00516315: hypothetical protein +FIG00516315 FIG00516317: hypothetical protein +FIG00516317 FIG00516318: hypothetical protein +FIG00516320 Cobalt-precorrin-6x reductase (EC 1.3.1.54) / Siroheme synthase (precorrin-2 oxidase/ferrochelatase domain) +FIG00516324 FIG00516325: hypothetical protein +FIG00516325 FIG00516326: hypothetical protein +FIG00516326 FIG00516329: hypothetical protein +FIG00516332 FIG00516333: hypothetical protein +FIG00516334 FIG00516335: hypothetical protein +FIG00516335 FIG00516336: hypothetical protein +FIG00516336 CRISPR-associated helicase Cas3 +FIG00516337 Cation antiporter +FIG00516338 FIG00516339: hypothetical protein +FIG00516339 FIG00516340: hypothetical protein +FIG00516342 FIG00516343: hypothetical protein +FIG00516343 FIG00516345: hypothetical protein +FIG00516345 FIG00516346: hypothetical protein +FIG00516346 Molybdopterin-guanine dinucleotide biosynthesis protein A +FIG00516347 FIG00516348: hypothetical protein +FIG00516351 FIG00516353: hypothetical protein +FIG00516356 FIG00516357: hypothetical protein +FIG00516357 FIG00516358: hypothetical protein +FIG00516358 FIG00516361: hypothetical protein +FIG00516362 FIG00516363: hypothetical protein +FIG00516366 FIG00516367: hypothetical protein +FIG00516367 FIG00516368: hypothetical protein +FIG00516370 FIG00516372: hypothetical protein +FIG00516372 FIG00516373: hypothetical protein +FIG00516373 FIG00516375: hypothetical protein +FIG00516379 FIG00516380: hypothetical protein +FIG00516383 FIG00516384: hypothetical protein +FIG00516384 FIG00516385: hypothetical protein +FIG00516385 FIG00516388: hypothetical protein +FIG00516393 FIG00516398: hypothetical protein +FIG00516401 FIG00516402: hypothetical protein +FIG00516402 spore germination protein, putative +FIG00516409 FIG00516410: hypothetical protein +FIG00516410 FIG00516412: hypothetical protein +FIG00516412 FIG00516415: hypothetical protein +FIG00516416 FIG00516418: hypothetical protein +FIG00516419 FIG00516422: hypothetical protein +FIG00516422 FIG00516425: hypothetical protein +FIG00516425 FIG00516426: hypothetical protein +FIG00516426 FIG00516427: hypothetical protein +FIG00516429 FIG00516434: hypothetical protein +FIG00516434 FIG00516435: hypothetical protein +FIG00516435 FIG00516436: hypothetical protein +FIG00516440 FIG00516442: hypothetical protein +FIG00516442 Endoglucanase (EC 3.2.1.4) +FIG00516444 FIG00516445: hypothetical protein +FIG00516445 Lysine-N-methylase (EC 2.1.1.-) (Lysine N-methyltransferase) +FIG00516451 sensory transduction protein kinase +FIG00516453 FIG00516454: hypothetical protein +FIG00516455 FIG00516457: hypothetical protein +FIG00516458 FIG00516459: hypothetical protein +FIG00516459 FIG00516462: hypothetical protein +FIG00516464 FIG00516465: hypothetical protein +FIG00516465 FIG00516466: hypothetical protein +FIG00516466 FIG00516467: hypothetical protein +FIG00516467 FIG00516470: hypothetical protein +FIG00516471 FIG00516472: hypothetical protein +FIG00516472 FIG00516476: hypothetical protein +FIG00516476 FIG00516478: hypothetical protein +FIG00516478 PGAP1-like protein +FIG00516479 Cellulose 1,4-beta-cellobiosidase (EC 3.2.1.91) +FIG00516481 FIG00516483: hypothetical protein +FIG00516483 FIG00516485: hypothetical protein +FIG00516485 FIG00516487: hypothetical protein +FIG00516487 FIG00516488: hypothetical protein +FIG00516488 FIG00516490: hypothetical protein +FIG00516493 FIG00516494: hypothetical protein +FIG00516494 FIG00516495: hypothetical protein +FIG00516499 FIG00516501: hypothetical protein +FIG00516502 FIG00516512: hypothetical protein +FIG00516517 Putative polyamine transport system, ATP-binding protein +FIG00516521 FIG00516522: hypothetical protein +FIG00516522 FIG00516523: hypothetical protein +FIG00516523 FIG00516524: hypothetical protein +FIG00516524 FIG00516526: hypothetical protein +FIG00516527 FIG00516530: hypothetical protein +FIG00516531 FIG00516534: hypothetical protein +FIG00516534 FIG00516536: hypothetical protein +FIG00516536 FIG00516537: hypothetical protein +FIG00516539 FIG00516542: hypothetical protein +FIG00516546 FIG00516548: hypothetical protein +FIG00516548 FIG00516550: hypothetical protein +FIG00516550 FIG00516551: hypothetical protein +FIG00516554 FIG00516556: hypothetical protein +FIG00516556 FIG00516557: hypothetical protein +FIG00516557 FIG00516558: hypothetical protein +FIG00516562 FIG00516569: hypothetical protein +FIG00516569 FIG00516574: hypothetical protein +FIG00516575 FIG00516578: hypothetical protein +FIG00516578 FIG00516579: hypothetical protein +FIG00516580 FIG00516582: hypothetical protein +FIG00516582 FIG00516584: hypothetical protein +FIG00516584 FIG00516590: hypothetical protein +FIG00516590 FIG00516591: hypothetical protein +FIG00516591 FIG00516592: hypothetical protein +FIG00516592 FIG00516595: hypothetical protein +FIG00516595 FIG00516596: hypothetical protein +FIG00516596 FIG00516598: hypothetical protein +FIG00516598 FIG00516599: hypothetical protein +FIG00516599 FIG00516600: hypothetical protein +FIG00516600 FIG00516601: hypothetical protein +FIG00516603 FIG00516604: hypothetical protein +FIG00516604 FIG00516605: hypothetical protein +FIG00516605 FIG00516606: hypothetical protein +FIG00516606 FIG00516610: hypothetical protein +FIG00516610 FIG00516612: hypothetical protein +FIG00516614 transcriptional regulator BotR, P-21 +FIG00516618 FIG00526497: hypothetical protein +FIG00516620 FIG00516621: hypothetical protein +FIG00516622 bacteriocin UviB +FIG00516624 FIG00516626: hypothetical protein +FIG00516627 FIG00516629: hypothetical protein +FIG00516629 FIG00516630: hypothetical protein +FIG00516630 FIG00516632: hypothetical protein +FIG00516633 FIG00516635: hypothetical protein +FIG00516635 FIG00516636: hypothetical protein +FIG00516636 FIG00516638: hypothetical protein +FIG00516638 FIG00516640: hypothetical protein +FIG00516640 Cell surface protein IsdA, transfers heme from hemoglobin to apo-IsdC / NPQTN cell wall anchored protein IsdC +FIG00516643 FIG00516644: hypothetical protein +FIG00516644 Zn-finger containing protein +FIG00516650 FIG00516655: hypothetical protein +FIG00516655 FIG00516656: hypothetical protein +FIG00516657 FIG00516660: hypothetical protein +FIG00516660 FIG00516661: hypothetical protein +FIG00516661 FIG00516665: hypothetical protein +FIG00516665 FIG00516666: hypothetical protein +FIG00516666 FIG00516668: hypothetical protein +FIG00516669 FIG00516672: hypothetical protein +FIG00516672 FIG00516679: hypothetical protein +FIG00516679 FIG00516682: hypothetical protein +FIG00516682 FIG00516684: hypothetical protein +FIG00516684 FIG00516688: hypothetical protein +FIG00516688 spore coat protein CotJC +FIG00516689 FIG00516690: hypothetical protein +FIG00516690 FIG00516691: hypothetical protein +FIG00516693 Spore cortex-lytic enzyme precursor +FIG00516694 DUF89 domain of unknown function +FIG00516697 putative phage resolvase/integrase (partial) +FIG00516711 FIG00516714: hypothetical protein +FIG00516714 FIG00516716: hypothetical protein +FIG00516724 FIG00516725: hypothetical protein +FIG00516725 FIG00516726: hypothetical protein +FIG00516726 electron transferring subunit of proline reductase +FIG00516727 small, acid-soluble spore protein, alpha/beta family +FIG00516728 putative sodium:sulfate symporter +FIG00516735 FIG00516736: hypothetical protein +FIG00516737 FIG00516738: hypothetical protein +FIG00516738 FIG00516739: hypothetical protein +FIG00516739 FIG00516745: hypothetical protein +FIG00516745 FIG00516749: hypothetical protein +FIG00516749 FIG00516757: hypothetical protein +FIG00516757 FIG00516760: hypothetical protein +FIG00516761 FIG00516762: hypothetical protein +FIG00516763 FIG00516764: hypothetical protein +FIG00516764 FIG00516765: hypothetical protein +FIG00516765 FIG00516767: hypothetical protein +FIG00516771 FIG00516776: hypothetical protein +FIG00516776 FIG00516777: hypothetical protein +FIG00516777 FIG00516778: hypothetical protein +FIG00516779 probable amino acid ABC transporter +FIG00516781 FIG00516782: hypothetical protein +FIG00516782 FIG00516783: hypothetical protein +FIG00516783 FIG00516786: hypothetical protein +FIG00516786 FIG00516787: hypothetical protein +FIG00516787 FIG00516788: hypothetical protein +FIG00516788 FIG00516790: hypothetical protein +FIG00516790 FIG00516793: hypothetical protein +FIG00516793 FIG00516794: hypothetical protein +FIG00516794 FIG00516795: hypothetical protein +FIG00516795 FIG00516798: hypothetical protein +FIG00516801 NADPH-dependent butanol dehydrogenase +FIG00516802 FIG00516803: hypothetical protein +FIG00516803 FIG00516804: hypothetical protein +FIG00516804 FIG00516807: hypothetical protein +FIG00516807 FIG00516811: hypothetical protein +FIG00516811 FIG00516813: hypothetical protein +FIG00516815 glutaredoxin-like protein, YruB-family +FIG00516816 FIG00516818: hypothetical protein +FIG00516818 FIG00516820: hypothetical protein +FIG00516820 FIG00516821: hypothetical protein +FIG00516824 FIG00516825: hypothetical protein +FIG00516825 FIG00516826: hypothetical protein +FIG00516826 FIG00516829: hypothetical protein +FIG00516829 FIG00516830: hypothetical protein +FIG00516833 L-fuculose phosphate aldolase( EC:4.1.2.17 ) +FIG00516836 FIG00516837: hypothetical protein +FIG00516837 FIG00516839: hypothetical protein +FIG00516839 FIG00516840: hypothetical protein +FIG00516840 FIG00516843: hypothetical protein +FIG00516844 FIG00516845: hypothetical protein +FIG00516845 FIG00516848: hypothetical protein +FIG00516848 FIG00516849: hypothetical protein +FIG00516849 FIG00516851: hypothetical protein +FIG00516854 FIG00516858: hypothetical protein +FIG00516858 acetyltransferase, GNAT family, putative +FIG00516859 FIG00516862: hypothetical protein +FIG00516862 putative bacterioferritin +FIG00516863 FIG00516865: hypothetical protein +FIG00516865 FIG00516866: hypothetical protein +FIG00516866 FIG00516868: hypothetical protein +FIG00516868 FIG00516869: hypothetical protein +FIG00516869 FIG00516870: hypothetical protein +FIG00516870 Probable calcium-transporting ATPase +FIG00516871 FIG00516872: hypothetical protein +FIG00516872 ABC-type MDR transport system, permease component +FIG00516876 FIG00516877: hypothetical protein +FIG00516877 FIG00516879: hypothetical protein +FIG00516879 FIG00516881: hypothetical protein +FIG00516881 FIG00516882: hypothetical protein +FIG00516882 FIG00516883: hypothetical protein +FIG00516885 FIG00516890: hypothetical protein +FIG00516892 FIG00516894: hypothetical protein +FIG00516894 FIG00516897: hypothetical protein +FIG00516897 FIG00516904: hypothetical protein +FIG00516904 FIG00516905: hypothetical protein +FIG00516905 FIG00516906: hypothetical protein +FIG00516906 FIG00516908: hypothetical protein +FIG00516908 FIG00516909: hypothetical protein +FIG00516909 FIG00516911: hypothetical protein +FIG00516911 FIG00516913: hypothetical protein +FIG00516913 FIG00516914: hypothetical protein +FIG00516914 FIG00516915: hypothetical protein +FIG00516915 FIG00516917: hypothetical protein +FIG00516919 FIG00516921: hypothetical protein +FIG00516921 FIG00516924: hypothetical protein +FIG00516928 FIG00516930: hypothetical protein +FIG00516930 FIG00516931: hypothetical protein +FIG00516931 FIG00516932: hypothetical protein +FIG00516932 FIG00516933: hypothetical protein +FIG00516933 FIG00516934: hypothetical protein +FIG00516934 FIG00516935: hypothetical protein +FIG00516935 copper amine oxidase-like protein +FIG00516938 ThlR, HTH transcriptional regulator TetR/AcrR family +FIG00516940 FIG00516942: hypothetical protein +FIG00516942 FIG00516948: hypothetical protein +FIG00516948 FIG00516950: hypothetical protein +FIG00516950 FIG00516955: hypothetical protein +FIG00516955 FIG00516956: hypothetical protein +FIG00516956 FIG00516968: hypothetical protein +FIG00516968 FIG00516971: hypothetical protein +FIG00516971 FIG00516972: hypothetical protein +FIG00516972 FIG00516974: hypothetical protein +FIG00516974 FIG00516975: hypothetical protein +FIG00516975 FIG00516976: hypothetical protein +FIG00516976 FIG00516978: hypothetical protein +FIG00516982 Cwp66 homolog/N-acetylmuramoyl-L-alanine amidase (EC 3.5.1.28) +FIG00516983 FIG00516984: hypothetical protein +FIG00516985 FIG00516986: hypothetical protein +FIG00516986 FIG00516988: hypothetical protein +FIG00516988 ORF-X1 +FIG00516992 FIG00534282: hypothetical protein +FIG00517000 FIG00517001: hypothetical protein +FIG00517001 FIG00517003: hypothetical protein +FIG00517003 FIG00517004: hypothetical protein +FIG00517004 FIG00517005: hypothetical protein +FIG00517007 FIG00517009: hypothetical protein +FIG00517009 FIG00517010: hypothetical protein +FIG00517010 FIG00517011: hypothetical protein +FIG00517011 FIG00517014: hypothetical protein +FIG00517017 FIG00517018: hypothetical protein +FIG00517021 FIG00517022: hypothetical protein +FIG00517025 FIG00517027: hypothetical protein +FIG00517027 FIG00517029: hypothetical protein +FIG00517029 FIG00517032: hypothetical protein +FIG00517033 FIG00517034: hypothetical protein +FIG00517034 FIG00517039: hypothetical protein +FIG00517039 FIG00517040: hypothetical protein +FIG00517040 FIG00517041: hypothetical protein +FIG00517041 FIG00517045: hypothetical protein +FIG00517045 Alpha-arabinosides ABC transport system, permease protein AraN +FIG00517054 two-component system response regulator +FIG00517055 FIG00517058: hypothetical protein +FIG00517058 nitroreductase-family protein +FIG00517067 Aldehyde reductase( EC:1.1.1.21 ) +FIG00517068 FIG00517070: hypothetical protein +FIG00517072 2,4-dienoyl-CoA reductase [NADPH] (EC 1.3.1.34) +FIG00517080 FIG00517081: hypothetical protein +FIG00517081 FIG00517083: hypothetical protein +FIG00517083 FIG00517084: hypothetical protein +FIG00517089 FIG00517090: hypothetical protein +FIG00517090 FIG00517101: hypothetical protein +FIG00517104 FIG00517105: hypothetical protein +FIG00517105 FIG00517107: hypothetical protein +FIG00517111 FIG00517112: hypothetical protein +FIG00517112 FIG00517113: hypothetical protein +FIG00517116 FIG00517118: hypothetical protein +FIG00517118 FIG00517121: hypothetical protein +FIG00517122 FIG00517123: hypothetical protein +FIG00517123 putative transporter, trans-membrane domain bacteriocin immunity protein +FIG00517127 FIG00517129: hypothetical protein +FIG00517129 FIG00517131: hypothetical protein +FIG00517131 FIG00517132: hypothetical protein +FIG00517132 FIG00517133: hypothetical protein +FIG00517138 FIG00517139: hypothetical protein +FIG00517139 FIG00517140: hypothetical protein +FIG00517142 probable polysaccharide deacetylase +FIG00517143 FIG00517146: hypothetical protein +FIG00517148 FIG00517149: hypothetical protein +FIG00517157 FIG00517158: hypothetical protein +FIG00517158 FIG00517160: hypothetical protein +FIG00517161 FIG00517162: hypothetical protein +FIG00517162 FIG00517164: hypothetical protein +FIG00517169 FIG00517171: hypothetical protein +FIG00517171 FIG00517172: hypothetical protein +FIG00517172 FIG00517173: hypothetical protein +FIG00517176 FIG00517177: hypothetical protein +FIG00517177 FIG00517178: hypothetical protein +FIG00517178 FIG00517180: hypothetical protein +FIG00517181 FIG00517182: hypothetical protein +FIG00517185 FIG00517186: hypothetical protein +FIG00517186 FIG00517187: hypothetical protein +FIG00517187 FIG00517191: hypothetical protein +FIG00517191 FIG00517193: hypothetical protein +FIG00517202 FIG00517206: hypothetical protein +FIG00517206 FIG00517208: hypothetical protein +FIG00517208 FIG00517209: hypothetical protein +FIG00517212 FIG00517214: hypothetical protein +FIG00517224 FIG00517225: hypothetical protein +FIG00517231 FIG00517234: hypothetical protein +FIG00517234 FIG00517237: hypothetical protein +FIG00517237 FIG00517238: hypothetical protein +FIG00517239 FIG00517240: hypothetical protein +FIG00517240 FIG00517241: hypothetical protein +FIG00517241 FIG00517244: hypothetical protein +FIG00517244 FIG00517247: hypothetical protein +FIG00517247 FIG00517249: hypothetical protein +FIG00517249 FIG00517250: hypothetical protein +FIG00517252 FIG00517253: hypothetical protein +FIG00517253 FIG00517254: hypothetical protein +FIG00517254 FIG00517258: hypothetical protein +FIG00517258 FIG00517262: hypothetical protein +FIG00517263 FIG00517265: hypothetical protein +FIG00517265 FIG00517267: hypothetical protein +FIG00517267 FIG00517268: hypothetical protein +FIG00517268 FIG00517269: hypothetical protein +FIG00517271 FIG00517272: hypothetical protein +FIG00517272 FIG00517273: hypothetical protein +FIG00517273 FIG00517274: hypothetical protein +FIG00517274 FIG00517277: hypothetical protein +FIG00517277 FIG00517278: hypothetical protein +FIG00517283 FIG00517284: hypothetical protein +FIG00517284 FIG00523003: hypothetical protein +FIG00517287 FIG00517289: hypothetical protein +FIG00517289 FIG00517290: hypothetical protein +FIG00517290 FIG00517296: hypothetical protein +FIG00517296 FIG00517298: hypothetical protein +FIG00517298 FIG00517300: hypothetical protein +FIG00517300 FIG00517302: hypothetical protein +FIG00517302 FIG00517303: hypothetical protein +FIG00517303 FIG00517304: hypothetical protein +FIG00517304 FIG00517306: hypothetical protein +FIG00517306 FIG00517310: hypothetical protein +FIG00517317 FIG00517318: hypothetical protein +FIG00517318 FIG01118304: hypothetical protein +FIG00517319 FIG00517320: hypothetical protein +FIG00517320 FIG00517321: hypothetical protein +FIG00517321 FIG00517324: hypothetical protein +FIG00517325 FIG00517328: hypothetical protein +FIG00517328 FIG00517331: hypothetical protein +FIG00517334 FIG00517339: hypothetical protein +FIG00517339 FIG00517341: hypothetical protein +FIG00517341 FIG00517342: hypothetical protein +FIG00517342 FIG00517343: hypothetical protein +FIG00517343 FIG00517353: hypothetical protein +FIG00517354 FIG00517355: hypothetical protein +FIG00517355 FIG00517358: hypothetical protein +FIG00517358 FIG00517359: hypothetical protein +FIG00517359 FIG00517360: hypothetical protein +FIG00517360 Mannan endo-1,4-beta-mannosidase., Cellulose 1,4-beta-cellobiosidase( EC:3.2.1.91,EC:3.2.1.78 ) +FIG00517367 FIG00517368: hypothetical protein +FIG00517368 FIG00517369: hypothetical protein +FIG00517369 FIG00517372: hypothetical protein +FIG00517372 putative flavodoxin +FIG00517376 BFD domain protein (2Fe-2S)-binding domain protein +FIG00517388 Homolog of cell division GTPase FtsZ, diverged +FIG00517390 FIG00517391: hypothetical protein +FIG00517393 glycosyltransferase 36 +FIG00517394 FIG00517398: hypothetical protein +FIG00517402 FIG00517403: hypothetical protein +FIG00517403 FIG00517404: hypothetical protein +FIG00517404 FIG00517406: hypothetical protein +FIG00517406 FIG00517408: hypothetical protein +FIG00517408 FIG00517409: hypothetical protein +FIG00517409 FIG00517411: hypothetical protein +FIG00517411 FIG00517412: hypothetical protein +FIG00517412 FIG00517413: hypothetical protein +FIG00517413 FIG00517416: hypothetical protein +FIG00517416 FIG00517417: hypothetical protein +FIG00517420 FIG00517421: hypothetical protein +FIG00517428 FIG00517429: hypothetical protein +FIG00517429 FIG00517430: hypothetical protein +FIG00517430 FIG00517435: hypothetical protein +FIG00517435 FIG00517437: hypothetical protein +FIG00517437 FIG00517443: hypothetical protein +FIG00517443 FIG00517445: hypothetical protein +FIG00517447 FIG00517448: hypothetical protein +FIG00517450 Two-component sensor kinase yesM( EC:2.7.3.- ) +FIG00517451 FIG00517454: hypothetical protein +FIG00517455 FIG00517456: hypothetical protein +FIG00517460 FIG00517463: hypothetical protein +FIG00517463 FIG00517464: hypothetical protein +FIG00517464 FIG00517465: hypothetical protein +FIG00517467 FIG00517469: hypothetical protein +FIG00517469 FIG00517471: hypothetical protein +FIG00517471 FIG00517472: hypothetical protein +FIG00517473 membrane spanning protein +FIG00517474 FIG00517476: hypothetical protein +FIG00517476 FIG00517477: hypothetical protein +FIG00517482 FIG00517483: hypothetical protein +FIG00517483 Lipopolysaccharide biosynthesis protein +FIG00517486 FIG00517487: hypothetical protein +FIG00517487 FIG00517489: hypothetical protein +FIG00517489 FIG00517493: hypothetical protein +FIG00517493 FIG00517494: hypothetical protein +FIG00517494 PAS +FIG00517495 FIG00517497: hypothetical protein +FIG00517497 FIG00517498: hypothetical protein +FIG00517499 FIG00517504: hypothetical protein +FIG00517506 FIG00517508: hypothetical protein +FIG00517508 RIKEN cDNA 6330442E10 gene +FIG00517511 FIG00517513: hypothetical protein +FIG00517518 FIG00517519: hypothetical protein +FIG00517519 FIG00517520: hypothetical protein +FIG00517521 multisensor signal transduction histidine kinase +FIG00517525 FIG00517529: hypothetical protein +FIG00517529 FIG00517530: hypothetical protein +FIG00517531 FIG00517532: hypothetical protein +FIG00517532 FIG00517533: hypothetical protein +FIG00517535 Protein of unknown function DUF1667 +FIG00517537 FIG00517538: hypothetical protein +FIG00517542 FIG00517544: hypothetical protein +FIG00517544 FIG00517546: hypothetical protein +FIG00517547 FIG00517549: hypothetical protein +FIG00517551 FIG00517552: hypothetical protein +FIG00517552 chlorohydrolase/deaminase family protein +FIG00517555 FIG00517557: hypothetical protein +FIG00517557 FIG00517558: hypothetical protein +FIG00517558 FIG00517561: hypothetical protein +FIG00517561 FIG00517564: hypothetical protein +FIG00517564 FIG00517565: hypothetical protein +FIG00517565 FIG00517568: hypothetical protein +FIG00517568 FIG00517573: hypothetical protein +FIG00517573 FIG00517575: hypothetical protein +FIG00517576 sensory box protein +FIG00517579 FIG00517580: hypothetical protein +FIG00517581 FIG00517584: hypothetical protein +FIG00517584 FIG00517586: hypothetical protein +FIG00517586 FIG00517589: hypothetical protein +FIG00517589 FIG00517590: hypothetical protein +FIG00517591 FIG00517595: hypothetical protein +FIG00517598 probable HD superfamily hydrolase +FIG00517607 FIG00517608: hypothetical protein +FIG00517608 FIG00517611: hypothetical protein +FIG00517614 FIG00517616: hypothetical protein +FIG00517616 FIG00517617: hypothetical protein +FIG00517617 FIG00517624: hypothetical protein +FIG00517627 FIG00517629: hypothetical protein +FIG00517629 FIG00517631: hypothetical protein +FIG00517631 FIG00517632: hypothetical protein +FIG00517632 FIG00517634: hypothetical protein +FIG00517634 FIG00517636: hypothetical protein +FIG00517637 FIG00517640: hypothetical protein +FIG00517640 CD4+ T cell-stimulating antigen, lipoprotein +FIG00517642 FIG00517647: hypothetical protein +FIG00517649 FIG00517650: hypothetical protein +FIG00517658 FIG00517660: hypothetical protein +FIG00517662 FIG00517663: hypothetical protein +FIG00517663 FIG00517664: hypothetical protein +FIG00517664 FIG00517666: hypothetical protein +FIG00517666 FIG00517667: hypothetical protein +FIG00517667 FIG00517669: hypothetical protein +FIG00517671 FIG00517673: hypothetical protein +FIG00517675 prepilin peptidase-dependent +FIG00517679 FIG00517681: hypothetical protein +FIG00517681 FIG00517682: hypothetical protein +FIG00517682 FIG00517683: hypothetical protein +FIG00517683 FIG00517685: hypothetical protein +FIG00517696 FIG00517697: hypothetical protein +FIG00517698 FIG00517699: hypothetical protein +FIG00517699 FIG00517704: hypothetical protein +FIG00517704 FIG00517707: hypothetical protein +FIG00517707 FIG00517708: hypothetical protein +FIG00517708 FIG00517716: hypothetical protein +FIG00517719 FIG00517720: hypothetical protein +FIG00517720 FIG00517722: hypothetical protein +FIG00517722 FIG00517725: hypothetical protein +FIG00517725 FIG00517726: hypothetical protein +FIG00517726 FIG00517727: hypothetical protein +FIG00517731 FIG00517735: hypothetical protein +FIG00517738 FIG00517741: hypothetical protein +FIG00517741 FIG00517744: hypothetical protein +FIG00517758 FIG00517759: hypothetical protein +FIG00517759 FIG00517760: hypothetical protein +FIG00517760 FIG00517762: hypothetical protein +FIG00517762 FIG00517764: hypothetical protein +FIG00517764 FIG00517765: hypothetical protein +FIG00517765 FIG00517766: hypothetical protein +FIG00517766 FIG00517767: hypothetical protein +FIG00517771 FIG00517773: hypothetical protein +FIG00517773 FIG00517775: hypothetical protein +FIG00517775 FIG00517776: hypothetical protein +FIG00517776 pirin-related protein +FIG00517777 pilin +FIG00517779 NADH:flavin oxidoreductase/NADH oxidase:FAD-dependent pyridine nucleotide-disulphide oxidoreductase +FIG00517788 FIG00517789: hypothetical protein +FIG00517789 FIG00517790: hypothetical protein +FIG00517791 uncharacterized conserved protein +FIG00517800 FIG00517802: hypothetical protein +FIG00517802 FIG00517803: hypothetical protein +FIG00517803 FIG00517804: hypothetical protein +FIG00517804 putative two-component histidine kinase +FIG00517805 FIG00517810: hypothetical protein +FIG00517811 FIG00517813: hypothetical protein +FIG00517816 Response regulator (CheY-like receiver domain and HTH DNA binding domain) +FIG00517818 FIG00517819: hypothetical protein +FIG00517819 FIG00517821: hypothetical protein +FIG00517822 FIG00517827: hypothetical protein +FIG00517827 FIG00517830: hypothetical protein +FIG00517830 FIG00517831: hypothetical protein +FIG00517831 FIG00517832: hypothetical protein +FIG00517832 FIG00517835: hypothetical protein +FIG00517835 ABC transporter, ATP-binding protein/permease protein +FIG00517836 FIG00517837: hypothetical protein +FIG00517837 uncharacterized conserved protein, YbhB family +FIG00517840 FIG00517842: hypothetical protein +FIG00517846 FIG00517849: hypothetical protein +FIG00517853 FIG00517855: hypothetical protein +FIG00517855 FIG00517856: hypothetical protein +FIG00517856 FIG00517857: hypothetical protein +FIG00517859 putative membrane transporter +FIG00517861 FIG00517867: hypothetical protein +FIG00517867 FIG00517869: hypothetical protein +FIG00517869 cellulosome anchoring protein, cohesin region +FIG00517870 FIG00517871: hypothetical protein +FIG00517871 FIG00517873: hypothetical protein +FIG00517874 FIG00517878: hypothetical protein +FIG00517889 putative bacitracin ABC transporter, permease protein +FIG00517901 FIG00517905: hypothetical protein +FIG00517908 FIG00517910: hypothetical protein +FIG00517910 FIG00517911: hypothetical protein +FIG00517911 FIG00517912: hypothetical protein +FIG00517912 FIG00517914: hypothetical protein +FIG00517914 FIG00517915: hypothetical protein +FIG00517915 FIG00517917: hypothetical protein +FIG00517920 FIG00517921: hypothetical protein +FIG00517923 acetyltransferase domain protein +FIG00517924 FIG00517927: hypothetical protein +FIG00517933 FIG00517935: hypothetical protein +FIG00517935 FIG00517937: hypothetical protein +FIG00517939 FIG00517945: hypothetical protein +FIG00517945 FIG00517947: hypothetical protein +FIG00517947 FIG00517950: hypothetical protein +FIG00517956 FIG00517957: hypothetical protein +FIG00517958 FIG00517961: hypothetical protein +FIG00517961 FIG00517967: hypothetical protein +FIG00517967 FIG00517968: hypothetical protein +FIG00517968 FIG00517970: hypothetical protein +FIG00517973 FIG00517979: hypothetical protein +FIG00517979 FIG00517983: hypothetical protein +FIG00517983 FIG00517985: hypothetical protein +FIG00517985 FIG00517988: hypothetical protein +FIG00517988 FIG00517992: hypothetical protein +FIG00517992 FIG00517993: hypothetical protein +FIG00517993 FIG00517996: hypothetical protein +FIG00517998 FIG00517999: hypothetical protein +FIG00518000 FIG00518001: hypothetical protein +FIG00518002 FIG00518010: hypothetical protein +FIG00518010 FIG00518012: hypothetical protein +FIG00518012 FIG00518013: hypothetical protein +FIG00518016 FIG00518018: hypothetical protein +FIG00518018 accessory gene regulator +FIG00518021 FIG00518025: hypothetical protein +FIG00518025 AraC-type DNA-binding domain-containing protein, transcriptional regulator +FIG00518027 FIG00518029: hypothetical protein +FIG00518029 FIG00518031: hypothetical protein +FIG00518036 FIG00518038: hypothetical protein +FIG00518041 FIG00518044: hypothetical protein +FIG00518044 Ribosomal protein S12 +FIG00518045 chloride ion channel protein +FIG00518048 FIG00518049: hypothetical protein +FIG00518055 FIG00518057: hypothetical protein +FIG00518057 FIG00518058: hypothetical protein +FIG00518058 FIG00518059: hypothetical protein +FIG00518061 metal-dependent phosphohydrolase, HD subdomain +FIG00518062 FIG00518063: hypothetical protein +FIG00518063 FIG00518065: hypothetical protein +FIG00518066 FIG00518068: hypothetical protein +FIG00518068 FIG00518069: hypothetical protein +FIG00518069 dehydrogenase (flavoproteins) +FIG00518070 FIG00518071: hypothetical protein +FIG00518078 FIG00518079: hypothetical protein +FIG00518079 FIG00518080: hypothetical protein +FIG00518080 FIG00518082: hypothetical protein +FIG00518082 FIG00518086: hypothetical protein +FIG00518086 FIG00518088: hypothetical protein +FIG00518088 FIG00518092: hypothetical protein +FIG00518092 FIG00518093: hypothetical protein +FIG00518094 FIG00518095: hypothetical protein +FIG00518095 FIG00518096: hypothetical protein +FIG00518096 FIG00518097: hypothetical protein +FIG00518097 FIG00518098: hypothetical protein +FIG00518098 FIG00518099: hypothetical protein +FIG00518099 FIG00518100: hypothetical protein +FIG00518103 FIG00518104: hypothetical protein +FIG00518104 FIG00518106: hypothetical protein +FIG00518109 FIG00518114: hypothetical protein +FIG00518114 FIG00518115: hypothetical protein +FIG00518115 FIG00518116: hypothetical protein +FIG00518117 FIG00518118: hypothetical protein +FIG00518127 hypothetical protein +FIG00518131 FIG00518134: hypothetical protein +FIG00518134 FIG00518140: hypothetical protein +FIG00518140 FIG00518142: hypothetical protein +FIG00518142 FIG00518149: hypothetical protein +FIG00518155 conserved hypothetical protein; possible zinc metalloprotease +FIG00518160 FIG00518164: hypothetical protein +FIG00518164 FIG00518165: hypothetical protein +FIG00518165 FIG00518167: hypothetical protein +FIG00518167 FIG00518168: hypothetical protein +FIG00518173 FIG00518175: hypothetical protein +FIG00518175 FIG00518181: hypothetical protein +FIG00518183 FIG00518186: hypothetical protein +FIG00518192 FIG00518194: hypothetical protein +FIG00518195 FIG00518198: hypothetical protein +FIG00518198 FIG00518200: hypothetical protein +FIG00518200 FIG00518204: hypothetical protein +FIG00518204 FIG00518206: hypothetical protein +FIG00518208 FIG00518210: hypothetical protein +FIG00518216 FIG00518217: hypothetical protein +FIG00518219 FIG00518220: hypothetical protein +FIG00518220 FIG00518225: hypothetical protein +FIG00518225 FIG00518226: hypothetical protein +FIG00518227 FIG00518228: hypothetical protein +FIG00518228 FIG00518230: hypothetical protein +FIG00518232 FIG00518233: hypothetical protein +FIG00518233 FIG00518235: hypothetical protein +FIG00518235 FIG00518236: hypothetical protein +FIG00518236 FIG00518237: hypothetical protein +FIG00518237 FIG00518242: hypothetical protein +FIG00518242 FIG00518243: hypothetical protein +FIG00518245 FIG00518246: hypothetical protein +FIG00518246 FIG00518247: hypothetical protein +FIG00518247 FIG00518248: hypothetical protein +FIG00518248 FIG00518250: hypothetical protein +FIG00518252 FIG00518260: hypothetical protein +FIG00518260 FIG00518261: hypothetical protein +FIG00518261 FIG00518263: hypothetical protein +FIG00518263 FIG00518265: hypothetical protein +FIG00518268 FIG00518272: hypothetical protein +FIG00518272 FIG00518273: hypothetical protein +FIG00518273 FIG00518277: hypothetical protein +FIG00518277 FIG00518279: hypothetical protein +FIG00518279 FIG00518280: hypothetical protein +FIG00518280 FIG00518281: hypothetical protein +FIG00518281 FIG00518282: hypothetical protein +FIG00518282 Dimethylamine corrinoid protein 2 +FIG00518286 FIG00518287: hypothetical protein +FIG00518288 FIG00518289: hypothetical protein +FIG00518298 FIG00518301: hypothetical protein +FIG00518302 FIG00518305: hypothetical protein +FIG00518306 FIG00518311: hypothetical protein +FIG00518311 FIG00518313: hypothetical protein +FIG00518314 FIG00518318: hypothetical protein +FIG00518318 FIG00518319: hypothetical protein +FIG00518319 cassette chromosome recombinase B +FIG00518327 FIG00518329: hypothetical protein +FIG00518331 FIG00518333: hypothetical protein +FIG00518334 FIG00518335: hypothetical protein +FIG00518335 FIG00518336: hypothetical protein +FIG00518338 FIG00518340: hypothetical protein +FIG00518344 FIG00518353: hypothetical protein +FIG00518353 FIG00518357: hypothetical protein +FIG00518357 FIG00518358: hypothetical protein +FIG00518358 FIG00518363: hypothetical protein +FIG00518363 FIG00518366: hypothetical protein +FIG00518371 Ca2+/Na+ antiporter +FIG00518372 FIG00518374: hypothetical protein +FIG00518375 FIG00518376: hypothetical protein +FIG00518378 FIG00518379: hypothetical protein +FIG00518380 FIG00518381: hypothetical protein +FIG00518381 FIG00518382: hypothetical protein +FIG00518382 Predicted phosphohydrolases, Icc family +FIG00518385 FIG00518388: hypothetical protein +FIG00518388 FIG00518389: hypothetical protein +FIG00518390 prepilin-type cleavage/methylation +FIG00518391 Stage IV sporulation pro-sigma-K processing enzyme (SpoIVFB) +FIG00518394 FIG00518395: hypothetical protein +FIG00518395 FIG00518396: hypothetical protein +FIG00518396 FIG00518399: hypothetical protein +FIG00518399 FIG00518400: hypothetical protein +FIG00518400 FIG00518402: hypothetical protein +FIG00518403 FIG00518404: hypothetical protein +FIG00518406 FIG00518408: hypothetical protein +FIG00518408 FIG00518410: hypothetical protein +FIG00518410 putative pilus biogenesis protein +FIG00518412 FIG00518417: hypothetical protein +FIG00518417 FIG00518421: hypothetical protein +FIG00518421 FIG00518423: hypothetical protein +FIG00518432 FIG00518433: hypothetical protein +FIG00518433 FIG00518435: hypothetical protein +FIG00518435 NIF3-related protein +FIG00518437 FIG00518438: hypothetical protein +FIG00518444 FIG00518447: hypothetical protein +FIG00518453 FIG00518455: hypothetical protein +FIG00518458 FIG00518459: hypothetical protein +FIG00518460 putative phage-related protein +FIG00518470 FIG00518473: hypothetical protein +FIG00518476 FIG00518477: hypothetical protein +FIG00518477 FIG00518485: hypothetical protein +FIG00518485 HTH transcriptional regulator MerR family +FIG00518490 putative spore-cortex-lytic protein +FIG00518493 FIG00518497: hypothetical protein +FIG00518499 FIG00518500: hypothetical protein +FIG00518500 accessory gene regulator protein C +FIG00518503 FIG00518505: hypothetical protein +FIG00518517 FIG00518518: hypothetical protein +FIG00518518 FIG00518519: hypothetical protein +FIG00518519 FIG00518526: hypothetical protein +FIG00518526 FIG00518528: hypothetical protein +FIG00518530 FIG00518533: hypothetical protein +FIG00518533 FIG00518534: hypothetical protein +FIG00518534 FIG00518535: hypothetical protein +FIG00518536 FIG00518543: hypothetical protein +FIG00518543 FIG00518544: hypothetical protein +FIG00518544 FIG00518547: hypothetical protein +FIG00518547 phage portal protein +FIG00518548 FIG00518549: hypothetical protein +FIG00518549 FIG00518553: hypothetical protein +FIG00518554 FIG00518560: hypothetical protein +FIG00518560 FIG00518562: hypothetical protein +FIG00518562 FIG00518563: hypothetical protein +FIG00518563 FIG00518568: hypothetical protein +FIG00518568 FIG00518570: hypothetical protein +FIG00518570 FIG00518572: hypothetical protein +FIG00518572 FIG00518576: hypothetical protein +FIG00518579 FIG00518580: hypothetical protein +FIG00518586 FIG00518595: hypothetical protein +FIG00518595 FIG00518596: hypothetical protein +FIG00518602 FIG00518604: hypothetical protein +FIG00518605 FIG00518606: hypothetical protein +FIG00518606 FIG00518607: hypothetical protein +FIG00518607 FIG00518608: hypothetical protein +FIG00518611 phosphoglycerate mutase, putative +FIG00518624 hydrogenase, membrane subunit 2-like protein +FIG00518631 FIG00518637: hypothetical protein +FIG00518638 FIG00518641: hypothetical protein +FIG00518642 FIG00518645: hypothetical protein +FIG00518645 FIG00518646: hypothetical protein +FIG00518646 FIG00518648: hypothetical protein +FIG00518648 FIG00518649: hypothetical protein +FIG00518650 FIG00518652: hypothetical protein +FIG00518653 FIG00518654: hypothetical protein +FIG00518654 FIG00518657: hypothetical protein +FIG00518658 FIG00518662: hypothetical protein +FIG00518664 FIG00518668: hypothetical protein +FIG00518670 FIG00518672: hypothetical protein +FIG00518672 FIG01031815: hypothetical protein +FIG00518678 FIG00518681: hypothetical protein +FIG00518681 FIG00518688: hypothetical protein +FIG00518688 FIG00518690: hypothetical protein +FIG00518692 FIG00518697: hypothetical protein +FIG00518697 FIG00518702: hypothetical protein +FIG00518703 FIG00518705: hypothetical protein +FIG00518710 FIG00518711: hypothetical protein +FIG00518711 FIG00518715: hypothetical protein +FIG00518715 FIG00518716: hypothetical protein +FIG00518716 ABC sugar transporter, periplasmic binding protein +FIG00518722 FIG00518725: hypothetical protein +FIG00518725 FIG00518726: hypothetical protein +FIG00518726 FIG00518728: hypothetical protein +FIG00518728 FIG00518731: hypothetical protein +FIG00518731 FIG00518732: hypothetical protein +FIG00518732 FIG00518734: hypothetical protein +FIG00518734 FIG00518735: hypothetical protein +FIG00518739 FIG00518742: hypothetical protein +FIG00518746 FIG00518748: hypothetical protein +FIG00518748 FIG00518750: hypothetical protein +FIG00518750 iron ABC transporter, solute-binding lipoprotein +FIG00518752 FIG00518753: hypothetical protein +FIG00518755 FIG00518756: hypothetical protein +FIG00518761 FIG00518763: hypothetical protein +FIG00518763 FIG00518765: hypothetical protein +FIG00518765 FIG00518766: hypothetical protein +FIG00518766 FIG00518767: hypothetical protein +FIG00518767 FIG00518768: hypothetical protein +FIG00518771 FIG00518772: hypothetical protein +FIG00518772 FIG00518773: hypothetical protein +FIG00518774 Endo-1,4-beta-xylanase Z precursor (EC 3.2.1.8) +FIG00518776 FIG00518780: hypothetical protein +FIG00518780 FIG00518784: hypothetical protein +FIG00518784 FIG00518790: hypothetical protein +FIG00518790 FIG00518792: hypothetical protein +FIG00518794 FIG00518798: hypothetical protein +FIG00518801 FIG00518802: hypothetical protein +FIG00518802 FIG00518805: hypothetical protein +FIG00518805 FIG00518806: hypothetical protein +FIG00518808 Modification methylase Cfr9I (EC 2.1.1.113) +FIG00518809 FIG00518810: hypothetical protein +FIG00518811 FIG00518814: hypothetical protein +FIG00518814 FIG00518815: hypothetical protein +FIG00518822 FIG00518823: hypothetical protein +FIG00518826 FIG00518831: hypothetical protein +FIG00518834 FIG00518836: hypothetical protein +FIG00518836 FIG00518839: hypothetical protein +FIG00518839 FIG00518840: hypothetical protein +FIG00518841 FIG00518842: hypothetical protein +FIG00518845 FIG00518846: hypothetical protein +FIG00518846 FIG00518847: hypothetical protein +FIG00518847 FIG00518848: hypothetical protein +FIG00518848 FIG00518849: hypothetical protein +FIG00518849 FIG00518852: hypothetical protein +FIG00518853 FIG00518854: hypothetical protein +FIG00518855 FIG00518858: hypothetical protein +FIG00518858 FIG00518860: hypothetical protein +FIG00518862 predicted transglutaminase/protease +FIG00518864 FIG00518865: hypothetical protein +FIG00518865 FIG00518866: hypothetical protein +FIG00518866 FIG00518867: hypothetical protein +FIG00518867 FIG00518869: hypothetical protein +FIG00518869 FIG00518870: hypothetical protein +FIG00518871 FIG00518875: hypothetical protein +FIG00518875 GntR-family transcriptional regulator +FIG00518876 FIG00518877: hypothetical protein +FIG00518877 FIG00518878: hypothetical protein +FIG00518878 FIG00518879: hypothetical protein +FIG00518879 FIG00518880: hypothetical protein +FIG00518886 acyl-ACP thioesterase +FIG00518889 FIG00518890: hypothetical protein +FIG00518890 FIG00518891: hypothetical protein +FIG00518895 FIG00518900: hypothetical protein +FIG00518900 FIG00518901: hypothetical protein +FIG00518905 FIG00518910: hypothetical protein +FIG00518910 FIG00518911: hypothetical protein +FIG00518916 FIG00518917: hypothetical protein +FIG00518917 FIG00518918: hypothetical protein +FIG00518925 FIG00518930: hypothetical protein +FIG00518930 FIG00518935: hypothetical protein +FIG00518935 FIG00518938: hypothetical protein +FIG00518939 FIG00518940: hypothetical protein +FIG00518941 FIG00518943: hypothetical protein +FIG00518944 putative conjugative transposon regulatory protein +FIG00518945 FIG00518948: hypothetical protein +FIG00518948 FIG00518949: hypothetical protein +FIG00518949 FIG00518951: hypothetical protein +FIG00518952 FIG00518953: hypothetical protein +FIG00518953 FIG00518954: hypothetical protein +FIG00518954 conserved acetyltransferase +FIG00518955 FIG00518957: hypothetical protein +FIG00518961 FIG00518965: hypothetical protein +FIG00518965 FIG00518966: hypothetical protein +FIG00518968 FIG00518970: hypothetical protein +FIG00518970 FIG00518972: hypothetical protein +FIG00518977 FIG00518979: hypothetical protein +FIG00518980 FIG00518981: hypothetical protein +FIG00518981 FIG00518983: hypothetical protein +FIG00518983 FIG00752460: hypothetical protein +FIG00518999 FIG00519000: hypothetical protein +FIG00519000 FIG00519004: hypothetical protein +FIG00519004 FIG00519005: hypothetical protein +FIG00519009 Hexokinase (EC 2.7.1.1) +FIG00519017 FIG00519019: hypothetical protein +FIG00519027 FIG00519028: hypothetical protein +FIG00519028 FIG00519029: hypothetical protein +FIG00519029 FIG00519032: hypothetical protein +FIG00519032 FIG00519034: hypothetical protein +FIG00519037 FIG00519039: hypothetical protein +FIG00519040 FIG00519041: hypothetical protein +FIG00519041 FIG00519044: hypothetical protein +FIG00519045 FIG00519048: hypothetical protein +FIG00519048 FIG00519049: hypothetical protein +FIG00519049 FIG00519053: hypothetical protein +FIG00519053 FIG00519055: hypothetical protein +FIG00519059 FIG00519065: hypothetical protein +FIG00519066 FIG00519067: hypothetical protein +FIG00519067 FIG00519068: hypothetical protein +FIG00519070 FIG00519071: hypothetical protein +FIG00519071 hypothetical protein +FIG00519072 FIG00519074: hypothetical protein +FIG00519074 FIG00519076: hypothetical protein +FIG00519078 FIG00519079: hypothetical protein +FIG00519081 FIG00519090: hypothetical protein +FIG00519099 FIG00519100: hypothetical protein +FIG00519102 FIG00519104: hypothetical protein +FIG00519106 FIG00519107: hypothetical protein +FIG00519107 FIG00519111: hypothetical protein +FIG00519114 FIG00519115: hypothetical protein +FIG00519116 FIG00519121: hypothetical protein +FIG00519123 FIG00519126: hypothetical protein +FIG00519126 FIG00519128: hypothetical protein +FIG00519128 FIG00519129: hypothetical protein +FIG00519130 FIG00519132: hypothetical protein +FIG00519134 FIG00519135: hypothetical protein +FIG00519135 FIG00519137: hypothetical protein +FIG00519137 FIG00519138: hypothetical protein +FIG00519139 FIG00519145: hypothetical protein +FIG00519145 FIG00519150: hypothetical protein +FIG00519155 FIG00519164: hypothetical protein +FIG00519164 FIG00519166: hypothetical protein +FIG00519166 FIG00519168: hypothetical protein +FIG00519168 FIG00519170: hypothetical protein +FIG00519172 FIG00519173: hypothetical protein +FIG00519176 FIG00519178: hypothetical protein +FIG00519178 FIG00519180: hypothetical protein +FIG00519185 FIG00519186: hypothetical protein +FIG00519186 FIG00519187: hypothetical protein +FIG00519187 FIG00519190: hypothetical protein +FIG00519190 FIG00519192: hypothetical protein +FIG00519192 FIG00519193: hypothetical protein +FIG00519196 FIG00519197: hypothetical protein +FIG00519199 Rhodanese-related sulfurtransferases +FIG00519204 FIG00519208: hypothetical protein +FIG00519212 Probable site-specific serine recombinase-resolvase family protein +FIG00519213 FIG00519215: hypothetical protein +FIG00519215 FIG00519219: hypothetical protein +FIG00519219 FIG00519221: hypothetical protein +FIG00519221 FIG00519222: hypothetical protein +FIG00519222 FIG00519225: hypothetical protein +FIG00519228 FIG00519229: hypothetical protein +FIG00519229 FIG00519232: hypothetical protein +FIG00519232 FIG00519235: hypothetical protein +FIG00519235 EAL domain protein, putative +FIG00519236 FIG00519238: hypothetical protein +FIG00519240 FIG00519242: hypothetical protein +FIG00519247 putative ABC transporter, permease permease +FIG00519248 FIG00519250: hypothetical protein +FIG00519250 FIG00519253: hypothetical protein +FIG00519253 FIG00519254: hypothetical protein +FIG00519257 FIG00519258: hypothetical protein +FIG00519258 FIG00519259: hypothetical protein +FIG00519259 FIG00519261: hypothetical protein +FIG00519261 FIG00519264: hypothetical protein +FIG00519264 FIG00519266: hypothetical protein +FIG00519266 FIG00519267: hypothetical protein +FIG00519268 FIG00519269: hypothetical protein +FIG00519269 FIG00519271: hypothetical protein +FIG00519271 FIG00519273: hypothetical protein +FIG00519273 FIG00519274: hypothetical protein +FIG00519274 FIG00519277: hypothetical protein +FIG00519280 FIG00519281: hypothetical protein +FIG00519282 FIG00519289: hypothetical protein +FIG00519289 putative phage regulatory protein +FIG00519292 FIG00519294: hypothetical protein +FIG00519296 FIG00519301: hypothetical protein +FIG00519305 FIG00519309: hypothetical protein +FIG00519309 FIG00519310: hypothetical protein +FIG00519310 FIG00519316: hypothetical protein +FIG00519316 FIG00519318: hypothetical protein +FIG00519318 FIG00519320: hypothetical protein +FIG00519320 FIG00519323: hypothetical protein +FIG00519323 FIG00519326: hypothetical protein +FIG00519327 FIG00519329: hypothetical protein +FIG00519329 Export ABC transporter permease protein +FIG00519334 FIG00519335: hypothetical protein +FIG00519337 FIG00519338: hypothetical protein +FIG00519341 FIG00519343: hypothetical protein +FIG00519343 FIG00519347: hypothetical protein +FIG00519347 FIG00519348: hypothetical protein +FIG00519348 FIG00519351: hypothetical protein +FIG00519351 FIG00519353: hypothetical protein +FIG00519354 FIG00519357: hypothetical protein +FIG00519359 FIG00519361: hypothetical protein +FIG00519361 glycoside hydrolase, family 8 +FIG00519362 FIG00519363: hypothetical protein +FIG00519363 FIG00519364: hypothetical protein +FIG00519364 FIG00519369: hypothetical protein +FIG00519370 Cwp66-like protein/N-acetylmuramoyl-L-alanine amidase (EC 3.5.1.28) +FIG00519372 FIG00519373: hypothetical protein +FIG00519373 FIG00519376: hypothetical protein +FIG00519376 FIG00519379: hypothetical protein +FIG00519381 FIG00519382: hypothetical protein +FIG00519384 Membrane dipeptidase( EC:3.4.13.19 ) +FIG00519387 FIG00519388: hypothetical protein +FIG00519395 FIG00519399: hypothetical protein +FIG00519399 FIG00519401: hypothetical protein +FIG00519401 FIG00521837: hypothetical protein +FIG00519406 FIG00519408: hypothetical protein +FIG00519408 FIG00519412: hypothetical protein +FIG00519413 FIG00519417: hypothetical protein +FIG00519420 FIG00519422: hypothetical protein +FIG00519423 FIG00519424: hypothetical protein +FIG00519424 FIG00519425: hypothetical protein +FIG00519425 FIG00519427: hypothetical protein +FIG00519427 Cof family protein , putative +FIG00519429 FIG00519431: hypothetical protein +FIG00519431 FIG00519432: hypothetical protein +FIG00519432 FIG00519434: hypothetical protein +FIG00519434 FIG00519437: hypothetical protein +FIG00519437 FIG00519442: hypothetical protein +FIG00519442 FIG00519443: hypothetical protein +FIG00519443 FIG00519444: hypothetical protein +FIG00519444 FIG00519445: hypothetical protein +FIG00519447 FIG00519456: hypothetical protein +FIG00519456 FIG00519458: hypothetical protein +FIG00519460 FIG00519461: hypothetical protein +FIG00519461 Alcohol dehydrogenase IV +FIG00519462 FIG00519466: hypothetical protein +FIG00519472 FIG00519479: hypothetical protein +FIG00519479 FIG00519480: hypothetical protein +FIG00519480 putative exonuclease +FIG00519484 FIG00519485: hypothetical protein +FIG00519485 FIG00519489: hypothetical protein +FIG00519490 FIG00519491: hypothetical protein +FIG00519491 FIG00519493: hypothetical protein +FIG00519493 FIG00519494: hypothetical protein +FIG00519494 FIG00519495: hypothetical protein +FIG00519495 FIG00519500: hypothetical protein +FIG00519502 FIG00519503: hypothetical protein +FIG00519511 nucleotidyltransferase( EC:2.7.7.- ) +FIG00519514 FIG00519515: hypothetical protein +FIG00519515 FIG00519516: hypothetical protein +FIG00519516 FIG00519517: hypothetical protein +FIG00519517 Tn7-like transposition protein D +FIG00519526 FIG00519527: hypothetical protein +FIG00519527 FIG00519529: hypothetical protein +FIG00519530 FIG00519540: hypothetical protein +FIG00519540 FIG00519541: hypothetical protein +FIG00519541 FIG00519543: hypothetical protein +FIG00519544 FIG00519547: hypothetical protein +FIG00519547 FIG00519548: hypothetical protein +FIG00519548 FIG00519549: hypothetical protein +FIG00519549 FIG00519552: hypothetical protein +FIG00519553 FIG00519554: hypothetical protein +FIG00519554 FIG00519555: hypothetical protein +FIG00519559 alkaline phosphatase synthesis transcriptional regulatory protein phoP +FIG00519563 FIG00519565: hypothetical protein +FIG00519565 FIG00519566: hypothetical protein +FIG00519566 Probable DNA polymerase III epsilon chain +FIG00519568 FIG00519572: hypothetical protein +FIG00519573 FIG00519574: hypothetical protein +FIG00519574 FIG00519580: hypothetical protein +FIG00519580 FIG00519583: hypothetical protein +FIG00519589 FIG00519591: hypothetical protein +FIG00519591 FIG00519594: hypothetical protein +FIG00519595 FIG00519604: hypothetical protein +FIG00519607 FIG00519608: hypothetical protein +FIG00519620 FIG00519622: hypothetical protein +FIG00519622 FIG00519624: hypothetical protein +FIG00519624 FIG00519625: hypothetical protein +FIG00519625 FIG00519629: hypothetical protein +FIG00519629 FIG00519631: hypothetical protein +FIG00519631 FIG00519636: hypothetical protein +FIG00519640 esterase (putative) +FIG00519644 FIG00519648: hypothetical protein +FIG00519648 FIG00519650: hypothetical protein +FIG00519654 FIG00519658: hypothetical protein +FIG00519658 involved in polyketide synthesis +FIG00519659 FIG00519662: hypothetical protein +FIG00519666 FIG00519667: hypothetical protein +FIG00519667 FIG00519668: hypothetical protein +FIG00519668 FIG00519676: hypothetical protein +FIG00519678 FIG00519681: hypothetical protein +FIG00519688 FIG00519690: hypothetical protein +FIG00519696 FIG00519698: hypothetical protein +FIG00519699 FIG00519700: hypothetical protein +FIG00519700 FIG00519701: hypothetical protein +FIG00519701 FIG00519703: hypothetical protein +FIG00519703 FIG00519705: hypothetical protein +FIG00519707 Spore germination protein +FIG00519708 FIG00519709: hypothetical protein +FIG00519709 FIG00519710: hypothetical protein +FIG00519710 FIG00519712: hypothetical protein +FIG00519712 FIG00519714: hypothetical protein +FIG00519714 FIG00519716: hypothetical protein +FIG00519716 FIG00519717: hypothetical protein +FIG00519719 FIG00519721: hypothetical protein +FIG00519724 FIG00519726: hypothetical protein +FIG00519728 FIG00519729: hypothetical protein +FIG00519729 FIG00519731: hypothetical protein +FIG00519731 Spore germination protein, gerKC +FIG00519733 FIG00519734: hypothetical protein +FIG00519738 FIG168740: DRTGG domain-containing protein +FIG00519743 FIG00519744: hypothetical protein +FIG00519744 FIG00519746: hypothetical protein +FIG00519746 FIG00519748: hypothetical protein +FIG00519748 FIG00519749: hypothetical protein +FIG00519749 Membrane-associated histidine kinase with HAMP domain +FIG00519753 FIG00519754: hypothetical protein +FIG00519754 Ferritin and Dps +FIG00519757 FIG00519761: hypothetical protein +FIG00519770 FIG00519772: hypothetical protein +FIG00519772 FIG00519773: hypothetical protein +FIG00519775 FIG00519778: hypothetical protein +FIG00519784 FIG00519785: hypothetical protein +FIG00519794 FIG00519795: hypothetical protein +FIG00519795 FIG00519797: hypothetical protein +FIG00519797 FIG00519798: hypothetical protein +FIG00519798 FIG00519802: hypothetical protein +FIG00519802 FIG00519809: hypothetical protein +FIG00519809 FIG00519810: hypothetical protein +FIG00519810 FIG00519812: hypothetical protein +FIG00519818 FIG00519822: hypothetical protein +FIG00519824 FIG00519825: hypothetical protein +FIG00519829 FIG00519830: hypothetical protein +FIG00519830 FIG00519831: hypothetical protein +FIG00519831 FIG00519833: hypothetical protein +FIG00519833 FIG00519834: hypothetical protein +FIG00519834 FIG00519836: hypothetical protein +FIG00519840 FIG00519841: hypothetical protein +FIG00519851 FIG00519852: hypothetical protein +FIG00519852 FIG00519853: hypothetical protein +FIG00519853 FIG00519855: hypothetical protein +FIG00519855 FIG00519857: hypothetical protein +FIG00519857 FIG00519858: hypothetical protein +FIG00519861 FIG00519863: hypothetical protein +FIG00519868 FIG00533713: hypothetical protein +FIG00519870 FIG00519871: hypothetical protein +FIG00519875 FIG00519880: hypothetical protein +FIG00519880 FIG00519882: hypothetical protein +FIG00519882 FIG00519883: hypothetical protein +FIG00519883 FIG00519884: hypothetical protein +FIG00519884 Transcriptional regulators, RpiR family +FIG00519886 FIG00519887: hypothetical protein +FIG00519894 FIG00519895: hypothetical protein +FIG00519895 FIG00519897: hypothetical protein +FIG00519897 FIG00519899: hypothetical protein +FIG00519900 FIG00519901: hypothetical protein +FIG00519901 FIG00519904: hypothetical protein +FIG00519904 FIG00519905: hypothetical protein +FIG00519906 FIG00519908: hypothetical protein +FIG00519908 FIG00519911: hypothetical protein +FIG00519911 FIG00519912: hypothetical protein +FIG00519915 FIG00519921: hypothetical protein +FIG00519921 FIG00519922: hypothetical protein +FIG00519922 FIG00519924: hypothetical protein +FIG00519926 FIG00519927: hypothetical protein +FIG00519927 FIG00519931: hypothetical protein +FIG00519931 FIG00519932: hypothetical protein +FIG00519932 FIG00519935: hypothetical protein +FIG00519935 FIG00519939: hypothetical protein +FIG00519940 FIG00519947: hypothetical protein +FIG00519949 FIG00519954: hypothetical protein +FIG00519956 FIG00519960: hypothetical protein +FIG00519960 FIG00519961: hypothetical protein +FIG00519961 FIG00519962: hypothetical protein +FIG00519963 FIG00519964: hypothetical protein +FIG00519964 Amino acid ABC transporter, ATP-binding protein +FIG00519966 Endoglucanase F precursor +FIG00519968 FIG00519969: hypothetical protein +FIG00519971 FIG00519972: hypothetical protein +FIG00519972 FIG221949: hypothetical protein +FIG00519975 FIG00519978: hypothetical protein +FIG00519981 FIG00519985: hypothetical protein +FIG00519985 FIG00519986: hypothetical protein +FIG00519986 FIG00519988: hypothetical protein +FIG00519988 FIG00519989: hypothetical protein +FIG00519990 FIG00519993: hypothetical protein +FIG00519993 FIG00519999: hypothetical protein +FIG00520006 FIG00520009: hypothetical protein +FIG00520010 FIG00520011: hypothetical protein +FIG00520015 FIG00520016: hypothetical protein +FIG00520018 FIG00520021: hypothetical protein +FIG00520021 FIG00520024: hypothetical protein +FIG00520024 FIG00520025: hypothetical protein +FIG00520025 FIG00520029: hypothetical protein +FIG00520035 FIG00520038: hypothetical protein +FIG00520040 FIG00520041: hypothetical protein +FIG00520041 FIG00520045: hypothetical protein +FIG00520045 FIG00520048: hypothetical protein +FIG00520048 FIG00520049: hypothetical protein +FIG00520050 FIG00520051: hypothetical protein +FIG00520057 FIG00520060: hypothetical protein +FIG00520060 FIG00520061: hypothetical protein +FIG00520061 FIG00520064: hypothetical protein +FIG00520064 FIG00520066: hypothetical protein +FIG00520066 FIG00520067: hypothetical protein +FIG00520073 FIG00524231: hypothetical protein +FIG00520081 FIG00520082: hypothetical protein +FIG00520082 FIG00520084: hypothetical protein +FIG00520084 FIG00520086: hypothetical protein +FIG00520086 FIG00520088: hypothetical protein +FIG00520088 FIG00520090: hypothetical protein +FIG00520090 Permease of the Na:galactoside symporter family +FIG00520092 FIG00520093: hypothetical protein +FIG00520093 FIG00520094: hypothetical protein +FIG00520097 FIG00520098: hypothetical protein +FIG00520099 FIG00520102: hypothetical protein +FIG00520102 FIG00520108: hypothetical protein +FIG00520108 FIG00520110: hypothetical protein +FIG00520110 FIG00520111: hypothetical protein +FIG00520111 helix-turn-helix domain-containing protein +FIG00520112 FIG00520114: hypothetical protein +FIG00520114 FIG00520116: hypothetical protein +FIG00520125 FIG00520126: hypothetical protein +FIG00520126 FIG00520127: hypothetical protein +FIG00520127 FIG00520130: hypothetical protein +FIG00520130 conserved hypothetical protein (partial) +FIG00520135 FIG00520136: hypothetical protein +FIG00520136 FIG00520137: hypothetical protein +FIG00520137 FIG00520139: hypothetical protein +FIG00520139 FIG00520140: hypothetical protein +FIG00520142 FIG00520146: hypothetical protein +FIG00520146 FIG00520147: hypothetical protein +FIG00520148 FIG00520149: hypothetical protein +FIG00520149 FIG00520151: hypothetical protein +FIG00520156 FIG00520159: hypothetical protein +FIG00520159 FIG00520161: hypothetical protein +FIG00520161 Probable integrase/recombinase +FIG00520162 FIG00520164: hypothetical protein +FIG00520164 TcpA +FIG00520170 FIG00520172: hypothetical protein +FIG00520172 FIG00520173: hypothetical protein +FIG00520178 FIG00520180: hypothetical protein +FIG00520183 phosphoglycerate mutase family protein( EC:5.4.2.1 ) +FIG00520187 FIG00520188: hypothetical protein +FIG00520203 FIG00520208: hypothetical protein +FIG00520211 FIG00520218: hypothetical protein +FIG00520218 FIG00520219: hypothetical protein +FIG00520224 FIG00522296: hypothetical protein +FIG00520226 FIG00520228: hypothetical protein +FIG00520232 FIG00520233: hypothetical protein +FIG00520241 FIG01031724: hypothetical protein +FIG00520243 FIG00520244: hypothetical protein +FIG00520248 FIG00520252: hypothetical protein +FIG00520257 FIG00520258: hypothetical protein +FIG00520258 FIG00520260: hypothetical protein +FIG00520261 FIG00520264: hypothetical protein +FIG00520266 FIG00520269: hypothetical protein +FIG00520272 FIG00520274: hypothetical protein +FIG00520274 Nucleotide-binding protein +FIG00520276 FIG00520277: hypothetical protein +FIG00520277 FIG00520279: hypothetical protein +FIG00520279 UbiA prenyltransferase family membrane protein +FIG00520280 FIG00520283: hypothetical protein +FIG00520283 FIG00520284: hypothetical protein +FIG00520284 FIG00520286: hypothetical protein +FIG00520291 FIG00520297: hypothetical protein +FIG00520301 FIG00520302: hypothetical protein +FIG00520302 Peptidoglycan-binding domain-containing protein +FIG00520303 FIG00520304: hypothetical protein +FIG00520304 Xylitol dehydrogenase (EC 1.1.1.9) +FIG00520308 Phage protein, HK97 gp10 family +FIG00520311 FIG00520313: hypothetical protein +FIG00520313 hypothetical protein +FIG00520314 FIG00520320: hypothetical protein +FIG00520320 FIG00520327: hypothetical protein +FIG00520327 FIG00520329: hypothetical protein +FIG00520330 FIG00520331: hypothetical protein +FIG00520331 FIG00520334: hypothetical protein +FIG00520336 FIG00520337: hypothetical protein +FIG00520337 FIG00520338: hypothetical protein +FIG00520344 FIG00520345: hypothetical protein +FIG00520345 FIG00520346: hypothetical protein +FIG00520348 FIG00520352: hypothetical protein +FIG00520352 FIG00520353: hypothetical protein +FIG00520354 FIG00520355: hypothetical protein +FIG00520355 FIG00520358: hypothetical protein +FIG00520358 FIG00520359: hypothetical protein +FIG00520359 FIG00520360: hypothetical protein +FIG00520364 encapsulation protein capA +FIG00520366 FIG00520369: hypothetical protein +FIG00520372 FIG00520373: hypothetical protein +FIG00520373 FIG00520374: hypothetical protein +FIG00520374 D-glucuronyl C5 epimerase (EC 5.1.3.-) (Heparin/heparan sulfate:glucuronic acid C5 epimerase) +FIG00520376 FIG00520378: hypothetical protein +FIG00520379 FIG00520380: hypothetical protein +FIG00520382 FIG00520384: hypothetical protein +FIG00520387 FIG00520389: hypothetical protein +FIG00520393 FIG00520397: hypothetical protein +FIG00520397 FIG00520399: hypothetical protein +FIG00520400 FIG00520401: hypothetical protein +FIG00520401 FIG00520403: hypothetical protein +FIG00520403 FIG00520404: hypothetical protein +FIG00520408 FIG00520412: hypothetical protein +FIG00520412 FIG00520414: hypothetical protein +FIG00520414 FIG00520415: hypothetical protein +FIG00520418 FIG00520423: hypothetical protein +FIG00520426 FIG00520427: hypothetical protein +FIG00520427 FIG00520430: hypothetical protein +FIG00520430 putative oxidoreductase, ferredoxin subunit +FIG00520432 FIG00520433: hypothetical protein +FIG00520434 FIG00520435: hypothetical protein +FIG00520435 FIG00520441: hypothetical protein +FIG00520441 FIG00520442: hypothetical protein +FIG00520442 FIG00520445: hypothetical protein +FIG00520445 FIG00520447: hypothetical protein +FIG00520452 FIG00520456: hypothetical protein +FIG00520461 FIG00520462: hypothetical protein +FIG00520465 FIG00520470: hypothetical protein +FIG00520470 FIG00520473: hypothetical protein +FIG00520475 FIG00520478: hypothetical protein +FIG00520478 FIG00520485: hypothetical protein +FIG00520485 FIG00520486: hypothetical protein +FIG00520490 FIG00520492: hypothetical protein +FIG00520492 FIG00520494: hypothetical protein +FIG00520501 FIG00520514: hypothetical protein +FIG00520516 FIG00520517: hypothetical protein +FIG00520517 putative transcriptional regulator sinR +FIG00520525 Uncharacterized conserved protein, YTFE family, possibly metal-binding +FIG00520527 FIG00520529: hypothetical protein +FIG00520531 FIG00520532: hypothetical protein +FIG00520532 FIG00520535: hypothetical protein +FIG00520537 putative cation transport-related, membrane protein +FIG00520538 FIG00520540: hypothetical protein +FIG00520540 FIG00520542: hypothetical protein +FIG00520543 FIG00520545: hypothetical protein +FIG00520545 FIG00520547: hypothetical protein +FIG00520547 viral A-type inclusion protein +FIG00520548 FIG00520550: hypothetical protein +FIG00520550 FIG00520552: hypothetical protein +FIG00520552 FIG00520554: hypothetical protein +FIG00520556 FIG00520558: hypothetical protein +FIG00520559 FIG00520560: hypothetical protein +FIG00520560 FIG00520561: hypothetical protein +FIG00520561 FIG00520566: hypothetical protein +FIG00520566 prenyltransferase, UbiA family +FIG00520567 FIG00520569: hypothetical protein +FIG00520569 FIG00520571: hypothetical protein +FIG00520571 FIG00520574: hypothetical protein +FIG00520574 FIG00520578: hypothetical protein +FIG00520578 FIG00520583: hypothetical protein +FIG00520583 protein serine/threonine phosphatases +FIG00520584 FIG00520589: hypothetical protein +FIG00520590 FIG00520592: hypothetical protein +FIG00520596 FIG00520597: hypothetical protein +FIG00520598 FIG00520599: hypothetical protein +FIG00520599 FIG00520602: hypothetical protein +FIG00520602 FIG00520604: hypothetical protein +FIG00520606 FIG00520608: hypothetical protein +FIG00520608 FIG00520609: hypothetical protein +FIG00520613 Ser-type protease +FIG00520621 FIG00520622: hypothetical protein +FIG00520622 FIG00520624: hypothetical protein +FIG00520626 FIG00520627: hypothetical protein +FIG00520627 FIG00520628: hypothetical protein +FIG00520630 FIG00520637: hypothetical protein +FIG00520637 FIG00520645: hypothetical protein +FIG00520645 FIG00520648: hypothetical protein +FIG00520649 FIG00520651: hypothetical protein +FIG00520655 FIG00520658: hypothetical protein +FIG00520658 FIG00520659: hypothetical protein +FIG00520659 hypothetical protein +FIG00520661 FIG00520662: hypothetical protein +FIG00520663 FIG00520664: hypothetical protein +FIG00520664 FIG00520665: hypothetical protein +FIG00520665 FIG00520666: hypothetical protein +FIG00520666 FIG00520670: hypothetical protein +FIG00520670 FIG00520672: hypothetical protein +FIG00520672 FIG00520674: hypothetical protein +FIG00520674 Intracellular serine protease (EC 3.4.21.-) +FIG00520678 FIG00520680: hypothetical protein +FIG00520680 FIG00520681: hypothetical protein +FIG00520681 FIG00520686: hypothetical protein +FIG00520690 FIG00520695: hypothetical protein +FIG00520695 FIG00520696: hypothetical protein +FIG00520696 FIG00520701: hypothetical protein +FIG00520701 FIG00520702: hypothetical protein +FIG00520704 FIG00520706: hypothetical protein +FIG00520707 FIG00520710: hypothetical protein +FIG00520721 FIG00520723: hypothetical protein +FIG00520723 FIG00520728: hypothetical protein +FIG00520731 FIG00520733: hypothetical protein +FIG00520733 FIG00520740: hypothetical protein +FIG00520741 FIG00520742: hypothetical protein +FIG00520742 FIG00520743: hypothetical protein +FIG00520744 FIG00520746: hypothetical protein +FIG00520746 hypothetical protein +FIG00520750 FIG00520752: hypothetical protein +FIG00520753 FIG00520757: hypothetical protein +FIG00520758 sodium-dependent amino acid transporter (proline, tryptophan) +FIG00520759 FIG00520764: hypothetical protein +FIG00520764 FIG00520766: hypothetical protein +FIG00520773 FIG00520775: hypothetical protein +FIG00520786 FIG00520788: hypothetical protein +FIG00520788 FIG00520789: hypothetical protein +FIG00520794 FIG00520796: hypothetical protein +FIG00520797 FIG00520798: hypothetical protein +FIG00520798 FIG00520800: hypothetical protein +FIG00520800 Predicted glycosyltransferase +FIG00520803 FIG00520804: hypothetical protein +FIG00520804 FIG00520805: hypothetical protein +FIG00520805 FIG00645020: hypothetical protein +FIG00520806 FIG00520809: hypothetical protein +FIG00520809 FIG00617288: hypothetical protein +FIG00520813 FIG00520815: hypothetical protein +FIG00520818 FIG00520821: hypothetical protein +FIG00520821 FIG00520824: hypothetical protein +FIG00520824 FIG00520825: hypothetical protein +FIG00520825 FIG00520828: hypothetical protein +FIG00520828 FIG00520835: hypothetical protein +FIG00520846 FIG00520847: hypothetical protein +FIG00520850 FIG00520851: hypothetical protein +FIG00520851 FIG00520853: hypothetical protein +FIG00520855 FIG00520859: hypothetical protein +FIG00520859 FIG00520861: hypothetical protein +FIG00520861 FIG00520862: hypothetical protein +FIG00520862 FIG00520867: hypothetical protein +FIG00520868 FIG00520871: hypothetical protein +FIG00520871 FIG00520872: hypothetical protein +FIG00520872 FIG00520878: hypothetical protein +FIG00520878 FIG00520879: hypothetical protein +FIG00520879 FIG00520881: hypothetical protein +FIG00520881 FIG00520883: hypothetical protein +FIG00520883 putative surface/cell-adhesion protein, multiple big2 domain +FIG00520887 FIG00520888: hypothetical protein +FIG00520891 FIG00520892: hypothetical protein +FIG00520892 FIG00520894: hypothetical protein +FIG00520894 Response regulator (CheY + HTH domains) +FIG00520906 FIG00520907: hypothetical protein +FIG00520918 FIG00520920: hypothetical protein +FIG00520920 FIG00520923: hypothetical protein +FIG00520931 FIG00520932: hypothetical protein +FIG00520932 FIG00520936: hypothetical protein +FIG00520936 FIG028593: membrane protein +FIG00520942 FIG00520943: hypothetical protein +FIG00520947 FIG00520948: hypothetical protein +FIG00520952 FIG00520954: hypothetical protein +FIG00520958 probable cell wall-binding protein +FIG00520962 FIG00520964: hypothetical protein +FIG00520964 FIG00520967: hypothetical protein +FIG00520967 FIG00520969: hypothetical protein +FIG00520970 FIG00520971: hypothetical protein +FIG00520971 FIG00520972: hypothetical protein +FIG00520977 FIG00520978: hypothetical protein +FIG00520978 FIG00520980: hypothetical protein +FIG00520980 FIG00520982: hypothetical protein +FIG00520993 FIG00520997: hypothetical protein +FIG00521000 FIG00521001: hypothetical protein +FIG00521001 FIG00521002: hypothetical protein +FIG00521005 FIG00521009: hypothetical protein +FIG00521009 FIG00521015: hypothetical protein +FIG00521015 FIG00521017: hypothetical protein +FIG00521017 FIG00521018: hypothetical protein +FIG00521018 Cell wall-associated hydrolases +FIG00521021 FIG00521024: hypothetical protein +FIG00521024 FIG00521039: hypothetical protein +FIG00521039 FIG00521043: hypothetical protein +FIG00521048 FIG00521049: hypothetical protein +FIG00521049 FIG00521056: hypothetical protein +FIG00521056 FIG00521057: hypothetical protein +FIG00521057 FIG00521058: hypothetical protein +FIG00521058 transcriptional regulator, ArsR family/dinitrogenase iron-molybdenum cofactor family protein +FIG00521060 FIG00521061: hypothetical protein +FIG00521061 FIG00521064: hypothetical protein +FIG00521064 FIG00521065: hypothetical protein +FIG00521065 predicted membrane protein, containing FHA domain +FIG00521066 FIG00521069: hypothetical protein +FIG00521069 FIG00521070: hypothetical protein +FIG00521070 FIG00521072: hypothetical protein +FIG00521073 FIG00521074: hypothetical protein +FIG00521074 FIG00521076: hypothetical protein +FIG00521076 FIG00521077: hypothetical protein +FIG00521077 FIG00521079: hypothetical protein +FIG00521080 FIG00521083: hypothetical protein +FIG00521083 FIG00521086: hypothetical protein +FIG00521093 FIG00521094: hypothetical protein +FIG00521094 FIG00521095: hypothetical protein +FIG00521097 FIG00521103: hypothetical protein +FIG00521106 FIG00521107: hypothetical protein +FIG00521108 FIG00521110: hypothetical protein +FIG00521110 FIG00521113: hypothetical protein +FIG00521115 FIG00521118: hypothetical protein +FIG00521122 FIG00521123: hypothetical protein +FIG00521125 FIG00521129: hypothetical protein +FIG00521129 FIG00521132: hypothetical protein +FIG00521134 Alkaline phosphatase synthesis transcriptional regulatory protein phoP +FIG00521138 FIG00521146: hypothetical protein +FIG00521146 Bacteriocin-like protein +FIG00521155 FIG00521161: hypothetical protein +FIG00521161 FIG00521162: hypothetical protein +FIG00521164 FIG00521166: hypothetical protein +FIG00521169 FIG01253051: hypothetical protein +FIG00521170 FIG00521171: hypothetical protein +FIG00521171 FIG00521172: hypothetical protein +FIG00521172 FIG00521176: hypothetical protein +FIG00521176 fructose response regulator of fruA and EII fructose/mannose +FIG00521179 FIG00521180: hypothetical protein +FIG00521180 FIG00521181: hypothetical protein +FIG00521181 FIG00521189: hypothetical protein +FIG00521189 Major head protein +FIG00521192 FIG00521194: hypothetical protein +FIG00521194 FIG00521197: hypothetical protein +FIG00521197 FIG00521209: hypothetical protein +FIG00521209 FIG00521210: hypothetical protein +FIG00521213 FIG00521217: hypothetical protein +FIG00521217 FIG00521219: hypothetical protein +FIG00521220 O-antigen export system permease protein RfbD +FIG00521233 FIG00521236: hypothetical protein +FIG00521238 FIG00521244: hypothetical protein +FIG00521244 FIG00521245: hypothetical protein +FIG00521250 FIG00521252: hypothetical protein +FIG00521252 FIG00521258: hypothetical protein +FIG00521261 FIG00521263: hypothetical protein +FIG00521263 FIG002003: Protein YdjA +FIG00521267 FIG00521269: hypothetical protein +FIG00521270 Conserved protein, tetratricopeptide repeat family protein +FIG00521280 FIG00521281: hypothetical protein +FIG00521281 FIG00521285: hypothetical protein +FIG00521285 FIG00521287: hypothetical protein +FIG00521289 FIG00521294: hypothetical protein +FIG00521301 FIG00521302: hypothetical protein +FIG00521302 FIG00521304: hypothetical protein +FIG00521309 FIG00521310: hypothetical protein +FIG00521310 FIG00521313: hypothetical protein +FIG00521315 FIG00521317: hypothetical protein +FIG00521317 FIG00521319: hypothetical protein +FIG00521319 FIG00521321: hypothetical protein +FIG00521321 FIG00521324: hypothetical protein +FIG00521324 FIG00521326: hypothetical protein +FIG00521328 FIG00521329: hypothetical protein +FIG00521329 predicted ABC-type polar amino acid transport system, ATP-binding protein +FIG00521331 FIG00521332: hypothetical protein +FIG00521336 FIG00521338: hypothetical protein +FIG00521340 FIG00521341: hypothetical protein +FIG00521341 FIG00521363: hypothetical protein +FIG00521363 FIG00521366: hypothetical protein +FIG00521366 probable proline dipeptidase +FIG00521371 FIG00521372: hypothetical protein +FIG00521372 FIG00521373: hypothetical protein +FIG00521376 FIG00521378: hypothetical protein +FIG00521378 FIG00521383: hypothetical protein +FIG00521387 FIG00521392: hypothetical protein +FIG00521396 FIG00521398: hypothetical protein +FIG00521405 FIG00521409: hypothetical protein +FIG00521409 FIG00521412: hypothetical protein +FIG00521412 FIG00521418: hypothetical protein +FIG00521418 FIG00521421: hypothetical protein +FIG00521421 HAD-superfamily hydrolase subfamily IIIA:HAD-superfamily phosphatase subfamily IIIA +FIG00521422 FIG00521423: hypothetical protein +FIG00521425 FIG00521429: hypothetical protein +FIG00521429 FIG00521432: hypothetical protein +FIG00521439 FIG00521441: hypothetical protein +FIG00521441 FIG00521442: hypothetical protein +FIG00521442 FIG00521446: hypothetical protein +FIG00521446 FIG00521448: hypothetical protein +FIG00521451 FIG00521454: hypothetical protein +FIG00521454 FIG00521457: hypothetical protein +FIG00521457 FIG00521458: hypothetical protein +FIG00521458 OxaI/YidC membrane insertion protein +FIG00521464 FIG00521471: hypothetical protein +FIG00521477 ABC transporter, periplasmic binding protein +FIG00521481 FIG00521483: hypothetical protein +FIG00521484 FIG00521485: hypothetical protein +FIG00521485 FIG00521486: hypothetical protein +FIG00521486 regulatory protein moxR +FIG00521491 Site-specific recombinase +FIG00521498 FIG00521499: hypothetical protein +FIG00521499 FIG00521505: hypothetical protein +FIG00521505 FIG00521512: hypothetical protein +FIG00521512 FIG00521513: hypothetical protein +FIG00521513 FIG00521525: hypothetical protein +FIG00521525 FIG00521529: hypothetical protein +FIG00521530 FIG00521533: hypothetical protein +FIG00521533 FIG00521535: hypothetical protein +FIG00521539 FIG00521541: hypothetical protein +FIG00521542 kelch-like 5 (Drosophila) +FIG00521546 FIG00521550: hypothetical protein +FIG00521550 FIG00521551: hypothetical protein +FIG00521554 FIG00521556: hypothetical protein +FIG00521556 FIG00521559: hypothetical protein +FIG00521559 NADH dehydrogenase (ubiquinone), 30 kDa subunit +FIG00521561 transcriptional regulator, putative pyruvate dehydrogenase complex repressor +FIG00521564 FIG00521565: hypothetical protein +FIG00521570 FIG00521574: hypothetical protein +FIG00521574 GAF modulated sigma54 specific transcriptional regulator, Fis family +FIG00521588 FIG00521590: hypothetical protein +FIG00521590 FIG00521592: hypothetical protein +FIG00521594 FIG00521596: hypothetical protein +FIG00521596 FIG00521600: hypothetical protein +FIG00521601 FIG00521602: hypothetical protein +FIG00521609 FIG00521611: hypothetical protein +FIG00521611 FIG00521612: hypothetical protein +FIG00521612 FIG00521615: hypothetical protein +FIG00521615 FIG00521616: hypothetical protein +FIG00521616 FIG00521619: hypothetical protein +FIG00521620 FIG00521623: hypothetical protein +FIG00521634 FIG00521637: hypothetical protein +FIG00521637 ABC transporter, ATPase component +FIG00521638 xylan esterase 1 +FIG00521641 FIG00521643: hypothetical protein +FIG00521643 FIG00521647: hypothetical protein +FIG00521648 FIG00521649: hypothetical protein +FIG00521649 FIG00521650: hypothetical protein +FIG00521650 FIG00521651: hypothetical protein +FIG00521652 FIG00521658: hypothetical protein +FIG00521658 FIG00521665: hypothetical protein +FIG00521665 FIG00521667: hypothetical protein +FIG00521667 FIG00521672: hypothetical protein +FIG00521676 FIG00521680: hypothetical protein +FIG00521687 FIG00521690: hypothetical protein +FIG00521690 FIG00521695: hypothetical protein +FIG00521695 FIG00521696: hypothetical protein +FIG00521696 FIG00521703: hypothetical protein +FIG00521703 FIG00521708: hypothetical protein +FIG00521709 FIG00521710: hypothetical protein +FIG00521710 FIG00521711: hypothetical protein +FIG00521711 general stress protein, putative +FIG00521715 FIG00521718: hypothetical protein +FIG00521718 FIG00521719: hypothetical protein +FIG00521725 FIG00521726: hypothetical protein +FIG00521726 FIG00521730: hypothetical protein +FIG00521733 Cupin 2, conserved barrel domain protein +FIG00521734 FIG00521740: hypothetical protein +FIG00521749 FIG00521751: hypothetical protein +FIG00521751 FIG00521757: hypothetical protein +FIG00521757 FIG00521758: hypothetical protein +FIG00521759 FIG00521764: hypothetical protein +FIG00521770 FIG00521771: hypothetical protein +FIG00521778 FIG00521781: hypothetical protein +FIG00521790 FIG00521791: hypothetical protein +FIG00521795 FIG00521797: hypothetical protein +FIG00521799 HD-GYP hydrolase domain containing protein +FIG00521806 FIG00521807: hypothetical protein +FIG00521807 FIG00521812: hypothetical protein +FIG00521812 FIG00521814: hypothetical protein +FIG00521814 FIG00521815: hypothetical protein +FIG00521828 FIG00521829: hypothetical protein +FIG00521831 FIG00521832: hypothetical protein +FIG00521832 FIG00521835: hypothetical protein +FIG00521837 FIG00521838: hypothetical protein +FIG00521838 FIG00521840: hypothetical protein +FIG00521840 FIG00521842: hypothetical protein +FIG00521844 FIG00521846: hypothetical protein +FIG00521857 FIG00521858: hypothetical protein +FIG00521858 FIG00521859: hypothetical protein +FIG00521868 FIG00521869: hypothetical protein +FIG00521873 hypothetical protein +FIG00521874 FIG00521878: hypothetical protein +FIG00521883 FIG00521884: hypothetical protein +FIG00521884 FIG00521888: hypothetical protein +FIG00521890 FIG00521893: hypothetical protein +FIG00521893 uncharacterized conserved protein, YgiN family +FIG00521896 FIG00521897: hypothetical protein +FIG00521897 FIG00521899: hypothetical protein +FIG00521899 FIG00521902: hypothetical protein +FIG00521902 FIG00521903: hypothetical protein +FIG00521903 FIG00521912: hypothetical protein +FIG00521917 FIG00521918: hypothetical protein +FIG00521921 FIG00521923: hypothetical protein +FIG00521926 FIG00521928: hypothetical protein +FIG00521930 FIG00521935: hypothetical protein +FIG00521935 FIG00521936: hypothetical protein +FIG00521940 FIG00617218: hypothetical protein +FIG00521946 FIG00521948: hypothetical protein +FIG00521948 FIG00521950: hypothetical protein +FIG00521950 transcriptional regulator, MarR family, putative +FIG00521960 phage major tail protein, phi13 family +FIG00521961 FIG00521962: hypothetical protein +FIG00521966 FIG00521967: hypothetical protein +FIG00521968 FIG00521970: hypothetical protein +FIG00521978 FIG00521979: hypothetical protein +FIG00521980 FIG00521982: hypothetical protein +FIG00521989 FIG00521990: hypothetical protein +FIG00521991 FIG00521993: hypothetical protein +FIG00521993 FIG00521996: hypothetical protein +FIG00521999 FIG00522001: hypothetical protein +FIG00522001 FIG00522003: hypothetical protein +FIG00522007 FIG00522010: hypothetical protein +FIG00522022 Putative DNase/RNase endonuclease +FIG00522024 FIG00522025: hypothetical protein +FIG00522025 FIG00522028: hypothetical protein +FIG00522029 FIG00522030: hypothetical protein +FIG00522030 FIG00522035: hypothetical protein +FIG00522035 FIG00522037: hypothetical protein +FIG00522037 FIG00522038: hypothetical protein +FIG00522038 FIG00525509: hypothetical protein +FIG00522039 FIG00522040: hypothetical protein +FIG00522044 FIG00522046: hypothetical protein +FIG00522046 FIG00522047: hypothetical protein +FIG00522048 Mobilization protein +FIG00522050 FIG00522054: hypothetical protein +FIG00522054 FIG00522057: hypothetical protein +FIG00522057 FIG00522059: hypothetical protein +FIG00522070 FIG00522075: hypothetical protein +FIG00522077 FIG00522078: hypothetical protein +FIG00522085 FIG00522086: hypothetical protein +FIG00522087 FIG00522095: hypothetical protein +FIG00522095 FIG00522097: hypothetical protein +FIG00522097 FIG00522098: hypothetical protein +FIG00522099 FIG00522101: hypothetical protein +FIG00522104 FIG00522106: hypothetical protein +FIG00522114 FIG00522115: hypothetical protein +FIG00522115 FIG00522119: hypothetical protein +FIG00522127 FIG00522128: hypothetical protein +FIG00522130 FIG00522133: hypothetical protein +FIG00522133 FIG00522134: hypothetical protein +FIG00522134 FIG00522137: hypothetical protein +FIG00522137 FIG00522138: hypothetical protein +FIG00522138 FIG00522139: hypothetical protein +FIG00522139 FIG00522143: hypothetical protein +FIG00522143 FIG00522147: hypothetical protein +FIG00522147 FIG00522152: hypothetical protein +FIG00522152 FIG00522153: hypothetical protein +FIG00522166 glycosyltransferase 28-like protein +FIG00522168 FIG00522169: hypothetical protein +FIG00522169 FIG00522170: hypothetical protein +FIG00522173 FIG00522176: hypothetical protein +FIG00522176 FIG00522177: hypothetical protein +FIG00522177 FIG00522178: hypothetical protein +FIG00522178 FIG00522180: hypothetical protein +FIG00522189 FIG00522190: hypothetical protein +FIG00522193 FIG00522195: hypothetical protein +FIG00522202 FIG00522203: hypothetical protein +FIG00522203 FIG00522205: hypothetical protein +FIG00522205 Endo-1,3(4)-beta-glucanase +FIG00522208 FIG00522209: hypothetical protein +FIG00522209 FIG00523680: hypothetical protein +FIG00522211 FIG00522213: hypothetical protein +FIG00522213 FIG00522214: hypothetical protein +FIG00522216 FIG00522223: hypothetical protein +FIG00522223 sporulation inhibitor KapD +FIG00522225 FIG00522228: hypothetical protein +FIG00522228 FIG00522229: hypothetical protein +FIG00522229 FIG00522232: hypothetical protein +FIG00522232 FIG00522235: hypothetical protein +FIG00522235 FIG00522236: hypothetical protein +FIG00522236 Phosphohydrolase +FIG00522237 FIG00522239: hypothetical protein +FIG00522242 FIG00522246: hypothetical protein +FIG00522246 FIG00522249: hypothetical protein +FIG00522249 FIG00522250: hypothetical protein +FIG00522250 FIG00522252: hypothetical protein +FIG00522252 FIG00522254: hypothetical protein +FIG00522254 FIG00522261: hypothetical protein +FIG00522261 FIG00522263: hypothetical protein +FIG00522263 FIG00522264: hypothetical protein +FIG00522264 FIG00522265: hypothetical protein +FIG00522265 FIG01032097: hypothetical protein +FIG00522271 FIG00522272: hypothetical protein +FIG00522272 antirepressor +FIG00522278 FIG00522280: hypothetical protein +FIG00522284 FIG00522289: hypothetical protein +FIG00522289 FIG00522290: hypothetical protein +FIG00522296 FIG00522297: hypothetical protein +FIG00522297 FIG00522300: hypothetical protein +FIG00522302 FIG00522304: hypothetical protein +FIG00522304 FIG00522308: hypothetical protein +FIG00522308 FIG00522311: hypothetical protein +FIG00522312 FIG00522314: hypothetical protein +FIG00522314 Putative toxin component near putative ESAT-related proteins, repetitive +FIG00522315 FIG00522316: hypothetical protein +FIG00522316 FIG00522326: hypothetical protein +FIG00522326 FIG00522331: hypothetical protein +FIG00522333 FIG00522334: hypothetical protein +FIG00522339 FIG00522346: hypothetical protein +FIG00522347 FIG00522353: hypothetical protein +FIG00522353 FIG00522358: hypothetical protein +FIG00522358 FIG00522361: hypothetical protein +FIG00522361 FIG00522362: hypothetical protein +FIG00522362 FIG00522364: hypothetical protein +FIG00522364 FIG00522367: hypothetical protein +FIG00522378 FIG00522380: hypothetical protein +FIG00522380 FIG00522383: hypothetical protein +FIG00522386 FIG00522387: hypothetical protein +FIG00522391 FIG00522395: hypothetical protein +FIG00522395 FIG00522397: hypothetical protein +FIG00522400 FIG00522402: hypothetical protein +FIG00522406 FIG00522407: hypothetical protein +FIG00522407 FIG00522409: hypothetical protein +FIG00522409 FIG00522411: hypothetical protein +FIG00522425 FIG00522428: hypothetical protein +FIG00522432 FIG00522437: hypothetical protein +FIG00522438 FIG00522439: hypothetical protein +FIG00522439 FIG00522440: hypothetical protein +FIG00522440 FIG00522447: hypothetical protein +FIG00522447 FIG00522450: hypothetical protein +FIG00522450 FIG00522453: hypothetical protein +FIG00522453 FIG00522456: hypothetical protein +FIG00522456 FIG00522459: hypothetical protein +FIG00522463 FIG00522466: hypothetical protein +FIG00522466 FIG00522467: hypothetical protein +FIG00522473 FIG00522475: hypothetical protein +FIG00522476 glycosyl transferase-like protein +FIG00522480 FIG00522482: hypothetical protein +FIG00522482 FIG00522483: hypothetical protein +FIG00522484 FIG00522491: hypothetical protein +FIG00522492 FIG00522496: hypothetical protein +FIG00522497 FIG00522498: hypothetical protein +FIG00522502 FIG00522503: hypothetical protein +FIG00522503 FIG00522506: hypothetical protein +FIG00522506 FIG00522507: hypothetical protein +FIG00522514 FIG00522519: hypothetical protein +FIG00522520 FIG00522521: hypothetical protein +FIG00522526 FIG00522527: hypothetical protein +FIG00522527 Lipase/Acylhydrolase with GDSL-like motif +FIG00522528 FIG00522529: hypothetical protein +FIG00522535 FIG00522548: hypothetical protein +FIG00522548 FIG00522550: hypothetical protein +FIG00522550 FIG00522551: hypothetical protein +FIG00522551 FIG00522555: hypothetical protein +FIG00522555 FIG00522556: hypothetical protein +FIG00522556 FIG00522558: hypothetical protein +FIG00522577 FIG00522578: hypothetical protein +FIG00522578 FIG00522579: hypothetical protein +FIG00522579 FIG00522582: hypothetical protein +FIG00522582 FIG00522585: hypothetical protein +FIG00522585 FIG00522590: hypothetical protein +FIG00522614 FIG00522619: hypothetical protein +FIG00522619 FIG00522620: hypothetical protein +FIG00522620 Sortase family protein +FIG00522621 FIG00522622: hypothetical protein +FIG00522622 Antirepressor [Bacteriophage A118] +FIG00522623 FIG00522624: hypothetical protein +FIG00522624 FIG00522631: hypothetical protein +FIG00522631 FIG00522634: hypothetical protein +FIG00522635 iron aquisition yersiniabactin synthesis enzyme (Irp2) +FIG00522637 FIG00522638: hypothetical protein +FIG00522641 FIG00522642: hypothetical protein +FIG00522642 FIG00522644: hypothetical protein +FIG00522644 FIG00522647: hypothetical protein +FIG00522649 FIG00522650: hypothetical protein +FIG00522650 FIG00522652: hypothetical protein +FIG00522652 FIG00522658: hypothetical protein +FIG00522662 FIG00522664: hypothetical protein +FIG00522666 FIG00522668: hypothetical protein +FIG00522671 FIG00522676: hypothetical protein +FIG00522676 FIG00522677: hypothetical protein +FIG00522677 FIG00522678: hypothetical protein +FIG00522678 FIG00522683: hypothetical protein +FIG00522683 chemotaxis response regulator, putative +FIG00522693 FIG00522695: hypothetical protein +FIG00522697 FIG00522699: hypothetical protein +FIG00522703 FIG00522704: hypothetical protein +FIG00522704 FIG00522705: hypothetical protein +FIG00522705 FIG00522706: hypothetical protein +FIG00522708 Phosphohydrolase from calcineurin family +FIG00522720 FIG00522721: hypothetical protein +FIG00522722 FIG00522725: hypothetical protein +FIG00522725 FIG00522726: hypothetical protein +FIG00522726 FIG00522728: hypothetical protein +FIG00522728 FIG00522733: hypothetical protein +FIG00522739 FIG00522747: hypothetical protein +FIG00522747 FIG00522748: hypothetical protein +FIG00522748 FIG00522752: hypothetical protein +FIG00522752 FIG00522753: hypothetical protein +FIG00522753 FIG00522754: hypothetical protein +FIG00522754 FIG00522755: hypothetical protein +FIG00522755 FIG00522757: hypothetical protein +FIG00522761 putative arylesterase +FIG00522766 FIG00522774: hypothetical protein +FIG00522774 FIG00522775: hypothetical protein +FIG00522775 FIG00522777: hypothetical protein +FIG00522779 FIG00522781: hypothetical protein +FIG00522781 FIG00522782: hypothetical protein +FIG00522782 FIG00522783: hypothetical protein +FIG00522795 putative F pilin acetylation protein +FIG00522797 beta-propeller fold protein +FIG00522799 FIG00522802: hypothetical protein +FIG00522802 FIG00522810: hypothetical protein +FIG00522810 FIG00522814: hypothetical protein +FIG00522814 FIG00522818: hypothetical protein +FIG00522827 FIG00522828: hypothetical protein +FIG00522830 FIG00522832: hypothetical protein +FIG00522832 FIG00522834: hypothetical protein +FIG00522834 FIG00522836: hypothetical protein +FIG00522838 FIG00522841: hypothetical protein +FIG00522845 FIG00522846: hypothetical protein +FIG00522846 FIG00522853: hypothetical protein +FIG00522853 sugar transport system permease protein +FIG00522857 FIG00522863: hypothetical protein +FIG00522863 FIG00522866: hypothetical protein +FIG00522866 FIG00522868: hypothetical protein +FIG00522868 FIG00522869: hypothetical protein +FIG00522869 FIG00522870: hypothetical protein +FIG00522870 FIG00522871: hypothetical protein +FIG00522871 FIG00522874: hypothetical protein +FIG00522874 FIG00522877: hypothetical protein +FIG00522878 FIG00522881: hypothetical protein +FIG00522881 FIG00522882: hypothetical protein +FIG00522888 FIG00522889: hypothetical protein +FIG00522889 FIG00522891: hypothetical protein +FIG00522891 FIG00522896: hypothetical protein +FIG00522896 FIG00522897: hypothetical protein +FIG00522901 FIG00522904: hypothetical protein +FIG00522908 FIG00522909: hypothetical protein +FIG00522912 FIG00522914: hypothetical protein +FIG00522914 FIG00522915: hypothetical protein +FIG00522915 hypothetical protein +FIG00522920 FIG00522925: hypothetical protein +FIG00522925 FIG00522927: hypothetical protein +FIG00522927 FIG00522929: hypothetical protein +FIG00522931 CRISPR-associated protein Cas5 +FIG00522932 FIG00522935: hypothetical protein +FIG00522935 FIG00522936: hypothetical protein +FIG00522937 FIG00522938: hypothetical protein +FIG00522946 FIG00522947: hypothetical protein +FIG00522954 FIG00522956: hypothetical protein +FIG00522957 FIG00522961: hypothetical protein +FIG00522961 FIG00522962: hypothetical protein +FIG00522962 FIG00522964: hypothetical protein +FIG00522964 FIG00522966: hypothetical protein +FIG00522968 FIG00522974: hypothetical protein +FIG00522975 FIG00522977: hypothetical protein +FIG00522977 FIG00522980: hypothetical protein +FIG00522980 FIG00522982: hypothetical protein +FIG00522985 FIG00522987: hypothetical protein +FIG00522987 FIG00522995: hypothetical protein +FIG00522996 FIG00522998: hypothetical protein +FIG00522998 FIG00523001: hypothetical protein +FIG00523017 FIG00523027: hypothetical protein +FIG00523027 Cna protein B-type domain +FIG00523028 putative modification methylase (Cytosine-specific methyltransferase)( EC:2.1.1.37 ) +FIG00523030 FIG00523032: hypothetical protein +FIG00523032 FIG00523034: hypothetical protein +FIG00523044 FIG00523048: hypothetical protein +FIG00523053 FIG00523054: hypothetical protein +FIG00523054 FIG00523055: hypothetical protein +FIG00523055 FIG00523058: hypothetical protein +FIG00523058 FIG00523062: hypothetical protein +FIG00523066 FIG00523071: hypothetical protein +FIG00523071 FIG00523074: hypothetical protein +FIG00523076 FIG00523077: hypothetical protein +FIG00523078 FIG00523080: hypothetical protein +FIG00523080 FIG00523086: hypothetical protein +FIG00523088 FIG00523091: hypothetical protein +FIG00523091 FIG00523097: hypothetical protein +FIG00523100 FIG00523103: hypothetical protein +FIG00523103 FIG00523104: hypothetical protein +FIG00523104 FIG00523106: hypothetical protein +FIG00523106 FIG00523110: hypothetical protein +FIG00523110 FIG00523111: hypothetical protein +FIG00523113 FIG00523119: hypothetical protein +FIG00523123 FIG00523125: hypothetical protein +FIG00523125 FIG00523129: hypothetical protein +FIG00523137 FIG00523141: hypothetical protein +FIG00523141 FIG00523143: hypothetical protein +FIG00523143 FIG00523145: hypothetical protein +FIG00523148 FIG00523149: hypothetical protein +FIG00523151 FIG00523152: hypothetical protein +FIG00523156 FIG00523157: hypothetical protein +FIG00523157 FIG00523159: hypothetical protein +FIG00523159 FIG00523161: hypothetical protein +FIG00523161 FIG00523163: hypothetical protein +FIG00523167 FIG00523171: hypothetical protein +FIG00523173 FIG00523176: hypothetical protein +FIG00523179 FIG00523184: hypothetical protein +FIG00523184 FIG00523189: hypothetical protein +FIG00523189 FIG00523192: hypothetical protein +FIG00523192 FIG00523195: hypothetical protein +FIG00523195 FIG00523199: hypothetical protein +FIG00523203 FIG00523205: hypothetical protein +FIG00523206 FIG00523208: hypothetical protein +FIG00523208 FIG00523209: hypothetical protein +FIG00523216 FIG00523217: hypothetical protein +FIG00523217 FIG00523219: hypothetical protein +FIG00523219 FIG00523223: hypothetical protein +FIG00523243 FIG00523244: hypothetical protein +FIG00523245 FIG00523248: hypothetical protein +FIG00523248 FIG00523251: hypothetical protein +FIG00523251 iron-sulfur cluster-binding protein, rieske family +FIG00523252 FIG00523254: hypothetical protein +FIG00523259 FIG00523261: hypothetical protein +FIG00523262 PduA +FIG00523266 FIG00523272: hypothetical protein +FIG00523272 FIG00523273: hypothetical protein +FIG00523279 FIG00523281: hypothetical protein +FIG00523294 Beta-1,4-galactosyltransferase CpsIVG +FIG00523299 FIG00523309: hypothetical protein +FIG00523309 FIG00523310: hypothetical protein +FIG00523310 FIG00523311: hypothetical protein +FIG00523311 FIG00523312: hypothetical protein +FIG00523312 FIG00523315: hypothetical protein +FIG00523315 FIG00523320: hypothetical protein +FIG00523320 FIG00523322: hypothetical protein +FIG00523322 FIG00523325: hypothetical protein +FIG00523325 FIG00523327: hypothetical protein +FIG00523327 FIG00523329: hypothetical protein +FIG00523329 FIG00523330: hypothetical protein +FIG00523335 FIG00523338: hypothetical protein +FIG00523345 FIG00523346: hypothetical protein +FIG00523346 FIG00523350: hypothetical protein +FIG00523350 FIG00523353: hypothetical protein +FIG00523358 FIG00523362: hypothetical protein +FIG00523368 FIG00523375: hypothetical protein +FIG00523375 FIG00523376: hypothetical protein +FIG00523376 FIG00523377: hypothetical protein +FIG00523377 FIG00523378: hypothetical protein +FIG00523378 FIG00523380: hypothetical protein +FIG00523381 Possible DNA segregation Ftsk/SpoIIE like ATPase +FIG00523385 FIG00523386: hypothetical protein +FIG00523389 FIG00523390: hypothetical protein +FIG00523390 FIG00523398: hypothetical protein +FIG00523403 FIG00523404: hypothetical protein +FIG00523412 FIG00523414: hypothetical protein +FIG00523416 FIG00523417: hypothetical protein +FIG00523418 FIG00523419: hypothetical protein +FIG00523419 FIG00523426: hypothetical protein +FIG00523426 FIG00523428: hypothetical protein +FIG00523428 FIG00523429: hypothetical protein +FIG00523429 spore coat peptide assembly protein cotJB +FIG00523431 FIG00523435: hypothetical protein +FIG00523449 FIG00523453: hypothetical protein +FIG00523462 FIG00523463: hypothetical protein +FIG00523470 FIG00523471: hypothetical protein +FIG00523471 FIG00523476: hypothetical protein +FIG00523476 FIG00523477: hypothetical protein +FIG00523477 FIG00523479: hypothetical protein +FIG00523479 FIG00523482: hypothetical protein +FIG00523485 FIG00523486: hypothetical protein +FIG00523489 FIG00523490: hypothetical protein +FIG00523491 FIG00523492: hypothetical protein +FIG00523496 FIG00523499: hypothetical protein +FIG00523504 FIG00523506: hypothetical protein +FIG00523506 FIG00523507: hypothetical protein +FIG00523508 FIG00523510: hypothetical protein +FIG00523510 FIG00523511: hypothetical protein +FIG00523511 FIG00523513: hypothetical protein +FIG00523513 FIG00523515: hypothetical protein +FIG00523522 D-3-phosphoglycerate dehydrogenase (EC 1.1.1.95) (PGDH) +FIG00523523 FIG00523524: hypothetical protein +FIG00523524 FIG00523531: hypothetical protein +FIG00523531 FIG00523532: hypothetical protein +FIG00523532 FIG00523537: hypothetical protein +FIG00523537 FIG00523538: hypothetical protein +FIG00523541 FIG00523542: hypothetical protein +FIG00523542 FIG00523544: hypothetical protein +FIG00523545 FIG00523546: hypothetical protein +FIG00523546 2,4-dihydroxyhept-2-ene-1,7-dioic acid aldolase, putative +FIG00523551 FIG00523553: hypothetical protein +FIG00523566 FIG00523569: hypothetical protein +FIG00523571 FIG00523573: hypothetical protein +FIG00523575 FIG00523576: hypothetical protein +FIG00523578 FIG00523585: hypothetical protein +FIG00523585 FIG00523586: hypothetical protein +FIG00523588 FIG00523589: hypothetical protein +FIG00523613 FIG00523616: hypothetical protein +FIG00523620 FIG00523621: hypothetical protein +FIG00523621 FIG00523622: hypothetical protein +FIG00523622 FIG00523624: hypothetical protein +FIG00523625 FIG00523626: hypothetical protein +FIG00523626 FIG00523628: hypothetical protein +FIG00523629 FIG00523638: hypothetical protein +FIG00523639 FIG00523640: hypothetical protein +FIG00523640 FIG00523647: hypothetical protein +FIG00523648 FIG00523652: hypothetical protein +FIG00523652 FIG00523653: hypothetical protein +FIG00523653 FIG00523654: hypothetical protein +FIG00523654 FIG00523655: hypothetical protein +FIG00523655 FIG00523656: hypothetical protein +FIG00523656 FIG00523668: hypothetical protein +FIG00523673 Uncharacterized protein, YceG B.subtilis homolog +FIG00523674 FIG00523678: hypothetical protein +FIG00523684 FIG00523688: hypothetical protein +FIG00523692 FIG00523697: hypothetical protein +FIG00523705 FIG00523707: hypothetical protein +FIG00523707 FIG00523711: hypothetical protein +FIG00523711 FIG00523712: hypothetical protein +FIG00523712 FIG00523713: hypothetical protein +FIG00523713 FIG00523714: hypothetical protein +FIG00523715 FIG00523717: hypothetical protein +FIG00523722 FIG00523724: hypothetical protein +FIG00523726 FIG00523727: hypothetical protein +FIG00523740 FIG00523741: hypothetical protein +FIG00523741 FIG00523745: hypothetical protein +FIG00523745 FIG00523748: hypothetical protein +FIG00523748 FIG00523751: hypothetical protein +FIG00523751 FIG00523752: hypothetical protein +FIG00523752 FIG00523759: hypothetical protein +FIG00523759 FIG00523760: hypothetical protein +FIG00523760 FIG00523766: hypothetical protein +FIG00523766 FIG00523767: hypothetical protein +FIG00523770 FIG00523778: hypothetical protein +FIG00523783 FIG00521570: hypothetical protein +FIG00523786 FIG00523797: hypothetical protein +FIG00523799 FIG00523800: hypothetical protein +FIG00523801 transcriptional regulator, deoR family +FIG00523805 FIG00523806: hypothetical protein +FIG00523806 FIG00523807: hypothetical protein +FIG00523807 FIG00523808: hypothetical protein +FIG00523808 FIG00523809: hypothetical protein +FIG00523809 FIG00523810: hypothetical protein +FIG00523810 FIG00523811: hypothetical protein +FIG00523811 FIG00523812: hypothetical protein +FIG00523813 FIG00523814: hypothetical protein +FIG00523814 FIG00523816: hypothetical protein +FIG00523834 FIG00523838: hypothetical protein +FIG00523838 FIG00523842: hypothetical protein +FIG00523843 tetracenomycin polyketide synthesis O-methyltransferase TcmP, putative +FIG00523851 FIG00523854: hypothetical protein +FIG00523856 FIG00523857: hypothetical protein +FIG00523857 FIG00523858: hypothetical protein +FIG00523859 FIG00523860: hypothetical protein +FIG00523860 FIG00523862: hypothetical protein +FIG00523867 FIG00523868: hypothetical protein +FIG00523868 FIG00523869: hypothetical protein +FIG00523869 FIG00523870: hypothetical protein +FIG00523870 FIG00523871: hypothetical protein +FIG00523878 FIG00523879: hypothetical protein +FIG00523879 FIG00523884: hypothetical protein +FIG00523884 FIG00523888: hypothetical protein +FIG00523902 FIG00523903: hypothetical protein +FIG00523903 FIG00523908: hypothetical protein +FIG00523908 FIG00523909: hypothetical protein +FIG00523909 FIG00523917: hypothetical protein +FIG00523923 FIG00523927: hypothetical protein +FIG00523927 FIG00523929: hypothetical protein +FIG00523929 FIG00523932: hypothetical protein +FIG00523932 FIG00523940: hypothetical protein +FIG00523952 FIG00523963: hypothetical protein +FIG00523963 FIG00523965: hypothetical protein +FIG00523965 FIG00523966: hypothetical protein +FIG00523968 Chain A, Structural And Active Site Modification Studies Implicate Glu, Trp And Arg In The Activity Of Xylanase From Alkalophilic Bacillus Sp. (Ncl 87-6-10). +FIG00523969 FIG00523971: hypothetical protein +FIG00523978 FIG00523981: hypothetical protein +FIG00523982 FIG00523984: hypothetical protein +FIG00523984 FIG00523990: hypothetical protein +FIG00523990 FIG00523991: hypothetical protein +FIG00523991 FIG00523993: hypothetical protein +FIG00523993 FIG00523996: hypothetical protein +FIG00523999 metallo beta-lactamase superfamily lipoprotein +FIG00524007 FIG00524011: hypothetical protein +FIG00524017 FIG00524022: hypothetical protein +FIG00524022 FIG00524023: hypothetical protein +FIG00524023 FIG00524026: hypothetical protein +FIG00524039 FIG00524040: hypothetical protein +FIG00524042 Putative membrane protein +FIG00524050 tRNA (Uracil-5-) -methyltransferase (EC 2.1.1.35) +FIG00524056 FIG00524061: hypothetical protein +FIG00524061 FIG00524062: hypothetical protein +FIG00524062 FIG00524064: hypothetical protein +FIG00524064 secreted protein containing uncharacterized conserved protein of ErfK family +FIG00524068 FIG00524073: hypothetical protein +FIG00524074 spore coat protein F +FIG00524077 Nitrilase (EC 3.5.5.1) +FIG00524080 FIG00524085: hypothetical protein +FIG00524085 FIG00524087: hypothetical protein +FIG00524087 FIG00524090: hypothetical protein +FIG00524107 FIG00524109: hypothetical protein +FIG00524119 FIG00524120: hypothetical protein +FIG00524120 FIG00524121: hypothetical protein +FIG00524121 FIG00524128: hypothetical protein +FIG00524128 FIG00524129: hypothetical protein +FIG00524129 FIG00524130: hypothetical protein +FIG00524131 Resolvase, N-terminal +FIG00524134 FIG00524135: hypothetical protein +FIG00524135 FIG00524143: hypothetical protein +FIG00524148 FIG00524150: hypothetical protein +FIG00524150 FIG00524151: hypothetical protein +FIG00524151 FIG00524152: hypothetical protein +FIG00524157 FIG00524161: hypothetical protein +FIG00524167 FIG00524168: hypothetical protein +FIG00524168 FIG00524169: hypothetical protein +FIG00524170 Acetyltransferase (with duplicated domains), possibly RIMI-like protein +FIG00524172 FIG00524174: hypothetical protein +FIG00524174 FIG00524177: hypothetical protein +FIG00524179 FIG00524182: hypothetical protein +FIG00524182 FIG00524186: hypothetical protein +FIG00524186 FIG00524190: hypothetical protein +FIG00524195 FIG00524202: hypothetical protein +FIG00524203 FIG00524206: hypothetical protein +FIG00524222 FIG00524223: hypothetical protein +FIG00524223 FIG00524224: hypothetical protein +FIG00524224 arsenate reductase-like protein +FIG00524226 FIG00524228: hypothetical protein +FIG00524231 FIG00524232: hypothetical protein +FIG00524233 FIG00524236: hypothetical protein +FIG00524239 FIG00524240: hypothetical protein +FIG00524246 FIG00524249: hypothetical protein +FIG00524249 FIG00524255: hypothetical protein +FIG00524260 FIG00524261: hypothetical protein +FIG00524287 FIG00524289: hypothetical protein +FIG00524289 FIG00524292: hypothetical protein +FIG00524296 FIG00524297: hypothetical protein +FIG00524297 FIG00524298: hypothetical protein +FIG00524298 FIG00524300: hypothetical protein +FIG00524300 FIG00524311: hypothetical protein +FIG00524311 putative phage major capsid protein +FIG00524317 FIG00524323: hypothetical protein +FIG00524323 hypothetical protein +FIG00524324 FIG00524335: hypothetical protein +FIG00524335 FIG00524341: hypothetical protein +FIG00524346 FIG00524351: hypothetical protein +FIG00524351 FIG00524352: hypothetical protein +FIG00524361 FIG00524370: hypothetical protein +FIG00524370 FIG00524373: hypothetical protein +FIG00524375 FIG00524377: hypothetical protein +FIG00524388 FIG00524389: hypothetical protein +FIG00524389 COG1399 protein in cluster with ribosomal protein L32p, Firmicutes subfamily +FIG00524390 FIG00524392: hypothetical protein +FIG00524392 FIG00524394: hypothetical protein +FIG00524395 FIG00524396: hypothetical protein +FIG00524396 FIG00524398: hypothetical protein +FIG00524399 FIG00524404: hypothetical protein +FIG00524404 FIG00524407: hypothetical protein +FIG00524407 FIG00524411: hypothetical protein +FIG00524415 FIG00524420: hypothetical protein +FIG00524420 FIG00524427: hypothetical protein +FIG00524427 FIG00524428: hypothetical protein +FIG00524428 FIG00524429: hypothetical protein +FIG00524434 FIG00524446: hypothetical protein +FIG00524446 FIG00524447: hypothetical protein +FIG00524450 FIG00524451: hypothetical protein +FIG00524451 FIG00524453: hypothetical protein +FIG00524453 FIG00524454: hypothetical protein +FIG00524454 FIG00524455: hypothetical protein +FIG00524455 FIG00524460: hypothetical protein +FIG00524460 FIG00524461: hypothetical protein +FIG00524461 FIG00524463: hypothetical protein +FIG00524463 FIG00524464: hypothetical protein +FIG00524480 FIG00524490: hypothetical protein +FIG00524490 FIG00524493: hypothetical protein +FIG00524493 FIG00524495: hypothetical protein +FIG00524496 FIG00524498: hypothetical protein +FIG00524503 FIG00524505: hypothetical protein +FIG00524510 peptidase C11, clostripain +FIG00524516 FIG00524517: hypothetical protein +FIG00524517 IMP dehydrogenase/GMP reductase:Bacterial extracellular solute-binding protein, family 1 +FIG00524518 FIG00524521: hypothetical protein +FIG00524532 FIG00524534: hypothetical protein +FIG00524559 CG15628-PA +FIG00524561 D-isomer specific 2-hydroxyacid dehydrogenase NAD-binding +FIG00524567 FIG00524568: hypothetical protein +FIG00524569 FIG00524570: hypothetical protein +FIG00524570 FIG00524571: hypothetical protein +FIG00524579 FIG00524580: hypothetical protein +FIG00524587 FIG00524590: hypothetical protein +FIG00524590 Glutamine ABC transporter, periplasmic glutamine-binding protein (TC 3.A.1.3.2) / Glutamine transport system permease protein GlnP (TC 3.A.1.3.2) +FIG00524593 Erythronolide synthase( EC:2.3.1.94 ) +FIG00524602 glycosyl transferase, family 2 +FIG00524603 FIG00524605: hypothetical protein +FIG00524605 FIG00524609: hypothetical protein +FIG00524618 FIG00524619: hypothetical protein +FIG00524620 FIG00524621: hypothetical protein +FIG00524621 Alpha/beta superfamily hydrolase (possible chloroperoxidase) +FIG00524623 FIG00524625: hypothetical protein +FIG00524640 FIG00524643: hypothetical protein +FIG00524651 FIG00524654: hypothetical protein +FIG00524654 FIG00524657: hypothetical protein +FIG00524657 FIG00524659: hypothetical protein +FIG00524659 FIG00524667: hypothetical protein +FIG00524667 FIG00524668: hypothetical protein +FIG00524668 FIG00524670: hypothetical protein +FIG00524670 FIG01124638: hypothetical protein +FIG00524673 FIG00524683: hypothetical protein +FIG00524683 FIG00524685: hypothetical protein +FIG00524686 FIG00524689: hypothetical protein +FIG00524689 FIG00524692: hypothetical protein +FIG00524692 FIG00524694: hypothetical protein +FIG00524694 AzlC-like protein +FIG00524703 FIG00524704: hypothetical protein +FIG00524705 FIG00524717: hypothetical protein +FIG00524717 FIG00524722: hypothetical protein +FIG00524723 FIG00524726: hypothetical protein +FIG00524729 FIG00524732: hypothetical protein +FIG00524732 prophage LambdaBa04, Gp54 +FIG00524736 FIG00524739: hypothetical protein +FIG00524739 FIG00524740: hypothetical protein +FIG00524748 FIG00524750: hypothetical protein +FIG00524753 FIG00524755: hypothetical protein +FIG00524755 FIG00524756: hypothetical protein +FIG00524756 FIG00524757: hypothetical protein +FIG00524757 FIG00524758: hypothetical protein +FIG00524764 FIG00524774: hypothetical protein +FIG00524774 FIG00524775: hypothetical protein +FIG00524778 FIG00524779: hypothetical protein +FIG00524779 FIG00524782: hypothetical protein +FIG00524782 FIG00524783: hypothetical protein +FIG00524783 FIG00524787: hypothetical protein +FIG00524787 FIG00524789: hypothetical protein +FIG00524791 FIG00524793: hypothetical protein +FIG00524793 Methylase/methyltransferase +FIG00524795 FIG00524801: hypothetical protein +FIG00524803 FIG00524804: hypothetical protein +FIG00524804 FIG00524805: hypothetical protein +FIG00524805 Glycosyltransferase involved in cell wall biogenesis (EC 2.4.-.- ) +FIG00524810 FIG00524814: hypothetical protein +FIG00524819 FIG00524822: hypothetical protein +FIG00524822 FIG00524824: hypothetical protein +FIG00524827 FIG00524829: hypothetical protein +FIG00524829 FIG00524833: hypothetical protein +FIG00524843 putative sugar transporter, substrate-binding lipoprotein +FIG00524847 FIG00524850: hypothetical protein +FIG00524850 succinoglycan biosynthesis protein exoA +FIG00524858 FIG00524860: hypothetical protein +FIG00524860 FIG00524867: hypothetical protein +FIG00524874 FIG00524875: hypothetical protein +FIG00524875 FIG00524878: hypothetical protein +FIG00524878 FIG00524881: hypothetical protein +FIG00524882 FIG00524889: hypothetical protein +FIG00524904 FIG00524906: hypothetical protein +FIG00524909 FIG00524911: hypothetical protein +FIG00524911 FIG00524919: hypothetical protein +FIG00524925 Helix-turn-helix, AraC type:transcription activator, effector binding +FIG00524927 FIG00524928: hypothetical protein +FIG00524929 FIG00524930: hypothetical protein +FIG00524941 FIG00524942: hypothetical protein +FIG00524944 FIG00524945: hypothetical protein +FIG00524947 FIG00524956: hypothetical protein +FIG00524956 FIG00524958: hypothetical protein +FIG00524958 FIG00524964: hypothetical protein +FIG00524971 FIG00524974: hypothetical protein +FIG00524975 FIG00524977: hypothetical protein +FIG00524977 FIG00524981: hypothetical protein +FIG00524982 FIG00524985: hypothetical protein +FIG00524985 Ortholog of S. aureus MRSA252 (BX571856) SAR0359 +FIG00524988 FIG00524994: hypothetical protein +FIG00524995 FIG00524998: hypothetical protein +FIG00525002 Endoglucanase A precursor (EC 3.2.1.4) (Endo-1,4-beta-glucanase A) (Cellulase A) +FIG00525004 FIG00525006: hypothetical protein +FIG00525009 FIG00525010: hypothetical protein +FIG00525010 FIG00525011: hypothetical protein +FIG00525013 FIG00525014: hypothetical protein +FIG00525020 putative acyl carrier protein phosphodiesterase +FIG00525023 FIG00525025: hypothetical protein +FIG00525025 FIG00525031: hypothetical protein +FIG00525033 FIG00525038: hypothetical protein +FIG00525039 FIG00525041: hypothetical protein +FIG00525042 FIG00525043: hypothetical protein +FIG00525047 FIG00525049: hypothetical protein +FIG00525049 FIG00525054: hypothetical protein +FIG00525068 INTEGRAL MEMBRANE PROTEIN (Rhomboid family) +FIG00525070 FIG00525073: hypothetical protein +FIG00525073 FIG00525078: hypothetical protein +FIG00525090 FIG00525097: hypothetical protein +FIG00525097 FIG00525100: hypothetical protein +FIG00525100 FIG00525105: hypothetical protein +FIG00525105 FIG00525106: hypothetical protein +FIG00525107 FIG00525109: hypothetical protein +FIG00525118 FIG00525119: hypothetical protein +FIG00525123 FIG00525127: hypothetical protein +FIG00525148 FIG00525149: hypothetical protein +FIG00525149 FIG00525152: hypothetical protein +FIG00525152 glycoside hydrolase, family 5 +FIG00525154 FIG00525158: hypothetical protein +FIG00525159 FIG00525160: hypothetical protein +FIG00525160 ROK domain containing protein +FIG00525167 FIG00525171: hypothetical protein +FIG00525171 FIG00525172: hypothetical protein +FIG00525172 FIG00525173: hypothetical protein +FIG00525173 FIG00525178: hypothetical protein +FIG00525178 FIG00525180: hypothetical protein +FIG00525180 FIG00525182: hypothetical protein +FIG00525182 FIG00525184: hypothetical protein +FIG00525201 phage-related hypothetical protein +FIG00525203 FIG00525204: hypothetical protein +FIG00525204 Sugar diacid utilization regulator-like +FIG00525208 FIG00525217: hypothetical protein +FIG00525217 FIG00525218: hypothetical protein +FIG00525218 FIG00525220: hypothetical protein +FIG00525220 FIG00525224: hypothetical protein +FIG00525224 FIG00525226: hypothetical protein +FIG00525236 Rhodanese-like domain +FIG00525246 FIG00525249: hypothetical protein +FIG00525254 FIG00525257: hypothetical protein +FIG00525271 FIG00525273: hypothetical protein +FIG00525278 FIG00525281: hypothetical protein +FIG00525281 FIG00525285: hypothetical protein +FIG00525285 FIG00525288: hypothetical protein +FIG00525288 FIG00525293: hypothetical protein +FIG00525294 FIG00525295: hypothetical protein +FIG00525295 FIG00525298: hypothetical protein +FIG00525301 FIG00525303: hypothetical protein +FIG00525305 FIG00525307: hypothetical protein +FIG00525307 FIG00525310: hypothetical protein +FIG00525310 FIG00525314: hypothetical protein +FIG00525323 FIG00525332: hypothetical protein +FIG00525332 thiol:disulfide oxidoreductase +FIG00525334 FIG00525338: hypothetical protein +FIG00525346 putative transcriptional regulator, MarR-family +FIG00525353 FIG00525356: hypothetical protein +FIG00525356 FIG00525361: hypothetical protein +FIG00525361 FIG00525367: hypothetical protein +FIG00525381 FIG00525383: hypothetical protein +FIG00525394 FIG00525398: hypothetical protein +FIG00525398 FIG00525399: hypothetical protein +FIG00525404 FIG00525406: hypothetical protein +FIG00525407 FIG00525408: hypothetical protein +FIG00525408 FIG00525409: hypothetical protein +FIG00525409 FIG00525410: hypothetical protein +FIG00525410 FIG00525411: hypothetical protein +FIG00525418 FIG00525419: hypothetical protein +FIG00525419 FIG00525420: hypothetical protein +FIG00525420 FIG00525423: hypothetical protein +FIG00525424 FIG00525427: hypothetical protein +FIG00525427 FIG00525430: hypothetical protein +FIG00525446 FIG00525447: hypothetical protein +FIG00525455 FIG00525456: hypothetical protein +FIG00525461 FIG00525465: hypothetical protein +FIG00525468 FIG00525474: hypothetical protein +FIG00525499 FIG00525500: hypothetical protein +FIG00525500 FIG00525503: hypothetical protein +FIG00525503 FIG00525504: hypothetical protein +FIG00525504 sporulation protein and related proteins +FIG00525509 FIG00525514: hypothetical protein +FIG00525517 FIG00525523: hypothetical protein +FIG00525533 FIG00525534: hypothetical protein +FIG00525542 FIG00525543: hypothetical protein +FIG00525543 FIG00525546: hypothetical protein +FIG00525550 FIG00525551: hypothetical protein +FIG00525551 FIG00525555: hypothetical protein +FIG00525556 FIG00525558: hypothetical protein +FIG00525566 FIG00525576: hypothetical protein +FIG00525584 FIG00525593: hypothetical protein +FIG00525604 FIG00525608: hypothetical protein +FIG00525610 FIG00525611: hypothetical protein +FIG00525616 FIG00525617: hypothetical protein +FIG00525622 FIG00525625: hypothetical protein +FIG00525625 Iron-sulfur-binding protein +FIG00525632 FIG00525633: hypothetical protein +FIG00525633 unnamed protein product; orf178 +FIG00525635 FIG00525640: hypothetical protein +FIG00525640 FIG00525643: hypothetical protein +FIG00525653 Metal-dependent phosphohydrolase, HD region +FIG00525656 FIG00525658: hypothetical protein +FIG00525669 FIG00525670: hypothetical protein +FIG00525673 FIG00525674: hypothetical protein +FIG00525677 FIG00525680: hypothetical protein +FIG00525680 FIG00525683: hypothetical protein +FIG00525697 FIG00525703: hypothetical protein +FIG00525703 FIG00525705: hypothetical protein +FIG00525705 FIG00525709: hypothetical protein +FIG00525717 FIG00525722: hypothetical protein +FIG00525722 FIG00525727: hypothetical protein +FIG00525727 FIG00525729: hypothetical protein +FIG00525739 FIG00525744: hypothetical protein +FIG00525744 TPR repeat domain containing protein +FIG00525760 FIG00525763: hypothetical protein +FIG00525766 FIG00525767: hypothetical protein +FIG00525767 FIG00525771: hypothetical protein +FIG00525773 FIG00525779: hypothetical protein +FIG00525779 FIG00525781: hypothetical protein +FIG00525781 FIG00525786: hypothetical protein +FIG00525789 FIG00525794: hypothetical protein +FIG00525794 FIG00525798: hypothetical protein +FIG00525798 FIG00525802: hypothetical protein +FIG00525803 FIG00525815: hypothetical protein +FIG00525817 FIG00525818: hypothetical protein +FIG00525821 FIG00525822: hypothetical protein +FIG00525822 FIG00525823: hypothetical protein +FIG00525823 FIG00525826: hypothetical protein +FIG00525826 FIG00530205: hypothetical protein +FIG00525838 FIG00525840: hypothetical protein +FIG00525840 FIG00525841: hypothetical protein +FIG00525841 Carbon monoxide dehydrogenase small chain (EC 1.2.99.2) +FIG00525854 FIG00525862: hypothetical protein +FIG00525862 FIG00525866: hypothetical protein +FIG00525866 FIG00525877: hypothetical protein +FIG00525877 FIG00525881: hypothetical protein +FIG00525883 FIG00525885: hypothetical protein +FIG00525885 FIG00525886: hypothetical protein +FIG00525890 FIG00525892: hypothetical protein +FIG00525892 4-amino-4-deoxychorismate lyase( EC:4.- ) +FIG00525894 FIG00525899: hypothetical protein +FIG00525899 LysR-family transcriptional regulator (partial) +FIG00525901 Uncharacterized secreted protein, homolog YXKC Bacillus subtilis +FIG00525910 FIG00525911: hypothetical protein +FIG00525911 FIG00525912: hypothetical protein +FIG00525912 FIG00525915: hypothetical protein +FIG00525918 FIG00525923: hypothetical protein +FIG00525923 coenzyme F390 synthetase-like protein +FIG00525926 FIG00525929: hypothetical protein +FIG00525929 FIG00525930: hypothetical protein +FIG00525930 FIG00525932: hypothetical protein +FIG00525932 FIG00525934: hypothetical protein +FIG00525936 FIG00525937: hypothetical protein +FIG00525937 FIG00525943: hypothetical protein +FIG00525943 FIG00525945: hypothetical protein +FIG00525945 FIG00525953: hypothetical protein +FIG00525953 FIG00525955: hypothetical protein +FIG00525959 FIG00525960: hypothetical protein +FIG00525960 FIG00525961: hypothetical protein +FIG00525978 transcriptional regulators, AcrR family +FIG00525980 FIG00525988: hypothetical protein +FIG00526000 FIG00526001: hypothetical protein +FIG00526002 FIG00526008: hypothetical protein +FIG00526009 FIG00526016: hypothetical protein +FIG00526016 Lantibiotic transport ATP-binding protein srtF +FIG00526018 FIG00526019: hypothetical protein +FIG00526020 FIG00526021: hypothetical protein +FIG00526037 FIG00526045: hypothetical protein +FIG00526046 FIG00526048: hypothetical protein +FIG00526051 FIG00526057: hypothetical protein +FIG00526063 FIG00526064: hypothetical protein +FIG00526064 FIG00526066: hypothetical protein +FIG00526073 FIG00526074: hypothetical protein +FIG00526079 FIG00526083: hypothetical protein +FIG00526083 FIG00526085: hypothetical protein +FIG00526085 FIG00526088: hypothetical protein +FIG00526088 FIG00526091: hypothetical protein +FIG00526091 FIG00526092: hypothetical protein +FIG00526092 capsular polysaccharide biosynthsis protein +FIG00526095 FIG00526097: hypothetical protein +FIG00526097 FIG00526102: hypothetical protein +FIG00526104 FIG00526112: hypothetical protein +FIG00526118 FIG00526120: hypothetical protein +FIG00526129 FIG00526133: hypothetical protein +FIG00526138 FIG00526146: hypothetical protein +FIG00526146 FIG00526148: hypothetical protein +FIG00526148 putative cell wall anchor domain protein +FIG00526150 FIG00526151: hypothetical protein +FIG00526151 FIG00526156: hypothetical protein +FIG00526156 FIG00526160: hypothetical protein +FIG00526160 FIG00526165: hypothetical protein +FIG00526165 FIG00526167: hypothetical protein +FIG00526169 FIG00526173: hypothetical protein +FIG00526173 FIG00526174: hypothetical protein +FIG00526174 FIG00526175: hypothetical protein +FIG00526175 LycA +FIG00526180 FIG00526182: hypothetical protein +FIG00526184 putative anaerobic ribonucleoside-triphosphate reductase +FIG00526186 FIG00526189: hypothetical protein +FIG00526189 FIG00526190: hypothetical protein +FIG00526220 FIG00526226: hypothetical protein +FIG00526244 FIG00526253: hypothetical protein +FIG00526253 FIG00526254: hypothetical protein +FIG00526259 putative proline iminopeptidase +FIG00526262 FIG00526263: hypothetical protein +FIG00526263 FIG00526271: hypothetical protein +FIG00526272 FIG00526273: hypothetical protein +FIG00526273 FIG00526275: hypothetical protein +FIG00526275 FIG00526279: hypothetical protein +FIG00526284 FIG00526287: hypothetical protein +FIG00526287 FIG00526289: hypothetical protein +FIG00526290 FIG00526298: hypothetical protein +FIG00526304 FIG00526305: hypothetical protein +FIG00526305 FIG00526309: hypothetical protein +FIG00526316 FIG00526317: hypothetical protein +FIG00526317 FIG00526319: hypothetical protein +FIG00526320 FIG00526322: hypothetical protein +FIG00526322 FIG00526323: hypothetical protein +FIG00526333 Type IV pilus biogenesis protein PilO +FIG00526340 Re face-specific citrate synthase (EC 2.3.3.3) +FIG00526355 3-oxoacyl-(acyl-carrier-protein) synthase( EC:2.3.1.41 ) +FIG00526374 FIG00526376: hypothetical protein +FIG00526392 FIG00526393: hypothetical protein +FIG00526403 FIG00526409: hypothetical protein +FIG00526411 FIG00526413: hypothetical protein +FIG00526415 FIG00526416: hypothetical protein +FIG00526418 Nitrogenase molybdenum-iron protein, alpha and beta chains +FIG00526423 FIG00526425: hypothetical protein +FIG00526425 FIG00526431: hypothetical protein +FIG00526431 FIG00526436: hypothetical protein +FIG00526436 FIG00526441: hypothetical protein +FIG00526441 FIG00526442: hypothetical protein +FIG00526443 FIG00526444: hypothetical protein +FIG00526447 FIG00526459: hypothetical protein +FIG00526459 FIG00526461: hypothetical protein +FIG00526461 FIG00526464: hypothetical protein +FIG00526469 FIG00526471: hypothetical protein +FIG00526471 FIG00526472: hypothetical protein +FIG00526472 FIG00526476: hypothetical protein +FIG00526485 FIG00526486: hypothetical protein +FIG00526486 FIG00526489: hypothetical protein +FIG00526489 type IV pilus assembly protein PilZ +FIG00526494 FIG00526499: hypothetical protein +FIG00526505 hypothetical protein +FIG00526512 FIG00526513: hypothetical protein +FIG00526527 transcription regulator, AsnC-type +FIG00526528 FIG00526535: hypothetical protein +FIG00526547 FIG00526549: hypothetical protein +FIG00526556 FIG00526560: hypothetical protein +FIG00526561 FIG00526562: hypothetical protein +FIG00526562 FIG00526564: hypothetical protein +FIG00526564 FIG00526567: hypothetical protein +FIG00526567 FIG00526573: hypothetical protein +FIG00526573 FIG00526574: hypothetical protein +FIG00526574 FIG00526575: hypothetical protein +FIG00526575 conserved hypothetical pentapeptide repeat protein +FIG00526579 FIG00526582: hypothetical protein +FIG00526593 cwp66 homolog/N-acetylmuramoyl-L-alanine amidase +FIG00526599 FIG00526610: hypothetical protein +FIG00526626 FIG00526628: hypothetical protein +FIG00526628 FIG00526630: hypothetical protein +FIG00526630 protein of unknown function DUF1696 +FIG00526634 FIG00526636: hypothetical protein +FIG00526636 FIG00526637: hypothetical protein +FIG00526645 FIG00526646: hypothetical protein +FIG00526646 FIG00526648: hypothetical protein +FIG00526648 FIG00526649: hypothetical protein +FIG00526649 capsule biosynthesis protein CapA +FIG00526651 FIG00526656: hypothetical protein +FIG00526662 FIG00526667: hypothetical protein +FIG00526667 FIG00526675: hypothetical protein +FIG00526679 FIG00526683: hypothetical protein +FIG00526683 FIG00526684: hypothetical protein +FIG00526685 FIG00526686: hypothetical protein +FIG00526687 FIG00526694: hypothetical protein +FIG00526694 FIG00526695: hypothetical protein +FIG00526695 FIG00526701: hypothetical protein +FIG00526701 FIG00526703: hypothetical protein +FIG00526704 FIG00526705: hypothetical protein +FIG00526705 FIG00526712: hypothetical protein +FIG00526714 FIG00526720: hypothetical protein +FIG00526720 FIG00526722: hypothetical protein +FIG00526737 FIG00526745: hypothetical protein +FIG00526745 FIG00526746: hypothetical protein +FIG00526746 FIG00526749: hypothetical protein +FIG00526749 FIG00526754: hypothetical protein +FIG00526760 FIG00526764: hypothetical protein +FIG00526765 FIG00526766: hypothetical protein +FIG00526766 probable phosphinothricin acetyltransferase (antibiotic resistance) protein +FIG00526768 FIG00526770: hypothetical protein +FIG00526770 FIG00526772: hypothetical protein +FIG00526772 FIG00526778: hypothetical protein +FIG00526786 FIG00526787: hypothetical protein +FIG00526788 FIG00526789: hypothetical protein +FIG00526792 FIG00526793: hypothetical protein +FIG00526793 FIG00526794: hypothetical protein +FIG00526794 FIG00526797: hypothetical protein +FIG00526798 FIG00526804: hypothetical protein +FIG00526808 FIG00526817: hypothetical protein +FIG00526819 Lyzozyme M1 (1,4-beta-N-acetylmuramidase) (EC 3.2.1.17) +FIG00526821 FIG00526824: hypothetical protein +FIG00526824 FIG00526833: hypothetical protein +FIG00526833 FIG00526834: hypothetical protein +FIG00526839 FIG00526843: hypothetical protein +FIG00526843 FIG00526844: hypothetical protein +FIG00526844 Bacitracin ABC transporter, ATP-binding protein +FIG00526845 FIG00526847: hypothetical protein +FIG00526848 FIG00526850: hypothetical protein +FIG00526863 hypothetical protein +FIG00526871 pyrophosphohydrolase MazG RS21-C6 family protein contains InterPro domain +FIG00526874 FIG00526877: hypothetical protein +FIG00526887 FIG00526889: hypothetical protein +FIG00526906 FIG00526908: hypothetical protein +FIG00526908 FIG00526910: hypothetical protein +FIG00526910 FIG00526926: hypothetical protein +FIG00526929 FIG00526934: hypothetical protein +FIG00526935 FIG00526936: hypothetical protein +FIG00526941 FIG00526943: hypothetical protein +FIG00526946 FIG00526947: hypothetical protein +FIG00526948 FIG00526953: hypothetical protein +FIG00526953 FIG00526954: hypothetical protein +FIG00526958 Tetratricopeptide protein +FIG00526962 FIG00526964: hypothetical protein +FIG00526967 FIG00526971: hypothetical protein +FIG00526978 FIG00526982: hypothetical protein +FIG00526995 FIG00527000: hypothetical protein +FIG00527000 Choline-binding protein +FIG00527015 FIG00527017: hypothetical protein +FIG00527017 FIG00527028: hypothetical protein +FIG00527028 FIG00527043: hypothetical protein +FIG00527047 FIG00527051: hypothetical protein +FIG00527051 FIG00527053: hypothetical protein +FIG00527053 FIG00527055: hypothetical protein +FIG00527055 FIG00527057: hypothetical protein +FIG00527061 FIG00527067: hypothetical protein +FIG00527073 FIG00527075: hypothetical protein +FIG00527075 FIG00527076: hypothetical protein +FIG00527076 FIG00527077: hypothetical protein +FIG00527078 FIG00527080: hypothetical protein +FIG00527091 FIG00527092: hypothetical protein +FIG00527110 FIG00527112: hypothetical protein +FIG00527127 FIG00527130: hypothetical protein +FIG00527149 FIG00527157: hypothetical protein +FIG00527158 FIG00527159: hypothetical protein +FIG00527159 TcpF +FIG00527160 FIG00527162: hypothetical protein +FIG00527166 FIG00527171: hypothetical protein +FIG00527171 FIG00527172: hypothetical protein +FIG00527180 FIG00527181: hypothetical protein +FIG00527181 FIG00527182: hypothetical protein +FIG00527182 FIG00527189: hypothetical protein +FIG00527209 Radical SAM superfamily protein +FIG00527218 FIG00527219: hypothetical protein +FIG00527220 FIG00527221: hypothetical protein +FIG00527226 FIG00527236: hypothetical protein +FIG00527237 FIG00527241: hypothetical protein +FIG00527241 protein of unknown function DUF990 +FIG00527256 Retinitis pigmentosa GTPase regulator-like protein +FIG00527257 FIG00527260: hypothetical protein +FIG00527260 FIG00527263: hypothetical protein +FIG00527263 FIG00527267: hypothetical protein +FIG00527267 FIG00527269: hypothetical protein +FIG00527269 FIG00527270: hypothetical protein +FIG00527277 FIG00527281: hypothetical protein +FIG00527288 FIG00527289: hypothetical protein +FIG00527289 FIG00527290: hypothetical protein +FIG00527290 FIG00527295: hypothetical protein +FIG00527299 FIG00527303: hypothetical protein +FIG00527313 FIG00527316: hypothetical protein +FIG00527316 FIG00527319: hypothetical protein +FIG00527319 FIG00527323: hypothetical protein +FIG00527323 FIG00527327: hypothetical protein +FIG00527330 FIG00527334: hypothetical protein +FIG00527334 FIG00527335: hypothetical protein +FIG00527335 FIG00527337: hypothetical protein +FIG00527340 FIG00527341: hypothetical protein +FIG00527341 FIG00527342: hypothetical protein +FIG00527347 FIG00527351: hypothetical protein +FIG00527357 FIG00527358: hypothetical protein +FIG00527358 FIG00617215: hypothetical protein +FIG00527364 FIG00527367: hypothetical protein +FIG00527375 FIG00527376: hypothetical protein +FIG00527376 FIG00527378: hypothetical protein +FIG00527396 FIG00527399: hypothetical protein +FIG00527399 FIG00527400: hypothetical protein +FIG00527404 Ribose ABC transporter, periplasmic ribose-binding protein rbsB (TC 3.A.1.2.1) +FIG00527409 FIG00527411: hypothetical protein +FIG00527411 FIG00527412: hypothetical protein +FIG00527413 FIG00527415: hypothetical protein +FIG00527415 FIG00527420: hypothetical protein +FIG00527420 FIG00527423: hypothetical protein +FIG00527423 FIG00527424: hypothetical protein +FIG00527424 FIG00527426: hypothetical protein +FIG00527431 FIG00527432: hypothetical protein +FIG00527432 FIG00527433: hypothetical protein +FIG00527433 FIG00527436: hypothetical protein +FIG00527440 FIG00527443: hypothetical protein +FIG00527450 FIG00527456: hypothetical protein +FIG00527456 HAD-superfamily hydrolase, subfamily IB (PSPase-like),HAD-superfamily subfamily IB hydrolase, hypothetical 1 +FIG00527486 FIG00527488: hypothetical protein +FIG00527488 predicted flavodoxin +FIG00527492 FIG00527493: hypothetical protein +FIG00527493 FIG00527503: hypothetical protein +FIG00527514 FIG00527516: hypothetical protein +FIG00527520 FIG00527521: hypothetical protein +FIG00527526 FIG00527527: hypothetical protein +FIG00527527 FIG00527533: hypothetical protein +FIG00527533 Possible transcriptional regulator from leucine-rich protein (LRPR) family +FIG00527537 FIG00527539: hypothetical protein +FIG00527547 FIG00527553: hypothetical protein +FIG00527553 FIG00527559: hypothetical protein +FIG00527567 FIG00527569: hypothetical protein +FIG00527569 FIG00527570: hypothetical protein +FIG00527570 FIG00527575: hypothetical protein +FIG00527575 FIG00527581: hypothetical protein +FIG00527583 FIG00527586: hypothetical protein +FIG00527586 FIG00527588: hypothetical protein +FIG00527588 S-layer-like domain containing protein +FIG00527590 FIG00527594: hypothetical protein +FIG00527594 FIG00527595: hypothetical protein +FIG00527597 FIG00527604: hypothetical protein +FIG00527604 FIG00527605: hypothetical protein +FIG00527606 FIG00527610: hypothetical protein +FIG00527610 FIG00527622: hypothetical protein +FIG00527641 FIG00527646: hypothetical protein +FIG00527647 FIG00527648: hypothetical protein +FIG00527648 Exochitinase 1 precursor (EC 3.2.1.14) +FIG00527651 FIG00527652: hypothetical protein +FIG00527652 FIG00527654: hypothetical protein +FIG00527654 FIG00527655: hypothetical protein +FIG00527655 FIG00527656: hypothetical protein +FIG00527656 FIG00527657: hypothetical protein +FIG00527657 FIG00527660: hypothetical protein +FIG00527665 FIG00527671: hypothetical protein +FIG00527671 FIG00527673: hypothetical protein +FIG00527673 FIG00527683: hypothetical protein +FIG00527689 FIG00527691: hypothetical protein +FIG00527717 FIG00527723: hypothetical protein +FIG00527723 FIG00527726: hypothetical protein +FIG00527737 FIG00527739: hypothetical protein +FIG00527742 copper amine oxidase domain protein +FIG00527748 FIG00527751: hypothetical protein +FIG00527759 FIG00527762: hypothetical protein +FIG00527762 FIG00527763: hypothetical protein +FIG00527766 FIG00527767: hypothetical protein +FIG00527767 phage-like element pbsx protein XkdT +FIG00527775 FIG00527777: hypothetical protein +FIG00527781 FIG00527782: hypothetical protein +FIG00527782 FIG00527789: hypothetical protein +FIG00527790 FIG00527791: hypothetical protein +FIG00527795 FIG00527799: hypothetical protein +FIG00527799 FIG00527805: hypothetical protein +FIG00527805 FIG00527813: hypothetical protein +FIG00527821 FIG00527824: hypothetical protein +FIG00527824 acetobutylicum phosphotransbutyrylase BH3707 +FIG00527844 FIG00527850: hypothetical protein +FIG00527850 putative Na+/H+ exchanger +FIG00527874 FIG00527877: hypothetical protein +FIG00527877 FIG00527882: hypothetical protein +FIG00527894 FIG00527897: hypothetical protein +FIG00527897 FIG00527899: hypothetical protein +FIG00527906 FIG00527910: hypothetical protein +FIG00527910 FIG00527911: hypothetical protein +FIG00527911 FIG00527914: hypothetical protein +FIG00527914 FIG00527916: hypothetical protein +FIG00527928 FIG00527929: hypothetical protein +FIG00527938 FIG00527942: hypothetical protein +FIG00527949 FIG00527950: hypothetical protein +FIG00527950 FIG00527951: hypothetical protein +FIG00527956 FIG00527957: hypothetical protein +FIG00527957 FIG00527959: hypothetical protein +FIG00527968 FIG00527973: hypothetical protein +FIG00527991 FIG00527992: hypothetical protein +FIG00527992 Uncharacterized conserved membrane protein, similar to MDR (VANZ) ORF of Enterococcus +FIG00527996 oxaloacetate decarboxylase +FIG00528000 FIG00528002: hypothetical protein +FIG00528002 FIG00528003: hypothetical protein +FIG00528014 FIG00528015: hypothetical protein +FIG00528015 FIG00528017: hypothetical protein +FIG00528017 FIG00528019: hypothetical protein +FIG00528019 FIG00528021: hypothetical protein +FIG00528021 dihydropteroate synthase, putative +FIG00528029 FIG00528030: hypothetical protein +FIG00528030 FIG00528031: hypothetical protein +FIG00528033 FIG00528037: hypothetical protein +FIG00528037 FIG00528041: hypothetical protein +FIG00528046 FIG00528047: hypothetical protein +FIG00528048 FIG00528049: hypothetical protein +FIG00528049 bacteriocin ABC transporter, bacteriocin-binding protein, putative +FIG00528053 FIG00528054: hypothetical protein +FIG00528054 CARBOXYLIC ESTER HYDROLASE( EC:3.1.1.- ) +FIG00528061 FIG00528062: hypothetical protein +FIG00528069 Probable 2-phosphosulfolactate phosphatase (EC 3.1.3.71) +FIG00528070 FIG00528076: hypothetical protein +FIG00528079 FIG00528082: hypothetical protein +FIG00528085 FIG00528086: hypothetical protein +FIG00528088 FIG00528090: hypothetical protein +FIG00528090 FIG00528095: hypothetical protein +FIG00528097 FIG00528102: hypothetical protein +FIG00528102 FIG00528106: hypothetical protein +FIG00528106 FIG00528111: hypothetical protein +FIG00528117 FIG00528118: hypothetical protein +FIG00528118 FIG00528119: hypothetical protein +FIG00528121 FIG00528122: hypothetical protein +FIG00528122 FIG00528124: hypothetical protein +FIG00528127 FIG00528132: hypothetical protein +FIG00528132 FIG00528142: hypothetical protein +FIG00528146 FIG00528147: hypothetical protein +FIG00528148 FIG00528152: hypothetical protein +FIG00528165 FIG00528167: hypothetical protein +FIG00528178 fimbrial assembly protein +FIG00528191 FIG00528192: hypothetical protein +FIG00528197 ABC transporter component-like protein +FIG00528202 mobilization protein Mob 14-3 +FIG00528207 FIG00528208: hypothetical protein +FIG00528208 FIG00528212: hypothetical protein +FIG00528212 FIG00528213: hypothetical protein +FIG00528220 FIG00528222: hypothetical protein +FIG00528235 FIG00528237: hypothetical protein +FIG00528241 FIG00528242: hypothetical protein +FIG00528242 FIG00528247: hypothetical protein +FIG00528247 CRISPR-associated protein Cas5 +FIG00528249 FIG00528250: hypothetical protein +FIG00528265 FIG00528278: hypothetical protein +FIG00528278 glycosyl transferase, group 2 family protein, putative +FIG00528280 FIG00528281: hypothetical protein +FIG00528283 Early transcription factor 70 kDa subunit (VETF small subunit) , putative +FIG00528284 FIG00528285: hypothetical protein +FIG00528287 FIG00528289: hypothetical protein +FIG00528292 FIG00528293: hypothetical protein +FIG00528296 FIG00528300: hypothetical protein +FIG00528300 FIG00528308: hypothetical protein +FIG00528308 FIG00528313: hypothetical protein +FIG00528339 FIG00528340: hypothetical protein +FIG00528351 FIG00528354: hypothetical protein +FIG00528356 FIG00528359: hypothetical protein +FIG00528359 FIG00528361: hypothetical protein +FIG00528364 FIG00528365: hypothetical protein +FIG00528368 FIG00528375: hypothetical protein +FIG00528381 putative Cof-like hydrolase +FIG00528383 FIG00528385: hypothetical protein +FIG00528392 FIG00528393: hypothetical protein +FIG00528397 FIG00528398: hypothetical protein +FIG00528398 FIG00528402: hypothetical protein +FIG00528406 FIG00528407: hypothetical protein +FIG00528407 FIG00528409: hypothetical protein +FIG00528410 FIG00528411: hypothetical protein +FIG00528411 Tryptophan-rich possible sensory protein, TSPO homolog +FIG00528423 FIG00528428: hypothetical protein +FIG00528446 Permease MDR type +FIG00528447 FIG00528453: hypothetical protein +FIG00528454 FIG00528455: hypothetical protein +FIG00528465 FIG00528466: hypothetical protein +FIG00528480 FIG00528484: hypothetical protein +FIG00528484 FIG00528489: hypothetical protein +FIG00528495 FIG00627334: hypothetical protein +FIG00528497 FIG00528498: hypothetical protein +FIG00528505 FIG00528507: hypothetical protein +FIG00528507 FIG00528508: hypothetical protein +FIG00528508 FIG00528509: hypothetical protein +FIG00528509 FIG00528512: hypothetical protein +FIG00528518 FIG00528519: hypothetical protein +FIG00528519 FIG00528520: hypothetical protein +FIG00528532 FIG00528534: hypothetical protein +FIG00528534 FIG00528538: hypothetical protein +FIG00528538 FIG00528540: hypothetical protein +FIG00528540 FIG00528541: hypothetical protein +FIG00528541 FIG00528546: hypothetical protein +FIG00528548 FIG00528550: hypothetical protein +FIG00528550 FIG00528552: hypothetical protein +FIG00528560 FIG00528563: hypothetical protein +FIG00528563 FIG00528570: hypothetical protein +FIG00528570 FIG00528571: hypothetical protein +FIG00528574 FIG00528579: hypothetical protein +FIG00528579 FIG00528582: hypothetical protein +FIG00528582 XkdK +FIG00528603 FIG00528606: hypothetical protein +FIG00528620 FIG00528626: hypothetical protein +FIG00528626 FIG00528630: hypothetical protein +FIG00528630 regulatory proteins, AsnC/Lrp +FIG00528641 FIG00528647: hypothetical protein +FIG00528648 integral membrane sensor signal transduction histidine kinase +FIG00528658 FIG00528662: hypothetical protein +FIG00528664 FIG00528665: hypothetical protein +FIG00528665 FIG00528671: hypothetical protein +FIG00528671 FIG00528672: hypothetical protein +FIG00528672 FIG00528673: hypothetical protein +FIG00528673 FIG00528678: hypothetical protein +FIG00528678 FIG00528682: hypothetical protein +FIG00528682 membrane associated peptidase +FIG00528693 putative GtrA family protein +FIG00528707 FIG00528709: hypothetical protein +FIG00528709 FIG00528713: hypothetical protein +FIG00528717 FIG00528720: hypothetical protein +FIG00528720 FIG00528724: hypothetical protein +FIG00528735 FIG00528736: hypothetical protein +FIG00528736 FIG00528742: hypothetical protein +FIG00528744 FIG00528745: hypothetical protein +FIG00528745 FIG00528749: hypothetical protein +FIG00528757 DNA repair protein RAD50, putative +FIG00528759 FIG00528760: hypothetical protein +FIG00528760 FIG00528761: hypothetical protein +FIG00528761 FIG00528766: hypothetical protein +FIG00528770 FIG00528779: hypothetical protein +FIG00528780 FIG00528782: hypothetical protein +FIG00528795 FIG00528796: hypothetical protein +FIG00528799 colossin A +FIG00528800 FIG00528801: hypothetical protein +FIG00528801 FIG00528804: hypothetical protein +FIG00528804 FIG00528809: hypothetical protein +FIG00528822 conserved protein, tetratricopeptide repeat family protein +FIG00528830 FIG00528832: hypothetical protein +FIG00528840 FIG00528842: hypothetical protein +FIG00528844 FIG00528845: hypothetical protein +FIG00528845 FIG00528847: hypothetical protein +FIG00528847 hypothetical protein +FIG00528872 FIG00528876: hypothetical protein +FIG00528876 FIG00528880: hypothetical protein +FIG00528880 GntR domain protein +FIG00528886 FIG00528887: hypothetical protein +FIG00528887 FIG00528888: hypothetical protein +FIG00528897 FIG00528901: hypothetical protein +FIG00528903 FIG00528913: hypothetical protein +FIG00528913 FIG00528918: hypothetical protein +FIG00528918 FIG00528920: hypothetical protein +FIG00528920 FIG00528924: hypothetical protein +FIG00528927 FIG00528932: hypothetical protein +FIG00528932 FIG00528933: hypothetical protein +FIG00528939 FIG00528941: hypothetical protein +FIG00528944 FIG00528952: hypothetical protein +FIG00528963 FIG00528967: hypothetical protein +FIG00528973 FIG00528978: hypothetical protein +FIG00528978 FIG00528980: hypothetical protein +FIG00528988 FIG00528989: hypothetical protein +FIG00528989 FIG00528991: hypothetical protein +FIG00528991 methyl-accepting chemotaxis protein (MCP) signaling domain +FIG00529005 FIG00529006: hypothetical protein +FIG00529007 FIG00529008: hypothetical protein +FIG00529008 FIG00529010: hypothetical protein +FIG00529010 FIG00529012: hypothetical protein +FIG00529012 FIG00529014: hypothetical protein +FIG00529016 FIG00529018: hypothetical protein +FIG00529018 FIG00529019: hypothetical protein +FIG00529031 FIG00529032: hypothetical protein +FIG00529037 ABC-type iron(III)-siderophore transport system, ATPase component +FIG00529048 FIG00529051: hypothetical protein +FIG00529056 FIG00529061: hypothetical protein +FIG00529061 FIG00529064: hypothetical protein +FIG00529078 FIG00529083: hypothetical protein +FIG00529084 FIG00529086: hypothetical protein +FIG00529091 FIG00529095: hypothetical protein +FIG00529097 FIG00529104: hypothetical protein +FIG00529119 FIG00529129: hypothetical protein +FIG00529157 FIG00529158: hypothetical protein +FIG00529158 FIG00529162: hypothetical protein +FIG00529162 FIG00529163: hypothetical protein +FIG00529165 Type II restriction enzyme, methylase subunit +FIG00529177 FIG00529180: hypothetical protein +FIG00529180 FIG00529186: hypothetical protein +FIG00529186 Transmembrane component SCO2323 of energizing module of predicted cobalamin ECF transporter +FIG00529189 FIG00529190: hypothetical protein +FIG00529190 FIG00529197: hypothetical protein +FIG00529197 FIG00529200: hypothetical protein +FIG00529201 FIG00529202: hypothetical protein +FIG00529202 FIG00529204: hypothetical protein +FIG00529204 FIG00529206: hypothetical protein +FIG00529207 Transcriptional regulator, FadR family +FIG00529223 FIG00529226: hypothetical protein +FIG00529228 FIG00529230: hypothetical protein +FIG00529231 FIG00529235: hypothetical protein +FIG00529249 FIG00529250: hypothetical protein +FIG00529250 FIG00529255: hypothetical protein +FIG00529255 FIG00529258: hypothetical protein +FIG00529266 FIG00529267: hypothetical protein +FIG00529267 FIG00529268: hypothetical protein +FIG00529269 FIG00529272: hypothetical protein +FIG00529272 FIG00529277: hypothetical protein +FIG00529277 FIG00529288: hypothetical protein +FIG00529288 FIG00529298: hypothetical protein +FIG00529302 FIG00529305: hypothetical protein +FIG00529305 FIG00529307: hypothetical protein +FIG00529307 FIG00529309: hypothetical protein +FIG00529312 FIG00529317: hypothetical protein +FIG00529323 FIG00529325: hypothetical protein +FIG00529325 FIG00529327: hypothetical protein +FIG00529329 FIG00529337: hypothetical protein +FIG00529341 FIG00529342: hypothetical protein +FIG00529344 FIG00529346: hypothetical protein +FIG00529346 FIG00529348: hypothetical protein +FIG00529348 Hydrolase, haloacid dehalogenase-like family +FIG00529350 FIG00529352: hypothetical protein +FIG00529352 Putative regulatory protein malR +FIG00529358 FIG00529360: hypothetical protein +FIG00529364 FIG00529366: hypothetical protein +FIG00529366 FIG01249700: hypothetical protein +FIG00529373 membrane-anchored cell surface protein +FIG00529379 FIG00529380: hypothetical protein +FIG00529385 FIG00529387: hypothetical protein +FIG00529387 FIG00529395: hypothetical protein +FIG00529397 FIG00529400: hypothetical protein +FIG00529401 FIG01116244: hypothetical protein +FIG00529403 Spore germination protein KA +FIG00529409 FIG00529411: hypothetical protein +FIG00529417 FIG00529422: hypothetical protein +FIG00529423 FIG00529424: hypothetical protein +FIG00529424 FIG00529435: hypothetical protein +FIG00529437 FIG00529444: hypothetical protein +FIG00529446 FIG00529448: hypothetical protein +FIG00529448 FIG00529454: hypothetical protein +FIG00529454 FIG00529455: hypothetical protein +FIG00529463 FIG00529464: hypothetical protein +FIG00529472 FIG00529475: hypothetical protein +FIG00529487 FIG00529490: hypothetical protein +FIG00529490 FIG00529493: hypothetical protein +FIG00529493 FIG00529495: hypothetical protein +FIG00529495 FIG00529496: hypothetical protein +FIG00529496 FIG00529500: hypothetical protein +FIG00529501 protein of unknown function DUF291 +FIG00529503 FIG00529508: hypothetical protein +FIG00529512 FIG00529513: hypothetical protein +FIG00529519 FIG00529524: hypothetical protein +FIG00529530 FIG00529532: hypothetical protein +FIG00529536 FIG00529537: hypothetical protein +FIG00529537 FIG00529539: hypothetical protein +FIG00529539 FIG00529540: hypothetical protein +FIG00529549 FIG00529554: hypothetical protein +FIG00529559 FIG00529560: hypothetical protein +FIG00529576 FIG00529577: hypothetical protein +FIG00529577 FIG00529579: hypothetical protein +FIG00529595 FIG00529597: hypothetical protein +FIG00529597 FIG00529601: hypothetical protein +FIG00529601 FIG00529603: hypothetical protein +FIG00529605 Predicted phosphohydrolase, Icc family +FIG00529606 FIG00529608: hypothetical protein +FIG00529612 FIG00529613: hypothetical protein +FIG00529613 Apo-citrate lyase phosphoribosyl-dephospho-CoA transferase( EC:2.7.7.- ) +FIG00529617 FIG00529619: hypothetical protein +FIG00529619 FIG00529622: hypothetical protein +FIG00529624 FIG00529626: hypothetical protein +FIG00529626 FIG00529629: hypothetical protein +FIG00529629 FIG00529630: hypothetical protein +FIG00529642 FIG00529650: hypothetical protein +FIG00529650 FIG00529654: hypothetical protein +FIG00529654 FIG00529655: hypothetical protein +FIG00529667 FIG00529669: hypothetical protein +FIG00529669 FIG00529671: hypothetical protein +FIG00529687 FIG00529688: hypothetical protein +FIG00529688 FIG00529692: hypothetical protein +FIG00529697 FIG00529703: hypothetical protein +FIG00529703 FIG00529707: hypothetical protein +FIG00529719 FIG00529721: hypothetical protein +FIG00529730 FIG00529733: hypothetical protein +FIG00529733 FIG00529737: hypothetical protein +FIG00529737 FIG00529738: hypothetical protein +FIG00529748 FIG00529752: hypothetical protein +FIG00529754 N-terminal fragment of elongation factor Ts +FIG00529759 FIG00529761: hypothetical protein +FIG00529772 FIG00529776: hypothetical protein +FIG00529776 FIG00529785: hypothetical protein +FIG00529794 FIG00529796: hypothetical protein +FIG00529796 FIG00529799: hypothetical protein +FIG00529810 FIG00529811: hypothetical protein +FIG00529811 FIG00529813: hypothetical protein +FIG00529813 FIG00529814: hypothetical protein +FIG00529814 conserved protein, putative metal-dependent peptidase +FIG00529834 FIG00529837: hypothetical protein +FIG00529838 FIG00529844: hypothetical protein +FIG00529844 FIG00529845: hypothetical protein +FIG00529849 FIG00529850: hypothetical protein +FIG00529850 FIG00529853: hypothetical protein +FIG00529855 FIG00529859: hypothetical protein +FIG00529859 FIG00529861: hypothetical protein +FIG00529861 FIG00529869: hypothetical protein +FIG00529869 FIG00529870: hypothetical protein +FIG00529884 FIG00529887: hypothetical protein +FIG00529894 FIG00529900: hypothetical protein +FIG00529900 Predicted transporter protein +FIG00529916 FIG00529918: hypothetical protein +FIG00529933 FIG00529939: hypothetical protein +FIG00529953 N-terminal HKD family nuclease fused to DNA/RNA helicases of superfamily II,conserved in Streptomyces +FIG00529954 FIG00529957: hypothetical protein +FIG00529957 FIG00529963: hypothetical protein +FIG00529967 Protein hypA +FIG00529984 FIG00529987: hypothetical protein +FIG00529987 FIG00529990: hypothetical protein +FIG00530000 FIG00530003: hypothetical protein +FIG00530010 FIG00530013: hypothetical protein +FIG00530029 FIG00530031: hypothetical protein +FIG00530031 FIG00530032: hypothetical protein +FIG00530036 FIG00530037: hypothetical protein +FIG00530042 FIG00530045: hypothetical protein +FIG00530045 FIG00530048: hypothetical protein +FIG00530048 FIG00530049: hypothetical protein +FIG00530049 FIG00530058: hypothetical protein +FIG00530072 FIG00530073: hypothetical protein +FIG00530073 FIG00530085: hypothetical protein +FIG00530092 FIG00530104: hypothetical protein +FIG00530104 FIG00530106: hypothetical protein +FIG00530136 FIG00530138: hypothetical protein +FIG00530142 FIG00530144: hypothetical protein +FIG00530157 FIG00530160: hypothetical protein +FIG00530163 UPF0237 protein MJ1558 +FIG00530164 FIG00530167: hypothetical protein +FIG00530167 FIG00530173: hypothetical protein +FIG00530173 FIG00530179: hypothetical protein +FIG00530179 FIG00530185: hypothetical protein +FIG00530185 FIG00530188: hypothetical protein +FIG00530199 FIG00530200: hypothetical protein +FIG00530207 FIG00530210: hypothetical protein +FIG00530210 FIG00530211: hypothetical protein +FIG00530211 FIG00530213: hypothetical protein +FIG00530222 FIG00530223: hypothetical protein +FIG00530254 FIG00530257: hypothetical protein +FIG00530270 FIG00530272: hypothetical protein +FIG00530275 FIG00530276: hypothetical protein +FIG00530278 FIG00530280: hypothetical protein +FIG00530281 FIG00530282: hypothetical protein +FIG00530298 FIG00530302: hypothetical protein +FIG00530310 FIG00530311: hypothetical protein +FIG00530311 FIG00530313: hypothetical protein +FIG00530313 FIG00530321: hypothetical protein +FIG00530321 FIG00530334: hypothetical protein +FIG00530334 FIG00530336: hypothetical protein +FIG00530350 FIG00530351: hypothetical protein +FIG00530351 FIG00530355: hypothetical protein +FIG00530355 FIG00530357: hypothetical protein +FIG00530357 Possible surface protein, responsible for cell interaction; contains cell adhesion domain and ChW-repeats +FIG00530358 FIG00530360: hypothetical protein +FIG00530360 DUF324 domain-containing protein +FIG00530370 FIG00530374: hypothetical protein +FIG00530390 FIG00530395: hypothetical protein +FIG00530395 FIG00530404: hypothetical protein +FIG00530404 FIG00530407: hypothetical protein +FIG00530407 FIG00530410: hypothetical protein +FIG00530413 FIG00530414: hypothetical protein +FIG00530423 FIG00530426: hypothetical protein +FIG00530426 FIG00530430: hypothetical protein +FIG00530430 Methyl-accepting chemotaxis protein, contain HAMP domain +FIG00530454 FIG00530459: hypothetical protein +FIG00530464 FIG00531956: hypothetical protein +FIG00530465 FIG00530467: hypothetical protein +FIG00530475 FIG00530479: hypothetical protein +FIG00530479 FIG00530485: hypothetical protein +FIG00530485 FIG00530486: hypothetical protein +FIG00530486 FIG00530506: hypothetical protein +FIG00530520 FIG00530521: hypothetical protein +FIG00530521 FIG00530523: hypothetical protein +FIG00530534 putative nucleoside-diphosphate sugar epimerase +FIG00530535 FIG00530536: hypothetical protein +FIG00530539 FIG00530541: hypothetical protein +FIG00530547 FIG00530550: hypothetical protein +FIG00530555 Nitrogenase subunit NifH paralog, type 2 +FIG00530563 FIG00530569: hypothetical protein +FIG00530569 FIG00530572: hypothetical protein +FIG00530576 FIG00530578: hypothetical protein +FIG00530578 FIG00530580: hypothetical protein +FIG00530580 FIG00530588: hypothetical protein +FIG00530588 FIG00530593: hypothetical protein +FIG00530598 FIG00530600: hypothetical protein +FIG00530608 FIG00530612: hypothetical protein +FIG00530621 FIG00530622: hypothetical protein +FIG00530622 FIG00530623: hypothetical protein +FIG00530635 FIG00530639: hypothetical protein +FIG00530639 FIG00530641: hypothetical protein +FIG00530641 FIG00530648: hypothetical protein +FIG00530648 FIG00530652: hypothetical protein +FIG00530656 FIG00530661: hypothetical protein +FIG00530664 FIG00530675: hypothetical protein +FIG00530675 FIG00530680: hypothetical protein +FIG00530694 Colicin E2 tolerance protein CbrC-like protein +FIG00530700 FIG00530704: hypothetical protein +FIG00530704 Transcriptional regulator, MarR family protein +FIG00530713 putative iron complex transport system substrate-binding protein +FIG00530720 FIG00530721: hypothetical protein +FIG00530736 FIG00627540: hypothetical protein +FIG00530741 FIG00530742: hypothetical protein +FIG00530748 FIG00530760: hypothetical protein +FIG00530760 FIG00530762: hypothetical protein +FIG00530762 FIG00530763: hypothetical protein +FIG00530763 FIG00530766: hypothetical protein +FIG00530786 putative Holliday junction resolvase +FIG00530792 FIG00530794: hypothetical protein +FIG00530794 FIG00530795: hypothetical protein +FIG00530795 FIG00530801: hypothetical protein +FIG00530817 FIG00530821: hypothetical protein +FIG00530821 FIG00530822: hypothetical protein +FIG00530831 FIG00530840: hypothetical protein +FIG00530844 FIG00530847: hypothetical protein +FIG00530847 FIG00530849: hypothetical protein +FIG00530855 FIG00530857: hypothetical protein +FIG00530859 Gll3979 protein +FIG00530867 FIG00530870: hypothetical protein +FIG00530872 FIG00530877: hypothetical protein +FIG00530880 FIG00530881: hypothetical protein +FIG00530881 FIG00530883: hypothetical protein +FIG00530887 FIG00530894: hypothetical protein +FIG00530895 FIG00530897: hypothetical protein +FIG00530900 FIG00530901: hypothetical protein +FIG00530901 FIG00530903: hypothetical protein +FIG00530921 FIG00530923: hypothetical protein +FIG00530923 FIG00530925: hypothetical protein +FIG00530938 FIG00530940: hypothetical protein +FIG00530940 FIG00530950: hypothetical protein +FIG00530972 FIG00530973: hypothetical protein +FIG00530982 FIG00530987: hypothetical protein +FIG00530991 FIG00530992: hypothetical protein +FIG00530995 FIG00530998: hypothetical protein +FIG00530998 FIG00531006: hypothetical protein +FIG00531018 FIG00531023: hypothetical protein +FIG00531023 FIG00531025: hypothetical protein +FIG00531029 FIG00531030: hypothetical protein +FIG00531033 FIG00531039: hypothetical protein +FIG00531039 FIG00531040: hypothetical protein +FIG00531059 FIG00531086: hypothetical protein +FIG00531086 main capsid protein Gp34 +FIG00531090 FIG00531098: hypothetical protein +FIG00531101 FIG00531118: hypothetical protein +FIG00531118 FIG00531124: hypothetical protein +FIG00531124 FIG00531128: hypothetical protein +FIG00531130 FIG00531131: hypothetical protein +FIG00531131 sodium transporter family protein +FIG00531134 Ribosomal RNA large subunit methyltransferase A (EC 2.1.1.51) +FIG00531145 FIG00531150: hypothetical protein +FIG00531165 FIG00531177: hypothetical protein +FIG00531177 no significant homology. +FIG00531181 FIG00531184: hypothetical protein +FIG00531194 FIG00531197: hypothetical protein +FIG00531197 FIG00531199: hypothetical protein +FIG00531199 FIG00531200: hypothetical protein +FIG00531204 putative nucleotidyl transferase +FIG00531208 FIG00531210: hypothetical protein +FIG00531212 FIG00531215: hypothetical protein +FIG00531215 Carbohydrate kinase, PfkB +FIG00531217 FIG00531219: hypothetical protein +FIG00531219 FIG00531224: hypothetical protein +FIG00531230 Small protein similar to cysteinyl-tRNA synthetase +FIG00531231 FIG00531232: hypothetical protein +FIG00531232 FIG00531239: hypothetical protein +FIG00531239 FIG00531240: hypothetical protein +FIG00531240 FIG00531246: hypothetical protein +FIG00531248 FIG00531260: hypothetical protein +FIG00531260 DEAD/DEAH box helicase, N-terminal +FIG00531268 FIG00531272: hypothetical protein +FIG00531289 FIG00531290: hypothetical protein +FIG00531295 FIG01117483: hypothetical protein +FIG00531312 FIG00531316: hypothetical protein +FIG00531316 FIG00531325: hypothetical protein +FIG00531325 FIG00531331: hypothetical protein +FIG00531356 FIG00531359: hypothetical protein +FIG00531362 FIG00531364: hypothetical protein +FIG00531377 FIG00531379: hypothetical protein +FIG00531379 glycoside hydrolase, family 9 +FIG00531384 FIG00531386: hypothetical protein +FIG00531386 FIG00531387: hypothetical protein +FIG00531400 Rhamnosyl transferase, rfbQ +FIG00531423 FIG00531427: hypothetical protein +FIG00531434 FIG00531435: hypothetical protein +FIG00531435 FIG00531439: hypothetical protein +FIG00531442 FIG00531449: hypothetical protein +FIG00531449 FIG00531454: hypothetical protein +FIG00531455 FIG00531456: hypothetical protein +FIG00531460 FIG00531461: hypothetical protein +FIG00531485 FIG00531493: hypothetical protein +FIG00531493 FIG00531496: hypothetical protein +FIG00531500 FIG00531504: hypothetical protein +FIG00531508 FIG00531517: hypothetical protein +FIG00531517 Protein, probably involved in Fe2+ transport +FIG00531520 FIG00531523: hypothetical protein +FIG00531523 FIG00531527: hypothetical protein +FIG00531552 FIG00531553: hypothetical protein +FIG00531558 FIG00531559: hypothetical protein +FIG00531565 FIG00531568: hypothetical protein +FIG00531586 FIG00531589: hypothetical protein +FIG00531603 FIG00531610: hypothetical protein +FIG00531652 FIG00531653: hypothetical protein +FIG00531657 FIG00531658: hypothetical protein +FIG00531680 FIG00531683: hypothetical protein +FIG00531685 FIG00531690: hypothetical protein +FIG00531693 FIG00531698: hypothetical protein +FIG00531701 FIG00531703: hypothetical protein +FIG00531725 FIG00531731: hypothetical protein +FIG00531758 FIG00531760: hypothetical protein +FIG00531778 Sensor histidine kinase HpkA +FIG00531779 FIG00531783: hypothetical protein +FIG00531783 FIG00531785: hypothetical protein +FIG00531788 FIG00531789: hypothetical protein +FIG00531789 FIG00531796: hypothetical protein +FIG00531796 FIG00531799: hypothetical protein +FIG00531801 FIG00531807: hypothetical protein +FIG00531814 FIG00531816: hypothetical protein +FIG00531822 Membrane-associated sensory histidine kinase-like ATPase +FIG00531835 FIG00531844: hypothetical protein +FIG00531849 FIG00531853: hypothetical protein +FIG00531869 FIG00531873: hypothetical protein +FIG00531873 hypothetical protein +FIG00531892 FIG00531894: hypothetical protein +FIG00531894 FIG00531895: hypothetical protein +FIG00531895 FIG00531897: hypothetical protein +FIG00531917 FIG00531922: hypothetical protein +FIG00531922 FIG00531923: hypothetical protein +FIG00531927 putative LysM domain +FIG00531933 FIG00531935: hypothetical protein +FIG00531945 FIG00531946: hypothetical protein +FIG00531956 FIG00531959: hypothetical protein +FIG00531959 FIG00531960: hypothetical protein +FIG00531963 FIG00531965: hypothetical protein +FIG00531965 FIG00531969: hypothetical protein +FIG00531989 FIG00531991: hypothetical protein +FIG00531998 FIG00532000: hypothetical protein +FIG00532001 FIG00532008: hypothetical protein +FIG00532014 FIG00532015: hypothetical protein +FIG00532015 FIG00532018: hypothetical protein +FIG00532039 FIG00532040: hypothetical protein +FIG00532043 FIG00532044: hypothetical protein +FIG00532045 FIG00532057: hypothetical protein +FIG00532057 FIG00532063: hypothetical protein +FIG00532066 FIG00532067: hypothetical protein +FIG00532068 FIG00532071: hypothetical protein +FIG00532071 FIG00532072: hypothetical protein +FIG00532072 FIG00532074: hypothetical protein +FIG00532074 FIG00532079: hypothetical protein +FIG00532093 FIG00532096: hypothetical protein +FIG00532099 Response regulators consisting of a CheY-like receiver domain and an HD-GYP domain +FIG00532100 FIG00532106: hypothetical protein +FIG00532110 FIG00532113: hypothetical protein +FIG00532124 FIG00532132: hypothetical protein +FIG00532133 FIG00532151: hypothetical protein +FIG00532151 FIG00532152: hypothetical protein +FIG00532175 FIG00532178: hypothetical protein +FIG00532178 Membrane assosiated methyl-accepting chemotaxis protein with HAMP domain +FIG00532186 FIG00532195: hypothetical protein +FIG00532202 FIG00532203: hypothetical protein +FIG00532203 FIG00532208: hypothetical protein +FIG00532209 FIG00532211: hypothetical protein +FIG00532211 FIG00532212: hypothetical protein +FIG00532212 FIG00532226: hypothetical protein +FIG00532226 FIG00532237: hypothetical protein +FIG00532237 FIG00532239: hypothetical protein +FIG00532253 FIG00532259: hypothetical protein +FIG00532296 FIG00532303: hypothetical protein +FIG00532311 FIG00532314: hypothetical protein +FIG00532314 FIG00532315: hypothetical protein +FIG00532333 FIG00532334: hypothetical protein +FIG00532337 FIG00532344: hypothetical protein +FIG00532354 FIG00532360: hypothetical protein +FIG00532370 FIG00532372: hypothetical protein +FIG00532372 FIG00532374: hypothetical protein +FIG00532374 FIG00532376: hypothetical protein +FIG00532389 FIG00532392: hypothetical protein +FIG00532392 FIG00645333: hypothetical protein +FIG00532396 FIG00532398: hypothetical protein +FIG00532432 FIG00532433: hypothetical protein +FIG00532433 FIG00532439: hypothetical protein +FIG00532443 ABC Transporter, ATP-binding protein +FIG00532447 FIG00532455: hypothetical protein +FIG00532455 FIG00532458: hypothetical protein +FIG00532501 FIG00532502: hypothetical protein +FIG00532502 FIG00532507: hypothetical protein +FIG00532515 FIG00532516: hypothetical protein +FIG00532516 FIG00532517: hypothetical protein +FIG00532519 FIG00532522: hypothetical protein +FIG00532522 FIG00532523: hypothetical protein +FIG00532537 FIG00532538: hypothetical protein +FIG00532538 FIG00532541: hypothetical protein +FIG00532541 FIG00532547: hypothetical protein +FIG00532547 FIG00532550: hypothetical protein +FIG00532550 FIG00532552: hypothetical protein +FIG00532552 FIG00532555: hypothetical protein +FIG00532555 FIG00532556: hypothetical protein +FIG00532568 FIG00532571: hypothetical protein +FIG00532585 FIG00532594: hypothetical protein +FIG00532599 FIG00532600: hypothetical protein +FIG00532608 FIG00532614: hypothetical protein +FIG00532616 Repressor +FIG00532621 FIG00532622: hypothetical protein +FIG00532625 FIG00532627: hypothetical protein +FIG00532627 FIG00532630: hypothetical protein +FIG00532630 FIG00532632: hypothetical protein +FIG00532638 FIG00532642: hypothetical protein +FIG00532642 FIG00532644: hypothetical protein +FIG00532671 FIG00532678: hypothetical protein +FIG00532678 FIG00532682: hypothetical protein +FIG00532682 FIG00532685: hypothetical protein +FIG00532689 FIG00532693: hypothetical protein +FIG00532698 FIG00523076: hypothetical protein +FIG00532708 protein of unknown function DUF1602 +FIG00532709 spore cortex-lytic enzyme, pre-pro-form +FIG00532711 FIG00532713: hypothetical protein +FIG00532736 FIG00532741: hypothetical protein +FIG00532747 FIG00532748: hypothetical protein +FIG00532748 FIG00532752: hypothetical protein +FIG00532752 FIG00532760: hypothetical protein +FIG00532769 FIG00532773: hypothetical protein +FIG00532777 FIG00532779: hypothetical protein +FIG00532782 FIG00532788: hypothetical protein +FIG00532788 FIG00532797: hypothetical protein +FIG00532805 FIG00532806: hypothetical protein +FIG00532821 FIG00532823: hypothetical protein +FIG00532830 FIG00532839: hypothetical protein +FIG00532839 TrsK-like protein +FIG00532840 FIG00532845: hypothetical protein +FIG00532848 FIG00532849: hypothetical protein +FIG00532849 Endoglucanase Z precursor +FIG00532850 FIG00532853: hypothetical protein +FIG00532857 FIG00532861: hypothetical protein +FIG00532867 FIG00532870: hypothetical protein +FIG00532870 FIG00532871: hypothetical protein +FIG00532871 Zinc-transporting ATPase( EC:3.6.1.- ) +FIG00532908 FIG00532912: hypothetical protein +FIG00532913 putative ABC-transporter transport protein +FIG00532914 FIG00532919: hypothetical protein +FIG00532936 FIG00532938: hypothetical protein +FIG00532946 FIG00532949: hypothetical protein +FIG00532949 FIG00532954: hypothetical protein +FIG00532954 FIG00532955: hypothetical protein +FIG00532957 FIG00532959: hypothetical protein +FIG00532959 Na+-driven multidrug efflux pump (MATE family), NorM +FIG00532987 phage minor capsid protein +FIG00532995 FIG00533005: hypothetical protein +FIG00533009 FIG00533022: hypothetical protein +FIG00533030 FIG00533035: hypothetical protein +FIG00533044 FIG00533048: hypothetical protein +FIG00533065 putative transport system permease ABC transporter protein +FIG00533081 FIG00533082: hypothetical protein +FIG00533090 FIG00533093: hypothetical protein +FIG00533097 FIG00533099: hypothetical protein +FIG00533106 FIG00533107: hypothetical protein +FIG00533112 FIG00533114: hypothetical protein +FIG00533120 FIG00533121: hypothetical protein +FIG00533121 FIG00533131: hypothetical protein +FIG00533136 FIG00533137: hypothetical protein +FIG00533137 FIG00533141: hypothetical protein +FIG00533141 FIG00533143: hypothetical protein +FIG00533145 FIG00533151: hypothetical protein +FIG00533164 FIG00533167: hypothetical protein +FIG00533167 Putative 4-Cys ferredoxin +FIG00533180 FIG00533182: hypothetical protein +FIG00533184 FIG00533185: hypothetical protein +FIG00533185 FIG00533189: hypothetical protein +FIG00533189 FIG00533196: hypothetical protein +FIG00533204 FIG00533215: hypothetical protein +FIG00533218 FIG00533221: hypothetical protein +FIG00533221 FIG00533233: hypothetical protein +FIG00533233 FIG00533235: hypothetical protein +FIG00533235 FIG00627241: hypothetical protein +FIG00533239 FIG00533240: hypothetical protein +FIG00533259 FIG00533262: hypothetical protein +FIG00533292 FIG00533296: hypothetical protein +FIG00533297 FIG00533300: hypothetical protein +FIG00533300 FIG00533301: hypothetical protein +FIG00533318 Protein containing a domain related to multimeric flavodoxin WrbA family +FIG00533322 conserved protein with patatin domain +FIG00533327 FIG00533332: hypothetical protein +FIG00533335 FIG00533336: hypothetical protein +FIG00533348 FIG00533350: hypothetical protein +FIG00533350 FIG00533351: hypothetical protein +FIG00533365 FIG00533367: hypothetical protein +FIG00533369 FIG00533370: hypothetical protein +FIG00533398 FIG00533403: hypothetical protein +FIG00533422 FIG00533423: hypothetical protein +FIG00533426 FIG00533442: hypothetical protein +FIG00533467 FIG00533483: hypothetical protein +FIG00533500 FIG00533502: hypothetical protein +FIG00533508 FIG00533509: hypothetical protein +FIG00533518 FIG00533522: hypothetical protein +FIG00533532 FIG00533536: hypothetical protein +FIG00533541 FIG00533549: hypothetical protein +FIG00533574 FIG00533576: hypothetical protein +FIG00533604 FIG00533605: hypothetical protein +FIG00533605 FIG00533611: hypothetical protein +FIG00533642 FIG00530012: hypothetical protein +FIG00533647 Uncharacterized protein, ortholog of Thermotoga (4980645) +FIG00533717 FIG00533719: hypothetical protein +FIG00533729 FIG00533742: hypothetical protein +FIG00533769 FIG00533770: hypothetical protein +FIG00533770 FIG00533778: hypothetical protein +FIG00533778 FIG00533782: hypothetical protein +FIG00533782 FIG00533787: hypothetical protein +FIG00533808 FIG00533812: hypothetical protein +FIG00533812 FIG00533815: hypothetical protein +FIG00533815 FIG00533816: hypothetical protein +FIG00533823 FIG00533824: hypothetical protein +FIG00533824 FIG00533830: hypothetical protein +FIG00533835 FIG00533838: hypothetical protein +FIG00533841 FIG00533844: hypothetical protein +FIG00533851 FIG00533852: hypothetical protein +FIG00533852 Cell wall teichoic acid glycosylation protein gtcA +FIG00533902 FIG00533904: hypothetical protein +FIG00533935 FIG00533937: hypothetical protein +FIG00533938 Sensor protein resE (EC 2.7.3.-) +FIG00533948 FIG00533956: hypothetical protein +FIG00533962 FIG00533965: hypothetical protein +FIG00533972 FIG00533976: hypothetical protein +FIG00533976 FIG00533987: hypothetical protein +FIG00533987 FIG00533993: hypothetical protein +FIG00533999 FIG00534011: hypothetical protein +FIG00534011 biotin/lipoyl attachment protein +FIG00534021 FIG00534024: hypothetical protein +FIG00534024 FIG00534025: hypothetical protein +FIG00534025 FIG00534026: hypothetical protein +FIG00534051 FIG00534055: hypothetical protein +FIG00534060 FIG00534067: hypothetical protein +FIG00534070 FIG00534071: hypothetical protein +FIG00534071 FIG00534076: hypothetical protein +FIG00534081 FIG00534082: hypothetical protein +FIG00534088 FIG00534092: hypothetical protein +FIG00534107 FIG00534109: hypothetical protein +FIG00534120 FIG00534125: hypothetical protein +FIG00534131 FIG00534142: hypothetical protein +FIG00534155 FIG00534158: hypothetical protein +FIG00534174 FIG00534175: hypothetical protein +FIG00534183 FIG00534184: hypothetical protein +FIG00534190 FIG00534193: hypothetical protein +FIG00534193 FIG00534195: hypothetical protein +FIG00534195 Response regulator (CheY receiver domain and HTH-type DNA-binding domain) +FIG00534198 FIG00534200: hypothetical protein +FIG00534200 FIG00534210: hypothetical protein +FIG00534214 FIG00534216: hypothetical protein +FIG00534232 FIG00534235: hypothetical protein +FIG00534238 FIG00534265: hypothetical protein +FIG00534285 FIG00534287: hypothetical protein +FIG00534298 FIG030922: Ubiquinone/menaquinone biosynthesis methyltransferase UbiE/ COQ5 (EC 2.1.1.-) +FIG00534311 FIG00534313: hypothetical protein +FIG00534340 FIG00534343: hypothetical protein +FIG00534343 FIG00534345: hypothetical protein +FIG00534345 FIG01032643: hypothetical protein +FIG00534364 FIG00534368: hypothetical protein +FIG00534372 Protein bhlA +FIG00534384 FIG00534387: hypothetical protein +FIG00534410 FIG00534415: hypothetical protein +FIG00534418 FIG00534419: hypothetical protein +FIG00534419 FIG00534420: hypothetical protein +FIG00534422 FIG00534424: hypothetical protein +FIG00534426 FIG00534428: hypothetical protein +FIG00534428 Cell division initiation protein +FIG00534429 FIG00534430: hypothetical protein +FIG00534430 FIG00534431: hypothetical protein +FIG00534431 FIG00534432: hypothetical protein +FIG00534448 FIG00534450: hypothetical protein +FIG00534457 FIG00534458: hypothetical protein +FIG00534462 FIG00534463: hypothetical protein +FIG00534470 FIG00534472: hypothetical protein +FIG00534482 FIG00534483: hypothetical protein +FIG00534483 FIG00534484: hypothetical protein +FIG00534485 FIG00534486: hypothetical protein +FIG00534487 FIG00534488: hypothetical protein +FIG00534492 FIG00534493: hypothetical protein +FIG00534497 FIG00534499: hypothetical protein +FIG00534502 FIG00534505: hypothetical protein +FIG00534508 FIG00534509: hypothetical protein +FIG00534511 FIG00534512: hypothetical protein +FIG00534514 FIG00534515: hypothetical protein +FIG00534521 FIG00534522: hypothetical protein +FIG00534526 FIG00534527: hypothetical protein +FIG00534530 FIG00534531: hypothetical protein +FIG00534531 FIG00534533: hypothetical protein +FIG00534533 FIG00527821: hypothetical protein +FIG00534534 FIG00534535: hypothetical protein +FIG00534535 FIG00534536: hypothetical protein +FIG00534540 FIG00534541: hypothetical protein +FIG00534544 Glucan 1,3-beta-glucosidase precursor (EC 3.2.1.58) (Exo-1,3-beta-glucanase) +FIG00534545 FIG00534546: hypothetical protein +FIG00534552 D-aspartate ligase (EC 6.3.1.12) +FIG00534553 putative type II restriction enzyme methylase subunit +FIG00534563 FIG00534564: hypothetical protein +FIG00534566 FIG00534567: hypothetical protein +FIG00534570 FIG00534571: hypothetical protein +FIG00534575 FIG00534576: hypothetical protein +FIG00534577 FIG00534578: hypothetical protein +FIG00534580 FIG00534581: hypothetical protein +FIG00534581 FIG00534582: hypothetical protein +FIG00534582 FIG00534583: hypothetical protein +FIG00534586 FIG00534592: hypothetical protein +FIG00534592 FIG00534593: hypothetical protein +FIG00534595 FIG00534597: hypothetical protein +FIG00534600 FIG00534601: hypothetical protein +FIG00534601 FIG00534602: hypothetical protein +FIG00534603 FIG00534604: hypothetical protein +FIG00534608 FIG00534609: hypothetical protein +FIG00534616 FIG00534617: hypothetical protein +FIG00534617 FIG00534618: hypothetical protein +FIG00534629 FIG00534630: hypothetical protein +FIG00534632 FIG00534634: hypothetical protein +FIG00534637 FIG00534638: hypothetical protein +FIG00534640 FIG00534641: hypothetical protein +FIG00534641 FIG00534643: hypothetical protein +FIG00534645 FIG00534646: hypothetical protein +FIG00534647 FIG00534648: hypothetical protein +FIG00534652 FIG00534653: hypothetical protein +FIG00534662 FIG00534663: hypothetical protein +FIG00534663 FIG00534664: hypothetical protein +FIG00534665 FIG00534668: hypothetical protein +FIG00534668 FIG00534670: hypothetical protein +FIG00534672 FIG00534673: hypothetical protein +FIG00534678 FIG00534679: hypothetical protein +FIG00534681 FIG00534682: hypothetical protein +FIG00534688 FIG00534690: hypothetical protein +FIG00534694 FIG00534695: hypothetical protein +FIG00534696 ATPase (AAA+ superfamily)-like protein +FIG00534701 FIG00534702: hypothetical protein +FIG00534721 FIG00534722: hypothetical protein +FIG00534728 FIG00534729: hypothetical protein +FIG00534733 FIG00534736: hypothetical protein +FIG00534741 FIG00534742: hypothetical protein +FIG00534742 tRNA/rRNA cytosine-C5-methylase +FIG00534746 FIG00534747: hypothetical protein +FIG00534753 FIG00534754: hypothetical protein +FIG00534754 FIG00534756: hypothetical protein +FIG00534756 FIG00534757: hypothetical protein +FIG00534760 FIG00534761: hypothetical protein +FIG00534765 FIG00534767: hypothetical protein +FIG00534767 FIG00534768: hypothetical protein +FIG00534781 FIG00534784: hypothetical protein +FIG00534784 FIG00534786: hypothetical protein +FIG00534787 FIG00534789: hypothetical protein +FIG00534803 FIG00534806: hypothetical protein +FIG00534808 FIG00534809: hypothetical protein +FIG00534809 putative portal protein +FIG00534816 FIG00534817: hypothetical protein +FIG00534821 Tagatose-1-phosphate kinase TagK +FIG00534823 FIG00534824: hypothetical protein +FIG00534832 FIG00534833: hypothetical protein +FIG00534838 FIG00534846: hypothetical protein +FIG00535151 FIG00535158: hypothetical protein +FIG00535158 tgtA5 cluster protein 3 +FIG00535351 Extracellular ribonuclease Bsn / Extracellular deoxyribonuclease PA3909 (required for catabolism of external DNA) +FIG00535376 Putative permease precursor +FIG00535439 FIG00535446: hypothetical protein +FIG00535486 FIG00535497: hypothetical protein +FIG00535598 FIG00535603: hypothetical protein +FIG00535641 FIG00535642: hypothetical protein +FIG00535651 FIG00535662: hypothetical protein +FIG00535677 FIG00535681: hypothetical protein +FIG00535711 FIG00535713: hypothetical protein +FIG00535723 LPS glycosyltransferase +FIG00535923 FIG00535925: hypothetical protein +FIG00536039 FIG00953184: hypothetical protein +FIG00536119 FIG00951002: hypothetical protein +FIG00536239 FIG00536247: hypothetical protein +FIG00536356 FIG00536358: hypothetical protein +FIG00536378 FIG00536384: hypothetical protein +FIG00536456 FIG00536457: hypothetical protein +FIG00536476 FIG00536481: hypothetical protein +FIG00536495 FIG00536496: hypothetical protein +FIG00536589 FIG00536591: hypothetical protein +FIG00536611 FIG00536623: hypothetical protein +FIG00536634 conserved hypothetical secreted protein +FIG00536651 ATP-dependent helicase hrpB +FIG00536767 Probable amino acid ABC transporter +FIG00536811 FIG01058223: hypothetical protein +FIG00536956 FIG00536957: hypothetical protein +FIG00536972 FIG00536973: hypothetical protein +FIG00536985 FIG00536986: hypothetical protein +FIG00536999 hemerythrin-like metal-binding protein +FIG00537006 FIG00537009: hypothetical protein +FIG00537037 FIG00537038: hypothetical protein +FIG00537049 Calcium-binding EF-hand-containing protein +FIG00537068 tRNA pseudouridine synthase C (EC 4.2.1.70) +FIG00537070 PMID: 11481431 +FIG00537094 TRAP-type C4-dicarboxylate transport system, small permease component +FIG00537096 aspartate racemase +FIG00537120 diguanylate cyclase/phosphodiesterase (GGDEF & EAL domains) with PAS/PAC sensor(s) +FIG00537124 FIG00537126: hypothetical protein +FIG00537139 FIG00537140: hypothetical protein +FIG00537143 Regulatory protein, LuxR:Response regulator receiver +FIG00537148 COG0840: Methyl-accepting chemotaxis protein +FIG00537172 thioesterase superfamily +FIG00537186 Diadenosine tetraphosphate (Ap4A) hydrolase and other HIT family hydrolases +FIG00537197 FIG00537199: hypothetical protein +FIG00537204 FIG00537205: hypothetical protein +FIG00537208 FIG00537209: hypothetical protein +FIG00537209 FIG00537210: hypothetical protein +FIG00537210 Cyclase +FIG00537222 FIG00537223: hypothetical protein +FIG00537244 FIG00537245: hypothetical protein +FIG00537252 FIG00537253: hypothetical protein +FIG00537255 Surface lipoprotein +FIG00537274 Carbon monoxide oxidation accessory protein CoxG +FIG00537290 Flp pilus assembly protein TadG +FIG00537306 FIG00537307: hypothetical protein +FIG00537343 FIG00537346: hypothetical protein +FIG00537351 FIG00537353: hypothetical protein +FIG00537358 Bll6900 protein +FIG00537369 Protein containing domains DUF403 +FIG00537371 FIG00537372: hypothetical protein +FIG00537388 FIG00537389: hypothetical protein +FIG00537391 FIG00537393: hypothetical protein +FIG00537416 Uncharacterized protein SCO3165 +FIG00537421 Heat shock (predicted periplasmic) protein YciM, precursor +FIG00537439 Auxin Efflux Carrier +FIG00537476 FIG00537477: hypothetical protein +FIG00537496 Related to two-component system sensory/regulatory protein +FIG00537498 FIG00537499: hypothetical protein +FIG00537506 Flagellar biosynthesis protein FliO +FIG00537517 CYtochrome C family protein +FIG00537523 FIG00537524: hypothetical protein +FIG00537529 FIG00537531: hypothetical protein +FIG00537531 FIG00537534: hypothetical protein +FIG00537540 FIG00537543: hypothetical protein +FIG00537543 Transthyretin +FIG00537545 FIG00537547: hypothetical protein +FIG00537549 Probable MFS transporter precursor +FIG00537576 FIG00537579: hypothetical protein +FIG00537582 putative alkyl salicylate esterase +FIG00537587 Sugar transport PTS system IIa component +FIG00537612 FIG00537615: hypothetical protein +FIG00537667 granule-associated protein +FIG00537671 FIG00537672: hypothetical protein +FIG00537681 FIG00537682: hypothetical protein +FIG00537697 FIG00537701: hypothetical protein +FIG00537701 FIG00537702: hypothetical protein +FIG00537711 Putative branched-chain amino acid transporter substrate-binding protein +FIG00537719 FIG00537720: hypothetical protein +FIG00537748 FIG00537749: hypothetical protein +FIG00537756 FIG00537757: hypothetical protein +FIG00537781 Protein containing domains DUF404, DUF407 +FIG00537784 putative permease component of branched-chain amino acid transport system +FIG00537788 FIG00537789: hypothetical protein +FIG00537795 FIG00537796: hypothetical protein +FIG00537806 Probable hydrolase protein (EC 3.-.-.-) +FIG00537822 Heavy-metal-associated domain (N-terminus) and membrane-bounded cytochrome biogenesis cycZ-like domain, possible membrane copper tolerance protein +FIG00537831 FIG00537832: hypothetical protein +FIG00537846 FOG: GGDEF domain +FIG00537858 FIG00537859: hypothetical protein +FIG00537866 FIG00537867: hypothetical protein +FIG00537873 FIG00537874: hypothetical protein +FIG00537879 FIG00537880: hypothetical protein +FIG00537880 FIG00537881: hypothetical protein +FIG00537888 FIG00537892: hypothetical protein +FIG00537892 FIG00537893: hypothetical protein +FIG00537900 FIG00537901: hypothetical protein +FIG00537912 PROBABLE LIPID TRANSFER PROTEIN OR KETO ACYL-COA THIOLASE LTP2 (EC 2.3.1.16) +FIG00537918 Probable integral membrane protein +FIG00537919 FIG00537921: hypothetical protein +FIG00537935 FIG00537936: hypothetical protein +FIG00537941 FIG00537944: hypothetical protein +FIG00537962 Probable metal-dependent hydrolase protein +FIG00537997 FIG00537998: hypothetical protein +FIG00537999 FIG00538000: hypothetical protein +FIG00538031 FIG00538032: hypothetical protein +FIG00538041 putative inner membrane efflux protein +FIG00538044 Putative translation initiation inhibitor, yjgF family +FIG00538049 FIG00538052: hypothetical protein +FIG00538064 sulfate transporter/antisigma-factor antagonist STAS +FIG00538079 FIG00538080: hypothetical protein +FIG00538080 FIG00538085: hypothetical protein +FIG00538091 Far-related protein +FIG00538093 FIG00538094: hypothetical protein +FIG00538108 FIG00538109: hypothetical protein +FIG00538122 ferric siderophore ABC transporter, permease protein +FIG00538141 Endonuclease/exonuclease/phosphatase +FIG00538143 Biotin synthesis protein BioH +FIG00538144 FIG00538145: hypothetical protein +FIG00538167 FIG00538168: hypothetical protein +FIG00538176 FIG00538177: hypothetical protein +FIG00538177 FIG00538181: hypothetical protein +FIG00538183 FIG00538184: hypothetical protein +FIG00538184 FIG00976956: hypothetical protein +FIG00538193 FIG00538194: hypothetical protein +FIG00538195 FIG00581508: hypothetical protein +FIG00538199 FIG00538201: hypothetical protein +FIG00538203 Mlr7906 protein +FIG00538204 Glutamate ABC transport system, permease protein +FIG00538210 FIG00538213: hypothetical protein +FIG00538220 D-(-)-3-hydroxybutyrate oligomer hydrolase +FIG00538221 FIG00538223: hypothetical protein +FIG00538256 FIG00538257: hypothetical protein +FIG00538299 FIG00538300: hypothetical protein +FIG00538301 putative lipoprotein transmembrane +FIG00538303 cytochrome c, class I +FIG00538326 FIG00538327: hypothetical protein +FIG00538337 FIG00347912: hypothetical protein +FIG00538347 FIG00538348: hypothetical protein +FIG00538383 Taurine dioxygenase (EC 1.14.11.17) +FIG00538394 EF hand repeat-containing protein +FIG00538396 tRNA(m7G46)-methyltransferase (EC 2.1.1.33) +FIG00538403 Response regulator receiver:Transcriptional regulatory protein, C terminal +FIG00538406 Putative periplasmic cytochrome type-C oxidoreductase signal peptide protein (EC 1.-.-.-) +FIG00538423 L-Aspartate dehydrogenase (EC 1.4.1.21) +FIG00538430 protein of unknown function UPF0125 +FIG00538438 putative amino acid carrier protein +FIG00538452 Probable proline-rich protein +FIG00538454 FIG00538456: hypothetical protein +FIG00538471 FIG00538472: hypothetical protein +FIG00538482 FIG00538483: hypothetical protein +FIG00538491 Probable protease (EC 3.4.24.3) +FIG00538501 FIG00538502: hypothetical protein +FIG00538502 FIG00538503: hypothetical protein +FIG00538503 Outer membrane protein (porin)-like +FIG00538515 Surface antigen +FIG00538551 FIG00538552: hypothetical protein +FIG00538598 FIG00538600: hypothetical protein +FIG00538608 FIG00538613: hypothetical protein +FIG00538617 FIG00538618: hypothetical protein +FIG00538631 FIG00538633: hypothetical protein +FIG00538636 FIG00538637: hypothetical protein +FIG00538637 Hemerythrin-like protein RSc0777 +FIG00538642 FIG00538644: hypothetical protein +FIG00538660 FIG00538662: hypothetical protein +FIG00538679 Sulfate permease family protein +FIG00538687 Regulatory protein, RpfE type +FIG00538692 Probable chromate transporter protein +FIG00538709 FIG00538710: hypothetical protein +FIG00538729 FIG00538730: hypothetical protein +FIG00538742 FIG00538743: hypothetical protein +FIG00538748 FIG146285: Diadenosine tetraphosphate (Ap4A) hydrolase and other HIT family hydrolases +FIG00538850 Pyruvate dehydrogenase (acetyl-transferring)( EC:1.2.4.1 ) +FIG00539000 FIG00539003: hypothetical protein +FIG00539229 protein of unknown function DUF59 +FIG00539310 POSSIBLE LINOLEOYL-CoA DESATURASE (DELTA(6)-DESATURASE) +FIG00539650 putative phosphotriesterase protein +FIG00540176 Daunorubicin resistance ABC transporter ATP-binding subunit +FIG00540607 glucosyltransferase +FIG00540801 FIG00540805: hypothetical protein +FIG00540861 FIG00540875: hypothetical protein +FIG00540904 Cysteine dioxygenase type I +FIG00540974 FIG00540980: hypothetical protein +FIG00541002 binding-protein-dependent transport system permease +FIG00541234 FIG00541241: hypothetical protein +FIG00541437 FIG00541441: hypothetical protein +FIG00541661 ABC-type Maltose/ Maltodextrin permease +FIG00541772 FIG00541786: hypothetical protein +FIG00541801 FIG01002177: hypothetical protein +FIG00541816 Activator of Hsp90 ATPase 1 family protein +FIG00541873 FIG00541875: hypothetical protein +FIG00541885 FIG00541889: hypothetical protein +FIG00542139 ABC transporter ATP-binding protein - glutamine transport +FIG00542283 probable metabolite transport protein CsbC +FIG00542320 3-hydroxybutyryl-CoA dehydrogenase( EC:1.1.1.157 ) +FIG00542329 MoeX5 +FIG00542421 probable amino acid transporter, APC superfamily +FIG00542483 FIG00542492: hypothetical protein +FIG00542498 Repressor CsoR of the copZA operon +FIG00542625 FIG00542641: hypothetical protein +FIG00542718 FIG00542736: hypothetical protein +FIG00542738 FIG00542743: hypothetical protein +FIG00542816 D-cysteine desulfhydrase (EC 4.4.1.15) +FIG00542888 cytochrome P450 CYP105( EC:1.14.- ) +FIG00542957 FIG00542958: hypothetical protein +FIG00543097 sigma-24, ECF subfamily +FIG00543450 conserved Archaeal protein, putative +FIG00543684 molybdenum cofactor synthesis domain +FIG00543808 putative coenzyme A transferase +FIG00543814 FIG00543815: hypothetical protein +FIG00543815 acyl-CoA synthetase +FIG00543817 FIG00543821: hypothetical protein +FIG00543821 FIG00543822: hypothetical protein +FIG00543822 FIG00543823: hypothetical protein +FIG00543832 FIG00543833: hypothetical protein +FIG00543833 FIG00543835: hypothetical protein +FIG00543837 FIG00543838: hypothetical protein +FIG00543838 FIG00543839: hypothetical protein +FIG00543839 FIG00543840: hypothetical protein +FIG00543841 FIG00546271: hypothetical protein +FIG00543842 FIG00543843: hypothetical protein +FIG00543843 FIG00543844: hypothetical protein +FIG00543844 FIG00543846: hypothetical protein +FIG00543846 Dolichol-phosphate mannosyltransferase (EC 2.4.1.83) in lipid-linked oligosaccharide synthesis cluster +FIG00543851 FIG00543853: hypothetical protein +FIG00543853 FIG00543854: hypothetical protein +FIG00543867 probable metallopeptidase +FIG00543869 FIG00543870: hypothetical protein +FIG00543871 FIG00543872: hypothetical protein +FIG00543875 FIG00543876: hypothetical protein +FIG00543877 FIG00543878: hypothetical protein +FIG00543879 FIG00543880: hypothetical protein +FIG00543883 FIG00543884: hypothetical protein +FIG00543885 FIG00543888: hypothetical protein +FIG00543888 FIG00543890: hypothetical protein +FIG00543892 FIG00543893: hypothetical protein +FIG00543893 FIG00543894: hypothetical protein +FIG00543894 lysine export regulator protein +FIG00543895 FIG00543896: hypothetical protein +FIG00543896 FIG00543898: hypothetical protein +FIG00543898 FIG00543899: hypothetical protein +FIG00543899 FIG00543901: hypothetical protein +FIG00543901 glutamate-binding protein GluB +FIG00543903 FIG00543905: hypothetical protein +FIG00543906 FIG00543907: hypothetical protein +FIG00543907 FIG00543909: hypothetical protein +FIG00543909 cell wall-associated hydrolase +FIG00543915 FIG00543916: hypothetical protein +FIG00543918 FIG00543921: hypothetical protein +FIG00543921 FIG00543922: hypothetical protein +FIG00543922 FIG00543923: hypothetical protein +FIG00543924 putative iron transporter ATP-binding protein +FIG00543925 FIG00543926: hypothetical protein +FIG00543926 FIG00543928: hypothetical protein +FIG00543930 putative ribonuclease +FIG00543931 FIG00543933: hypothetical protein +FIG00543933 FIG00996461: hypothetical protein +FIG00543934 FIG00543935: hypothetical protein +FIG00543935 Methionine synthase, vitamin-B12 independent, putative +FIG00543936 FIG00543939: hypothetical protein +FIG00543939 FIG00543940: hypothetical protein +FIG00543940 FIG00543941: hypothetical protein +FIG00543941 FIG00543943: hypothetical protein +FIG00543944 FIG00543949: hypothetical protein +FIG00543951 FIG00543952: hypothetical protein +FIG00543957 FIG00543959: hypothetical protein +FIG00543959 No significant database matches. High concentration of alanine, glycine and proline residues +FIG00543960 FIG00543961: hypothetical protein +FIG00543962 Putative transport system secreted protein +FIG00543963 FIG00543965: hypothetical protein +FIG00543965 probable secreted protein. +FIG00543968 sugar kinase +FIG00543970 FIG00543972: hypothetical protein +FIG00543973 FIG00543975: hypothetical protein +FIG00543975 FIG00543976: hypothetical protein +FIG00543976 FIG00543977: hypothetical protein +FIG00543977 FIG00543978: hypothetical protein +FIG00543978 FIG00543979: hypothetical protein +FIG00543982 FIG00543983: hypothetical protein +FIG00543983 FIG00543985: hypothetical protein +FIG00543985 FIG00543986: hypothetical protein +FIG00543986 FIG00543988: hypothetical protein +FIG00543988 FIG00543989: hypothetical protein +FIG00543989 FIG00543990: hypothetical protein +FIG00543990 conserved hypothetical protein, putative F420-dependent NADP reductase +FIG00543992 FIG00543993: hypothetical protein +FIG00543995 FIG00543997: hypothetical protein +FIG00543997 FIG00544000: hypothetical protein +FIG00544000 FIG00544001: hypothetical protein +FIG00544001 Possible mutator protein MutT3 (7,8-dihydro-8-oxoguanine-triphosphatase) +FIG00544003 FIG00544004: hypothetical protein +FIG00544006 HigA protein (antitoxin to HigB) +FIG00544007 Fe3+/thiamine transport system, secreted component; ABC transporter substrate-binding protein +FIG00544009 FIG00544010: hypothetical protein +FIG00544010 FIG00544011: hypothetical protein +FIG00544011 FIG054872: Sortase-like protein +FIG00544013 FIG00544014: hypothetical protein +FIG00544019 FIG00544022: hypothetical protein +FIG00544028 FIG00544031: hypothetical protein +FIG00544036 FIG00544037: hypothetical protein +FIG00544037 two-component system, response regulator +FIG00544044 FIG00544046: hypothetical protein +FIG00544046 FIG00544048: hypothetical protein +FIG00544048 Putative bacterioferritin +FIG00544050 FIG00544054: hypothetical protein +FIG00544054 FIG00544057: hypothetical protein +FIG00544057 hydrolase of the alpha/beta superfamily +FIG00544060 FIG00544061: hypothetical protein +FIG00544061 FIG00544062: hypothetical protein +FIG00544062 FIG00544064: hypothetical protein +FIG00544067 FIG00544068: hypothetical protein +FIG00544068 FIG00544069: hypothetical protein +FIG00544077 FIG00945644: hypothetical protein +FIG00544078 FIG00544079: hypothetical protein +FIG00544079 FIG00544080: hypothetical protein +FIG00544080 Putative CBS domain containing protein +FIG00544083 FIG00544084: hypothetical protein +FIG00544085 FIG00544086: hypothetical protein +FIG00544088 FIG00544089: hypothetical protein +FIG00544091 FIG00544092: hypothetical protein +FIG00544094 FIG00544095: hypothetical protein +FIG00544095 putative permease of the major facilitator superfamily +FIG00544104 NADPH:quinone reductase and related Zn-dependent oxidoreductases (EC 1.6.5.5) +FIG00544105 FIG00544106: hypothetical protein +FIG00544106 FIG00544109: hypothetical protein +FIG00544110 FIG00544111: hypothetical protein +FIG00544111 bicarbonate transport system ATP-binding protein +FIG00544114 FIG00544115: hypothetical protein +FIG00544115 FIG00544116: hypothetical protein +FIG00544118 FIG00544119: hypothetical protein +FIG00544119 predicted acetyltransferase +FIG00544125 LpqW +FIG00544129 FIG00544130: hypothetical protein +FIG00544133 FIG00544135: hypothetical protein +FIG00544138 FIG00544139: hypothetical protein +FIG00544141 FIG00544143: hypothetical protein +FIG00544143 two-component system, sensory transduction histidine kinase +FIG00544148 FIG00544149: hypothetical protein +FIG00544149 FIG00544151: hypothetical protein +FIG00544151 FIG00544153: hypothetical protein +FIG00544153 FIG00544156: hypothetical protein +FIG00544156 FIG00544157: hypothetical protein +FIG00544157 FIG00544159: hypothetical protein +FIG00544163 FIG00544164: hypothetical protein +FIG00544164 FIG00544165: hypothetical protein +FIG00544165 FIG00544166: hypothetical protein +FIG00544167 FIG00544169: hypothetical protein +FIG00544169 FIG00544172: hypothetical protein +FIG00544172 FIG00544173: hypothetical protein +FIG00544173 FIG00544174: hypothetical protein +FIG00544174 FIG00544175: hypothetical protein +FIG00544175 FIG00544176: hypothetical protein +FIG00544177 predicted hydrolase or acyltransferase +FIG00544180 FIG00544185: hypothetical protein +FIG00544186 FIG00544187: hypothetical protein +FIG00544189 FIG00544190: hypothetical protein +FIG00544197 FIG00544199: hypothetical protein +FIG00544200 FIG00544201: hypothetical protein +FIG00544201 FIG00544202: hypothetical protein +FIG00544203 FIG00544204: hypothetical protein +FIG00544206 FIG00544207: hypothetical protein +FIG00544210 FIG00544213: hypothetical protein +FIG00544215 FIG00544217: hypothetical protein +FIG00544221 FIG00544222: hypothetical protein +FIG00544223 FIG00544225: hypothetical protein +FIG00544229 FIG00544230: hypothetical protein +FIG00544230 Putative iron ABC transport system, ATP-binding protein +FIG00544232 FIG00544233: hypothetical protein +FIG00544239 FIG00544241: hypothetical protein +FIG00544241 FIG00544243: hypothetical protein +FIG00544243 FIG00544244: hypothetical protein +FIG00544244 FIG00544245: hypothetical protein +FIG00544247 FIG00544249: hypothetical protein +FIG00544249 FIG00544250: hypothetical protein +FIG00544250 FIG00544252: hypothetical protein +FIG00544253 FIG00544255: hypothetical protein +FIG00544258 FIG00544260: hypothetical protein +FIG00544262 putative amino acid ABC transporter ATP-binding protein +FIG00544263 FIG00544264: hypothetical protein +FIG00544266 FIG00544267: hypothetical protein +FIG00544270 putative arabinosyltransferase +FIG00544275 periplasmic component of ABC-type Fe3+-siderophore transport system +FIG00544277 FIG00544278: hypothetical protein +FIG00544278 FIG00544279: hypothetical protein +FIG00544279 FIG00544280: hypothetical protein +FIG00544282 FIG026501: hypothetical protein +FIG00544288 Sucrose-6-phosphate hydrolase (EC 3.2.1.26); Levanase (EC 3.2.1.65) +FIG00544290 FIG00544293: hypothetical protein +FIG00544293 FIG00544295: hypothetical protein +FIG00544296 Possible membrane-anchored thioredoxin-like protein +FIG00544297 FIG00544299: hypothetical protein +FIG00544299 FIG00544300: hypothetical protein +FIG00544300 Bona fide RidA/YjgF/TdcF/RutC subgroup +FIG00544301 putative protein with NUDIX domain +FIG00544307 ABC transporter component, possibly Mn transport +FIG00544308 FIG00544309: hypothetical protein +FIG00544309 FIG00544311: hypothetical protein +FIG00544311 putative iron ABC transport system, solute-binding protein +FIG00544312 putative protein (2G313) / putative protein (2G313) +FIG00544314 FIG00544315: hypothetical protein +FIG00544315 FIG00544316: hypothetical protein +FIG00544318 FIG00544319: hypothetical protein +FIG00544323 FIG00544325: hypothetical protein +FIG00544327 FIG00544328: hypothetical protein +FIG00544333 FIG00544334: hypothetical protein +FIG00544338 FIG00544339: hypothetical protein +FIG00544340 DNA polymerase III epsilon subunit (EC 2.7.7.7) +FIG00544345 FIG00544346: hypothetical protein +FIG00544347 FIG00544348: hypothetical protein +FIG00544349 FIG00544350: hypothetical protein +FIG00544351 FIG00544353: hypothetical protein +FIG00544353 FIG00544355: hypothetical protein +FIG00544355 FIG00544357: hypothetical protein +FIG00544357 FIG00544358: hypothetical protein +FIG00544358 FIG00544361: hypothetical protein +FIG00544363 FIG00544365: hypothetical protein +FIG00544365 FIG00544366: hypothetical protein +FIG00544366 FIG00544367: hypothetical protein +FIG00544371 Putative iron transport system membrane protein +FIG00544372 FIG00544373: hypothetical protein +FIG00544373 elongation factor Tu +FIG00544382 FIG00544384: hypothetical protein +FIG00544384 FIG00544385: hypothetical protein +FIG00544385 FIG00544386: hypothetical protein +FIG00544387 FIG00544388: hypothetical protein +FIG00544388 FIG00544389: hypothetical protein +FIG00544394 FIG00544395: hypothetical protein +FIG00544395 Putative single-strand binding protein +FIG00544396 FIG00544397: hypothetical protein +FIG00544397 FIG00544398: hypothetical protein +FIG00544400 FIG00544401: hypothetical protein +FIG00544403 Putative two component system sensor kinase +FIG00544405 FIG00544406: hypothetical protein +FIG00544409 FIG00544411: hypothetical protein +FIG00544411 FIG00544412: hypothetical protein +FIG00544412 FIG00544413: hypothetical protein +FIG00544413 FIG00544414: hypothetical protein +FIG00544414 permease binding-protein component +FIG00544416 FIG00544417: hypothetical protein +FIG00544417 FIG00544418: hypothetical protein +FIG00544418 archaeal fructose-1,6-bisphosphatase +FIG00544419 ankyrin repeat containing protein +FIG00544420 putative aldose-1-epimerase( EC:5.1.3.3 ) +FIG00544425 phosphohistidine phosphatase SixA +FIG00544427 FIG00544428: hypothetical protein +FIG00544430 FIG00544431: hypothetical protein +FIG00544431 FIG00544433: hypothetical protein +FIG00544433 molybdopterin biosynthesis enzyme +FIG00544435 FIG00544436: hypothetical protein +FIG00544440 FIG00544441: hypothetical protein +FIG00544441 FIG00544442: hypothetical protein +FIG00544442 FIG00995839: hypothetical protein +FIG00544445 FIG00544446: hypothetical protein +FIG00544446 FIG00544449: hypothetical protein +FIG00544450 DNA repair helicase +FIG00544462 FIG00544463: hypothetical protein +FIG00544463 FIG00544464: hypothetical protein +FIG00544464 FIG00544468: hypothetical protein +FIG00544469 FIG00544470: hypothetical protein +FIG00544471 Transcriptional regulator, IclR family +FIG00544472 FIG00544473: hypothetical protein +FIG00544473 FIG00544474: hypothetical protein +FIG00544475 FIG00544477: hypothetical protein +FIG00544477 FIG00544479: hypothetical protein +FIG00544480 glutamate transporter permease protein GluD +FIG00544482 FIG00544483: hypothetical protein +FIG00544483 Cytoplasmic membrane protein FsxA +FIG00544485 FIG00544486: hypothetical protein +FIG00544489 FIG00544490: hypothetical protein +FIG00544490 FIG00544491: hypothetical protein +FIG00544491 FIG00544492: hypothetical protein +FIG00544492 FIG00544494: hypothetical protein +FIG00544498 FIG00544501: hypothetical protein +FIG00544502 FIG00544505: hypothetical protein +FIG00544506 FIG00544507: hypothetical protein +FIG00544507 putative ankyrin repeat-containing protein +FIG00544508 FIG00544509: hypothetical protein +FIG00544509 putative amylase +FIG00544512 probable 5-methylcytosine-specific restriction enzyme B +FIG00544513 FIG00544516: hypothetical protein +FIG00544517 FIG00544520: hypothetical protein +FIG00544524 FIG00544525: hypothetical protein +FIG00544525 FIG00544526: hypothetical protein +FIG00544529 FIG00544530: hypothetical protein +FIG00544534 FIG00544535: hypothetical protein +FIG00544535 FIG00544538: hypothetical protein +FIG00544544 FIG00544545: hypothetical protein +FIG00544547 FIG00544549: hypothetical protein +FIG00544549 FIG00544553: hypothetical protein +FIG00544556 putative single-strand DNA binding protein +FIG00544557 FIG00544558: hypothetical protein +FIG00544558 FIG00544560: hypothetical protein +FIG00544562 FIG00544563: hypothetical protein +FIG00544563 FIG00544564: hypothetical protein +FIG00544564 FIG00544566: hypothetical protein +FIG00544566 FIG00544569: hypothetical protein +FIG00544569 FIG00544570: hypothetical protein +FIG00544570 FIG00544571: hypothetical protein +FIG00544571 FIG00544572: hypothetical protein +FIG00544575 FIG00997919: hypothetical protein +FIG00544581 FIG00544583: hypothetical protein +FIG00544583 FIG00544584: hypothetical protein +FIG00544586 lysine exporter protein +FIG00544587 FIG00544588: hypothetical protein +FIG00544590 FIG00544592: hypothetical protein +FIG00544594 Putative aldo/keto-reductase family protein +FIG00544596 FIG00544597: hypothetical protein +FIG00544597 Putative oxidoreductase SMc00968 +FIG00544600 FIG00544601: hypothetical protein +FIG00544601 FIG00544602: hypothetical protein +FIG00544602 FIG00544603: hypothetical protein +FIG00544603 FIG00544604: hypothetical protein +FIG00544612 FIG00544614: hypothetical protein +FIG00544614 FIG00544615: hypothetical protein +FIG00544615 Inner membrane protein translocase component YidC, Corynebacterium paraloge +FIG00544616 FIG00544618: hypothetical protein +FIG00544619 FIG00544621: hypothetical protein +FIG00544621 putative transcriptional regulator (MarR family) +FIG00544624 FIG00544625: hypothetical protein +FIG00544625 FIG00544626: hypothetical protein +FIG00544627 phosphotransferase system IIC component, glucose/maltose/N-acetylglucosamine-specific +FIG00544628 FIG00544629: hypothetical protein +FIG00544631 FIG00544632: hypothetical protein +FIG00544632 putative rubredoxin reductase +FIG00544634 Phage peptidoglycan binding endopeptidase +FIG00544635 FIG00544636: hypothetical protein +FIG00544637 FIG00544638: hypothetical protein +FIG00544638 FIG00544639: hypothetical protein +FIG00544640 FIG00544641: hypothetical protein +FIG00544644 FIG00544646: hypothetical protein +FIG00544652 FIG00544653: hypothetical protein +FIG00544654 FIG00544655: hypothetical protein +FIG00544655 FIG00544657: hypothetical protein +FIG00544657 FIG00544658: hypothetical protein +FIG00544658 FIG00544659: hypothetical protein +FIG00544659 FIG00544661: hypothetical protein +FIG00544671 FIG00544672: hypothetical protein +FIG00544672 FIG00544673: hypothetical protein +FIG00544673 FIG00544676: hypothetical protein +FIG00544677 FIG00544678: hypothetical protein +FIG00544678 FIG00544679: hypothetical protein +FIG00544685 FIG00544686: hypothetical protein +FIG00544690 FIG00544692: hypothetical protein +FIG00544692 FIG00544694: hypothetical protein +FIG00544697 FIG00544701: hypothetical protein +FIG00544706 FIG00544707: hypothetical protein +FIG00544707 FIG00544708: hypothetical protein +FIG00544708 FIG00544709: hypothetical protein +FIG00544714 FIG00544715: hypothetical protein +FIG00544715 FIG00544716: hypothetical protein +FIG00544716 FIG00544717: hypothetical protein +FIG00544720 probable transciptional regulator, IclR family +FIG00544722 FIG00544723: hypothetical protein +FIG00544723 FIG071084: hypothetical protein +FIG00544728 FIG00544729: hypothetical protein +FIG00544730 FIG00544731: hypothetical protein +FIG00544733 FIG00544735: hypothetical protein +FIG00544736 aspartyl aminopeptidase +FIG00544737 FIG00544738: hypothetical protein +FIG00544740 FIG00544742: hypothetical protein +FIG00544742 FIG00544744: hypothetical protein +FIG00544745 FIG00544746: hypothetical protein +FIG00544747 GMP synthase +FIG00544750 FIG00544751: hypothetical protein +FIG00544751 FIG00544752: hypothetical protein +FIG00544757 FIG00544760: hypothetical protein +FIG00544761 FIG00544763: hypothetical protein +FIG00544763 Hydrolase MutT1 (EC 3.6.1.-) +FIG00544764 FIG00544765: hypothetical protein +FIG00544766 FIG00544769: hypothetical protein +FIG00544770 putative Capsular polysaccharide biosynthesis glycosyl transferase +FIG00544771 TerC family integral membrane protein +FIG00544775 FIG00544776: hypothetical protein +FIG00544776 FIG00544777: hypothetical protein +FIG00544777 FIG00544780: hypothetical protein +FIG00544781 FIG00544783: hypothetical protein +FIG00544783 FIG00544786: hypothetical protein +FIG00544789 FIG00544791: hypothetical protein +FIG00544793 Putative DNA-binding (excisionase) protein +FIG00544796 FIG00544798: hypothetical protein +FIG00544799 FIG00544802: hypothetical protein +FIG00544802 FIG021574: Possible membrane protein related to de Novo purine biosynthesis +FIG00544808 FIG00544811: hypothetical protein +FIG00544812 FIG00544813: hypothetical protein +FIG00544814 FIG00544816: hypothetical protein +FIG00544822 FIG00544824: hypothetical protein +FIG00544824 FIG00544827: hypothetical protein +FIG00544830 FIG00544831: hypothetical protein +FIG00544831 FIG00544833: hypothetical protein +FIG00544835 putative nisin resistance protein +FIG00544836 FIG00544839: hypothetical protein +FIG00544839 FIG00544840: hypothetical protein +FIG00544840 FIG00544841: hypothetical protein +FIG00544841 FIG00544844: hypothetical protein +FIG00544844 FIG00544846: hypothetical protein +FIG00544846 FIG00544849: hypothetical protein +FIG00544850 ABC-type transport systems, periplasmic component +FIG00544851 FIG00544856: hypothetical protein +FIG00544857 xanthine/uracil permease +FIG00544858 FIG00544859: hypothetical protein +FIG00544859 FIG00544860: hypothetical protein +FIG00544861 FIG00544862: hypothetical protein +FIG00544864 FIG00544865: hypothetical protein +FIG00544865 FIG00544866: hypothetical protein +FIG00544867 FIG00544868: hypothetical protein +FIG00544868 FIG00544869: hypothetical protein +FIG00544877 Uncharacterized tRNA/rRNA methyltransferase (EC 2.1.1.-) +FIG00544879 FIG00544880: hypothetical protein +FIG00544881 FIG00544882: hypothetical protein +FIG00544883 protein of unknown function DUF222 +FIG00544886 FIG00544887: hypothetical protein +FIG00544888 FIG00544889: hypothetical protein +FIG00544890 FIG00544891: hypothetical protein +FIG00544892 FIG00544893: hypothetical protein +FIG00544897 FIG00544898: hypothetical protein +FIG00544898 FIG00544899: hypothetical protein +FIG00544901 FIG00544902: hypothetical protein +FIG00544903 FIG00544905: hypothetical protein +FIG00544907 FIG00544908: hypothetical protein +FIG00544908 FIG00544909: hypothetical protein +FIG00544911 FIG00544912: hypothetical protein +FIG00544912 FIG00996758: hypothetical protein +FIG00544915 FIG00544916: hypothetical protein +FIG00544916 No significant database matches. High content in alanine, leucine and valine amino acid residues Low G+C content (52.14%) +FIG00544919 FIG00544922: hypothetical protein +FIG00544926 FIG00544927: hypothetical protein +FIG00544933 FIG00544934: hypothetical protein +FIG00544934 permease of the drug/metabolite transporter (DMT) superfamily +FIG00544938 FIG00544939: hypothetical protein +FIG00544939 ABC-type transport system ATPase component +FIG00544940 FIG00544942: hypothetical protein +FIG00544943 FIG00544944: hypothetical protein +FIG00544946 FIG00544951: hypothetical protein +FIG00544952 FIG00544953: hypothetical protein +FIG00544954 FIG00544955: hypothetical protein +FIG00544956 FIG00544957: hypothetical protein +FIG00544960 FIG00544962: hypothetical protein +FIG00544975 FIG00544976: hypothetical protein +FIG00544976 FIG00544977: hypothetical protein +FIG00544978 FIG00544979: hypothetical protein +FIG00544980 FIG00544981: hypothetical protein +FIG00544981 FIG00544982: hypothetical protein +FIG00544982 FIG00544983: hypothetical protein +FIG00544983 FIG00544985: hypothetical protein +FIG00544987 FIG00544989: hypothetical protein +FIG00544989 FIG00544992: hypothetical protein +FIG00544992 FIG00544993: hypothetical protein +FIG00544993 FIG00544994: hypothetical protein +FIG00544994 FIG00544995: hypothetical protein +FIG00544999 FIG00545001: hypothetical protein +FIG00545002 FIG00545003: hypothetical protein +FIG00545005 FIG00545006: hypothetical protein +FIG00545008 FIG00545012: hypothetical protein +FIG00545012 FIG00545013: hypothetical protein +FIG00545013 FIG00545015: hypothetical protein +FIG00545015 FIG00545016: hypothetical protein +FIG00545016 FIG00545017: hypothetical protein +FIG00545018 Lyzozyme M1 (1,4-beta-N-acetylmuramidase) (EC 3.2.1.17) +FIG00545020 FIG004853: possible toxin to DivIC +FIG00545023 FIG00545027: hypothetical protein +FIG00545031 UPF0225 protein YchJ +FIG00545032 FIG00545033: hypothetical protein +FIG00545038 FIG00545040: hypothetical protein +FIG00545041 putative transcription regulator +FIG00545044 FIG00545045: hypothetical protein +FIG00545046 FIG00545047: hypothetical protein +FIG00545048 FIG027937: secreted protein +FIG00545054 FIG00545055: hypothetical protein +FIG00545055 FIG00545058: hypothetical protein +FIG00545058 FIG00545059: hypothetical protein +FIG00545059 lactoylglutathione lyase-like protein +FIG00545060 FIG00545064: hypothetical protein +FIG00545068 FIG00545070: hypothetical protein +FIG00545070 FIG00545071: hypothetical protein +FIG00545071 coenzyme F420-dependent N5,N10-methylene tetrahydromethanopterin reductase( EC:1.14.14.3 ) +FIG00545072 FIG00545075: hypothetical protein +FIG00545075 FIG00545076: hypothetical protein +FIG00545077 FIG00545079: hypothetical protein +FIG00545083 FIG00545085: hypothetical protein +FIG00545086 lipase, class 2 +FIG00545087 NAD-dependent aldehyde dehydrogenase +FIG00545088 FIG00545089: hypothetical protein +FIG00545090 FIG00545091: hypothetical protein +FIG00545091 FIG00545092: hypothetical protein +FIG00545092 FIG00545097: hypothetical protein +FIG00545097 FIG00545098: hypothetical protein +FIG00545098 membrane-associated phospholipid phosphatase +FIG00545102 FIG00545103: hypothetical protein +FIG00545103 FIG00545105: hypothetical protein +FIG00545106 FIG00545107: hypothetical protein +FIG00545107 FIG00545109: hypothetical protein +FIG00545111 FIG00545115: hypothetical protein +FIG00545115 sarcosine oxidase( EC:1.5.3.1 ) +FIG00545116 FIG00545117: hypothetical protein +FIG00545118 glutamine cyclotransferase +FIG00545121 FIG00545122: hypothetical protein +FIG00545124 FIG00545125: hypothetical protein +FIG00545130 putative protein tyrosine phosphatase +FIG00545132 FIG00545133: hypothetical protein +FIG00545133 FIG00545135: hypothetical protein +FIG00545141 FIG00545144: hypothetical protein +FIG00545144 FIG00545146: hypothetical protein +FIG00545146 FIG00545147: hypothetical protein +FIG00545147 FIG00545148: hypothetical protein +FIG00545152 FIG00545154: hypothetical protein +FIG00545156 FIG00545158: hypothetical protein +FIG00545159 FIG00545160: hypothetical protein +FIG00545167 FIG00545169: hypothetical protein +FIG00545172 FIG00545173: hypothetical protein +FIG00545173 FIG00545174: hypothetical protein +FIG00545190 FIG00545191: hypothetical protein +FIG00545197 FIG00545198: hypothetical protein +FIG00545198 FIG00545201: hypothetical protein +FIG00545201 FIG00545202: hypothetical protein +FIG00545204 FIG00545205: hypothetical protein +FIG00545205 FIG00545207: hypothetical protein +FIG00545209 FIG00545210: hypothetical protein +FIG00545212 FIG00547725: hypothetical protein +FIG00545214 FIG00545216: hypothetical protein +FIG00545220 FIG00545221: hypothetical protein +FIG00545224 FIG00545225: hypothetical protein +FIG00545231 FIG00545234: hypothetical protein +FIG00545236 FIG00545237: hypothetical protein +FIG00545238 amino acid ABC transporter, ATP-binding protein (glnQ) +FIG00545241 FIG00545242: hypothetical protein +FIG00545242 FIG00545243: hypothetical protein +FIG00545246 FIG00545249: hypothetical protein +FIG00545249 FIG00545251: hypothetical protein +FIG00545251 FIG00545254: hypothetical protein +FIG00545255 PROBABLE CONSERVED LIPOPROTEIN LPRD +FIG00545261 FIG00545264: hypothetical protein +FIG00545264 FIG00545265: hypothetical protein +FIG00545265 permeases of the major facilitator superfamily +FIG00545266 FIG00545269: hypothetical protein +FIG00545273 FIG00545274: hypothetical protein +FIG00545274 FIG00545275: hypothetical protein +FIG00545281 FIG00545282: hypothetical protein +FIG00545282 FIG00545283: hypothetical protein +FIG00545283 FIG00545284: hypothetical protein +FIG00545284 xanthine/uracil permeases +FIG00545286 FIG00545288: hypothetical protein +FIG00545293 FIG00545294: hypothetical protein +FIG00545294 Putative magnesium and cobalt transport protein +FIG00545296 putative epoxyalkane:coenzyme M transferase +FIG00545299 FIG00545300: hypothetical protein +FIG00545303 FIG00545305: hypothetical protein +FIG00545305 FIG00545306: hypothetical protein +FIG00545312 FIG00545313: hypothetical protein +FIG00545313 FIG00545314: hypothetical protein +FIG00545314 FIG00545315: hypothetical protein +FIG00545315 FIG00545318: hypothetical protein +FIG00545320 FIG00545321: hypothetical protein +FIG00545321 FIG00545324: hypothetical protein +FIG00545324 RESOLVASE FAMILY RECOMBINASE +FIG00545330 FIG00545331: hypothetical protein +FIG00545335 FIG00545336: hypothetical protein +FIG00545338 FIG00545340: hypothetical protein +FIG00545342 FIG00545345: hypothetical protein +FIG00545346 FIG00545348: hypothetical protein +FIG00545355 FIG00545356: hypothetical protein +FIG00545360 FIG00545361: hypothetical protein +FIG00545361 FIG00545362: hypothetical protein +FIG00545373 FIG00545374: hypothetical protein +FIG00545376 FIG00545377: hypothetical protein +FIG00545377 FIG00545378: hypothetical protein +FIG00545378 immunity-specific protein Beta286 +FIG00545381 FIG00545382: hypothetical protein +FIG00545390 FIG00545392: hypothetical protein +FIG00545397 RidA/YER057c/UK114 superfamily, group 1 +FIG00545402 FIG00545404: hypothetical protein +FIG00545424 FIG00545427: hypothetical protein +FIG00545434 FIG00545435: hypothetical protein +FIG00545437 FIG00545438: hypothetical protein +FIG00545439 FIG00545440: hypothetical protein +FIG00545446 FIG00545448: hypothetical protein +FIG00545448 FIG00545451: hypothetical protein +FIG00545451 FIG007808: hypothetical protein +FIG00545453 transcriptional regulator of sugar metabolism +FIG00545454 FIG00545455: hypothetical protein +FIG00545456 FIG00545459: hypothetical protein +FIG00545459 FIG00545460: hypothetical protein +FIG00545460 di- and tricarboxylate transporter +FIG00545461 FIG00545462: hypothetical protein +FIG00545462 FIG00545464: hypothetical protein +FIG00545464 FIG00545466: hypothetical protein +FIG00545466 FIG00545467: hypothetical protein +FIG00545474 FIG00545475: hypothetical protein +FIG00545475 FIG00545476: hypothetical protein +FIG00545476 FIG00545477: hypothetical protein +FIG00545477 FIG00545482: hypothetical protein +FIG00545485 FIG00545486: hypothetical protein +FIG00545486 FIG00545487: hypothetical protein +FIG00545487 FIG00545488: hypothetical protein +FIG00545488 FIG00545489: hypothetical protein +FIG00545489 putative adenylate kinase +FIG00545496 FIG00545497: hypothetical protein +FIG00545497 FIG00545499: hypothetical protein +FIG00545504 FIG00545505: hypothetical protein +FIG00545505 FIG00545506: hypothetical protein +FIG00545507 FIG00545508: hypothetical protein +FIG00545508 conserved hypothetical 3 TMS, ~360aa Corynebacterium protein +FIG00545509 FIG00545514: hypothetical protein +FIG00545514 FIG00545515: hypothetical protein +FIG00545515 COG0385 sodium-dependent transporter +FIG00545516 FIG00545517: hypothetical protein +FIG00545517 FIG00545518: hypothetical protein +FIG00545519 FIG00545521: hypothetical protein +FIG00545524 putative transmembrane symporter +FIG00545525 FIG00545526: hypothetical protein +FIG00545527 Two component sensory transduction transcriptional regulatory protein MtrA +FIG00545532 FIG00545533: hypothetical protein +FIG00545538 FIG00545540: hypothetical protein +FIG00545540 FIG00545541: hypothetical protein +FIG00545548 FIG00545550: hypothetical protein +FIG00545550 alkanal monooxygenase-like protein +FIG00545553 FIG00545554: hypothetical protein +FIG00545554 Mar family transcriptional regulator +FIG00545558 putative transcriptional regulator (MerR family) +FIG00545560 FIG00545565: hypothetical protein +FIG00545566 FIG00545568: hypothetical protein +FIG00545570 FIG00545571: hypothetical protein +FIG00545575 FIG00545576: hypothetical protein +FIG00545577 FIG00545581: hypothetical protein +FIG00545582 FIG00545585: hypothetical protein +FIG00545589 FIG00545591: hypothetical protein +FIG00545594 FIG00545596: hypothetical protein +FIG00545597 glutamate ABC-type transporter, permease component +FIG00545599 FIG00545601: hypothetical protein +FIG00545601 FIG00545603: hypothetical protein +FIG00545603 FIG00545605: hypothetical protein +FIG00545605 FIG00545606: hypothetical protein +FIG00545606 Chromosome segregation ATPases +FIG00545610 FIG00545612: hypothetical protein +FIG00545615 FIG00545616: hypothetical protein +FIG00545617 FIG00545619: hypothetical protein +FIG00545621 FIG00545622: hypothetical protein +FIG00545629 FIG00545631: hypothetical protein +FIG00545634 Putative iron-sulphur protein +FIG00545635 FIG00545637: hypothetical protein +FIG00545641 FIG00545643: hypothetical protein +FIG00545643 Metal-dependent amidase/aminoacylase/carboxypeptidase (EC 3.5.1.32) +FIG00545645 FIG00545646: hypothetical protein +FIG00545646 FIG00545647: hypothetical protein +FIG00545656 FIG00545657: hypothetical protein +FIG00545673 FIG00545674: hypothetical protein +FIG00545675 FIG00545676: hypothetical protein +FIG00545676 Putative amino acid export carrier protein +FIG00545677 FIG00545678: hypothetical protein +FIG00545681 FIG00545682: hypothetical protein +FIG00545688 FIG00545691: hypothetical protein +FIG00545695 FIG00545698: hypothetical protein +FIG00545703 FIG00545704: hypothetical protein +FIG00545704 FIG00545707: hypothetical protein +FIG00545707 Aliphatic amidase AmiE (EC 3.5.1.4) +FIG00545709 FIG00545712: hypothetical protein +FIG00545713 FIG00545717: hypothetical protein +FIG00545717 FIG00545719: hypothetical protein +FIG00545735 FIG00545736: hypothetical protein +FIG00545739 FIG00545740: hypothetical protein +FIG00545740 FIG00545742: hypothetical protein +FIG00545742 FIG00545743: hypothetical protein +FIG00545745 Ferritin-like protein +FIG00545750 FIG00545752: hypothetical protein +FIG00545754 FIG00545756: hypothetical protein +FIG00545756 FIG00545760: hypothetical protein +FIG00545760 FIG00545761: hypothetical protein +FIG00545764 ABC-type transport system TetB +FIG00545772 FIG00545774: hypothetical protein +FIG00545774 Conserved putative integral membrane protein +FIG00545775 FIG00545776: hypothetical protein +FIG00545776 FIG00545779: hypothetical protein +FIG00545779 FIG00545782: hypothetical protein +FIG00545783 inositol monophosphatase family protein +FIG00545784 putative nitrate transport ATP-binding protein( EC:3.6.3.25 ) +FIG00545785 FIG00545787: hypothetical protein +FIG00545788 FIG00545789: hypothetical protein +FIG00545789 Putative low molecular weight protein antigen 6 +FIG00545790 FIG00545792: hypothetical protein +FIG00545794 FIG00545796: hypothetical protein +FIG00545802 sortase or related acyltransferase +FIG00545804 FIG00545805: hypothetical protein +FIG00545805 FIG00545808: hypothetical protein +FIG00545808 Putative reducing hydrogenase alpha subunit +FIG00545812 FIG00545814: hypothetical protein +FIG00545815 FIG00545819: hypothetical protein +FIG00545822 Doubtful CDS. No strong consensus RBS usptream. No significant database matches +FIG00545827 FIG00545828: hypothetical protein +FIG00545829 gamma-aminobutyrate (GABA) permease +FIG00545831 FIG00545832: hypothetical protein +FIG00545837 FIG00545838: hypothetical protein +FIG00545838 FIG00545840: hypothetical protein +FIG00545840 FIG00545841: hypothetical protein +FIG00545841 Putative transferase +FIG00545842 DNA-binding HTH domain-containing protein +FIG00545853 FIG00545854: hypothetical protein +FIG00545857 Siderophore biosynthesis non-ribosomal peptide synthetase modules +FIG00545858 FIG00545859: hypothetical protein +FIG00545865 FIG00545866: hypothetical protein +FIG00545866 FIG00545868: hypothetical protein +FIG00545872 FIG00545875: hypothetical protein +FIG00545881 FIG00545882: hypothetical protein +FIG00545885 FIG00545886: hypothetical protein +FIG00545887 FIG00545889: hypothetical protein +FIG00545889 FIG00545890: hypothetical protein +FIG00545892 FIG00545893: hypothetical protein +FIG00545895 FIG00545896: hypothetical protein +FIG00545898 FIG00545899: hypothetical protein +FIG00545908 FIG00545909: hypothetical protein +FIG00545909 FIG00545912: hypothetical protein +FIG00545912 FIG00545915: hypothetical protein +FIG00545922 FIG00545923: hypothetical protein +FIG00545924 FIG00545925: hypothetical protein +FIG00545928 putative phospho-sugar mutase +FIG00545934 FIG00545936: hypothetical protein +FIG00545937 FIG00545938: hypothetical protein +FIG00545940 FIG00545941: hypothetical protein +FIG00545941 Glutamine ABC transporter, periplasmic glutamine-binding protein (TC 3.A.1.3.2) +FIG00545942 FIG00545943: hypothetical protein +FIG00545947 FIG00545949: hypothetical protein +FIG00545951 FIG00545952: hypothetical protein +FIG00545952 FIG00545953: hypothetical protein +FIG00545953 FIG00545954: hypothetical protein +FIG00545956 FIG00545957: hypothetical protein +FIG00545966 FIG00545968: hypothetical protein +FIG00545969 FIG00545970: hypothetical protein +FIG00545973 FIG00545981: hypothetical protein +FIG00545993 FIG00545996: hypothetical protein +FIG00545999 Putative sugar related operon transcriptional regulator (PTS system) +FIG00546021 FIG00546022: hypothetical protein +FIG00546022 FIG00546025: hypothetical protein +FIG00546030 FIG00546031: hypothetical protein +FIG00546031 FIG00546033: hypothetical protein +FIG00546033 Putative surface anchored protein +FIG00546038 putative multidrug resistance protein +FIG00546041 FIG00546042: hypothetical protein +FIG00546045 FIG00546046: hypothetical protein +FIG00546047 FIG00546048: hypothetical protein +FIG00546060 FIG00546066: hypothetical protein +FIG00546071 FIG00546074: hypothetical protein +FIG00546074 FIG00546075: hypothetical protein +FIG00546087 Probable ABC transport protein, membrane component +FIG00546091 FIG00546093: hypothetical protein +FIG00546093 FIG00546095: hypothetical protein +FIG00546095 FIG00546098: hypothetical protein +FIG00546098 FIG00546101: hypothetical protein +FIG00546107 FIG00546108: hypothetical protein +FIG00546109 FIG00546110: hypothetical protein +FIG00546112 FIG00546113: hypothetical protein +FIG00546115 FIG00546116: hypothetical protein +FIG00546116 FIG00546117: hypothetical protein +FIG00546118 FIG00546120: hypothetical protein +FIG00546130 FIG00546135: hypothetical protein +FIG00546136 FIG00546138: hypothetical protein +FIG00546138 FIG00546139: hypothetical protein +FIG00546140 FIG00546141: hypothetical protein +FIG00546145 Serine protease mycosin MycP4, component of Type VII secretion system ESX-4 +FIG00546155 FIG00546156: hypothetical protein +FIG00546157 FIG00546158: hypothetical protein +FIG00546160 Short-chain dehydrogenase/reductase SDR +FIG00546162 FIG00546164: hypothetical protein +FIG00546172 FIG00546173: hypothetical protein +FIG00546173 ABC transporter TetB +FIG00546176 FIG00546178: hypothetical protein +FIG00546184 FIG00546185: hypothetical protein +FIG00546185 hypothetical protein +FIG00546197 FIG00546198: hypothetical protein +FIG00546198 FIG00546199: hypothetical protein +FIG00546203 FIG00546205: hypothetical protein +FIG00546209 FIG00546213: hypothetical protein +FIG00546213 FIG00546214: hypothetical protein +FIG00546219 FIG00546220: hypothetical protein +FIG00546227 FIG00546228: hypothetical protein +FIG00546228 FIG00546229: hypothetical protein +FIG00546231 FIG00546232: hypothetical protein +FIG00546236 FIG00546237: hypothetical protein +FIG00546237 FIG00546238: hypothetical protein +FIG00546241 FIG00546242: hypothetical protein +FIG00546243 FIG00546244: hypothetical protein +FIG00546250 FIG00546254: hypothetical protein +FIG00546255 FIG00546255: Oxidoreductase, FAD-binding protein +FIG00546256 FIG00546260: hypothetical protein +FIG00546261 FIG00546262: hypothetical protein +FIG00546268 NhaP-type Na+/H+ and K+/H+ antiporter +FIG00546271 FIG00546273: hypothetical protein +FIG00546273 FIG00546274: hypothetical protein +FIG00546275 cation efflux protein +FIG00546280 FIG00546281: hypothetical protein +FIG00546281 FIG00546283: hypothetical protein +FIG00546283 putative amino acid ABC transporter permease protein +FIG00546287 FIG00546288: hypothetical protein +FIG00546288 FIG00546289: hypothetical protein +FIG00546293 NADP oxidoreductase, coenzyme F420-dependent +FIG00546299 FIG00546302: hypothetical protein +FIG00546302 FIG00546304: hypothetical protein +FIG00546304 FIG00546306: hypothetical protein +FIG00546306 FIG00546307: hypothetical protein +FIG00546312 FIG00546314: hypothetical protein +FIG00546314 FIG00546315: hypothetical protein +FIG00546325 Uncharacterized transporter PPA2034 +FIG00546326 FIG00546329: hypothetical protein +FIG00546332 FIG00546334: hypothetical protein +FIG00546334 FIG00546336: hypothetical protein +FIG00546340 FIG00546343: hypothetical protein +FIG00546350 FIG00546351: hypothetical protein +FIG00546354 FIG00546356: hypothetical protein +FIG00546359 putative transcription repressor +FIG00546361 FIG00546362: hypothetical protein +FIG00546362 FIG00546364: hypothetical protein +FIG00546364 FIG00546368: hypothetical protein +FIG00546368 FIG00546369: hypothetical protein +FIG00546369 FIG00546370: hypothetical protein +FIG00546371 FIG00546372: hypothetical protein +FIG00546379 FIG00546380: hypothetical protein +FIG00546382 FIG00546383: hypothetical protein +FIG00546386 FIG00546389: hypothetical protein +FIG00546391 FIG00546395: hypothetical protein +FIG00546403 immunity-specific protein Beta201 +FIG00546408 FIG00546409: hypothetical protein +FIG00546410 FIG00546412: hypothetical protein +FIG00546416 FIG00546417: hypothetical protein +FIG00546417 FIG00546418: hypothetical protein +FIG00546418 Putative ABc transport system integral membrane protein +FIG00546433 FIG00546434: hypothetical protein +FIG00546436 FIG00546437: hypothetical protein +FIG00546437 FIG00546438: hypothetical protein +FIG00546441 FIG00546443: hypothetical protein +FIG00546443 FIG00546445: hypothetical protein +FIG00546445 Siderophore-interacting protein +FIG00546448 FIG00546451: hypothetical protein +FIG00546454 FIG00546460: hypothetical protein +FIG00546460 FIG00546461: hypothetical protein +FIG00546463 FIG00546464: hypothetical protein +FIG00546464 Uncharacterized protein Rv3292/MT3391 +FIG00546465 FIG00546466: hypothetical protein +FIG00546466 COG0385 sodium-dependent transporter +FIG00546470 FIG00546472: hypothetical protein +FIG00546477 FIG00546478: hypothetical protein +FIG00546478 FIG00546479: hypothetical protein +FIG00546483 involved in biosynthesis of extracellular polysaccharides +FIG00546484 FIG00546485: hypothetical protein +FIG00546497 FIG00546498: hypothetical protein +FIG00546498 FIG00546500: hypothetical protein +FIG00546507 FIG00546509: hypothetical protein +FIG00546510 FIG00546511: hypothetical protein +FIG00546525 FIG00546526: hypothetical protein +FIG00546527 FIG00546528: hypothetical protein +FIG00546533 FIG00546535: hypothetical protein +FIG00546539 FIG00546540: hypothetical protein +FIG00546543 MUTT/NUDIX FAMILY PROTEIN +FIG00546544 FIG00546546: hypothetical protein +FIG00546546 FIG00546547: hypothetical protein +FIG00546547 FIG00546548: hypothetical protein +FIG00546562 FIG00546565: hypothetical protein +FIG00546566 Heat shock protein 22.5 (Hsp22.5) +FIG00546567 FIG00546568: hypothetical protein +FIG00546568 FIG00546570: hypothetical protein +FIG00546570 FIG00546571: hypothetical protein +FIG00546571 FIG00546575: hypothetical protein +FIG00546583 FIG00546585: hypothetical protein +FIG00546587 FIG00546590: hypothetical protein +FIG00546595 FIG00548024: hypothetical protein +FIG00546596 FIG00546597: hypothetical protein +FIG00546600 gamma-aminobutyrate (GABA) permease +FIG00546604 FIG00546606: hypothetical protein +FIG00546607 Putative secreted hydrolase +FIG00546618 FIG00546621: hypothetical protein +FIG00546621 FIG00546622: hypothetical protein +FIG00546622 FIG00820963: Predicted deacetylase +FIG00546626 FIG00546627: hypothetical protein +FIG00546631 FIG00546632: hypothetical protein +FIG00546632 FIG00546633: hypothetical protein +FIG00546633 Putative Na+/H+ antiporter +FIG00546645 FIG00546649: hypothetical protein +FIG00546650 FIG00546653: hypothetical protein +FIG00546669 FIG00546670: hypothetical protein +FIG00546670 FIG00546671: hypothetical protein +FIG00546671 histone acetyltransferase HPA2-like protein +FIG00546675 Putative anaerobic c4-dicarboxylate transport protein +FIG00546680 FIG00546685: hypothetical protein +FIG00546689 FIG00546691: hypothetical protein +FIG00546698 FIG00546699: hypothetical protein +FIG00546699 FIG00546700: hypothetical protein +FIG00546700 FIG00546701: hypothetical protein +FIG00546701 FIG00546702: hypothetical protein +FIG00546703 FIG00546704: hypothetical protein +FIG00546704 FIG00546706: hypothetical protein +FIG00546706 FIG00546709: hypothetical protein +FIG00546709 putative non-ribosomal peptide synthetase +FIG00546712 FIG00546716: hypothetical protein +FIG00546717 FIG00546718: hypothetical protein +FIG00546718 FIG00546719: hypothetical protein +FIG00546719 FIG00546720: hypothetical protein +FIG00546726 FIG00546727: hypothetical protein +FIG00546727 FIG00546729: hypothetical protein +FIG00546730 FIG00546731: hypothetical protein +FIG00546736 FIG00546737: hypothetical protein +FIG00546737 FIG00546739: hypothetical protein +FIG00546740 FIG00546741: hypothetical protein +FIG00546742 FIG00546743: hypothetical protein +FIG00546744 FIG00546747: hypothetical protein +FIG00546747 FIG00546748: hypothetical protein +FIG00546754 universal stress protein UspA +FIG00546755 FIG00546760: hypothetical protein +FIG00546760 FIG00546761: hypothetical protein +FIG00546766 FIG00546770: hypothetical protein +FIG00546771 Putative membrane-anchored protein +FIG00546775 FIG00546777: hypothetical protein +FIG00546777 FIG00546778: hypothetical protein +FIG00546782 Putative transport system membrane protein +FIG00546788 FIG00546790: hypothetical protein +FIG00546796 FIG00546797: hypothetical protein +FIG00546797 FIG00546798: hypothetical protein +FIG00546805 FIG00546806: hypothetical protein +FIG00546806 FIG00546807: hypothetical protein +FIG00546807 FIG00546808: hypothetical protein +FIG00546815 FIG00546819: hypothetical protein +FIG00546821 Ectoine, glycine betaine and proline transport system membrane protein +FIG00546827 FIG00546828: hypothetical protein +FIG00546828 FIG00546830: hypothetical protein +FIG00546832 FIG00546833: hypothetical protein +FIG00546838 FIG00546840: hypothetical protein +FIG00546843 FIG00546846: hypothetical protein +FIG00546846 FIG00546847: hypothetical protein +FIG00546847 FIG00546849: hypothetical protein +FIG00546849 FIG00546850: hypothetical protein +FIG00546850 FIG00546851: hypothetical protein +FIG00546859 FIG00546860: hypothetical protein +FIG00546862 chloride channel EriC-like protein +FIG00546866 putative tryptophan transpoter +FIG00546868 FIG00546870: hypothetical protein +FIG00546877 FIG00546878: hypothetical protein +FIG00546879 FIG00546880: hypothetical protein +FIG00546880 FIG00546881: hypothetical protein +FIG00546883 FIG00546884: hypothetical protein +FIG00546888 FIG00546890: hypothetical protein +FIG00546895 putative alkanal monooxygenase alpha chain +FIG00546896 FIG00546897: hypothetical protein +FIG00546897 putative peptide ABC transporter ATP-binding protein +FIG00546901 FIG00546902: hypothetical protein +FIG00546914 FIG00546915: hypothetical protein +FIG00546915 FIG00546916: hypothetical protein +FIG00546919 FIG00546920: hypothetical protein +FIG00546920 FIG00546921: hypothetical protein +FIG00546932 10 TMS hypothetical membrane protein +FIG00546934 FIG00546935: hypothetical protein +FIG00546935 FIG00546937: hypothetical protein +FIG00546944 putative triacylglycerol lipase precursor +FIG00546947 FIG00546948: hypothetical protein +FIG00546948 FIG00546949: hypothetical protein +FIG00546949 FIG00546951: hypothetical protein +FIG00546951 FIG00546952: hypothetical protein +FIG00546954 FIG00546955: hypothetical protein +FIG00546955 FIG00546957: hypothetical protein +FIG00546959 FIG00546961: hypothetical protein +FIG00546962 FIG00546965: hypothetical protein +FIG00546972 FIG00546976: hypothetical protein +FIG00546977 FIG00546978: hypothetical protein +FIG00546978 FIG00546979: hypothetical protein +FIG00546980 FIG00546981: hypothetical protein +FIG00546986 FIG00546992: hypothetical protein +FIG00546995 FIG00546997: hypothetical protein +FIG00546997 FIG00546998: hypothetical protein +FIG00546998 FIG00546999: hypothetical protein +FIG00546999 FIG00547001: hypothetical protein +FIG00547004 FIG00547005: hypothetical protein +FIG00547007 FIG00547008: hypothetical protein +FIG00547013 Thioredoxin (EC 1.8.1.8) +FIG00547028 FIG00547029: hypothetical protein +FIG00547030 FIG00547032: hypothetical protein +FIG00547032 FIG00547033: hypothetical protein +FIG00547036 PUTATIVE DICARBOXYLIC ACID HYDROLASE +FIG00547037 FIG00547038: hypothetical protein +FIG00547048 FIG00547049: hypothetical protein +FIG00547054 FIG00547055: hypothetical protein +FIG00547055 FIG00547058: hypothetical protein +FIG00547063 FIG00547065: hypothetical protein +FIG00547065 FIG00547066: hypothetical protein +FIG00547071 FIG00547072: hypothetical protein +FIG00547072 FIG00547073: hypothetical protein +FIG00547075 FIG00547076: hypothetical protein +FIG00547076 FIG00547077: hypothetical protein +FIG00547081 FIG00547082: hypothetical protein +FIG00547083 FIG00547084: hypothetical protein +FIG00547084 FIG00547085: hypothetical protein +FIG00547086 FIG00547088: hypothetical protein +FIG00547090 FIG00547092: hypothetical protein +FIG00547095 FIG00547096: hypothetical protein +FIG00547097 potential surface-anchored protein +FIG00547121 FIG00547124: hypothetical protein +FIG00547128 FIG00547129: hypothetical protein +FIG00547139 FIG00547140: hypothetical protein +FIG00547140 FIG00547141: hypothetical protein +FIG00547141 putative transcriptional regulator (ArsR family) +FIG00547147 FIG00547148: hypothetical protein +FIG00547156 FIG00547157: hypothetical protein +FIG00547157 FIG00547159: hypothetical protein +FIG00547173 FIG00547174: hypothetical protein +FIG00547183 FIG00547184: hypothetical protein +FIG00547193 putative iron ABC transporter ATP-binding protein +FIG00547199 FIG00547205: hypothetical protein +FIG00547208 FIG00547211: hypothetical protein +FIG00547219 FIG00547220: hypothetical protein +FIG00547220 FIG00547221: hypothetical protein +FIG00547221 FIG00547224: hypothetical protein +FIG00547240 FIG00547241: hypothetical protein +FIG00547242 FIG00547245: hypothetical protein +FIG00547255 FIG00547256: hypothetical protein +FIG00547256 FIG00547257: hypothetical protein +FIG00547262 FIG00547263: hypothetical protein +FIG00547270 FIG00547271: hypothetical protein +FIG00547271 FIG00547272: hypothetical protein +FIG00547274 FIG00547275: hypothetical protein +FIG00547288 FIG00547289: hypothetical protein +FIG00547289 FIG00547290: hypothetical protein +FIG00547294 FIG00547295: hypothetical protein +FIG00547295 FIG00547296: hypothetical protein +FIG00547296 FIG00547297: hypothetical protein +FIG00547298 FIG00547299: hypothetical protein +FIG00547302 FIG00547304: hypothetical protein +FIG00547304 FIG00547305: hypothetical protein +FIG00547308 FIG00547311: hypothetical protein +FIG00547316 FIG00547320: hypothetical protein +FIG00547320 FIG00547322: hypothetical protein +FIG00547323 FIG00547324: hypothetical protein +FIG00547327 ABC-type transport system, periplasmic component +FIG00547329 FIG00547331: hypothetical protein +FIG00547359 FIG00547362: hypothetical protein +FIG00547362 FIG00547364: hypothetical protein +FIG00547367 putative polyhydroxybutyrate depolymerase +FIG00547369 FIG00547375: hypothetical protein +FIG00547376 FIG00547379: hypothetical protein +FIG00547380 FIG00547381: hypothetical protein +FIG00547381 FIG00547383: hypothetical protein +FIG00547384 FIG00547385: hypothetical protein +FIG00547393 FIG00547394: hypothetical protein +FIG00547394 putative cholesterol esterase +FIG00547397 HigA protein (antitoxin to HigB) +FIG00547403 FIG00547406: hypothetical protein +FIG00547407 FIG00547408: hypothetical protein +FIG00547408 COG0665: Glycine/D-amino acid oxidases (deaminating) +FIG00547410 FIG00547411: hypothetical protein +FIG00547413 FIG00547414: hypothetical protein +FIG00547417 FIG00547418: hypothetical protein +FIG00547421 FIG00547422: hypothetical protein +FIG00547427 FIG00547428: hypothetical protein +FIG00547442 FIG00547443: hypothetical protein +FIG00547443 FIG00547445: hypothetical protein +FIG00547455 FIG00547456: hypothetical protein +FIG00547457 FIG00547459: hypothetical protein +FIG00547476 FIG00547478: hypothetical protein +FIG00547478 FIG00547479: hypothetical protein +FIG00547482 FIG00547483: hypothetical protein +FIG00547487 FIG00547488: hypothetical protein +FIG00547497 FIG00547498: hypothetical protein +FIG00547498 FIG00547500: hypothetical protein +FIG00547501 FIG00547503: hypothetical protein +FIG00547506 FIG00547507: hypothetical protein +FIG00547512 FIG00547513: hypothetical protein +FIG00547513 FIG00547514: hypothetical protein +FIG00547514 FIG00547517: hypothetical protein +FIG00547529 FIG00547530: hypothetical protein +FIG00547530 Putative ABC transport system, ATP-binding protein +FIG00547531 FIG00547536: hypothetical protein +FIG00547547 FIG00547553: hypothetical protein +FIG00547561 FIG00547562: hypothetical protein +FIG00547563 FIG00547564: hypothetical protein +FIG00547565 FIG00547571: hypothetical protein +FIG00547574 FIG00547576: hypothetical protein +FIG00547576 putative lipoprotein involved in iron transport +FIG00547582 FIG00547585: hypothetical protein +FIG00547590 FIG00547591: hypothetical protein +FIG00547591 FIG00547592: hypothetical protein +FIG00547598 FIG00547599: hypothetical protein +FIG00547603 FIG00547604: hypothetical protein +FIG00547609 FIG00547611: hypothetical protein +FIG00547611 FIG00547613: hypothetical protein +FIG00547613 FIG00662487: probable membrane protein +FIG00547617 FIG00547620: hypothetical protein +FIG00547621 two-component regulatory protein +FIG00547626 FIG00547627: hypothetical protein +FIG00547631 FIG00547633: hypothetical protein +FIG00547641 FIG00547642: hypothetical protein +FIG00547643 FIG00547644: hypothetical protein +FIG00547646 FIG00547647: hypothetical protein +FIG00547650 FIG00547651: hypothetical protein +FIG00547654 FIG00547658: hypothetical protein +FIG00547660 FIG00547661: hypothetical protein +FIG00547661 FIG00547662: hypothetical protein +FIG00547665 FIG00547666: hypothetical protein +FIG00547669 FIG00547670: hypothetical protein +FIG00547676 FIG00547677: hypothetical protein +FIG00547677 FIG00547678: hypothetical protein +FIG00547678 FIG00547680: hypothetical protein +FIG00547682 FIG00547683: hypothetical protein +FIG00547684 FIG00547686: hypothetical protein +FIG00547694 FIG00547695: hypothetical protein +FIG00547696 FIG00547697: hypothetical protein +FIG00547698 FIG00547703: hypothetical protein +FIG00547717 FIG00547718: hypothetical protein +FIG00547720 FIG00547721: hypothetical protein +FIG00547726 FIG00547727: hypothetical protein +FIG00547731 FIG00547734: hypothetical protein +FIG00547745 FIG00547747: hypothetical protein +FIG00547758 FIG00547760: hypothetical protein +FIG00547766 FIG00547767: hypothetical protein +FIG00547771 FIG00547773: hypothetical protein +FIG00547774 FIG00547776: hypothetical protein +FIG00547799 FIG00547800: hypothetical protein +FIG00547800 FIG00547801: hypothetical protein +FIG00547803 Probable serine/threonine-protein kinase pknL (EC 2.7.11.1) +FIG00547804 FIG00547806: hypothetical protein +FIG00547810 FIG00547811: hypothetical protein +FIG00547819 FIG00547820: hypothetical protein +FIG00547822 FIG00547823: hypothetical protein +FIG00547828 FIG00547829: hypothetical protein +FIG00547830 FIG00547831: hypothetical protein +FIG00547831 Succinate dehydrogenase/fumarate reductase, flavoprotein subunit +FIG00547832 putative cellulose synthase catalytic subunit +FIG00547833 FIG00547835: hypothetical protein +FIG00547841 FIG00547842: hypothetical protein +FIG00547842 FIG00547849: hypothetical protein +FIG00547852 FIG00547853: hypothetical protein +FIG00547854 FIG00547859: hypothetical protein +FIG00547870 FIG00547871: hypothetical protein +FIG00547872 FIG00547873: hypothetical protein +FIG00547877 FIG00547878: hypothetical protein +FIG00547878 FIG00547879: hypothetical protein +FIG00547883 FIG00547886: hypothetical protein +FIG00547886 FIG00547887: hypothetical protein +FIG00547894 FIG00549883: hypothetical protein +FIG00547896 FIG00547898: hypothetical protein +FIG00547911 FIG00547912: hypothetical protein +FIG00547917 FIG00547918: hypothetical protein +FIG00547919 FIG00547928: hypothetical protein +FIG00547932 FIG00547933: hypothetical protein +FIG00547936 FIG00547937: hypothetical protein +FIG00547939 putative 3-alpha-hydroxysteroid dehydrogenase +FIG00547941 FIG00547943: hypothetical protein +FIG00547953 FIG00547956: hypothetical protein +FIG00547967 FIG00547969: hypothetical protein +FIG00547969 FIG00547971: hypothetical protein +FIG00547975 FIG00547978: hypothetical protein +FIG00547978 FIG00547980: hypothetical protein +FIG00547984 two-component system response regulator TcsR7 +FIG00547993 FIG00547998: hypothetical protein +FIG00547998 FIG00548000: hypothetical protein +FIG00548008 putative sensor kinase +FIG00548012 FIG00548013: hypothetical protein +FIG00548029 FIG00548032: hypothetical protein +FIG00548057 FIG00548059: hypothetical protein +FIG00548059 FIG00548060: hypothetical protein +FIG00548067 FIG00548070: hypothetical protein +FIG00548071 FIG00548072: hypothetical protein +FIG00548072 corynomycolyl transferase +FIG00548086 FIG00548088: hypothetical protein +FIG00548088 putative peptide ABC transporter peptide-binding protein +FIG00548092 hypothetical malic enzyme protein +FIG00548107 FIG00548108: hypothetical protein +FIG00548122 FIG00548123: hypothetical protein +FIG00548123 O-antigen/lipopolysaccharide transport ATP-binding protein ABC transporter RfbE +FIG00548126 FIG00548127: hypothetical protein +FIG00548127 predicted nucleoside-diphosphate-sugar epimerase +FIG00548141 hypothetical protein, mmyy +FIG00548144 FIG00548145: hypothetical protein +FIG00548146 FIG00548151: hypothetical protein +FIG00548154 FIG00548157: hypothetical protein +FIG00548163 FIG00548165: hypothetical protein +FIG00548165 FIG00548167: hypothetical protein +FIG00548169 FIG00548171: hypothetical protein +FIG00548173 FIG00548175: hypothetical protein +FIG00548175 FIG00548177: hypothetical protein +FIG00548179 FIG00548182: hypothetical protein +FIG00548185 FIG00548186: hypothetical protein +FIG00548190 ABC-type transporter, permease component +FIG00548195 FIG00548196: hypothetical protein +FIG00548196 FIG00548199: hypothetical protein +FIG00548210 FIG00548211: hypothetical protein +FIG00548218 FIG00548219: hypothetical protein +FIG00548229 FIG00548230: hypothetical protein +FIG00548232 FIG00548233: hypothetical protein +FIG00548234 predicted permease +FIG00548239 FIG00548242: hypothetical protein +FIG00548242 FIG00548244: hypothetical protein +FIG00548254 iron compound ABC transporter, periplasmic iron-compound-binding protein +FIG00548256 FIG00548257: hypothetical protein +FIG00548266 FIG00548267: hypothetical protein +FIG00548267 FIG00548268: hypothetical protein +FIG00548277 FIG00548279: hypothetical protein +FIG00548300 FIG00548301: hypothetical protein +FIG00548301 FIG00548303: hypothetical protein +FIG00548304 FIG00548305: hypothetical protein +FIG00548308 alkanal monooxygenase +FIG00548312 FIG00548314: hypothetical protein +FIG00548332 FIG00548336: hypothetical protein +FIG00548343 FIG00548349: hypothetical protein +FIG00548355 FIG00548359: hypothetical protein +FIG00548367 FIG00548368: hypothetical protein +FIG00548368 cell wall biogenesis glycosyltransferase +FIG00548372 FIG00548373: hypothetical protein +FIG00548378 FIG00548380: hypothetical protein +FIG00548384 ABC-type transporter, periplasmic component +FIG00548388 FIG00548389: hypothetical protein +FIG00548417 FIG00548418: hypothetical protein +FIG00548434 FIG00548436: hypothetical protein +FIG00548445 FIG00548447: hypothetical protein +FIG00548447 FIG00548449: hypothetical protein +FIG00548451 FIG00548452: hypothetical protein +FIG00548453 FIG00548455: hypothetical protein +FIG00548458 HigB toxin protein +FIG00548465 FIG00548470: hypothetical protein +FIG00548473 FIG00548476: hypothetical protein +FIG00548479 FIG00548480: hypothetical protein +FIG00548484 FIG00548485: hypothetical protein +FIG00548503 FIG00548504: hypothetical protein +FIG00548531 TYPE B CARBOXYLESTERASE (EC 3.1.1.1) +FIG00548532 FIG00548534: hypothetical protein +FIG00548541 FIG00548543: hypothetical protein +FIG00548552 FIG00548554: hypothetical protein +FIG00548558 FIG00548562: hypothetical protein +FIG00548571 FIG00548576: hypothetical protein +FIG00548578 FIG00548581: hypothetical protein +FIG00548586 beta-lactamase class C +FIG00548588 FIG00548589: hypothetical protein +FIG00548601 FIG00548603: hypothetical protein +FIG00548605 FIG00548606: hypothetical protein +FIG00548613 non-ribosomal peptide synthetase modules and related proteins +FIG00548617 FIG00548618: hypothetical protein +FIG00548618 FIG00548619: hypothetical protein +FIG00548622 FIG00548623: hypothetical protein +FIG00548628 FIG00548629: hypothetical protein +FIG00548630 FIG00548631: hypothetical protein +FIG00548633 FIG00548635: hypothetical protein +FIG00548641 FIG00548642: hypothetical protein +FIG00548644 FIG00548647: hypothetical protein +FIG00548648 FIG00548649: hypothetical protein +FIG00548652 FIG00548655: hypothetical protein +FIG00548665 FIG00548667: hypothetical protein +FIG00548667 FIG00548668: hypothetical protein +FIG00548668 FIG00548670: hypothetical protein +FIG00548675 FIG00548678: hypothetical protein +FIG00548697 FIG00548699: hypothetical protein +FIG00548710 PTS system, N-acetylglucosamine-specific IIB component (EC 2.7.1.69) / PTS system, N-acetylglucosamine-specific IIC component / PTS system, N-acetylglucosamine-specific IIA component +FIG00548719 FIG00548721: hypothetical protein +FIG00548723 daunorubicin C-13 ketoreductase +FIG00548726 FIG00548735: hypothetical protein +FIG00548741 FIG00548743: hypothetical protein +FIG00548765 FIG00548766: hypothetical protein +FIG00548768 FIG00548772: hypothetical protein +FIG00548780 FIG00548782: hypothetical protein +FIG00548782 FIG00548784: hypothetical protein +FIG00548785 FIG00548787: hypothetical protein +FIG00548787 FIG00548792: hypothetical protein +FIG00548792 FIG00548793: hypothetical protein +FIG00548795 FIG00548796: hypothetical protein +FIG00548803 FIG00548804: hypothetical protein +FIG00548812 FIG00548816: hypothetical protein +FIG00548820 FIG00548821: hypothetical protein +FIG00548822 FIG00548823: hypothetical protein +FIG00548826 FIG00548828: hypothetical protein +FIG00548831 FIG00548834: hypothetical protein +FIG00548854 FIG00548860: hypothetical protein +FIG00548862 FIG00548866: hypothetical protein +FIG00548872 Coenzyme F420-dependent N5,N10-methylene tetrahydromethanopterin reductase and related flavin-dependent oxidoreductases (EC 1.14.14.3) +FIG00548873 FIG00548875: hypothetical protein +FIG00548876 FIG00544345: hypothetical protein +FIG00548890 COG1802: Transcriptional regulators +FIG00548895 FIG00548896: hypothetical protein +FIG00548910 FIG00548916: hypothetical protein +FIG00548943 putative iron ABC transport system, ATP-binding protein +FIG00548944 FIG00548945: hypothetical protein +FIG00548950 FIG00548951: hypothetical protein +FIG00548955 similar to Acyl-CoA synthetase (AMP-forming)/AMP-acid ligase +FIG00548979 FIG00548980: hypothetical protein +FIG00548980 FIG00548982: hypothetical protein +FIG00548997 FIG00548998: hypothetical protein +FIG00549009 FIG00549010: hypothetical protein +FIG00549015 FIG00549019: hypothetical protein +FIG00549030 FIG00549031: hypothetical protein +FIG00549032 FIG00549037: hypothetical protein +FIG00549058 FIG00549059: hypothetical protein +FIG00549065 FIG00549067: hypothetical protein +FIG00549067 FIG00549069: hypothetical protein +FIG00549070 FIG00549071: hypothetical protein +FIG00549071 FIG00549074: hypothetical protein +FIG00549088 FIG00549090: hypothetical protein +FIG00549092 FIG00549094: hypothetical protein +FIG00549102 FIG00549106: hypothetical protein +FIG00549114 FIG00549115: hypothetical protein +FIG00549115 isochorismatase +FIG00549118 FIG00549122: hypothetical protein +FIG00549122 FIG00549123: hypothetical protein +FIG00549123 FIG00549127: hypothetical protein +FIG00549127 Conserved hypothetical DNA-binding protein +FIG00549128 FIG00549131: hypothetical protein +FIG00549148 FIG00549150: hypothetical protein +FIG00549150 FIG00549151: hypothetical protein +FIG00549162 FIG00549167: hypothetical protein +FIG00549168 FIG00549169: hypothetical protein +FIG00549174 FIG00549175: hypothetical protein +FIG00549177 FIG00549179: hypothetical protein +FIG00549183 Pigment protein +FIG00549191 FIG00549194: hypothetical protein +FIG00549194 FIG00549195: hypothetical protein +FIG00549202 FIG00549203: hypothetical protein +FIG00549203 FIG00549204: hypothetical protein +FIG00549205 FIG00549207: hypothetical protein +FIG00549208 FIG00549210: hypothetical protein +FIG00549227 FIG00549229: hypothetical protein +FIG00549230 FIG00549231: hypothetical protein +FIG00549243 FIG00549247: hypothetical protein +FIG00549248 FIG00549254: hypothetical protein +FIG00549271 FIG00549272: hypothetical protein +FIG00549297 FIG00549298: hypothetical protein +FIG00549301 FIG00549302: hypothetical protein +FIG00549317 FIG00549318: hypothetical protein +FIG00549318 FIG00549319: hypothetical protein +FIG00549334 FIG00549336: hypothetical protein +FIG00549336 FIG00549338: hypothetical protein +FIG00549338 FIG00549340: hypothetical protein +FIG00549340 COG3118: Thioredoxin domain-containing protein +FIG00549367 FIG00549370: hypothetical protein +FIG00549370 putative ABC transport system, permease protein +FIG00549376 FIG00549378: hypothetical protein +FIG00549402 FIG00549403: hypothetical protein +FIG00549410 hypothetical helicase +FIG00549414 FIG00549418: hypothetical protein +FIG00549426 FIG00549427: hypothetical protein +FIG00549432 FIG00549434: hypothetical protein +FIG00549434 FIG00549435: hypothetical protein +FIG00549447 FIG00549449: hypothetical protein +FIG00549453 FIG00549454: hypothetical protein +FIG00549476 FIG00549479: hypothetical protein +FIG00549491 FIG00549493: hypothetical protein +FIG00549493 FIG00549495: hypothetical protein +FIG00549503 YibE/F family membrane protein +FIG00549506 FIG00549509: hypothetical protein +FIG00549510 FIG00549511: hypothetical protein +FIG00549516 FIG00549520: hypothetical protein +FIG00549536 FIG00549538: hypothetical protein +FIG00549543 FIG00549545: hypothetical protein +FIG00549606 FIG00549608: hypothetical protein +FIG00549608 FIG00549609: hypothetical protein +FIG00549609 putative cation efflux transporter +FIG00549617 FIG00549618: hypothetical protein +FIG00549624 PUTATIVE ALIPHATIC SULFONATES UPTAKE ABC TRANSPORTER SECRETED SOLUTE-BINDING PROTEIN +FIG00549635 FIG00549636: hypothetical protein +FIG00549636 FIG00549637: hypothetical protein +FIG00549669 FIG00549670: hypothetical protein +FIG00549678 PAS/PAC domain (EC 2.7.3.-) +FIG00549704 putative PS1 protein +FIG00549719 FIG00549720: hypothetical protein +FIG00549742 FIG00549751: hypothetical protein +FIG00549757 FIG00549758: hypothetical protein +FIG00549773 cytochrome P450-like putative monoxygenase,C-terminal fragment +FIG00549807 FIG00549812: hypothetical protein +FIG00549819 FIG00549822: hypothetical protein +FIG00549830 FIG00549834: hypothetical protein +FIG00549850 FIG00549857: hypothetical protein +FIG00549864 FIG00549867: hypothetical protein +FIG00549879 FIG00549880: hypothetical protein +FIG00549880 FIG00549881: hypothetical protein +FIG00549883 FIG00549885: hypothetical protein +FIG00549889 FIG00549892: hypothetical protein +FIG00549900 FIG00549904: hypothetical protein +FIG00549908 FIG00549910: hypothetical protein +FIG00549910 FIG00549911: hypothetical protein +FIG00549923 FIG00549925: hypothetical protein +FIG00549935 FIG00549937: hypothetical protein +FIG00549951 FIG00549954: hypothetical protein +FIG00549966 FIG00549969: hypothetical protein +FIG00549994 FIG00549995: hypothetical protein +FIG00549997 FIG00549999: hypothetical protein +FIG00550002 conserved 13e12 repeat family protein +FIG00550004 FIG00550008: hypothetical protein +FIG00550039 FIG00550041: hypothetical protein +FIG00550085 FIG00550086: hypothetical protein +FIG00550097 FIG00550099: hypothetical protein +FIG00550107 FIG00550109: hypothetical protein +FIG00550109 FIG00550112: hypothetical protein +FIG00550125 FIG00550128: hypothetical protein +FIG00550130 FIG00550137: hypothetical protein +FIG00550174 FIG00550175: hypothetical protein +FIG00550175 FIG00550178: hypothetical protein +FIG00550178 FIG00550179: hypothetical protein +FIG00550179 FIG00550180: hypothetical protein +FIG00550180 FIG00550184: hypothetical protein +FIG00550186 FIG00550187: hypothetical protein +FIG00550189 FIG00550195: hypothetical protein +FIG00550195 FIG00550197: hypothetical protein +FIG00550197 FIG00550200: hypothetical protein +FIG00550200 FIG00550201: hypothetical protein +FIG00550201 FIG00550204: hypothetical protein +FIG00550204 FIG00550206: hypothetical protein +FIG00550206 FIG00550207: hypothetical protein +FIG00550207 FIG00550208: hypothetical protein +FIG00550208 FIG00550209: hypothetical protein +FIG00550209 FIG00550213: hypothetical protein +FIG00550213 FIG00550214: hypothetical protein +FIG00550214 FIG00550215: hypothetical protein +FIG00550219 FIG00550224: hypothetical protein +FIG00550224 FIG00550225: hypothetical protein +FIG00550225 FIG00550226: hypothetical protein +FIG00550226 FIG00550227: hypothetical protein +FIG00550229 FIG00550230: hypothetical protein +FIG00550230 FIG00550231: hypothetical protein +FIG00550231 FIG00550232: hypothetical protein +FIG00550232 FIG00550233: hypothetical protein +FIG00550233 FIG00550235: hypothetical protein +FIG00550235 FIG00550236: hypothetical protein +FIG00550236 FIG00550238: hypothetical protein +FIG00550238 FIG00550240: hypothetical protein +FIG00550240 FIG00550241: hypothetical protein +FIG00550242 FIG00550245: hypothetical protein +FIG00550245 FIG00550246: hypothetical protein +FIG00550248 FIG00550250: hypothetical protein +FIG00550252 FIG00550254: hypothetical protein +FIG00550254 FIG00550255: hypothetical protein +FIG00550256 FIG00550259: hypothetical protein +FIG00550259 FIG00550260: hypothetical protein +FIG00550260 FIG00550264: hypothetical protein +FIG00550264 FIG00550265: hypothetical protein +FIG00550265 FIG00550266: hypothetical protein +FIG00550266 FIG00550267: hypothetical protein +FIG00550267 FIG00550268: hypothetical protein +FIG00550268 FIG00550269: hypothetical protein +FIG00550269 FIG00550270: hypothetical protein +FIG00550270 FIG00550274: hypothetical protein +FIG00550274 FIG00550276: hypothetical protein +FIG00550276 FIG00550277: hypothetical protein +FIG00550277 FIG00550278: hypothetical protein +FIG00550278 FIG00550279: hypothetical protein +FIG00550279 FIG00550281: hypothetical protein +FIG00550281 FIG00550284: hypothetical protein +FIG00550284 FIG00550285: hypothetical protein +FIG00550286 FIG00550287: hypothetical protein +FIG00550287 FIG00550288: hypothetical protein +FIG00550288 FIG00550290: hypothetical protein +FIG00550290 FIG00550293: hypothetical protein +FIG00550293 FIG00550294: hypothetical protein +FIG00550294 FIG00550295: hypothetical protein +FIG00550295 FIG00550299: hypothetical protein +FIG00550302 potassium efflux system KefA +FIG00550303 FIG00550304: hypothetical protein +FIG00550305 FIG00550306: hypothetical protein +FIG00550306 FIG00550307: hypothetical protein +FIG00550307 FIG00550310: hypothetical protein +FIG00550310 FIG00550311: hypothetical protein +FIG00550311 FIG00550314: hypothetical protein +FIG00550315 FIG00550316: hypothetical protein +FIG00550316 FIG00550318: hypothetical protein +FIG00550319 FIG00550320: hypothetical protein +FIG00550320 FIG00550322: hypothetical protein +FIG00550322 FIG00550323: hypothetical protein +FIG00550323 FIG00550324: hypothetical protein +FIG00550324 FIG00550326: hypothetical protein +FIG00550326 FIG00550328: hypothetical protein +FIG00550328 hypothetical protein +FIG00550330 FIG00550331: hypothetical protein +FIG00550331 FIG00550332: hypothetical protein +FIG00550332 FIG00550334: hypothetical protein +FIG00550334 FIG00550335: hypothetical protein +FIG00550335 FIG00550336: hypothetical protein +FIG00550336 FIG00550337: hypothetical protein +FIG00550337 FIG00550338: hypothetical protein +FIG00550338 FIG00550340: hypothetical protein +FIG00550340 FIG00550341: hypothetical protein +FIG00550341 CRISPR-associated protein, Csy3 family +FIG00550342 FIG00550343: hypothetical protein +FIG00550343 FIG00550346: hypothetical protein +FIG00550346 FIG00550351: hypothetical protein +FIG00550351 FIG00550352: hypothetical protein +FIG00550352 FIG00550353: hypothetical protein +FIG00550353 FIG00550356: hypothetical protein +FIG00550356 FIG00550357: hypothetical protein +FIG00550357 FIG00550358: hypothetical protein +FIG00550358 FIG00550367: hypothetical protein +FIG00550367 FIG00550368: hypothetical protein +FIG00550368 FIG00550370: hypothetical protein +FIG00550370 FIG00550371: hypothetical protein +FIG00550371 FIG00550372: hypothetical protein +FIG00550372 FIG00550374: hypothetical protein +FIG00550374 FIG00550376: hypothetical protein +FIG00550377 FIG00550378: hypothetical protein +FIG00550378 hypothetical protein +FIG00550379 FIG00550380: hypothetical protein +FIG00550380 FIG00550381: hypothetical protein +FIG00550382 FIG00550383: hypothetical protein +FIG00550383 FIG00550384: hypothetical protein +FIG00550384 FIG00550385: hypothetical protein +FIG00550385 FIG00550386: hypothetical protein +FIG00550386 FIG00550387: hypothetical protein +FIG00550388 FIG00550390: hypothetical protein +FIG00550390 hypothetical protein +FIG00550393 FIG00550394: hypothetical protein +FIG00550395 FIG00550396: hypothetical protein +FIG00550396 FIG00550397: hypothetical protein +FIG00550397 FIG00550398: hypothetical protein +FIG00550398 FIG00550401: hypothetical protein +FIG00550401 FIG00550403: hypothetical protein +FIG00550403 FIG00550404: hypothetical protein +FIG00550404 FIG00550407: hypothetical protein +FIG00550407 FIG00550408: hypothetical protein +FIG00550408 FIG00550409: hypothetical protein +FIG00550409 FIG00550413: hypothetical protein +FIG00550413 FIG00550414: hypothetical protein +FIG00550414 FIG00550415: hypothetical protein +FIG00550418 FIG00550419: hypothetical protein +FIG00550420 FIG00550422: hypothetical protein +FIG00550424 FIG00550425: hypothetical protein +FIG00550425 FIG00550426: hypothetical protein +FIG00550426 FIG00550428: hypothetical protein +FIG00550428 FIG00550429: hypothetical protein +FIG00550429 FIG00550430: hypothetical protein +FIG00550430 FIG00550431: hypothetical protein +FIG00550432 FIG00550433: hypothetical protein +FIG00550433 FIG00550436: hypothetical protein +FIG00550437 FIG00550438: hypothetical protein +FIG00550438 FIG00550439: hypothetical protein +FIG00550442 FIG00550443: hypothetical protein +FIG00550443 FIG00550444: hypothetical protein +FIG00550444 FIG00550447: hypothetical protein +FIG00550448 FIG00550449: hypothetical protein +FIG00550449 FIG00550450: hypothetical protein +FIG00550450 FIG00550454: hypothetical protein +FIG00550454 FIG00550455: hypothetical protein +FIG00550455 FIG00550456: hypothetical protein +FIG00550456 FIG00550457: hypothetical protein +FIG00550457 FIG00550460: hypothetical protein +FIG00550460 Flavoprotein WrbA +FIG00550461 FIG00550464: hypothetical protein +FIG00550464 FIG00550466: hypothetical protein +FIG00550466 FIG00550468: hypothetical protein +FIG00550468 FIG00550469: hypothetical protein +FIG00550469 FIG00550470: hypothetical protein +FIG00550470 FIG00550471: hypothetical protein +FIG00550471 hypothetical protein +FIG00550472 FIG00550473: hypothetical protein +FIG00550473 FIG00550476: hypothetical protein +FIG00550476 FIG00550481: hypothetical protein +FIG00550481 FIG00550482: hypothetical protein +FIG00550482 FIG00550484: hypothetical protein +FIG00550484 FIG00550485: hypothetical protein +FIG00550485 FIG00550486: hypothetical protein +FIG00550486 FIG00550487: hypothetical protein +FIG00550487 FIG00550488: hypothetical protein +FIG00550488 FIG00550489: hypothetical protein +FIG00550489 FIG00550492: hypothetical protein +FIG00550493 hypothetical protein +FIG00550495 FIG00550496: hypothetical protein +FIG00550496 FIG00550498: hypothetical protein +FIG00550498 FIG00550499: hypothetical protein +FIG00550503 FIG00550504: hypothetical protein +FIG00550504 FIG00550509: hypothetical protein +FIG00550517 FIG00550518: hypothetical protein +FIG00550518 FIG00550520: hypothetical protein +FIG00550520 FIG00550522: hypothetical protein +FIG00550524 FIG00550525: hypothetical protein +FIG00550525 FIG00550527: hypothetical protein +FIG00550527 FIG00550528: hypothetical protein +FIG00550528 FIG00550530: hypothetical protein +FIG00550530 FIG00550531: hypothetical protein +FIG00550531 hypothetical protein +FIG00550532 FIG00550534: hypothetical protein +FIG00550534 FIG00550535: hypothetical protein +FIG00550535 FIG00550536: hypothetical protein +FIG00550536 FIG00550538: hypothetical protein +FIG00550540 FIG00550542: hypothetical protein +FIG00550543 FIG00550544: hypothetical protein +FIG00550544 FIG00550547: hypothetical protein +FIG00550547 FIG00550548: hypothetical protein +FIG00550549 FIG00550550: hypothetical protein +FIG00550550 FIG00550551: hypothetical protein +FIG00550551 FIG00550552: hypothetical protein +FIG00550552 FIG00550553: hypothetical protein +FIG00550553 FIG00550554: hypothetical protein +FIG00550554 FIG00550557: hypothetical protein +FIG00550557 FIG00550558: hypothetical protein +FIG00550558 FIG00550560: hypothetical protein +FIG00550562 FIG00550563: hypothetical protein +FIG00550563 Initiator RepB protein +FIG00550566 FIG00550568: hypothetical protein +FIG00550568 FIG00550569: hypothetical protein +FIG00550570 FIG00550572: hypothetical protein +FIG00550572 FIG00550574: hypothetical protein +FIG00550574 FIG00550575: hypothetical protein +FIG00550575 Uncharacterized protein COG3461 +FIG00550583 FIG00550585: hypothetical protein +FIG00550586 FIG00550589: hypothetical protein +FIG00550589 FIG00550590: hypothetical protein +FIG00550590 hypothetical protein +FIG00550591 FIG00550592: hypothetical protein +FIG00550592 FIG00550595: hypothetical protein +FIG00550595 FIG00550597: hypothetical protein +FIG00550597 FIG00550598: hypothetical protein +FIG00550601 FIG00550602: hypothetical protein +FIG00550607 FIG00550609: hypothetical protein +FIG00550609 FIG00550610: hypothetical protein +FIG00550615 hypothetical protein +FIG00550616 FIG00550617: hypothetical protein +FIG00550617 FIG00550619: hypothetical protein +FIG00550619 FIG00550620: hypothetical protein +FIG00550621 FIG00550622: hypothetical protein +FIG00550622 FIG00550623: hypothetical protein +FIG00550623 FIG00550627: hypothetical protein +FIG00550627 FIG00550630: hypothetical protein +FIG00550630 FIG00550631: hypothetical protein +FIG00550631 FIG00550632: hypothetical protein +FIG00550635 FIG00550636: hypothetical protein +FIG00550636 FIG00550637: hypothetical protein +FIG00550638 FIG00550639: hypothetical protein +FIG00550639 FIG00550640: hypothetical protein +FIG00550640 FIG00550642: hypothetical protein +FIG00550642 FIG00550644: hypothetical protein +FIG00550646 FIG00550647: hypothetical protein +FIG00550647 FIG00550650: hypothetical protein +FIG00550650 FIG00550651: hypothetical protein +FIG00550651 FIG00550654: hypothetical protein +FIG00550654 FIG00550655: hypothetical protein +FIG00550658 FIG00550659: hypothetical protein +FIG00550659 FIG00550663: hypothetical protein +FIG00550663 FIG00550664: hypothetical protein +FIG00550664 FIG00550666: hypothetical protein +FIG00550666 dolichyl-phosphate mannose synthase related protein +FIG00550667 FIG00550668: hypothetical protein +FIG00550670 FIG00550671: hypothetical protein +FIG00550671 FIG00550676: hypothetical protein +FIG00550676 FIG00550677: hypothetical protein +FIG00550678 FIG00550679: hypothetical protein +FIG00550679 FIG00550680: hypothetical protein +FIG00550681 FIG00550684: hypothetical protein +FIG00550684 FIG00550685: hypothetical protein +FIG00550685 FIG00550686: hypothetical protein +FIG00550686 FIG00550687: hypothetical protein +FIG00550687 FIG00550688: hypothetical protein +FIG00550688 YciL protein / Cell division protein BolA +FIG00550689 sodium/hydrogen antiporter family protein +FIG00550692 FIG00550694: hypothetical protein +FIG00550695 FIG00550697: hypothetical protein +FIG00550697 FIG00550698: hypothetical protein +FIG00550700 FIG00550701: hypothetical protein +FIG00550703 FIG00550704: hypothetical protein +FIG00550704 FIG00550706: hypothetical protein +FIG00550707 FIG00550708: hypothetical protein +FIG00550708 FIG00550709: hypothetical protein +FIG00550714 FIG00550715: hypothetical protein +FIG00550716 FIG00550717: hypothetical protein +FIG00550717 FIG00550718: hypothetical protein +FIG00550718 FIG00550719: hypothetical protein +FIG00550721 FIG00550722: hypothetical protein +FIG00550722 FIG00550723: hypothetical protein +FIG00550723 FIG00550725: hypothetical protein +FIG00550725 FIG00550726: hypothetical protein +FIG00550726 FIG00550729: hypothetical protein +FIG00550729 FIG00550730: hypothetical protein +FIG00550730 FIG00550731: hypothetical protein +FIG00550731 FIG00550734: hypothetical protein +FIG00550734 FIG00550736: hypothetical protein +FIG00550736 FIG00550737: hypothetical protein +FIG00550737 FIG00550738: hypothetical protein +FIG00550738 FIG00550741: hypothetical protein +FIG00550741 FIG00550743: hypothetical protein +FIG00550744 FIG00550745: hypothetical protein +FIG00550746 FIG00550747: hypothetical protein +FIG00550747 FIG00550749: hypothetical protein +FIG00550749 FIG00550751: hypothetical protein +FIG00550751 FIG00550752: hypothetical protein +FIG00550752 FIG00550753: hypothetical protein +FIG00550753 FIG00550754: hypothetical protein +FIG00550756 FIG00550757: hypothetical protein +FIG00550757 FIG00550759: hypothetical protein +FIG00550759 FIG00550765: hypothetical protein +FIG00550766 FIG00550767: hypothetical protein +FIG00550767 FIG00550769: hypothetical protein +FIG00550770 hypothetical protein +FIG00550772 FIG00550773: hypothetical protein +FIG00550776 FIG00550777: hypothetical protein +FIG00550777 FIG00550778: hypothetical protein +FIG00550778 FIG00550780: hypothetical protein +FIG00550780 FIG00550782: hypothetical protein +FIG00550782 FIG00550784: hypothetical protein +FIG00550784 FIG00550785: hypothetical protein +FIG00550785 FIG00550787: hypothetical protein +FIG00550788 FIG00550789: hypothetical protein +FIG00550789 FIG00550790: hypothetical protein +FIG00550790 FIG00550791: hypothetical protein +FIG00550794 FIG00550796: hypothetical protein +FIG00550797 FIG00550800: hypothetical protein +FIG00550800 FIG00550803: hypothetical protein +FIG00550804 FIG00550805: hypothetical protein +FIG00550805 FIG00550807: hypothetical protein +FIG00550807 FIG00550808: hypothetical protein +FIG00550808 FIG00550809: hypothetical protein +FIG00550809 FIG00550813: hypothetical protein +FIG00550813 FIG00550814: hypothetical protein +FIG00550814 FIG00550815: hypothetical protein +FIG00550815 FIG00550817: hypothetical protein +FIG00550818 FIG00550819: hypothetical protein +FIG00550820 FIG00550821: hypothetical protein +FIG00550821 FIG00550822: hypothetical protein +FIG00550822 FIG00550823: hypothetical protein +FIG00550829 FIG00550831: hypothetical protein +FIG00550831 FIG00550832: hypothetical protein +FIG00550834 FIG00550835: hypothetical protein +FIG00550835 FIG00550837: hypothetical protein +FIG00550837 FIG00550839: hypothetical protein +FIG00550839 FIG00550840: hypothetical protein +FIG00550840 FIG00550845: hypothetical protein +FIG00550845 CRISPR-associated helicase Cas3, Yersinia-type +FIG00550847 FIG00550848: hypothetical protein +FIG00550848 FIG00550849: hypothetical protein +FIG00550849 hypothetical protein +FIG00550852 FIG00550853: hypothetical protein +FIG00550853 FIG00550854: hypothetical protein +FIG00550854 FIG00550855: hypothetical protein +FIG00550855 FIG00550858: hypothetical protein +FIG00550858 FIG00550859: hypothetical protein +FIG00550863 FIG00550864: hypothetical protein +FIG00550864 FIG00550865: hypothetical protein +FIG00550871 FIG00550872: hypothetical protein +FIG00550875 FIG00550876: hypothetical protein +FIG00550879 FIG00550881: hypothetical protein +FIG00550881 FIG00550883: hypothetical protein +FIG00550883 FIG00550884: hypothetical protein +FIG00550885 FIG00550888: hypothetical protein +FIG00550888 FIG00550889: hypothetical protein +FIG00550889 FIG00550892: hypothetical protein +FIG00550893 FIG00550900: hypothetical protein +FIG00550900 FIG00550903: hypothetical protein +FIG00550903 hypothetical protein +FIG00550905 FIG00550907: hypothetical protein +FIG00550907 FIG00550909: hypothetical protein +FIG00550909 FIG00550912: hypothetical protein +FIG00550913 FIG00550914: hypothetical protein +FIG00550914 FIG00550916: hypothetical protein +FIG00550916 FIG00550918: hypothetical protein +FIG00550920 FIG00550922: hypothetical protein +FIG00550922 FIG00550923: hypothetical protein +FIG00550923 FIG00550924: hypothetical protein +FIG00550924 FIG00550926: hypothetical protein +FIG00550926 FIG00550927: hypothetical protein +FIG00550927 FIG00550928: hypothetical protein +FIG00550928 FIG00550929: hypothetical protein +FIG00550929 FIG00550930: hypothetical protein +FIG00550930 FIG00550932: hypothetical protein +FIG00550932 FIG00550934: hypothetical protein +FIG00550934 FIG00550936: hypothetical protein +FIG00550936 FIG00550939: hypothetical protein +FIG00550939 FIG00550940: hypothetical protein +FIG00550940 FIG00550943: hypothetical protein +FIG00550943 FIG00550946: hypothetical protein +FIG00550946 FIG00550947: hypothetical protein +FIG00550947 sensory box sensor histidine kinase/response regulator, putative +FIG00550948 FIG00550949: hypothetical protein +FIG00550949 FIG00550952: hypothetical protein +FIG00550952 FIG00550953: hypothetical protein +FIG00550953 FIG00550954: hypothetical protein +FIG00550955 FIG00550958: hypothetical protein +FIG00550958 FIG00550959: hypothetical protein +FIG00550960 FIG00550964: hypothetical protein +FIG00550964 FIG00550966: hypothetical protein +FIG00550970 FIG00550971: hypothetical protein +FIG00550972 FIG00550975: hypothetical protein +FIG00550975 FIG00550976: hypothetical protein +FIG00550976 FIG00550977: hypothetical protein +FIG00550982 FIG00550983: hypothetical protein +FIG00550983 FIG00550984: hypothetical protein +FIG00550984 FIG00550985: hypothetical protein +FIG00550985 FIG00550986: hypothetical protein +FIG00550986 FIG00550987: hypothetical protein +FIG00550988 FIG00550989: hypothetical protein +FIG00550989 FIG00550990: hypothetical protein +FIG00550990 FIG00550991: hypothetical protein +FIG00550991 FIG00550992: hypothetical protein +FIG00550992 LPS-assembly lipoprotein RlpB precursor (Rare lipoprotein B) +FIG00550998 FIG00551000: hypothetical protein +FIG00551000 FIG00551001: hypothetical protein +FIG00551001 FIG00551002: hypothetical protein +FIG00551002 FIG00551003: hypothetical protein +FIG00551005 FIG00551006: hypothetical protein +FIG00551006 FIG00551007: hypothetical protein +FIG00551007 FIG00551008: hypothetical protein +FIG00551008 FIG00551010: hypothetical protein +FIG00551011 FIG00551013: hypothetical protein +FIG00551013 FIG00551015: hypothetical protein +FIG00551017 FIG00551018: hypothetical protein +FIG00551018 FIG00551023: hypothetical protein +FIG00551023 FIG00551025: hypothetical protein +FIG00551031 FIG00551033: hypothetical protein +FIG00551033 FIG00551034: hypothetical protein +FIG00551035 FIG00551036: hypothetical protein +FIG00551036 FIG00551037: hypothetical protein +FIG00551037 FIG00551038: hypothetical protein +FIG00551038 FIG00551039: hypothetical protein +FIG00551042 FIG00551044: hypothetical protein +FIG00551044 FIG00551045: hypothetical protein +FIG00551046 FIG00551047: hypothetical protein +FIG00551047 hypothetical protein +FIG00551049 FIG00551050: hypothetical protein +FIG00551050 FIG00551052: hypothetical protein +FIG00551058 GIY-YIG catalytic domain protein +FIG00551063 FIG00551065: hypothetical protein +FIG00551065 FIG00551066: hypothetical protein +FIG00551066 FIG00551067: hypothetical protein +FIG00551067 FIG00551069: hypothetical protein +FIG00551069 FIG00551071: hypothetical protein +FIG00551071 FIG00551072: hypothetical protein +FIG00551072 FIG00551073: hypothetical protein +FIG00551074 Phytochelatin synthase (EC 2.3.2.15), bacterial type +FIG00551075 FIG00551076: hypothetical protein +FIG00551076 FIG00551079: hypothetical protein +FIG00551079 FIG00551080: hypothetical protein +FIG00551080 FIG00551084: hypothetical protein +FIG00551084 FIG00551085: hypothetical protein +FIG00551091 FIG00551093: hypothetical protein +FIG00551093 FIG00551094: hypothetical protein +FIG00551094 FIG00551095: hypothetical protein +FIG00551095 4Fe-4S ferredoxin, iron-sulfur binding +FIG00551105 FIG00551106: hypothetical protein +FIG00551106 FIG00551107: hypothetical protein +FIG00551107 FIG00551109: hypothetical protein +FIG00551110 FIG00551114: hypothetical protein +FIG00551114 FIG00551120: hypothetical protein +FIG00551120 FIG00551124: hypothetical protein +FIG00551124 FIG00551125: hypothetical protein +FIG00551125 CbhE protein +FIG00551128 FIG00551130: hypothetical protein +FIG00551131 FIG00551132: hypothetical protein +FIG00551132 FIG00551134: hypothetical protein +FIG00551134 FIG00551135: hypothetical protein +FIG00551135 FIG00551137: hypothetical protein +FIG00551137 FIG00551139: hypothetical protein +FIG00551139 FIG00551141: hypothetical protein +FIG00551141 FIG00551143: hypothetical protein +FIG00551143 FIG00551144: hypothetical protein +FIG00551144 FIG00551148: hypothetical protein +FIG00551150 FIG00551151: hypothetical protein +FIG00551153 FIG00551154: hypothetical protein +FIG00551155 FIG00551157: hypothetical protein +FIG00551160 Lanthionine biosynthesis protein LanM +FIG00551161 FIG00551163: hypothetical protein +FIG00551163 FIG00551164: hypothetical protein +FIG00551170 FIG00551171: hypothetical protein +FIG00551171 hypothetical protein +FIG00551175 FIG00551178: hypothetical protein +FIG00551178 FIG00551179: hypothetical protein +FIG00551179 FIG00551181: hypothetical protein +FIG00551181 Inner membrane protein AmpE +FIG00551185 FIG00551186: hypothetical protein +FIG00551186 FIG00551187: hypothetical protein +FIG00551187 FIG00551189: hypothetical protein +FIG00551189 FIG00551190: hypothetical protein +FIG00551190 FIG00551196: hypothetical protein +FIG00551196 FIG00551199: hypothetical protein +FIG00551200 FIG00551204: hypothetical protein +FIG00551204 FIG00551205: hypothetical protein +FIG00551205 FIG00551211: hypothetical protein +FIG00551220 FIG00551221: hypothetical protein +FIG00551221 FIG00551222: hypothetical protein +FIG00551222 FIG00551224: hypothetical protein +FIG00551227 FIG00551229: hypothetical protein +FIG00551229 FIG00551230: hypothetical protein +FIG00551230 FIG00551231: hypothetical protein +FIG00551234 FIG00551235: hypothetical protein +FIG00551236 FIG00551237: hypothetical protein +FIG00551239 FIG00551244: hypothetical protein +FIG00551244 FIG00551245: hypothetical protein +FIG00551245 FIG00551248: hypothetical protein +FIG00551249 Diphosphomevalonate decarboxylase (EC 4.1.1.33) / Isopentenyl-diphosphate delta-isomerase (EC 5.3.3.2) +FIG00551254 FIG00551256: hypothetical protein +FIG00551256 FIG00551257: hypothetical protein +FIG00551257 FIG00551263: hypothetical protein +FIG00551271 FIG00551272: hypothetical protein +FIG00551272 FIG00551274: hypothetical protein +FIG00551275 FIG00551276: hypothetical protein +FIG00551276 FIG00551277: hypothetical protein +FIG00551277 FIG00551278: hypothetical protein +FIG00551278 FIG00551279: hypothetical protein +FIG00551279 FIG00551280: hypothetical protein +FIG00551280 FIG00551281: hypothetical protein +FIG00551284 FIG00551285: hypothetical protein +FIG00551287 FIG00551289: hypothetical protein +FIG00551289 FIG00551290: hypothetical protein +FIG00551291 FIG00551297: hypothetical protein +FIG00551297 FIG00551298: hypothetical protein +FIG00551302 FIG00551306: hypothetical protein +FIG00551306 hypothetical protein +FIG00551311 FIG00551312: hypothetical protein +FIG00551312 FIG00551313: hypothetical protein +FIG00551313 FIG00551315: hypothetical protein +FIG00551315 FIG00551317: hypothetical protein +FIG00551322 FIG00551323: hypothetical protein +FIG00551324 FIG00551328: hypothetical protein +FIG00551329 FIG00551330: hypothetical protein +FIG00551330 polysaccharide biosynthesis protein +FIG00551331 FIG00551333: hypothetical protein +FIG00551333 FIG00551334: hypothetical protein +FIG00551338 FIG00551341: hypothetical protein +FIG00551346 FIG00551349: hypothetical protein +FIG00551349 FIG00551351: hypothetical protein +FIG00551351 FIG00551355: hypothetical protein +FIG00551355 FIG00551357: hypothetical protein +FIG00551361 FIG00551363: hypothetical protein +FIG00551363 FIG00551364: hypothetical protein +FIG00551365 FIG00551366: hypothetical protein +FIG00551370 FIG00551372: hypothetical protein +FIG00551374 FIG00551378: hypothetical protein +FIG00551378 FIG00551379: hypothetical protein +FIG00551379 FIG00551380: hypothetical protein +FIG00551380 FIG00551381: hypothetical protein +FIG00551390 FIG00551394: hypothetical protein +FIG00551396 FIG00551397: hypothetical protein +FIG00551397 FIG00551399: hypothetical protein +FIG00551399 transporter, putative +FIG00551403 FIG00551404: hypothetical protein +FIG00551405 FIG00551406: hypothetical protein +FIG00551406 hypothetical protein +FIG00551409 FIG00551413: hypothetical protein +FIG00551413 FIG00551414: hypothetical protein +FIG00551414 FIG00551419: hypothetical protein +FIG00551419 FIG00551420: hypothetical protein +FIG00551428 FIG00551432: hypothetical protein +FIG00551443 FIG00551444: hypothetical protein +FIG00551445 FIG00551447: hypothetical protein +FIG00551447 rhodanese domain protein +FIG00551450 FIG00551453: hypothetical protein +FIG00551453 hypothetical protein +FIG00551458 FIG00551463: hypothetical protein +FIG00551464 FIG00551466: hypothetical protein +FIG00551469 FIG00551470: hypothetical protein +FIG00551473 FIG00551474: hypothetical protein +FIG00551483 FIG00551486: hypothetical protein +FIG00551486 FIG00551492: hypothetical protein +FIG00551494 FIG00551496: hypothetical protein +FIG00551498 FIG00551499: hypothetical protein +FIG00551503 FIG00551506: hypothetical protein +FIG00551506 FIG00551510: hypothetical protein +FIG00551513 polyketide synthase, putative +FIG00551515 FIG00551520: hypothetical protein +FIG00551520 hypothetical protein +FIG00551521 FIG00551522: hypothetical protein +FIG00551524 FIG00551526: hypothetical protein +FIG00551530 FIG00551533: hypothetical protein +FIG00551533 hypothetical protein +FIG00551539 FIG00551542: hypothetical protein +FIG00551542 FIG00551544: hypothetical protein +FIG00551544 FIG00551545: hypothetical protein +FIG00551545 FIG00551546: hypothetical protein +FIG00551546 FIG00551554: hypothetical protein +FIG00551556 FIG00551558: hypothetical protein +FIG00551558 FIG00551559: hypothetical protein +FIG00551563 FIG00551578: hypothetical protein +FIG00551578 FIG00551581: hypothetical protein +FIG00551585 FIG00551586: hypothetical protein +FIG00551586 FIG00551588: hypothetical protein +FIG00551588 FIG00551589: hypothetical protein +FIG00551591 CRISPR-associated helicase Cas3, Yersinia-type +FIG00551593 FIG00551594: hypothetical protein +FIG00551611 FIG00551613: hypothetical protein +FIG00551618 FIG00551621: hypothetical protein +FIG00551621 FIG00551622: hypothetical protein +FIG00551625 FIG00551628: hypothetical protein +FIG00551628 FIG00551632: hypothetical protein +FIG00551635 FIG00551638: hypothetical protein +FIG00551642 FIG00551644: hypothetical protein +FIG00551658 FIG00551663: hypothetical protein +FIG00551678 FIG00551680: hypothetical protein +FIG00551682 hypothetical protein +FIG00551688 FIG00551691: hypothetical protein +FIG00551691 hypothetical protein +FIG00551719 FIG00551722: hypothetical protein +FIG00551722 FIG00551726: hypothetical protein +FIG00551729 hypothetical protein +FIG00551734 FIG00551739: hypothetical protein +FIG00551746 FIG00551749: hypothetical protein +FIG00551755 FIG00551769: hypothetical protein +FIG00551769 FIG00551770: hypothetical protein +FIG00551781 FIG00551792: hypothetical protein +FIG00551793 FIG00551794: hypothetical protein +FIG00551801 FIG00551804: hypothetical protein +FIG00551813 FIG00551818: hypothetical protein +FIG00551818 FIG00551819: hypothetical protein +FIG00551899 FIG00551901: hypothetical protein +FIG00551901 FIG00551902: hypothetical protein +FIG00551902 Lmo0572 protein +FIG00551906 FIG00551907: hypothetical protein +FIG00551907 FIG00551908: hypothetical protein +FIG00551909 FIG00551913: hypothetical protein +FIG00551913 FIG00551914: hypothetical protein +FIG00551914 similar to MINDIN2 +FIG00551916 FIG00551917: hypothetical protein +FIG00551931 FIG00551936: hypothetical protein +FIG00551936 FIG00551937: hypothetical protein +FIG00551937 FIG00551940: hypothetical protein +FIG00551940 FIG00551943: hypothetical protein +FIG00551949 FIG00551952: hypothetical protein +FIG00551958 Mll6489 protein +FIG00551962 FIG00551971: hypothetical protein +FIG00551971 FIG00551973: hypothetical protein +FIG00551973 FIG00551978: hypothetical protein +FIG00551991 FIG00551999: hypothetical protein +FIG00551999 FIG00552000: hypothetical protein +FIG00552000 FIG00552001: hypothetical protein +FIG00552001 FIG00552003: hypothetical protein +FIG00552003 FIG00552008: hypothetical protein +FIG00552008 FIG00552016: hypothetical protein +FIG00552016 FIG00552021: hypothetical protein +FIG00552021 FIG00552023: hypothetical protein +FIG00552023 FIG00552025: hypothetical protein +FIG00552025 FIG00552028: hypothetical protein +FIG00552048 FIG00552051: hypothetical protein +FIG00552075 FIG00552079: hypothetical protein +FIG00552079 FIG00552082: hypothetical protein +FIG00552082 FIG00552105: hypothetical protein +FIG00552105 FIG00552117: hypothetical protein +FIG00552117 FIG00552120: hypothetical protein +FIG00552120 FIG00552125: hypothetical protein +FIG00552130 FIG00552132: hypothetical protein +FIG00552142 FIG00552150: hypothetical protein +FIG00552150 FIG00552153: hypothetical protein +FIG00552153 FIG00552161: hypothetical protein +FIG00552161 FIG00552163: hypothetical protein +FIG00552163 FIG00552170: hypothetical protein +FIG00552171 FIG00552183: hypothetical protein +FIG00552183 FIG00552184: hypothetical protein +FIG00552184 FIG00552193: hypothetical protein +FIG00552194 FIG00552213: hypothetical protein +FIG00552213 FIG00552214: hypothetical protein +FIG00552214 FIG00552220: hypothetical protein +FIG00552220 FIG00552225: hypothetical protein +FIG00552228 FIG00552230: hypothetical protein +FIG00552230 FIG00552239: hypothetical protein +FIG00552240 FIG00552243: hypothetical protein +FIG00552243 FIG00552253: hypothetical protein +FIG00552253 FIG00552254: hypothetical protein +FIG00552254 FIG00552257: hypothetical protein +FIG00552259 FIG00552260: hypothetical protein +FIG00552260 FIG00552271: hypothetical protein +FIG00552276 FIG00552278: hypothetical protein +FIG00552278 FIG00552280: hypothetical protein +FIG00552281 FIG00552288: hypothetical protein +FIG00552288 FIG00552291: hypothetical protein +FIG00552291 FIG00552293: hypothetical protein +FIG00552304 FIG00552317: hypothetical protein +FIG00552327 FIG00552335: hypothetical protein +FIG00552335 FIG00552336: hypothetical protein +FIG00552336 FIG00552337: hypothetical protein +FIG00552337 FIG00552340: hypothetical protein +FIG00552340 FIG00552344: hypothetical protein +FIG00552344 FIG00552348: hypothetical protein +FIG00552348 FIG00552350: hypothetical protein +FIG00552352 FIG00552353: hypothetical protein +FIG00552353 FIG00552356: hypothetical protein +FIG00552356 FIG00552358: hypothetical protein +FIG00552370 FIG00552374: hypothetical protein +FIG00552379 FIG00552380: hypothetical protein +FIG00552385 Nucleoside-diphosphate-sugar epimerases +FIG00552415 FIG00552431: hypothetical protein +FIG00552431 FIG00552432: hypothetical protein +FIG00552437 FIG00552439: hypothetical protein +FIG00552439 FIG00552450: hypothetical protein +FIG00552466 FIG00552467: hypothetical protein +FIG00552467 FIG00552471: hypothetical protein +FIG00552471 FIG00552472: hypothetical protein +FIG00552472 FIG00552475: hypothetical protein +FIG00552475 FIG00552487: hypothetical protein +FIG00552488 FIG00552489: hypothetical protein +FIG00552489 FIG00552490: hypothetical protein +FIG00552490 FIG00552492: hypothetical protein +FIG00552492 FIG00552497: hypothetical protein +FIG00552497 FIG00552498: hypothetical protein +FIG00552499 FIG00552500: hypothetical protein +FIG00552500 FIG00552507: hypothetical protein +FIG00552507 FIG00552510: hypothetical protein +FIG00552510 FIG00552520: hypothetical protein +FIG00552520 FIG00552524: hypothetical protein +FIG00552524 FIG00552525: hypothetical protein +FIG00552527 FIG00552529: hypothetical protein +FIG00552529 FIG00552530: hypothetical protein +FIG00552530 Serine esterase (EC 3.1.1.1) +FIG00552531 FIG00552532: hypothetical protein +FIG00552532 FIG00552538: hypothetical protein +FIG00552544 Outer membrane lipoprotein omp16 precursor +FIG00552546 FIG00552550: hypothetical protein +FIG00552550 FIG00552555: hypothetical protein +FIG00552555 FIG00552556: hypothetical protein +FIG00552574 FIG00552578: hypothetical protein +FIG00552578 FIG00552580: hypothetical protein +FIG00552580 FIG00552582: hypothetical protein +FIG00552582 FIG00552583: hypothetical protein +FIG00552583 FIG00552587: hypothetical protein +FIG00552587 FIG00552591: hypothetical protein +FIG00552591 Putative glutathione synthase +FIG00552603 FIG00552607: hypothetical protein +FIG00552607 FIG00552610: hypothetical protein +FIG00552615 FIG00552624: hypothetical protein +FIG00552624 Tetrapyrrole (Corrin-Porphyrin) methylase family protein +FIG00552631 FIG00552639: hypothetical protein +FIG00552639 FIG00552641: hypothetical protein +FIG00552644 FIG00552646: hypothetical protein +FIG00552646 coproporphyrinogen III oxidase( EC:1.3.3.3 ) +FIG00552647 FIG00552648: hypothetical protein +FIG00552648 FIG00552655: hypothetical protein +FIG00552668 FIG00552679: hypothetical protein +FIG00552679 FIG00552683: hypothetical protein +FIG00552683 FIG00552684: hypothetical protein +FIG00552684 FIG00552689: hypothetical protein +FIG00552689 putative signal transduction protein, C-terminal ATPase domain +FIG00552691 FIG00552694: hypothetical protein +FIG00552720 FIG00552723: hypothetical protein +FIG00552723 FIG00552725: hypothetical protein +FIG00552725 FIG00552745: hypothetical protein +FIG00552750 FIG00552752: hypothetical protein +FIG00552752 FIG00552755: hypothetical protein +FIG00552755 FIG00552758: hypothetical protein +FIG00552758 FIG00552760: hypothetical protein +FIG00552770 FIG00552775: hypothetical protein +FIG00552775 FIG00552778: hypothetical protein +FIG00552778 FIG00552784: hypothetical protein +FIG00552784 FIG00552788: hypothetical protein +FIG00552788 FIG00552791: hypothetical protein +FIG00552791 FIG00552792: hypothetical protein +FIG00552792 FIG00552798: hypothetical protein +FIG00552798 FIG00552801: hypothetical protein +FIG00552801 FIG00552802: hypothetical protein +FIG00552802 FIG00552803: hypothetical protein +FIG00552803 FIG00552807: hypothetical protein +FIG00552807 FIG00552816: hypothetical protein +FIG00552817 FIG00552821: hypothetical protein +FIG00552823 FIG00552827: hypothetical protein +FIG00552833 SpoU rRNA methylase family protein +FIG00552835 FIG00552836: hypothetical protein +FIG00552836 FIG00552837: hypothetical protein +FIG00552837 FIG00552849: hypothetical protein +FIG00552849 FIG00552851: hypothetical protein +FIG00552851 FIG00552857: hypothetical protein +FIG00552857 FIG00552863: hypothetical protein +FIG00552878 FIG00552880: hypothetical protein +FIG00552880 metalloprotease, putative +FIG00552884 FIG00552885: hypothetical protein +FIG00552889 FIG00552894: hypothetical protein +FIG00552894 FIG00552895: hypothetical protein +FIG00552895 FIG00552896: hypothetical protein +FIG00552896 FIG00552900: hypothetical protein +FIG00552900 FIG00552901: hypothetical protein +FIG00552901 FIG00552903: hypothetical protein +FIG00552903 FIG00552915: hypothetical protein +FIG00552915 FIG00552916: hypothetical protein +FIG00552916 FIG00552919: hypothetical protein +FIG00552926 FIG00552928: hypothetical protein +FIG00552930 FIG00552931: hypothetical protein +FIG00552933 FIG00552942: hypothetical protein +FIG00552942 FIG00552948: hypothetical protein +FIG00552954 D-glutamate deacylase +FIG00552998 FIG00553001: hypothetical protein +FIG00553001 FIG00553004: hypothetical protein +FIG00553004 FIG00553005: hypothetical protein +FIG00553005 FIG00553006: hypothetical protein +FIG00553006 FIG00553007: hypothetical protein +FIG00553011 FIG00553021: hypothetical protein +FIG00553021 FIG00553031: hypothetical protein +FIG00553031 FIG00553047: hypothetical protein +FIG00553048 FIG00553049: hypothetical protein +FIG00553049 FIG00553050: hypothetical protein +FIG00553050 FIG00553058: hypothetical protein +FIG00553059 FIG00553060: hypothetical protein +FIG00553060 FIG00553061: hypothetical protein +FIG00553061 FIG00553063: hypothetical protein +FIG00553063 FIG00553069: hypothetical protein +FIG00553069 FIG00553075: hypothetical protein +FIG00553075 FIG00553076: hypothetical protein +FIG00553076 FIG00553078: hypothetical protein +FIG00553081 FIG00553084: hypothetical protein +FIG00553084 FIG00553085: hypothetical protein +FIG00553085 FIG00553090: hypothetical protein +FIG00553093 TRNA and rRNA cytosine-C5-methylase +FIG00553098 FIG00553100: hypothetical protein +FIG00553100 FIG00553101: hypothetical protein +FIG00553101 FIG00553106: hypothetical protein +FIG00553106 Serine-type D-Ala-D-Ala carboxypeptidase precursor (EC 3.4.16.4) +FIG00553113 FIG00553124: hypothetical protein +FIG00553124 FIG00553125: hypothetical protein +FIG00553125 Transcriptional regulatory protein rprY +FIG00553131 FIG00553139: hypothetical protein +FIG00553139 FIG00553148: hypothetical protein +FIG00553148 FIG00553151: hypothetical protein +FIG00553151 FIG00553156: hypothetical protein +FIG00553156 FIG00553157: hypothetical protein +FIG00553157 FIG00553160: hypothetical protein +FIG00553160 FIG00553164: hypothetical protein +FIG00553164 FIG00553165: hypothetical protein +FIG00553165 FIG00553180: hypothetical protein +FIG00553180 FIG00553181: hypothetical protein +FIG00553181 FIG00553186: hypothetical protein +FIG00553186 Probable lipoprotein nlpC +FIG00553189 FIG00553196: hypothetical protein +FIG00553196 FIG00553203: hypothetical protein +FIG00553203 FIG00553205: hypothetical protein +FIG00553205 FIG00553214: hypothetical protein +FIG00553214 FIG00553217: hypothetical protein +FIG00553217 FIG00553230: hypothetical protein +FIG00553230 FIG00553232: hypothetical protein +FIG00553240 FIG00553243: hypothetical protein +FIG00553243 FIG00553244: hypothetical protein +FIG00553244 Hypothetical protein YmdC, PLD phosphodiesterase domains +FIG00553256 FIG00553257: hypothetical protein +FIG00553257 FIG00553258: hypothetical protein +FIG00553258 FIG00543870: hypothetical protein +FIG00553262 FIG00553265: hypothetical protein +FIG00553265 FIG00553267: hypothetical protein +FIG00553267 FIG00553273: hypothetical protein +FIG00553273 FIG00553276: hypothetical protein +FIG00553276 FIG00553281: hypothetical protein +FIG00553281 FIG00553284: hypothetical protein +FIG00553290 Cellulose synthase operon protein C +FIG00553294 FIG00553297: hypothetical protein +FIG00553300 FIG00553301: hypothetical protein +FIG00553301 FIG00553303: hypothetical protein +FIG00553303 FIG00553308: hypothetical protein +FIG00553308 FIG00553316: hypothetical protein +FIG00553316 Ren protein +FIG00553317 FIG00553320: hypothetical protein +FIG00553323 Putative PerM family permease +FIG00553334 FIG00553336: hypothetical protein +FIG00553339 FIG00613201: hypothetical protein +FIG00553342 FIG00553350: hypothetical protein +FIG00553350 Cytochrome b(561) +FIG00553354 FIG00553356: hypothetical protein +FIG00553356 Putative ACR protein +FIG00553361 FIG00553362: hypothetical protein +FIG00553362 FIG00553365: hypothetical protein +FIG00553365 Zinc transporter ZupT +FIG00553366 FIG00553369: hypothetical protein +FIG00553374 FIG00553377: hypothetical protein +FIG00553385 FIG00553391: hypothetical protein +FIG00553391 Beta-mannosidase Man2 +FIG00553392 Putative luxR family bacterial regulatory protein +FIG00553395 FIG006303: protein yraQ +FIG00553398 FIG00553399: hypothetical protein +FIG00553399 FIG00553400: hypothetical protein +FIG00553407 FIG00553408: hypothetical protein +FIG00553415 FIG00553416: hypothetical protein +FIG00553417 Invasin +FIG00553422 FIG00553423: hypothetical protein +FIG00553429 Putative ABC transporter membrane protein +FIG00553431 FIG00553433: hypothetical protein +FIG00553433 RpiR family transcriptional regulator +FIG00553436 FIG00553440: hypothetical protein +FIG00553441 FIG00553445: hypothetical protein +FIG00553445 Putative acetyltransferase +FIG00553446 FIG00553451: hypothetical protein +FIG00553455 Multidrug translocase MdfA +FIG00553462 FIG00553464: hypothetical protein +FIG00553464 FIG00553465: hypothetical protein +FIG00553465 FIG00553466: hypothetical protein +FIG00553470 Putative HTH-type transcriptional regulator ybaO +FIG00553471 FIG00553472: hypothetical protein +FIG00553472 FIG00553474: hypothetical protein +FIG00553477 FIG00553478: hypothetical protein +FIG00553478 FIG00553479: hypothetical protein +FIG00553479 FIG00553480: hypothetical protein +FIG00553480 Sugar efflux transporter SotB +FIG00553482 FIG00553483: hypothetical protein +FIG00553483 FIG00553484: hypothetical protein +FIG00553484 FIG00553486: hypothetical protein +FIG00553486 FIG00553489: hypothetical protein +FIG00553489 UPF0410 protein YmgE +FIG00553499 FIG00553502: hypothetical protein +FIG00553502 FIG00553507: hypothetical protein +FIG00553507 FIG00553508: hypothetical protein +FIG00553510 FIG00553515: hypothetical protein +FIG00553516 FIG00553518: hypothetical protein +FIG00553525 FIG00553526: hypothetical protein +FIG00553536 FIG00553537: hypothetical protein +FIG00553537 FIG00553540: hypothetical protein +FIG00553540 FIG01045895: hypothetical protein +FIG00553542 diguanylate phosphodiesterase +FIG00553543 FIG00553545: hypothetical protein +FIG00553545 FIG00553546: hypothetical protein +FIG00553548 FIG00553549: hypothetical protein +FIG00553549 Probable protease HtpX (EC 3.4.24.-) +FIG00553553 FIG00553556: hypothetical protein +FIG00553556 FIG00553563: hypothetical protein +FIG00553563 FIG00553564: hypothetical protein +FIG00553568 FIG00553569: hypothetical protein +FIG00553575 Phospholipase A1 +FIG00553585 FIG00553587: hypothetical protein +FIG00553587 FIG00553590: hypothetical protein +FIG00553590 FIG00553594: hypothetical protein +FIG00553594 FIG00553598: hypothetical protein +FIG00553599 COG3541: Predicted nucleotidyltransferase +FIG00553605 Putative ATP-dependent RNA helicase-like protein +FIG00553606 FIG00553607: hypothetical protein +FIG00553607 FIG00553612: hypothetical protein +FIG00553612 COG2320: Uncharacterized conserved protein +FIG00553613 FIG00553614: hypothetical protein +FIG00553614 Possible oxidoreductase +FIG00553620 FIG00553622: hypothetical protein +FIG00553622 FIG00553623: hypothetical protein +FIG00553623 FIG00553626: hypothetical protein +FIG00553628 Putative metalloprotease yggG (EC 3.4.24.-) +FIG00553637 FIG00553641: hypothetical protein +FIG00553641 FIG00553647: hypothetical protein +FIG00553650 FIG01045643: hypothetical protein +FIG00553659 FMN-dependent NADH-azoreductase +FIG00553660 phenazine biosynthesis protein PhzF family +FIG00553662 FIG00553663: hypothetical protein +FIG00553664 FIG00553665: hypothetical protein +FIG00553665 FIG00553667: hypothetical protein +FIG00553670 Protein ybjI +FIG00553673 FIG00553674: hypothetical protein +FIG00553674 probable transcription regulator protein, deoR family +FIG00553677 FIG00553679: hypothetical protein +FIG00553691 Transcriptional regulator YPDSF_0092, LacI family +FIG00553693 Possible LysR-family transcriptional regulator +FIG00553695 Succinate-semialdehyde dehydrogenase [NAD(P)+] (EC 1.2.1.16) +FIG00553708 FIG00553709: hypothetical protein +FIG00553709 FIG00553712: hypothetical protein +FIG00553719 carbonic anhydrase, family 3 +FIG00553723 Possible efflux pump +FIG00553726 FIG00553728: hypothetical protein +FIG00553729 FIG00553733: hypothetical protein +FIG00553733 Helicase, C-terminal +FIG00553734 FIG00553736: hypothetical protein +FIG00553736 FIG00553737: hypothetical protein +FIG00553737 Glycosyltransferase tibC (EC 2.4.-.-) (Fragment) +FIG00553743 FIG00553744: hypothetical protein +FIG00553749 FIG00553750: hypothetical protein +FIG00553750 FIG00553754: hypothetical protein +FIG00553754 proteinase inhibitor +FIG00553756 FIG00553758: hypothetical protein +FIG00553758 FIG00553762: hypothetical protein +FIG00553764 FIG00553768: hypothetical protein +FIG00553768 FIG00553769: hypothetical protein +FIG00553770 FIG00553775: hypothetical protein +FIG00553776 FIG00553778: hypothetical protein +FIG00553778 FIG00553781: hypothetical protein +FIG00553781 putative acetyltransferase (GNAT family) +FIG00553784 Uncharacterized protein YeaK +FIG00553786 FIG00553787: hypothetical protein +FIG00553791 FIG00553793: hypothetical protein +FIG00553793 FIG00553794: hypothetical protein +FIG00553794 FIG00553796: hypothetical protein +FIG00553796 FIG00553800: hypothetical protein +FIG00553803 FIG00553804: hypothetical protein +FIG00553807 FIG00553812: hypothetical protein +FIG00553812 FIG00553813: hypothetical protein +FIG00553813 FIG00553816: hypothetical protein +FIG00553816 FIG00553820: hypothetical protein +FIG00553823 UV damage repair endonuclease +FIG00553824 SbmA protein +FIG00553827 FIG00553828: hypothetical protein +FIG00553828 FIG00553830: hypothetical protein +FIG00553835 FIG00634680: hypothetical protein +FIG00553840 FIG00553841: hypothetical protein +FIG00553847 Multidrug resistance protein D +FIG00553851 FIG00553854: hypothetical protein +FIG00553854 FIG00553856: hypothetical protein +FIG00553860 FIG00553861: hypothetical protein +FIG00553869 FIG00553872: hypothetical protein +FIG00553872 FIG00553873: hypothetical protein +FIG00553873 FIG00553873: hypothetical protein +FIG00553874 FIG00553876: hypothetical protein +FIG00553877 FIG00553879: hypothetical protein +FIG00553879 FIG00553882: hypothetical protein +FIG00553891 FIG00553894: hypothetical protein +FIG00553895 FIG00553898: hypothetical protein +FIG00553898 CrcB protein +FIG00553913 FIG00553914: hypothetical protein +FIG00553914 FIG00553916: hypothetical protein +FIG00553917 FIG00553919: hypothetical protein +FIG00553919 FIG00553920: hypothetical protein +FIG00553944 FIG00553946: hypothetical protein +FIG00553946 FIG00553949: hypothetical protein +FIG00553949 H(+)/Cl(-) exchange transporter ClcA +FIG00553956 FIG00553957: hypothetical protein +FIG00553958 Flagellar biosynthesis protein fliT +FIG00553959 Putative diguanylate cyclase/phosphodiesterase domain 1 +FIG00553964 metal-dependent phosphohydrolase +FIG00553967 FIG00553968: hypothetical protein +FIG00553969 FIG00553971: hypothetical protein +FIG00553978 COG3645: Uncharacterized phage-encoded protein +FIG00553981 FIG00553989: hypothetical protein +FIG00553990 FIG00553991: hypothetical protein +FIG00553991 FIG00553993: hypothetical protein +FIG00553993 FIG00553995: hypothetical protein +FIG00553995 FIG00554000: hypothetical protein +FIG00554000 FIG00554002: hypothetical protein +FIG00554003 FIG00554004: hypothetical protein +FIG00554007 FIG00554009: hypothetical protein +FIG00554023 FIG00554027: hypothetical protein +FIG00554043 FIG00554045: hypothetical protein +FIG00554051 FIG00554058: hypothetical protein +FIG00554058 FIG00554059: hypothetical protein +FIG00554059 FIG00554061: hypothetical protein +FIG00554061 FIG00554063: hypothetical protein +FIG00554066 FIG00554071: hypothetical protein +FIG00554071 Cytochrome B561, bacterial precursor +FIG00554072 FIG00554073: hypothetical protein +FIG00554076 FIG00554079: hypothetical protein +FIG00554081 FIG00554082: hypothetical protein +FIG00554083 Gifsy-2 prophage protein +FIG00554085 FIG00554086: hypothetical protein +FIG00554087 Putative polyferredoxin +FIG00554108 FIG00554111: hypothetical protein +FIG00554111 FIG00554113: hypothetical protein +FIG00554114 Outer membrane pore protein E precursor +FIG00554120 FIG00554121: hypothetical protein +FIG00554121 FIG00554125: hypothetical protein +FIG00554125 FIG00554127: hypothetical protein +FIG00554127 FIG00554128: hypothetical protein +FIG00554130 FIG00554131: hypothetical protein +FIG00554131 FIG00554136: hypothetical protein +FIG00554136 FIG00554138: hypothetical protein +FIG00554138 FIG00554143: hypothetical protein +FIG00554143 Ferritin-like protein 2 +FIG00554146 FIG00554149: hypothetical protein +FIG00554156 FIG00554158: hypothetical protein +FIG00554158 FIG00554159: hypothetical protein +FIG00554159 FIG00554160: hypothetical protein +FIG00554160 FIG00554162: hypothetical protein +FIG00554164 FIG00554165: hypothetical protein +FIG00554173 Colanic acid biosynthesis protein wcaM +FIG00554175 FIG00554176: hypothetical protein +FIG00554176 FIG00554177: hypothetical protein +FIG00554189 FIG00554193: hypothetical protein +FIG00554193 Tripeptide aminopeptidase (EC 3.4.11.4) +FIG00554196 FIG00554199: hypothetical protein +FIG00554199 FIG00554200: hypothetical protein +FIG00554214 FIG01219785: hypothetical protein +FIG00554216 FIG00554218: hypothetical protein +FIG00554220 FIG00554221: hypothetical protein +FIG00554221 FIG00554222: hypothetical protein +FIG00554222 FIG00554223: hypothetical protein +FIG00554223 Complete genome; segment 3/17 +FIG00554226 FIG00554228: hypothetical protein +FIG00554228 FIG00554235: hypothetical protein +FIG00554239 FIG00554240: hypothetical protein +FIG00554243 FIG00554245: hypothetical protein +FIG00554245 FIG00554246: hypothetical protein +FIG00554246 FIG00554249: hypothetical protein +FIG00554250 FIG00554256: hypothetical protein +FIG00554256 FIG00554257: hypothetical protein +FIG00554257 FIG00554258: hypothetical protein +FIG00554258 FIG00554261: hypothetical protein +FIG00554261 FIG00554262: hypothetical protein +FIG00554262 FIG00554264: hypothetical protein +FIG00554264 FIG00554266: hypothetical protein +FIG00554266 FIG00554268: hypothetical protein +FIG00554268 FIG00554270: hypothetical protein +FIG00554273 YjcB protein +FIG00554275 Luciferase-like monooxygenase (EC 1.14.-.-) +FIG00554276 putative collagenase +FIG00554283 COG1296: Predicted branched-chain amino acid permease (azaleucine resistance) +FIG00554286 Manganese transport protein MntH +FIG00554290 FIG00554298: hypothetical protein +FIG00554298 FIG00554300: hypothetical protein +FIG00554311 Coenzyme PQQ synthesis protein F +FIG00554321 FIG00639052: hypothetical protein +FIG00554328 FIG00554335: hypothetical protein +FIG00554335 FIG00554340: hypothetical protein +FIG00554358 FIG00554360: hypothetical protein +FIG00554363 FIG00554366: hypothetical protein +FIG00554366 Putative ATP-binding component of a transport system +FIG00554375 FIG00554377: hypothetical protein +FIG00554377 FIG00554378: hypothetical protein +FIG00554412 FIG00554414: hypothetical protein +FIG00554415 FIG00554417: hypothetical protein +FIG00554417 Transcriptional regulator, TetR family +FIG00554419 Aliphatic amidase AmiE (EC 3.5.1.4) +FIG00554427 Inner membrane protein +FIG00554428 FIG00554433: hypothetical protein +FIG00554438 FIG00554441: hypothetical protein +FIG00554441 FIG00554442: hypothetical protein +FIG00554442 Protein of unknown function UPF0060 +FIG00554444 FIG00554445: hypothetical protein +FIG00554445 PTS system, 2-O-alpha-mannosyl-D-glycerate-specific IIA component / PTS system, 2-O-alpha-mannosyl-D-glycerate-specific IIB component / PTS system, 2-O-alpha-mannosyl-D-glycerate-specific IIC component +FIG00554448 FIG00554451: hypothetical protein +FIG00554455 FIG00637864: hypothetical protein +FIG00554457 Putative cytochrome oxidase subunit +FIG00554465 FIG00554473: hypothetical protein +FIG00554473 FIG00554474: hypothetical protein +FIG00554474 FIG00554476: hypothetical protein +FIG00554478 FIG00554483: hypothetical protein +FIG00554483 FIG00554484: hypothetical protein +FIG00554484 FIG00554485: hypothetical protein +FIG00554485 FIG00554487: hypothetical protein +FIG00554487 FIG00554493: hypothetical protein +FIG00554493 FIG00554495: hypothetical protein +FIG00554495 anti-sigma F factor antagonist (spoIIAA-2); anti sigma b factor antagonist RsbV +FIG00554499 FIG00554501: hypothetical protein +FIG00554503 Putative ABC transporter periplasmic binding protein +FIG00554504 FIG00554513: hypothetical protein +FIG00554513 FIG00554520: hypothetical protein +FIG00554523 FIG00554524: hypothetical protein +FIG00554526 FIG00554528: hypothetical protein +FIG00554529 FIG00554530: hypothetical protein +FIG00554532 Putative oxidoreductase component of anaerobic dehydrogenases; Functional role page for Chaperone protein TorD +FIG00554535 FIG00554536: hypothetical protein +FIG00554536 HTH-type transcriptional regulator mlrA +FIG00554559 Hypothetical UPF0257 lipoprotein ynfC precursor +FIG00554566 FIG00554569: hypothetical protein +FIG00554569 FIG00554570: hypothetical protein +FIG00554570 UPF0098 protein ybhB +FIG00554579 FIG00554580: hypothetical protein +FIG00554580 Sugar efflux transporter B +FIG00554584 FIG00554585: hypothetical protein +FIG00554592 RNA-binding domain protein +FIG00554602 FIG00554606: hypothetical protein +FIG00554606 FIG00554608: hypothetical protein +FIG00554608 FIG00554610: hypothetical protein +FIG00554610 Transcriptional regulator, MarR family +FIG00554612 FIG00554613: hypothetical protein +FIG00554626 FIG00554627: hypothetical protein +FIG00554627 FIG00554630: hypothetical protein +FIG00554630 Coenzyme F390 synthetase +FIG00554631 Uncharacterized zinc-type alcohol dehydrogenase-like protein ybdR +FIG00554635 FIG00554637: hypothetical protein +FIG00554641 FIG00554642: hypothetical protein +FIG00554653 FIG00554654: hypothetical protein +FIG00554657 Transcriptional regulatory protein YciT +FIG00554662 FIG00554663: hypothetical protein +FIG00554665 FIG00554667: hypothetical protein +FIG00554667 FIG00554669: hypothetical protein +FIG00554669 FIG00554672: hypothetical protein +FIG00554679 FIG00554680: hypothetical protein +FIG00554684 FIG00554685: hypothetical protein +FIG00554687 COG1132 +FIG00554691 FIG00554692: hypothetical protein +FIG00554692 Possible MFS Superfamily transporter precursor +FIG00554694 Tryptophan-specific transport protein +FIG00554698 Putative virulence factor +FIG00554702 Cation transport regulator chaB +FIG00554705 GlpM family protein +FIG00554706 FIG00554712: hypothetical protein +FIG00554712 FIG018993: membrane protein +FIG00554720 FIG00554721: hypothetical protein +FIG00554721 FIG00554722: hypothetical protein +FIG00554726 FIG00554727: hypothetical protein +FIG00554729 gp7 +FIG00554733 FIG00554736: hypothetical protein +FIG00554739 FIG00554739: membrane protein YchH +FIG00554748 FIG00554751: hypothetical protein +FIG00554751 FIG00554752: hypothetical protein +FIG00554752 FIG00554756: hypothetical protein +FIG00554756 Nucleoside-specific channel-forming protein Tsx precursor +FIG00554759 FIG00924762: possible membrane protein +FIG00554760 FIG00554761: hypothetical protein +FIG00554761 Hypothetical protein YagQ +FIG00554767 pili assembly chaperone +FIG00554769 FIG00554779: hypothetical protein +FIG00554779 FIG00554789: hypothetical protein +FIG00554789 FIG00554794: hypothetical protein +FIG00554799 FIG00554802: hypothetical protein +FIG00554802 FIG00554810: hypothetical protein +FIG00554814 FIG00554817: hypothetical protein +FIG00554817 rRNA small subunit methyltransferase J +FIG00554819 FIG00554823: hypothetical protein +FIG00554829 FIG00554838: hypothetical protein +FIG00554855 FIG00554856: hypothetical protein +FIG00554858 FIG00554859: hypothetical protein +FIG00554859 protein iraP +FIG00554871 FIG00554876: hypothetical protein +FIG00554876 FIG00554878: hypothetical protein +FIG00554878 FIG00554879: hypothetical protein +FIG00554883 similar to Uncharacterized conserved protein contains double-stranded beta-helix domain +FIG00554886 FIG00554887: hypothetical protein +FIG00554895 FIG00554900: hypothetical protein +FIG00554900 Periplasmic aromatic aldehyde oxidoreductase, molybdenum binding subunit YagR +FIG00554902 L-asparagine permease +FIG00554918 FIG00948312: hypothetical protein +FIG00554921 FIG00554923: hypothetical protein +FIG00554923 FIG00554929: hypothetical protein +FIG00554929 FIG00554932: hypothetical protein +FIG00554932 Alpha-ketoglutarate permease +FIG00554957 Cell filamentation protein fic +FIG00554970 FIG00554971: hypothetical protein +FIG00554976 FIG00554979: hypothetical protein +FIG00554979 FIG00554985: hypothetical protein +FIG00554986 FIG00554990: hypothetical protein +FIG00554990 FIG00554994: hypothetical protein +FIG00554999 Virulence-associated protein vagC +FIG00555007 Collagen-binding A protein-like +FIG00555009 FIG00555016: hypothetical protein +FIG00555034 FIG00555039: hypothetical protein +FIG00555113 Phenylacetate--CoA ligase( EC:6.2.1.30 ) +FIG00555195 FIG00555200: hypothetical protein +FIG00555208 FIG00624264: hypothetical protein +FIG00555274 FIG00534530: hypothetical protein +FIG00555343 FIG00555350: hypothetical protein +FIG00555373 FIG00555378: hypothetical protein +FIG00555416 ethanolamine utilization protein EutH +FIG00555526 FIG00555532: hypothetical protein +FIG00555578 FIG00555581: hypothetical protein +FIG00555613 FIG00555615: hypothetical protein +FIG00555615 Probable cation transport protein +FIG00555629 FIG00555640: hypothetical protein +FIG00555654 FIG002958: hypothetical protein +FIG00555656 Predicted transcriptional regulators +FIG00555668 FIG00555669: hypothetical protein +FIG00555682 FIG00555684: hypothetical protein +FIG00555684 FIG00857679: hypothetical protein +FIG00555690 FIG00555695: hypothetical protein +FIG00555705 endo alpha-1,4 polygalactosaminidase precusor +FIG00555711 FIG006442: Integral membrane protein +FIG00555714 FIG00555715: hypothetical protein +FIG00555717 3-methylthioacryloyl-CoA hydratase 2 (DmdD2) +FIG00555729 FIG00432713: hypothetical protein +FIG00555732 response regulator receiver domain protein (CheY-like) +FIG00555741 two-component hybrid sensor and regulator +FIG00555762 FIG00555764: hypothetical protein +FIG00555797 FIG00555800: hypothetical protein +FIG00555800 FIG00555803: hypothetical protein +FIG00555803 FIG00555805: hypothetical protein +FIG00555805 FIG00555810: hypothetical protein +FIG00555818 FIG00555821: hypothetical protein +FIG00555838 FIG00555839: hypothetical protein +FIG00555839 Signal transduction histidine kinase, glucose-6-phosphate specific +FIG00555855 FIG00555873: hypothetical protein +FIG00555879 FIG00555881: hypothetical protein +FIG00555881 FIG00555882: hypothetical protein +FIG00555884 CAAX prenyl protease 1, putative +FIG00555909 FOG: TPR repeat +FIG00555922 Probable lipoprotein transmembrane +FIG00555932 HYPOTHETICAL TRANSMEMBRANE PROTEIN +FIG00555959 FIG00555961: hypothetical protein +FIG00556016 FIG00556018: hypothetical protein +FIG00556025 Regulatory protein, LysR +FIG00556035 FIG00556037: hypothetical protein +FIG00556058 FIG00556060: hypothetical protein +FIG00556060 FIG00556062: hypothetical protein +FIG00556084 FIG00556087: hypothetical protein +FIG00556093 FIG00556103: hypothetical protein +FIG00556109 FIG00556114: hypothetical protein +FIG00556114 FIG00556117: hypothetical protein +FIG00556122 FIG00556130: hypothetical protein +FIG00556130 PROBABLE TWO-COMPONENT SYSTEM SENSOR HISTIDINE KINASE TRANSCRIPTION REGULATOR PROTEIN( EC:2.7.3.- ) +FIG00556136 FIG00556139: hypothetical protein +FIG00556144 FIG00556145: hypothetical protein +FIG00556147 FIG00556163: hypothetical protein +FIG00556190 FIG00556192: hypothetical protein +FIG00556205 YoeB toxin protein +FIG00556206 FIG00556211: hypothetical protein +FIG00556211 FIG00556214: hypothetical protein +FIG00556214 FIG00556218: hypothetical protein +FIG00556226 FIG00556233: hypothetical protein +FIG00556233 FIG00556234: hypothetical protein +FIG00556246 FIG00556251: hypothetical protein +FIG00556263 FIG00556271: hypothetical protein +FIG00556275 FIG00556277: hypothetical protein +FIG00556277 FIG00556279: hypothetical protein +FIG00556279 FIG00556287: hypothetical protein +FIG00556287 FIG00556291: hypothetical protein +FIG00556291 G-protein beta WD-40 repeat +FIG00556292 PilT protein-like protein +FIG00556293 FIG00556298: hypothetical protein +FIG00556298 FIG00556300: hypothetical protein +FIG00556300 FIG00556301: hypothetical protein +FIG00556306 FIG00556310: hypothetical protein +FIG00556310 FIG00556313: hypothetical protein +FIG00556334 FIG00556339: hypothetical protein +FIG00556339 FIG01191858: hypothetical protein +FIG00556340 FIG00556345: hypothetical protein +FIG00556345 FIG00556353: hypothetical protein +FIG00556353 FIG00556355: hypothetical protein +FIG00556376 FIG00556379: hypothetical protein +FIG00556383 FIG00556389: hypothetical protein +FIG00556395 FIG00556397: hypothetical protein +FIG00556398 FIG00556404: hypothetical protein +FIG00556405 FIG00556411: hypothetical protein +FIG00556411 FIG00556430: hypothetical protein +FIG00556430 hypothetical protein +FIG00556432 carboxyl-terminal protease +FIG00556440 FIG00556442: hypothetical protein +FIG00556443 probable sugar kinase +FIG00556449 FIG00556465: hypothetical protein +FIG00556472 FIG00556473: hypothetical protein +FIG00556473 FIG00556477: hypothetical protein +FIG00556477 FIG00556492: hypothetical protein +FIG00556492 FIG00556495: hypothetical protein +FIG00556495 FIG00556498: hypothetical protein +FIG00556498 FIG00556507: hypothetical protein +FIG00556513 FIG00556514: hypothetical protein +FIG00556514 FIG00556515: hypothetical protein +FIG00556515 FIG00556517: hypothetical protein +FIG00556517 FIG00556519: hypothetical protein +FIG00556519 FIG00556520: hypothetical protein +FIG00556520 FIG00556524: hypothetical protein +FIG00556526 FIG00556532: hypothetical protein +FIG00556532 FIG00556535: hypothetical protein +FIG00556535 FIG00556540: hypothetical protein +FIG00556540 FIG00556541: hypothetical protein +FIG00556541 FIG00556544: hypothetical protein +FIG00556544 FIG00556547: hypothetical protein +FIG00556551 FIG00556559: hypothetical protein +FIG00556559 FIG00556560: hypothetical protein +FIG00556560 FIG00556562: hypothetical protein +FIG00556562 FIG00556576: hypothetical protein +FIG00556576 FIG00556577: hypothetical protein +FIG00556583 FIG00556587: hypothetical protein +FIG00556587 FIG00556591: hypothetical protein +FIG00556600 FIG00556602: hypothetical protein +FIG00556612 FIG00556613: hypothetical protein +FIG00556613 FIG00556617: hypothetical protein +FIG00556617 FIG00556618: hypothetical protein +FIG00556618 FIG00556620: hypothetical protein +FIG00556628 FIG00556630: hypothetical protein +FIG00556632 FIG00556633: hypothetical protein +FIG00556633 COG5002: Signal transduction histidine kinase +FIG00556634 FIG00556644: hypothetical protein +FIG00556656 FIG00556663: hypothetical protein +FIG00556663 FIG00556665: hypothetical protein +FIG00556665 FIG00556668: hypothetical protein +FIG00556674 FIG00556675: hypothetical protein +FIG00556676 Protein of unknown function DUF1232 +FIG00556679 FIG00556680: hypothetical protein +FIG00556680 FIG00556682: hypothetical protein +FIG00556682 FIG00556688: hypothetical protein +FIG00556688 FIG00556689: hypothetical protein +FIG00556689 FIG00556693: hypothetical protein +FIG00556693 FIG00556695: hypothetical protein +FIG00556695 FIG00556696: hypothetical protein +FIG00556701 DnaJ-class molecular chaperone +FIG00556722 FIG00556723: hypothetical protein +FIG00556723 FIG00556728: hypothetical protein +FIG00556731 FIG00556734: hypothetical protein +FIG00556734 FIG00556747: hypothetical protein +FIG00556747 FIG00556748: hypothetical protein +FIG00556748 FIG00556756: hypothetical protein +FIG00556756 FIG00556761: hypothetical protein +FIG00556761 FIG00556765: hypothetical protein +FIG00556765 FIG00556766: hypothetical protein +FIG00556795 FIG00556797: hypothetical protein +FIG00556797 FIG00556800: hypothetical protein +FIG00556800 FIG00556805: hypothetical protein +FIG00556810 FIG00556818: hypothetical protein +FIG00556830 FIG00556832: hypothetical protein +FIG00556832 FIG00556833: hypothetical protein +FIG00556833 FIG00556835: hypothetical protein +FIG00556847 FIG00556863: hypothetical protein +FIG00556866 FIG00556868: hypothetical protein +FIG00556872 FIG00556874: hypothetical protein +FIG00556877 FIG00556878: hypothetical protein +FIG00556879 FIG00871364: hypothetical protein +FIG00556884 FIG00556886: hypothetical protein +FIG00556890 FIG00556891: hypothetical protein +FIG00556891 FIG00556897: hypothetical protein +FIG00556904 FIG00556906: hypothetical protein +FIG00556906 FIG00556907: hypothetical protein +FIG00556907 ribonucleoprotein Ro/SS-A-related protein +FIG00556908 FIG00556911: hypothetical protein +FIG00556911 FIG00556912: hypothetical protein +FIG00556912 FIG00556919: hypothetical protein +FIG00556919 FIG00556921: hypothetical protein +FIG00556923 FIG00556926: hypothetical protein +FIG00556926 FIG00556932: hypothetical protein +FIG00556932 Multisubunit Na+/H+ antiporter, MnhB subunit +FIG00556935 FIG00556936: hypothetical protein +FIG00556939 FIG00556940: hypothetical protein +FIG00556940 FIG00556942: hypothetical protein +FIG00556942 FIG00556948: hypothetical protein +FIG00556948 Sucrose-phosphate phosphatase +FIG00556950 FIG00556953: hypothetical protein +FIG00556953 16.6 kDa small heat shock protein molecular chaperon +FIG00556955 FIG00556960: hypothetical protein +FIG00556960 FIG00556961: hypothetical protein +FIG00556961 FIG00556964: hypothetical protein +FIG00556964 FIG00556965: hypothetical protein +FIG00556965 FIG00556966: hypothetical protein +FIG00556973 FIG00556977: hypothetical protein +FIG00556978 FIG00556979: hypothetical protein +FIG00556979 FIG00556994: hypothetical protein +FIG00556994 FIG00556999: hypothetical protein +FIG00556999 FIG00557003: hypothetical protein +FIG00557003 cAMP protein kinase regulatory chain +FIG00557012 FIG00557015: hypothetical protein +FIG00557015 FIG00557016: hypothetical protein +FIG00557016 FIG00557019: hypothetical protein +FIG00557019 FIG00557025: hypothetical protein +FIG00557025 FIG00557030: hypothetical protein +FIG00557030 FIG00557032: hypothetical protein +FIG00557032 FIG00557047: hypothetical protein +FIG00557047 FIG00557050: hypothetical protein +FIG00557050 FIG00557056: hypothetical protein +FIG00557056 FIG00557058: hypothetical protein +FIG00557058 FIG00557061: hypothetical protein +FIG00557095 FIG00557096: hypothetical protein +FIG00557096 FIG00557099: hypothetical protein +FIG00557099 Similar to ferrous iron transporter protein B +FIG00557100 FIG00557102: hypothetical protein +FIG00557104 FIG00557105: hypothetical protein +FIG00557112 FIG00557123: hypothetical protein +FIG00557123 FIG00557124: hypothetical protein +FIG00557124 FIG00557125: hypothetical protein +FIG00557126 FIG00557132: hypothetical protein +FIG00557132 FIG00557133: hypothetical protein +FIG00557133 FIG00557134: hypothetical protein +FIG00557134 FIG00557135: hypothetical protein +FIG00557138 aspartate kinase( EC:2.7.2.4 ) +FIG00557141 FIG00557145: hypothetical protein +FIG00557153 FIG00557154: hypothetical protein +FIG00557158 FIG00557160: hypothetical protein +FIG00557164 FIG00557165: hypothetical protein +FIG00557173 FIG00873523: hypothetical protein +FIG00557174 FIG00557178: hypothetical protein +FIG00557178 FIG00557179: hypothetical protein +FIG00557179 FIG00557181: hypothetical protein +FIG00557183 FIG00557185: hypothetical protein +FIG00557185 FIG00557186: hypothetical protein +FIG00557186 FIG00557189: hypothetical protein +FIG00557189 FIG00557192: hypothetical protein +FIG00557192 FIG00557193: hypothetical protein +FIG00557193 FIG00557194: hypothetical protein +FIG00557194 Protein of unknown function DUF427 +FIG00557196 FIG00557209: hypothetical protein +FIG00557215 FIG00557221: hypothetical protein +FIG00557221 FIG00557225: hypothetical protein +FIG00557225 FIG00557235: hypothetical protein +FIG00557240 FIG00557242: hypothetical protein +FIG00557242 FIG00557243: hypothetical protein +FIG00557243 FIG00557247: hypothetical protein +FIG00557249 FIG00557250: hypothetical protein +FIG00557252 Ycf22 protein +FIG00557269 FIG00557273: hypothetical protein +FIG00557273 FIG00557274: hypothetical protein +FIG00557279 FIG00557288: hypothetical protein +FIG00557288 FIG00557290: hypothetical protein +FIG00557291 Protein of unknown function UPF0153 +FIG00557292 Putative Multisubunit sodium/proton antiporter, MrpE subunit +FIG00557301 Protein hesA, heterocyst +FIG00557312 FIG00557315: hypothetical protein +FIG00557321 Aspartate aminotransferase B (EC 2.6.1.1) +FIG00557323 FIG00557329: hypothetical protein +FIG00557329 FIG00557334: hypothetical protein +FIG00557334 FIG00557335: hypothetical protein +FIG00557335 FIG00557337: hypothetical protein +FIG00557337 FIG00557340: hypothetical protein +FIG00557350 FIG00557354: hypothetical protein +FIG00557359 FIG00557364: hypothetical protein +FIG00557373 FIG00557374: hypothetical protein +FIG00557374 FIG00872660: hypothetical protein +FIG00557383 FIG00557388: hypothetical protein +FIG00557388 FIG00557391: hypothetical protein +FIG00557391 FIG00557393: hypothetical protein +FIG00557399 FIG00557401: hypothetical protein +FIG00557411 FIG00557413: hypothetical protein +FIG00557420 FIG00557424: hypothetical protein +FIG00557424 FIG00557431: hypothetical protein +FIG00557431 FIG00557432: hypothetical protein +FIG00557432 FIG00557433: hypothetical protein +FIG00557433 FIG00557434: hypothetical protein +FIG00557434 FIG00557438: hypothetical protein +FIG00557438 FIG00557439: hypothetical protein +FIG00557443 FIG00557445: hypothetical protein +FIG00557445 FIG00557449: hypothetical protein +FIG00557449 FIG00557450: hypothetical protein +FIG00557450 FIG00557453: hypothetical protein +FIG00557453 FIG00557457: hypothetical protein +FIG00557457 FIG00557462: hypothetical protein +FIG00557462 Dynamin +FIG00557473 FIG00557478: hypothetical protein +FIG00557478 FIG00557479: hypothetical protein +FIG00557479 FIG00557483: hypothetical protein +FIG00557483 FIG00557488: hypothetical protein +FIG00557488 FIG00557489: hypothetical protein +FIG00557489 protease; HhoB +FIG00557496 FIG00557504: hypothetical protein +FIG00557506 FIG00557508: hypothetical protein +FIG00557508 FIG00557516: hypothetical protein +FIG00557521 FIG00557523: hypothetical protein +FIG00557523 FAD-dependent pyridine nucleotide-disulphide oxidoreductase:Pyridine nucleotide-disulphide oxidoreductase dimerisation region +FIG00557532 FIG00557533: hypothetical protein +FIG00557539 Viral A-type inclusion protein repeat containing protein +FIG00557540 FIG00557543: hypothetical protein +FIG00557543 FIG00557544: hypothetical protein +FIG00557562 FIG00557564: hypothetical protein +FIG00557564 FIG00557569: hypothetical protein +FIG00557569 FIG00557571: hypothetical protein +FIG00557574 Ferredoxin-thioredoxin reductase, variable chain +FIG00557575 FIG00557576: hypothetical protein +FIG00557576 FIG00557577: hypothetical protein +FIG00557577 FIG00557578: hypothetical protein +FIG00557582 FIG00557583: hypothetical protein +FIG00557583 FIG00557584: hypothetical protein +FIG00557584 FIG00557585: hypothetical protein +FIG00557585 FIG00557591: hypothetical protein +FIG00557591 FIG00557597: hypothetical protein +FIG00557597 FIG00557600: hypothetical protein +FIG00557601 FIG00557604: hypothetical protein +FIG00557604 FIG00557606: hypothetical protein +FIG00557606 putative sodium:galactoside symporter protein +FIG00557608 FIG00557611: hypothetical protein +FIG00557611 FIG00557612: hypothetical protein +FIG00557614 FIG00557615: hypothetical protein +FIG00557615 FIG00557616: hypothetical protein +FIG00557616 FIG00557617: hypothetical protein +FIG00557617 FIG00557619: hypothetical protein +FIG00557621 RelE/StbE replicon stabilization toxin +FIG00557622 2-oxoisovalerate dehydrogenase, E1 component beta subunit +FIG00557624 FIG00557627: hypothetical protein +FIG00557627 FIG00557628: hypothetical protein +FIG00557630 FIG00557633: hypothetical protein +FIG00557633 FIG00557634: hypothetical protein +FIG00557634 FIG00557637: hypothetical protein +FIG00557637 FdxN +FIG00557639 FIG00557643: hypothetical protein +FIG00557643 FIG00557645: hypothetical protein +FIG00557651 FIG00557653: hypothetical protein +FIG00557653 Gll0726 protein +FIG00557659 FIG00557660: hypothetical protein +FIG00557660 FIG00557662: hypothetical protein +FIG00557662 FIG00557664: hypothetical protein +FIG00557664 FIG00557672: hypothetical protein +FIG00557681 FIG00557682: hypothetical protein +FIG00557686 FIG00557688: hypothetical protein +FIG00557691 FIG00557692: hypothetical protein +FIG00557692 FIG00557693: hypothetical protein +FIG00557693 FIG00557694: hypothetical protein +FIG00557694 FIG00557695: hypothetical protein +FIG00557695 FIG00557698: hypothetical protein +FIG00557705 FIG00557707: hypothetical protein +FIG00557707 FIG00557708: hypothetical protein +FIG00557708 FIG00557713: hypothetical protein +FIG00557713 FIG00557719: hypothetical protein +FIG00557719 FIG00557720: hypothetical protein +FIG00557720 FIG00557722: hypothetical protein +FIG00557722 FIG00557725: hypothetical protein +FIG00557726 FIG00557727: hypothetical protein +FIG00557732 FIG00557741: hypothetical protein +FIG00557759 FIG00557761: hypothetical protein +FIG00557761 FIG00557763: hypothetical protein +FIG00557763 FIG00557767: hypothetical protein +FIG00557767 FIG00557771: hypothetical protein +FIG00557772 FIG00557773: hypothetical protein +FIG00557776 FIG00557785: hypothetical protein +FIG00557785 CheY-like receiver +FIG00557788 FIG00557790: hypothetical protein +FIG00557791 FIG00557793: hypothetical protein +FIG00557793 FIG00557794: hypothetical protein +FIG00557794 Circadian oscillation regulator KaiB +FIG00557798 FIG00557799: hypothetical protein +FIG00557801 Exoribonuclease II +FIG00557813 FIG00557817: hypothetical protein +FIG00557822 FIG00557826: hypothetical protein +FIG00557826 FIG00557827: hypothetical protein +FIG00557833 FIG00557842: hypothetical protein +FIG00557857 FIG00557863: hypothetical protein +FIG00557866 FIG00557873: hypothetical protein +FIG00557875 FIG00557876: hypothetical protein +FIG00557876 FIG00557880: hypothetical protein +FIG00557885 FIG00557886: hypothetical protein +FIG00557886 FIG00557891: hypothetical protein +FIG00557891 FIG00557896: hypothetical protein +FIG00557940 FIG00557942: hypothetical protein +FIG00557942 FIG00557953: hypothetical protein +FIG00557959 FIG00557961: hypothetical protein +FIG00557961 FIG00557962: hypothetical protein +FIG00557967 FIG00557968: hypothetical protein +FIG00557968 FIG00557970: hypothetical protein +FIG00557970 FIG00557973: hypothetical protein +FIG00557981 FIG00557990: hypothetical protein +FIG00557990 FIG00558001: hypothetical protein +FIG00558001 FIG00558002: hypothetical protein +FIG00558002 FIG00558004: hypothetical protein +FIG00558004 FIG00558008: hypothetical protein +FIG00558008 FIG00558014: hypothetical protein +FIG00558031 FIG00558034: hypothetical protein +FIG00558034 FIG00558035: hypothetical protein +FIG00558035 FIG00558037: hypothetical protein +FIG00558060 FIG00558062: hypothetical protein +FIG00558062 FIG00558063: hypothetical protein +FIG00558075 FIG00558078: hypothetical protein +FIG00558078 FIG00558080: hypothetical protein +FIG00558080 FIG00558081: hypothetical protein +FIG00558084 FIG00558086: hypothetical protein +FIG00558088 FIG00569383: hypothetical protein +FIG00558089 FIG00558091: hypothetical protein +FIG00558091 FIG00558097: hypothetical protein +FIG00558097 FIG00558098: hypothetical protein +FIG00558099 FIG00558102: hypothetical protein +FIG00558102 FIG00558104: hypothetical protein +FIG00558105 FIG00558112: hypothetical protein +FIG00558112 FIG00558114: hypothetical protein +FIG00558114 FIG00558115: hypothetical protein +FIG00558119 FIG00558120: hypothetical protein +FIG00558126 XisI protein-like +FIG00558128 FIG00558130: hypothetical protein +FIG00558130 FIG00558131: hypothetical protein +FIG00558131 FIG00558132: hypothetical protein +FIG00558133 FIG00558137: hypothetical protein +FIG00558137 FIG00558140: hypothetical protein +FIG00558140 FIG00558152: hypothetical protein +FIG00558165 FIG00558170: hypothetical protein +FIG00558185 FIG00558186: hypothetical protein +FIG00558186 FIG00558189: hypothetical protein +FIG00558189 FIG00558198: hypothetical protein +FIG00558200 FIG00558206: hypothetical protein +FIG00558206 FIG00558207: hypothetical protein +FIG00558212 FIG00558213: hypothetical protein +FIG00558213 FIG00558215: hypothetical protein +FIG00558218 FIG00558222: hypothetical protein +FIG00558223 FIG00558229: hypothetical protein +FIG00558229 FIG00558233: hypothetical protein +FIG00558233 FIG00558240: hypothetical protein +FIG00558248 FIG00558253: hypothetical protein +FIG00558253 FIG00558255: hypothetical protein +FIG00558255 FIG00558263: hypothetical protein +FIG00558263 FIG00558265: hypothetical protein +FIG00558268 FIG00558278: hypothetical protein +FIG00558278 FIG00558286: hypothetical protein +FIG00558293 FIG00558299: hypothetical protein +FIG00558299 FIG00558304: hypothetical protein +FIG00558304 FIG00558310: hypothetical protein +FIG00558337 FIG00558338: hypothetical protein +FIG00558338 FIG00558346: hypothetical protein +FIG00558346 FIG00558351: hypothetical protein +FIG00558351 FIG00558356: hypothetical protein +FIG00558356 FIG00558358: hypothetical protein +FIG00558360 FIG00558367: hypothetical protein +FIG00558379 FIG00558382: hypothetical protein +FIG00558392 FIG00558394: hypothetical protein +FIG00558396 FIG00558399: hypothetical protein +FIG00558399 FIG00558403: hypothetical protein +FIG00558403 FIG00558409: hypothetical protein +FIG00558413 possible polysaccharide pyruvyl transferase +FIG00558417 tRNA (guanine-N(2)-)-methyltransferase +FIG00558443 FIG00558444: hypothetical protein +FIG00558444 FIG00558445: hypothetical protein +FIG00558445 FIG00558446: hypothetical protein +FIG00558446 FIG00558451: hypothetical protein +FIG00558451 FIG00558458: hypothetical protein +FIG00558483 GDP-D-mannose dehydratase +FIG00558497 putative sensory histidine kinase protein +FIG00558499 FIG00558500: hypothetical protein +FIG00558500 Collagen-like protein 7 +FIG00558501 FIG00558502: hypothetical protein +FIG00558507 FIG00558508: hypothetical protein +FIG00558508 FIG00558509: hypothetical protein +FIG00558509 FIG00558510: hypothetical protein +FIG00558510 FIG00558517: hypothetical protein +FIG00558520 FIG00558524: hypothetical protein +FIG00558524 FIG00558527: hypothetical protein +FIG00558532 FIG00558534: hypothetical protein +FIG00558540 FIG00558545: hypothetical protein +FIG00558551 FIG00558553: hypothetical protein +FIG00558553 FIG00558556: hypothetical protein +FIG00558558 FIG00558562: hypothetical protein +FIG00558562 FIG00558570: hypothetical protein +FIG00558570 FIG00558574: hypothetical protein +FIG00558576 FIG00558578: hypothetical protein +FIG00558580 FIG00558581: hypothetical protein +FIG00558584 FIG00558588: hypothetical protein +FIG00558588 FIG00558592: hypothetical protein +FIG00558596 FIG00558603: hypothetical protein +FIG00558603 FIG00558607: hypothetical protein +FIG00558607 FIG00558608: hypothetical protein +FIG00558608 FIG00558609: hypothetical protein +FIG00558610 FIG00558611: hypothetical protein +FIG00558611 FIG00558615: hypothetical protein +FIG00558615 FIG00558618: hypothetical protein +FIG00558620 FIG00558626: hypothetical protein +FIG00558629 chemotaxis protein +FIG00558632 FIG00558636: hypothetical protein +FIG00558640 FIG00558642: hypothetical protein +FIG00558642 FIG00558647: hypothetical protein +FIG00558647 FIG00558650: hypothetical protein +FIG00558650 FIG00558651: hypothetical protein +FIG00558652 FIG00558653: hypothetical protein +FIG00558653 FIG00558660: hypothetical protein +FIG00558662 FIG00558664: hypothetical protein +FIG00558664 FIG00558671: hypothetical protein +FIG00558671 FIG00558676: hypothetical protein +FIG00558676 FIG00558677: hypothetical protein +FIG00558677 FIG00558679: hypothetical protein +FIG00558679 FIG00558681: hypothetical protein +FIG00558681 FIG00558688: hypothetical protein +FIG00558688 FIG00558697: hypothetical protein +FIG00558697 FIG00558702: hypothetical protein +FIG00558702 FIG00558707: hypothetical protein +FIG00558709 FIG00558714: hypothetical protein +FIG00558714 mannosyltransferase, putative +FIG00558720 putative polysaccharide export protein +FIG00558724 FIG00872126: hypothetical protein +FIG00558727 periplasmic protein, function unknown +FIG00558752 FIG00558757: hypothetical protein +FIG00558757 FIG00558768: hypothetical protein +FIG00558768 FIG00558769: hypothetical protein +FIG00558769 FIG00558771: hypothetical protein +FIG00558772 FIG00558783: hypothetical protein +FIG00558783 FIG00558789: hypothetical protein +FIG00558789 FIG00558793: hypothetical protein +FIG00558793 FIG00558794: hypothetical protein +FIG00558794 EsV-1-176 +FIG00558796 FIG00558798: hypothetical protein +FIG00558800 FIG00558801: hypothetical protein +FIG00558801 FIG00558802: hypothetical protein +FIG00558802 FIG00558803: hypothetical protein +FIG00558803 FIG00558804: hypothetical protein +FIG00558804 FIG00558806: hypothetical protein +FIG00558806 FIG00558809: hypothetical protein +FIG00558817 FIG00558819: hypothetical protein +FIG00558819 FIG00558822: hypothetical protein +FIG00558822 FIG00558824: hypothetical protein +FIG00558825 FIG00558835: hypothetical protein +FIG00558835 FIG00558836: hypothetical protein +FIG00558836 FIG00558837: hypothetical protein +FIG00558837 FIG00558846: hypothetical protein +FIG00558846 FIG00558848: hypothetical protein +FIG00558848 FIG00558849: hypothetical protein +FIG00558853 FIG00558856: hypothetical protein +FIG00558874 FIG00558876: hypothetical protein +FIG00558882 FIG00558884: hypothetical protein +FIG00558884 Pathogenesis-related protein 1C precursor +FIG00558885 FIG00558888: hypothetical protein +FIG00558890 FIG00558893: hypothetical protein +FIG00558893 Peptidase S49, SppA +FIG00558897 beta transducin-like protein +FIG00558899 FIG00558905: hypothetical protein +FIG00558905 FIG00558906: hypothetical protein +FIG00558906 FIG00558912: hypothetical protein +FIG00558912 FIG00558914: hypothetical protein +FIG00558941 FIG00558946: hypothetical protein +FIG00558946 FIG00558950: hypothetical protein +FIG00558950 Cd/Co/Hg/Pb/Zn-translocating P-type ATPase +FIG00558959 FIG00558960: hypothetical protein +FIG00558966 FIG00558970: hypothetical protein +FIG00558970 FIG00558972: hypothetical protein +FIG00558972 FIG00558974: hypothetical protein +FIG00558974 possible ATLS1-like light-inducible protein +FIG00558980 FIG00558982: hypothetical protein +FIG00558982 FIG00558987: hypothetical protein +FIG00558987 FIG00558991: hypothetical protein +FIG00559004 FIG00559014: hypothetical protein +FIG00559014 FIG00559017: hypothetical protein +FIG00559021 FIG00559026: hypothetical protein +FIG00559026 FIG00559029: hypothetical protein +FIG00559029 GAF Sensor Signal Transduction Histidine Kinase +FIG00559031 FIG00559032: hypothetical protein +FIG00559032 FIG00559038: hypothetical protein +FIG00559038 FIG00559041: hypothetical protein +FIG00559041 FIG00559044: hypothetical protein +FIG00559054 FIG00559056: hypothetical protein +FIG00559056 FIG00559059: hypothetical protein +FIG00559059 FIG00559063: hypothetical protein +FIG00559063 FIG00559067: hypothetical protein +FIG00559070 FIG00559083: hypothetical protein +FIG00559083 FIG00559086: hypothetical protein +FIG00559086 Type IV pilin PilA +FIG00559096 FIG00559097: hypothetical protein +FIG00559097 FIG00559100: hypothetical protein +FIG00559100 FIG00559101: hypothetical protein +FIG00559101 FIG00559102: hypothetical protein +FIG00559102 FIG00559105: hypothetical protein +FIG00559105 Chromosome segregation ATPases +FIG00559113 FIG00559123: hypothetical protein +FIG00559123 FIG00559127: hypothetical protein +FIG00559127 FIG00559128: hypothetical protein +FIG00559128 FIG00559132: hypothetical protein +FIG00559133 FIG00559135: hypothetical protein +FIG00559136 FIG00559137: hypothetical protein +FIG00559138 FIG00559141: hypothetical protein +FIG00559141 FIG00559150: hypothetical protein +FIG00559154 FIG00559156: hypothetical protein +FIG00559162 H+/Ca2+ exchanger +FIG00559163 FIG00559165: hypothetical protein +FIG00559166 FIG00559167: hypothetical protein +FIG00559167 FIG00559168: hypothetical protein +FIG00559168 Lipoprotein precursor +FIG00559177 FIG00559178: hypothetical protein +FIG00559178 FIG00559181: hypothetical protein +FIG00559181 FIG00559188: hypothetical protein +FIG00559188 FIG00559190: hypothetical protein +FIG00559201 ABC transporter ATP binding subunit +FIG00559206 FIG00559208: hypothetical protein +FIG00559213 FIG00559215: hypothetical protein +FIG00559216 FIG00559218: hypothetical protein +FIG00559232 Alr3471 protein +FIG00559235 FIG00559246: hypothetical protein +FIG00559248 FIG00559250: hypothetical protein +FIG00559268 FIG00559269: hypothetical protein +FIG00559270 FIG00559275: hypothetical protein +FIG00559275 FIG00559276: hypothetical protein +FIG00559276 FIG00559288: hypothetical protein +FIG00559292 FIG00559293: hypothetical protein +FIG00559293 FIG00559295: hypothetical protein +FIG00559303 FIG00559304: hypothetical protein +FIG00559304 FIG00559313: hypothetical protein +FIG00559313 FIG00559316: hypothetical protein +FIG00559320 Chromosome segregation ATPases +FIG00559321 FIG00559324: hypothetical protein +FIG00559324 FIG00559330: hypothetical protein +FIG00559330 FIG00559333: hypothetical protein +FIG00559333 FIG00559337: hypothetical protein +FIG00559337 FIG00559344: hypothetical protein +FIG00559345 FIG00559347: hypothetical protein +FIG00559347 FIG00559350: hypothetical protein +FIG00559359 FIG00559362: hypothetical protein +FIG00559368 FIG00559374: hypothetical protein +FIG00559374 FIG00559376: hypothetical protein +FIG00559378 FIG00559384: hypothetical protein +FIG00559384 FIG00559385: hypothetical protein +FIG00559385 FIG00559391: hypothetical protein +FIG00559393 FIG00559396: hypothetical protein +FIG00559398 FIG00559404: hypothetical protein +FIG00559404 FIG00559414: hypothetical protein +FIG00559414 FIG00559416: hypothetical protein +FIG00559416 FIG00559436: hypothetical protein +FIG00559436 FIG00559441: hypothetical protein +FIG00559449 FIG00559450: hypothetical protein +FIG00559450 FIG00559455: hypothetical protein +FIG00559455 FIG00559456: hypothetical protein +FIG00559457 FIG00559462: hypothetical protein +FIG00559463 FIG00559468: hypothetical protein +FIG00559468 FIG00559471: hypothetical protein +FIG00559471 dimethyladenosine transferase( EC:2.1.1.- ) +FIG00559473 FIG00559475: hypothetical protein +FIG00559475 FIG00559478: hypothetical protein +FIG00559478 FIG00559479: hypothetical protein +FIG00559485 FIG00559489: hypothetical protein +FIG00559490 Modification methylase AccI (EC 2.1.1.72) (Adenine-specific methyltransferase AccI) (M.AccI) +FIG00559492 Type IV pilus biogenesis protein PilN +FIG00559501 FIG00559503: hypothetical protein +FIG00559506 FIG00559512: hypothetical protein +FIG00559518 FIG00559522: hypothetical protein +FIG00559522 probable streptomycin biosynthesis operon possible regulatory protein +FIG00559526 FIG00559527: hypothetical protein +FIG00559527 UDP-sulfoquinovose synthase (EC 3.13.1.1) +FIG00559536 FIG00559537: hypothetical protein +FIG00559537 FIG00559540: hypothetical protein +FIG00559556 FIG00559557: hypothetical protein +FIG00559557 Glucosylglycerol-phosphate phosphatase (EC 3.1.3.69) +FIG00559562 FIG00559565: hypothetical protein +FIG00559570 FIG00559574: hypothetical protein +FIG00559575 FIG00559577: hypothetical protein +FIG00559579 FIG00559588: hypothetical protein +FIG00559588 FIG00559589: hypothetical protein +FIG00559589 FIG00559601: hypothetical protein +FIG00559601 FIG00559605: hypothetical protein +FIG00559605 FIG00559611: hypothetical protein +FIG00559611 FIG00559619: hypothetical protein +FIG00559619 FIG00559620: hypothetical protein +FIG00559629 FIG00559631: hypothetical protein +FIG00559631 Diflavin flavoprotein Sll0550 +FIG00559632 FIG00559637: hypothetical protein +FIG00559637 FIG00559641: hypothetical protein +FIG00559641 FIG00559647: hypothetical protein +FIG00559647 Uridine phosphorylase +FIG00559654 FIG00559655: hypothetical protein +FIG00559655 FIG00559660: hypothetical protein +FIG00559661 FIG00559662: hypothetical protein +FIG00559667 FIG00559668: hypothetical protein +FIG00559668 rubisco operon transcriptional regulator +FIG00559686 FIG00559695: hypothetical protein +FIG00559695 FIG00559703: hypothetical protein +FIG00559703 FIG00559704: hypothetical protein +FIG00559731 FIG00559733: hypothetical protein +FIG00559741 FIG00559744: hypothetical protein +FIG00559744 FIG00559746: hypothetical protein +FIG00559746 FIG00559750: hypothetical protein +FIG00559752 FIG00559758: hypothetical protein +FIG00559777 putative NifU-like protein +FIG00559780 FIG00559781: hypothetical protein +FIG00559781 FIG00559782: hypothetical protein +FIG00559803 FIG00559813: hypothetical protein +FIG00559823 FIG00559824: hypothetical protein +FIG00559824 FdxN element excision controlling factor protein +FIG00559826 FIG00559829: hypothetical protein +FIG00559829 FIG00559832: hypothetical protein +FIG00559833 FIG00559838: hypothetical protein +FIG00559838 FIG00559844: hypothetical protein +FIG00559844 FIG00559850: hypothetical protein +FIG00559850 FIG00559854: hypothetical protein +FIG00559863 FIG00559864: hypothetical protein +FIG00559865 FIG00559866: hypothetical protein +FIG00559866 Hopanoid 2-methyltransferase +FIG00559872 FIG00559873: hypothetical protein +FIG00559877 FIG00559885: hypothetical protein +FIG00559885 FIG00559890: hypothetical protein +FIG00559890 FIG00559892: hypothetical protein +FIG00559892 FIG00559899: hypothetical protein +FIG00559899 FIG00559903: hypothetical protein +FIG00559903 FIG00559904: hypothetical protein +FIG00559907 FIG00559909: hypothetical protein +FIG00559909 FIG00559910: hypothetical protein +FIG00559910 FIG00559913: hypothetical protein +FIG00559913 FIG00559915: hypothetical protein +FIG00559915 FIG00559917: hypothetical protein +FIG00559918 FIG00559925: hypothetical protein +FIG00559925 FIG00559927: hypothetical protein +FIG00559933 FIG00559936: hypothetical protein +FIG00559942 FIG00559944: hypothetical protein +FIG00559944 FIG00559947: hypothetical protein +FIG00559951 FIG00559952: hypothetical protein +FIG00559952 FIG00559960: hypothetical protein +FIG00559960 Putative multicomponent Na+:H+ antiporter subunit C +FIG00559970 FIG00559977: hypothetical protein +FIG00559977 protease; HhoA +FIG00559980 FIG00559985: hypothetical protein +FIG00559985 Protein of unknown function DUF323 +FIG00560003 Glycosyl transferase, family 2:TPR repeat:TPR repeat +FIG00560012 FIG00560018: hypothetical protein +FIG00560018 FIG00560021: hypothetical protein +FIG00560021 FIG00560022: hypothetical protein +FIG00560022 FIG00560023: hypothetical protein +FIG00560023 FIG00560025: hypothetical protein +FIG00560025 FIG00560026: hypothetical protein +FIG00560029 FIG00560031: hypothetical protein +FIG00560038 FIG00560040: hypothetical protein +FIG00560040 FIG00560043: hypothetical protein +FIG00560047 probable integral-membrane protein +FIG00560048 EF hand domain/PKD domain protein +FIG00560053 FIG00560054: hypothetical protein +FIG00560055 FIG00560056: hypothetical protein +FIG00560056 Aminotransferase +FIG00560065 FIG00560068: hypothetical protein +FIG00560070 Anti-sigma regulatory factor (Ser/Thr protein kinase), essential for photomixotrophic growth, PmgA +FIG00560074 FIG00570327: hypothetical protein +FIG00560076 FIG00560078: hypothetical protein +FIG00560078 FIG00560084: hypothetical protein +FIG00560088 FIG00560089: hypothetical protein +FIG00560089 FIG00560093: hypothetical protein +FIG00560093 FIG00560095: hypothetical protein +FIG00560095 FIG00560096: hypothetical protein +FIG00560096 FIG00560103: hypothetical protein +FIG00560103 FIG00560106: hypothetical protein +FIG00560106 Putative sulfite oxidase subunit YedY +FIG00560109 FIG00560114: hypothetical protein +FIG00560114 FIG00560115: hypothetical protein +FIG00560127 FIG00560128: hypothetical protein +FIG00560128 FIG00560129: hypothetical protein +FIG00560129 FIG00560130: hypothetical protein +FIG00560130 FIG00560133: hypothetical protein +FIG00560136 FIG00560137: hypothetical protein +FIG00560148 Two component Transcriptional regulator, Winged helix family protein +FIG00560156 COG0178: Excinuclease ATPase subunit +FIG00560160 FIG00560163: hypothetical protein +FIG00560171 FIG00560173: hypothetical protein +FIG00560173 COG4636: Uncharacterized protein conserved in cyanobacteria +FIG00560179 FIG00560185: hypothetical protein +FIG00560191 FIG00560198: hypothetical protein +FIG00560198 FIG00560199: hypothetical protein +FIG00560200 FIG00560208: hypothetical protein +FIG00560208 FIG00560210: hypothetical protein +FIG00560210 probable phosphoribosyltransferase +FIG00560215 Gll2901 protein +FIG00560217 Protein of unknown function DUF564 +FIG00560221 FIG00560223: hypothetical protein +FIG00560223 FIG00560228: hypothetical protein +FIG00560232 FIG00560236: hypothetical protein +FIG00560236 FIG00560250: hypothetical protein +FIG00560250 FIG00560255: hypothetical protein +FIG00560255 FIG00560262: hypothetical protein +FIG00560262 peptide deformylase( EC:3.5.1.88 ) +FIG00560263 FIG00560270: hypothetical protein +FIG00560270 FIG00560275: hypothetical protein +FIG00560275 FIG00560276: hypothetical protein +FIG00560276 FIG00560282: hypothetical protein +FIG00560282 FIG00560283: hypothetical protein +FIG00560285 FIG00560286: hypothetical protein +FIG00560286 FIG00560290: hypothetical protein +FIG00560292 FIG00560293: hypothetical protein +FIG00560293 FIG00560302: hypothetical protein +FIG00560302 FIG00560309: hypothetical protein +FIG00560309 FIG00560312: hypothetical protein +FIG00560312 FIG00560314: hypothetical protein +FIG00560314 FIG00560322: hypothetical protein +FIG00560322 FIG00560324: hypothetical protein +FIG00560341 FIG00560346: hypothetical protein +FIG00560347 FIG00560352: hypothetical protein +FIG00560352 FIG00560353: hypothetical protein +FIG00560353 FIG00560356: hypothetical protein +FIG00560357 FIG00560358: hypothetical protein +FIG00560362 FIG00560363: hypothetical protein +FIG00560363 FIG00560365: hypothetical protein +FIG00560370 Probable hydrocarbon oxygenase MocD +FIG00560372 FIG00560374: hypothetical protein +FIG00560374 FIG00560379: hypothetical protein +FIG00560379 FIG00560385: hypothetical protein +FIG00560386 FIG00560387: hypothetical protein +FIG00560387 FIG00560388: hypothetical protein +FIG00560388 FIG00560390: hypothetical protein +FIG00560390 FIG00560393: hypothetical protein +FIG00560404 FIG00560406: hypothetical protein +FIG00560406 FIG00560410: hypothetical protein +FIG00560410 FIG00560416: hypothetical protein +FIG00560416 FIG00560424: hypothetical protein +FIG00560424 FIG00560433: hypothetical protein +FIG00560434 FIG00560435: hypothetical protein +FIG00560435 HEAT:PBS lyase HEAT-like repeat +FIG00560436 FIG00560442: hypothetical protein +FIG00560446 FIG00560449: hypothetical protein +FIG00560451 FIG00560454: hypothetical protein +FIG00560461 Putative sulfite oxidase subunit YedY +FIG00560469 FIG00560473: hypothetical protein +FIG00560473 FIG00560474: hypothetical protein +FIG00560475 FIG00560476: hypothetical protein +FIG00560477 FIG00560482: hypothetical protein +FIG00560482 FIG00560483: hypothetical protein +FIG00560483 FIG00560489: hypothetical protein +FIG00560540 FIG00560544: hypothetical protein +FIG00560547 FIG00560550: hypothetical protein +FIG00560550 FIG00560551: hypothetical protein +FIG00560556 FIG00560559: hypothetical protein +FIG00560572 FIG00560583: hypothetical protein +FIG00560583 FIG00560585: hypothetical protein +FIG00560585 FIG00560587: hypothetical protein +FIG00560587 FIG00560590: hypothetical protein +FIG00560590 FIG00560594: hypothetical protein +FIG00560595 FIG00560605: hypothetical protein +FIG00560605 FIG00560606: hypothetical protein +FIG00560606 FIG00560608: hypothetical protein +FIG00560608 FIG00560609: hypothetical protein +FIG00560609 transcriptional regulator, AbrB family protein +FIG00560610 FIG00560615: hypothetical protein +FIG00560615 FIG00560618: hypothetical protein +FIG00560631 FIG00560633: hypothetical protein +FIG00560640 FIG00560650: hypothetical protein +FIG00560660 FIG00560664: hypothetical protein +FIG00560670 FIG00560672: hypothetical protein +FIG00560672 FIG00560677: hypothetical protein +FIG00560677 mitochondrial outer membrane 72K protein +FIG00560678 FIG00560681: hypothetical protein +FIG00560681 FIG00560689: hypothetical protein +FIG00560692 FIG00560705: hypothetical protein +FIG00560705 FIG00560707: hypothetical protein +FIG00560707 FIG00560714: hypothetical protein +FIG00560714 FIG00560723: hypothetical protein +FIG00560727 FIG00560739: hypothetical protein +FIG00560739 FIG00560741: hypothetical protein +FIG00560766 FIG00560768: hypothetical protein +FIG00560768 FIG00560778: hypothetical protein +FIG00560784 FIG00560786: hypothetical protein +FIG00560786 FIG00560787: hypothetical protein +FIG00560797 FIG00560798: hypothetical protein +FIG00560798 FIG00560801: hypothetical protein +FIG00560801 FIG00560802: hypothetical protein +FIG00560803 FIG00560805: hypothetical protein +FIG00560805 FIG00560807: hypothetical protein +FIG00560807 FIG00560810: hypothetical protein +FIG00560811 FIG00560812: hypothetical protein +FIG00560812 FIG00560814: hypothetical protein +FIG00560815 ORF_ID:slr6064 +FIG00560819 FIG00560820: hypothetical protein +FIG00560820 FIG00560823: hypothetical protein +FIG00560823 FIG00560825: hypothetical protein +FIG00560830 FIG00560831: hypothetical protein +FIG00560833 FIG00560837: hypothetical protein +FIG00560845 FIG00560849: hypothetical protein +FIG00560849 FIG00560851: hypothetical protein +FIG00560851 FIG00560856: hypothetical protein +FIG00560879 FIG00560880: hypothetical protein +FIG00560892 tRNA-dihydrouridine synthase A +FIG00560902 FIG00560905: hypothetical protein +FIG00560919 FIG00560921: hypothetical protein +FIG00560929 FIG00560931: hypothetical protein +FIG00560931 FIG00560935: hypothetical protein +FIG00560935 FIG00560938: hypothetical protein +FIG00560939 FIG00560944: hypothetical protein +FIG00560950 FIG00560951: hypothetical protein +FIG00560959 FIG00560962: hypothetical protein +FIG00560962 FIG00560964: hypothetical protein +FIG00560966 FIG00560972: hypothetical protein +FIG00560979 FIG00560987: hypothetical protein +FIG00560987 similar to TRAP-type uncharacterized transport system periplasmic component +FIG00560990 FIG00560997: hypothetical protein +FIG00560997 FIG00561003: hypothetical protein +FIG00561003 putative glycosyltransferase protein +FIG00561004 FIG00561006: hypothetical protein +FIG00561006 Myosin heavy chain +FIG00561023 fructose-bisphosphate aldolase( EC:4.1.2.13 ) +FIG00561026 FIG00561027: hypothetical protein +FIG00561037 FIG00561049: hypothetical protein +FIG00561049 FIG00561051: hypothetical protein +FIG00561056 FIG00561058: hypothetical protein +FIG00561058 FIG00561059: hypothetical protein +FIG00561061 FIG00561064: hypothetical protein +FIG00561064 FIG00561065: hypothetical protein +FIG00561065 FIG00561073: hypothetical protein +FIG00561073 FIG00561076: hypothetical protein +FIG00561090 FIG00561093: hypothetical protein +FIG00561093 FIG00561095: hypothetical protein +FIG00561095 FIG00561097: hypothetical protein +FIG00561102 PUCC protein:PUCC protein +FIG00561109 FIG00561110: hypothetical protein +FIG00561110 FIG00561111: hypothetical protein +FIG00561111 FIG00561112: hypothetical protein +FIG00561112 FIG00561121: hypothetical protein +FIG00561121 Protein-arginine deiminase type III (EC 3.5.3.15) +FIG00561134 FIG00561138: hypothetical protein +FIG00561175 FIG00561179: hypothetical protein +FIG00561190 FIG00561196: hypothetical protein +FIG00561196 FIG00561206: hypothetical protein +FIG00561207 FIG00561211: hypothetical protein +FIG00561211 FIG00561215: hypothetical protein +FIG00561224 FIG00561231: hypothetical protein +FIG00561235 FIG00561237: hypothetical protein +FIG00561238 FIG00561242: hypothetical protein +FIG00561265 FIG00561271: hypothetical protein +FIG00561277 FIG00561279: hypothetical protein +FIG00561282 FIG00561289: hypothetical protein +FIG00561290 FIG00561291: hypothetical protein +FIG00561291 FIG00561292: hypothetical protein +FIG00561299 FIG00561304: hypothetical protein +FIG00561304 FIG00561305: hypothetical protein +FIG00561305 FIG00561313: hypothetical protein +FIG00561313 FIG00561318: hypothetical protein +FIG00561318 FIG00561322: hypothetical protein +FIG00561329 FIG00561338: hypothetical protein +FIG00561338 FIG00561354: hypothetical protein +FIG00561354 FIG00561371: hypothetical protein +FIG00561371 FIG00561385: hypothetical protein +FIG00561385 FIG00561387: hypothetical protein +FIG00561387 FIG00561394: hypothetical protein +FIG00561400 FIG00561405: hypothetical protein +FIG00561408 FIG00561412: hypothetical protein +FIG00561412 FIG00561415: hypothetical protein +FIG00561415 FIG00561417: hypothetical protein +FIG00561420 Modification methylase AccI (EC 2.1.1.72) +FIG00561427 FIG00561436: hypothetical protein +FIG00561436 FIG00561438: hypothetical protein +FIG00561438 FIG00561440: hypothetical protein +FIG00561440 FIG00561444: hypothetical protein +FIG00561450 FIG00561452: hypothetical protein +FIG00561452 FIG00561460: hypothetical protein +FIG00561460 FIG00561461: hypothetical protein +FIG00561464 FIG00561466: hypothetical protein +FIG00561466 FIG00561471: hypothetical protein +FIG00561471 FIG00561475: hypothetical protein +FIG00561475 FIG00561480: hypothetical protein +FIG00561480 FIG00561481: hypothetical protein +FIG00561481 FIG00561485: hypothetical protein +FIG00561492 FIG00561493: hypothetical protein +FIG00561493 FIG00561496: hypothetical protein +FIG00561496 FIG00561497: hypothetical protein +FIG00561497 FIG00561498: hypothetical protein +FIG00561498 D-alanyl-D-alanine carboxypeptidase (EC 3.4.16.4) +FIG00561503 FIG00561506: hypothetical protein +FIG00561513 FIG00561522: hypothetical protein +FIG00561522 FIG00561525: hypothetical protein +FIG00561525 FIG00561530: hypothetical protein +FIG00561530 FIG00561533: hypothetical protein +FIG00561534 diguanylate cyclase/phosphodiesterase (GGDEF & EAL domains) with PAS/PAC sensor(s) +FIG00561541 FIG00561546: hypothetical protein +FIG00561546 FIG00561547: hypothetical protein +FIG00561547 FIG00561549: hypothetical protein +FIG00561556 FIG00561558: hypothetical protein +FIG00561558 FIG00561559: hypothetical protein +FIG00561578 FIG00561579: hypothetical protein +FIG00561579 FIG00561580: hypothetical protein +FIG00561589 FIG00561590: hypothetical protein +FIG00561616 FIG00561624: hypothetical protein +FIG00561624 FIG00561634: hypothetical protein +FIG00561634 FIG00561636: hypothetical protein +FIG00561636 FIG00561642: hypothetical protein +FIG00561647 FIG00561655: hypothetical protein +FIG00561655 FIG00561657: hypothetical protein +FIG00561664 FIG00561669: hypothetical protein +FIG00561669 putative UDP-glucose:sterol glucosyltransferase +FIG00561673 FIG00561674: hypothetical protein +FIG00561674 FIG00561675: hypothetical protein +FIG00561675 FIG00561687: hypothetical protein +FIG00561687 FIG00561701: hypothetical protein +FIG00561701 FIG00561713: hypothetical protein +FIG00561713 FIG00561716: hypothetical protein +FIG00561716 FIG00561717: hypothetical protein +FIG00561717 FIG00561718: hypothetical protein +FIG00561723 Surface antigen variable number +FIG00561726 FIG00561727: hypothetical protein +FIG00561732 FIG00561733: hypothetical protein +FIG00561733 FIG00561735: hypothetical protein +FIG00561735 FIG00561737: hypothetical protein +FIG00561739 FIG00561741: hypothetical protein +FIG00561754 FIG00561757: hypothetical protein +FIG00561757 FIG00561764: hypothetical protein +FIG00561764 FIG00561768: hypothetical protein +FIG00561770 FIG00561771: hypothetical protein +FIG00561771 cytosine-specific DNA methyltransferase +FIG00561775 FIG00561776: hypothetical protein +FIG00561776 FIG00561780: hypothetical protein +FIG00561780 FIG00561783: hypothetical protein +FIG00561783 FIG00561786: hypothetical protein +FIG00561786 FIG00561792: hypothetical protein +FIG00561792 FIG00561793: hypothetical protein +FIG00561819 FIG00561820: hypothetical protein +FIG00561823 FIG00561827: hypothetical protein +FIG00561833 FIG00561835: hypothetical protein +FIG00561835 FIG00561843: hypothetical protein +FIG00561843 FIG00561846: hypothetical protein +FIG00561846 FIG00561851: hypothetical protein +FIG00561856 FIG00561858: hypothetical protein +FIG00561858 FIG00561860: hypothetical protein +FIG00561860 FIG00561873: hypothetical protein +FIG00561878 FIG00561881: hypothetical protein +FIG00561881 hypothetical protein +FIG00561902 similar to phosphoenolpyruvate synthase +FIG00561913 FIG00561917: hypothetical protein +FIG00561917 FIG00561922: hypothetical protein +FIG00561925 FIG00561931: hypothetical protein +FIG00561931 FIG00561939: hypothetical protein +FIG00561940 FIG00561941: hypothetical protein +FIG00561941 FIG00561949: hypothetical protein +FIG00561956 FIG00561957: hypothetical protein +FIG00561957 FIG00561959: hypothetical protein +FIG00561959 FIG00561960: hypothetical protein +FIG00561981 FIG00561988: hypothetical protein +FIG00561996 FIG00561997: hypothetical protein +FIG00561997 FIG00562000: hypothetical protein +FIG00562000 FIG00562001: hypothetical protein +FIG00562001 FIG00562003: hypothetical protein +FIG00562003 FIG00562007: hypothetical protein +FIG00562007 FIG00562008: hypothetical protein +FIG00562009 FIG00562014: hypothetical protein +FIG00562014 FIG00562017: hypothetical protein +FIG00562017 FIG00562020: hypothetical protein +FIG00562020 FIG00562026: hypothetical protein +FIG00562026 FIG00562032: hypothetical protein +FIG00562032 FIG00562033: hypothetical protein +FIG00562033 FIG00562034: hypothetical protein +FIG00562034 FIG00562036: hypothetical protein +FIG00562037 FIG00562040: hypothetical protein +FIG00562040 FIG00562042: hypothetical protein +FIG00562052 FIG00562054: hypothetical protein +FIG00562056 FIG00562060: hypothetical protein +FIG00562060 FIG00562063: hypothetical protein +FIG00562063 FIG00562064: hypothetical protein +FIG00562066 FIG00562074: hypothetical protein +FIG00562077 FIG00562079: hypothetical protein +FIG00562079 FIG00562082: hypothetical protein +FIG00562082 Sll0319 protein +FIG00562104 FIG00562107: hypothetical protein +FIG00562107 FIG00562113: hypothetical protein +FIG00562113 FIG00562115: hypothetical protein +FIG00562116 FIG00562123: hypothetical protein +FIG00562123 FIG00562132: hypothetical protein +FIG00562132 FIG00562138: hypothetical protein +FIG00562138 FIG00562145: hypothetical protein +FIG00562146 FIG00562147: hypothetical protein +FIG00562147 FIG00562148: hypothetical protein +FIG00562148 FIG00562150: hypothetical protein +FIG00562150 FIG00562151: hypothetical protein +FIG00562151 FIG00562154: hypothetical protein +FIG00562154 FIG00562156: hypothetical protein +FIG00562156 FIG00562160: hypothetical protein +FIG00562160 FIG00562161: hypothetical protein +FIG00562166 FIG00562177: hypothetical protein +FIG00562189 FIG00562190: hypothetical protein +FIG00562190 FIG00562191: hypothetical protein +FIG00562193 FIG00562194: hypothetical protein +FIG00562194 FIG00562197: hypothetical protein +FIG00562197 FIG00562201: hypothetical protein +FIG00562201 FIG00562204: hypothetical protein +FIG00562204 FIG00562206: hypothetical protein +FIG00562207 Cellulose-binding domain protein +FIG00562222 FIG00562223: hypothetical protein +FIG00562223 FIG00562226: hypothetical protein +FIG00562226 FIG00562228: hypothetical protein +FIG00562232 FIG00562233: hypothetical protein +FIG00562233 FIG00562238: hypothetical protein +FIG00562253 FIG00562254: hypothetical protein +FIG00562264 FIG00562270: hypothetical protein +FIG00562271 FIG00562272: hypothetical protein +FIG00562282 FIG00562291: hypothetical protein +FIG00562295 FIG00562298: hypothetical protein +FIG00562300 FIG00562302: hypothetical protein +FIG00562302 FIG00562304: hypothetical protein +FIG00562304 FIG00562308: hypothetical protein +FIG00562308 FIG00562311: hypothetical protein +FIG00562312 FIG00562318: hypothetical protein +FIG00562318 FIG00562319: hypothetical protein +FIG00562319 FIG00562345: hypothetical protein +FIG00562362 FIG00562365: hypothetical protein +FIG00562365 FIG00562371: hypothetical protein +FIG00562371 FIG00562372: hypothetical protein +FIG00562374 Response Regulator Receiver Signal Transduction Histidine Kinase +FIG00562377 FIG00562379: hypothetical protein +FIG00562379 FIG00562380: hypothetical protein +FIG00562380 FIG00562383: hypothetical protein +FIG00562385 Chromosome segregation ATPase-like protein +FIG00562404 FIG00562405: hypothetical protein +FIG00562405 FIG00562411: hypothetical protein +FIG00562412 FIG00562417: hypothetical protein +FIG00562417 FIG00562421: hypothetical protein +FIG00562424 FIG00562425: hypothetical protein +FIG00562430 FIG00562435: hypothetical protein +FIG00562439 FIG00562447: hypothetical protein +FIG00562447 FIG00562458: hypothetical protein +FIG00562458 FIG00562462: hypothetical protein +FIG00562462 FIG00562465: hypothetical protein +FIG00562467 FIG00562468: hypothetical protein +FIG00562476 FIG00562480: hypothetical protein +FIG00562481 FIG00562483: hypothetical protein +FIG00562483 mercuric reductase +FIG00562485 FIG00562486: hypothetical protein +FIG00562486 FIG00562488: hypothetical protein +FIG00562488 FIG00562489: hypothetical protein +FIG00562489 FIG00562491: hypothetical protein +FIG00562491 FIG00562495: hypothetical protein +FIG00562495 FIG00562498: hypothetical protein +FIG00562498 FIG00562500: hypothetical protein +FIG00562501 FIG00562503: hypothetical protein +FIG00562503 FIG00562507: hypothetical protein +FIG00562507 FIG00562511: hypothetical protein +FIG00562513 FIG00562514: hypothetical protein +FIG00562515 FIG00562520: hypothetical protein +FIG00562524 FIG00562527: hypothetical protein +FIG00562527 FIG00562534: hypothetical protein +FIG00562540 FIG00562542: hypothetical protein +FIG00562543 FIG00562545: hypothetical protein +FIG00562545 Tn7-like transposition protein C +FIG00562549 FIG00562554: hypothetical protein +FIG00562558 FIG01021846: hypothetical protein +FIG00562572 FIG00562573: hypothetical protein +FIG00562573 FIG00562577: hypothetical protein +FIG00562577 FIG00562582: hypothetical protein +FIG00562591 FIG00562592: hypothetical protein +FIG00562612 Mannose-6-phosphate isomerase, type II:Cupin region +FIG00562617 FIG00562621: hypothetical protein +FIG00562621 FIG00562633: hypothetical protein +FIG00562633 FIG00562637: hypothetical protein +FIG00562644 FIG00562653: hypothetical protein +FIG00562653 FIG00562661: hypothetical protein +FIG00562662 FIG00562663: hypothetical protein +FIG00562663 ABC-transporter DevC-like protein +FIG00562665 FIG00562666: hypothetical protein +FIG00562669 FIG00562677: hypothetical protein +FIG00562677 FIG00562678: hypothetical protein +FIG00562678 FIG00562682: hypothetical protein +FIG00562683 FIG00562694: hypothetical protein +FIG00562716 FIG00562721: hypothetical protein +FIG00562722 FIG00562725: hypothetical protein +FIG00562725 FIG00562729: hypothetical protein +FIG00562729 FIG00562735: hypothetical protein +FIG00562735 FIG00562741: hypothetical protein +FIG00562751 FIG00562768: hypothetical protein +FIG00562768 FIG00562773: hypothetical protein +FIG00562783 FIG00562784: hypothetical protein +FIG00562784 FIG00562787: hypothetical protein +FIG00562787 FIG00562791: hypothetical protein +FIG00562795 FIG00562798: hypothetical protein +FIG00562806 FIG00562808: hypothetical protein +FIG00562808 FIG00562815: hypothetical protein +FIG00562819 FIG00562825: hypothetical protein +FIG00562825 FIG00562826: hypothetical protein +FIG00562826 FIG00562827: hypothetical protein +FIG00562827 FIG00562830: hypothetical protein +FIG00562835 FIG00562843: hypothetical protein +FIG00562843 FIG00562847: hypothetical protein +FIG00562851 FIG00562853: hypothetical protein +FIG00562853 FIG00562856: hypothetical protein +FIG00562861 FIG00562867: hypothetical protein +FIG00562867 FIG00562872: hypothetical protein +FIG00562872 FIG00562873: hypothetical protein +FIG00562873 FIG00562874: hypothetical protein +FIG00562874 FIG00562875: hypothetical protein +FIG00562875 FIG00562879: hypothetical protein +FIG00562881 FIG00562882: hypothetical protein +FIG00562882 FIG00562893: hypothetical protein +FIG00562893 FIG00562899: hypothetical protein +FIG00562910 FIG00562912: hypothetical protein +FIG00562923 fdxN element excision controlling factor protein +FIG00562934 FIG00562937: hypothetical protein +FIG00562937 FIG00562938: hypothetical protein +FIG00562938 FIG00562941: hypothetical protein +FIG00562941 GCN5-related N-acetyltransferase( EC:2.3.1.82 ) +FIG00562948 FIG00562949: hypothetical protein +FIG00562949 FIG00562956: hypothetical protein +FIG00562956 FIG00562957: hypothetical protein +FIG00562957 Conserved hypothetical protein 725 +FIG00562963 FIG00562968: hypothetical protein +FIG00562991 YCII-related +FIG00562992 FIG00562995: hypothetical protein +FIG00562995 FIG00563004: hypothetical protein +FIG00563004 Protein of unknown function DUF433 +FIG00563006 FIG00563008: hypothetical protein +FIG00563008 FIG00563011: hypothetical protein +FIG00563019 FIG00563026: hypothetical protein +FIG00563026 FIG00563027: hypothetical protein +FIG00563027 FIG00563028: hypothetical protein +FIG00563028 FIG00563039: hypothetical protein +FIG00563039 FIG00563040: hypothetical protein +FIG00563043 FIG00563045: hypothetical protein +FIG00563045 FIG00563049: hypothetical protein +FIG00563049 FIG00563054: hypothetical protein +FIG00563054 FIG00563055: hypothetical protein +FIG00563059 FIG00563061: hypothetical protein +FIG00563073 FIG00563077: hypothetical protein +FIG00563087 FIG00563089: hypothetical protein +FIG00563089 FIG00563090: hypothetical protein +FIG00563090 FIG00563094: hypothetical protein +FIG00563094 FIG00563096: hypothetical protein +FIG00563096 FIG00563097: hypothetical protein +FIG00563100 FIG00563101: hypothetical protein +FIG00563101 FIG00563103: hypothetical protein +FIG00563103 FIG00563111: hypothetical protein +FIG00563111 FIG00563113: hypothetical protein +FIG00563113 FIG00563115: hypothetical protein +FIG00563115 FIG00563117: hypothetical protein +FIG00563121 FIG00563122: hypothetical protein +FIG00563124 FIG00563126: hypothetical protein +FIG00563126 FIG00563127: hypothetical protein +FIG00563133 FIG00563137: hypothetical protein +FIG00563137 beta lactamase family protein +FIG00563138 FIG00563142: hypothetical protein +FIG00563142 FIG00563145: hypothetical protein +FIG00563145 FIG00563147: hypothetical protein +FIG00563147 FIG00563154: hypothetical protein +FIG00563155 FIG00563158: hypothetical protein +FIG00563158 FIG00563160: hypothetical protein +FIG00563167 FIG00563168: hypothetical protein +FIG00563168 FIG00563169: hypothetical protein +FIG00563177 FIG00563179: hypothetical protein +FIG00563198 Type IV pilin PilA +FIG00563201 FIG00563211: hypothetical protein +FIG00563217 FIG00563218: hypothetical protein +FIG00563220 FIG00563226: hypothetical protein +FIG00563230 FIG00563231: hypothetical protein +FIG00563259 FIG00563260: hypothetical protein +FIG00563260 FIG00563263: hypothetical protein +FIG00563263 FIG00563266: hypothetical protein +FIG00563266 FIG00563270: hypothetical protein +FIG00563270 FIG00563276: hypothetical protein +FIG00563287 FIG00563289: hypothetical protein +FIG00563289 FIG00563294: hypothetical protein +FIG00563300 FIG00563302: hypothetical protein +FIG00563303 FIG00563312: hypothetical protein +FIG00563317 FIG00563318: hypothetical protein +FIG00563328 FIG00563329: hypothetical protein +FIG00563329 FIG00563339: hypothetical protein +FIG00563339 Ssl0467 protein +FIG00563343 FIG00563347: hypothetical protein +FIG00563350 PepSY-associated TM helix protein +FIG00563355 FIG00563356: hypothetical protein +FIG00563359 FIG00563364: hypothetical protein +FIG00563364 FIG00563366: hypothetical protein +FIG00563366 FIG00563367: hypothetical protein +FIG00563372 FIG00563375: hypothetical protein +FIG00563377 FIG00563379: hypothetical protein +FIG00563382 FIG00563394: hypothetical protein +FIG00563394 FIG00563396: hypothetical protein +FIG00563396 FIG00563401: hypothetical protein +FIG00563401 FIG00563402: hypothetical protein +FIG00563402 FIG00563405: hypothetical protein +FIG00563405 FIG00563408: hypothetical protein +FIG00563418 FIG00563421: hypothetical protein +FIG00563421 Two Component Transcriptional Regulator, LuxR family protein +FIG00563427 FIG00563433: hypothetical protein +FIG00563439 FIG00563445: hypothetical protein +FIG00563445 FIG00563446: hypothetical protein +FIG00563446 FIG00563454: hypothetical protein +FIG00563456 FIG00563465: hypothetical protein +FIG00563468 FIG00563469: hypothetical protein +FIG00563469 FIG00563471: hypothetical protein +FIG00563471 FIG00563478: hypothetical protein +FIG00563478 FIG00563482: hypothetical protein +FIG00563482 homolog of ABC-type phosphate transport system substrate-binding protein SphX/PstS +FIG00563487 FIG00563489: hypothetical protein +FIG00563489 probable enterotoxin +FIG00563490 FIG00563491: hypothetical protein +FIG00563491 FIG00563493: hypothetical protein +FIG00563500 FIG00563501: hypothetical protein +FIG00563504 putative porin; major outer membrane protein +FIG00563521 FIG00563524: hypothetical protein +FIG00563526 FIG00563527: hypothetical protein +FIG00563527 cellulose-binding domain protein +FIG00563537 FIG00563539: hypothetical protein +FIG00563539 FIG00563543: hypothetical protein +FIG00563543 FIG00563544: hypothetical protein +FIG00563544 FIG00563548: hypothetical protein +FIG00563552 FIG00563554: hypothetical protein +FIG00563554 ribosomal protein L17 +FIG00563557 FIG00563558: hypothetical protein +FIG00563572 FIG00563573: hypothetical protein +FIG00563578 FIG00563580: hypothetical protein +FIG00563583 FIG00563587: hypothetical protein +FIG00563587 Membrane associated glutaredoxin +FIG00563598 FIG00563605: hypothetical protein +FIG00563605 FIG00563607: hypothetical protein +FIG00563607 FIG00563608: hypothetical protein +FIG00563608 FIG00563625: hypothetical protein +FIG00563625 FIG00563632: hypothetical protein +FIG00563632 FIG00563639: hypothetical protein +FIG00563639 COG0439: Biotin carboxylase +FIG00563663 FIG00563668: hypothetical protein +FIG00563668 FIG00563675: hypothetical protein +FIG00563675 FIG00563678: hypothetical protein +FIG00563682 FIG00563684: hypothetical protein +FIG00563684 FIG00563686: hypothetical protein +FIG00563686 FIG00563692: hypothetical protein +FIG00563692 FIG00563695: hypothetical protein +FIG00563706 FIG00563708: hypothetical protein +FIG00563716 FIG00563720: hypothetical protein +FIG00563721 FIG00563724: hypothetical protein +FIG00563726 HicB protein +FIG00563740 FIG00563752: hypothetical protein +FIG00563773 FIG00563778: hypothetical protein +FIG00563778 FIG00563783: hypothetical protein +FIG00563783 FIG00563789: hypothetical protein +FIG00563801 FIG00563805: hypothetical protein +FIG00563805 FIG00563807: hypothetical protein +FIG00563807 FIG00563810: hypothetical protein +FIG00563812 FIG00563818: hypothetical protein +FIG00563821 FIG00563823: hypothetical protein +FIG00563823 FIG00563825: hypothetical protein +FIG00563825 FIG00563828: hypothetical protein +FIG00563828 FIG00563837: hypothetical protein +FIG00563837 FIG00563845: hypothetical protein +FIG00563850 FIG00563851: hypothetical protein +FIG00563851 FIG00563852: hypothetical protein +FIG00563863 FIG00563866: hypothetical protein +FIG00563866 FIG00563878: hypothetical protein +FIG00563878 FIG00563886: hypothetical protein +FIG00563886 FIG00563887: hypothetical protein +FIG00563887 FIG00563891: hypothetical protein +FIG00563903 FIG00563906: hypothetical protein +FIG00563906 FIG00563909: hypothetical protein +FIG00563914 FIG00563922: hypothetical protein +FIG00563922 FIG00563927: hypothetical protein +FIG00563946 FIG00563948: hypothetical protein +FIG00563948 FIG00563954: hypothetical protein +FIG00563964 Sulfotransferase domain superfamily +FIG00563967 FIG00563970: hypothetical protein +FIG00563970 FIG00563973: hypothetical protein +FIG00563976 FIG00563986: hypothetical protein +FIG00563986 FIG00564001: hypothetical protein +FIG00564001 FIG00564004: hypothetical protein +FIG00564022 FIG00564023: hypothetical protein +FIG00564023 FIG00564024: hypothetical protein +FIG00564024 FIG00564025: hypothetical protein +FIG00564025 Sll0524 protein +FIG00564036 FIG00564050: hypothetical protein +FIG00564050 FIG00564052: hypothetical protein +FIG00564052 FIG00564055: hypothetical protein +FIG00564055 FIG00564059: hypothetical protein +FIG00564059 molybdopterin precursor biosynthesis protein +FIG00564061 FIG00564062: hypothetical protein +FIG00564062 FIG00564065: hypothetical protein +FIG00564065 FIG00564067: hypothetical protein +FIG00564067 FIG00564069: hypothetical protein +FIG00564069 FIG00564074: hypothetical protein +FIG00564074 FIG00564077: hypothetical protein +FIG00564085 FIG00564090: hypothetical protein +FIG00564090 FIG00564098: hypothetical protein +FIG00564098 FIG00564105: hypothetical protein +FIG00564105 FIG00564111: hypothetical protein +FIG00564126 FIG00564134: hypothetical protein +FIG00564134 regulatory protein CII +FIG00564141 FIG00564145: hypothetical protein +FIG00564145 FIG00564146: hypothetical protein +FIG00564146 Phosphodiesterase/alkaline phosphatase D-like +FIG00564151 FIG00564153: hypothetical protein +FIG00564153 FIG00564154: hypothetical protein +FIG00564154 FIG00564157: hypothetical protein +FIG00564161 FIG00564170: hypothetical protein +FIG00564171 FIG00564177: hypothetical protein +FIG00564178 FIG00564181: hypothetical protein +FIG00564209 FIG00564214: hypothetical protein +FIG00564216 FIG00564224: hypothetical protein +FIG00564224 FIG00564230: hypothetical protein +FIG00564230 FIG00564231: hypothetical protein +FIG00564232 FIG00564241: hypothetical protein +FIG00564251 FIG00564256: hypothetical protein +FIG00564256 Cellulose synthase (UDP-forming) +FIG00564257 FIG00564258: hypothetical protein +FIG00564260 FIG00564261: hypothetical protein +FIG00564261 FIG00564267: hypothetical protein +FIG00564267 FIG00564276: hypothetical protein +FIG00564278 FIG00564284: hypothetical protein +FIG00564287 similar to integral membrane protein +FIG00564300 FIG00564309: hypothetical protein +FIG00564309 FIG00564314: hypothetical protein +FIG00564314 Putative silver efflux pump +FIG00564315 FIG00564324: hypothetical protein +FIG00564345 FIG00564346: hypothetical protein +FIG00564347 FIG00564353: hypothetical protein +FIG00564353 FIG00564355: hypothetical protein +FIG00564355 Protein of unknown function DUF1400 +FIG00564359 FIG00564361: hypothetical protein +FIG00564361 Fe-S oxidoreductases of moaA/nifB/pqqE family +FIG00564369 Gll2151 protein +FIG00564380 FIG00564382: hypothetical protein +FIG00564382 FIG00564383: hypothetical protein +FIG00564383 FIG00564384: hypothetical protein +FIG00564387 FIG00564389: hypothetical protein +FIG00564389 FIG00564390: hypothetical protein +FIG00564390 FIG00564392: hypothetical protein +FIG00564392 FIG00564397: hypothetical protein +FIG00564412 FIG00564415: hypothetical protein +FIG00564415 FIG00564416: hypothetical protein +FIG00564416 FIG00564420: hypothetical protein +FIG00564420 FIG00564421: hypothetical protein +FIG00564424 FIG00564427: hypothetical protein +FIG00564459 FIG00564460: hypothetical protein +FIG00564468 FIG00564469: hypothetical protein +FIG00564469 FIG00564473: hypothetical protein +FIG00564473 FIG00564474: hypothetical protein +FIG00564474 NB-ARC domain protein +FIG00564477 FIG00564479: hypothetical protein +FIG00564479 FIG00564482: hypothetical protein +FIG00564498 FIG00564503: hypothetical protein +FIG00564503 FIG00564509: hypothetical protein +FIG00564509 FIG00564516: hypothetical protein +FIG00564521 FIG00564522: hypothetical protein +FIG00564522 FIG00564528: hypothetical protein +FIG00564528 FIG00564538: hypothetical protein +FIG00564538 FIG00564541: hypothetical protein +FIG00564547 FIG00564558: hypothetical protein +FIG00564558 FIG00564559: hypothetical protein +FIG00564565 FIG00564566: hypothetical protein +FIG00564573 FIG00564574: hypothetical protein +FIG00564577 FIG00564586: hypothetical protein +FIG00564586 FIG00564590: hypothetical protein +FIG00564592 CRISPR-associated protein Cas5 +FIG00564603 FIG00564614: hypothetical protein +FIG00564614 FIG00564617: hypothetical protein +FIG00564617 FIG00564621: hypothetical protein +FIG00564622 FIG00564623: hypothetical protein +FIG00564623 FIG00564630: hypothetical protein +FIG00564637 FIG00564638: hypothetical protein +FIG00564638 FIG00564639: hypothetical protein +FIG00564639 FIG00564648: hypothetical protein +FIG00564648 FIG00564650: hypothetical protein +FIG00564650 FIG00564654: hypothetical protein +FIG00564669 FIG00564682: hypothetical protein +FIG00564682 Mo-dependent nitrogenase-like protein +FIG00564694 FIG00564703: hypothetical protein +FIG00564703 FIG00564713: hypothetical protein +FIG00564713 FIG00564715: hypothetical protein +FIG00564715 FIG00564722: hypothetical protein +FIG00564722 FIG00564723: hypothetical protein +FIG00564727 FIG00564728: hypothetical protein +FIG00564729 FIG00564732: hypothetical protein +FIG00564737 FIG00564742: hypothetical protein +FIG00564744 FIG00564749: hypothetical protein +FIG00564754 FIG00564755: hypothetical protein +FIG00564755 FIG00564757: hypothetical protein +FIG00564760 aspartate aminotransferase( EC:2.6.1.1 ) +FIG00564769 FIG00564774: hypothetical protein +FIG00564774 FIG00564775: hypothetical protein +FIG00564775 Glutaryl-7-aminocephalosporanic-acid acylase precursor (EC 3.5.1.93) +FIG00564784 FIG00564794: hypothetical protein +FIG00564794 FIG00564801: hypothetical protein +FIG00564801 FIG00564802: hypothetical protein +FIG00564802 FIG00564805: hypothetical protein +FIG00564805 FIG00564814: hypothetical protein +FIG00564814 FIG00564815: hypothetical protein +FIG00564820 FIG00564822: hypothetical protein +FIG00564838 FIG00564845: hypothetical protein +FIG00564869 FIG00564881: hypothetical protein +FIG00564881 FIG00564888: hypothetical protein +FIG00564899 FIG00564901: hypothetical protein +FIG00564905 FIG00564907: hypothetical protein +FIG00564907 FIG00564915: hypothetical protein +FIG00564915 FIG00564919: hypothetical protein +FIG00564922 FIG00564930: hypothetical protein +FIG00564930 COG0643: Chemotaxis protein histidine kinase and related kinases +FIG00564931 Neurofilament triplet H protein +FIG00564932 Dolichol-phosphate mannosyltransferase (EC 2.4.1.83) +FIG00564935 FIG00564941: hypothetical protein +FIG00564941 FIG00564955: hypothetical protein +FIG00564955 FIG00564959: hypothetical protein +FIG00564964 FIG00564965: hypothetical protein +FIG00564965 DUF98 family +FIG00564984 FIG00564995: hypothetical protein +FIG00564995 FIG00564997: hypothetical protein +FIG00565004 FIG00565010: hypothetical protein +FIG00565013 FIG00565014: hypothetical protein +FIG00565014 FIG00565015: hypothetical protein +FIG00565017 Transcriptional Regulator of molybdate metabolism, XRE family +FIG00565018 COG1725: Predicted transcriptional regulators +FIG00565027 FIG00565029: hypothetical protein +FIG00565031 FIG00565045: hypothetical protein +FIG00565048 FIG00565050: hypothetical protein +FIG00565050 FIG00565055: hypothetical protein +FIG00565055 FIG00565058: hypothetical protein +FIG00565058 FIG00565066: hypothetical protein +FIG00565066 FIG00565075: hypothetical protein +FIG00565081 SAM-dependent methyltransferase +FIG00565090 FIG00565091: hypothetical protein +FIG00565091 FIG00565097: hypothetical protein +FIG00565102 Peptidase S49, protease IV +FIG00565109 FIG00565115: hypothetical protein +FIG00565115 FIG00565132: hypothetical protein +FIG00565132 FIG00565133: hypothetical protein +FIG00565133 FIG00565134: hypothetical protein +FIG00565134 FIG00565140: hypothetical protein +FIG00565143 FIG00565150: hypothetical protein +FIG00565150 FIG00565152: hypothetical protein +FIG00565152 FIG00565153: hypothetical protein +FIG00565153 FIG00565154: hypothetical protein +FIG00565162 FIG00565165: hypothetical protein +FIG00565175 Glutathione-dependent formaldehyde-activating, GFA +FIG00565188 FIG00565190: hypothetical protein +FIG00565196 FIG00565197: hypothetical protein +FIG00565197 FIG00565203: hypothetical protein +FIG00565203 FIG00565205: hypothetical protein +FIG00565219 FIG00565220: hypothetical protein +FIG00565223 FIG00565224: hypothetical protein +FIG00565231 FIG01191333: hypothetical protein +FIG00565235 FIG00565239: hypothetical protein +FIG00565246 FIG00565248: hypothetical protein +FIG00565248 FIG00565252: hypothetical protein +FIG00565252 FIG00565255: hypothetical protein +FIG00565258 FIG00565259: hypothetical protein +FIG00565259 FIG00565263: hypothetical protein +FIG00565270 FIG00565275: hypothetical protein +FIG00565280 FIG00565286: hypothetical protein +FIG00565290 FIG00565293: hypothetical protein +FIG00565308 FIG00565310: hypothetical protein +FIG00565310 FIG00565313: hypothetical protein +FIG00565313 Transcriptional regulatory protein tyrR +FIG00565316 FIG00565319: hypothetical protein +FIG00565319 FIG00565320: hypothetical protein +FIG00565337 FIG00565341: hypothetical protein +FIG00565341 FIG00565348: hypothetical protein +FIG00565348 FIG00565352: hypothetical protein +FIG00565356 FIG00565362: hypothetical protein +FIG00565364 FIG00565370: hypothetical protein +FIG00565370 FIG00565372: hypothetical protein +FIG00565374 FIG00565375: hypothetical protein +FIG00565379 Protein of unknown function DUF1499 +FIG00565384 FIG00565388: hypothetical protein +FIG00565388 Retinal pigment epithelial membrane protein +FIG00565411 FIG00565412: hypothetical protein +FIG00565413 FIG00565415: hypothetical protein +FIG00565425 FIG00565427: hypothetical protein +FIG00565427 FIG00565444: hypothetical protein +FIG00565444 FIG00565456: hypothetical protein +FIG00565461 FIG00565462: hypothetical protein +FIG00565463 FIG00565478: hypothetical protein +FIG00565478 FIG00565488: hypothetical protein +FIG00565488 FIG00565490: hypothetical protein +FIG00565490 FIG00565491: hypothetical protein +FIG00565491 hypothetical transporter +FIG00565501 FIG00565511: hypothetical protein +FIG00565535 FIG00565538: hypothetical protein +FIG00565538 FIG00565541: hypothetical protein +FIG00565541 FIG00565543: hypothetical protein +FIG00565559 FIG00565563: hypothetical protein +FIG00565568 FIG00565569: hypothetical protein +FIG00565569 FIG00565570: hypothetical protein +FIG00565570 FIG00565577: hypothetical protein +FIG00565577 FIG00565598: hypothetical protein +FIG00565602 FIG00565604: hypothetical protein +FIG00565604 FIG00565607: hypothetical protein +FIG00565612 ABC transporter, permease protein ybbP / Tlr1762 protein +FIG00565621 Exopolysaccharide synthesis protein +FIG00565628 FIG00565634: hypothetical protein +FIG00565634 FIG00565635: hypothetical protein +FIG00565643 FIG00565648: hypothetical protein +FIG00565648 FIG00565651: hypothetical protein +FIG00565651 FIG00565652: hypothetical protein +FIG00565653 FIG00565656: hypothetical protein +FIG00565656 FIG00565662: hypothetical protein +FIG00565664 FIG00565670: hypothetical protein +FIG00565673 FIG00565675: hypothetical protein +FIG00565675 FIG00565679: hypothetical protein +FIG00565679 FIG00565682: hypothetical protein +FIG00565682 FIG00565686: hypothetical protein +FIG00565694 FIG00565698: hypothetical protein +FIG00565698 FIG00565700: hypothetical protein +FIG00565700 FIG00565707: hypothetical protein +FIG00565707 Conserved hypothetical protein 730 +FIG00565711 FIG00565715: hypothetical protein +FIG00565715 FIG00565717: hypothetical protein +FIG00565727 FIG00565746: hypothetical protein +FIG00565762 FIG00565765: hypothetical protein +FIG00565767 FIG00565768: hypothetical protein +FIG00565769 FIG00565774: hypothetical protein +FIG00565781 FIG00565782: hypothetical protein +FIG00565782 FIG00565784: hypothetical protein +FIG00565784 FIG00565792: hypothetical protein +FIG00565796 FIG00565806: hypothetical protein +FIG00565815 FIG00565817: hypothetical protein +FIG00565817 FIG00565818: hypothetical protein +FIG00565830 FIG00565834: hypothetical protein +FIG00565834 FIG00565836: hypothetical protein +FIG00565836 FIG00565851: hypothetical protein +FIG00565851 FIG00565852: hypothetical protein +FIG00565852 FIG00565853: hypothetical protein +FIG00565853 FIG00565855: hypothetical protein +FIG00565857 FIG00565858: hypothetical protein +FIG00565858 FIG00565859: hypothetical protein +FIG00565859 FIG00565862: hypothetical protein +FIG00565865 FIG00565868: hypothetical protein +FIG00565880 FIG00565883: hypothetical protein +FIG00565913 FIG00565916: hypothetical protein +FIG00565916 FIG00565923: hypothetical protein +FIG00565923 FIG00565924: hypothetical protein +FIG00565924 FIG00565933: hypothetical protein +FIG00565933 FIG00565936: hypothetical protein +FIG00565945 FIG00565948: hypothetical protein +FIG00565948 FIG00565953: hypothetical protein +FIG00565953 FIG00565957: hypothetical protein +FIG00565957 FIG00565959: hypothetical protein +FIG00565960 FIG00565961: hypothetical protein +FIG00565966 leucyl aminopeptidase( EC:3.4.11.1 ) +FIG00566009 putative restriction enzyme +FIG00566010 FIG00566012: hypothetical protein +FIG00566014 Protein containing N-terminal predicted GTPase domain +FIG00566036 FIG00566039: hypothetical protein +FIG00566039 FIG00566045: hypothetical protein +FIG00566045 FIG00566047: hypothetical protein +FIG00566047 FIG00566053: hypothetical protein +FIG00566056 FIG00566075: hypothetical protein +FIG00566075 FIG00566077: hypothetical protein +FIG00566077 FIG00566086: hypothetical protein +FIG00566086 Short-chain dehydrogenase/reductase SDR( EC:1.1.1.100 ) +FIG00566092 FIG00566099: hypothetical protein +FIG00566102 FIG00566118: hypothetical protein +FIG00566131 FIG00566138: hypothetical protein +FIG00566146 FIG00566147: hypothetical protein +FIG00566162 FIG00566165: hypothetical protein +FIG00566165 NarL subfamily protein +FIG00566167 FIG00566173: hypothetical protein +FIG00566179 FIG00566202: hypothetical protein +FIG00566202 FIG00566205: hypothetical protein +FIG00566214 FIG00566220: hypothetical protein +FIG00566220 FIG00566223: hypothetical protein +FIG00566254 FIG00566261: hypothetical protein +FIG00566284 FIG00566287: hypothetical protein +FIG00566287 Peptidase M23B +FIG00566293 FIG00566294: hypothetical protein +FIG00566294 FIG00566300: hypothetical protein +FIG00566320 FIG00566328: hypothetical protein +FIG00566331 FIG00566333: hypothetical protein +FIG00566338 FIG00566340: hypothetical protein +FIG00566359 Tsl0919 protein +FIG00566360 FIG00566365: hypothetical protein +FIG00566365 FIG00566374: hypothetical protein +FIG00566374 Aspartoacylase (EC 3.5.1.15) +FIG00566399 FIG00566401: hypothetical protein +FIG00566423 FIG00566442: hypothetical protein +FIG00566445 FIG00566447: hypothetical protein +FIG00566449 melibiose carrier protein +FIG00566451 FIG00566452: hypothetical protein +FIG00566460 FIG00566462: hypothetical protein +FIG00566484 FIG00566487: hypothetical protein +FIG00566507 Exopolysaccharide synthesis, ExoD +FIG00566541 FIG00566544: hypothetical protein +FIG00566558 FIG00566565: hypothetical protein +FIG00566570 FIG00566575: hypothetical protein +FIG00566575 FIG00566576: hypothetical protein +FIG00566576 FIG00566577: hypothetical protein +FIG00566587 FIG00566588: hypothetical protein +FIG00566588 FIG00566595: hypothetical protein +FIG00566598 FIG00566604: hypothetical protein +FIG00566607 FIG00566613: hypothetical protein +FIG00566613 FIG00873399: hypothetical protein +FIG00566615 FIG00566616: hypothetical protein +FIG00566616 FIG00566617: hypothetical protein +FIG00566639 Domain of unknown function DUF1537 +FIG00566646 FIG00566649: hypothetical protein +FIG00566649 Protein of unknown function DUF540 +FIG00566675 FIG00566678: hypothetical protein +FIG00566683 FIG00566687: hypothetical protein +FIG00566701 FIG00566715: hypothetical protein +FIG00566730 FIG00566735: hypothetical protein +FIG00566742 FIG00566743: hypothetical protein +FIG00566759 FIG00566765: hypothetical protein +FIG00566768 FIG00566769: hypothetical protein +FIG00566769 FIG00566772: hypothetical protein +FIG00566772 FIG00566775: hypothetical protein +FIG00566781 FIG00566785: hypothetical protein +FIG00566785 FIG00566808: hypothetical protein +FIG00566808 FIG00566812: hypothetical protein +FIG00566812 FIG00566813: hypothetical protein +FIG00566815 FIG00566817: hypothetical protein +FIG00566826 FIG00566827: hypothetical protein +FIG00566827 Multi-component Transcriptional regulator, Winged helix family +FIG00566828 FIG00566835: hypothetical protein +FIG00566835 FIG00566843: hypothetical protein +FIG00566843 FIG00566844: hypothetical protein +FIG00566853 FIG00566859: hypothetical protein +FIG00566868 FIG00566869: hypothetical protein +FIG00566869 FIG00566872: hypothetical protein +FIG00566872 FIG00566882: hypothetical protein +FIG00566882 FIG00566889: hypothetical protein +FIG00566889 Muramidase (phage lambda lysozyme) +FIG00566897 FIG00566901: hypothetical protein +FIG00566901 FIG00566906: hypothetical protein +FIG00566907 FIG00566910: hypothetical protein +FIG00566923 Pyridoxamine 5'-phosphate oxidase (EC 1.4.3.5) +FIG00566927 FIG00566929: hypothetical protein +FIG00566940 FIG00566946: hypothetical protein +FIG00566946 FIG00566950: hypothetical protein +FIG00566965 FIG00566966: hypothetical protein +FIG00566966 FIG00566968: hypothetical protein +FIG00566970 FIG00566978: hypothetical protein +FIG00566982 FIG00566989: hypothetical protein +FIG00566989 FIG00567000: hypothetical protein +FIG00567000 FIG00567005: hypothetical protein +FIG00567011 FIG00567012: hypothetical protein +FIG00567012 FIG00567014: hypothetical protein +FIG00567014 Sll1376 protein +FIG00567015 FIG00567023: hypothetical protein +FIG00567025 FIG00567030: hypothetical protein +FIG00567042 FIG00567049: hypothetical protein +FIG00567049 FIG00567052: hypothetical protein +FIG00567055 FIG00567071: hypothetical protein +FIG00567075 FIG00567076: hypothetical protein +FIG00567076 FIG00567077: hypothetical protein +FIG00567119 FIG00567120: hypothetical protein +FIG00567136 FIG00567140: hypothetical protein +FIG00567140 FIG00567142: hypothetical protein +FIG00567142 FIG00567147: hypothetical protein +FIG00567149 CemA-like protein sll1685 +FIG00567158 FIG00567161: hypothetical protein +FIG00567161 abhydrolase domain containing 14A-like +FIG00567163 FIG00567170: hypothetical protein +FIG00567170 S-adenosylmethionine synthetase( EC:2.5.1.6 ) +FIG00567209 FIG00567210: hypothetical protein +FIG00567212 FIG00567225: hypothetical protein +FIG00567262 FIG00567290: hypothetical protein +FIG00567290 FIG00567291: hypothetical protein +FIG00567291 FIG00567294: hypothetical protein +FIG00567295 FIG00567296: hypothetical protein +FIG00567328 FIG00567331: hypothetical protein +FIG00567353 FIG00567360: hypothetical protein +FIG00567360 FIG00567362: hypothetical protein +FIG00567362 FIG00567367: hypothetical protein +FIG00567367 CAB/ELIP/HLIP family protein +FIG00567374 FIG00567379: hypothetical protein +FIG00567379 FIG00567393: hypothetical protein +FIG00567393 FIG00567396: hypothetical protein +FIG00567396 FIG00567397: hypothetical protein +FIG00567397 FIG00567414: hypothetical protein +FIG00567414 FIG00567416: hypothetical protein +FIG00567421 FIG00567422: hypothetical protein +FIG00567424 FIG00567429: hypothetical protein +FIG00567429 FIG00567431: hypothetical protein +FIG00567431 Histidine Kinase +FIG00567433 FIG00567434: hypothetical protein +FIG00567434 FIG00567440: hypothetical protein +FIG00567440 FIG00567446: hypothetical protein +FIG00567449 sodium:alanine symporter +FIG00567468 FIG00567471: hypothetical protein +FIG00567481 FIG00567483: hypothetical protein +FIG00567499 FIG00567503: hypothetical protein +FIG00567517 FIG00567528: hypothetical protein +FIG00567532 FIG00567548: hypothetical protein +FIG00567548 FIG00567549: hypothetical protein +FIG00567571 FIG00567575: hypothetical protein +FIG00567575 FIG00567588: hypothetical protein +FIG00567588 Diflavin flavoprotein Sll0217 +FIG00567594 FIG00567595: hypothetical protein +FIG00567600 FIG00567605: hypothetical protein +FIG00567605 FIG00567607: hypothetical protein +FIG00567607 FIG00567609: hypothetical protein +FIG00567610 FIG00567621: hypothetical protein +FIG00567639 FIG00567641: hypothetical protein +FIG00567652 FIG00567655: hypothetical protein +FIG00567655 FIG00567661: hypothetical protein +FIG00567661 FIG00567662: hypothetical protein +FIG00567663 FIG00567666: hypothetical protein +FIG00567666 FIG00567670: hypothetical protein +FIG00567670 COG1176: ABC-type spermidine/putrescine transport system, permease component I +FIG00567682 FIG00567687: hypothetical protein +FIG00567720 FIG00567721: hypothetical protein +FIG00567721 FIG00567726: hypothetical protein +FIG00567726 FIG00567733: hypothetical protein +FIG00567734 FIG00567737: hypothetical protein +FIG00567737 FIG00567739: hypothetical protein +FIG00567743 FIG00567755: hypothetical protein +FIG00567755 FIG028593: membrane protein +FIG00567761 FIG00567764: hypothetical protein +FIG00567774 FIG00567782: hypothetical protein +FIG00567787 FIG00567792: hypothetical protein +FIG00567792 FIG00567793: hypothetical protein +FIG00567793 FIG00567794: hypothetical protein +FIG00567794 FIG00567798: hypothetical protein +FIG00567800 FIG00567802: hypothetical protein +FIG00567807 FIG00567815: hypothetical protein +FIG00567815 FIG00567821: hypothetical protein +FIG00567821 FIG00567830: hypothetical protein +FIG00567830 FIG00567835: hypothetical protein +FIG00567835 FIG00567836: hypothetical protein +FIG00567836 FIG00567838: hypothetical protein +FIG00567838 FIG00567852: hypothetical protein +FIG00567852 FIG00567853: hypothetical protein +FIG00567860 FIG00567863: hypothetical protein +FIG00567863 FIG00567867: hypothetical protein +FIG00567867 FIG00567876: hypothetical protein +FIG00567876 Na-Ca exchanger/integrin-beta4 +FIG00567897 FIG00567901: hypothetical protein +FIG00567901 FIG00567903: hypothetical protein +FIG00567903 FIG00567904: hypothetical protein +FIG00567904 FIG00567912: hypothetical protein +FIG00567914 FIG00567916: hypothetical protein +FIG00567916 FIG00567924: hypothetical protein +FIG00567940 FIG00567941: hypothetical protein +FIG00567952 FIG00567955: hypothetical protein +FIG00567955 Ribonuclease III domain protein +FIG00567970 Cyanobacterial SigF-related sigma factor +FIG00567974 FIG00567977: hypothetical protein +FIG00567978 Multiple antibiotic resistance (MarC)-related proteins +FIG00567985 FIG00567988: hypothetical protein +FIG00567988 FIG00567989: hypothetical protein +FIG00567989 FIG00567991: hypothetical protein +FIG00568003 FIG00568006: hypothetical protein +FIG00568012 chitooligosaccharide deacetylase +FIG00568017 FIG00568020: hypothetical protein +FIG00568030 FIG00568036: hypothetical protein +FIG00568036 FIG00568039: hypothetical protein +FIG00568039 FIG00568049: hypothetical protein +FIG00568058 FIG00568059: hypothetical protein +FIG00568059 FIG00568062: hypothetical protein +FIG00568062 FIG00568065: hypothetical protein +FIG00568070 FIG00568072: hypothetical protein +FIG00568072 FIG00568073: hypothetical protein +FIG00568074 FIG00568077: hypothetical protein +FIG00568084 FIG00568090: hypothetical protein +FIG00568090 FIG00568093: hypothetical protein +FIG00568093 Alpha-mannosidase +FIG00568099 FIG00568101: hypothetical protein +FIG00568103 Phytoene desaturase, neurosporene or lycopene producing (EC 1.3.-.-) +FIG00568108 FIG00568114: hypothetical protein +FIG00568114 TPR repeat:TPR repeat +FIG00568127 FIG00568129: hypothetical protein +FIG00568129 FIG00568143: hypothetical protein +FIG00568143 FIG00568153: hypothetical protein +FIG00568156 FIG00568159: hypothetical protein +FIG00568160 FIG00568162: hypothetical protein +FIG00568164 FIG00568172: hypothetical protein +FIG00568172 FIG00568176: hypothetical protein +FIG00568176 FIG00568191: hypothetical protein +FIG00568191 FIG00568195: hypothetical protein +FIG00568204 FIG00568217: hypothetical protein +FIG00568217 Serine/threonine-protein kinase F (EC 2.7.11.1) +FIG00568220 FIG00568221: hypothetical protein +FIG00568226 FIG00568229: hypothetical protein +FIG00568229 FIG00568232: hypothetical protein +FIG00568232 FIG00568236: hypothetical protein +FIG00568243 FIG00568252: hypothetical protein +FIG00568263 FIG00568279: hypothetical protein +FIG00568279 FIG00568283: hypothetical protein +FIG00568287 FIG00568288: hypothetical protein +FIG00568298 FIG00568300: hypothetical protein +FIG00568300 FIG00568303: hypothetical protein +FIG00568303 FIG00568304: hypothetical protein +FIG00568313 FIG00568315: hypothetical protein +FIG00568324 FIG00568325: hypothetical protein +FIG00568325 FIG00568328: hypothetical protein +FIG00568330 FIG00568339: hypothetical protein +FIG00568363 FIG00568365: hypothetical protein +FIG00568365 FIG00568372: hypothetical protein +FIG00568398 FIG00568403: hypothetical protein +FIG00568404 FIG00568407: hypothetical protein +FIG00568407 FIG00568409: hypothetical protein +FIG00568438 FIG00568440: hypothetical protein +FIG00568442 Lycopene cyclase, CruP type +FIG00568462 FIG00568464: hypothetical protein +FIG00568510 FIG00568511: hypothetical protein +FIG00568511 FIG00568514: hypothetical protein +FIG00568520 FIG00568524: hypothetical protein +FIG00568540 FIG00568542: hypothetical protein +FIG00568549 FIG00568560: hypothetical protein +FIG00568560 FIG00568567: hypothetical protein +FIG00568567 Ethylene receptor (EC 2.7.3.-) +FIG00568586 Tic22-like +FIG00568588 FIG00568598: hypothetical protein +FIG00568598 Protein often near L-alanine-DL-glutamate epimerase (cell wall recycling) +FIG00568599 Sll0423 protein +FIG00568603 FIG00568606: hypothetical protein +FIG00568609 FIG00568618: hypothetical protein +FIG00568618 FIG00568638: hypothetical protein +FIG00568640 FIG00568641: hypothetical protein +FIG00568661 FIG00568666: hypothetical protein +FIG00568666 FIG00568669: hypothetical protein +FIG00568669 FIG00568672: hypothetical protein +FIG00568698 FIG00568700: hypothetical protein +FIG00568700 FIG00568703: hypothetical protein +FIG00568703 FIG00568717: hypothetical protein +FIG00568735 FIG00568740: hypothetical protein +FIG00568751 FIG00568752: hypothetical protein +FIG00568752 FIG00568753: hypothetical protein +FIG00568753 FIG00568754: hypothetical protein +FIG00568756 FIG00568757: hypothetical protein +FIG00568781 Gll0553 protein +FIG00568782 FIG00568784: hypothetical protein +FIG00568786 FIG00568788: hypothetical protein +FIG00568796 FIG00568797: hypothetical protein +FIG00568797 COG3037: Uncharacterized protein conserved in bacteria +FIG00568822 FIG00568828: hypothetical protein +FIG00568832 FIG00568834: hypothetical protein +FIG00568839 FIG00568840: hypothetical protein +FIG00568844 FIG00568851: hypothetical protein +FIG00568858 FIG00568860: hypothetical protein +FIG00568860 FIG00568867: hypothetical protein +FIG00568875 FIG00568878: hypothetical protein +FIG00568878 FIG00568879: hypothetical protein +FIG00568879 FIG00568888: hypothetical protein +FIG00568888 FIG00568889: hypothetical protein +FIG00568889 FIG00568902: hypothetical protein +FIG00568902 FIG00568908: hypothetical protein +FIG00568914 FIG00568915: hypothetical protein +FIG00568915 FIG00568916: hypothetical protein +FIG00568916 FIG00568925: hypothetical protein +FIG00568925 Gll0426 protein +FIG00568938 FIG00568946: hypothetical protein +FIG00568946 FIG00568947: hypothetical protein +FIG00568947 FIG00568952: hypothetical protein +FIG00568952 glutathione S-transferase +FIG00568965 putative invertase +FIG00568969 FIG00568970: hypothetical protein +FIG00568970 FIG00568972: hypothetical protein +FIG00568988 FIG00568991: hypothetical protein +FIG00568991 FIG00568993: hypothetical protein +FIG00568999 FIG00569007: hypothetical protein +FIG00569007 FIG00569012: hypothetical protein +FIG00569012 FIG00569014: hypothetical protein +FIG00569017 Protein of unknown function DUF820 +FIG00569027 FIG00569029: hypothetical protein +FIG00569035 FIG00569043: hypothetical protein +FIG00569043 mutator protein +FIG00569061 FIG00569073: hypothetical protein +FIG00569117 FIG00569119: hypothetical protein +FIG00569124 FIG00569125: hypothetical protein +FIG00569125 FIG00569130: hypothetical protein +FIG00569130 FIG00569141: hypothetical protein +FIG00569147 FIG00569148: hypothetical protein +FIG00569165 FIG00569166: hypothetical protein +FIG00569180 FIG00569181: hypothetical protein +FIG00569181 FIG00569188: hypothetical protein +FIG00569188 FIG00569191: hypothetical protein +FIG00569193 FIG00569194: hypothetical protein +FIG00569203 FIG00569205: hypothetical protein +FIG00569213 FIG01150086: hypothetical protein +FIG00569219 FIG00569247: hypothetical protein +FIG00569247 FIG00569248: hypothetical protein +FIG00569248 FIG00569249: hypothetical protein +FIG00569258 FIG00569263: hypothetical protein +FIG00569263 FIG00569264: hypothetical protein +FIG00569264 FIG00569265: hypothetical protein +FIG00569268 FIG00569280: hypothetical protein +FIG00569294 FIG00569309: hypothetical protein +FIG00569309 FIG00569315: hypothetical protein +FIG00569315 FIG00569322: hypothetical protein +FIG00569322 FIG00569324: hypothetical protein +FIG00569324 FIG00569328: hypothetical protein +FIG00569356 FIG00569369: hypothetical protein +FIG00569369 4-amino, 4-deoxychorismate mutase (EC 5.4.99.-) +FIG00569383 FIG00569391: hypothetical protein +FIG00569391 FIG00569409: hypothetical protein +FIG00569409 chorismate mutase/prephenate dehydrogenase +FIG00569410 FIG00569413: hypothetical protein +FIG00569413 FIG00569420: hypothetical protein +FIG00569433 FIG00569434: hypothetical protein +FIG00569434 FIG00569442: hypothetical protein +FIG00569447 FIG00569454: hypothetical protein +FIG00569454 FIG00569455: hypothetical protein +FIG00569458 FIG00569459: hypothetical protein +FIG00569471 ATPase, E1-E2 type +FIG00569499 FIG00569502: hypothetical protein +FIG00569559 two-component hybrid sensor & regulator +FIG00569563 FIG00569567: hypothetical protein +FIG00569567 FIG00569570: hypothetical protein +FIG00569572 Cleavage and polyadenylation specificity factor, 73 kDa subunit +FIG00569581 FIG00569582: hypothetical protein +FIG00569582 FIG00569597: hypothetical protein +FIG00569597 Photosystem II protein Y +FIG00569600 keto-hydroxyglutarate-aldolase/keto-deoxy- phosphogluconate aldolase( EC:4.1.2.14 ) +FIG00569602 Mo-dependent nitrogenase, C-terminal +FIG00569605 FIG00569607: hypothetical protein +FIG00569610 FIG00569619: hypothetical protein +FIG00569619 FIG00569621: hypothetical protein +FIG00569632 FIG00569635: hypothetical protein +FIG00569650 FIG00569656: hypothetical protein +FIG00569657 FIG00569667: hypothetical protein +FIG00569691 FIG00569695: hypothetical protein +FIG00569695 FIG00569697: hypothetical protein +FIG00569699 FIG00569701: hypothetical protein +FIG00569718 Circadian oscillation regulator KaiB +FIG00569720 FIG00569722: hypothetical protein +FIG00569733 COG0330: Membrane protease subunits, stomatin/prohibitin homologs +FIG00569734 FIG00569748: hypothetical protein +FIG00569766 FIG00569769: hypothetical protein +FIG00569769 FIG00569770: hypothetical protein +FIG00569791 FIG00569796: hypothetical protein +FIG00569842 FIG00569844: hypothetical protein +FIG00569855 FIG00569858: hypothetical protein +FIG00569864 FIG00569867: hypothetical protein +FIG00569867 FIG00569884: hypothetical protein +FIG00569890 similar to ATPase (AAA+ superfamily) +FIG00569897 FIG00569900: hypothetical protein +FIG00569900 FIG00569902: hypothetical protein +FIG00569903 Protein of unknown function DUF393 +FIG00569913 FIG00569925: hypothetical protein +FIG00569932 FIG00569939: hypothetical protein +FIG00569947 FIG00569966: hypothetical protein +FIG00569978 stress induced hydrophobic peptide +FIG00569982 WD-40 repeat protein +FIG00569995 FIG00569997: hypothetical protein +FIG00570016 FIG00570018: hypothetical protein +FIG00570019 FIG00570023: hypothetical protein +FIG00570033 FIG00570036: hypothetical protein +FIG00570049 Caspase-1, p20 +FIG00570066 FIG00570069: hypothetical protein +FIG00570069 FIG00570070: hypothetical protein +FIG00570071 FIG00570072: hypothetical protein +FIG00570076 FIG00570078: hypothetical protein +FIG00570080 FIG00570083: hypothetical protein +FIG00570121 FIG00570122: hypothetical protein +FIG00570129 FIG00570132: hypothetical protein +FIG00570154 putative potassium-efflux system protein +FIG00570155 hypothetical ATP-binding protein +FIG00570180 COG0071: Molecular chaperone (small heat shock protein) +FIG00570194 FIG00570196: hypothetical protein +FIG00570196 FIG00570204: hypothetical protein +FIG00570204 FIG00570205: hypothetical protein +FIG00570205 Modification methylase XorII (EC 2.1.1.37) +FIG00570214 FIG00570224: hypothetical protein +FIG00570226 FIG00570231: hypothetical protein +FIG00570231 probable serine/threonine kinase +FIG00570238 FIG00570239: hypothetical protein +FIG00570256 FIG00570258: hypothetical protein +FIG00570263 FIG00570264: hypothetical protein +FIG00570268 FIG00570270: hypothetical protein +FIG00570298 FIG00570313: hypothetical protein +FIG00570319 FIG00570320: hypothetical protein +FIG00570320 FIG00570322: hypothetical protein +FIG00570322 FIG00570327: hypothetical protein +FIG00570328 FIG00570332: hypothetical protein +FIG00570332 Type IV pilus biogenesis protein PilN +FIG00570341 FIG00570348: hypothetical protein +FIG00570356 FIG00570375: hypothetical protein +FIG00570375 FIG00570378: hypothetical protein +FIG00570388 FIG00570396: hypothetical protein +FIG00570402 FIG00570410: hypothetical protein +FIG00570410 FIG00570416: hypothetical protein +FIG00570431 FIG00570432: hypothetical protein +FIG00570432 FIG00570438: hypothetical protein +FIG00570455 FIG00570456: hypothetical protein +FIG00570466 FIG00570471: hypothetical protein +FIG00570481 COG2203: FOG: GAF domain +FIG00570487 FIG00570496: hypothetical protein +FIG00570513 FIG00570519: hypothetical protein +FIG00570523 FIG00570527: hypothetical protein +FIG00570543 FIG00570548: hypothetical protein +FIG00570574 FIG00570579: hypothetical protein +FIG00570579 FIG00570582: hypothetical protein +FIG00570586 FIG00570591: hypothetical protein +FIG00570594 FIG00570595: hypothetical protein +FIG00570599 FIG00570603: hypothetical protein +FIG00570603 FIG00570605: hypothetical protein +FIG00570614 peptide chain release factor 3 +FIG00570624 FIG00570627: hypothetical protein +FIG00570627 FIG00570628: hypothetical protein +FIG00570652 FIG00570661: hypothetical protein +FIG00570681 Signal peptide peptidase SppA (Protease IV) (EC 3.4.21.-) +FIG00570684 FIG00570687: hypothetical protein +FIG00570769 FIG00570772: hypothetical protein +FIG00570772 FIG00570776: hypothetical protein +FIG00570776 FIG00570777: hypothetical protein +FIG00570791 FIG00570792: hypothetical protein +FIG00570795 FIG00570803: hypothetical protein +FIG00570803 FIG00570808: hypothetical protein +FIG00570835 FIG00570837: hypothetical protein +FIG00570837 FIG00570857: hypothetical protein +FIG00570886 FIG00570889: hypothetical protein +FIG00570889 FIG00570893: hypothetical protein +FIG00570911 thiol:disulfide interchange protein; TrxA +FIG00570915 FIG00570917: hypothetical protein +FIG00570917 FIG00570918: hypothetical protein +FIG00570918 FIG00570919: hypothetical protein +FIG00570941 FIG00570943: hypothetical protein +FIG00570979 Histidine kinase A, N-terminal +FIG00570985 FIG00570987: hypothetical protein +FIG00570987 FIG00570998: hypothetical protein +FIG00570998 FIG00570999: hypothetical protein +FIG00571007 FIG00571019: hypothetical protein +FIG00571028 FIG00571030: hypothetical protein +FIG00571030 FIG00571046: hypothetical protein +FIG00571046 FIG00571063: hypothetical protein +FIG00571065 FIG00571072: hypothetical protein +FIG00571085 FIG00571092: hypothetical protein +FIG00571092 FIG00571095: hypothetical protein +FIG00571139 FIG00571143: hypothetical protein +FIG00571143 FIG00571144: hypothetical protein +FIG00571147 FIG00571151: hypothetical protein +FIG00571194 FIG00571195: hypothetical protein +FIG00571216 FIG00571219: hypothetical protein +FIG00571239 FIG00571246: hypothetical protein +FIG00571256 FIG00571262: hypothetical protein +FIG00571287 FIG00571296: hypothetical protein +FIG00571301 FtsZ like protein I1 +FIG00571326 FIG00571329: hypothetical protein +FIG00571336 FIG00571364: hypothetical protein +FIG00571364 FIG00571366: hypothetical protein +FIG00571377 Serine-rich protein +FIG00571380 FIG00571407: hypothetical protein +FIG00571407 FIG00571423: hypothetical protein +FIG00571423 exopolysaccharide synthesis protein +FIG00571427 COG4294: UV damage repair endonuclease +FIG00571448 FIG00571465: hypothetical protein +FIG00571470 FIG00571479: hypothetical protein +FIG00571479 FIG00571482: hypothetical protein +FIG00571482 FIG00571484: hypothetical protein +FIG00571534 FIG00571535: hypothetical protein +FIG00571535 FIG00571552: hypothetical protein +FIG00571613 FIG00571625: hypothetical protein +FIG00571641 FIG00571643: hypothetical protein +FIG00571648 FIG00571666: hypothetical protein +FIG00571711 FIG00571715: hypothetical protein +FIG00571739 FIG00571746: hypothetical protein +FIG00571753 FIG00571755: hypothetical protein +FIG00571755 Protein of unknown function DUF187 +FIG00571757 FIG00571762: hypothetical protein +FIG00571772 FIG00571774: hypothetical protein +FIG00571832 FIG00571841: hypothetical protein +FIG00571848 FIG00571856: hypothetical protein +FIG00571871 Ferredoxin--NADP(+) reductase (EC 1.18.1.2) +FIG00571883 FIG00571885: hypothetical protein +FIG00571891 FIG00571894: hypothetical protein +FIG00571949 FIG00571954: hypothetical protein +FIG00572004 FIG00572014: hypothetical protein +FIG00572074 FIG00572089: hypothetical protein +FIG00572092 FIG00572103: hypothetical protein +FIG00572150 FIG00572151: hypothetical protein +FIG00572190 FIG00572194: hypothetical protein +FIG00572215 FIG00572217: hypothetical protein +FIG00572228 Serine/threonine-protein kinase pknA (EC 2.7.11.1) +FIG00572229 probable glucosyltransferase EpsE homolog +FIG00572238 Protein-tyrosine sulfotransferase 1 (EC 2.8.2.20) +FIG00572249 FIG00572271: hypothetical protein +FIG00572318 FIG00572326: hypothetical protein +FIG00572337 Precorrin-3B methylase +FIG00572375 FIG00572386: hypothetical protein +FIG00572419 FIG00572425: hypothetical protein +FIG00572425 HAD-superfamily hydrolase, subfamily IIIA:HAD superfamily (subfamily IIIA) phosphatase +FIG00572436 FIG00572440: hypothetical protein +FIG00572440 FIG00572444: hypothetical protein +FIG00572444 FIG00572459: hypothetical protein +FIG00572459 FIG00572486: hypothetical protein +FIG00572486 FIG00572487: hypothetical protein +FIG00572566 FIG00572567: hypothetical protein +FIG00572571 FIG00572572: hypothetical protein +FIG00572608 Predicted BioA alternative protein +FIG00572666 FIG00572669: hypothetical protein +FIG00572823 FIG00572829: hypothetical protein +FIG00572850 FIG00572861: hypothetical protein +FIG00572889 FIG00572892: hypothetical protein +FIG00572913 FIG00648977: hypothetical protein +FIG00572985 FIG00572986: hypothetical protein +FIG00573034 FIG00573035: hypothetical protein +FIG00573083 FIG00573088: hypothetical protein +FIG00573169 FIG00573176: hypothetical protein +FIG00573185 FIG00573188: hypothetical protein +FIG00573345 Probable alkylhalidase homolog (EC 3.8.1.1) +FIG00573352 FIG00573359: hypothetical protein +FIG00573372 FIG00573375: hypothetical protein +FIG00573413 Na+/H+-exchanging protein (Na+/H+ antiporter) +FIG00573443 FIG00573444: hypothetical protein +FIG00573444 polysaccharide-forming b-glycosyltransferase-related protein, glycosyltransferase family 2 protein +FIG00573717 FIG00573718: hypothetical protein +FIG00573722 FIG00573728: hypothetical protein +FIG00573734 FIG00573738: hypothetical protein +FIG00573763 SAM-dependent methyltransferase +FIG00573906 FIG00573909: hypothetical protein +FIG00574040 Homolog of geranylgeranylglyceryl phosphate synthase +FIG00574125 gliding motility-related protein +FIG00574141 FIG00574142: hypothetical protein +FIG00574195 patatin-like protein +FIG00574234 FIG00649530: hypothetical protein +FIG00574326 Vitamin K-dependent gamma-carboxylase (EC 6.4.-.-) +FIG00574330 FIG00574338: hypothetical protein +FIG00574373 FIG00574377: hypothetical protein +FIG00574391 FIG00574401: hypothetical protein +FIG00574536 Endo-beta-1,3-glucanase +FIG00574629 FIG00574633: hypothetical protein +FIG00574637 FIG00574641: hypothetical protein +FIG00574649 possible Fe-S oxidoreductase, SAM radical superfamily +FIG00574780 FIG00574781: hypothetical protein +FIG00574807 FIG00574810: hypothetical protein +FIG00574921 FIG00574925: hypothetical protein +FIG00575000 FIG00575002: hypothetical protein +FIG00575045 FIG00575047: hypothetical protein +FIG00575071 FIG00575079: hypothetical protein +FIG00575176 FIG00575177: hypothetical protein +FIG00575183 FIG00732814: hypothetical protein +FIG00575225 FIG00575229: hypothetical protein +FIG00575232 FIG00575243: hypothetical protein +FIG00575397 FIG00575401: hypothetical protein +FIG00575557 FIG00453548: hypothetical protein +FIG00575668 FIG00575681: hypothetical protein +FIG00575700 FIG00575701: hypothetical protein +FIG00575719 Phospholipase D1 (EC 3.1.4.4) +FIG00575772 putative amino acids binding protein +FIG00575815 FIG00575819: hypothetical protein +FIG00575899 FIG00859406: hypothetical protein +FIG00575918 Sensor protein zraS (EC 2.7.3.-) +FIG00575947 FIG00575948: hypothetical protein +FIG00575971 FIG00575972: hypothetical protein +FIG00576045 putative regulatory protein, LysR +FIG00576224 FIG00433688: hypothetical protein +FIG00576225 FIG00576227: hypothetical protein +FIG00576298 putative cox2 cytochrome oxidase subunit 2 +FIG00576349 FIG00576351: hypothetical protein +FIG00576363 FIG00576366: hypothetical protein +FIG00576384 FIG00576391: hypothetical protein +FIG00576583 FIG00576584: hypothetical protein +FIG00576606 Nucleotidyltransferase, putative +FIG00576642 FIG00576644: hypothetical protein +FIG00576672 sigma-54 dependent transcriptional regulator +FIG00576678 FIG00576679: hypothetical protein +FIG00576679 FIG00576681: hypothetical protein +FIG00576738 FIG00576739: hypothetical protein +FIG00576740 FIG00576741: hypothetical protein +FIG00576741 FIG00576743: hypothetical protein +FIG00576743 FIG00576744: hypothetical protein +FIG00576744 FIG00576745: hypothetical protein +FIG00576745 FIG00576747: hypothetical protein +FIG00576747 iron-sulfur cluster-binding protein, Rieske family +FIG00576748 FIG00576749: hypothetical protein +FIG00576749 Alr3900 protein +FIG00576750 FIG00576751: hypothetical protein +FIG00576751 FIG00576752: hypothetical protein +FIG00576753 FIG00576754: hypothetical protein +FIG00576754 FIG00576755: hypothetical protein +FIG00576757 FIG00576758: hypothetical protein +FIG00576758 FIG00576759: hypothetical protein +FIG00576759 FIG00576760: hypothetical protein +FIG00576762 FIG00576765: hypothetical protein +FIG00576765 FIG00576766: hypothetical protein +FIG00576767 FIG00576768: hypothetical protein +FIG00576768 FIG00576769: hypothetical protein +FIG00576769 FIG00576770: hypothetical protein +FIG00576770 FIG00576771: hypothetical protein +FIG00576771 FIG00576773: hypothetical protein +FIG00576774 FIG00576775: hypothetical protein +FIG00576775 FIG00576776: hypothetical protein +FIG00576778 FIG00576779: hypothetical protein +FIG00576779 FIG00576780: hypothetical protein +FIG00576780 FIG00576782: hypothetical protein +FIG00576782 FIG00576784: hypothetical protein +FIG00576784 FIG00576785: hypothetical protein +FIG00576785 Carbon-nitrogen hydrolase family protein +FIG00576786 FIG00576787: hypothetical protein +FIG00576787 FIG00576788: hypothetical protein +FIG00576788 FIG00576789: hypothetical protein +FIG00576789 FIG00576790: hypothetical protein +FIG00576790 FIG00576793: hypothetical protein +FIG00576793 FIG00576794: hypothetical protein +FIG00576795 FIG00576796: hypothetical protein +FIG00576800 FIG00576801: hypothetical protein +FIG00576801 Twin-arginine translocation protein TatA +FIG00576803 FIG00576804: hypothetical protein +FIG00576804 FIG00576805: hypothetical protein +FIG00576805 FIG00576806: hypothetical protein +FIG00576806 FIG00576807: hypothetical protein +FIG00576807 FIG00576808: hypothetical protein +FIG00576808 FIG00576809: hypothetical protein +FIG00576811 FIG00576812: hypothetical protein +FIG00576814 FIG00576815: hypothetical protein +FIG00576815 FIG00576816: hypothetical protein +FIG00576816 FIG00576818: hypothetical protein +FIG00576818 FIG00576820: hypothetical protein +FIG00576820 FIG00576821: hypothetical protein +FIG00576821 FIG00576822: hypothetical protein +FIG00576822 FIG00576824: hypothetical protein +FIG00576828 FIG00576834: hypothetical protein +FIG00576834 FIG00576835: hypothetical protein +FIG00576837 FIG00576838: hypothetical protein +FIG00576838 quinone methlytransferase, UbiE family +FIG00576839 FIG00576840: hypothetical protein +FIG00576840 FIG00576841: hypothetical protein +FIG00576841 FIG00576842: hypothetical protein +FIG00576843 FIG00576844: hypothetical protein +FIG00576844 regulatory protein RecX (recX) +FIG00576847 Gll3031 protein +FIG00576848 FIG00576849: hypothetical protein +FIG00576849 Hydrogenase expression/formation factor related protein +FIG00576850 FIG00576851: hypothetical protein +FIG00576851 FIG00576854: hypothetical protein +FIG00576854 FIG00576856: hypothetical protein +FIG00576856 FIG00576857: hypothetical protein +FIG00576857 FIG00576859: hypothetical protein +FIG00576860 predicted metal-dependent hydrolase of the TIM-barrel fold +FIG00576861 FIG00576862: hypothetical protein +FIG00576862 FIG00576863: hypothetical protein +FIG00576864 FIG00576865: hypothetical protein +FIG00576871 general secretion family protein +FIG00576873 FIG00576875: hypothetical protein +FIG00576875 Mlr0554 protein +FIG00576876 FIG00576877: hypothetical protein +FIG00576877 FIG00576878: hypothetical protein +FIG00576878 FIG00576880: hypothetical protein +FIG00576881 FIG00576882: hypothetical protein +FIG00576882 FIG00576884: hypothetical protein +FIG00576885 FIG00576886: hypothetical protein +FIG00576887 FIG00576888: hypothetical protein +FIG00576890 FIG00576891: hypothetical protein +FIG00576895 FIG00576896: hypothetical protein +FIG00576896 SpoVT/AbrB domain protein +FIG00576897 FIG00576898: hypothetical protein +FIG00576900 FIG00576901: hypothetical protein +FIG00576903 FIG00576906: hypothetical protein +FIG00576906 FIG00576909: hypothetical protein +FIG00576909 FIG00576910: hypothetical protein +FIG00576910 MarR family transcriptional regulator MJ0558 +FIG00576915 FIG00576917: hypothetical protein +FIG00576919 FIG00576920: hypothetical protein +FIG00576927 FIG00576928: hypothetical protein +FIG00576928 FIG00576929: hypothetical protein +FIG00576929 FIG00576930: hypothetical protein +FIG00576930 FIG00576931: hypothetical protein +FIG00576931 FIG00576934: hypothetical protein +FIG00576935 FIG00576937: hypothetical protein +FIG00576940 FIG00576942: hypothetical protein +FIG00576943 FIG00576944: hypothetical protein +FIG00576946 FIG00576947: hypothetical protein +FIG00576947 FIG00576948: hypothetical protein +FIG00576950 FIG00576951: hypothetical protein +FIG00576958 FIG00576959: hypothetical protein +FIG00576967 FIG00576968: hypothetical protein +FIG00576968 FIG00576969: hypothetical protein +FIG00576969 FIG00576970: hypothetical protein +FIG00576970 FIG00576971: hypothetical protein +FIG00576971 FIG00576973: hypothetical protein +FIG00576973 FIG00576974: hypothetical protein +FIG00576974 FIG00576975: hypothetical protein +FIG00576975 FIG00576976: hypothetical protein +FIG00576977 FIG00576979: hypothetical protein +FIG00576979 Integral membrane protein 1906 +FIG00576980 FIG00576982: hypothetical protein +FIG00576982 FIG00576983: hypothetical protein +FIG00576983 FIG00576984: hypothetical protein +FIG00576985 FIG00576986: hypothetical protein +FIG00576986 FIG00576987: hypothetical protein +FIG00576987 FIG00576988: hypothetical protein +FIG00576988 FIG00576991: hypothetical protein +FIG00576991 FIG00576992: hypothetical protein +FIG00576992 FIG00576994: hypothetical protein +FIG00576996 ABC-transporter, ATPase and permease component +FIG00576998 FIG00577000: hypothetical protein +FIG00577000 FIG00577001: hypothetical protein +FIG00577001 FIG00577002: hypothetical protein +FIG00577005 FIG00577006: hypothetical protein +FIG00577006 FIG00577008: hypothetical protein +FIG00577012 FIG00577014: hypothetical protein +FIG00577014 FIG00577016: hypothetical protein +FIG00577016 FIG00577017: hypothetical protein +FIG00577017 competence protein ComEA, putative +FIG00577022 FIG00577024: hypothetical protein +FIG00577024 FIG00577025: hypothetical protein +FIG00577028 FIG00577029: hypothetical protein +FIG00577029 FIG00577031: hypothetical protein +FIG00577032 FIG00577033: hypothetical protein +FIG00577033 FIG00577034: hypothetical protein +FIG00577035 FIG00577036: hypothetical protein +FIG00577036 FIG00577040: hypothetical protein +FIG00577040 ATP-binding transport protein +FIG00577041 FIG00577044: hypothetical protein +FIG00577050 FIG00577053: hypothetical protein +FIG00577054 FIG00577055: hypothetical protein +FIG00577056 ATP-dependent RNA helicase, DEAD-DEAH box family +FIG00577061 FIG00577064: hypothetical protein +FIG00577064 FIG00577065: hypothetical protein +FIG00577065 FIG00577066: hypothetical protein +FIG00577069 FIG00577071: hypothetical protein +FIG00577071 FIG00577073: hypothetical protein +FIG00577073 FIG00577076: hypothetical protein +FIG00577078 FIG00577079: hypothetical protein +FIG00577079 FIG00577080: hypothetical protein +FIG00577082 FIG00577084: hypothetical protein +FIG00577084 cvpA family protein +FIG00577085 Alr1903 protein +FIG00577086 FIG00577087: hypothetical protein +FIG00577087 FIG00577089: hypothetical protein +FIG00577089 FIG00577090: hypothetical protein +FIG00577090 FIG00577093: hypothetical protein +FIG00577095 Efflux pump antibiotic resistance protein +FIG00577096 FIG00577097: hypothetical protein +FIG00577097 FIG00577100: hypothetical protein +FIG00577102 FIG00577103: hypothetical protein +FIG00577103 FIG00577104: hypothetical protein +FIG00577106 FIG00577107: hypothetical protein +FIG00577107 FIG00577108: hypothetical protein +FIG00577108 FIG00577110: hypothetical protein +FIG00577110 FIG00577111: hypothetical protein +FIG00577112 FIG00577113: hypothetical protein +FIG00577114 daunorubicin resistance ABC transporter, ATP-binding protein, putative +FIG00577115 FIG00577116: hypothetical protein +FIG00577121 Mannosyl-3-phosphoglycerate synthase (EC 2.4.1.217) / Mannosyl-3-phosphoglycerate phosphatase (EC 3.1.3.70) +FIG00577127 FIG00577128: hypothetical protein +FIG00577128 FIG00577130: hypothetical protein +FIG00577130 FIG00577131: hypothetical protein +FIG00577132 FIG00577134: hypothetical protein +FIG00577134 FIG00577135: hypothetical protein +FIG00577135 FIG00577136: hypothetical protein +FIG00577136 FIG00577138: hypothetical protein +FIG00577138 FIG00577139: hypothetical protein +FIG00577139 Adenosylcobinamide amidohydrolase (EC 3.5.1.90) +FIG00577142 FIG00577143: hypothetical protein +FIG00577144 FIG00577146: hypothetical protein +FIG00577147 FIG00577152: hypothetical protein +FIG00577152 glycosyl transferase-polysaccharide deacetylase family protein +FIG00577156 FIG00577158: hypothetical protein +FIG00577159 FIG00577162: hypothetical protein +FIG00577162 FIG00577166: hypothetical protein +FIG00577169 FIG00577170: hypothetical protein +FIG00577171 sensory box sensor histidine kinase-response regulator +FIG00577172 FIG00577173: hypothetical protein +FIG00577174 FIG00577176: hypothetical protein +FIG00577176 FIG00577177: hypothetical protein +FIG00577177 FIG00577180: hypothetical protein +FIG00577180 Molybdopterin oxidoreductase iron-sulfur binding subunit +FIG00577184 FIG00577185: hypothetical protein +FIG00577185 FIG00577186: hypothetical protein +FIG00577186 Integral membrane protein of the MarC family +FIG00577188 Adenosylcobinamide amidohydrolase (EC 3.5.1.90) +FIG00577189 FIG00577190: hypothetical protein +FIG00577191 Alr4787 protein +FIG00577192 FIG00577193: hypothetical protein +FIG00577193 FIG00577194: hypothetical protein +FIG00577194 COG1872 +FIG00577195 FIG00577199: hypothetical protein +FIG00577200 FIG00577201: hypothetical protein +FIG00577201 translin family protein +FIG00577205 FIG00577206: hypothetical protein +FIG00577206 FIG00577207: hypothetical protein +FIG00577208 FIG00577209: hypothetical protein +FIG00577209 FIG00577210: hypothetical protein +FIG00577210 FIG00577211: hypothetical protein +FIG00577211 FIG00577212: hypothetical protein +FIG00577212 FIG00577214: hypothetical protein +FIG00577217 FIG00577219: hypothetical protein +FIG00577219 FIG00577220: hypothetical protein +FIG00577230 YaaH protein +FIG00577231 FIG00577233: hypothetical protein +FIG00577233 FIG00577235: hypothetical protein +FIG00577242 FIG00577243: hypothetical protein +FIG00577243 FIG00577245: hypothetical protein +FIG00577245 FIG00577246: hypothetical protein +FIG00577246 FIG00577248: hypothetical protein +FIG00577249 FIG00577250: hypothetical protein +FIG00577251 domain of unknown function / Methylthioribose-1-phosphate isomerase (EC 5.3.1.23) +FIG00577261 FIG00577264: hypothetical protein +FIG00577264 FIG00577266: hypothetical protein +FIG00577266 LemA family domain protein +FIG00577271 FIG00577272: hypothetical protein +FIG00577272 FIG00577273: hypothetical protein +FIG00577275 bacterioferritin domain protein +FIG00577280 FIG00577283: hypothetical protein +FIG00577283 FIG00577285: hypothetical protein +FIG00577286 FIG00577287: hypothetical protein +FIG00577293 protease family protein +FIG00577294 FIG00577296: hypothetical protein +FIG00577299 FIG00577301: hypothetical protein +FIG00577303 FIG00577304: hypothetical protein +FIG00577304 FIG00577307: hypothetical protein +FIG00577307 FIG00577308: hypothetical protein +FIG00577310 DNA invertase/resolvase family protein +FIG00577317 FIG00577318: hypothetical protein +FIG00577318 FIG00577319: hypothetical protein +FIG00577319 FIG00577320: hypothetical protein +FIG00577320 FIG00577321: hypothetical protein +FIG00577321 FIG00577322: hypothetical protein +FIG00577322 FIG00577325: hypothetical protein +FIG00577325 FIG00577326: hypothetical protein +FIG00577328 FIG00577331: hypothetical protein +FIG00577334 Geranylgeranyl hydrogenase +FIG00577335 FIG00577336: hypothetical protein +FIG00577336 FIG00577337: hypothetical protein +FIG00577338 FIG00577339: hypothetical protein +FIG00577339 Bona fide RidA/YjgF/TdcF/RutC subgroup +FIG00577343 FIG00577345: hypothetical protein +FIG00577346 FIG00577349: hypothetical protein +FIG00577350 MutS2 protein +FIG00577354 FIG00577356: hypothetical protein +FIG00577356 glycosyl hydrolase domain protein +FIG00577357 FIG00577359: hypothetical protein +FIG00577359 FIG00577360: hypothetical protein +FIG00577360 virulence-related protein +FIG00577363 FIG00577364: hypothetical protein +FIG00577366 fasciclin domain protein +FIG00577369 FIG00577371: hypothetical protein +FIG00577371 FIG00577375: hypothetical protein +FIG00577375 FIG00577376: hypothetical protein +FIG00577376 FIG00577377: hypothetical protein +FIG00577377 FIG00577378: hypothetical protein +FIG00577378 FIG00577382: hypothetical protein +FIG00577389 FIG00577391: hypothetical protein +FIG00577391 FIG00577393: hypothetical protein +FIG00577393 FIG00577394: hypothetical protein +FIG00577395 FIG00577396: hypothetical protein +FIG00577396 FIG00577398: hypothetical protein +FIG00577399 FIG00577404: hypothetical protein +FIG00577404 FIG00577406: hypothetical protein +FIG00577406 transcription regulator, TetR family +FIG00577407 FIG00577408: hypothetical protein +FIG00577408 FIG00577410: hypothetical protein +FIG00577412 Molybdopterin oxidoreductase membrane subunit +FIG00577422 FIG00577425: hypothetical protein +FIG00577425 FIG00577426: hypothetical protein +FIG00577435 FIG00577437: hypothetical protein +FIG00577437 FIG00577438: hypothetical protein +FIG00577439 FIG00577442: hypothetical protein +FIG00577442 amino acid ABC transporter, permease protein, His-Glu-Gln-Arg-opine family +FIG00577443 FIG00577444: hypothetical protein +FIG00577457 FIG00577458: hypothetical protein +FIG00577458 FIG00577459: hypothetical protein +FIG00577459 FIG00577464: hypothetical protein +FIG00577464 FIG00577468: hypothetical protein +FIG00577468 FIG00577470: hypothetical protein +FIG00577475 FIG00577476: hypothetical protein +FIG00577476 FIG00577478: hypothetical protein +FIG00577481 FIG00577484: hypothetical protein +FIG00577484 FIG00577489: hypothetical protein +FIG00577491 FIG00577492: hypothetical protein +FIG00577492 FIG00577493: hypothetical protein +FIG00577496 FIG00577497: hypothetical protein +FIG00577497 FIG00577501: hypothetical protein +FIG00577549 FIG00577550: hypothetical protein +FIG00577551 FIG00577556: hypothetical protein +FIG00577557 FIG00577560: hypothetical protein +FIG00577561 FIG00577564: hypothetical protein +FIG00577601 FIG00577603: hypothetical protein +FIG00577618 Oligoendopeptidase F (EC 3.4.24.-) +FIG00577623 FIG00577624: hypothetical protein +FIG00577624 FIG00577626: hypothetical protein +FIG00577626 FIG00577628: hypothetical protein +FIG00577637 FIG00577640: hypothetical protein +FIG00577640 FIG00577642: hypothetical protein +FIG00577649 FIG00577650: hypothetical protein +FIG00577660 FIG00577663: hypothetical protein +FIG00577678 FIG00577684: hypothetical protein +FIG00577684 FIG00577685: hypothetical protein +FIG00577687 FIG00577688: hypothetical protein +FIG00577694 FIG00577695: hypothetical protein +FIG00577703 FIG00577704: hypothetical protein +FIG00577709 peptide ABC transporter, permease protein +FIG00577710 AlgP-related protein +FIG00577719 FIG00577724: hypothetical protein +FIG00577730 FIG00577731: hypothetical protein +FIG00577739 FIG00577742: hypothetical protein +FIG00577748 ribosomal protein N-acetyltransferase, putative +FIG00577754 FIG00577758: hypothetical protein +FIG00577779 FIG00577781: hypothetical protein +FIG00577786 FIG00577789: hypothetical protein +FIG00577789 FIG00577793: hypothetical protein +FIG00577796 putative, Molybdenum cofactor biosynthesis protein C +FIG00577801 FIG00577802: hypothetical protein +FIG00577812 FIG00577813: hypothetical protein +FIG00577814 FIG00577815: hypothetical protein +FIG00577816 FIG00577821: hypothetical protein +FIG00577824 FIG00577826: hypothetical protein +FIG00577839 UV-endonuclease UvdE +FIG00577842 FIG00577843: hypothetical protein +FIG00577853 FIG00577855: hypothetical protein +FIG00577895 FIG00577898: hypothetical protein +FIG00577900 FIG00577903: hypothetical protein +FIG00577903 FIG00577910: hypothetical protein +FIG00577910 FIG00577911: hypothetical protein +FIG00577911 FIG00577915: hypothetical protein +FIG00577915 FIG00577917: hypothetical protein +FIG00577931 FIG00577933: hypothetical protein +FIG00577936 5,10-methylenetetrahydrofolate reductase-related protein +FIG00577944 FIG00577945: hypothetical protein +FIG00577949 FIG00577950: hypothetical protein +FIG00577952 Cell wall synthesis protein +FIG00577961 FIG00577962: hypothetical protein +FIG00577983 FIG00577987: hypothetical protein +FIG00577991 FIG00577993: hypothetical protein +FIG00578022 FIG00578025: hypothetical protein +FIG00578029 FIG00578034: hypothetical protein +FIG00578034 FIG00578040: hypothetical protein +FIG00578040 FIG00578041: hypothetical protein +FIG00578049 FIG00578050: hypothetical protein +FIG00578054 FIG00578055: hypothetical protein +FIG00578060 FIG00578062: hypothetical protein +FIG00578066 molybdate metabolism regulator-related protein +FIG00578110 FIG00578111: hypothetical protein +FIG00578121 FIG00578122: hypothetical protein +FIG00578138 FIG00578139: hypothetical protein +FIG00578139 FIG00578141: hypothetical protein +FIG00578152 FIG00578155: hypothetical protein +FIG00578161 FIG00578162: hypothetical protein +FIG00578163 FIG00578164: hypothetical protein +FIG00578164 FIG00578166: hypothetical protein +FIG00578168 FIG00578171: hypothetical protein +FIG00578171 FIG00578172: hypothetical protein +FIG00578172 FIG00578173: hypothetical protein +FIG00578184 FIG00578185: hypothetical protein +FIG00578188 FIG00578192: hypothetical protein +FIG00578258 FIG00578260: hypothetical protein +FIG00578260 FIG00578263: hypothetical protein +FIG00578277 FIG00578278: hypothetical protein +FIG00578278 FIG00578281: hypothetical protein +FIG00578287 cytochrome complex Fe-S subunit, putative +FIG00578288 FIG00578289: hypothetical protein +FIG00578299 FIG00578301: hypothetical protein +FIG00578305 FIG00578306: hypothetical protein +FIG00578308 FIG00578310: hypothetical protein +FIG00578313 FIG00578314: hypothetical protein +FIG00578336 FIG00578337: hypothetical protein +FIG00578341 FIG00578346: hypothetical protein +FIG00578346 Epoxyqueuosine (oQ) reductase QueG +FIG00578348 FIG00578349: hypothetical protein +FIG00578350 type III restriction system endonuclease, putative +FIG00578355 FIG00578356: hypothetical protein +FIG00578356 FIG00578359: hypothetical protein +FIG00578370 FIG00578371: hypothetical protein +FIG00578381 cationic outer membrane protein OmpH, putative +FIG00578383 FIG00578384: hypothetical protein +FIG00578391 FIG00578392: hypothetical protein +FIG00578395 FIG00578401: hypothetical protein +FIG00578407 FIG00578411: hypothetical protein +FIG00578411 FIG00578412: hypothetical protein +FIG00578415 FIG00578416: hypothetical protein +FIG00578416 FIG00578417: hypothetical protein +FIG00578423 FIG00578426: hypothetical protein +FIG00578427 RelA/SpoT +FIG00578429 FIG00578430: hypothetical protein +FIG00578443 FIG00578444: hypothetical protein +FIG00578445 FIG00578448: hypothetical protein +FIG00578449 FIG00578451: hypothetical protein +FIG00578451 FIG00578454: hypothetical protein +FIG00578469 FIG00578470: hypothetical protein +FIG00578477 sugar ABC transporter, permease protein +FIG00578488 osmotically inducible protein C +FIG00578496 FIG00578499: hypothetical protein +FIG00578504 FIG00578506: hypothetical protein +FIG00578511 FIG00578513: hypothetical protein +FIG00578518 FIG00578519: hypothetical protein +FIG00578520 FIG00578523: hypothetical protein +FIG00578523 FIG00578524: hypothetical protein +FIG00578530 FIG00578532: hypothetical protein +FIG00578539 FIG00578542: hypothetical protein +FIG00578542 FIG00578546: hypothetical protein +FIG00578546 FIG00578548: hypothetical protein +FIG00578548 serine/threonine protein kinase-related protein +FIG00578556 FIG00578557: hypothetical protein +FIG00578572 FIG00578577: hypothetical protein +FIG00578577 Probable serine/threonine protein kinase pknB (EC 2.7.11.1) +FIG00578578 Uricase (urate oxidase) (EC 1.7.3.3) +FIG00578594 histone deacetylase family protein +FIG00578602 FIG00578604: hypothetical protein +FIG00578606 branched-chain amino acid transport system permease protein livH +FIG00578628 FIG00578629: hypothetical protein +FIG00578629 FIG00578632: hypothetical protein +FIG00578638 Aminoglycoside 3'-phosphotransferase (EC 2.7.1.95) +FIG00578642 FIG00578643: hypothetical protein +FIG00578663 FIG00578664: hypothetical protein +FIG00578664 sporulation protein SpoIID-related protein +FIG00578669 FIG00578672: hypothetical protein +FIG00578675 guanine-specific ribonuclease N1 and T1( EC:3.1.27.3 ) +FIG00578681 FIG00578682: hypothetical protein +FIG00578695 FIG00578698: hypothetical protein +FIG00578698 FIG00578705: hypothetical protein +FIG00578710 FIG00578712: hypothetical protein +FIG00578712 FIG00578715: hypothetical protein +FIG00578749 FIG00578750: hypothetical protein +FIG00578753 FIG00578755: hypothetical protein +FIG00578773 FIG00578774: hypothetical protein +FIG00578775 FIG00578776: hypothetical protein +FIG00578782 FIG00578783: hypothetical protein +FIG00578783 FIG00578789: hypothetical protein +FIG00578791 methyltransferase, putative, BioC family +FIG00578794 FIG00578798: hypothetical protein +FIG00578814 FIG00578818: hypothetical protein +FIG00578827 multidrug resistance protein-related protein +FIG00578842 FIG00578843: hypothetical protein +FIG00578843 FIG00578848: hypothetical protein +FIG00578848 FIG00578851: hypothetical protein +FIG00578852 FIG00578853: hypothetical protein +FIG00578860 FIG00578863: hypothetical protein +FIG00578865 FIG00578866: hypothetical protein +FIG00578893 FIG00578894: hypothetical protein +FIG00578896 FIG00578899: hypothetical protein +FIG00578899 DNA damage repair protein +FIG00578932 FIG00578935: hypothetical protein +FIG00578952 c-type cytochrome, putative +FIG00578953 FIG00578956: hypothetical protein +FIG00578956 FIG00578961: hypothetical protein +FIG00578985 FIG00578987: hypothetical protein +FIG00578992 Iron(III) dicitrate transport system permease protein fecD +FIG00579008 FIG00579010: hypothetical protein +FIG00579012 FIG00579017: hypothetical protein +FIG00579037 FIG00579039: hypothetical protein +FIG00579042 FIG00579046: hypothetical protein +FIG00579047 FIG00579050: hypothetical protein +FIG00579064 FIG00579066: hypothetical protein +FIG00579067 FIG00579069: hypothetical protein +FIG00579085 FIG00579089: hypothetical protein +FIG00579100 FIG00579101: hypothetical protein +FIG00579114 FIG00579120: hypothetical protein +FIG00579126 DNA polymerase IV (family X) +FIG00579144 FIG00579146: hypothetical protein +FIG00579150 FIG00579152: hypothetical protein +FIG00579174 FIG00579177: hypothetical protein +FIG00579177 FIG00579178: hypothetical protein +FIG00579193 transcriptional activator TipA +FIG00579197 FIG00579198: hypothetical protein +FIG00579198 FIG00579201: hypothetical protein +FIG00579216 FIG00579218: hypothetical protein +FIG00579218 FIG00579220: hypothetical protein +FIG00579244 peptide ABC transporter, permease protein, putative +FIG00579246 chromosome partitioning ATPase, putative, ParA family +FIG00579251 FIG00579253: hypothetical protein +FIG00579257 FIG00579258: hypothetical protein +FIG00579263 FIG00579264: hypothetical protein +FIG00579275 FIG00579285: hypothetical protein +FIG00579291 FIG00579292: hypothetical protein +FIG00579295 FIG00579296: hypothetical protein +FIG00579296 FIG00579297: hypothetical protein +FIG00579297 FIG00579298: hypothetical protein +FIG00579299 comA protein +FIG00579349 FIG00579357: hypothetical protein +FIG00579392 FIG00579395: hypothetical protein +FIG00579398 FIG00579399: hypothetical protein +FIG00579400 FIG00579402: hypothetical protein +FIG00579409 FIG00579410: hypothetical protein +FIG00579419 FIG00579422: hypothetical protein +FIG00579425 FIG00579426: hypothetical protein +FIG00579426 FIG00579432: hypothetical protein +FIG00579437 FIG00579441: hypothetical protein +FIG00579444 FIG00579445: hypothetical protein +FIG00579454 dTDP-D-glucose 4,6-dehydratase +FIG00579467 FIG00579469: hypothetical protein +FIG00579472 FIG00579474: hypothetical protein +FIG00579483 FIG00579485: hypothetical protein +FIG00579493 FIG00579495: hypothetical protein +FIG00579498 FIG00579499: hypothetical protein +FIG00579513 FIG00579514: hypothetical protein +FIG00579514 FIG00579524: hypothetical protein +FIG00579527 FIG00579529: hypothetical protein +FIG00579542 FIG00579548: hypothetical protein +FIG00579564 FIG00579568: hypothetical protein +FIG00579581 FIG00579583: hypothetical protein +FIG00579583 streptomycin 3-kinase +FIG00579590 FIG00579592: hypothetical protein +FIG00579592 FIG00579597: hypothetical protein +FIG00579597 FIG00579598: hypothetical protein +FIG00579606 FIG00579607: hypothetical protein +FIG00579640 FIG00579643: hypothetical protein +FIG00579643 S-layer-like array-related protein +FIG00579644 Probable acyl-[acyl-carrier protein] desaturase DESA1 (Acyl-[ACP] desaturase) (Stearoyl-ACP desaturase) (Protein DES) (EC 1.14.19.2) +FIG00579645 FIG00579650: hypothetical protein +FIG00579660 FIG00579664: hypothetical protein +FIG00579664 FIG00579665: hypothetical protein +FIG00579679 FIG00579680: hypothetical protein +FIG00579680 FIG00579683: hypothetical protein +FIG00579713 FIG00579714: hypothetical protein +FIG00579717 FIG00579720: hypothetical protein +FIG00579736 FIG00579739: hypothetical protein +FIG00579743 FIG00579746: hypothetical protein +FIG00579772 PecM-related protein +FIG00579810 FIG00579812: hypothetical protein +FIG00579849 FIG00579850: hypothetical protein +FIG00579873 FIG00579877: hypothetical protein +FIG00579878 FIG00579881: hypothetical protein +FIG00579889 FIG00579894: hypothetical protein +FIG00579903 FIG00579904: hypothetical protein +FIG00579905 FIG00579906: hypothetical protein +FIG00579908 FIG00579910: hypothetical protein +FIG00579910 FIG00579912: hypothetical protein +FIG00579914 FIG00579920: hypothetical protein +FIG00579920 FIG00579924: hypothetical protein +FIG00579925 SudD-related protein +FIG00579934 COG2363 +FIG00579975 FIG00579977: hypothetical protein +FIG00579989 FIG00579993: hypothetical protein +FIG00580003 beta-lactamase, putative +FIG00580006 FIG00580008: hypothetical protein +FIG00580016 Probable transcriptional regulator ycf27 +FIG00580020 FIG00580021: hypothetical protein +FIG00580025 FIG00580026: hypothetical protein +FIG00580027 FIG00580029: hypothetical protein +FIG00580029 FIG00580031: hypothetical protein +FIG00580034 FIG00580036: hypothetical protein +FIG00580038 FIG00580046: hypothetical protein +FIG00580054 FIG00580056: hypothetical protein +FIG00580058 FIG00580063: hypothetical protein +FIG00580071 FIG00580074: hypothetical protein +FIG00580079 FIG00580081: hypothetical protein +FIG00580085 tetratricopeptide repeat family protein +FIG00580090 FIG00580092: hypothetical protein +FIG00580101 FIG00580107: hypothetical protein +FIG00580109 FIG00580110: hypothetical protein +FIG00580110 FIG00580113: hypothetical protein +FIG00580113 FIG00580116: hypothetical protein +FIG00580129 FIG00580130: hypothetical protein +FIG00580130 FIG00580131: hypothetical protein +FIG00580160 FIG00580162: hypothetical protein +FIG00580188 FIG00580192: hypothetical protein +FIG00580220 FIG00580221: hypothetical protein +FIG00580224 FIG00580225: hypothetical protein +FIG00580234 FIG00580235: hypothetical protein +FIG00580243 FIG00580248: hypothetical protein +FIG00580248 kanamycin resistance protein-related protein +FIG00580261 FIG00580265: hypothetical protein +FIG00580265 peptidase M42 +FIG00580272 FIG00580277: hypothetical protein +FIG00580293 FIG00580295: hypothetical protein +FIG00580300 FIG00580303: hypothetical protein +FIG00580310 FIG00580313: hypothetical protein +FIG00580331 FIG00580334: hypothetical protein +FIG00580338 FIG00580340: hypothetical protein +FIG00580358 FIG00580359: hypothetical protein +FIG00580369 FIG00580371: hypothetical protein +FIG00580379 FIG00580381: hypothetical protein +FIG00580385 Cyclomaltodextrin glucanotransferase precursor (EC 2.4.1.19) +FIG00580387 FIG00580389: hypothetical protein +FIG00580396 FIG00580400: hypothetical protein +FIG00580411 FIG00580412: hypothetical protein +FIG00580418 FIG00580425: hypothetical protein +FIG00580451 FIG00580452: hypothetical protein +FIG00580486 Zn-ribbon-containing, possibly RNA-binding protein and truncated derivatives +FIG00580495 FIG00580500: hypothetical protein +FIG00580563 FIG00580569: hypothetical protein +FIG00580569 FIG00580575: hypothetical protein +FIG00580584 FIG00580588: hypothetical protein +FIG00580592 FIG00580594: hypothetical protein +FIG00580602 FIG00580604: hypothetical protein +FIG00580629 FIG00580631: hypothetical protein +FIG00580639 FIG00580641: hypothetical protein +FIG00580750 FIG00580752: hypothetical protein +FIG00580757 Response regulator/GGDEF/EAL domain protein +FIG00580767 Dessication-associated protein +FIG00580790 Osmotically inducible lipoprotein B precursor +FIG00580812 FIG00580815: hypothetical protein +FIG00580855 FIG00580858: hypothetical protein +FIG00580890 glucose sorbosone dehydrogenase +FIG00580899 FIG00580901: hypothetical protein +FIG00580933 Outer membrane usher protein +FIG00580943 Type I secretion outer membrane protein, TolC family +FIG00580947 Probable sulfite reductase +FIG00580968 FIG00580970: hypothetical protein +FIG00581050 FIG00581054: hypothetical protein +FIG00581054 FIG00581055: hypothetical protein +FIG00581057 FIG00581061: hypothetical protein +FIG00581073 FIG00581074: hypothetical protein +FIG00581096 Gsr0356 protein +FIG00581122 FIG00581129: hypothetical protein +FIG00581208 hypothetical protein +FIG00581337 FIG00581344: hypothetical protein +FIG00581392 FIG00581394: hypothetical protein +FIG00581394 FIG00581396: hypothetical protein +FIG00581404 FIG00581413: hypothetical protein +FIG00581413 FIG00581414: hypothetical protein +FIG00581416 FIG00581418: hypothetical protein +FIG00581470 FIG00581472: hypothetical protein +FIG00581478 putative desaturase +FIG00581493 FIG00347798: hypothetical protein +FIG00581531 FIG00581545: hypothetical protein +FIG00581553 SlyX +FIG00581566 FIG00581576: hypothetical protein +FIG00581577 Mlr8013 protein +FIG00581582 FIG00581584: hypothetical protein +FIG00581607 FIG01198229: hypothetical protein +FIG00581686 LemA +FIG00581715 FIG00581718: hypothetical protein +FIG00581730 FIG00581734: hypothetical protein +FIG00581738 FIG00581744: hypothetical protein +FIG00581777 FIG062788: hypothetical protein +FIG00581783 Osmotically inducible periplasmic protein +FIG00581817 FIG00581818: hypothetical protein +FIG00581830 FIG00581832: hypothetical protein +FIG00581859 FIG00956406: hypothetical protein +FIG00581900 FIG00581907: hypothetical protein +FIG00581910 FIG00349181: hypothetical protein +FIG00581920 Msl3420 protein +FIG00581926 Ferric anguibactin transport system permease protein fatD +FIG00581928 Probable RNA 2'-phosphotransferase (EC 2.7.1.-) +FIG00581961 Oligopeptide transport system permease protein OppB (TC 3.A.1.5.1) +FIG00581971 FIG00581974: hypothetical protein +FIG00581982 FIG00581984: hypothetical protein +FIG00582008 putative acetolactate synthase large subunit +FIG00582056 FIG00715336: hypothetical protein +FIG00582122 FIG00582124: hypothetical protein +FIG00582130 FIG00582131: hypothetical protein +FIG00582175 FIG00582181: hypothetical protein +FIG00582206 FIG00582211: hypothetical protein +FIG00582215 FIG00582216: hypothetical protein +FIG00582288 FIG00582290: hypothetical protein +FIG00582332 FIG00582336: hypothetical protein +FIG00582345 FIG00582348: hypothetical protein +FIG00582380 FIG00582381: hypothetical protein +FIG00582426 FIG00582428: hypothetical protein +FIG00582489 FIG00582496: hypothetical protein +FIG00582570 FIG00582571: hypothetical protein +FIG00582571 FIG00582580: hypothetical protein +FIG00582581 transcriptional regulatory protein, MerR family +FIG00582607 FIG00582608: hypothetical protein +FIG00582632 FIG00582639: hypothetical protein +FIG00582658 FIG00582659: hypothetical protein +FIG00582697 FIG00582706: hypothetical protein +FIG00582765 alkyl sulfatase( EC:3.1.6.- ) +FIG00582784 FIG00582785: hypothetical protein +FIG00582786 FIG00932012: hypothetical protein +FIG00582788 FIG00582796: hypothetical protein +FIG00582829 FIG00715976: hypothetical protein +FIG00582848 FIG00582854: hypothetical protein +FIG00582856 FIG00582857: hypothetical protein +FIG00582880 General L-amino acid transport system permease protein aapQ +FIG00582881 FIG00582885: hypothetical protein +FIG00582885 FIG00582897: hypothetical protein +FIG00582905 Probable sensor histidine kinase protein (EC 2.7.3.-) +FIG00582909 Toluene tolerance precursor +FIG00582953 porin, gram-negative type +FIG00583020 FIG00583030: hypothetical protein +FIG00583073 FIG00583090: hypothetical protein +FIG00583158 FIG00583161: hypothetical protein +FIG00583161 FIG00583172: hypothetical protein +FIG00583172 FIG00583182: hypothetical protein +FIG00583182 FIG00583184: hypothetical protein +FIG00583184 FIG00583186: hypothetical protein +FIG00583190 FIG00583206: hypothetical protein +FIG00583206 FIG00583210: hypothetical protein +FIG00583210 FIG00583223: hypothetical protein +FIG00583223 FIG00583226: hypothetical protein +FIG00583226 FIG00583228: hypothetical protein +FIG00583228 FIG00583238: hypothetical protein +FIG00583249 Fumarate reductase flavoprotein subunit precursor (EC 1.3.99.1) (Iron(III)-induced flavocytochrome C3) (Ifc3) +FIG00583277 FIG00583283: hypothetical protein +FIG00583350 FIG00583370: hypothetical protein +FIG00583386 FIG00583406: hypothetical protein +FIG00583426 FIG00583435: hypothetical protein +FIG00583435 FIG00583444: hypothetical protein +FIG00583444 FIG00583445: hypothetical protein +FIG00583451 FIG00583465: hypothetical protein +FIG00583465 FIG00583466: hypothetical protein +FIG00583487 amino acid amidohydrolase +FIG00583502 sulfide dehydrogenase, flavoprotein subunit +FIG00583505 Possible RNA methyltransferase aq_1528 +FIG00583543 FIG00583546: hypothetical protein +FIG00583547 FIG00583553: hypothetical protein +FIG00583575 FIG00583579: hypothetical protein +FIG00583579 FIG00583599: hypothetical protein +FIG00583599 FIG00583623: hypothetical protein +FIG00583628 COG0398: uncharacterized membrane protein +FIG00583637 FIG00583640: hypothetical protein +FIG00583640 FIG00583652: hypothetical protein +FIG00583652 FIG00583681: hypothetical protein +FIG00583681 FIG00583691: hypothetical protein +FIG00583691 FIG00583692: hypothetical protein +FIG00583705 FIG00583746: hypothetical protein +FIG00583746 FIG00583777: hypothetical protein +FIG00583783 FIG00583787: hypothetical protein +FIG00583787 FIG00583814: hypothetical protein +FIG00583820 FIG00583828: hypothetical protein +FIG00583828 FIG00583836: hypothetical protein +FIG00583836 FIG00583857: hypothetical protein +FIG00583883 FIG00583890: hypothetical protein +FIG00583890 FIG00583923: hypothetical protein +FIG00583923 FIG00583938: hypothetical protein +FIG00583938 FIG00583942: hypothetical protein +FIG00583955 FIG00583960: hypothetical protein +FIG00583970 FIG00584014: hypothetical protein +FIG00584046 iron compound ABC transporter, periplasmic iron compount-binding protein, putative +FIG00584062 FIG00584072: hypothetical protein +FIG00584072 FIG00584132: hypothetical protein +FIG00584144 FIG00584171: hypothetical protein +FIG00584199 FIG00584232: hypothetical protein +FIG00584232 FIG00584244: hypothetical protein +FIG00584244 FIG00584275: hypothetical protein +FIG00584275 FIG00584303: hypothetical protein +FIG00584303 oxidoreductase, Gfo/Idh/MocA family, putative +FIG00584354 phosphoesterase, RecJ domain protein +FIG00584374 FIG00584399: hypothetical protein +FIG00584405 FIG00584409: hypothetical protein +FIG00584409 putative RTX toxin +FIG00584413 FIG00584420: hypothetical protein +FIG00584420 FIG00584435: hypothetical protein +FIG00584435 FIG00584499: hypothetical protein +FIG00584499 FIG00584505: hypothetical protein +FIG00584512 FIG00584520: hypothetical protein +FIG00584520 Gll3705 protein +FIG00584559 FIG00584577: hypothetical protein +FIG00584577 FIG00584600: hypothetical protein +FIG00584605 Transposon Tn7 transposition protein tnsD +FIG00584796 cytochrome c class III +FIG00584798 related to methylamine utilization protein +FIG00585095 FIG00585098: hypothetical protein +FIG00585359 c-di-GMP phosphodiesterase A +FIG00585621 protein of unknown function DUF1568 +FIG00585908 protein of unknown function DUF169 +FIG00586019 FIG00586037: hypothetical protein +FIG00586207 Nitrogen assimilation regulatory protein +FIG00586419 Phosphocarrier protein kinase/phosphorylase, nitrogen regulation associated +FIG00587265 Translation elongation factor P Lys34:lysine transferase +FIG00587750 related to exopolysaccharide biosynthesis protein (GumC protein) +FIG00588223 Protein of unknown function DUF172 +FIG00588640 FIG00588641: hypothetical protein +FIG00588642 FIG00588647: hypothetical protein +FIG00588647 FIG00588648: hypothetical protein +FIG00588650 FIG00588651: hypothetical protein +FIG00588652 FIG00588653: hypothetical protein +FIG00588656 FIG00588658: hypothetical protein +FIG00588660 Molybdopterin oxidoreductase +FIG00588664 FIG00588665: hypothetical protein +FIG00588665 Response regulator containing a CheY-like receiver domain and a GGDEF domain +FIG00588672 FIG00588673: hypothetical protein +FIG00588673 FIG00588675: hypothetical protein +FIG00588675 FIG00588676: hypothetical protein +FIG00588677 FIG00588679: hypothetical protein +FIG00588680 FIG00588681: hypothetical protein +FIG00588681 FIG00588682: hypothetical protein +FIG00588682 FIG00588683: hypothetical protein +FIG00588685 FIG00588686: hypothetical protein +FIG00588686 Putative exporter of polyketide antibiotics +FIG00588689 FIG00588691: hypothetical protein +FIG00588691 FIG00588692: hypothetical protein +FIG00588692 FIG00588693: hypothetical protein +FIG00588696 FIG00588699: hypothetical protein +FIG00588699 FIG00588700: hypothetical protein +FIG00588704 FIG00588705: hypothetical protein +FIG00588705 Ser/Thr and Tyr protein phosphatase (dual specificity)# +FIG00588706 FIG00588707: hypothetical protein +FIG00588707 FIG00588708: hypothetical protein +FIG00588714 FIG00588715: hypothetical protein +FIG00588716 FIG00588722: hypothetical protein +FIG00588722 FIG00588723: hypothetical protein +FIG00588723 FIG00588726: hypothetical protein +FIG00588727 FIG00588729: hypothetical protein +FIG00588729 Transcriptional regulator, CdaR +FIG00588737 FIG00588739: hypothetical protein +FIG00588742 FIG00588743: hypothetical protein +FIG00588748 FIG00588749: hypothetical protein +FIG00588751 FIG00588753: hypothetical protein +FIG00588754 FIG00588755: hypothetical protein +FIG00588756 FIG00588758: hypothetical protein +FIG00588759 FIG00588761: hypothetical protein +FIG00588761 FIG00588762: hypothetical protein +FIG00588762 Unknown, probable lipopolysaccharide biosynthesis protein +FIG00588770 FIG00588772: hypothetical protein +FIG00588774 FIG00588776: hypothetical protein +FIG00588776 FIG00588779: hypothetical protein +FIG00588783 FIG00588784: hypothetical protein +FIG00588794 FIG00588795: hypothetical protein +FIG00588801 FIG00588802: hypothetical protein +FIG00588802 FIG00588803: hypothetical protein +FIG00588806 FIG00588807: hypothetical protein +FIG00588807 FIG00588808: hypothetical protein +FIG00588812 FIG00588813: hypothetical protein +FIG00588817 FIG00588818: hypothetical protein +FIG00588825 FIG00588827: hypothetical protein +FIG00588829 Modification methylase VspI (EC 2.1.1.72) +FIG00588834 FIG00588835: hypothetical protein +FIG00588838 FIG00588840: hypothetical protein +FIG00588842 FIG00588843: hypothetical protein +FIG00588843 FIG00588846: hypothetical protein +FIG00588849 FIG00588851: hypothetical protein +FIG00588852 FIG00588854: hypothetical protein +FIG00588860 FIG00588863: hypothetical protein +FIG00588863 FIG00588869: hypothetical protein +FIG00588869 Methylthiol:coenzyme M methyltransferase +FIG00588874 FIG00588876: hypothetical protein +FIG00588876 FIG00588878: hypothetical protein +FIG00588884 FIG00588887: hypothetical protein +FIG00588887 FIG00588889: hypothetical protein +FIG00588889 FIG00588891: hypothetical protein +FIG00588891 FIG00588892: hypothetical protein +FIG00588895 FIG00588896: hypothetical protein +FIG00588899 FIG00588900: hypothetical protein +FIG00588900 FIG00588903: hypothetical protein +FIG00588903 FIG00588911: hypothetical protein +FIG00588911 FIG00588914: hypothetical protein +FIG00588914 FIG00588916: hypothetical protein +FIG00588916 FIG00588922: hypothetical protein +FIG00588922 FIG00588926: hypothetical protein +FIG00588926 FIG00588928: hypothetical protein +FIG00588928 DNA polymerase III, alpha subunit +FIG00588929 FIG00588931: hypothetical protein +FIG00588934 FIG00588937: hypothetical protein +FIG00588938 FIG00588939: hypothetical protein +FIG00588939 FIG00588940: hypothetical protein +FIG00588941 FIG00588942: hypothetical protein +FIG00588945 FIG00588947: hypothetical protein +FIG00588947 FIG00588948: hypothetical protein +FIG00588948 FIG00588950: hypothetical protein +FIG00588950 FIG00588951: hypothetical protein +FIG00588958 FIG00588959: hypothetical protein +FIG00588972 FIG00588974: hypothetical protein +FIG00588975 FIG00588977: hypothetical protein +FIG00588982 FIG00588986: hypothetical protein +FIG00588986 FIG00588987: hypothetical protein +FIG00588987 FIG00588988: hypothetical protein +FIG00588991 FIG00588994: hypothetical protein +FIG00588994 MmcK +FIG00588995 FIG00588996: hypothetical protein +FIG00588999 FIG00589000: hypothetical protein +FIG00589005 FIG00589007: hypothetical protein +FIG00589007 FIG00589009: hypothetical protein +FIG00589009 FIG00589010: hypothetical protein +FIG00589010 FIG00589011: hypothetical protein +FIG00589012 FIG00589013: hypothetical protein +FIG00589015 FIG00589018: hypothetical protein +FIG00589018 FIG00589019: hypothetical protein +FIG00589019 FIG00589020: hypothetical protein +FIG00589020 FIG00589022: hypothetical protein +FIG00589024 FIG00589025: hypothetical protein +FIG00589025 FIG00589026: hypothetical protein +FIG00589028 FIG00589029: hypothetical protein +FIG00589031 FIG00589034: hypothetical protein +FIG00589039 FIG00589042: hypothetical protein +FIG00589048 FIG00589049: hypothetical protein +FIG00589049 FIG00589050: hypothetical protein +FIG00589050 FIG00589051: hypothetical protein +FIG00589052 FIG00589053: hypothetical protein +FIG00589055 FIG00589056: hypothetical protein +FIG00589060 FIG00589061: hypothetical protein +FIG00589062 FIG00589063: hypothetical protein +FIG00589065 FIG00589066: hypothetical protein +FIG00589066 FIG00589067: hypothetical protein +FIG00589067 FIG00589069: hypothetical protein +FIG00589075 FIG00589078: hypothetical protein +FIG00589079 FIG00589081: hypothetical protein +FIG00589085 FIG00589086: hypothetical protein +FIG00589086 HD-GYP domain protein +FIG00589087 FIG00589088: hypothetical protein +FIG00589088 FIG00589090: hypothetical protein +FIG00589090 FIG00589091: hypothetical protein +FIG00589091 Polyferredoxin-like +FIG00589093 Membrane-bound serine protease (ClpP class) +FIG00589095 FIG00589099: hypothetical protein +FIG00589100 FIG00589101: hypothetical protein +FIG00589101 FIG00589103: hypothetical protein +FIG00589103 FIG00589105: hypothetical protein +FIG00589110 FIG00589111: hypothetical protein +FIG00589115 UPF0251 protein CT1277 +FIG00589116 FIG00589117: hypothetical protein +FIG00589120 FIG00589121: hypothetical protein +FIG00589122 FIG00589126: hypothetical protein +FIG00589129 FIG00589130: hypothetical protein +FIG00589130 FIG00589133: hypothetical protein +FIG00589137 FIG00589138: hypothetical protein +FIG00589140 FIG00589142: hypothetical protein +FIG00589142 FIG00589144: hypothetical protein +FIG00589144 FIG00589148: hypothetical protein +FIG00589148 FIG00589152: hypothetical protein +FIG00589152 Formate-dependent nitrite reductase, membrane component +FIG00589163 FIG00589165: hypothetical protein +FIG00589166 FIG00589167: hypothetical protein +FIG00589170 METHYLASPARTATE MUTASE (EC 5.4.99.1) +FIG00589172 FIG00589181: hypothetical protein +FIG00589184 FIG00589185: hypothetical protein +FIG00589187 FIG00589193: hypothetical protein +FIG00589193 FIG00589198: hypothetical protein +FIG00589198 FIG00589200: hypothetical protein +FIG00589201 FIG00589202: hypothetical protein +FIG00589202 FIG00589203: hypothetical protein +FIG00589203 FIG00589204: hypothetical protein +FIG00589204 FIG00589205: hypothetical protein +FIG00589208 FIG00589209: hypothetical protein +FIG00589212 FIG00589213: hypothetical protein +FIG00589213 FIG00589214: hypothetical protein +FIG00589214 FIG00589215: hypothetical protein +FIG00589221 FIG00589222: hypothetical protein +FIG00589222 Aconitase family protein YbhJ +FIG00589225 FIG00589228: hypothetical protein +FIG00589228 FIG00589230: hypothetical protein +FIG00589233 FIG00589234: hypothetical protein +FIG00589234 FIG00589235: hypothetical protein +FIG00589237 FIG00589238: hypothetical protein +FIG00589238 FIG00589239: hypothetical protein +FIG00589239 FIG00589240: hypothetical protein +FIG00589240 FIG00589243: hypothetical protein +FIG00589254 FIG00589255: hypothetical protein +FIG00589255 Polysaccharide deacetylase precursor (EC 3.5.1.41) +FIG00589264 FIG00589266: hypothetical protein +FIG00589266 FIG00589268: hypothetical protein +FIG00589268 FIG00589269: hypothetical protein +FIG00589269 DNA-binding response regulator DegU +FIG00589272 FIG00589274: hypothetical protein +FIG00589277 FIG00589279: hypothetical protein +FIG00589279 FIG00589281: hypothetical protein +FIG00589281 FIG00589283: hypothetical protein +FIG00589283 FIG00589285: hypothetical protein +FIG00589288 FIG00589289: hypothetical protein +FIG00589294 FIG00589296: hypothetical protein +FIG00589296 FIG00589302: hypothetical protein +FIG00589305 FIG00589306: hypothetical protein +FIG00589307 FIG00589308: hypothetical protein +FIG00589308 FIG00589309: hypothetical protein +FIG00589309 FIG00589314: hypothetical protein +FIG00589314 FIG00589316: hypothetical protein +FIG00589316 FIG00589320: hypothetical protein +FIG00589332 DUF1934 domain-containing protein +FIG00589334 FIG00589335: hypothetical protein +FIG00589336 FIG00589340: hypothetical protein +FIG00589341 Methyltransferase corrinoid protein Dhaf_2146 +FIG00589342 FIG00589345: hypothetical protein +FIG00589348 FIG00589350: hypothetical protein +FIG00589350 FIG00589353: hypothetical protein +FIG00589353 FIG00589354: hypothetical protein +FIG00589354 FIG00589356: hypothetical protein +FIG00589357 FIG00589359: hypothetical protein +FIG00589359 FIG00589365: hypothetical protein +FIG00589365 FIG00589367: hypothetical protein +FIG00589369 FIG00589371: hypothetical protein +FIG00589379 FIG00589380: hypothetical protein +FIG00589384 FIG00589385: hypothetical protein +FIG00589385 FIG00589387: hypothetical protein +FIG00589387 FIG00589390: hypothetical protein +FIG00589390 FIG00589391: hypothetical protein +FIG00589391 FIG00589393: hypothetical protein +FIG00589397 FIG00589398: hypothetical protein +FIG00589406 Amino-acid ABC transporter ATP-binding protein PebC +FIG00589408 FIG00589409: hypothetical protein +FIG00589420 FIG00589421: hypothetical protein +FIG00589425 FIG00589427: hypothetical protein +FIG00589428 FIG00589429: hypothetical protein +FIG00589430 FIG00589432: hypothetical protein +FIG00589432 FIG00589433: hypothetical protein +FIG00589433 FIG00589441: hypothetical protein +FIG00589441 FIG00589442: hypothetical protein +FIG00589442 FIG00589444: hypothetical protein +FIG00589452 Methylaspartate mutase, E subunit (EC 5.4.99.1) +FIG00589459 FIG00589460: hypothetical protein +FIG00589460 FIG00589461: hypothetical protein +FIG00589461 FIG00589462: hypothetical protein +FIG00589462 FIG00589463: hypothetical protein +FIG00589469 FIG00589471: hypothetical protein +FIG00589482 FIG00589483: hypothetical protein +FIG00589484 FIG00589487: hypothetical protein +FIG00589487 FIG00589489: hypothetical protein +FIG00589489 FIG00589490: hypothetical protein +FIG00589491 FIG00589492: hypothetical protein +FIG00589493 FIG00589494: hypothetical protein +FIG00589494 FIG00589496: hypothetical protein +FIG00589513 protein of unknown function DUF307 +FIG00589518 FIG00589519: hypothetical protein +FIG00589520 Uroporphyrinogen-III decarboxylase-like +FIG00589524 FIG00589525: hypothetical protein +FIG00589531 FIG00589533: hypothetical protein +FIG00589533 FIG00589540: hypothetical protein +FIG00589544 FIG00589547: hypothetical protein +FIG00589547 FIG00589548: hypothetical protein +FIG00589550 FIG00589552: hypothetical protein +FIG00589552 FIG00589553: hypothetical protein +FIG00589553 FIG00589554: hypothetical protein +FIG00589554 FIG00589558: hypothetical protein +FIG00589560 FIG00589561: hypothetical protein +FIG00589561 FIG00589562: hypothetical protein +FIG00589562 FIG00589563: hypothetical protein +FIG00589568 FIG00589569: hypothetical protein +FIG00589570 FIG00589571: hypothetical protein +FIG00589575 transcriptional regulator for cysteine regulon +FIG00589580 FIG00589582: hypothetical protein +FIG00589594 FIG00589595: hypothetical protein +FIG00589598 FIG00589599: hypothetical protein +FIG00589599 FIG00589600: hypothetical protein +FIG00589600 FIG00589604: hypothetical protein +FIG00589615 FIG00589617: hypothetical protein +FIG00589617 FIG00589618: hypothetical protein +FIG00589618 FIG00589620: hypothetical protein +FIG00589621 FIG00589623: hypothetical protein +FIG00589634 FIG00589637: hypothetical protein +FIG00589637 FIG00589638: hypothetical protein +FIG00589639 Putative sulfide reductase +FIG00589645 FIG00589648: hypothetical protein +FIG00589648 FIG00589649: hypothetical protein +FIG00589653 TatA like protein +FIG00589655 FIG00589656: hypothetical protein +FIG00589658 FIG00589660: hypothetical protein +FIG00589671 FIG00589677: hypothetical protein +FIG00589677 FIG00589678: hypothetical protein +FIG00589697 FIG00589700: hypothetical protein +FIG00589700 FIG00589701: hypothetical protein +FIG00589701 FIG00589702: hypothetical protein +FIG00589706 FIG00589707: hypothetical protein +FIG00589707 iron-binding protein, hemerythrin +FIG00589718 FIG00589721: hypothetical protein +FIG00589721 FIG00589722: hypothetical protein +FIG00589731 FIG00589732: hypothetical protein +FIG00589734 FIG00589735: hypothetical protein +FIG00589735 FIG00589737: hypothetical protein +FIG00589745 FIG00589746: hypothetical protein +FIG00589756 FIG00589760: hypothetical protein +FIG00589761 FIG00589762: hypothetical protein +FIG00589762 FIG00589763: hypothetical protein +FIG00589763 FIG00589764: hypothetical protein +FIG00589775 FIG00589779: hypothetical protein +FIG00589779 FIG00589780: hypothetical protein +FIG00589780 FIG00589781: hypothetical protein +FIG00589782 FIG00589785: hypothetical protein +FIG00589785 FIG00589787: hypothetical protein +FIG00589788 FIG00589792: hypothetical protein +FIG00589792 Acetyl xylan esterase (EC 3.1.1.6) +FIG00589798 FIG00589802: hypothetical protein +FIG00589802 FIG00589803: hypothetical protein +FIG00589808 FIG00589810: hypothetical protein +FIG00589810 FIG00589811: hypothetical protein +FIG00589811 FIG00589813: hypothetical protein +FIG00589813 FIG00589814: hypothetical protein +FIG00589814 Methyltransferase corrinoid protein Dhaf_0843 +FIG00589817 FIG00589819: hypothetical protein +FIG00589819 FIG00589823: hypothetical protein +FIG00589823 FIG00589830: hypothetical protein +FIG00589836 FIG00589837: hypothetical protein +FIG00589845 FIG00589846: hypothetical protein +FIG00589846 FIG00589847: hypothetical protein +FIG00589852 FIG00589853: hypothetical protein +FIG00589854 FIG00589859: hypothetical protein +FIG00589862 FIG00589864: hypothetical protein +FIG00589864 FIG00589865: hypothetical protein +FIG00589872 FIG00589875: hypothetical protein +FIG00589875 FIG00589876: hypothetical protein +FIG00589877 FIG00589879: hypothetical protein +FIG00589879 FIG00589881: hypothetical protein +FIG00589898 FIG00589900: hypothetical protein +FIG00589900 Sensory transduction protein yxdJ +FIG00589904 FIG00589905: hypothetical protein +FIG00589905 FIG00589906: hypothetical protein +FIG00589906 FIG00589907: hypothetical protein +FIG00589907 FIG00589910: hypothetical protein +FIG00589910 FIG00589912: hypothetical protein +FIG00589914 FIG00589916: hypothetical protein +FIG00589920 FIG00589921: hypothetical protein +FIG00589927 FIG00589928: hypothetical protein +FIG00589928 FIG00589931: hypothetical protein +FIG00589934 FIG00589935: hypothetical protein +FIG00589942 FIG00589944: hypothetical protein +FIG00589944 FIG00589946: hypothetical protein +FIG00589962 N6 adenine-specific DNA methyltransferase, D12 class (EC 2.1.1.72) +FIG00589963 FIG00589964: hypothetical protein +FIG00589967 FIG00589969: hypothetical protein +FIG00589977 FIG00589981: hypothetical protein +FIG00589981 FIG00589983: hypothetical protein +FIG00589990 FIG00589991: hypothetical protein +FIG00590003 FIG00590004: hypothetical protein +FIG00590005 FIG00590006: hypothetical protein +FIG00590011 FIG00590012: hypothetical protein +FIG00590012 FIG00590015: hypothetical protein +FIG00590015 FIG00590017: hypothetical protein +FIG00590025 FIG00590026: hypothetical protein +FIG00590028 FIG00590029: hypothetical protein +FIG00590029 FIG00590030: hypothetical protein +FIG00590037 FIG00590038: hypothetical protein +FIG00590038 FIG00590039: hypothetical protein +FIG00590046 FIG00590048: hypothetical protein +FIG00590048 FIG00590049: hypothetical protein +FIG00590055 FIG00590059: hypothetical protein +FIG00590059 FIG00590062: hypothetical protein +FIG00590062 FIG00590063: hypothetical protein +FIG00590063 FIG00590065: hypothetical protein +FIG00590065 FIG00590066: hypothetical protein +FIG00590066 FIG00590070: hypothetical protein +FIG00590074 FIG00590075: hypothetical protein +FIG00590075 FIG00590079: hypothetical protein +FIG00590079 FIG00793325: hypothetical protein +FIG00590091 Sodium/solute symporter +FIG00590093 FIG00590096: hypothetical protein +FIG00590098 FIG00590100: hypothetical protein +FIG00590100 FIG00590101: hypothetical protein +FIG00590105 FIG00590108: hypothetical protein +FIG00590109 FIG00590112: hypothetical protein +FIG00590112 FIG00590113: hypothetical protein +FIG00590113 FIG00590117: hypothetical protein +FIG00590124 FIG00590126: hypothetical protein +FIG00590136 FIG00590137: hypothetical protein +FIG00590137 FIG00590138: hypothetical protein +FIG00590141 FIG00590144: hypothetical protein +FIG00590147 FIG00590149: hypothetical protein +FIG00590149 FIG00590150: hypothetical protein +FIG00590150 FIG00590152: hypothetical protein +FIG00590158 FIG00590159: hypothetical protein +FIG00590168 FIG00590169: hypothetical protein +FIG00590173 FIG00590174: hypothetical protein +FIG00590179 FIG00590181: hypothetical protein +FIG00590181 FIG00590182: hypothetical protein +FIG00590182 FIG00590183: hypothetical protein +FIG00590183 FIG00590188: hypothetical protein +FIG00590200 FIG00590203: hypothetical protein +FIG00590203 N-methylhydantoinase A/acetone carboxylase, beta subunit +FIG00590205 FIG00590206: hypothetical protein +FIG00590210 FIG00590211: hypothetical protein +FIG00590211 FIG00590213: hypothetical protein +FIG00590219 FIG00590227: hypothetical protein +FIG00590230 Uncharacterized protein, possibly involved in utilization of glycolate and propanediol +FIG00590241 FIG00590243: hypothetical protein +FIG00590244 FIG00590246: hypothetical protein +FIG00590247 FIG00590249: hypothetical protein +FIG00590252 FIG00590254: hypothetical protein +FIG00590255 FIG00590256: hypothetical protein +FIG00590261 FIG00590262: hypothetical protein +FIG00590262 putative response regulator; homolog of RumR and ScnR +FIG00590264 FIG00590266: hypothetical protein +FIG00590266 FIG00590267: hypothetical protein +FIG00590270 FIG00590271: hypothetical protein +FIG00590271 FIG00590273: hypothetical protein +FIG00590273 FIG00590276: hypothetical protein +FIG00590277 FIG00590288: hypothetical protein +FIG00590298 FIG00590299: hypothetical protein +FIG00590310 FIG00590316: hypothetical protein +FIG00590316 FIG00590320: hypothetical protein +FIG00590323 FIG00590327: hypothetical protein +FIG00590327 FIG00590328: hypothetical protein +FIG00590335 FIG00590336: hypothetical protein +FIG00590340 FIG00590341: hypothetical protein +FIG00590341 FIG00590345: hypothetical protein +FIG00590350 FIG00590351: hypothetical protein +FIG00590358 FIG00590362: hypothetical protein +FIG00590369 FIG00590374: hypothetical protein +FIG00590380 FIG00590384: hypothetical protein +FIG00590394 FIG00590397: hypothetical protein +FIG00590399 FIG00590402: hypothetical protein +FIG00590402 FIG00590406: hypothetical protein +FIG00590406 FIG00590408: hypothetical protein +FIG00590413 FIG00590416: hypothetical protein +FIG00590417 FIG00590421: hypothetical protein +FIG00590437 FIG00590438: hypothetical protein +FIG00590438 FIG00590442: hypothetical protein +FIG00590442 FIG00590443: hypothetical protein +FIG00590447 FIG00590453: hypothetical protein +FIG00590455 FIG00590457: hypothetical protein +FIG00590457 FIG00590460: hypothetical protein +FIG00590465 FIG00590466: hypothetical protein +FIG00590466 FIG00590468: hypothetical protein +FIG00590468 FIG00590469: hypothetical protein +FIG00590469 FIG00590470: hypothetical protein +FIG00590470 FIG00590471: hypothetical protein +FIG00590471 FIG00590474: hypothetical protein +FIG00590481 FIG00590485: hypothetical protein +FIG00590487 Sll7028 protein +FIG00590494 FIG00590496: hypothetical protein +FIG00590499 FIG00590500: hypothetical protein +FIG00590503 FIG00590505: hypothetical protein +FIG00590505 FIG00590506: hypothetical protein +FIG00590515 FIG00590517: hypothetical protein +FIG00590517 FIG00590518: hypothetical protein +FIG00590518 FIG00590521: hypothetical protein +FIG00590521 FIG00590524: hypothetical protein +FIG00590526 FIG00590528: hypothetical protein +FIG00590542 Adenylylsulfate reductase beta-subunit (EC 1.8.99.2) +FIG00590544 FIG00590548: hypothetical protein +FIG00590548 NADH:ubiquinone oxidoreductase subunit 4 (chain M) +FIG00590555 FIG00590556: hypothetical protein +FIG00590566 FIG00590567: hypothetical protein +FIG00590569 FIG00590572: hypothetical protein +FIG00590581 FIG00590584: hypothetical protein +FIG00590589 FIG00590590: hypothetical protein +FIG00590592 FIG00590593: hypothetical protein +FIG00590593 FIG00590598: hypothetical protein +FIG00590598 FIG00590599: hypothetical protein +FIG00590603 FIG00590606: hypothetical protein +FIG00590614 FIG00590615: hypothetical protein +FIG00590616 FIG00590618: hypothetical protein +FIG00590618 FIG00590621: hypothetical protein +FIG00590621 FIG00590622: hypothetical protein +FIG00590627 FIG00590628: hypothetical protein +FIG00590631 FIG00590632: hypothetical protein +FIG00590632 FIG00590633: hypothetical protein +FIG00590633 Methyltransferase FkbM family +FIG00590640 FIG00590644: hypothetical protein +FIG00590644 FIG00590647: hypothetical protein +FIG00590647 FIG00590648: hypothetical protein +FIG00590654 FIG00590662: hypothetical protein +FIG00590662 FIG00590663: hypothetical protein +FIG00590664 FIG00590666: hypothetical protein +FIG00590666 FIG00590669: hypothetical protein +FIG00590669 FIG00590672: hypothetical protein +FIG00590672 FIG00590673: hypothetical protein +FIG00590682 FIG00590685: hypothetical protein +FIG00590685 FIG00590686: hypothetical protein +FIG00590692 FIG00590696: hypothetical protein +FIG00590698 FIG00590706: hypothetical protein +FIG00590706 FIG00590713: hypothetical protein +FIG00590724 L-carnitine dehydratase (EC:4.2.1.89) +FIG00590735 FIG00590736: hypothetical protein +FIG00590737 FIG00590738: hypothetical protein +FIG00590744 FIG00590747: hypothetical protein +FIG00590747 FIG00590749: hypothetical protein +FIG00590749 FIG00590750: hypothetical protein +FIG00590757 FIG00590759: hypothetical protein +FIG00590761 Uncharacterised conserved protein UCP029876 +FIG00590765 FIG00590767: hypothetical protein +FIG00590771 FIG00590772: hypothetical protein +FIG00590773 FIG00590779: hypothetical protein +FIG00590781 FIG00590784: hypothetical protein +FIG00590784 FIG00590785: hypothetical protein +FIG00590786 FIG00590794: hypothetical protein +FIG00590801 FIG00590804: hypothetical protein +FIG00590804 FIG00590805: hypothetical protein +FIG00590806 FIG00590809: hypothetical protein +FIG00590809 FIG00590810: hypothetical protein +FIG00590810 Putative JHP540-like protein +FIG00590827 FIG01197514: hypothetical protein +FIG00590830 FIG00590838: hypothetical protein +FIG00590868 FIG00590869: hypothetical protein +FIG00590869 FIG00590878: hypothetical protein +FIG00590878 FIG00590879: hypothetical protein +FIG00590897 FIG00590898: hypothetical protein +FIG00590932 FIG00590933: hypothetical protein +FIG00590934 FIG00590937: hypothetical protein +FIG00590942 FIG00590946: hypothetical protein +FIG00590947 FIG00590951: hypothetical protein +FIG00590951 FIG00590954: hypothetical protein +FIG00590959 FIG00590963: hypothetical protein +FIG00590963 FIG00590967: hypothetical protein +FIG00590985 FIG00590986: hypothetical protein +FIG00590998 FIG00590999: hypothetical protein +FIG00591021 FIG00591022: hypothetical protein +FIG00591095 Type II restriction enzyme BsuBI (EC 3.1.21.4) +FIG00591275 FIG00591278: hypothetical protein +FIG00591420 FIG00591428: hypothetical protein +FIG00591484 Trimethylamine:corrinoid methyltransferase +FIG00591556 FIG00591560: hypothetical protein +FIG00591560 FIG00591562: hypothetical protein +FIG00591666 FIG00591683: hypothetical protein +FIG00591739 UDP-2,3-diacetamido-2,3-dideoxy-D-mannuronic acid transferase +FIG00591772 Tungstate ABC transporter, periplasmic substrate-binding protein WtpA +FIG00591918 Possible membrane fusion protein +FIG00591950 dehydrase, putative +FIG00592072 FIG00925693: hypothetical protein +FIG00592165 modification methylase, type II R/M system +FIG00592622 odd Oz/ten-m homolog 4 +FIG00592647 Fe-S oxidoreductase-like +FIG00592810 Protein DVU_0532 (HMC operon ORF 5) +FIG00593230 glycoside hydrolase, family 13 domain protein +FIG00593647 acriflavin resistance protein D +FIG00593918 NADH ubiquinone oxidoreductase, 20 kDa subunit +FIG00593960 Methyltransferase corrinoid activation protein +FIG00594252 FIG00594257: hypothetical protein +FIG00594517 Tetratricopeptide domain protein +FIG00594560 FIG00594568: hypothetical protein +FIG00594774 FIG00594786: hypothetical protein +FIG00594919 glutamate synthase (NADPH) +FIG00595016 glycosyltransferase-like +FIG00595030 related to methyl-accepting chemotaxis protein +FIG00595220 FIG00595256: hypothetical protein +FIG00595614 FIG00595620: hypothetical protein +FIG00595740 Type II restriction enzyme, methylase subunits +FIG00595948 phosphoesterase, Icc protein-like +FIG00596009 Secretion protein HlyD +FIG00596067 GGDEF:Response regulator receiver +FIG00596130 Protein of unknown function DUF134 +FIG00596175 spore coat polysaccharide biosynthesis protein spsF +FIG00596341 Surface-layer glycoprotein SatB precursor +FIG00596406 Probable C4-dicarboxylate response regulator dctR +FIG00596702 FIG00596704: hypothetical protein +FIG00596717 lysine exporter protein (LysE/YggA) +FIG00596745 FIG00596747: hypothetical protein +FIG00596801 FIG00596803: hypothetical protein +FIG00596811 FIG00596812: hypothetical protein +FIG00596812 magnesium chelatase subunit +FIG00596813 FIG00596814: hypothetical protein +FIG00597032 molybdenum ABC transporter, periplasmic molybdate-binding protein +FIG00597119 FIG00597121: hypothetical protein +FIG00597125 4-hydroxybutyrate CoA-transferase +FIG00597130 FIG00597135: hypothetical protein +FIG00597168 FIG00597176: hypothetical protein +FIG00597229 FIG00597230: hypothetical protein +FIG00597344 putative DNA processing chain A +FIG00597353 related to TPR repeat proteins +FIG00597584 two-component system response regulator (Pho family) +FIG00597645 Iron(III) ABC transporter, permease protein +FIG00597646 FIG00597647: hypothetical protein +FIG00597676 related to 2-hydroxyglutaryl-CoA dehydratase, beta subunit +FIG00597746 oligopeptide/dipeptide ABC transporter, ATP-binding protein +FIG00597897 Metallopeptidase, M24 family +FIG00597977 FIG00597981: hypothetical protein +FIG00598023 FIG00598027: hypothetical protein +FIG00598129 related to rubrerythrin +FIG00598143 peptidase, M24 family +FIG00598199 related to two-component system response regulator (Ntr family) +FIG00598219 related to glycosyl transferase +FIG00598236 FIG00598241: hypothetical protein +FIG00598277 Serine phosphatase RsbU, regulator of sigma subunit / Serine-protein kinase RsbW (EC 2.7.11.1) +FIG00598292 ferredoxin-dependent glutamate synthase +FIG00598314 sigma-54 dependent DNA-binding response regulator +FIG00598347 FIG00598348: hypothetical protein +FIG00598352 FIG00598358: hypothetical protein +FIG00598382 related to peptide ABC-transporter, periplasmic substrate binding protein +FIG00598383 Probable L-lysine-epsilon aminotransferase (EC 2.6.1.36) (L-lysine aminotransferase) (Lysine 6-aminotransferase) +FIG00598407 similar to TPR-repeat-containing proteins (partial length) +FIG00598409 Mannose-6-phosphate isomerase (EC 5.3.1.8) +FIG00598425 SH3, type 3 +FIG00598471 related to integral membrane protein (RarD) +FIG00598515 ABC-type transport system involved in resistance to organic solvents, auxiliary component +FIG00598625 FIG00598634: hypothetical protein +FIG00598641 FIG00598646: hypothetical protein +FIG00598646 FIG00598655: hypothetical protein +FIG00598655 FIG00598671: hypothetical protein +FIG00598671 FIG00598675: hypothetical protein +FIG00598689 FIG00598691: hypothetical protein +FIG00598739 FIG01165741: hypothetical protein +FIG00598797 peptidase M18, aminopeptidase I +FIG00598931 Type IV pilin PilA +FIG00598949 FIG00598969: hypothetical protein +FIG00598969 FIG00598986: hypothetical protein +FIG00598986 FIG00598995: hypothetical protein +FIG00599011 FIG00599037: hypothetical protein +FIG00599099 FIG00599101: hypothetical protein +FIG00599136 FIG00599143: hypothetical protein +FIG00599191 FIG00599202: hypothetical protein +FIG00599254 FIG00599263: hypothetical protein +FIG00599294 protein of unknown function DUF421 +FIG00599302 FIG00599304: hypothetical protein +FIG00599439 FIG00599448: hypothetical protein +FIG00599448 FIG00599458: hypothetical protein +FIG00599479 FIG00599483: hypothetical protein +FIG00599542 FIG00599551: hypothetical protein +FIG00599590 transposase Tn5 +FIG00599630 Peptidase T (EC 3.4.11.14) +FIG00599661 protein of unknown function DUF204 +FIG00599743 NAD-dependent formate dehydrogenase alpha subunit @ selenocysteine-containing +FIG00599745 Membrane-bound metal-dependent hydrolase YdjM, induced during SOS response +FIG00599777 Thiazolinyl imide reductase in siderophore biosynthesis gene cluster +FIG00599825 FIG00599840: hypothetical protein +FIG00599842 FIG00599849: hypothetical protein +FIG00599849 FIG00599889: hypothetical protein +FIG00599942 FIG00599944: hypothetical protein +FIG00599966 FIG00599974: hypothetical protein +FIG00599986 FIG00599997: hypothetical protein +FIG00600058 COG1872 +FIG00600067 Amino acid ABC transporter, amino acid-binding protein/permease protein +FIG00600157 Mycofactocin system glycosyltransferase +FIG00600234 Activator of 2-hydroxyglutaryl-CoA dehydratase +FIG00600322 FIG00600340: hypothetical protein +FIG00600428 FIG00600442: hypothetical protein +FIG00600442 FIG00600450: hypothetical protein +FIG00600554 FIG00600560: hypothetical protein +FIG00600653 FIG00600654: hypothetical protein +FIG00600654 FIG00600656: hypothetical protein +FIG00600676 FIG00600685: hypothetical protein +FIG00600723 FIG00600726: hypothetical protein +FIG00600726 Tyrosine recombinase XerC +FIG00600773 FIG01165494: hypothetical protein +FIG00600877 alternate gene name: spoVJ disruption leads to the production of immature spores (stage V sporulation) +FIG00601039 FIG00601051: hypothetical protein +FIG00601150 FIG00601165: hypothetical protein +FIG00601165 FIG00601168: hypothetical protein +FIG00601325 FIG00601345: hypothetical protein +FIG00601386 FIG00601392: hypothetical protein +FIG00601523 FIG00601528: hypothetical protein +FIG00601566 putative sterol carrier protein +FIG00601581 FIG00601584: hypothetical protein +FIG00601650 Modification methylase LlaDCHIA (EC 2.1.1.72) (Adenine-specific methyltransferase LlaDCHIA) (M.LlaDCHIA) (M.LlaDCHI A) (M.LlaII A) +FIG00601846 mannosyltransferase( EC:2.4.1.- ) +FIG00601995 Type IV pilus biogenesis protein PilN +FIG00601997 FIG00601999: hypothetical protein +FIG00602196 ABC-type MDR transport system, ATPase component +FIG00602237 FIG00602239: hypothetical protein +FIG00602239 FIG00602240: hypothetical protein +FIG00602242 FIG00602245: hypothetical protein +FIG00602246 FIG00602248: hypothetical protein +FIG00602248 FIG00602249: hypothetical protein +FIG00602254 FIG00602255: hypothetical protein +FIG00602255 FIG00602256: hypothetical protein +FIG00602261 anaerobic cobalt chelatase +FIG00602267 FIG00602269: hypothetical protein +FIG00602269 FIG00602270: hypothetical protein +FIG00602270 FIG00602276: hypothetical protein +FIG00602276 FIG00602277: hypothetical protein +FIG00602278 FIG00602279: hypothetical protein +FIG00602279 FIG00602281: hypothetical protein +FIG00602282 FIG00602283: hypothetical protein +FIG00602283 FIG00602287: hypothetical protein +FIG00602287 FIG00602289: hypothetical protein +FIG00602290 FIG00602292: hypothetical protein +FIG00602293 FIG00602295: hypothetical protein +FIG00602295 FIG00602296: hypothetical protein +FIG00602296 FIG00602297: hypothetical protein +FIG00602297 FIG00602300: hypothetical protein +FIG00602300 anti-sigma factor, putative +FIG00602309 FIG00602312: hypothetical protein +FIG00602312 Sodium-dependent phosphate transporter +FIG00602317 FIG00602320: hypothetical protein +FIG00602320 FIG00602322: hypothetical protein +FIG00602322 FIG00602323: hypothetical protein +FIG00602323 FIG00602324: hypothetical protein +FIG00602324 FIG00602326: hypothetical protein +FIG00602330 FIG00602331: hypothetical protein +FIG00602333 FIG00602335: hypothetical protein +FIG00602335 FIG00602336: hypothetical protein +FIG00602336 FIG00602345: hypothetical protein +FIG00602349 FIG00602350: hypothetical protein +FIG00602355 FIG00602356: hypothetical protein +FIG00602362 FIG00602363: hypothetical protein +FIG00602366 CgeB family protein +FIG00602373 FIG00602374: hypothetical protein +FIG00602378 FIG00602381: hypothetical protein +FIG00602381 FIG00602382: hypothetical protein +FIG00602382 outer membrane protein A precursor +FIG00602383 FIG00602384: hypothetical protein +FIG00602384 FIG00602385: hypothetical protein +FIG00602385 FIG00602390: hypothetical protein +FIG00602394 FIG00602398: hypothetical protein +FIG00602398 SNF2/helicase domain protein +FIG00602401 FIG00602402: hypothetical protein +FIG00602404 FIG00602408: hypothetical protein +FIG00602408 FIG00602409: hypothetical protein +FIG00602409 FIG00602411: hypothetical protein +FIG00602411 FIG00602412: hypothetical protein +FIG00602412 FIG00602413: hypothetical protein +FIG00602415 FIG00602416: hypothetical protein +FIG00602419 FIG00602422: hypothetical protein +FIG00602422 FIG00602423: hypothetical protein +FIG00602423 hemerythrin family protein +FIG00602425 FIG00602426: hypothetical protein +FIG00602426 FIG00602430: hypothetical protein +FIG00602430 FIG00602432: hypothetical protein +FIG00602432 FIG00602433: hypothetical protein +FIG00602433 FIG00602438: hypothetical protein +FIG00602441 COG1872 +FIG00602442 multiple antibiotic resistance (MarC)-related proteins +FIG00602454 Transmembrane component BioN of energizing module of biotin ECF transporter +FIG00602456 FIG00602457: hypothetical protein +FIG00602457 FIG00602458: hypothetical protein +FIG00602458 FIG00602459: hypothetical protein +FIG00602459 Predicted beta-glucoside-regulated ABC transport system, sugar-binding protein +FIG00602464 FIG00602465: hypothetical protein +FIG00602466 FIG00602467: hypothetical protein +FIG00602467 FIG00602469: hypothetical protein +FIG00602470 FIG00602474: hypothetical protein +FIG00602474 FIG00602475: hypothetical protein +FIG00602477 FIG00602479: hypothetical protein +FIG00602479 FIG00602483: hypothetical protein +FIG00602487 FIG00602488: hypothetical protein +FIG00602494 FIG00602496: hypothetical protein +FIG00602496 FIG00602499: hypothetical protein +FIG00602499 FIG00602501: hypothetical protein +FIG00602509 FIG00602510: hypothetical protein +FIG00602510 FIG00602511: hypothetical protein +FIG00602511 FIG00602512: hypothetical protein +FIG00602512 FIG00602514: hypothetical protein +FIG00602518 FIG00602519: hypothetical protein +FIG00602519 type I secretion membrane fusion protein, HlyD family +FIG00602523 FIG00602524: hypothetical protein +FIG00602525 FIG00602528: hypothetical protein +FIG00602531 FIG00602532: hypothetical protein +FIG00602532 FIG00602533: hypothetical protein +FIG00602533 FIG00602534: hypothetical protein +FIG00602534 FIG00602537: hypothetical protein +FIG00602537 Dinitrogenase iron-molybdenum cofactor biosynthesis protein +FIG00602543 Ferritin/ribonucleotide reductase-like protein +FIG00602545 FIG00602546: hypothetical protein +FIG00602546 FIG00602547: hypothetical protein +FIG00602547 FIG00602550: hypothetical protein +FIG00602551 FIG00602552: hypothetical protein +FIG00602552 FIG00602555: hypothetical protein +FIG00602556 FIG00602557: hypothetical protein +FIG00602563 FIG00602567: hypothetical protein +FIG00602567 FIG00602568: hypothetical protein +FIG00602568 FIG00602569: hypothetical protein +FIG00602569 FIG00602570: hypothetical protein +FIG00602570 FIG00602572: hypothetical protein +FIG00602577 FIG00602578: hypothetical protein +FIG00602579 FIG00602581: hypothetical protein +FIG00602581 FIG00602584: hypothetical protein +FIG00602584 FIG00602585: hypothetical protein +FIG00602585 FIG00602589: hypothetical protein +FIG00602592 FIG00602593: hypothetical protein +FIG00602603 FIG00602604: hypothetical protein +FIG00602604 FIG00602605: hypothetical protein +FIG00602607 FIG00602610: hypothetical protein +FIG00602610 FIG00602615: hypothetical protein +FIG00602615 FIG00602618: hypothetical protein +FIG00602618 FIG00602622: hypothetical protein +FIG00602623 FIG00602627: hypothetical protein +FIG00602627 FIG00602628: hypothetical protein +FIG00602632 FIG00602633: hypothetical protein +FIG00602633 dual specificity protein phosphatase +FIG00602634 FIG00602635: hypothetical protein +FIG00602635 FIG00602636: hypothetical protein +FIG00602639 FIG00602643: hypothetical protein +FIG00602643 FIG00602645: hypothetical protein +FIG00602645 FIG00602646: hypothetical protein +FIG00602646 HAD-superfamily hydrolase, subfamily IA, variant 1 +FIG00602647 FIG00602650: hypothetical protein +FIG00602650 FIG00602652: hypothetical protein +FIG00602652 FIG00602654: hypothetical protein +FIG00602654 FIG00602657: hypothetical protein +FIG00602657 FIG00602660: hypothetical protein +FIG00602665 FIG00602666: hypothetical protein +FIG00602670 FIG00602673: hypothetical protein +FIG00602676 FIG00602677: hypothetical protein +FIG00602683 FIG00602685: hypothetical protein +FIG00602685 FIG00602686: hypothetical protein +FIG00602686 FIG00602688: hypothetical protein +FIG00602688 prophage PSPPH06, putative head completion/stabilization protein +FIG00602689 FIG00602690: hypothetical protein +FIG00602690 Response regulator/sensory box/HDIG domain protein +FIG00602691 FIG00602694: hypothetical protein +FIG00602698 FIG00602700: hypothetical protein +FIG00602700 Cell division protein DivIC (FtsB), stabilizes FtsL against RasP cleavage +FIG00602704 FIG00602705: hypothetical protein +FIG00602705 FIG00602706: hypothetical protein +FIG00602706 FIG00602707: hypothetical protein +FIG00602708 FIG00602712: hypothetical protein +FIG00602713 FIG00602714: hypothetical protein +FIG00602714 FIG00602719: hypothetical protein +FIG00602726 FIG00602727: hypothetical protein +FIG00602746 FIG00602748: hypothetical protein +FIG00602748 FIG00602749: hypothetical protein +FIG00602750 FIG00602753: hypothetical protein +FIG00602754 FIG00602756: hypothetical protein +FIG00602756 FIG00602761: hypothetical protein +FIG00602761 FIG00602762: hypothetical protein +FIG00602763 FIG00602765: hypothetical protein +FIG00602777 bacteriophage DNA transposition B protein +FIG00602786 FIG00602787: hypothetical protein +FIG00602787 FIG00602788: hypothetical protein +FIG00602789 FIG00602793: hypothetical protein +FIG00602793 oligopeptide/dipeptide ABC transporter, periplasmic oligopeptide/dipeptide-binding protein +FIG00602794 FIG00602795: hypothetical protein +FIG00602795 FIG00602798: hypothetical protein +FIG00602798 FIG00602801: hypothetical protein +FIG00602801 FIG00602804: hypothetical protein +FIG00602804 FIG00602805: hypothetical protein +FIG00602809 FIG00602813: hypothetical protein +FIG00602815 Glutamate synthase small subunit gltD +FIG00602820 FIG00602823: hypothetical protein +FIG00602823 FIG00602825: hypothetical protein +FIG00602825 FIG00602826: hypothetical protein +FIG00602826 FIG00602827: hypothetical protein +FIG00602827 FIG00602828: hypothetical protein +FIG00602831 FIG00602832: hypothetical protein +FIG00602833 FIG00602835: hypothetical protein +FIG00602836 FIG00602840: hypothetical protein +FIG00602841 FIG00602843: hypothetical protein +FIG00602850 FIG00602851: hypothetical protein +FIG00602856 FIG00602857: hypothetical protein +FIG00602861 FIG00602866: hypothetical protein +FIG00602866 FIG00602868: hypothetical protein +FIG00602871 FIG00602873: hypothetical protein +FIG00602879 TPR domain protein/response regulator receiver domain protein +FIG00602886 FIG00602888: hypothetical protein +FIG00602888 FIG00602890: hypothetical protein +FIG00602890 FIG00602891: hypothetical protein +FIG00602891 FIG00602894: hypothetical protein +FIG00602894 FIG00602895: hypothetical protein +FIG00602895 FIG00602897: hypothetical protein +FIG00602897 FIG00602898: hypothetical protein +FIG00602906 FIG00602907: hypothetical protein +FIG00602907 FIG00602910: hypothetical protein +FIG00602910 FIG00602911: hypothetical protein +FIG00602916 FIG00602919: hypothetical protein +FIG00602923 FIG00602927: hypothetical protein +FIG00602928 FIG00602933: hypothetical protein +FIG00602933 FIG00602934: hypothetical protein +FIG00602934 FIG00602935: hypothetical protein +FIG00602938 FIG00602940: hypothetical protein +FIG00602940 FIG00602944: hypothetical protein +FIG00602944 FIG00602945: hypothetical protein +FIG00602945 2 TMS, 152aa hypothetical protein: FIG00602948 +FIG00602948 FIG00602950: hypothetical protein +FIG00602950 FIG00602955: hypothetical protein +FIG00602958 FIG00602960: hypothetical protein +FIG00602962 FIG00602963: hypothetical protein +FIG00602968 High-molecular-weight cytochrome c precursor +FIG00602974 FIG00602975: hypothetical protein +FIG00602976 FIG00602978: hypothetical protein +FIG00602978 response regulator/sensory box/GGDEF domain/EAL domain protein +FIG00602982 FIG00602983: hypothetical protein +FIG00602984 FIG00602987: hypothetical protein +FIG00602988 FIG00602991: hypothetical protein +FIG00602994 Predicted glycolate dehydrogenase, 2-subunit type (EC 1.1.99.14), iron-sulfur subunit GlcF +FIG00602997 FIG00602998: hypothetical protein +FIG00603001 phage tail protein +FIG00603007 FIG00603009: hypothetical protein +FIG00603013 decarboxylase family protein +FIG00603022 Adenine-specific DNA methylase +FIG00603026 FIG00603028: hypothetical protein +FIG00603028 methyl-accepting chemotaxis sensory transducer +FIG00603029 Gll2178 protein +FIG00603030 membrane protein, HPP family +FIG00603031 FIG00603040: hypothetical protein +FIG00603041 FIG00603045: hypothetical protein +FIG00603045 ABC transporter, substrate-binding protein, aliphatic sulphonates +FIG00603047 FIG00603052: hypothetical protein +FIG00603052 FIG00603054: hypothetical protein +FIG00603054 FIG00603055: hypothetical protein +FIG00603061 FIG00603063: hypothetical protein +FIG00603063 FIG00603064: hypothetical protein +FIG00603064 FIG00603065: hypothetical protein +FIG00603073 FIG00603078: hypothetical protein +FIG00603083 FIG00603085: hypothetical protein +FIG00603089 FIG00603090: hypothetical protein +FIG00603090 FIG00603091: hypothetical protein +FIG00603091 protein of unknown function DUF88 +FIG00603099 COG0664: cAMP-binding proteins - catabolite gene activator and regulatory subunit of cAMP-dependent protein kinases +FIG00603115 FIG00603116: hypothetical protein +FIG00603116 FIG00603117: hypothetical protein +FIG00603117 NADH ubiquinone oxidoreductase 20 kDa subunit +FIG00603120 FIG00603123: hypothetical protein +FIG00603129 FIG00603130: hypothetical protein +FIG00603132 FIG00603135: hypothetical protein +FIG00603135 histidine kinase +FIG00603138 FIG00603141: hypothetical protein +FIG00603141 FIG00603142: hypothetical protein +FIG00603143 FIG00603145: hypothetical protein +FIG00603145 FIG00603148: hypothetical protein +FIG00603151 FIG00603156: hypothetical protein +FIG00603172 FIG00603177: hypothetical protein +FIG00603179 FIG00603182: hypothetical protein +FIG00603182 FIG00603183: hypothetical protein +FIG00603183 FIG00603184: hypothetical protein +FIG00603184 FIG00603186: hypothetical protein +FIG00603187 FIG00603189: hypothetical protein +FIG00603191 FIG00603192: hypothetical protein +FIG00603199 FIG00603201: hypothetical protein +FIG00603201 FIG00603203: hypothetical protein +FIG00603214 FIG00603216: hypothetical protein +FIG00603216 Spore coat polysaccharide biosynthesis protein spsC +FIG00603217 FIG00603220: hypothetical protein +FIG00603222 FIG00603224: hypothetical protein +FIG00603224 FIG00603225: hypothetical protein +FIG00603227 FIG00603232: hypothetical protein +FIG00603232 FIG00603233: hypothetical protein +FIG00603233 FIG00603236: hypothetical protein +FIG00603236 FIG00603237: hypothetical protein +FIG00603238 FIG00603239: hypothetical protein +FIG00603239 FIG00603242: hypothetical protein +FIG00603245 FIG00603247: hypothetical protein +FIG00603247 FIG00603248: hypothetical protein +FIG00603248 FIG00603251: hypothetical protein +FIG00603251 FIG00603252: hypothetical protein +FIG00603263 FIG00603264: hypothetical protein +FIG00603264 FIG00603265: hypothetical protein +FIG00603266 FIG00603270: hypothetical protein +FIG00603271 FIG00603273: hypothetical protein +FIG00603278 Phage baseplate assembly protein W-like +FIG00603279 FIG00603280: hypothetical protein +FIG00603281 membrane protein, Bmp family +FIG00603283 FIG00603286: hypothetical protein +FIG00603286 FIG00603287: hypothetical protein +FIG00603291 FIG00603293: hypothetical protein +FIG00603293 FIG00603294: hypothetical protein +FIG00603294 FIG00603296: hypothetical protein +FIG00603296 FIG00603299: hypothetical protein +FIG00603299 FIG00603300: hypothetical protein +FIG00603301 FIG00603303: hypothetical protein +FIG00603306 FIG00603307: hypothetical protein +FIG00603311 FIG00603312: hypothetical protein +FIG00603318 FIG00603320: hypothetical protein +FIG00603320 transglycosylase SLT domain protein +FIG00603323 FIG00603325: hypothetical protein +FIG00603325 FIG00603326: hypothetical protein +FIG00603326 FIG00603330: hypothetical protein +FIG00603330 FIG00603331: hypothetical protein +FIG00603331 type I secretion outer membrane protein, TolC family +FIG00603332 putative sulfonate/nitrate transport system substrate-binding protein +FIG00603338 FIG00603340: hypothetical protein +FIG00603340 FIG00603341: hypothetical protein +FIG00603342 FIG00603347: hypothetical protein +FIG00603347 FIG00603348: hypothetical protein +FIG00603349 FIG00603351: hypothetical protein +FIG00603351 FIG00603358: hypothetical protein +FIG00603368 FIG00603374: hypothetical protein +FIG00603374 FIG00603378: hypothetical protein +FIG00603381 FAD-dependent pyridine nucleotide-disulphide oxidoreductase +FIG00603387 FIG00603390: hypothetical protein +FIG00603391 FIG00603395: hypothetical protein +FIG00603406 FIG00603409: hypothetical protein +FIG00603409 FIG00603411: hypothetical protein +FIG00603411 FIG00603412: hypothetical protein +FIG00603412 FIG00603413: hypothetical protein +FIG00603417 FIG00603419: hypothetical protein +FIG00603419 FIG00603421: hypothetical protein +FIG00603421 FIG00603422: hypothetical protein +FIG00603423 FIG00603425: hypothetical protein +FIG00603425 FIG00603428: hypothetical protein +FIG00603429 FIG00603432: hypothetical protein +FIG00603432 FIG00603436: hypothetical protein +FIG00603437 FIG00603439: hypothetical protein +FIG00603439 FIG00603442: hypothetical protein +FIG00603442 FIG00603444: hypothetical protein +FIG00603444 FIG00603451: hypothetical protein +FIG00603460 Homocitrate synthase 1 (EC 2.3.3.14) +FIG00603462 FIG00603463: hypothetical protein +FIG00603463 FIG00603464: hypothetical protein +FIG00603464 FIG00603465: hypothetical protein +FIG00603472 FIG00603477: hypothetical protein +FIG00603477 FIG00603480: hypothetical protein +FIG00603481 FIG00603483: hypothetical protein +FIG00603486 FIG00603488: hypothetical protein +FIG00603488 peptidase, M18 family +FIG00603489 FIG00603503: hypothetical protein +FIG00603503 FIG00603504: hypothetical protein +FIG00603504 FIG00603510: hypothetical protein +FIG00603510 FIG00603512: hypothetical protein +FIG00603512 FIG00603513: hypothetical protein +FIG00603516 FIG00603522: hypothetical protein +FIG00603522 HD domain/sensory box protein +FIG00603528 FIG00603530: hypothetical protein +FIG00603530 FIG00603532: hypothetical protein +FIG00603537 FIG00603544: hypothetical protein +FIG00603544 FIG00603545: hypothetical protein +FIG00603549 FIG00603551: hypothetical protein +FIG00603551 FIG00603552: hypothetical protein +FIG00603559 FIG00603560: hypothetical protein +FIG00603560 FIG00603562: hypothetical protein +FIG00603562 FIG00603565: hypothetical protein +FIG00603565 FIG00603567: hypothetical protein +FIG00603567 FIG00603570: hypothetical protein +FIG00603570 FIG00603574: hypothetical protein +FIG00603574 FIG00603577: hypothetical protein +FIG00603577 FIG00603580: hypothetical protein +FIG00603580 FIG00603581: hypothetical protein +FIG00603581 RlpA-like protein precursor +FIG00603585 mce related protein +FIG00603587 FIG00603588: hypothetical protein +FIG00603588 FIG00603589: hypothetical protein +FIG00603589 FIG00603590: hypothetical protein +FIG00603595 FIG00603598: hypothetical protein +FIG00603598 FIG00603599: hypothetical protein +FIG00603599 FIG00603600: hypothetical protein +FIG00603600 FIG00603603: hypothetical protein +FIG00603610 FIG00603611: hypothetical protein +FIG00603612 FIG00603613: hypothetical protein +FIG00603613 SENSORY PROTEIN, CONTAINING EAL-DOMAIN +FIG00603618 FIG00603620: hypothetical protein +FIG00603621 FIG00603624: hypothetical protein +FIG00603624 FIG00603625: hypothetical protein +FIG00603625 FIG00603626: hypothetical protein +FIG00603630 FIG00603631: hypothetical protein +FIG00603638 FIG00603639: hypothetical protein +FIG00603639 FIG00603644: hypothetical protein +FIG00603646 Multidrug resistance efflux pump-like +FIG00603651 FIG00603652: hypothetical protein +FIG00603652 FIG00603654: hypothetical protein +FIG00603654 FIG00603657: hypothetical protein +FIG00603657 FIG00603661: hypothetical protein +FIG00603663 FIG00603665: hypothetical protein +FIG00603665 FIG00603666: hypothetical protein +FIG00603668 FIG00603671: hypothetical protein +FIG00603672 FIG00603677: hypothetical protein +FIG00603677 FIG00603681: hypothetical protein +FIG00603681 FIG00603683: hypothetical protein +FIG00603684 FIG00603688: hypothetical protein +FIG00603700 FIG00603701: hypothetical protein +FIG00603709 FIG00603711: hypothetical protein +FIG00603711 FIG00603713: hypothetical protein +FIG00603713 FIG00603714: hypothetical protein +FIG00603714 FIG00603716: hypothetical protein +FIG00603716 FIG00603717: hypothetical protein +FIG00603717 FIG00603719: hypothetical protein +FIG00603719 FIG00603721: hypothetical protein +FIG00603721 FIG00603724: hypothetical protein +FIG00603738 FIG00603741: hypothetical protein +FIG00603741 FIG00603742: hypothetical protein +FIG00603743 FIG00603746: hypothetical protein +FIG00603746 secretion protein HlyD family protein +FIG00603754 FIG00603758: hypothetical protein +FIG00603762 FIG00603764: hypothetical protein +FIG00603766 FIG00603768: hypothetical protein +FIG00603768 FIG00603770: hypothetical protein +FIG00603782 FIG00603784: hypothetical protein +FIG00603784 FIG00603786: hypothetical protein +FIG00603786 FIG00603787: hypothetical protein +FIG00603787 FIG00603788: hypothetical protein +FIG00603790 FIG00603791: hypothetical protein +FIG00603792 FIG00603794: hypothetical protein +FIG00603794 FIG00603796: hypothetical protein +FIG00603798 FIG00603800: hypothetical protein +FIG00603802 FIG00603805: hypothetical protein +FIG00603809 FIG00603811: hypothetical protein +FIG00603817 FIG00603818: hypothetical protein +FIG00603818 FIG00603821: hypothetical protein +FIG00603827 FIG00603831: hypothetical protein +FIG00603842 FIG00603845: hypothetical protein +FIG00603847 Smr family protein +FIG00603850 FIG00603852: hypothetical protein +FIG00603852 FIG00603853: hypothetical protein +FIG00603853 FIG00603855: hypothetical protein +FIG00603855 FIG00603857: hypothetical protein +FIG00603857 FIG00603860: hypothetical protein +FIG00603868 FIG00603869: hypothetical protein +FIG00603873 FIG00603876: hypothetical protein +FIG00603879 FIG00603886: hypothetical protein +FIG00603896 FIG00603898: hypothetical protein +FIG00603903 FIG00603907: hypothetical protein +FIG00603917 FIG00603920: hypothetical protein +FIG00603920 FIG00603923: hypothetical protein +FIG00603925 FIG00603930: hypothetical protein +FIG00603930 FIG00603933: hypothetical protein +FIG00603934 FIG00603935: hypothetical protein +FIG00603935 FIG00603938: hypothetical protein +FIG00603942 FIG00603945: hypothetical protein +FIG00603945 FIG00603947: hypothetical protein +FIG00603952 FIG00603953: hypothetical protein +FIG00603953 FIG00603954: hypothetical protein +FIG00603954 FIG00603958: hypothetical protein +FIG00603959 FIG00603964: hypothetical protein +FIG00603964 FIG00603968: hypothetical protein +FIG00603970 FIG00603972: hypothetical protein +FIG00603972 FIG00603975: hypothetical protein +FIG00603979 PP-loop domain protein +FIG00603980 FIG00603983: hypothetical protein +FIG00603983 FIG00603987: hypothetical protein +FIG00603987 FIG00603989: hypothetical protein +FIG00603989 FIG00603997: hypothetical protein +FIG00603997 FIG00603998: hypothetical protein +FIG00603998 FIG00603999: hypothetical protein +FIG00604003 FIG00604006: hypothetical protein +FIG00604006 FIG00604007: hypothetical protein +FIG00604013 FIG00604016: hypothetical protein +FIG00604016 FIG00604017: hypothetical protein +FIG00604017 FIG00604019: hypothetical protein +FIG00604019 FIG00604020: hypothetical protein +FIG00604020 FIG00604021: hypothetical protein +FIG00604021 FIG00604023: hypothetical protein +FIG00604026 FIG00604030: hypothetical protein +FIG00604035 FIG00604037: hypothetical protein +FIG00604037 FIG00604038: hypothetical protein +FIG00604041 FIG00604042: hypothetical protein +FIG00604046 FIG00604047: hypothetical protein +FIG00604051 FIG00604053: hypothetical protein +FIG00604053 FIG00604054: hypothetical protein +FIG00604059 FIG00604061: hypothetical protein +FIG00604061 tail fiber protein, putative +FIG00604076 FIG00604078: hypothetical protein +FIG00604094 phage tail tape measure protein, TP901 family +FIG00604097 FIG00604098: hypothetical protein +FIG00604099 FIG00604100: hypothetical protein +FIG00604102 putative transcriptional regulator, Fis family +FIG00604104 FIG00604110: hypothetical protein +FIG00604115 FIG00604116: hypothetical protein +FIG00604116 FIG00604117: hypothetical protein +FIG00604123 FIG00604124: hypothetical protein +FIG00604124 FIG00604129: hypothetical protein +FIG00604129 FIG00604131: hypothetical protein +FIG00604139 FIG00604141: hypothetical protein +FIG00604141 FIG00604147: hypothetical protein +FIG00604151 VacJ family lipoprotein +FIG00604152 FIG00604154: hypothetical protein +FIG00604157 FIG00604158: hypothetical protein +FIG00604158 FIG00604159: hypothetical protein +FIG00604159 FIG00604161: hypothetical protein +FIG00604162 FIG00604164: hypothetical protein +FIG00604164 Chemotaxis protein cheV (EC 2.7.3.-) +FIG00604166 FIG00604170: hypothetical protein +FIG00604171 FIG00604174: hypothetical protein +FIG00604176 FIG00604187: hypothetical protein +FIG00604187 FIG00604193: hypothetical protein +FIG00604193 FIG00604195: hypothetical protein +FIG00604199 FIG00604201: hypothetical protein +FIG00604201 FIG00604208: hypothetical protein +FIG00604208 FIG00604211: hypothetical protein +FIG00604211 FIG00604212: hypothetical protein +FIG00604215 Sensory box sensor histidine kinase/response regulator +FIG00604219 FIG00604223: hypothetical protein +FIG00604230 FIG00604231: hypothetical protein +FIG00604231 FIG00604232: hypothetical protein +FIG00604251 amino acid ABC transporter, permease protein, His/Glu/Gln/Arg/opine family +FIG00604253 FIG00604256: hypothetical protein +FIG00604256 FIG00604257: hypothetical protein +FIG00604257 FIG00604258: hypothetical protein +FIG00604258 FIG00604259: hypothetical protein +FIG00604259 FIG00604268: hypothetical protein +FIG00604269 FIG00604273: hypothetical protein +FIG00604273 FIG00604275: hypothetical protein +FIG00604275 FIG00604278: hypothetical protein +FIG00604278 FIG00604279: hypothetical protein +FIG00604288 FIG00515214: hypothetical protein +FIG00604295 FIG00604296: hypothetical protein +FIG00604296 FIG00604299: hypothetical protein +FIG00604299 FIG00604300: hypothetical protein +FIG00604305 FIG00604308: hypothetical protein +FIG00604308 Protein of unknown function DUF676, hydrolase domain protein +FIG00604313 FIG00604315: hypothetical protein +FIG00604315 FIG00604317: hypothetical protein +FIG00604318 FIG00604319: hypothetical protein +FIG00604322 FIG00604324: hypothetical protein +FIG00604327 FIG00604331: hypothetical protein +FIG00604332 FIG00604333: hypothetical protein +FIG00604336 FIG00604337: hypothetical protein +FIG00604337 FIG00604339: hypothetical protein +FIG00604365 FIG00604372: hypothetical protein +FIG00604372 FIG00604373: hypothetical protein +FIG00604373 FIG00604374: hypothetical protein +FIG00604374 FIG00604375: hypothetical protein +FIG00604375 Transmembrane protein co-occuring with sulfite exporter TauE/SafE +FIG00604376 FIG00604377: hypothetical protein +FIG00604379 FIG00604388: hypothetical protein +FIG00604393 transcriptional regulator, PadR-like family +FIG00604397 FIG00604399: hypothetical protein +FIG00604410 FIG00604413: hypothetical protein +FIG00604415 FIG00604416: hypothetical protein +FIG00604418 FIG00604422: hypothetical protein +FIG00604422 FIG00604423: hypothetical protein +FIG00604423 FIG00604426: hypothetical protein +FIG00604432 FIG00604439: hypothetical protein +FIG00604439 FIG00604440: hypothetical protein +FIG00604440 FIG00604441: hypothetical protein +FIG00604450 FIG00604452: hypothetical protein +FIG00604459 FIG00604460: hypothetical protein +FIG00604460 FIG00604461: hypothetical protein +FIG00604468 FIG00604473: hypothetical protein +FIG00604474 FIG00604476: hypothetical protein +FIG00604476 putative nimA protein +FIG00604477 FIG00604478: hypothetical protein +FIG00604478 FIG00604480: hypothetical protein +FIG00604480 FIG00604486: hypothetical protein +FIG00604501 FIG00604504: hypothetical protein +FIG00604509 multi-sensor signal transduction histidine kinase +FIG00604510 FIG00604511: hypothetical protein +FIG00604514 FIG00604515: hypothetical protein +FIG00604518 FIG00604520: hypothetical protein +FIG00604534 FIG00604537: hypothetical protein +FIG00604537 peptidase S24, S26A and S26B +FIG00604538 FIG00604539: hypothetical protein +FIG00604539 FIG00604549: hypothetical protein +FIG00604561 FIG00604564: hypothetical protein +FIG00604564 FIG00604567: hypothetical protein +FIG00604567 FIG00604568: hypothetical protein +FIG00604568 FIG00604570: hypothetical protein +FIG00604570 FIG00604571: hypothetical protein +FIG00604576 FIG00604581: hypothetical protein +FIG00604581 FIG00604583: hypothetical protein +FIG00604583 FIG00604587: hypothetical protein +FIG00604592 FIG00604593: hypothetical protein +FIG00604593 FIG00604595: hypothetical protein +FIG00604595 FIG00604597: hypothetical protein +FIG00604600 FIG00604602: hypothetical protein +FIG00604603 FIG00604604: hypothetical protein +FIG00604604 FIG00604608: hypothetical protein +FIG00604608 FIG00604611: hypothetical protein +FIG00604611 FIG00604612: hypothetical protein +FIG00604617 FIG00604618: hypothetical protein +FIG00604622 sensor histidine kinase/response regulator( EC:2.7.3.- ) +FIG00604626 magnesium transporter +FIG00604634 FIG00604635: hypothetical protein +FIG00604635 FIG00604636: hypothetical protein +FIG00604638 FIG00604639: hypothetical protein +FIG00604647 FIG00604648: hypothetical protein +FIG00604649 ATP-utilizing enzymes of the PP-loop superfamily +FIG00604651 FIG00604652: hypothetical protein +FIG00604652 FIG00604653: hypothetical protein +FIG00604653 FIG00604654: hypothetical protein +FIG00604663 FIG00604665: hypothetical protein +FIG00604674 FIG00604675: hypothetical protein +FIG00604675 ABC-type transport system involved in resistance to organic solvents periplasmic component-like +FIG00604678 FIG00604679: hypothetical protein +FIG00604679 FIG00604682: hypothetical protein +FIG00604682 FIG00604687: hypothetical protein +FIG00604691 FIG00604693: hypothetical protein +FIG00604693 FIG00604696: hypothetical protein +FIG00604698 FIG00604700: hypothetical protein +FIG00604708 FIG00604709: hypothetical protein +FIG00604715 FIG00604719: hypothetical protein +FIG00604720 FIG00604721: hypothetical protein +FIG00604721 FIG00604725: hypothetical protein +FIG00604733 FIG00604738: hypothetical protein +FIG00604738 FIG00604739: hypothetical protein +FIG00604739 FIG00604742: hypothetical protein +FIG00604742 FIG00604743: hypothetical protein +FIG00604743 FIG00604744: hypothetical protein +FIG00604745 FIG00604746: hypothetical protein +FIG00604750 FIG00604753: hypothetical protein +FIG00604757 Glycosyltransferases probably involved in cell wall biogenesis-like +FIG00604762 FIG00604763: hypothetical protein +FIG00604763 FIG00604768: hypothetical protein +FIG00604779 FIG00604780: hypothetical protein +FIG00604782 FIG00604783: hypothetical protein +FIG00604783 FIG00604787: hypothetical protein +FIG00604788 FIG00604790: hypothetical protein +FIG00604790 FIG00604791: hypothetical protein +FIG00604797 FIG00604798: hypothetical protein +FIG00604798 FIG00604799: hypothetical protein +FIG00604799 FIG00604801: hypothetical protein +FIG00604801 FIG00604804: hypothetical protein +FIG00604804 FIG00604811: hypothetical protein +FIG00604815 FIG00604818: hypothetical protein +FIG00604818 FIG00604819: hypothetical protein +FIG00604819 FIG00604822: hypothetical protein +FIG00604822 FIG00604831: hypothetical protein +FIG00604834 FIG00604842: hypothetical protein +FIG00604843 FIG00604845: hypothetical protein +FIG00604845 FIG00604847: hypothetical protein +FIG00604851 FIG00604852: hypothetical protein +FIG00604852 FIG00604853: hypothetical protein +FIG00604855 FIG00604857: hypothetical protein +FIG00604857 FIG00604858: hypothetical protein +FIG00604865 FIG00604866: hypothetical protein +FIG00604866 FIG00604868: hypothetical protein +FIG00604869 similar to 2-hydroxyglutaryl-CoA dehydratase, alpha subunit +FIG00604880 iron-sulfur cluster-binding protein, putative +FIG00604881 FIG00604882: hypothetical protein +FIG00604882 COG1280: Putative threonine efflux protein +FIG00604886 FIG00604893: hypothetical protein +FIG00604902 FIG00604903: hypothetical protein +FIG00604910 FIG00604915: hypothetical protein +FIG00604915 FIG00604916: hypothetical protein +FIG00604916 FIG00604917: hypothetical protein +FIG00604918 FIG00604922: hypothetical protein +FIG00604922 FIG00604924: hypothetical protein +FIG00604924 FIG00604927: hypothetical protein +FIG00604927 FIG00604929: hypothetical protein +FIG00604929 FIG00604932: hypothetical protein +FIG00604942 amidohydrolase family protein +FIG00604949 FIG00604952: hypothetical protein +FIG00604952 FIG00604953: hypothetical protein +FIG00604957 FIG00604958: hypothetical protein +FIG00604958 FIG00604961: hypothetical protein +FIG00604961 FIG00604967: hypothetical protein +FIG00604968 FIG00604970: hypothetical protein +FIG00604970 FIG00604972: hypothetical protein +FIG00604972 Sensor histidine kinase / response regulator +FIG00604976 FIG00604982: hypothetical protein +FIG00604982 FIG00604987: hypothetical protein +FIG00604987 FIG00604988: hypothetical protein +FIG00604991 FIG00604992: hypothetical protein +FIG00604994 FIG00604996: hypothetical protein +FIG00605010 FIG00605013: hypothetical protein +FIG00605017 Bll4887 protein +FIG00605021 FIG00605025: hypothetical protein +FIG00605025 FIG00605028: hypothetical protein +FIG00605029 FIG00605032: hypothetical protein +FIG00605035 TPR repeat:NB-ARC:Peptidase C14, caspase catalytic subunit p20:Tetratricopeptide TPR_3:Tetratricopeptide TPR_4:Tetratricopeptide TPR_4 +FIG00605045 FIG00605047: hypothetical protein +FIG00605047 FIG00605048: hypothetical protein +FIG00605049 FIG00605053: hypothetical protein +FIG00605053 FIG00605054: hypothetical protein +FIG00605054 FIG00605055: hypothetical protein +FIG00605057 FIG00605059: hypothetical protein +FIG00605063 FIG00605064: hypothetical protein +FIG00605068 FIG00605072: hypothetical protein +FIG00605073 FIG00605076: hypothetical protein +FIG00605076 FIG00605077: hypothetical protein +FIG00605079 FIG00605080: hypothetical protein +FIG00605080 FIG00605086: hypothetical protein +FIG00605089 FIG00605091: hypothetical protein +FIG00605091 FIG00605096: hypothetical protein +FIG00605096 FIG00605097: hypothetical protein +FIG00605097 FIG00605099: hypothetical protein +FIG00605099 FIG00605101: hypothetical protein +FIG00605102 FIG00605106: hypothetical protein +FIG00605106 FIG00605110: hypothetical protein +FIG00605114 FIG00605115: hypothetical protein +FIG00605115 FIG00605118: hypothetical protein +FIG00605118 FIG00605121: hypothetical protein +FIG00605121 FIG00605122: hypothetical protein +FIG00605129 FIG00605132: hypothetical protein +FIG00605135 FIG00605141: hypothetical protein +FIG00605142 FIG00605150: hypothetical protein +FIG00605162 FIG00605165: hypothetical protein +FIG00605165 FIG00605166: hypothetical protein +FIG00605166 FIG00605167: hypothetical protein +FIG00605167 FIG00605168: hypothetical protein +FIG00605176 FIG00605178: hypothetical protein +FIG00605183 FIG00605187: hypothetical protein +FIG00605192 Lead, cadmium, zinc and mercury transporting ATPase (EC 3.6.3.3) (EC 3.6.3.5); Copper-translocating P-type ATPase (EC 3.6.3.4); FUPA32 P-type ATPase +FIG00605198 FIG00605200: hypothetical protein +FIG00605200 FIG00605204: hypothetical protein +FIG00605205 FIG00605213: hypothetical protein +FIG00605220 efflux protein, LysE family +FIG00605221 FIG00605225: hypothetical protein +FIG00605227 FIG00605230: hypothetical protein +FIG00605232 FIG00605234: hypothetical protein +FIG00605246 FIG00605247: hypothetical protein +FIG00605252 FIG00605256: hypothetical protein +FIG00605256 FIG00605257: hypothetical protein +FIG00605258 FIG00605261: hypothetical protein +FIG00605266 FIG00605275: hypothetical protein +FIG00605276 FIG00605285: hypothetical protein +FIG00605285 FIG00605289: hypothetical protein +FIG00605289 FIG00605292: hypothetical protein +FIG00605292 FIG00605300: hypothetical protein +FIG00605300 FIG00605301: hypothetical protein +FIG00605301 FIG00605305: hypothetical protein +FIG00605305 FIG00605309: hypothetical protein +FIG00605309 FIG00605313: hypothetical protein +FIG00605320 protein of unknown function DUF330 +FIG00605323 FIG00605326: hypothetical protein +FIG00605340 FIG00605343: hypothetical protein +FIG00605343 FIG00605346: hypothetical protein +FIG00605348 Phage lytic murein transglycosylase +FIG00605355 FIG00605359: hypothetical protein +FIG00605362 FIG00605366: hypothetical protein +FIG00605369 Werner syndrome helicase homolog +FIG00605370 FIG00605372: hypothetical protein +FIG00605373 ERCC4-type nuclease +FIG00605377 FIG00605380: hypothetical protein +FIG00605381 FIG00605383: hypothetical protein +FIG00605398 FIG00605399: hypothetical protein +FIG00605399 FIG00605400: hypothetical protein +FIG00605409 FIG00605413: hypothetical protein +FIG00605413 FIG00605415: hypothetical protein +FIG00605415 FIG00605417: hypothetical protein +FIG00605417 FIG00605418: hypothetical protein +FIG00605421 FIG00605422: hypothetical protein +FIG00605422 FIG00605424: hypothetical protein +FIG00605435 FIG00605436: hypothetical protein +FIG00605436 FIG00605441: hypothetical protein +FIG00605441 FIG00605443: hypothetical protein +FIG00605456 FIG00605460: hypothetical protein +FIG00605466 FIG00605467: hypothetical protein +FIG00605467 FIG00605471: hypothetical protein +FIG00605471 FIG00605472: hypothetical protein +FIG00605481 FIG00605483: hypothetical protein +FIG00605483 FIG00605486: hypothetical protein +FIG00605490 FIG00605495: hypothetical protein +FIG00605508 FIG00605509: hypothetical protein +FIG00605513 FIG00605515: hypothetical protein +FIG00605515 FIG00605516: hypothetical protein +FIG00605516 FIG00605523: hypothetical protein +FIG00605528 FIG00605531: hypothetical protein +FIG00605535 FIG00605536: hypothetical protein +FIG00605536 FIG00605539: hypothetical protein +FIG00605539 FIG00605549: hypothetical protein +FIG00605549 FIG00605550: hypothetical protein +FIG00605552 FIG00605553: hypothetical protein +FIG00605554 FIG00605555: hypothetical protein +FIG00605557 FIG00605558: hypothetical protein +FIG00605558 FIG00605559: hypothetical protein +FIG00605559 FIG00605560: hypothetical protein +FIG00605560 FIG00605561: hypothetical protein +FIG00605561 FIG00605563: hypothetical protein +FIG00605563 FIG00605567: hypothetical protein +FIG00605576 FIG00605577: hypothetical protein +FIG00605577 Zn-ribbon-containing, possibly RNA-binding protein and truncated derivatives +FIG00605589 FIG00605590: hypothetical protein +FIG00605591 FIG00605593: hypothetical protein +FIG00605593 FIG00605595: hypothetical protein +FIG00605622 FIG00605629: hypothetical protein +FIG00605639 FIG00605640: hypothetical protein +FIG00605640 helix-turn-helix protein, CopG family +FIG00605643 FIG00605644: hypothetical protein +FIG00605644 FIG00605648: hypothetical protein +FIG00605657 FIG00605659: hypothetical protein +FIG00605659 oligopeptide/dipeptide ABC transporter, permease protein +FIG00605663 FIG00605665: hypothetical protein +FIG00605665 FIG00605666: hypothetical protein +FIG00605666 FIG00605667: hypothetical protein +FIG00605669 FIG00605671: hypothetical protein +FIG00605671 Phage protein D +FIG00605673 FIG00605674: hypothetical protein +FIG00605674 FIG00605677: hypothetical protein +FIG00605681 FIG00605688: hypothetical protein +FIG00605693 FIG00605698: hypothetical protein +FIG00605705 FIG00605709: hypothetical protein +FIG00605709 FIG00605710: hypothetical protein +FIG00605718 FIG00605719: hypothetical protein +FIG00605719 FIG00605721: hypothetical protein +FIG00605721 FIG00605722: hypothetical protein +FIG00605722 FIG00605726: hypothetical protein +FIG00605726 FIG00605727: hypothetical protein +FIG00605749 FIG00605750: hypothetical protein +FIG00605750 FIG00605752: hypothetical protein +FIG00605752 FIG00605754: hypothetical protein +FIG00605754 FIG00605760: hypothetical protein +FIG00605760 FIG00605764: hypothetical protein +FIG00605764 FIG00605767: hypothetical protein +FIG00605767 FIG00605768: hypothetical protein +FIG00605768 FIG00605774: hypothetical protein +FIG00605777 FIG00605778: hypothetical protein +FIG00605780 FIG00605781: hypothetical protein +FIG00605787 FIG00605795: hypothetical protein +FIG00605795 FIG00605798: hypothetical protein +FIG00605798 glucose transport system permease protein +FIG00605799 FIG00605800: hypothetical protein +FIG00605809 FIG00605810: hypothetical protein +FIG00605810 FIG00605813: hypothetical protein +FIG00605816 FIG00605822: hypothetical protein +FIG00605822 Sensor protein lytS (EC 2.7.13.3) +FIG00605836 phenylacetate-coenzyme A ligase, putative +FIG00605843 Protein of unknown function DUF140 +FIG00605846 FIG00605849: hypothetical protein +FIG00605853 FIG00605855: hypothetical protein +FIG00605855 FIG00605856: hypothetical protein +FIG00605856 minor capsid protein C, degenerate +FIG00605860 FIG00605862: hypothetical protein +FIG00605862 FIG00605865: hypothetical protein +FIG00605865 FIG00605867: hypothetical protein +FIG00605867 FIG00605871: hypothetical protein +FIG00605893 FIG00605894: hypothetical protein +FIG00605898 FIG00605902: hypothetical protein +FIG00605910 TRASH +FIG00605927 FIG00605929: hypothetical protein +FIG00605942 FIG00605943: hypothetical protein +FIG00605943 FIG00605949: hypothetical protein +FIG00605959 FIG00605972: hypothetical protein +FIG00605972 FIG00605974: hypothetical protein +FIG00605974 FIG00605976: hypothetical protein +FIG00605976 FIG00605977: hypothetical protein +FIG00605985 FIG00605988: hypothetical protein +FIG00605988 FIG00605990: hypothetical protein +FIG00605990 FIG00605992: hypothetical protein +FIG00605994 Linocin_M18 bacteriocin protein +FIG00606016 FIG00606017: hypothetical protein +FIG00606031 FIG00606033: hypothetical protein +FIG00606053 FIG00606057: hypothetical protein +FIG00606058 FIG00606063: hypothetical protein +FIG00606064 FIG00606065: hypothetical protein +FIG00606068 FIG00606071: hypothetical protein +FIG00606071 FIG00606074: hypothetical protein +FIG00606081 FIG00606085: hypothetical protein +FIG00606087 FIG00606092: hypothetical protein +FIG00606095 DSBA-like thioredoxin domain protein +FIG00606099 FIG00606101: hypothetical protein +FIG00606102 FIG00606106: hypothetical protein +FIG00606115 Alpha amylase domain protein +FIG00606126 FIG00606128: hypothetical protein +FIG00606136 Undecaprenyl-phosphate galactosephosphotransferase( EC:2.7.8.6 ) +FIG00606139 FIG00606141: hypothetical protein +FIG00606141 FIG00606144: hypothetical protein +FIG00606158 FIG00606160: hypothetical protein +FIG00606166 FIG00606168: hypothetical protein +FIG00606171 FIG00606176: hypothetical protein +FIG00606186 FIG00606188: hypothetical protein +FIG00606190 Pyruvoyl-dependent arginine decarboxylase (EC 4.1.1.19) +FIG00606196 FIG00606198: hypothetical protein +FIG00606208 FIG00606209: hypothetical protein +FIG00606215 FIG00606220: hypothetical protein +FIG00606220 FIG00606223: hypothetical protein +FIG00606223 hydrogenase, iron-sulfur cluster-binding subunit, putative +FIG00606230 FIG00606231: hypothetical protein +FIG00606233 FIG00606234: hypothetical protein +FIG00606234 FUPA32 P-type ATPase +FIG00606246 FIG00606248: hypothetical protein +FIG00606248 Flagellar biosynthesis protein FliQ +FIG00606253 FIG00606255: hypothetical protein +FIG00606255 FIG00606259: hypothetical protein +FIG00606261 FIG00606262: hypothetical protein +FIG00606262 Transcriptional regulator, Hth-3 family +FIG00606266 FIG00606267: hypothetical protein +FIG00606273 FIG00606278: hypothetical protein +FIG00606280 FIG00606281: hypothetical protein +FIG00606291 FIG00606292: hypothetical protein +FIG00606292 FIG00606301: hypothetical protein +FIG00606309 FIG00606311: hypothetical protein +FIG00606314 FIG00606315: hypothetical protein +FIG00606315 FIG00606317: hypothetical protein +FIG00606317 FIG00606325: hypothetical protein +FIG00606330 FIG00606332: hypothetical protein +FIG00606332 FIG00606333: hypothetical protein +FIG00606349 FIG00606350: hypothetical protein +FIG00606351 FIG00606354: hypothetical protein +FIG00606364 FIG00606366: hypothetical protein +FIG00606370 FIG00606376: hypothetical protein +FIG00606387 FIG00606388: hypothetical protein +FIG00606388 FIG00606389: hypothetical protein +FIG00606390 FIG00606395: hypothetical protein +FIG00606401 FIG00606402: hypothetical protein +FIG00606419 FIG00606420: hypothetical protein +FIG00606420 FIG00606425: hypothetical protein +FIG00606425 FIG00606428: hypothetical protein +FIG00606439 FIG00606445: hypothetical protein +FIG00606445 FIG00606459: hypothetical protein +FIG00606459 FIG00606465: hypothetical protein +FIG00606465 FIG00606472: hypothetical protein +FIG00606472 FIG00606478: hypothetical protein +FIG00606490 FIG00606495: hypothetical protein +FIG00606495 FIG00606502: hypothetical protein +FIG00606503 FIG00606504: hypothetical protein +FIG00606504 FIG00606506: hypothetical protein +FIG00606506 FIG00606507: hypothetical protein +FIG00606515 FIG00606517: hypothetical protein +FIG00606519 FIG00606522: hypothetical protein +FIG00606539 FIG00606540: hypothetical protein +FIG00606540 FIG00606541: hypothetical protein +FIG00606564 FIG00606565: hypothetical protein +FIG00606589 FIG00606591: hypothetical protein +FIG00606596 FIG00606601: hypothetical protein +FIG00606614 FIG00606616: hypothetical protein +FIG00606618 FIG00606624: hypothetical protein +FIG00606625 FIG00606626: hypothetical protein +FIG00606630 FIG00606631: hypothetical protein +FIG00606636 FIG00606638: hypothetical protein +FIG00606638 FIG00606643: hypothetical protein +FIG00606648 FIG00606650: hypothetical protein +FIG00606673 FIG00606676: hypothetical protein +FIG00606676 FIG00606679: hypothetical protein +FIG00606679 FIG00606683: hypothetical protein +FIG00606689 possible phosphoheptose isomerase +FIG00606691 FIG00606692: hypothetical protein +FIG00606695 FIG00606697: hypothetical protein +FIG00606697 FIG00606701: hypothetical protein +FIG00606705 FIG00606708: hypothetical protein +FIG00606712 FIG00606718: hypothetical protein +FIG00606727 HybA, Fe-S-cluster-containing hydrogenase components 1 homolog +FIG00606734 FIG00606735: hypothetical protein +FIG00606735 FIG00606748: hypothetical protein +FIG00606751 FIG00606753: hypothetical protein +FIG00606753 FIG00606754: hypothetical protein +FIG00606754 FIG00606760: hypothetical protein +FIG00606760 FIG00606762: hypothetical protein +FIG00606766 FIG00606767: hypothetical protein +FIG00606793 FIG00606796: hypothetical protein +FIG00606796 FIG00606799: hypothetical protein +FIG00606801 FIG00606804: hypothetical protein +FIG00606810 FIG00606814: hypothetical protein +FIG00606815 FIG00606816: hypothetical protein +FIG00606832 FIG00606834: hypothetical protein +FIG00606834 FIG00606836: hypothetical protein +FIG00606836 FIG00606838: hypothetical protein +FIG00606838 FIG00606843: hypothetical protein +FIG00606843 Site-specific recombinase XerD-like +FIG00606858 FIG00606859: hypothetical protein +FIG00606870 FIG00606872: hypothetical protein +FIG00606872 FIG00606873: hypothetical protein +FIG00606876 high-molecular-weight cytochrome c +FIG00606901 FIG00606906: hypothetical protein +FIG00606906 FIG00606912: hypothetical protein +FIG00606916 Glutathione synthase/Ribosomal protein S6 modification enzyme (glutaminyl transferase)-like +FIG00606922 anti-anti-sigma regulatory factor, SpoIIAA +FIG00606925 FIG00606938: hypothetical protein +FIG00606947 FIG00606949: hypothetical protein +FIG00606949 FIG00606951: hypothetical protein +FIG00606951 FIG00606953: hypothetical protein +FIG00606953 FIG00606956: hypothetical protein +FIG00606956 FIG00606960: hypothetical protein +FIG00606971 putative 2-phosphosulfolactate phosphatase( EC:3.1.3.71 ) +FIG00606979 FIG00606980: hypothetical protein +FIG00606980 FIG00606986: hypothetical protein +FIG00606990 FIG00606991: hypothetical protein +FIG00606991 FIG00606992: hypothetical protein +FIG00606994 FIG00606995: hypothetical protein +FIG00606998 FIG00607002: hypothetical protein +FIG00607007 FIG00607008: hypothetical protein +FIG00607012 FIG00607013: hypothetical protein +FIG00607022 FIG00607028: hypothetical protein +FIG00607033 phage/plasmid primase, P4 family +FIG00607035 FIG00607036: hypothetical protein +FIG00607036 FIG00607038: hypothetical protein +FIG00607039 NA +FIG00607043 FIG00607045: hypothetical protein +FIG00607045 FIG00607046: hypothetical protein +FIG00607048 FIG00607050: hypothetical protein +FIG00607055 FIG00607057: hypothetical protein +FIG00607058 FIG00607062: hypothetical protein +FIG00607067 FIG00607069: hypothetical protein +FIG00607078 FIG00607082: hypothetical protein +FIG00607089 FIG00607094: hypothetical protein +FIG00607094 FIG00607098: hypothetical protein +FIG00607098 FIG00607101: hypothetical protein +FIG00607102 FIG00607106: hypothetical protein +FIG00607110 hydrogenase (NiFe) small subunit (hydA)( EC:1.12.2.1 ) +FIG00607120 FIG00607122: hypothetical protein +FIG00607123 FIG00607126: hypothetical protein +FIG00607132 FIG00607133: hypothetical protein +FIG00607141 FIG00607143: hypothetical protein +FIG00607143 FIG00607145: hypothetical protein +FIG00607145 FIG00607147: hypothetical protein +FIG00607147 FIG00607148: hypothetical protein +FIG00607151 FIG00607153: hypothetical protein +FIG00607169 FIG00607170: hypothetical protein +FIG00607170 FIG00607171: hypothetical protein +FIG00607176 FIG00607177: hypothetical protein +FIG00607183 FIG00607184: hypothetical protein +FIG00607188 FIG00607190: hypothetical protein +FIG00607190 FIG00607193: hypothetical protein +FIG00607199 FIG00607200: hypothetical protein +FIG00607206 FIG00607207: hypothetical protein +FIG00607208 FIG00607210: hypothetical protein +FIG00607225 branched-chain amino acid binding protein +FIG00607227 FIG00607236: hypothetical protein +FIG00607237 FIG00607238: hypothetical protein +FIG00607238 FIG00607242: hypothetical protein +FIG00607251 FIG00607252: hypothetical protein +FIG00607256 FIG00607258: hypothetical protein +FIG00607262 FIG00607266: hypothetical protein +FIG00607276 FIG00607278: hypothetical protein +FIG00607287 FIG00607288: hypothetical protein +FIG00607295 FIG00607299: hypothetical protein +FIG00607310 FIG00607313: hypothetical protein +FIG00607314 FIG00607315: hypothetical protein +FIG00607315 FIG00607318: hypothetical protein +FIG00607318 1 TMS, 91aa hypothetical protein: FIG00607321 +FIG00607322 FIG00607324: hypothetical protein +FIG00607325 FIG00607330: hypothetical protein +FIG00607330 probable ABC transporter, periplasmic amino acid-binding protein +FIG00607345 FIG00607349: hypothetical protein +FIG00607349 FIG00607354: hypothetical protein +FIG00607366 FIG00607377: hypothetical protein +FIG00607389 FIG00607391: hypothetical protein +FIG00607391 FIG00607392: hypothetical protein +FIG00607393 FIG00607395: hypothetical protein +FIG00607408 FIG00607410: hypothetical protein +FIG00607415 FIG00607416: hypothetical protein +FIG00607425 FIG00607428: hypothetical protein +FIG00607428 ABC transport protein +FIG00607439 FIG00607442: hypothetical protein +FIG00607446 FIG00607460: hypothetical protein +FIG00607467 FIG00607469: hypothetical protein +FIG00607472 multidrug resistance efflux pump-like protein +FIG00607490 FIG00607491: hypothetical protein +FIG00607492 FIG00607493: hypothetical protein +FIG00607497 FIG00607499: hypothetical protein +FIG00607499 FIG00607503: hypothetical protein +FIG00607503 FIG00607504: hypothetical protein +FIG00607504 FIG00607505: hypothetical protein +FIG00607510 FIG00607523: hypothetical protein +FIG00607553 FIG00607561: hypothetical protein +FIG00607561 FIG00607562: hypothetical protein +FIG00607565 FIG00607566: hypothetical protein +FIG00607569 FIG00607570: hypothetical protein +FIG00607577 FIG00607585: hypothetical protein +FIG00607587 ACRIFLAVIN RESISTANCE PROTEIN D +FIG00607605 FIG00607608: hypothetical protein +FIG00607609 FIG00607613: hypothetical protein +FIG00607613 FIG00607621: hypothetical protein +FIG00607621 FIG00607632: hypothetical protein +FIG00607639 FIG00607642: hypothetical protein +FIG00607642 FIG00607645: hypothetical protein +FIG00607648 FIG00607654: hypothetical protein +FIG00607668 FIG00607669: hypothetical protein +FIG00607670 FIG00607671: hypothetical protein +FIG00607671 FIG00607677: hypothetical protein +FIG00607692 FIG00607695: hypothetical protein +FIG00607695 FIG00607697: hypothetical protein +FIG00607704 FIG00607707: hypothetical protein +FIG00607707 FIG00607709: hypothetical protein +FIG00607711 FIG00607715: hypothetical protein +FIG00607715 FIG00607719: hypothetical protein +FIG00607726 FIG00607737: hypothetical protein +FIG00607737 FIG00607738: hypothetical protein +FIG00607745 FIG00607746: hypothetical protein +FIG00607746 FIG00607747: hypothetical protein +FIG00607755 FIG00607763: hypothetical protein +FIG00607771 FIG00607773: hypothetical protein +FIG00607773 FIG00607774: hypothetical protein +FIG00607774 FIG00607775: hypothetical protein +FIG00607828 FIG00607842: hypothetical protein +FIG00607842 FIG00607845: hypothetical protein +FIG00607853 FIG00607854: hypothetical protein +FIG00607866 vanZ-like family protein +FIG00607888 FIG00607890: hypothetical protein +FIG00607893 FIG00607900: hypothetical protein +FIG00607904 FIG00607905: hypothetical protein +FIG00607925 FIG00607926: hypothetical protein +FIG00607926 FIG00607935: hypothetical protein +FIG00607935 FIG00607937: hypothetical protein +FIG00607937 FIG00607939: hypothetical protein +FIG00607949 FIG00607956: hypothetical protein +FIG00607964 FIG00607968: hypothetical protein +FIG00607975 cold-shock protein +FIG00607997 FIG00608000: hypothetical protein +FIG00608008 FIG00608014: hypothetical protein +FIG00608015 FIG00608017: hypothetical protein +FIG00608035 FIG00608038: hypothetical protein +FIG00608038 FIG00608049: hypothetical protein +FIG00608053 FIG00608055: hypothetical protein +FIG00608057 FIG00608060: hypothetical protein +FIG00608087 FIG00608088: hypothetical protein +FIG00608105 FIG00608108: hypothetical protein +FIG00608108 putative succinyltransferase involved in succinoglycan biosynthesis +FIG00608118 FIG00608120: hypothetical protein +FIG00608122 FIG00608124: hypothetical protein +FIG00608128 FIG00608136: hypothetical protein +FIG00608140 FIG00608141: hypothetical protein +FIG00608141 FIG00608142: hypothetical protein +FIG00608155 FIG00608160: hypothetical protein +FIG00608328 Na+/H+ antiporter subunit +FIG00608364 Protein of unknown function DUF1058 +FIG00608414 ribonuclease P protein +FIG00608528 FIG00608533: hypothetical protein +FIG00608588 Peptidoglycan-binding LysM:Peptidase M23B +FIG00608739 ABC-type phosphate/phosphonate transport system periplasmic component-like protein +FIG00608755 putative signal transduction protein +FIG00609052 FIG00609054: hypothetical protein +FIG00609057 FIG00609059: hypothetical protein +FIG00609116 FIG00609132: hypothetical protein +FIG00609176 FIG00609180: hypothetical protein +FIG00609191 FIG00609205: hypothetical protein +FIG00609324 NADH-ubiquinone/plastoquinone oxidoreductase, chain 6 +FIG00609437 polyferredoxin-like protein +FIG00609500 NADH ubiquinone oxidoreductase chain A (EC 1.6.5.3) +FIG00609588 Pyruvate, water dikinase( EC:2.7.9.2 ) +FIG00609745 DNA ligase (ATP) (EC 6.5.1.1) +FIG00609825 FIG00609828: hypothetical protein +FIG00609965 FIG00609972: hypothetical protein +FIG00610128 FIG00610130: hypothetical protein +FIG00610192 triphosphoribosyl-dephospho-CoA protein +FIG00610406 Ankyrin-repeat +FIG00610489 FIG00610492: hypothetical protein +FIG00610664 Tripartite motif protein 3 +FIG00610694 General stress protein 69 +FIG00610786 Lipopolysaccharide core biosynthesis glycosyl transferase lpsD (EC 2.-.-.-) +FIG00610800 Chemotaxis response regulator protein-glutamate methylesterase 3 (EC 3.1.1.61) +FIG00611004 COG3203: Outer membrane protein (porin) +FIG00611026 FIG00611027: hypothetical protein +FIG00611240 FIG00611249: hypothetical protein +FIG00611306 conserved hypothetical protein VrlP +FIG00611561 Metalloendopeptidase +FIG00611618 FIG00611622: hypothetical protein +FIG00611830 FIG00611839: hypothetical protein +FIG00612145 FIG00612187: hypothetical protein +FIG00612337 membrane-like protein +FIG00612678 bacterial extracellular solute-binding family protein +FIG00612995 ABC transport protein, ATP-binding subunit +FIG00612999 Pectate lyase B precursor (EC 4.2.2.2) +FIG00613009 FIG00613010: hypothetical protein +FIG00613015 FIG00613018: hypothetical protein +FIG00613020 Pectate lyase A precursor (EC 4.2.2.2) +FIG00613023 Type-1Ba cytolytic delta-endotoxin +FIG00613025 putative glycosyl transferase family 2( EC:2.- ) +FIG00613026 FIG00613027: hypothetical protein +FIG00613027 FIG00613028: hypothetical protein +FIG00613029 FIG00613032: hypothetical protein +FIG00613034 FIG00613040: hypothetical protein +FIG00613045 putative ABC transporter, permease subunit +FIG00613060 FIG00613062: hypothetical protein +FIG00613066 FIG00613069: hypothetical protein +FIG00613078 FIG00613079: hypothetical protein +FIG00613081 FIG00613082: hypothetical protein +FIG00613086 FIG00613088: hypothetical protein +FIG00613091 Putative ABC sugar transporter +FIG00613092 FIG00613095: hypothetical protein +FIG00613097 FIG00613099: hypothetical protein +FIG00613114 FIG00613115: hypothetical protein +FIG00613116 FIG00613118: hypothetical protein +FIG00613129 FIG00613130: hypothetical protein +FIG00613136 COG0233: Ribosome recycling factor +FIG00613137 Pectate lyase L precursor (EC 4.2.2.2) +FIG00613156 ribonuclease T2 family protein, putative +FIG00613170 FIG00613172: hypothetical protein +FIG00613176 FIG00613177: hypothetical protein +FIG00613177 FIG00613180: hypothetical protein +FIG00613188 FIG00613193: hypothetical protein +FIG00613194 DNA-binding protein H-NS +FIG00613201 FIG00613202: hypothetical protein +FIG00613204 FIG00613206: hypothetical protein +FIG00613210 FIG00613211: hypothetical protein +FIG00613215 FIG00613216: hypothetical protein +FIG00613221 FIG00613225: hypothetical protein +FIG00613225 Probable transcription regulator protein +FIG00613229 FIG00613231: hypothetical protein +FIG00613231 FIG00613233: hypothetical protein +FIG00613234 Citrate/acetate antiporter +FIG00613244 FIG00613245: hypothetical protein +FIG00613249 FIG00613254: hypothetical protein +FIG00613254 FIG00613255: hypothetical protein +FIG00613257 FIG00613258: hypothetical protein +FIG00613264 FIG00613269: hypothetical protein +FIG00613271 FIG00613272: hypothetical protein +FIG00613275 FIG00613276: hypothetical protein +FIG00613284 General secretion pathway protein M (Pectic enzymes secretion protein outM) +FIG00613287 FIG00613290: hypothetical protein +FIG00613302 metallo hydrolase +FIG00613307 D-alanine carrier protein DltC +FIG00613328 FIG00613330: hypothetical protein +FIG00613335 FIG00613337: hypothetical protein +FIG00613337 FIG00613338: hypothetical protein +FIG00613338 FIG00613339: hypothetical protein +FIG00613339 Histidine decarboxylase (EC 4.1.1.22) (HDC) (TOM92) +FIG00613342 UPF0028 protein YchK +FIG00613344 FIG00613345: hypothetical protein +FIG00613347 Extracellular phospholipase C (EC 3.1.-.-) +FIG00613349 FIG00613350: hypothetical protein +FIG00613351 FIG00613357: hypothetical protein +FIG00613362 FIG00613364: hypothetical protein +FIG00613364 VfmB protein +FIG00613366 FIG00613367: hypothetical protein +FIG00613368 COG1734: DnaK suppressor protein +FIG00613372 FIG00613374: hypothetical protein +FIG00613381 FIG00613383: hypothetical protein +FIG00613388 FIG00613390: hypothetical protein +FIG00613390 FIG00839717: hypothetical protein +FIG00613391 FIG00613393: hypothetical protein +FIG00613410 FIG00613411: hypothetical protein +FIG00613413 FIG00613417: hypothetical protein +FIG00613437 FIG00613438: hypothetical protein +FIG00613440 FIG00613441: hypothetical protein +FIG00613450 FIG00613454: hypothetical protein +FIG00613456 Putative ThuR, regulatory protein for trehalosemaltose transport +FIG00613457 putative prepilin peptidase dependent protein c precursor +FIG00613473 FIG00613474: hypothetical protein +FIG00613474 FIG00613475: hypothetical protein +FIG00613481 FIG00613482: hypothetical protein +FIG00613483 prepilin peptidase dependent protein B precursor +FIG00613493 FIG00613495: hypothetical protein +FIG00613500 Outer membrane efflux family protein +FIG00613503 putative arylamine N-acetyltransferase, truncation +FIG00613512 FIG00613513: hypothetical protein +FIG00613513 FIG00613521: hypothetical protein +FIG00613534 FIG00613535: hypothetical protein +FIG00613536 FIG00613537: hypothetical protein +FIG00613547 FIG00613552: hypothetical protein +FIG00613557 FIG00613559: hypothetical protein +FIG00613574 FIG00613575: hypothetical protein +FIG00613578 FIG00613579: hypothetical protein +FIG00613580 FIG00613581: hypothetical protein +FIG00613581 FIG00613582: hypothetical protein +FIG00613582 FIG00613583: hypothetical protein +FIG00613586 probable transcriptional regulator protein, ROK family( EC:2.7.1.2 ) +FIG00613588 UPF0266 membrane protein YobD +FIG00613594 UDP-N-acetyl-D-mannosamine dehydrogenase (EC 1.1.1.-) +FIG00613604 FIG00613605: hypothetical protein +FIG00613613 FIG00613614: hypothetical protein +FIG00613614 FIG00613616: hypothetical protein +FIG00613616 FIG00613620: hypothetical protein +FIG00613621 FIG00613623: hypothetical protein +FIG00613623 FIG00613624: hypothetical protein +FIG00613624 bacteriophage CI repressor +FIG00613626 steroid delta-isomerase domain protein +FIG00613628 FIG00613630: hypothetical protein +FIG00613635 3-Oxoacyl-(acyl-carrier-protein (ACP)) synthase III domain protein +FIG00613653 FIG00613655: hypothetical protein +FIG00613659 FIG00613660: hypothetical protein +FIG00613660 FIG00613661: hypothetical protein +FIG00613664 FIG00613665: hypothetical protein +FIG00613689 FIG00613691: hypothetical protein +FIG00613694 Domain of unknown function DUF1813 HSP20-like protein +FIG00613698 Harpin hrpN (Harpin-Ech) +FIG00613710 ABC transporter, membrane spanning protein [sugars] +FIG00613721 hypothetical protein; Some similarities with bacteriophage protein +FIG00613722 probable membrane protein YPO1016 +FIG00613730 FIG00613732: hypothetical protein +FIG00613734 Uncharacterized 42.6 kDa protein in cps region (ORF8) +FIG00613739 COG0543: 2-polyprenylphenol hydroxylase and related flavodoxin oxidoreductases +FIG00613743 Transporter, putative +FIG00613766 FIG00613767: hypothetical protein +FIG00613769 Exo-poly-alpha-D-galacturonosidase precursor (EC 3.2.1.82) +FIG00613777 FIG00613780: hypothetical protein +FIG00613791 FIG00613793: hypothetical protein +FIG00613797 hypothetical protein +FIG00613801 FIG00613802: hypothetical protein +FIG00613808 FIG00613809: hypothetical protein +FIG00613813 FIG00613814: hypothetical protein +FIG00613847 FIG00613848: hypothetical protein +FIG00613859 FIG00613860: hypothetical protein +FIG00613860 FIG00613864: hypothetical protein +FIG00613864 FIG00613867: hypothetical protein +FIG00613870 FIG00613874: hypothetical protein +FIG00613877 FIG00613881: hypothetical protein +FIG00613881 protein of unknown function DUF1176 +FIG00613883 FIG00613890: hypothetical protein +FIG00613890 Lipoprotein outS precursor +FIG00613892 FIG00613893: hypothetical protein +FIG00613902 FIG00613906: hypothetical protein +FIG00613906 FIG00613908: hypothetical protein +FIG00613919 FIG00613927: hypothetical protein +FIG00613928 FIG00613929: hypothetical protein +FIG00613934 FIG00613935: hypothetical protein +FIG00613944 FIG00613947: hypothetical protein +FIG00613950 FIG00613953: hypothetical protein +FIG00613966 Permeases of the major facilitator superfamily +FIG00613977 FIG00613978: hypothetical protein +FIG00613981 Magnesium transporting ATPase, P-type 1 (EC 3.6.3.2) +FIG00613985 FIG00613988: hypothetical protein +FIG00614006 FIG00614007: hypothetical protein +FIG00614011 FIG00614013: hypothetical protein +FIG00614013 FIG00614014: hypothetical protein +FIG00614017 Flagellar protein flhE +FIG00614023 FIG00614026: hypothetical protein +FIG00614029 FIG00614030: hypothetical protein +FIG00614034 HrpB +FIG00614044 FIG00614051: hypothetical protein +FIG00614051 FIG00614052: hypothetical protein +FIG00614052 FIG00614054: hypothetical protein +FIG00614063 FIG00614068: hypothetical protein +FIG00614072 GpE+E' +FIG00614073 FIG00614076: hypothetical protein +FIG00614086 FIG00614087: hypothetical protein +FIG00614087 FIG00614090: hypothetical protein +FIG00614092 FIG00614093: hypothetical protein +FIG00614100 phage tail assembly chaperone gp38 +FIG00614101 FIG00614102: hypothetical protein +FIG00614105 FIG00614107: hypothetical protein +FIG00614119 conserved hypothetical protein +FIG00614123 Transcriptional regulator, AlpA like +FIG00614126 putative carbamoyl-phosphate-synthetase protein +FIG00614133 oligopeptide ABC transporter (ATP-binding protein) +FIG00614142 Protease II (EC 3.4.21.83) +FIG00614144 FIG00614146: hypothetical protein +FIG00614156 Unknown pentose utilization regulator, DeoR family +FIG00614174 FIG00614175: hypothetical protein +FIG00614176 FIG00614177: hypothetical protein +FIG00614179 FIG00614181: hypothetical protein +FIG00614188 Sugar permease +FIG00614195 ophA +FIG00614196 Eps11J +FIG00614202 probable NADPH:quinone oxidoreductase( EC:1.6.99.2,EC:1.8.1.6 ) +FIG00614206 FIG00614208: hypothetical protein +FIG00614208 FIG00614210: hypothetical protein +FIG00614226 FIG00614227: hypothetical protein +FIG00614227 FIG00614229: hypothetical protein +FIG00614233 FIG00614236: hypothetical protein +FIG00614236 FIG00614237: hypothetical protein +FIG00614237 FIG00614240: hypothetical protein +FIG00614243 HrpT +FIG00614246 FIG00614247: hypothetical protein +FIG00614247 FIG00614253: hypothetical protein +FIG00614254 FIG00614256: hypothetical protein +FIG00614257 FIG00614259: hypothetical protein +FIG00614259 FIG00614260: hypothetical protein +FIG00614262 Phytase +FIG00614266 FIG00614267: hypothetical protein +FIG00614277 delta-endotoxin CytB +FIG00614281 Outer membrane lipoprotein pcp precursor +FIG00614293 FIG00614297: hypothetical protein +FIG00614298 FIG00614300: hypothetical protein +FIG00614300 FIG00614302: hypothetical protein +FIG00614302 FIG00614304: hypothetical protein +FIG00614305 FIG00614308: hypothetical protein +FIG00614308 Zinc-finger protein +FIG00614314 FIG00614316: hypothetical protein +FIG00614316 FIG00614317: hypothetical protein +FIG00614339 putative GAF sensor protein( EC:2.4.2.8 ) +FIG00614341 Type IV pilus biogenesis protein PilO +FIG00614343 FIG00614347: hypothetical protein +FIG00614347 FIG00614348: hypothetical protein +FIG00614354 FIG00614356: hypothetical protein +FIG00614359 FIG00614360: hypothetical protein +FIG00614360 FIG00614361: hypothetical protein +FIG00614362 surface antigen variable number repeat protein +FIG00614363 FIG00614364: hypothetical protein +FIG00614366 Methylaspartate mutase, S subunit (EC 5.4.99.1) +FIG00614372 FIG00614374: hypothetical protein +FIG00614377 FIG00614379: hypothetical protein +FIG00614382 FIG00614383: hypothetical protein +FIG00614383 FIG00614385: hypothetical protein +FIG00614385 fimbrial assembly protein (PilN) +FIG00614388 FIG00614393: hypothetical protein +FIG00614393 FIG00614394: hypothetical protein +FIG00614394 FIG00614399: hypothetical protein +FIG00614408 FIG00614409: hypothetical protein +FIG00614409 FIG00614411: hypothetical protein +FIG00614418 Cna protein B-type domain protein +FIG00614423 FIG00614424: hypothetical protein +FIG00614433 Corrinoid methyltransferase, Methanosarcina species +FIG00614436 ABC transporter, membrane spanning protein +FIG00614440 protein of unknown function DUF1049 +FIG00614441 FIG00614442: hypothetical protein +FIG00614442 FIG00614443: hypothetical protein +FIG00614445 Endo-1,4-beta-xylanase( EC:3.2.1.8 ) +FIG00614449 FIG00614451: hypothetical protein +FIG00614458 FIG00614459: hypothetical protein +FIG00614459 sugar ABC transporter, permease protein +FIG00614462 protein of unknown function DUF1680 +FIG00614466 FIG00614467: hypothetical protein +FIG00614471 solute binding protein-like protein +FIG00614475 Monosaccharide-transporting ATPase( EC:3.6.3.17 ) +FIG00614477 FIG00614479: hypothetical protein +FIG00614479 transcriptional regulator, LacI family( EC:5.1.1.1 ) +FIG00614481 FIG00614484: hypothetical protein +FIG00614484 FIG00614485: hypothetical protein +FIG00614488 outer membrane protein OmpH +FIG00614495 FIG00614497: hypothetical protein +FIG00614497 FIG00614498: hypothetical protein +FIG00614498 Mannan endo-1,4-beta-mannosidase( EC:3.2.1.78 ) +FIG00614509 FIG00614510: hypothetical protein +FIG00614510 FIG00614511: hypothetical protein +FIG00614518 NHL repeat containing protein +FIG00614519 FIG00614521: hypothetical protein +FIG00614527 dehydrogenase, E1 component +FIG00614540 FIG00614543: hypothetical protein +FIG00614545 Acylphosphate phosphohydrolase (EC 3.6.1.7), putative +FIG00614548 FIG00614549: hypothetical protein +FIG00614549 FIG00614553: hypothetical protein +FIG00614555 FIG00614559: hypothetical protein +FIG00614562 FIG00614563: hypothetical protein +FIG00614563 FIG00614566: hypothetical protein +FIG00614569 DOMON domain protein +FIG00614571 FIG00614575: hypothetical protein +FIG00614575 FIG00614576: hypothetical protein +FIG00614576 FIG00614577: hypothetical protein +FIG00614577 FIG00614578: hypothetical protein +FIG00614581 Homocitrate synthase (EC 2.3.3.14) +FIG00614585 FIG00614586: hypothetical protein +FIG00614586 Possible fucose ABC transporter, permease component +FIG00614588 methylated-DNA--protein-cysteine S-methyltransferase +FIG00614589 FIG00614592: hypothetical protein +FIG00614592 Lactoylglutathione lyase and related lyase +FIG00614593 FIG00614594: hypothetical protein +FIG00614594 FIG00614595: hypothetical protein +FIG00614602 FIG00614603: hypothetical protein +FIG00614614 Phosphoesterase family protein +FIG00614618 FIG00614620: hypothetical protein +FIG00614624 FIG00614625: hypothetical protein +FIG00614625 FIG00614626: hypothetical protein +FIG00614626 diguanylate cyclase and metal dependent phosphohydrolase +FIG00614628 basic membrane protein family protein +FIG00614629 RNA methyltransferase, TrmH family +FIG00614631 FIG00614632: hypothetical protein +FIG00614633 FIG176532: Sensory transduction histidine kinases +FIG00614643 FIG00614644: hypothetical protein +FIG00614644 FIG00614645: hypothetical protein +FIG00614645 FIG00614646: hypothetical protein +FIG00614650 HAD superfamily (subfamily IIIA) phosphatase, TIGR01668 +FIG00614651 FIG00614652: hypothetical protein +FIG00614652 FIG00614656: hypothetical protein +FIG00614656 FIG00614657: hypothetical protein +FIG00614664 daunorubicin resistance ABC transporter ATPase subunit +FIG00614665 FIG00614666: hypothetical protein +FIG00614670 FIG00614671: hypothetical protein +FIG00614675 FIG00614677: hypothetical protein +FIG00614678 FIG00614681: hypothetical protein +FIG00614681 Spore germination protein-like protein +FIG00614683 FIG00614686: hypothetical protein +FIG00614697 FIG00614703: hypothetical protein +FIG00614703 FIG00614704: hypothetical protein +FIG00614705 DNA for 3-methylaspartate ammonia-lyase, glutamate mutase +FIG00614707 subunit of 2-oxoglutarate:ferredoxin oxidoredutase +FIG00614708 FIG00614711: hypothetical protein +FIG00614711 FIG00614713: hypothetical protein +FIG00614717 oligopeptide/dipeptide ABC transporter, ATPase subunit +FIG00614718 FIG00614722: hypothetical protein +FIG00614725 FIG00614726: hypothetical protein +FIG00614726 FIG00614728: hypothetical protein +FIG00614728 FIG00614729: hypothetical protein +FIG00614729 FIG00614730: hypothetical protein +FIG00614732 extracellular solute-binding protein family 1 +FIG00614747 FIG00614749: hypothetical protein +FIG00614752 Sporulation stage II, protein E +FIG00614755 FIG00614756: hypothetical protein +FIG00614756 FIG00614758: hypothetical protein +FIG00614770 Appr-1-p processing domain protein +FIG00614773 proteinase inhibitor I4 serpin +FIG00614781 ATPase involved in chromosome partitioning, ParA/MinD family, Mrp homolog +FIG00614782 Carbonic anhydrase/acetyltransferase isoleucine patch superfamily-like protein +FIG00614785 FIG00614790: hypothetical protein +FIG00614790 FIG00614793: hypothetical protein +FIG00614793 FIG00614796: hypothetical protein +FIG00614796 FIG00614797: hypothetical protein +FIG00614797 protein of unknown function DUF123 +FIG00614802 FIG00614803: hypothetical protein +FIG00614803 sugar ABC transporter, ATP-binding protein +FIG00614808 FIG00614811: hypothetical protein +FIG00614811 MlpD +FIG00614822 FIG00614826: hypothetical protein +FIG00614826 FIG00614828: hypothetical protein +FIG00614828 FIG00614829: hypothetical protein +FIG00614829 FIG00614830: hypothetical protein +FIG00614831 FIG00614833: hypothetical protein +FIG00614833 FIG00614837: hypothetical protein +FIG00614838 FIG00614841: hypothetical protein +FIG00614841 FIG00614842: hypothetical protein +FIG00614842 FIG00614843: hypothetical protein +FIG00614843 FIG00614844: hypothetical protein +FIG00614844 FIG00614847: hypothetical protein +FIG00614847 FIG00614848: hypothetical protein +FIG00614859 FIG00614861: hypothetical protein +FIG00614861 FIG00614862: hypothetical protein +FIG00614862 FIG00614863: hypothetical protein +FIG00614866 DNA-(apurinic or apyrimidinic site) lyase( EC:4.2.99.18 ) +FIG00614870 FIG00614871: hypothetical protein +FIG00614872 COG1720: Uncharacterized conserved protein / Uncharacterized protein MA0381 +FIG00614873 FIG00614875: hypothetical protein +FIG00614880 FIG00614881: hypothetical protein +FIG00614881 ethanolamine utilization sensory transduction histidine kinase +FIG00614906 FIG00614907: hypothetical protein +FIG00614907 FIG00614910: hypothetical protein +FIG00614913 FIG00614917: hypothetical protein +FIG00614917 ferredoxin 2 +FIG00614921 FIG00614922: hypothetical protein +FIG00614922 FIG00614924: hypothetical protein +FIG00614930 FIG00614931: hypothetical protein +FIG00614931 FIG00614934: hypothetical protein +FIG00614941 FIG00614942: hypothetical protein +FIG00614958 Polynucleotide kinase (EC 2.7.1.78) +FIG00614964 DNA double-strand break repair protein Mre11 +FIG00614965 FIG00614966: hypothetical protein +FIG00614973 FIG00614978: hypothetical protein +FIG00614978 prepilin-type N-terminal cleavage/methylation domain protein +FIG00614979 FIG00614981: hypothetical protein +FIG00614982 FIG00614983: hypothetical protein +FIG00614984 FIG00614986: hypothetical protein +FIG00614986 FIG00614987: hypothetical protein +FIG00614987 FIG00614990: hypothetical protein +FIG00614990 FIG00614991: hypothetical protein +FIG00614991 FIG00614992: hypothetical protein +FIG00614993 FIG00614995: hypothetical protein +FIG00614995 Glucokinase ROK +FIG00615005 FIG00615006: hypothetical protein +FIG00615006 FIG00615010: hypothetical protein +FIG00615014 FIG00615020: hypothetical protein +FIG00615020 FIG00615021: hypothetical protein +FIG00615023 Polysaccharide ABC transporter substrate-binding protein +FIG00615026 FIG00615028: hypothetical protein +FIG00615028 FIG00615029: hypothetical protein +FIG00615029 Peptidase M15A +FIG00615035 PEGA domain protein +FIG00615036 FIG00615038: hypothetical protein +FIG00615043 FIG00615044: hypothetical protein +FIG00615044 fumarate hydratase, beta subunit +FIG00615050 FIG00615052: hypothetical protein +FIG00615065 FIG00615066: hypothetical protein +FIG00615067 Cellulase( EC:3.2.1.4 ) +FIG00615071 FIG00615072: hypothetical protein +FIG00615072 FIG00615073: hypothetical protein +FIG00615080 FIG00615081: hypothetical protein +FIG00615081 Zn-dependent hydrolase of the beta-lactamase fold-like protein +FIG00615085 FIG00615090: hypothetical protein +FIG00615090 FIG00615092: hypothetical protein +FIG00615098 preprotein translocase YajC subunit +FIG00615104 FIG00615107: hypothetical protein +FIG00615107 TRAP dicarboxylate transporter, DctQ subunit, unknown substrate 8 +FIG00615114 RNA polymerase, sigma 28 subunit +FIG00615118 FIG00615120: hypothetical protein +FIG00615122 FIG00615123: hypothetical protein +FIG00615127 FIG00615129: hypothetical protein +FIG00615130 FIG00615132: hypothetical protein +FIG00615132 Methylaspartate ammonia-lyase (EC 4.3.1.2) +FIG00615135 FIG00615141: hypothetical protein +FIG00615141 FIG00615145: hypothetical protein +FIG00615147 FIG00615148: hypothetical protein +FIG00615158 FIG00615168: hypothetical protein +FIG00615170 FIG00615171: hypothetical protein +FIG00615171 Predicted arabinoside ABC transporter, permease component 2 +FIG00615181 FIG00615184: hypothetical protein +FIG00615190 Xylobiose ABC transport system, ATP-binding protein 2 +FIG00615192 FIG00615193: hypothetical protein +FIG00615194 FIG00615195: hypothetical protein +FIG00615197 cationic outer membrane protein, putative +FIG00615198 FIG00615199: hypothetical protein +FIG00615199 FIG00615204: hypothetical protein +FIG00615208 ribose ABC transporter, ATP-binding protein +FIG00615213 FIG00615214: hypothetical protein +FIG00615222 FIG00615223: hypothetical protein +FIG00615225 FIG00615226: hypothetical protein +FIG00615230 Cell wall-binding protein +FIG00615232 binding-protein-dependent transport systems inner membrane component, putative +FIG00615253 FIG00615255: hypothetical protein +FIG00615255 Xylobiose ABC transport system, permease protein 2 +FIG00615267 FIG00615268: hypothetical protein +FIG00615268 FIG00615271: hypothetical protein +FIG00615271 FIG00615273: hypothetical protein +FIG00615276 FIG00615277: hypothetical protein +FIG00615281 FIG00615284: hypothetical protein +FIG00615287 potassium uptake protein, TrkA family +FIG00615292 FIG00615299: hypothetical protein +FIG00615302 FIG00615306: hypothetical protein +FIG00615306 N-terminal methylation motif domain protein +FIG00615320 FIG00615321: hypothetical protein +FIG00615323 NADH dehydrogenase (ubiquinone), 24 kDa subunit +FIG00615327 FIG00615329: hypothetical protein +FIG00615329 lipid A disaccharide synthetase-like protein +FIG00615333 Xylobiose ABC transport system, permease protein 1 +FIG00615335 FIG00615339: hypothetical protein +FIG00615344 FIG00615351: hypothetical protein +FIG00615356 protein of unknown function DUF152 +FIG00615361 FIG00615368: hypothetical protein +FIG00615370 FIG00615371: hypothetical protein +FIG00615393 efflux pump antibiotic resistance protein +FIG00615394 FIG00615396: hypothetical protein +FIG00615396 Fe-S cluster domain protein +FIG00615397 FIG00615398: hypothetical protein +FIG00615398 FIG00615399: hypothetical protein +FIG00615399 FIG00615400: hypothetical protein +FIG00615401 FIG00615406: hypothetical protein +FIG00615410 chromosome segregation and condensation protein ScpA +FIG00615414 FIG00615415: hypothetical protein +FIG00615415 Potassium uptake protein, integral membrane component, KtrB +FIG00615431 FIG00615435: hypothetical protein +FIG00615438 FIG00615439: hypothetical protein +FIG00615447 FIG00615450: hypothetical protein +FIG00615455 peptidase T-like protein +FIG00615460 FIG00615464: hypothetical protein +FIG00615466 FIG00615467: hypothetical protein +FIG00615467 FIG00615471: hypothetical protein +FIG00615474 putative hemin permease +FIG00615475 FIG00615477: hypothetical protein +FIG00615477 FIG00615481: hypothetical protein +FIG00615486 FIG00615492: hypothetical protein +FIG00615492 FIG00615494: hypothetical protein +FIG00615494 DNA-binding protein HU +FIG00615497 FIG00615502: hypothetical protein +FIG00615507 FIG00615509: hypothetical protein +FIG00615509 FIG00615510: hypothetical protein +FIG00615512 FIG00615515: hypothetical protein +FIG00615515 FIG00615516: hypothetical protein +FIG00615518 FIG00615521: hypothetical protein +FIG00615522 FIG00615527: hypothetical protein +FIG00615527 Smc1 chromosome segregation protein, putative +FIG00615538 xylulokinase +FIG00615542 FIG00615544: hypothetical protein +FIG00615545 FIG00615548: hypothetical protein +FIG00615548 FIG00615555: hypothetical protein +FIG00615568 FIG01179376: hypothetical protein +FIG00615586 putative DNA double-strand break repair RAD50 ATPase, putative +FIG00615592 FIG00615596: hypothetical protein +FIG00615598 FIG00615599: hypothetical protein +FIG00615601 Alcohol dehydrogenase GroES domain protein +FIG00615604 molybdopterin oxidoreductase Fe4S4 region +FIG00615615 FIG00615616: hypothetical protein +FIG00615616 FIG00615618: hypothetical protein +FIG00615620 FIG00615626: hypothetical protein +FIG00615630 FIG00615635: hypothetical protein +FIG00615635 FIG00615638: hypothetical protein +FIG00615639 chromosome partition protein +FIG00615643 FIG00615645: hypothetical protein +FIG00615647 xcmT3 +FIG00615658 Hypoxanthine phosphoribosyltransferase( EC:2.4.2.8 ) +FIG00615661 Zn-dependent hydrolase of the beta-lactamase fold +FIG00615662 FIG00615668: hypothetical protein +FIG00615673 FIG00615680: hypothetical protein +FIG00615680 FIG00615684: hypothetical protein +FIG00615684 FIG00615686: hypothetical protein +FIG00615702 Inosose isomerase +FIG00615718 ribosomal protein L35 +FIG00615720 FIG00615723: hypothetical protein +FIG00615744 FIG00615755: hypothetical protein +FIG00615781 FIG00615783: hypothetical protein +FIG00615783 sucrose transport protein +FIG00615858 FIG01005228: hypothetical protein +FIG00615927 FIG00615931: hypothetical protein +FIG00615975 FIG00615979: hypothetical protein +FIG00616076 FIG00616080: hypothetical protein +FIG00616080 FIG00616083: hypothetical protein +FIG00616085 identified by similarity to PIR:H95364 +FIG00616161 FIG00616163: hypothetical protein +FIG00616166 Protein flaF +FIG00616174 Ribonuclease T2 family protein +FIG00616178 FIG00616184: hypothetical protein +FIG00616242 FIG01026644: hypothetical protein +FIG00616267 Protein often near L-alanine-DL-glutamate epimerase (cell wall recycling) +FIG00616275 putative Taurine dehydrogenase +FIG00616298 Oxido-reductase, and dehydratase; MocA +FIG00616325 FIG00616333: hypothetical protein +FIG00616354 Hemimethylated DNA binding protein +FIG00616372 FIG00993130: hypothetical protein +FIG00616384 FIG00616386: hypothetical protein +FIG00616387 Spheroidene monooxygenase (EC 1.-.-.-) +FIG00616528 FIG00616529: hypothetical protein +FIG00616754 Nitrile hydratase subunit beta (EC 4.2.1.84) (Nitrilase) (NHase) +FIG00616774 FIG00616776: hypothetical protein +FIG00616795 FIG00616796: hypothetical protein +FIG00616802 FIG01152618: hypothetical protein +FIG00616826 FIG01026143: hypothetical protein +FIG00616871 TrapT dctQ-M fusion permease, dicarboxylate transport +FIG00616944 FIG00992739: hypothetical protein +FIG00617021 FIG00617022: hypothetical protein +FIG00617042 FIG01024417: hypothetical protein +FIG00617127 FIG01023853: hypothetical protein +FIG00617147 FIG00617153: hypothetical protein +FIG00617204 Flavin reductase family, FMN-binding +FIG00617215 FIG00617218: hypothetical protein +FIG00617236 FIG00617238: hypothetical protein +FIG00617259 FIG00533050: hypothetical protein +FIG00617264 FIG00617265: hypothetical protein +FIG00617267 FIG00645278: hypothetical protein +FIG00617272 FIG00617274: hypothetical protein +FIG00617316 FIG00617317: hypothetical protein +FIG00617317 FIG00617319: hypothetical protein +FIG00617325 FIG00617327: hypothetical protein +FIG00617338 TnpV +FIG00617339 FIG00617341: hypothetical protein +FIG00617346 putative poly-gamma-glutamate synthesis protein, PgsA +FIG00617350 FIG01032327: hypothetical protein +FIG00617355 FIG00617356: hypothetical protein +FIG00617368 FIG00617369: hypothetical protein +FIG00617372 FIG00617375: hypothetical protein +FIG00617381 FIG00617386: hypothetical protein +FIG00617400 FIG00513044: hypothetical protein +FIG00617432 FIG00617433: hypothetical protein +FIG00617435 Endonuclease (EC 3.1.-.-) +FIG00617448 33 kDa chaperonin +FIG00617464 FIG00617465: hypothetical protein +FIG00617467 FIG00617468: hypothetical protein +FIG00617473 FIG00617474: hypothetical protein +FIG00617490 FIG00617491: hypothetical protein +FIG00617493 FIG00617494: hypothetical protein +FIG00617494 FIG00617496: hypothetical protein +FIG00617496 FIG00617497: hypothetical protein +FIG00617507 FIG00617509: hypothetical protein +FIG00617510 FIG00617511: hypothetical protein +FIG00617519 FIG00617520: hypothetical protein +FIG00617541 FIG00617543: hypothetical protein +FIG00617544 FIG00617545: hypothetical protein +FIG00617576 FIG00617592: hypothetical protein +FIG00617592 Possible acyl protein synthase/acyl-CoA reductase-like protein +FIG00617633 FIG00617637: hypothetical protein +FIG00617702 Mandelate racemase/muconate lactonizing enzyme, N-terminal domain protein +FIG00617869 putative NADH-dependent oxidoreductase-possiblyglucose-fructose dependent oxidoreductase +FIG00617979 putative transmembrane glycosyltransferase +FIG00618007 Thiol:disulfide oxidoreductase related to ResA +FIG00618110 probable NADH-dependent dyhydrogenase +FIG00618252 CDP-tyvelose-2-epimerase (EC 5.1.3.-) +FIG00618436 3-hydroxybutyryl-coA dehydrogenase +FIG00618649 Putative NADPH-dependent reductase flavoprotein component, possibly involved in thiamine biosynthesis +FIG00618668 NUDIX hydrolase family protein +FIG00619008 aminopeptidase, putative +FIG00619201 major facilitator superfamily permease-possibl y sugar transporter +FIG00619571 twp-component sensor histidine kinase +FIG00619675 FIG00619677: hypothetical protein +FIG00619800 FIG00619832: hypothetical protein +FIG00619832 chromosome segregation ATPase; intracellular signalling protein +FIG00619983 FIG00619984: hypothetical protein +FIG00620418 FIG00620435: hypothetical protein +FIG00620620 possible haloacid dehalogenase-like hydrolase +FIG00620672 FIG00620685: hypothetical protein +FIG00620705 FIG00620722: hypothetical protein +FIG00620761 coagulation factor 5/8 type domain protein +FIG00620803 NADH:flavin oxidoreductase/nadh oxidase +FIG00620878 putative outer membrane transport/efflux protein +FIG00620965 ggdef domain protein, putative +FIG00620991 FIG00621000: hypothetical protein +FIG00621096 methyltransferase, FkbM family protein +FIG00621114 3-oxoacyl-[acyl-carrier protein] reductase (EC 1.1.1.100) +FIG00621151 FIG00621154: hypothetical protein +FIG00621163 FIG00621165: hypothetical protein +FIG00621201 FIG00621221: hypothetical protein +FIG00621426 conserved hypothetical protein with cytochrome b5-like binding domain +FIG00621594 FIG00621599: hypothetical protein +FIG00621715 FIG00621717: hypothetical protein +FIG00621718 putative L-2,4-diaminobutyrate decarboxylase +FIG00621722 EsaI +FIG00621727 FIG00621729: hypothetical protein +FIG00621729 FIG00621731: hypothetical protein +FIG00621731 FIG00621734: hypothetical protein +FIG00621734 FIG00621735: hypothetical protein +FIG00621736 FIG00621738: hypothetical protein +FIG00621738 FIG00621745: hypothetical protein +FIG00621747 FIG00621751: hypothetical protein +FIG00621751 FIG00621752: hypothetical protein +FIG00621758 FIG00621760: hypothetical protein +FIG00621760 FIG00621761: hypothetical protein +FIG00621761 FIG00621764: hypothetical protein +FIG00621764 Conserved hypothetical protein (perhaps related to histidine degradation) +FIG00621765 FIG00621770: hypothetical protein +FIG00621770 FIG00621771: hypothetical protein +FIG00621771 putative rubredoxin +FIG00621777 putative secreted effector protein +FIG00621778 FIG00621779: hypothetical protein +FIG00621782 FIG00621783: hypothetical protein +FIG00621783 FIG00621786: hypothetical protein +FIG00621786 Potassium channel protein +FIG00621790 FIG00621791: hypothetical protein +FIG00621791 FIG00621795: hypothetical protein +FIG00621795 FIG00621796: hypothetical protein +FIG00621798 FIG00621799: hypothetical protein +FIG00621801 EsaO +FIG00621806 FIG00621808: hypothetical protein +FIG00621816 FIG00621820: hypothetical protein +FIG00621820 hypothetical outer membrane protein +FIG00621821 FIG00621824: hypothetical protein +FIG00621824 FIG00621825: hypothetical protein +FIG00621827 FIG00621828: hypothetical protein +FIG00621828 FIG00621831: hypothetical protein +FIG00621834 FIG00621838: hypothetical protein +FIG00621838 FIG00621840: hypothetical protein +FIG00621842 Hydrogenase maturation factor HoxQ +FIG00621849 FIG00621851: hypothetical protein +FIG00621851 FIG00621852: hypothetical protein +FIG00621852 FIG00621853: hypothetical protein +FIG00621857 FIG00621859: hypothetical protein +FIG00621860 FIG00621863: hypothetical protein +FIG00621863 FIG00621867: hypothetical protein +FIG00621867 FIG00621872: hypothetical protein +FIG00621874 FIG00621875: hypothetical protein +FIG00621875 probable ligase ybaP +FIG00621876 FIG00621877: hypothetical protein +FIG00621878 Putative PTS system IIA component yadI (EC 2.7.1.69) +FIG00621883 FIG00621884: hypothetical protein +FIG00621884 Hydrogenase maturation protease (EC 3.4.24.-) +FIG00621886 Putative arylsulfate sulfotransferase (EC 2.8.2.22) +FIG00621887 FIG00621888: hypothetical protein +FIG00621888 FIG00621890: hypothetical protein +FIG00621892 FIG00621893: hypothetical protein +FIG00621893 Hydrogenase-2 operon protein hybE +FIG00621894 FIG00621895: hypothetical protein +FIG00621895 FIG00621896: hypothetical protein +FIG00621896 FIG00621897: hypothetical protein +FIG00621898 Flagellar biosynthesis protein fliL +FIG00621905 FIG00621909: hypothetical protein +FIG00621918 FIG00621922: hypothetical protein +FIG00621925 Transcriptional regulator, GntR family +FIG00621926 FIG00621927: hypothetical protein +FIG00621927 Uncharacterized protein MJ0319 +FIG00621930 protein of unknown function UPF0181 +FIG00621936 FIG00621937: hypothetical protein +FIG00621941 putative transcriptional regulator LYSR-type +FIG00621943 FIG00621945: hypothetical protein +FIG00621945 FIG00621946: hypothetical protein +FIG00621946 FIG00621947: hypothetical protein +FIG00621947 Cytosine/purine/uracil/thiamine/allantoin permease family protein +FIG00621953 FIG00621956: hypothetical protein +FIG00621960 FIG00621963: hypothetical protein +FIG00621963 FIG00621965: hypothetical protein +FIG00621965 FIG00621966: hypothetical protein +FIG00621969 FIG00621972: hypothetical protein +FIG00621973 FIG00621976: hypothetical protein +FIG00621976 COG2172: Anti-sigma regulatory factor (Ser/Thr protein kinase) +FIG00621988 FIG00621989: hypothetical protein +FIG00621999 FIG00622000: hypothetical protein +FIG00622000 FIG00622005: hypothetical protein +FIG00622009 FIG00622010: hypothetical protein +FIG00622010 FIG00622013: hypothetical protein +FIG00622015 FIG00622018: hypothetical protein +FIG00622018 FIG00622019: hypothetical protein +FIG00622025 FIG00622026: hypothetical protein +FIG00622027 EseD +FIG00622030 FIG00622033: hypothetical protein +FIG00622034 YacC +FIG00622048 FIG00622049: hypothetical protein +FIG00622049 FIG00622050: hypothetical protein +FIG00622050 FIG00622052: hypothetical protein +FIG00622052 FIG00622053: hypothetical protein +FIG00622053 FIG00622054: hypothetical protein +FIG00622056 FIG00622057: hypothetical protein +FIG00622058 probable membrane protein YPO3684 +FIG00622061 secretion system apparatus +FIG00622065 probable exported protein +FIG00622068 FIG00622073: hypothetical protein +FIG00622080 FIG00622083: hypothetical protein +FIG00622093 putative HdeD-like membrane protein +FIG00622108 FIG00622109: hypothetical protein +FIG00622109 FIG00622110: hypothetical protein +FIG00622110 FIG00622111: hypothetical protein +FIG00622126 FIG00622136: hypothetical protein +FIG00622136 Acetyl-CoA:acetoacetyl-CoA transferase, beta subunit (EC 2.8.3.8) +FIG00622137 FIG00622141: hypothetical protein +FIG00622147 FIG00622151: hypothetical protein +FIG00622151 FIG00622152: hypothetical protein +FIG00622152 FIG00622153: hypothetical protein +FIG00622154 FIG00622160: hypothetical protein +FIG00622165 FIG00622168: hypothetical protein +FIG00622170 FIG00622172: hypothetical protein +FIG00622172 FIG00622173: hypothetical protein +FIG00622174 sarcosine oxidase-like protein +FIG00622175 FIG00622177: hypothetical protein +FIG00622180 FIG00622181: hypothetical protein +FIG00622181 EsaH +FIG00622184 FIG00622185: hypothetical protein +FIG00622190 FIG00622194: hypothetical protein +FIG00622195 FIG00622199: hypothetical protein +FIG00622199 FIG00622200: hypothetical protein +FIG00622201 FIG00622202: hypothetical protein +FIG00622204 FIG00622205: hypothetical protein +FIG00622205 FIG00622207: hypothetical protein +FIG00622213 Trx +FIG00622219 FIG00622220: hypothetical protein +FIG00622230 PsiE protein +FIG00622233 FIG00622236: hypothetical protein +FIG00622236 putative prepilin peptidase dependent protein +FIG00622237 FIG00622241: hypothetical protein +FIG00622243 FIG00622245: hypothetical protein +FIG00622247 FIG00622248: hypothetical protein +FIG00622248 FIG00622251: hypothetical protein +FIG00622257 FIG00622258: hypothetical protein +FIG00622260 FIG00622263: hypothetical protein +FIG00622263 FIG00622265: hypothetical protein +FIG00622265 FIG00622266: hypothetical protein +FIG00622266 FIG00622268: hypothetical protein +FIG00622268 FIG00622269: hypothetical protein +FIG00622270 FIG00622276: hypothetical protein +FIG00622276 FIG00622278: hypothetical protein +FIG00622279 lipopolysaccharide biosynthesis protein WalW +FIG00622283 FIG00622289: hypothetical protein +FIG00622289 FIG00622290: hypothetical protein +FIG00622295 FIG00622301: hypothetical protein +FIG00622302 FIG00622305: hypothetical protein +FIG00622310 FIG00622311: hypothetical protein +FIG00622311 FIG00622313: hypothetical protein +FIG00622313 FIG00622315: hypothetical protein +FIG00622322 Putative Dcu family, anaerobic C4-dicarboxylate transporter +FIG00622329 FIG00622331: hypothetical protein +FIG00622338 FIG00622339: hypothetical protein +FIG00622341 secretion system effector +FIG00622345 hypothetical ABC-type sugar transport system, ATPase component +FIG00622347 FIG00622354: hypothetical protein +FIG00622354 FIG00622356: hypothetical protein +FIG00622356 FIG00622357: hypothetical protein +FIG00622362 FIG00622363: hypothetical protein +FIG00622363 FIG00622364: hypothetical protein +FIG00622364 FIG00622365: hypothetical protein +FIG00622365 FIG00622368: hypothetical protein +FIG00622368 Outer membrane protein C precursor (Porin ompC) (Porin ompk36) +FIG00622369 EsaK +FIG00622370 FIG00622371: hypothetical protein +FIG00622373 FIG00622374: hypothetical protein +FIG00622375 FIG00622377: hypothetical protein +FIG00622377 FIG00622379: hypothetical protein +FIG00622388 FIG00622389: hypothetical protein +FIG00622398 FIG00622399: hypothetical protein +FIG00622402 FIG00622403: hypothetical protein +FIG00622403 FIG00622404: hypothetical protein +FIG00622404 predicted isopentenyl-diphosphate delta-isomerase +FIG00622406 FIG00622407: hypothetical protein +FIG00622407 FIG00622413: hypothetical protein +FIG00622414 FIG00622416: hypothetical protein +FIG00622420 Orf13 +FIG00622422 FIG00622424: hypothetical protein +FIG00622430 FIG00622433: hypothetical protein +FIG00622434 FIG00622435: hypothetical protein +FIG00622439 FIG00622441: hypothetical protein +FIG00622441 FIG00622443: hypothetical protein +FIG00622446 FIG00622447: hypothetical protein +FIG00622447 FIG00622450: hypothetical protein +FIG00622450 FIG00622451: hypothetical protein +FIG00622451 FIG00622452: hypothetical protein +FIG00622454 FIG00622459: hypothetical protein +FIG00622464 Uncharacterized ferredoxin-like protein YdhX +FIG00622467 FIG00622468: hypothetical protein +FIG00622468 FIG00622473: hypothetical protein +FIG00622475 FIG00622476: hypothetical protein +FIG00622480 FIG00622481: hypothetical protein +FIG00622488 protein of unknown function DUF453 +FIG00622490 FIG00622492: hypothetical protein +FIG00622494 Sodium/alanine symporter +FIG00622501 FIG00622502: hypothetical protein +FIG00622512 FIG00622514: hypothetical protein +FIG00622514 FIG00622517: hypothetical protein +FIG00622520 FIG00622522: hypothetical protein +FIG00622522 putative nickel-dependent hydrogenase cytochrome b-type subunit +FIG00622531 radical activating enzyme +FIG00622534 FIG00622536: hypothetical protein +FIG00622536 Hypothetical lipoprotein ybfN precursor +FIG00622545 FIG00622547: hypothetical protein +FIG00622548 Hypothetical MFS-type transporter protein YcaD +FIG00622549 FIG00622554: hypothetical protein +FIG00622554 FIG00622555: hypothetical protein +FIG00622564 FIG00622565: hypothetical protein +FIG00622565 EspA family secreted protein +FIG00622572 FIG00622573: hypothetical protein +FIG00622575 FIG00622577: hypothetical protein +FIG00622577 FIG00622578: hypothetical protein +FIG00622589 FIG00622591: hypothetical protein +FIG00622594 FIG00622596: hypothetical protein +FIG00622596 putative anti-sigma-B factor antagonist +FIG00622597 FIG00622598: hypothetical protein +FIG00622598 FIG00622603: hypothetical protein +FIG00622603 FIG00622604: hypothetical protein +FIG00622604 FIG00622605: hypothetical protein +FIG00622605 FIG00622606: hypothetical protein +FIG00622614 FIG00622619: hypothetical protein +FIG00622621 FIG00622623: hypothetical protein +FIG00622623 FIG00622624: hypothetical protein +FIG00622624 FIG00622629: hypothetical protein +FIG00622629 FIG00622631: hypothetical protein +FIG00622631 FIG00622633: hypothetical protein +FIG00622635 FIG00622636: hypothetical protein +FIG00622636 FIG00622641: hypothetical protein +FIG00622641 type III secretion system CesD protein +FIG00622645 FIG00622647: hypothetical protein +FIG00622648 FIG00622650: hypothetical protein +FIG00622650 FIG00622653: hypothetical protein +FIG00622656 FIG00622657: hypothetical protein +FIG00622657 FIG00622663: hypothetical protein +FIG00622663 FIG00638839: hypothetical protein +FIG00622668 FIG00622670: hypothetical protein +FIG00622670 FIG00622671: hypothetical protein +FIG00622673 FIG00622674: hypothetical protein +FIG00622674 FIG00622675: hypothetical protein +FIG00622675 FIG00622677: hypothetical protein +FIG00622677 EsaB +FIG00622680 FIG00622681: hypothetical protein +FIG00622681 FIG00622682: hypothetical protein +FIG00622682 COG3111: Uncharacterized conserved protein +FIG00622686 type III secretion apparatus protein +FIG00622689 FIG00622690: hypothetical protein +FIG00622690 Virulence factor VirK +FIG00622691 FIG00622692: hypothetical protein +FIG00622693 Glutathione-regulated potassium-efflux system protein +FIG00622695 FIG00622696: hypothetical protein +FIG00622696 FIG00622698: hypothetical protein +FIG00622707 FIG00622708: hypothetical protein +FIG00622708 FIG00622709: hypothetical protein +FIG00622713 FIG00622714: hypothetical protein +FIG00622714 Histidine permease YuiF +FIG00622716 Type III secretion inner membrane channel protein (LcrD,HrcV,EscV,SsaV) +FIG00622717 FIG00622718: hypothetical protein +FIG00622722 FIG00622723: hypothetical protein +FIG00622725 FIG00622726: hypothetical protein +FIG00622729 FIG00622730: hypothetical protein +FIG00622730 FIG00622731: hypothetical protein +FIG00622746 Ni/Fe-hydrogenase, small subunit( EC:1.12.99.6 ) +FIG00622774 uncharacterized protein involved in formate dehydrogenase formation +FIG00622806 FIG00622829: hypothetical protein +FIG00622829 FIG00622845: hypothetical protein +FIG00622845 FIG00622889: hypothetical protein +FIG00622889 FIG00622891: hypothetical protein +FIG00622894 FIG00622896: hypothetical protein +FIG00622897 O-succinylbenzoic acid--CoA ligase (EC 6.2.1.26) / O-succinylbenzoate synthase (EC 4.2.1.113) +FIG00622920 FIG00622948: hypothetical protein +FIG00622960 FIG00622966: hypothetical protein +FIG00622966 FIG00622968: hypothetical protein +FIG00623000 FIG00623005: hypothetical protein +FIG00623083 FIG00623084: hypothetical protein +FIG00623166 FIG00623181: hypothetical protein +FIG00623183 FIG00623195: hypothetical protein +FIG00623239 FIG00623248: hypothetical protein +FIG00623250 FIG00623281: hypothetical protein +FIG00623319 FIG00623324: hypothetical protein +FIG00623342 FIG00623384: hypothetical protein +FIG00623398 FIG00623399: hypothetical protein +FIG00623399 FIG00623445: hypothetical protein +FIG00623500 FIG00623505: hypothetical protein +FIG00623505 FIG00623524: hypothetical protein +FIG00623570 FIG00623578: hypothetical protein +FIG00623681 capsular polysaccharide biosynthesis proteinCps4H +FIG00623749 FIG00623750: hypothetical protein +FIG00623773 FIG00623793: hypothetical protein +FIG00623807 FIG00623809: hypothetical protein +FIG00623809 Galactose-1-phosphate uridylyltransferase (EC 2.7.7.10) +FIG00623837 FIG00623843: hypothetical protein +FIG00623843 FIG00623848: hypothetical protein +FIG00623848 FIG00623859: hypothetical protein +FIG00623859 FIG00818171: hypothetical protein +FIG00623929 FIG00623942: hypothetical protein +FIG00623942 FIG00623948: hypothetical protein +FIG00623948 putative fumarate reductase flavoprotein subunit +FIG00623959 FIG00623972: hypothetical protein +FIG00623995 FIG00624001: hypothetical protein +FIG00624001 FIG00624003: hypothetical protein +FIG00624003 FIG00624013: hypothetical protein +FIG00624013 FIG00624022: hypothetical protein +FIG00624022 FIG00624030: hypothetical protein +FIG00624030 FIG00624083: hypothetical protein +FIG00624083 FIG00624092: hypothetical protein +FIG00624147 FIG00624148: hypothetical protein +FIG00624148 FIG00624155: hypothetical protein +FIG00624207 molybdopterin oxidoreductase +FIG00624236 FIG00624254: hypothetical protein +FIG00624351 FIG00624358: hypothetical protein +FIG00624427 FIG00624501: hypothetical protein +FIG00624504 FIG00624552: hypothetical protein +FIG00624597 FIG00624629: hypothetical protein +FIG00624647 FIG00624699: hypothetical protein +FIG00624747 FIG00624775: hypothetical protein +FIG00624799 FIG00624820: hypothetical protein +FIG00624840 FIG00624861: hypothetical protein +FIG00624861 FIG00624862: hypothetical protein +FIG00624862 FIG00385572: hypothetical protein +FIG00624864 FIG00624865: hypothetical protein +FIG00624867 FIG00624868: hypothetical protein +FIG00624868 FIG00624869: hypothetical protein +FIG00624869 FIG00624870: hypothetical protein +FIG00624870 FIG00624871: hypothetical protein +FIG00624871 FIG00624872: hypothetical protein +FIG00624872 FIG00624873: hypothetical protein +FIG00624873 FIG00624874: hypothetical protein +FIG00624875 FIG00624877: hypothetical protein +FIG00624877 FIG00624878: hypothetical protein +FIG00624879 Peptidoglycan-associated lipoprotein +FIG00624880 FIG00624881: hypothetical protein +FIG00624881 FIG00624882: hypothetical protein +FIG00624882 FIG00624883: hypothetical protein +FIG00624887 FIG00384879: hypothetical protein +FIG00624888 FIG00624889: hypothetical protein +FIG00624890 FIG00624891: hypothetical protein +FIG00624891 Peptide chain release factor 2; programmed frameshift-containing +FIG00624892 FIG00624893: hypothetical protein +FIG00624893 FIG00384993: hypothetical protein +FIG00624894 FIG00384970: hypothetical protein +FIG00624895 FIG00385072: hypothetical protein +FIG00624898 FIG00624904: hypothetical protein +FIG00624904 FIG00385186: hypothetical protein +FIG00624910 FIG00624913: hypothetical protein +FIG00624914 FIG00385098: hypothetical protein +FIG00624921 FIG00624923: hypothetical protein +FIG00624923 FIG00624925: hypothetical protein +FIG00624925 FIG00624926: hypothetical protein +FIG00624926 ribosomal large subunit pseudouridine synthase C +FIG00624929 FIG00624931: hypothetical protein +FIG00624931 FIG00624932: hypothetical protein +FIG00624932 FIG00624935: hypothetical protein +FIG00624935 FIG00384892: hypothetical protein +FIG00624937 FIG00624938: hypothetical protein +FIG00624938 FIG00624939: hypothetical protein +FIG00624939 FIG00624941: hypothetical protein +FIG00624941 FIG00624942: hypothetical protein +FIG00624944 FIG00385106: hypothetical protein +FIG00624947 FIG00624948: hypothetical protein +FIG00624951 FIG00624953: hypothetical protein +FIG00624953 FIG00384958: hypothetical protein +FIG00624957 FIG00624958: hypothetical protein +FIG00624958 FIG00385567: hypothetical protein +FIG00624959 Ankyrin domain protein +FIG00624961 FIG00385308: hypothetical protein +FIG00624962 FIG00384927: hypothetical protein +FIG00624971 FIG00624972: hypothetical protein +FIG00624972 FIG00385582: hypothetical protein +FIG00624978 FIG00624980: hypothetical protein +FIG00624980 FIG00624981: hypothetical protein +FIG00624981 FIG00624983: hypothetical protein +FIG00624986 FIG00624987: hypothetical protein +FIG00624987 FIG00624988: hypothetical protein +FIG00624988 FIG00624989: hypothetical protein +FIG00624989 FIG00624990: hypothetical protein +FIG00624990 FIG00385055: hypothetical protein +FIG00624991 FIG00624992: hypothetical protein +FIG00624992 FIG00624995: hypothetical protein +FIG00624997 FIG00624999: hypothetical protein +FIG00624999 FIG00625001: hypothetical protein +FIG00625001 FIG00384939: hypothetical protein +FIG00625002 FIG00625006: hypothetical protein +FIG00625006 putative lipoprotein NlpD +FIG00625007 FIG00625008: hypothetical protein +FIG00625008 FIG00385148: hypothetical protein +FIG00625009 FIG00625010: hypothetical protein +FIG00625010 FIG00625012: hypothetical protein +FIG00625012 FIG00625014: hypothetical protein +FIG00625014 FIG00625015: hypothetical protein +FIG00625015 FIG00625017: hypothetical protein +FIG00625017 FIG00625018: hypothetical protein +FIG00625018 FIG00385139: hypothetical protein +FIG00625020 FIG00625021: hypothetical protein +FIG00625021 FIG00625022: hypothetical protein +FIG00625024 FIG00625025: hypothetical protein +FIG00625025 FIG00625026: hypothetical protein +FIG00625026 FIG00625027: hypothetical protein +FIG00625027 FIG00625028: hypothetical protein +FIG00625028 FIG00625030: hypothetical protein +FIG00625030 FIG00625031: hypothetical protein +FIG00625031 FIG00625034: hypothetical protein +FIG00625037 FIG00625040: hypothetical protein +FIG00625040 FIG00625042: hypothetical protein +FIG00625044 FIG00625045: hypothetical protein +FIG00625046 FIG00625050: hypothetical protein +FIG00625050 FIG00385327: hypothetical protein +FIG00625051 FIG00625052: hypothetical protein +FIG00625056 FIG00625057: hypothetical protein +FIG00625058 FIG00625059: hypothetical protein +FIG00625059 FIG00625060: hypothetical protein +FIG00625060 FIG00625061: hypothetical protein +FIG00625061 FIG00625062: hypothetical protein +FIG00625062 FIG00625063: hypothetical protein +FIG00625063 FIG00625065: hypothetical protein +FIG00625065 FIG00625066: hypothetical protein +FIG00625069 Outer membrane protein (porin) +FIG00625071 FIG00625072: hypothetical protein +FIG00625072 FIG00625073: hypothetical protein +FIG00625074 FIG00625075: hypothetical protein +FIG00625075 FIG00625076: hypothetical protein +FIG00625076 FIG00385290: hypothetical protein +FIG00625079 FIG00625081: hypothetical protein +FIG00625081 FIG00625083: hypothetical protein +FIG00625083 FIG00625084: hypothetical protein +FIG00625084 FIG00625089: hypothetical protein +FIG00625089 FIG00625092: hypothetical protein +FIG00625092 FIG00625094: hypothetical protein +FIG00625095 FIG00625096: hypothetical protein +FIG00625096 FIG00384959: hypothetical protein +FIG00625101 FIG00625103: hypothetical protein +FIG00625103 FIG00625105: hypothetical protein +FIG00625110 FIG00625113: hypothetical protein +FIG00625114 FIG00385340: hypothetical protein +FIG00625115 FIG00625116: hypothetical protein +FIG00625119 FIG00625122: hypothetical protein +FIG00625132 FIG00385268: hypothetical protein +FIG00625137 FIG00625139: hypothetical protein +FIG00625139 FIG00625140: hypothetical protein +FIG00625141 FIG00625142: hypothetical protein +FIG00625148 FIG00625149: hypothetical protein +FIG00625149 FIG00384903: hypothetical protein +FIG00625152 FIG00625153: hypothetical protein +FIG00625153 FIG00625154: hypothetical protein +FIG00625160 FIG00625161: hypothetical protein +FIG00625161 FIG00625162: hypothetical protein +FIG00625162 FIG00625163: hypothetical protein +FIG00625163 FIG00625169: hypothetical protein +FIG00625169 FIG00625172: hypothetical protein +FIG00625172 FIG00625174: hypothetical protein +FIG00625174 FIG00625175: hypothetical protein +FIG00625186 FIG00625188: hypothetical protein +FIG00625189 FIG00625196: hypothetical protein +FIG00625198 FIG00625199: hypothetical protein +FIG00625199 FIG00625200: hypothetical protein +FIG00625216 FIG00625221: hypothetical protein +FIG00625228 FIG00625229: hypothetical protein +FIG00625232 FIG00625233: hypothetical protein +FIG00625233 FIG00625234: hypothetical protein +FIG00625235 FIG00385070: hypothetical protein +FIG00625238 FIG00625240: hypothetical protein +FIG00625242 FIG00625245: hypothetical protein +FIG00625247 FIG00625250: hypothetical protein +FIG00625250 FIG00625251: hypothetical protein +FIG00625258 FIG00625263: hypothetical protein +FIG00625273 FIG00625274: hypothetical protein +FIG00625274 FIG00625275: hypothetical protein +FIG00625275 FIG00625276: hypothetical protein +FIG00625280 FIG00625281: hypothetical protein +FIG00625411 FIG00625417: hypothetical protein +FIG00625717 FIG00625720: hypothetical protein +FIG00625839 phage terminase, large subunit, PBSX family +FIG00626086 FIG00626090: hypothetical protein +FIG00626092 Uncharacterized protein ybdG +FIG00626095 FIG00639119: hypothetical protein +FIG00626100 hypothetical protein +FIG00626107 FIG00626108: hypothetical protein +FIG00626122 FIG00626123: hypothetical protein +FIG00626127 FIG00626128: hypothetical protein +FIG00626131 FIG00626134: hypothetical protein +FIG00626134 FIG00626137: hypothetical protein +FIG00626137 FIG00626140: hypothetical protein +FIG00626140 FIG00626141: hypothetical protein +FIG00626149 FIG00626150: hypothetical protein +FIG00626151 Outer membrane protein N precursor +FIG00626153 FIG00613859: hypothetical protein +FIG00626162 FIG00626164: hypothetical protein +FIG00626164 FIG00626169: hypothetical protein +FIG00626178 FIG00626182: hypothetical protein +FIG00626183 FIG00626184: hypothetical protein +FIG00626185 FIG00626186: hypothetical protein +FIG00626190 FIG00626193: hypothetical protein +FIG00626193 B protein +FIG00626200 FIG00626204: hypothetical protein +FIG00626204 FIG00626207: hypothetical protein +FIG00626212 FIG01046262: hypothetical protein +FIG00626214 FIG00626216: hypothetical protein +FIG00626225 Outer membrane usher protein fimD precursor +FIG00626229 FIG027785: Fimbriae usher protein StfC +FIG00626238 FIG00626239: hypothetical protein +FIG00626239 FIG00626240: hypothetical protein +FIG00626247 FIG00626249: hypothetical protein +FIG00626254 FIG00626257: hypothetical protein +FIG00626259 FIG00626260: hypothetical protein +FIG00626260 FIG00626262: hypothetical protein +FIG00626266 FIG00626268: hypothetical protein +FIG00626268 FIG00626270: hypothetical protein +FIG00626288 FIG00626290: hypothetical protein +FIG00626300 FIG00626302: hypothetical protein +FIG00626332 Tail component protein +FIG00626333 Fermentation/respiration switch protein +FIG00626334 FIG00626335: hypothetical protein +FIG00626349 probable ribonuclease inhibitor YPO3690 +FIG00626351 FIG00626352: hypothetical protein +FIG00626352 FIG00626353: hypothetical protein +FIG00626353 FIG00626354: hypothetical protein +FIG00626356 FIG00626357: hypothetical protein +FIG00626361 FIG00626362: hypothetical protein +FIG00626365 FIG00626368: hypothetical protein +FIG00626368 FIG00626369: hypothetical protein +FIG00626369 FIG00626371: hypothetical protein +FIG00626371 FIG00626372: hypothetical protein +FIG00626379 FIG00626380: hypothetical protein +FIG00626385 FIG00626386: hypothetical protein +FIG00626388 FIG00626394: hypothetical protein +FIG00626395 FIG00626398: hypothetical protein +FIG00626400 FIG00626404: hypothetical protein +FIG00626404 FIG00626409: hypothetical protein +FIG00626409 orf96 +FIG00626418 Putative sugar ABC transporter precursor +FIG00626421 Phage DNA replication protein O +FIG00626423 FIG00628496: hypothetical protein +FIG00626439 FIG00626440: hypothetical protein +FIG00626447 FIG00626448: hypothetical protein +FIG00626448 FIG00626449: hypothetical protein +FIG00626450 FIG00638740: hypothetical protein +FIG00626463 FIG00626464: hypothetical protein +FIG00626466 FIG00626467: hypothetical protein +FIG00626476 FIG00626478: hypothetical protein +FIG00626485 FIG00626489: hypothetical protein +FIG00626489 FIG00626490: hypothetical protein +FIG00626493 FIG00626495: hypothetical protein +FIG00626495 FIG00626498: hypothetical protein +FIG00626509 FIG00626510: hypothetical protein +FIG00626514 FIG00626515: hypothetical protein +FIG00626522 FIG00626525: hypothetical protein +FIG00626544 FIG00626545: hypothetical protein +FIG00626547 FIG00626550: hypothetical protein +FIG00626551 Putative outer membrane protein yiaT precursor +FIG00626553 FIG00626554: hypothetical protein +FIG00626558 FIG00626560: hypothetical protein +FIG00626560 FIG00626561: hypothetical protein +FIG00626570 FIG00626573: hypothetical protein +FIG00626574 probable lipoprotein YPO2331 +FIG00626575 FIG00626576: hypothetical protein +FIG00626576 FIG00626577: hypothetical protein +FIG00626583 aspartate dehydrogenase +FIG00626585 predicted dehydrogenase +FIG00626588 FIG00626592: hypothetical protein +FIG00626592 COG2165: Type II secretory pathway, pseudopilin PulG +FIG00626602 COG1670: Acetyltransferases, including N-acetylases of ribosomal proteins +FIG00626605 FIG00626608: hypothetical protein +FIG00626610 FIG00626612: hypothetical protein +FIG00626612 FIG00626616: hypothetical protein +FIG00626630 FIG00626631: hypothetical protein +FIG00626639 Cell division activator cedA +FIG00626647 FIG00626650: hypothetical protein +FIG00626650 FIG00626651: hypothetical protein +FIG00626654 FIG00626658: hypothetical protein +FIG00626676 FIG00626680: hypothetical protein +FIG00626683 FIG00626684: hypothetical protein +FIG00626684 FIG00626687: hypothetical protein +FIG00626687 FIG00626688: hypothetical protein +FIG00626694 FIG00626701: hypothetical protein +FIG00626701 Trans-aconitate 2-methyltransferase (EC 2.1.1.144) +FIG00626729 FIG00626730: hypothetical protein +FIG00626745 fimbrial biogenesis outer membrane usher protein +FIG00626764 FIG00626766: hypothetical protein +FIG00626766 Putative BglB-family transcriptional antiterminator +FIG00626780 His-Xaa-Ser system radical SAM maturase HxsC +FIG00626800 FIG00638157: hypothetical protein +FIG00626801 FIG00626803: hypothetical protein +FIG00626803 FIG00626895: hypothetical protein +FIG00626804 FIG00626805: hypothetical protein +FIG00626808 FIG01045166: hypothetical protein +FIG00626809 FIG00626810: hypothetical protein +FIG00626811 general secretion pathway protein M +FIG00626817 FIG00626818: hypothetical protein +FIG00626818 Phage tape measure protein +FIG00626838 FIG00626844: hypothetical protein +FIG00626846 FIG00626847: hypothetical protein +FIG00626847 FIG00626848: hypothetical protein +FIG00626851 FIG00626852: hypothetical protein +FIG00626857 FIG00626859: hypothetical protein +FIG00626859 FIG00626860: hypothetical protein +FIG00626860 FIG00626861: hypothetical protein +FIG00626874 FIG00640946: hypothetical protein +FIG00626881 putative cold-shock protein +FIG00626883 FIG00626887: hypothetical protein +FIG00626887 FIG00626888: hypothetical protein +FIG00626888 FIG00626891: hypothetical protein +FIG00626891 probable bacteriophage protein STY1062 +FIG00626898 FIG00626899: hypothetical protein +FIG00626899 FIG00626900: hypothetical protein +FIG00626902 FIG00626905: hypothetical protein +FIG00626908 FIG00626910: hypothetical protein +FIG00626914 FIG00626917: hypothetical protein +FIG00626919 FIG00626920: hypothetical protein +FIG00626934 FIG00626935: hypothetical protein +FIG00626935 FIG00626937: hypothetical protein +FIG00626939 FIG00626940: hypothetical protein +FIG00626942 COG3539: P pilus assembly protein, pilin FimA +FIG00626946 FIG00626947: hypothetical protein +FIG00626947 FIG00626948: hypothetical protein +FIG00626952 FIG00626954: hypothetical protein +FIG00626980 corresponds to STY4639 from Accession AL513382: Salmonella typhi CT18 +FIG00626985 FIG00626989: hypothetical protein +FIG00626991 FIG00626993: hypothetical protein +FIG00626993 FIG00626994: hypothetical protein +FIG00626994 FIG00626999: hypothetical protein +FIG00627001 FIG00627003: hypothetical protein +FIG00627012 FIG00627013: hypothetical protein +FIG00627013 FIG00627017: hypothetical protein +FIG00627025 FIG00627026: hypothetical protein +FIG00627026 FIG00627027: hypothetical protein +FIG00627033 Putative type I secretion protein, ATP-binding protein +FIG00627036 Protein YciE +FIG00627041 Transcriptional activator feaR +FIG00627043 FIG00627048: hypothetical protein +FIG00627050 Putative membrane spanning export protein +FIG00627055 FIG00627057: hypothetical protein +FIG00627057 FIG00627060: hypothetical protein +FIG00627060 FIG00627063: hypothetical protein +FIG00627063 FIG00627064: hypothetical protein +FIG00627072 FIG00627077: hypothetical protein +FIG00627079 FIG00627080: hypothetical protein +FIG00627080 FIG00627083: hypothetical protein +FIG00627100 Putative membrane protein precursor +FIG00627108 Bacterioferritin-associated ferredoxin +FIG00627109 FIG00627110: hypothetical protein +FIG00627111 FIG00627113: hypothetical protein +FIG00627127 FIG00627129: hypothetical protein +FIG00627140 RpiR-family transcriptional regulator +FIG00627146 FIG00627147: hypothetical protein +FIG00627152 FIG00627158: hypothetical protein +FIG00627172 Protein ytfJ precursor +FIG00627178 Fimbrial protein +FIG00627204 UDP-N-acetylmuramoylalanyl-D-glutamyl-2,6-diaminopimelate--D-alanyl-D- alanyl ligase (EC 6.3.2.10) +FIG00627205 FIG00627206: hypothetical protein +FIG00627206 sodium:dicarboxylate symporter family protein +FIG00627208 ankyrin repeat family protein +FIG00627209 FIG00627211: hypothetical protein +FIG00627211 FIG00627212: hypothetical protein +FIG00627212 FIG00627214: hypothetical protein +FIG00627214 von Willebrand factor, type A:Cna B-type +FIG00627215 FIG00627217: hypothetical protein +FIG00627220 FIG00627221: hypothetical protein +FIG00627224 FIG00627225: hypothetical protein +FIG00627227 FIG00627229: hypothetical protein +FIG00627232 FIG00627234: hypothetical protein +FIG00627234 FIG00627236: hypothetical protein +FIG00627237 FIG00627238: hypothetical protein +FIG00627238 FIG00627239: hypothetical protein +FIG00627239 FIG00627240: hypothetical protein +FIG00627241 FIG00627242: hypothetical protein +FIG00627242 FIG00627244: hypothetical protein +FIG00627244 FIG00628299: hypothetical protein +FIG00627245 FIG00627246: hypothetical protein +FIG00627248 FIG00627250: hypothetical protein +FIG00627250 FIG00627251: hypothetical protein +FIG00627252 FIG00627254: hypothetical protein +FIG00627257 FIG00627258: hypothetical protein +FIG00627258 FIG00627259: hypothetical protein +FIG00627259 FIG00627264: hypothetical protein +FIG00627264 FIG00627265: hypothetical protein +FIG00627267 Acetyltransferase (GNAT family) SAS0976 +FIG00627268 FIG00627269: hypothetical protein +FIG00627269 FIG00627270: hypothetical protein +FIG00627274 FIG00627275: hypothetical protein +FIG00627277 FIG00627278: hypothetical protein +FIG00627278 FIG00627279: hypothetical protein +FIG00627279 extracellular protein +FIG00627280 FIG00627281: hypothetical protein +FIG00627286 FIG00744866: hypothetical protein +FIG00627290 FIG00627291: hypothetical protein +FIG00627291 FIG00627292: hypothetical protein +FIG00627292 FIG00627293: hypothetical protein +FIG00627294 PTS system, IIC component +FIG00627297 probable transcriptional regulator (AraC/XylS family) +FIG00627298 alpha-arabinosides ABC transport system, permease protein araP +FIG00627303 FIG00627304: hypothetical protein +FIG00627307 FIG00627308: hypothetical protein +FIG00627310 FIG00627311: hypothetical protein +FIG00627311 Manganese ABC transporter, periplasmic-binding protein SitA +FIG00627312 AP endonuclease, family 2 +FIG00627314 FIG00627315: hypothetical protein +FIG00627317 FIG00627318: hypothetical protein +FIG00627319 FIG00627320: hypothetical protein +FIG00627320 FIG00627321: hypothetical protein +FIG00627324 FIG00627325: hypothetical protein +FIG00627325 FIG00627327: hypothetical protein +FIG00627327 amino acid ABC transporter ATP-binding protein +FIG00627329 FIG00627332: hypothetical protein +FIG00627334 FIG00627335: hypothetical protein +FIG00627336 transcription regulator +FIG00627339 FIG00627340: hypothetical protein +FIG00627340 FIG00627341: hypothetical protein +FIG00627341 MISCELLANEOUS; Hypothetical/Partial homology +FIG00627343 FIG00627344: hypothetical protein +FIG00627344 N-terminal domain of molybdenum-binding protein +FIG00627346 FIG00627349: hypothetical protein +FIG00627351 FIG00627352: hypothetical protein +FIG00627352 Protein of unknown function DUF421 +FIG00627353 CylA +FIG00627354 FIG00627355: hypothetical protein +FIG00627358 FIG00627359: hypothetical protein +FIG00627359 FIG00627360: hypothetical protein +FIG00627360 FIG00627362: hypothetical protein +FIG00627362 helix-turn-helix protein, iron-dependent repressor family +FIG00627364 FIG00627365: hypothetical protein +FIG00627370 Transcriptional regulator PadR-like +FIG00627372 FIG00627373: hypothetical protein +FIG00627373 FIG00627374: hypothetical protein +FIG00627374 FIG00627375: hypothetical protein +FIG00627381 FIG00627383: hypothetical protein +FIG00627383 FIG00627384: hypothetical protein +FIG00627384 FIG00627385: hypothetical protein +FIG00627385 Putative virion core protein (lumpy skin disease virus) +FIG00627399 FIG00627400: hypothetical protein +FIG00627400 FIG00627401: hypothetical protein +FIG00627402 FIG00627403: hypothetical protein +FIG00627404 Fructose-bisphosphate aldolase class II (EC 4.1.2.13) homolog +FIG00627408 FIG00627409: hypothetical protein +FIG00627409 FIG00628949: hypothetical protein +FIG00627414 FIG00627415: hypothetical protein +FIG00627415 FIG00627417: hypothetical protein +FIG00627422 FIG00627423: hypothetical protein +FIG00627424 FIG00627425: hypothetical protein +FIG00627430 FIG00627431: hypothetical protein +FIG00627433 tunicamycin resistance protein, putative +FIG00627436 hypothetical protein +FIG00627437 sugar ABC transporter, permease protein +FIG00627439 Two component system sensor histidine kinase CiaH (EC 2.7.3.-) +FIG00627440 Putative hydrolase, haloacid dehalogenase family +FIG00627442 FIG00627443: hypothetical protein +FIG00627447 FIG00627448: hypothetical protein +FIG00627448 FIG00627452: hypothetical protein +FIG00627453 FIG00627454: hypothetical protein +FIG00627454 FIG00627455: hypothetical protein +FIG00627456 FIG00627458: hypothetical protein +FIG00627459 FIG00627460: hypothetical protein +FIG00627461 FIG00627462: hypothetical protein +FIG00627462 FIG00627463: hypothetical protein +FIG00627463 FIG00627464: hypothetical protein +FIG00627464 Bacteriocin, lactococcin 972 +FIG00627468 Protein of unknown function DUF188 +FIG00627469 phosphosugar-binding transcriptional regulator, putative +FIG00627471 FIG00627472: hypothetical protein +FIG00627475 FIG00627476: hypothetical protein +FIG00627476 FIG00627477: hypothetical protein +FIG00627478 FIG00627479: hypothetical protein +FIG00627480 FIG00627481: hypothetical protein +FIG00627484 FIG00627485: hypothetical protein +FIG00627488 FIG00627489: hypothetical protein +FIG00627492 FIG00627493: hypothetical protein +FIG00627493 LexA repressor (EC 3.4.21.88) +FIG00627497 FIG00627498: hypothetical protein +FIG00627498 Transcriptional regulator, repressor of the glutamine synthetase, MerR family +FIG00627500 FIG00627501: hypothetical protein +FIG00627501 FIG00627502: hypothetical protein +FIG00627503 FIG00627504: hypothetical protein +FIG00627505 spermine/spermidine acetyltransferase, putative +FIG00627506 FIG00627510: hypothetical protein +FIG00627514 FIG00627515: hypothetical protein +FIG00627515 FIG00627516: hypothetical protein +FIG00627516 FIG00627517: hypothetical protein +FIG00627520 FIG00627522: hypothetical protein +FIG00627522 FIG00627523: hypothetical protein +FIG00627524 FIG00627525: hypothetical protein +FIG00627526 FIG00627527: hypothetical protein +FIG00627530 FIG00627531: hypothetical protein +FIG00627531 FIG00627532: hypothetical protein +FIG00627532 FIG00627533: hypothetical protein +FIG00627533 FIG00627534: hypothetical protein +FIG00627536 FIG00627537: hypothetical protein +FIG00627537 FIG00627538: hypothetical protein +FIG00627538 FIG00627539: hypothetical protein +FIG00627540 FIG00627541: hypothetical protein +FIG00627541 FIG00627542: hypothetical protein +FIG00627543 FIG00627544: hypothetical protein +FIG00627545 6-aminohexanoate-cyclic-dimer hydrolase (EC 3.5.2.12) +FIG00627546 FIG00627547: hypothetical protein +FIG00627547 FIG00627548: hypothetical protein +FIG00627549 FIG00627551: hypothetical protein +FIG00627556 FIG00627557: hypothetical protein +FIG00627560 probable uroporphyrin-III c-methyltransferase (EC 2.1.1.107) +FIG00627562 FIG00627563: hypothetical protein +FIG00627565 FIG00627566: hypothetical protein +FIG00627566 two-component response regulator +FIG00627567 FIG00627568: hypothetical protein +FIG00627568 FIG00627569: hypothetical protein +FIG00627569 FIG00627571: hypothetical protein +FIG00627571 FIG00627572: hypothetical protein +FIG00627572 Probable ABC transporter permease protein ytcP +FIG00627573 FIG00627575: hypothetical protein +FIG00627579 FIG00627581: hypothetical protein +FIG00627581 FIG00627582: hypothetical protein +FIG00627582 Multidrug and toxin extrusion (MATE) family efflux pump YdhE/NorM, homolog +FIG00627584 transcriptional regulator (AraC/XylS family) protein +FIG00627588 Replication-associated protein RepB +FIG00627592 FIG00627593: hypothetical protein +FIG00627593 carbohydrate kinase, PfkB family +FIG00627594 Transcriptional antiterminator bglG:CAT RNA-binding region +FIG00627596 FIG00627597: hypothetical protein +FIG00627597 D-aspartate ligase (EC 6.3.1.12) +FIG00627599 FIG00627600: hypothetical protein +FIG00627602 Phage upper baseplate protein (TP901-1-like ORF48) +FIG00627603 FIG00627604: hypothetical protein +FIG00627606 FIG00627607: hypothetical protein +FIG00627607 FIG00627608: hypothetical protein +FIG00627615 FIG00627618: hypothetical protein +FIG00627619 FIG00627620: hypothetical protein +FIG00627620 toxin secretion/phage lysis holin +FIG00627622 phosphate-starvation-inducible protein PsiE +FIG00627624 FIG00627625: hypothetical protein +FIG00627626 Organic hydroperoxide resistance transcriptional regulator, MarR family +FIG00627630 FIG00627631: hypothetical protein +FIG00627634 FIG00627635: hypothetical protein +FIG00627636 MunI-like protein +FIG00627646 FIG00627648: hypothetical protein +FIG00627650 FIG00627652: hypothetical protein +FIG00627652 FIG00627654: hypothetical protein +FIG00627659 FIG00627660: hypothetical protein +FIG00627661 FIG00627662: hypothetical protein +FIG00627662 ABC transporter periplasmic-binding protein YtfQ +FIG00627663 FIG00627664: hypothetical protein +FIG00627664 FIG00627665: hypothetical protein +FIG00627665 FIG00627666: hypothetical protein +FIG00627666 FIG00627667: hypothetical protein +FIG00627671 FIG00627672: hypothetical protein +FIG00627672 FIG00627673: hypothetical protein +FIG00627673 FIG00627674: hypothetical protein +FIG00627674 FIG00627675: hypothetical protein +FIG00627675 signal peptidase type I +FIG00627677 FIG00627678: hypothetical protein +FIG00627678 TPR domain transcriptional regulator, Cro/CI family +FIG00627684 FIG00627685: hypothetical protein +FIG00627686 FIG00627687: hypothetical protein +FIG00627688 FIG00627689: hypothetical protein +FIG00627689 FIG00627691: hypothetical protein +FIG00627694 FIG00627696: hypothetical protein +FIG00627696 FIG00627697: hypothetical protein +FIG00627700 FIG00627701: hypothetical protein +FIG00627703 pheromone cAM373 precursor lipoprotein +FIG00627708 beta-phosphoglucomutase, putative +FIG00627712 FIG00627713: hypothetical protein +FIG00627713 FIG00627714: hypothetical protein +FIG00627714 Alpha/beta hydrolase fold +FIG00627717 FIG00627719: hypothetical protein +FIG00627721 FIG00627722: hypothetical protein +FIG00627723 FIG00627725: hypothetical protein +FIG00627725 glyoxalase family protein +FIG00627731 FIG00627732: hypothetical protein +FIG00627732 FIG00627733: hypothetical protein +FIG00627733 FIG00627735: hypothetical protein +FIG00627737 FIG00627738: hypothetical protein +FIG00627738 FIG00627739: hypothetical protein +FIG00627739 FIG00627740: hypothetical protein +FIG00627740 FIG00627741: hypothetical protein +FIG00627741 FIG00627742: hypothetical protein +FIG00627744 FIG00627745: hypothetical protein +FIG00627745 FIG00627746: hypothetical protein +FIG00627746 transcriptional regulator, Cro/CI family +FIG00627747 secreted endo-beta-N-acetylglucosaminidase +FIG00627752 FIG00627754: hypothetical protein +FIG00627756 FIG00627757: hypothetical protein +FIG00627757 2-dehydro-3-deoxyphosphogluconate aldolase (EC 4.1.2.14) in D-glucosaminate utilization operon +FIG00627758 FIG00627760: hypothetical protein +FIG00627762 FIG00627764: hypothetical protein +FIG00627767 FIG00627768: hypothetical protein +FIG00627768 FIG00627770: hypothetical protein +FIG00627770 FIG00627771: hypothetical protein +FIG00627771 polysaccharide biosynthesis family protein +FIG00627774 FIG00627775: hypothetical protein +FIG00627776 FIG00627778: hypothetical protein +FIG00627781 FIG00627782: hypothetical protein +FIG00627782 FIG00627783: hypothetical protein +FIG00627784 FIG00627785: hypothetical protein +FIG00627785 FIG00627786: hypothetical protein +FIG00627786 FIG00627787: hypothetical protein +FIG00627789 PTS system, gluconate-specific IIC component (EC 2.7.1.69) +FIG00627791 FIG00627792: hypothetical protein +FIG00627792 DNA recombinase, putative +FIG00627796 FIG00627797: hypothetical protein +FIG00627801 FIG00627802: hypothetical protein +FIG00627802 Short-chain fatty acids transporter +FIG00627804 FIG00627805: hypothetical protein +FIG00627805 FIG00627807: hypothetical protein +FIG00627807 FIG00627808: hypothetical protein +FIG00627808 FIG00627809: hypothetical protein +FIG00627816 Oligohyaluronate lyase (EC 4.2.2.-) +FIG00627817 FIG00627818: hypothetical protein +FIG00627818 FIG00627819: hypothetical protein +FIG00627819 amidase, putative +FIG00627822 phage integrase +FIG00627823 FIG00627824: hypothetical protein +FIG00627824 FIG00627827: hypothetical protein +FIG00627827 FIG00627828: hypothetical protein +FIG00627828 FIG00627829: hypothetical protein +FIG00627829 FIG00627830: hypothetical protein +FIG00627831 FIG00627835: hypothetical protein +FIG00627840 FIG00627841: hypothetical protein +FIG00627842 FIG00627843: hypothetical protein +FIG00627843 FIG00627844: hypothetical protein +FIG00627844 FIG00627845: hypothetical protein +FIG00627847 methylase( EC:2.1.1.- ) +FIG00627850 FIG00627851: hypothetical protein +FIG00627851 FIG00627852: hypothetical protein +FIG00627852 FIG00627853: hypothetical protein +FIG00627853 FIG00627854: hypothetical protein +FIG00627854 FIG00627855: hypothetical protein +FIG00627857 Putative hydrolase of the alpha/beta superfamily +FIG00627858 FIG00627862: hypothetical protein +FIG00627862 FIG00627863: hypothetical protein +FIG00627864 FIG00627866: hypothetical protein +FIG00627866 FIG00627867: hypothetical protein +FIG00627867 FIG00627868: hypothetical protein +FIG00627868 FIG00627869: hypothetical protein +FIG00627869 FIG00627870: hypothetical protein +FIG00627872 FIG00627873: hypothetical protein +FIG00627873 FIG00627874: hypothetical protein +FIG00627876 PTS system, gluconate-specific IIA component (EC 2.7.1.69) +FIG00627878 FIG00627879: hypothetical protein +FIG00627879 Prophage LambdaSa2, site-specific recombinase, phage integrase family +FIG00627882 FIG00627883: hypothetical protein +FIG00627883 FIG00627884: hypothetical protein +FIG00627884 heat shock protein Hsp20 +FIG00627886 FIG00627889: hypothetical protein +FIG00627890 FIG00627891: hypothetical protein +FIG00627891 FIG00627892: hypothetical protein +FIG00627893 FIG00627895: hypothetical protein +FIG00627898 FIG00627900: hypothetical protein +FIG00627900 FIG00627902: hypothetical protein +FIG00627902 ABC-type antimicrobial peptide transport system, permease component, putative +FIG00627903 FIG00627904: hypothetical protein +FIG00627904 FIG00627905: hypothetical protein +FIG00627907 aldo/keto reductase family protein +FIG00627908 carbonic anhydrase, putative +FIG00627910 FIG00627911: hypothetical protein +FIG00627915 FIG00627916: hypothetical protein +FIG00627917 FIG00627918: hypothetical protein +FIG00627918 FIG00627919: hypothetical protein +FIG00627919 FIG00627920: hypothetical protein +FIG00627920 FIG00627921: hypothetical protein +FIG00627923 FIG00627924: hypothetical protein +FIG00627924 holin, putative +FIG00627926 FIG00627927: hypothetical protein +FIG00627928 FIG00627929: hypothetical protein +FIG00627930 ABC transported MDR-type, ATPase component +FIG00627931 FIG00627932: hypothetical protein +FIG00627932 FIG00627933: hypothetical protein +FIG00627933 FIG00627934: hypothetical protein +FIG00627934 FIG00627935: hypothetical protein +FIG00627936 Type I site-specific deoxyribonuclease HsdR +FIG00627940 FIG00627941: hypothetical protein +FIG00627941 FIG00627942: hypothetical protein +FIG00627942 FIG00627944: hypothetical protein +FIG00627944 FIG00627945: hypothetical protein +FIG00627945 FIG00627946: hypothetical protein +FIG00627946 FIG00627947: hypothetical protein +FIG00627947 FIG00627948: hypothetical protein +FIG00627948 FIG00627952: hypothetical protein +FIG00627952 FIG00627953: hypothetical protein +FIG00627953 FIG00627954: hypothetical protein +FIG00627956 phosphonoacetaldehyde hydrolase +FIG00627959 FIG00627960: hypothetical protein +FIG00627960 FIG00627962: hypothetical protein +FIG00627965 ORF009 +FIG00627967 FIG00627968: hypothetical protein +FIG00627969 FIG00627970: hypothetical protein +FIG00627972 FIG00627973: hypothetical protein +FIG00627973 Protein of unknown function DUF916, cell surface putative +FIG00627975 FIG00627976: hypothetical protein +FIG00627979 FIG00627980: hypothetical protein +FIG00627980 Phage capsid and scaffold +FIG00627981 FIG00627982: hypothetical protein +FIG00627983 FIG00627984: hypothetical protein +FIG00627984 Hypothetical integral membrane protein +FIG00627991 FIG00627993: hypothetical protein +FIG00627997 FIG00628001: hypothetical protein +FIG00628001 FIG00628002: hypothetical protein +FIG00628004 FIG00628005: hypothetical protein +FIG00628006 Aggregation substance Asa1/PrgB +FIG00628007 FIG00628008: hypothetical protein +FIG00628008 FIG00628009: hypothetical protein +FIG00628011 Peptidase C60, sortase A and B +FIG00628013 FIG00628014: hypothetical protein +FIG00628014 FIG00628016: hypothetical protein +FIG00628016 FIG00628018: hypothetical protein +FIG00628018 FIG00628019: hypothetical protein +FIG00628019 Cell surface hydrolase, membrane-bound +FIG00628024 FIG00628025: hypothetical protein +FIG00628026 FIG00628027: hypothetical protein +FIG00628027 protein of unknown function UPF0118 +FIG00628028 FIG00628032: hypothetical protein +FIG00628035 FIG00628036: hypothetical protein +FIG00628036 FIG00628037: hypothetical protein +FIG00628038 FIG00628039: hypothetical protein +FIG00628040 FIG00628041: hypothetical protein +FIG00628041 acetyl xylan esterase, putative +FIG00628042 FIG00628043: hypothetical protein +FIG00628043 FIG00628045: hypothetical protein +FIG00628045 FIG00628046: hypothetical protein +FIG00628046 FIG00628047: hypothetical protein +FIG00628047 Cof-like hydrolase +FIG00628048 FIG00628049: hypothetical protein +FIG00628049 FIG00628050: hypothetical protein +FIG00628055 FAD-dependent pyridine nucleotide-disulphide oxidoreductase +FIG00628057 FIG00628059: hypothetical protein +FIG00628060 FIG00628061: hypothetical protein +FIG00628061 FIG00628064: hypothetical protein +FIG00628064 FIG00628065: hypothetical protein +FIG00628065 FIG00628066: hypothetical protein +FIG00628066 FIG00628067: hypothetical protein +FIG00628067 FIG00628068: hypothetical protein +FIG00628068 FIG00628069: hypothetical protein +FIG00628069 FIG00628070: hypothetical protein +FIG00628071 putative single stranded DNA binding protein +FIG00628075 FIG00628076: hypothetical protein +FIG00628076 FIG00628077: hypothetical protein +FIG00628078 FIG00628080: hypothetical protein +FIG00628081 FIG00628082: hypothetical protein +FIG00628084 decarboxylase, putative +FIG00628086 FIG00628088: hypothetical protein +FIG00628089 Transcriptional activator tipA +FIG00628094 FIG00628095: hypothetical protein +FIG00628095 lipase, putative +FIG00628099 FIG00628100: hypothetical protein +FIG00628100 FIG00628101: hypothetical protein +FIG00628101 FIG00628102: hypothetical protein +FIG00628103 DNA replication protein, putative +FIG00628105 FIG00628107: hypothetical protein +FIG00628107 Oligoendopeptidase F (EC 3.4.24.-) +FIG00628111 FIG00628113: hypothetical protein +FIG00628113 FIG00628114: hypothetical protein +FIG00628116 FIG00628117: hypothetical protein +FIG00628117 FIG00628118: hypothetical protein +FIG00628118 FIG00628119: hypothetical protein +FIG00628122 similar to thioredoxin +FIG00628123 FIG00628124: hypothetical protein +FIG00628124 traA protein +FIG00628128 FIG00628129: hypothetical protein +FIG00628129 FIG00628130: hypothetical protein +FIG00628135 FIG00628137: hypothetical protein +FIG00628137 FIG00628138: hypothetical protein +FIG00628138 transcriptional regulator, TetR family +FIG00628139 YTEU +FIG00628140 FIG00628141: hypothetical protein +FIG00628141 FIG00628142: hypothetical protein +FIG00628142 FIG00628144: hypothetical protein +FIG00628146 FIG00628147: hypothetical protein +FIG00628147 FIG00628150: hypothetical protein +FIG00628150 FIG00628151: hypothetical protein +FIG00628151 FIG00628152: hypothetical protein +FIG00628152 FIG00628157: hypothetical protein +FIG00628157 FIG00628158: hypothetical protein +FIG00628158 FIG00628159: hypothetical protein +FIG00628159 FIG00628160: hypothetical protein +FIG00628160 FIG00628161: hypothetical protein +FIG00628161 FIG00628162: hypothetical protein +FIG00628163 FIG00628164: hypothetical protein +FIG00628171 FIG00628172: hypothetical protein +FIG00628172 FIG00628174: hypothetical protein +FIG00628176 FIG00628177: hypothetical protein +FIG00628177 FIG00628178: hypothetical protein +FIG00628180 FIG00628181: hypothetical protein +FIG00628181 Acyl-coenzyme A synthetases/AMP-(fatty) acid ligase +FIG00628182 FIG00628183: hypothetical protein +FIG00628183 hypothetical protein +FIG00628187 FIG00628189: hypothetical protein +FIG00628190 FIG00628191: hypothetical protein +FIG00628194 Acid-resistant locus arl7 (Fragment) +FIG00628195 FIG00628196: hypothetical protein +FIG00628196 PTS system, hyaluronate-oligosaccharide-specific IID component (EC 2.7.1.69) +FIG00628197 FIG00628199: hypothetical protein +FIG00628199 FIG00628200: hypothetical protein +FIG00628203 major tail protein +FIG00628207 FIG00628208: hypothetical protein +FIG00628208 FIG00628209: hypothetical protein +FIG00628209 FIG00628210: hypothetical protein +FIG00628210 FIG00628212: hypothetical protein +FIG00628212 FIG00628213: hypothetical protein +FIG00628213 FIG00628214: hypothetical protein +FIG00628214 membrane protein +FIG00628216 FIG00628218: hypothetical protein +FIG00628218 FIG00628219: hypothetical protein +FIG00628220 FIG00628221: hypothetical protein +FIG00628224 FIG00628225: hypothetical protein +FIG00628228 FIG00628229: hypothetical protein +FIG00628230 FIG00628232: hypothetical protein +FIG00628232 FIG00628233: hypothetical protein +FIG00628233 FIG00628234: hypothetical protein +FIG00628234 Transcriptional regulatory protein levR +FIG00628238 FIG00628239: hypothetical protein +FIG00628239 LacX protein, plasmid +FIG00628240 FIG00628241: hypothetical protein +FIG00628241 FIG00628242: hypothetical protein +FIG00628242 FIG00628245: hypothetical protein +FIG00628245 FIG00628246: hypothetical protein +FIG00628247 FIG00628249: hypothetical protein +FIG00628249 FIG00628250: hypothetical protein +FIG00628250 FIG00628251: hypothetical protein +FIG00628255 FIG00628256: hypothetical protein +FIG00628256 FIG00628259: hypothetical protein +FIG00628259 orf13 +FIG00628263 FIG00628264: hypothetical protein +FIG00628264 FIG00628265: hypothetical protein +FIG00628265 FIG00628266: hypothetical protein +FIG00628267 FIG00628269: hypothetical protein +FIG00628271 Accessory gene regulator protein A +FIG00628273 transcriptional regulator, AraC family +FIG00628275 FIG00628276: hypothetical protein +FIG00628276 FIG00628277: hypothetical protein +FIG00628278 Multidrug resistance-associated protein 5 (EC 3.6.3.44) (Glutathione S-conjugate-transporting ATPase 5) (ATP-energized glutathione S-conjugate pump 5) +FIG00628282 FIG00628283: hypothetical protein +FIG00628283 Lysophospholipase L1 related esterase +FIG00628285 FIG086557: Conjugation related protein +FIG00628286 FIG00774441: hypothetical protein +FIG00628291 FIG00628292: hypothetical protein +FIG00628292 FIG00628293: hypothetical protein +FIG00628293 FIG00628295: hypothetical protein +FIG00628295 COG0553: Superfamily II DNA/RNA helicases, SNF2 family +FIG00628296 FIG00628297: hypothetical protein +FIG00628299 FIG00628300: hypothetical protein +FIG00628301 FIG00628306: hypothetical protein +FIG00628306 FIG00628307: hypothetical protein +FIG00628307 FIG00628310: hypothetical protein +FIG00628310 FIG00628311: hypothetical protein +FIG00628314 FIG00628315: hypothetical protein +FIG00628315 FIG00628316: hypothetical protein +FIG00628316 FIG00628318: hypothetical protein +FIG00628318 FIG00628319: hypothetical protein +FIG00628320 FIG00628322: hypothetical protein +FIG00628323 FIG00628324: hypothetical protein +FIG00628324 FIG00628325: hypothetical protein +FIG00628326 FIG00628327: hypothetical protein +FIG00628327 FIG00628328: hypothetical protein +FIG00628328 FIG00628330: hypothetical protein +FIG00628330 FIG00628331: hypothetical protein +FIG00628331 FIG00628332: hypothetical protein +FIG00628334 FIG00628336: hypothetical protein +FIG00628336 FIG00628337: hypothetical protein +FIG00628338 FIG00628339: hypothetical protein +FIG00628339 Primosomal protein N' (replication factor Y) - superfamily II helicase +FIG00628341 FIG00628342: hypothetical protein +FIG00628342 FIG00628344: hypothetical protein +FIG00628344 FIG00742896: hypothetical protein +FIG00628349 FIG00628350: hypothetical protein +FIG00628353 FIG00628354: hypothetical protein +FIG00628354 FIG00628356: hypothetical protein +FIG00628356 FIG00628358: hypothetical protein +FIG00628358 FIG00628360: hypothetical protein +FIG00628361 membrane protein +FIG00628363 FIG00628365: hypothetical protein +FIG00628365 FIG00628366: hypothetical protein +FIG00628366 FIG00628367: hypothetical protein +FIG00628367 transcription antiterminator, bglG family +FIG00628368 FIG00628370: hypothetical protein +FIG00628372 FIG00628373: hypothetical protein +FIG00628373 Probable metabolite transport protein +FIG00628379 FIG00628380: hypothetical protein +FIG00628383 FIG00628384: hypothetical protein +FIG00628384 FIG00628385: hypothetical protein +FIG00628392 FIG00628393: hypothetical protein +FIG00628393 FIG00628395: hypothetical protein +FIG00628398 L-O-lysylphosphatidylglycerol synthase (EC 2.3.2.3) +FIG00628399 probable enzyme with TIM-barrel fold +FIG00628400 COG1249: Pyruvate/2-oxoglutarate dehydrogenase complex, dihydrolipoamide dehydrogenase (E3) component, and related enzymes +FIG00628401 Integrase regulator RinA +FIG00628405 phosphotransferase system, B component +FIG00628418 FIG00628419: hypothetical protein +FIG00628419 FIG00628420: hypothetical protein +FIG00628420 FIG00628421: hypothetical protein +FIG00628421 FIG00628423: hypothetical protein +FIG00628423 FIG00631120: hypothetical protein +FIG00628425 FIG00628426: hypothetical protein +FIG00628426 Bacillus subtilis catabolite repression transcription factor CcpB +FIG00628427 FIG00628428: hypothetical protein +FIG00628429 methionine synthase, putative +FIG00628433 FIG00628434: hypothetical protein +FIG00628434 FIG00628435: hypothetical protein +FIG00628435 ImpB/MucB/SamB family protein +FIG00628439 FIG00628441: hypothetical protein +FIG00628442 FIG00628443: hypothetical protein +FIG00628447 FIG00628448: hypothetical protein +FIG00628448 FIG00628449: hypothetical protein +FIG00628449 FIG00628451: hypothetical protein +FIG00628451 FIG00628452: hypothetical protein +FIG00628453 FIG00628456: hypothetical protein +FIG00628456 FIG00628457: hypothetical protein +FIG00628457 FIG00628458: hypothetical protein +FIG00628460 aminoglycoside 6-adenylyltransferase +FIG00628461 FIG00629133: hypothetical protein +FIG00628463 FIG00628464: hypothetical protein +FIG00628464 FIG00628465: hypothetical protein +FIG00628465 FIG00628467: hypothetical protein +FIG00628469 prophage Lp3 protein 19, head-to-tail joining +FIG00628472 FIG00628474: hypothetical protein +FIG00628474 FIG00628476: hypothetical protein +FIG00628476 putative asparagine synthetase +FIG00628477 FIG00439284: hypothetical protein +FIG00628480 FIG00628481: hypothetical protein +FIG00628481 Protein of unknown function DUF534 +FIG00628482 FIG00628483: hypothetical protein +FIG00628483 FIG00628484: hypothetical protein +FIG00628485 Putative N-acetyltransferase, GNAT family +FIG00628486 RibTD gene product +FIG00628488 FIG00628489: hypothetical protein +FIG00628489 FIG00628491: hypothetical protein +FIG00628491 FIG00628492: hypothetical protein +FIG00628493 possible ATPase +FIG00628494 fibronectin-binding protein, putative +FIG00628497 FIG00628498: hypothetical protein +FIG00628500 FIG00628501: hypothetical protein +FIG00628505 FIG00628506: hypothetical protein +FIG00628506 FIG00628507: hypothetical protein +FIG00628507 endo-1,4-beta-glucanase +FIG00628513 FIG00628515: hypothetical protein +FIG00628515 FIG00628516: hypothetical protein +FIG00628516 Putative peptidase A +FIG00628519 FIG00628520: hypothetical protein +FIG00628520 FIG00628521: hypothetical protein +FIG00628521 FIG00628522: hypothetical protein +FIG00628522 FIG00628523: hypothetical protein +FIG00628524 FIG00628526: hypothetical protein +FIG00628526 Helix-turn-helix, AraC type:Bacterial transcription activator, effector binding +FIG00628534 FIG00628535: hypothetical protein +FIG00628535 FIG00628536: hypothetical protein +FIG00628536 FIG00628537: hypothetical protein +FIG00628537 FIG00628538: hypothetical protein +FIG00628538 FIG00628539: hypothetical protein +FIG00628541 FIG00628542: hypothetical protein +FIG00628546 FIG00628547: hypothetical protein +FIG00628547 FIG00628550: hypothetical protein +FIG00628550 FIG00628553: hypothetical protein +FIG00628554 FIG00628555: hypothetical protein +FIG00628555 FIG00628556: hypothetical protein +FIG00628556 FIG00628558: hypothetical protein +FIG00628562 FIG00628563: hypothetical protein +FIG00628565 FIG00628566: hypothetical protein +FIG00628568 FIG00628569: hypothetical protein +FIG00628569 FIG00628570: hypothetical protein +FIG00628571 VanZ like protein:RDD +FIG00628572 FIG00628573: hypothetical protein +FIG00628574 phosphatidylserine decarboxylase( EC:4.1.1.65 ) +FIG00628578 FIG00628579: hypothetical protein +FIG00628579 FIG00628580: hypothetical protein +FIG00628580 FIG00628582: hypothetical protein +FIG00628582 ErfK/YbiS/YcfS/YnhG family protein, putative +FIG00628584 FIG00628585: hypothetical protein +FIG00628586 FIG00628587: hypothetical protein +FIG00628587 FIG00628588: hypothetical protein +FIG00628588 FIG00628589: hypothetical protein +FIG00628592 thioesterase family protein +FIG00628593 Flagellar protein fliJ +FIG00628598 FIG00628600: hypothetical protein +FIG00628603 FIG00628605: hypothetical protein +FIG00628605 FIG00628606: hypothetical protein +FIG00628606 transcription repressor +FIG00628607 FIG00628608: hypothetical protein +FIG00628608 FIG00628610: hypothetical protein +FIG00628610 FIG00628612: hypothetical protein +FIG00628613 FIG00628615: hypothetical protein +FIG00628615 FIG00628616: hypothetical protein +FIG00628616 putative Two-component system sensor histidine kinase +FIG00628619 FIG00628620: hypothetical protein +FIG00628622 FIG00628623: hypothetical protein +FIG00628624 FIG00628625: hypothetical protein +FIG00628625 FIG00628626: hypothetical protein +FIG00628627 amino acid ABC transporter permease +FIG00628628 FIG00628629: hypothetical protein +FIG00628629 FIG00628630: hypothetical protein +FIG00628630 FIG00628631: hypothetical protein +FIG00628631 ABC transporter, ATP-binding protein +FIG00628634 FIG00628635: hypothetical protein +FIG00628635 FIG00628636: hypothetical protein +FIG00628637 FIG00628638: hypothetical protein +FIG00628638 FIG00628639: hypothetical protein +FIG00628639 FIG00628641: hypothetical protein +FIG00628643 FIG00628645: hypothetical protein +FIG00628645 FIG00628646: hypothetical protein +FIG00628646 FIG00628647: hypothetical protein +FIG00628647 FIG00628648: hypothetical protein +FIG00628649 FIG00628650: hypothetical protein +FIG00628650 Accessory protein YqeC in selenium-dependent molybdenum hydroxylase maturation +FIG00628651 Tn916, transcriptional regulator, putative +FIG00628653 FIG00628654: hypothetical protein +FIG00628655 FIG00628657: hypothetical protein +FIG00628657 FIG00628658: hypothetical protein +FIG00628658 FIG00628659: hypothetical protein +FIG00628659 zinc-binding transcriptional regulator, Cro/CI family +FIG00628660 FIG00628661: hypothetical protein +FIG00628661 FIG00628662: hypothetical protein +FIG00628662 FIG00628664: hypothetical protein +FIG00628666 FIG00628667: hypothetical protein +FIG00628667 PTS system, mannose-specific IIAB component (EC 2.7.1.69) +FIG00628668 FIG00628669: hypothetical protein +FIG00628670 FIG00628671: hypothetical protein +FIG00628671 FIG00628672: hypothetical protein +FIG00628674 FIG00628675: hypothetical protein +FIG00628675 FIG00628676: hypothetical protein +FIG00628681 FIG00628682: hypothetical protein +FIG00628682 FIG00628683: hypothetical protein +FIG00628683 FIG00628685: hypothetical protein +FIG00628685 FIG00628686: hypothetical protein +FIG00628689 FIG00628690: hypothetical protein +FIG00628690 FIG00628691: hypothetical protein +FIG00628691 FIG00628692: hypothetical protein +FIG00628694 FIG00628695: hypothetical protein +FIG00628698 FIG00628699: hypothetical protein +FIG00628699 ABC transporter, sugar binding protein +FIG00628700 FIG00628701: hypothetical protein +FIG00628702 FIG00628703: hypothetical protein +FIG00628703 FIG00628704: hypothetical protein +FIG00628704 Putative amidotransferase similar to cobyric acid synthase +FIG00628705 FIG00628706: hypothetical protein +FIG00628708 Activator of copYZAB +FIG00628712 FIG00628713: hypothetical protein +FIG00628713 FIG00628714: hypothetical protein +FIG00628716 FIG00628717: hypothetical protein +FIG00628717 Ferredoxin reductase +FIG00628718 FIG00628719: hypothetical protein +FIG00628720 FIG00628721: hypothetical protein +FIG00628721 NADPH-dependent FMN reductase domain protein +FIG00628723 FIG00628725: hypothetical protein +FIG00628726 FIG00628727: hypothetical protein +FIG00628727 Pheromone shutdown protein TraB/PrgY +FIG00628728 FIG00628729: hypothetical protein +FIG00628729 FIG00628730: hypothetical protein +FIG00628730 FIG00628731: hypothetical protein +FIG00628733 FIG00628735: hypothetical protein +FIG00628735 tspO protein, putative +FIG00628736 mannosyl-glycoprotein endo-beta-N-acetylglucosaminidase +FIG00628738 prophage Lp3 protein 15, terminase large subunit +FIG00628740 FIG00628741: hypothetical protein +FIG00628748 cell wall-associated protease precursor +FIG00628750 FIG00628751: hypothetical protein +FIG00628751 FIG00628753: hypothetical protein +FIG00628753 Veg protein +FIG00628755 FIG00628756: hypothetical protein +FIG00628756 FIG00628757: hypothetical protein +FIG00628757 FIG00628758: hypothetical protein +FIG00628767 FIG00628768: hypothetical protein +FIG00628768 FIG00628769: hypothetical protein +FIG00628769 ribosomal protein L23, putative +FIG00628771 Hypothetical protein, sulfurtransferase domain +FIG00628772 FIG00628773: hypothetical protein +FIG00628773 FIG00628775: hypothetical protein +FIG00628775 FIG00628776: hypothetical protein +FIG00628778 FIG00628779: hypothetical protein +FIG00628780 Putative transcriptional regulator, GntR family +FIG00628781 FIG00628782: hypothetical protein +FIG00628782 transcriptional regulator (ArsR family) +FIG00628786 FIG00628788: hypothetical protein +FIG00628788 FIG00628789: hypothetical protein +FIG00628789 FIG00628790: hypothetical protein +FIG00628790 FIG00628791: hypothetical protein +FIG00628791 FIG00628792: hypothetical protein +FIG00628796 FIG00628797: hypothetical protein +FIG00628800 replication-associated protein RepA +FIG00628801 FIG00628802: hypothetical protein +FIG00628802 FIG00628803: hypothetical protein +FIG00628804 phosphotransferase system, B component +FIG00628806 FIG011945: O-methyltransferase family protein +FIG00628811 FIG00628813: hypothetical protein +FIG00628813 Uncharacterized phage-encoded protein-like +FIG00628816 FIG00628817: hypothetical protein +FIG00628817 D-Glucosaminate-6-phosphate ammonia-lyase (EC 4.3.1.-) +FIG00628818 FIG00628819: hypothetical protein +FIG00628820 FIG00628822: hypothetical protein +FIG00628824 FIG00628825: hypothetical protein +FIG00628825 Protein of unknown function DUF378 +FIG00628826 FIG00628828: hypothetical protein +FIG00628828 FIG00628829: hypothetical protein +FIG00628831 choloylglycine hydrolase family protein +FIG00628832 Transglycosylase-associated protein +FIG00628834 FIG00628835: hypothetical protein +FIG00628835 Putative oxidoreductase subunit +FIG00628836 FIG00628837: hypothetical protein +FIG00628838 carboxymethylenebutenolidase-related protein +FIG00628839 FIG00628841: hypothetical protein +FIG00628841 FIG00628842: hypothetical protein +FIG00628843 FIG00628844: hypothetical protein +FIG00628844 Conserved membrane protein +FIG00628846 Fibronectin-binding +FIG00628847 FIG00628848: hypothetical protein +FIG00628848 FIG00628849: hypothetical protein +FIG00628850 FIG00628851: hypothetical protein +FIG00628851 Oleate hydratase (EC 4.2.1.53) +FIG00628854 FIG00628855: hypothetical protein +FIG00628855 putative cyclase +FIG00628856 ABC-2 family transporter protein YydJ +FIG00628859 FIG00628860: hypothetical protein +FIG00628860 Hypothetical protein Cj1505c +FIG00628861 FIG00628863: hypothetical protein +FIG00628863 FIG00628865: hypothetical protein +FIG00628865 Glucosyl tranferase II +FIG00628868 COG1192: ATPases involved in chromosome partitioning +FIG00628869 FIG00628870: hypothetical protein +FIG00628870 FIG00628871: hypothetical protein +FIG00628872 Drug resistance transporter EmrB/QacA subfamily +FIG00628873 FIG00628874: hypothetical protein +FIG00628875 FIG00628877: hypothetical protein +FIG00628877 FIG00628879: hypothetical protein +FIG00628879 FIG00628880: hypothetical protein +FIG00628880 FIG00628882: hypothetical protein +FIG00628882 FIG00628883: hypothetical protein +FIG00628883 FIG00628884: hypothetical protein +FIG00628884 FIG00628885: hypothetical protein +FIG00628885 FIG00628886: hypothetical protein +FIG00628886 FIG00628887: hypothetical protein +FIG00628887 FIG00628888: hypothetical protein +FIG00628888 transporter +FIG00628889 FIG00628890: hypothetical protein +FIG00628895 FIG00628897: hypothetical protein +FIG00628897 FIG00628898: hypothetical protein +FIG00628899 FIG00628900: hypothetical protein +FIG00628900 FIG00628902: hypothetical protein +FIG00628903 FIG00628904: hypothetical protein +FIG00628906 FIG00628907: hypothetical protein +FIG00628907 FIG00628908: hypothetical protein +FIG00628911 FIG00628914: hypothetical protein +FIG00628915 FIG00628916: hypothetical protein +FIG00628916 FIG00628917: hypothetical protein +FIG00628917 FIG00628918: hypothetical protein +FIG00628922 FIG00628923: hypothetical protein +FIG00628923 FIG00630625: hypothetical protein +FIG00628924 FIG00628925: hypothetical protein +FIG00628925 FIG00628926: hypothetical protein +FIG00628929 FIG01230468: hypothetical protein +FIG00628931 FIG00628933: hypothetical protein +FIG00628933 FIG00628934: hypothetical protein +FIG00628934 FIG00628935: hypothetical protein +FIG00628939 FIG00628943: hypothetical protein +FIG00628943 FIG00628944: hypothetical protein +FIG00628949 FIG00628950: hypothetical protein +FIG00628952 FIG00628953: hypothetical protein +FIG00628953 FIG00628954: hypothetical protein +FIG00628954 FIG00628955: hypothetical protein +FIG00628955 FIG00628957: hypothetical protein +FIG00628959 FIG00628962: hypothetical protein +FIG00628964 FIG00628965: hypothetical protein +FIG00628967 FIG00628968: hypothetical protein +FIG00628968 relaxase +FIG00628970 FIG00628971: hypothetical protein +FIG00628973 FIG00628974: hypothetical protein +FIG00628975 FIG00628976: hypothetical protein +FIG00628981 FIG00628982: hypothetical protein +FIG00628982 FIG00628984: hypothetical protein +FIG00628984 FIG00628985: hypothetical protein +FIG00628985 FIG00628986: hypothetical protein +FIG00628994 FIG00628995: hypothetical protein +FIG00628995 FIG00628996: hypothetical protein +FIG00628996 DNA repair exonuclease family protein +FIG00629000 magnesium transporter, CorA family +FIG00629001 FIG00629002: hypothetical protein +FIG00629003 FIG00629004: hypothetical protein +FIG00629004 FIG00629006: hypothetical protein +FIG00629006 FIG00629007: hypothetical protein +FIG00629010 FIG00629011: hypothetical protein +FIG00629011 FIG00629012: hypothetical protein +FIG00629012 FIG00629014: hypothetical protein +FIG00629014 FIG00629017: hypothetical protein +FIG00629017 FIG00629018: hypothetical protein +FIG00629018 FIG00629019: hypothetical protein +FIG00629019 leucine-rich protein +FIG00629022 probable ABC transporter protein, ATP-binding component +FIG00629024 FIG00629025: hypothetical protein +FIG00629025 FIG00629026: hypothetical protein +FIG00629026 FIG00629027: hypothetical protein +FIG00629027 FIG00629028: hypothetical protein +FIG00629028 FIG00629029: hypothetical protein +FIG00629030 Surface protein from Gram-positive cocci, anchor region +FIG00629034 FIG00629035: hypothetical protein +FIG00629036 FIG00629037: hypothetical protein +FIG00629037 FIG00629038: hypothetical protein +FIG00629038 protein of unknown function WbhW +FIG00629043 YdiL +FIG00629044 SMC domain protein +FIG00629047 FIG00629048: hypothetical protein +FIG00629048 FIG00629049: hypothetical protein +FIG00629052 FIG00629054: hypothetical protein +FIG00629054 glyoxalase/bleomycin resistance protein/dioxygenase superfamily protein +FIG00629059 cation transporter +FIG00629060 FIG00629062: hypothetical protein +FIG00629062 FIG00629064: hypothetical protein +FIG00629071 FIG00629072: hypothetical protein +FIG00629076 FIG00629077: hypothetical protein +FIG00629078 FIG00629079: hypothetical protein +FIG00629079 FIG00629080: hypothetical protein +FIG00629081 FIG00629082: hypothetical protein +FIG00629086 FIG00629088: hypothetical protein +FIG00629089 FIG00629090: hypothetical protein +FIG00629093 FIG00629095: hypothetical protein +FIG00629096 FIG00629097: hypothetical protein +FIG00629099 FIG00629100: hypothetical protein +FIG00629100 FIG00629101: hypothetical protein +FIG00629105 proposed amino acid ligase found clustered with an amidotransferase +FIG00629106 FIG00629107: hypothetical protein +FIG00629107 aminoglycoside adenylyltransferase +FIG00629109 FIG00629110: hypothetical protein +FIG00629114 FIG00629116: hypothetical protein +FIG00629117 Lj928 prophage protein +FIG00629118 FIG00629119: hypothetical protein +FIG00629119 FIG00629120: hypothetical protein +FIG00629122 structural protein, putative +FIG00629123 FIG00629124: hypothetical protein +FIG00629124 FIG00630050: hypothetical protein +FIG00629125 FIG00629126: hypothetical protein +FIG00629126 aerobic energy metabolism +FIG00629134 FIG00629135: hypothetical protein +FIG00629136 Resolvase +FIG00629139 FIG00629140: hypothetical protein +FIG00629140 FIG00629141: hypothetical protein +FIG00629141 FIG00424119: hypothetical protein +FIG00629142 FIG00629143: hypothetical protein +FIG00629144 FIG00629145: hypothetical protein +FIG00629145 FIG00629146: hypothetical protein +FIG00629146 endonuclease/exonuclease/phosphatase family protein +FIG00629147 glyoxylase family protein +FIG00629148 Predicted HD superfamily hydrolase +FIG00629150 FIG00629151: hypothetical protein +FIG00629151 FIG00629152: hypothetical protein +FIG00629153 FIG00629155: hypothetical protein +FIG00629155 FIG00629156: hypothetical protein +FIG00629156 conserved hypothetical protein +FIG00629157 FIG00629158: hypothetical protein +FIG00629163 FIG00629164: hypothetical protein +FIG00629164 FIG00629165: hypothetical protein +FIG00629165 FIG00629167: hypothetical protein +FIG00629167 FIG00629168: hypothetical protein +FIG00629168 FIG00629169: hypothetical protein +FIG00629172 FIG00629174: hypothetical protein +FIG00629174 FIG00629177: hypothetical protein +FIG00629177 FIG00629178: hypothetical protein +FIG00629183 FIG00629184: hypothetical protein +FIG00629184 FIG00629185: hypothetical protein +FIG00629185 FIG00629191: hypothetical protein +FIG00629191 FIG00629193: hypothetical protein +FIG00629194 FIG00629195: hypothetical protein +FIG00629196 ferrous iron transport protein A +FIG00629197 FIG00629198: hypothetical protein +FIG00629198 FIG00629199: hypothetical protein +FIG00629201 FIG00629202: hypothetical protein +FIG00629202 FIG00629203: hypothetical protein +FIG00629205 FIG00629206: hypothetical protein +FIG00629206 FIG00629207: hypothetical protein +FIG00629208 Rhodanese-like +FIG00629211 FIG00629212: hypothetical protein +FIG00629213 ATP-binding region, ATPase-like:Histidine kinase, HAMP region:Histidine kinase internal region +FIG00629216 FIG00629218: hypothetical protein +FIG00629220 Transglutaminase-like +FIG00629226 FIG00629228: hypothetical protein +FIG00629228 FIG00629229: hypothetical protein +FIG00629231 FIG00629233: hypothetical protein +FIG00629236 FIG00629239: hypothetical protein +FIG00629239 FIG00629240: hypothetical protein +FIG00629240 Major capsid protein (Protein Gp34) (ORF3 protein) +FIG00629242 protease synthase and sporulation negative regulatory protein pai 1, putative +FIG00629243 gram positive anchor protein, putative +FIG00629250 1 TMS, ~690aa hypothetical protein: FIG00629252 +FIG00629255 FIG00629256: hypothetical protein +FIG00629256 FIG00629258: hypothetical protein +FIG00629258 FIG00629261: hypothetical protein +FIG00629261 FIG00629262: hypothetical protein +FIG00629262 rhodanese-like domain protein +FIG00629263 Glucose uptake protein +FIG00629265 FIG00629269: hypothetical protein +FIG00629269 FIG00629270: hypothetical protein +FIG00629277 minor head protein, putative +FIG00629281 FIG00629283: hypothetical protein +FIG00629283 FIG00629284: hypothetical protein +FIG00629284 PTS system, fructose-specific IIBC component (EIIBC-Fru) (Fructose- permease IIBC component) (Phosphotransferase enzyme II, BC component) (EC 2.7.1.69) +FIG00629285 FIG00629286: hypothetical protein +FIG00629289 FIG00629291: hypothetical protein +FIG00629291 FIG00629294: hypothetical protein +FIG00629294 FIG00629295: hypothetical protein +FIG00629296 regulatory protein, TetR +FIG00629297 FIG00629298: hypothetical protein +FIG00629300 FIG00629302: hypothetical protein +FIG00629302 FIG00629303: hypothetical protein +FIG00629303 FIG00629304: hypothetical protein +FIG00629305 FIG00629307: hypothetical protein +FIG00629307 FIG00629308: hypothetical protein +FIG00629309 FIG00629311: hypothetical protein +FIG00629311 FIG00629312: hypothetical protein +FIG00629312 FIG00629313: hypothetical protein +FIG00629313 FIG00629315: hypothetical protein +FIG00629316 FIG00629317: hypothetical protein +FIG00629317 FIG00629318: hypothetical protein +FIG00629318 regulatory protein, LuxR:Response regulator receiver +FIG00629319 FIG00629320: hypothetical protein +FIG00629321 FIG00629322: hypothetical protein +FIG00629322 FIG00629323: hypothetical protein +FIG00629323 FIG00629324: hypothetical protein +FIG00629324 FIG00629325: hypothetical protein +FIG00629325 FIG00629327: hypothetical protein +FIG00629327 FIG00629328: hypothetical protein +FIG00629328 FIG00629329: hypothetical protein +FIG00629335 FIG00629336: hypothetical protein +FIG00629336 Chromosome partitioning ATPase +FIG00629340 LtrD-related protein, putative +FIG00629345 FIG00629346: hypothetical protein +FIG00629346 FIG00629349: hypothetical protein +FIG00629349 FIG00629350: hypothetical protein +FIG00629350 FIG00629351: hypothetical protein +FIG00629354 FIG00629355: hypothetical protein +FIG00629355 major tail protein, putative +FIG00629356 FIG00629358: hypothetical protein +FIG00629358 prophage Lp1 protein 8 +FIG00629365 FIG00629366: hypothetical protein +FIG00629366 FIG00629367: hypothetical protein +FIG00629367 Transcriptional regulator, Mar family +FIG00629369 FIG00629370: hypothetical protein +FIG00629370 cation-transporting ATPase +FIG00629373 Uve2 +FIG00629375 FIG00629376: hypothetical protein +FIG00629376 FIG00629377: hypothetical protein +FIG00629377 Mg2+/citrate complex transporter +FIG00629380 FIG00629381: hypothetical protein +FIG00629381 FIG00629382: hypothetical protein +FIG00629382 FIG00629383: hypothetical protein +FIG00629384 FIG00629386: hypothetical protein +FIG00629386 FIG00629387: hypothetical protein +FIG00629390 FIG00629391: hypothetical protein +FIG00629391 FIG00629393: hypothetical protein +FIG00629394 FIG00629395: hypothetical protein +FIG00629395 FIG00629396: hypothetical protein +FIG00629396 agrBfs protein +FIG00629397 FIG00629398: hypothetical protein +FIG00629398 FIG00629400: hypothetical protein +FIG00629400 DNA methylase, family protein +FIG00629401 FIG00629402: hypothetical protein +FIG00629402 FIG00629403: hypothetical protein +FIG00629404 FIG00629405: hypothetical protein +FIG00629405 Phage uncharacterised protein XkdX +FIG00629406 FIG00629407: hypothetical protein +FIG00629407 FIG00629408: hypothetical protein +FIG00629408 FIG00629409: hypothetical protein +FIG00629409 FIG00775153: hypothetical protein +FIG00629411 FIG00629412: hypothetical protein +FIG00629412 FIG00629413: hypothetical protein +FIG00629413 FIG00629414: hypothetical protein +FIG00629414 FIG00629415: hypothetical protein +FIG00629415 FIG00629420: hypothetical protein +FIG00629420 FIG00629421: hypothetical protein +FIG00629424 FIG00629425: hypothetical protein +FIG00629430 lipoprotein +FIG00629431 PTS system, IIA component, putative +FIG00629432 FIG00629433: hypothetical protein +FIG00629433 FIG00629435: hypothetical protein +FIG00629435 regulatory proteins, IclR +FIG00629437 abortive infection protein +FIG00629438 FIG00628040: hypothetical protein +FIG00629440 FIG00629441: hypothetical protein +FIG00629443 FIG00629444: hypothetical protein +FIG00629446 FIG00629448: hypothetical protein +FIG00629448 FIG00629449: hypothetical protein +FIG00629449 FIG00629450: hypothetical protein +FIG00629450 FIG00629451: hypothetical protein +FIG00629453 FIG001886: Cytoplasmic hypothetical protein +FIG00629455 FIG00629456: hypothetical protein +FIG00629458 FIG00629460: hypothetical protein +FIG00629462 Protein of unknown function DUF74 +FIG00629464 FIG00629467: hypothetical protein +FIG00629467 Predicted hydrolase of the HAD superfamily +FIG00629469 FIG00629471: hypothetical protein +FIG00629471 FIG00629472: hypothetical protein +FIG00629472 FIG00629473: hypothetical protein +FIG00629473 FIG00629474: hypothetical protein +FIG00629474 FIG00629475: hypothetical protein +FIG00629475 FIG00629478: hypothetical protein +FIG00629478 Nucleoside 2-deoxyribosyltransferase +FIG00629480 FIG00629481: hypothetical protein +FIG00629486 endo-beta-N-acetylglucosaminidase +FIG00629487 FIG00629489: hypothetical protein +FIG00629491 FIG00629492: hypothetical protein +FIG00629492 FIG00629493: hypothetical protein +FIG00629494 PTS system, gluconate-specific IID component (EC 2.7.1.69) +FIG00629497 Response regulator receiver:Transcriptional regulatory protein, C-terminal +FIG00629503 FIG00629504: hypothetical protein +FIG00629506 manganese-containing catalase( EC:1.11.1.6 ) +FIG00629508 FIG00629509: hypothetical protein +FIG00629510 Response regulator receiver:Transcriptional regulatory protein-like +FIG00629511 FIG00629512: hypothetical protein +FIG00629512 Conjugation pore forming protein EbsA +FIG00629517 transcriptional regulator, LysR family, putative +FIG00629522 FIG00629523: hypothetical protein +FIG00629523 FIG00629525: hypothetical protein +FIG00629525 FIG00629526: hypothetical protein +FIG00629530 FIG00629531: hypothetical protein +FIG00629533 replicase domain protein +FIG00629535 FIG00629539: hypothetical protein +FIG00629539 CRISPR-associated protein, Csn2 family +FIG00629542 FIG00629544: hypothetical protein +FIG00629544 FIG00629547: hypothetical protein +FIG00629547 FIG00629548: hypothetical protein +FIG00629548 FIG00629550: hypothetical protein +FIG00629550 FIG00629551: hypothetical protein +FIG00629551 transcriptional regulator, ArpU family +FIG00629555 FIG00629557: hypothetical protein +FIG00629558 FIG00629560: hypothetical protein +FIG00629560 FIG00629562: hypothetical protein +FIG00629562 FIG00629563: hypothetical protein +FIG00629565 FIG00629566: hypothetical protein +FIG00629566 FIG00629568: hypothetical protein +FIG00629570 FIG00629572: hypothetical protein +FIG00629572 FIG00629573: hypothetical protein +FIG00629573 FIG00629574: hypothetical protein +FIG00629574 FIG00629575: hypothetical protein +FIG00629575 FIG00629576: hypothetical protein +FIG00629576 COG0583: Transcriptional regulator +FIG00629581 FIG00629582: hypothetical protein +FIG00629583 N-acetylmuramoyl-L-alanine amidase, family 2 +FIG00629584 FIG00629585: hypothetical protein +FIG00629585 FIG00629588: hypothetical protein +FIG00629589 FIG00629590: hypothetical protein +FIG00629590 FIG00629592: hypothetical protein +FIG00629592 FIG00629595: hypothetical protein +FIG00629595 tRNA-dependent lipid II-Ala--L-alanine ligase @ tRNA-dependent lipid II-AlaAla--L-alanine ligase +FIG00629598 FIG00629599: hypothetical protein +FIG00629599 FIG00629600: hypothetical protein +FIG00629604 FIG00629605: hypothetical protein +FIG00629607 FIG00629609: hypothetical protein +FIG00629609 FIG00629611: hypothetical protein +FIG00629611 probable immunity protein +FIG00629612 nisin-resistance protein, putative +FIG00629619 FIG00629621: hypothetical protein +FIG00629623 FIG00629625: hypothetical protein +FIG00629626 FIG00629628: hypothetical protein +FIG00629628 putative ABC transporter, membrane protein subunit and ATP-binding protein +FIG00629629 FIG00629630: hypothetical protein +FIG00629631 FIG00629632: hypothetical protein +FIG00629632 FIG00629633: hypothetical protein +FIG00629633 FIG00629636: hypothetical protein +FIG00629636 FIG00629639: hypothetical protein +FIG00629639 FIG00629640: hypothetical protein +FIG00629640 FIG00629642: hypothetical protein +FIG00629642 FIG00629643: hypothetical protein +FIG00629643 Oligopeptide ABC transporter ATP-binding protein +FIG00629645 phage minor structural protein +FIG00629647 FIG00633031: hypothetical protein +FIG00629649 PTS system, hyaluronate-oligosaccharide-specific IID component (EC 2.7.1.69) +FIG00629652 FIG00629653: hypothetical protein +FIG00629653 FIG00629655: hypothetical protein +FIG00629656 FIG00629658: hypothetical protein +FIG00629660 FIG00629661: hypothetical protein +FIG00629661 FIG00629664: hypothetical protein +FIG00629664 permease of the major facilitator superfamily +FIG00629665 bacitracin ABC transporter, permease protein, putative +FIG00629670 FIG00629671: hypothetical protein +FIG00629671 FIG00629673: hypothetical protein +FIG00629673 FIG00629674: hypothetical protein +FIG00629676 FIG00629678: hypothetical protein +FIG00629685 FIG00629686: hypothetical protein +FIG00629686 FIG00629687: hypothetical protein +FIG00629687 FIG00629688: hypothetical protein +FIG00629688 FIG00629689: hypothetical protein +FIG00629689 FIG00629692: hypothetical protein +FIG00629692 FIG00629693: hypothetical protein +FIG00629698 FIG01114498: hypothetical protein +FIG00629702 Phage holin +FIG00629710 FIG00629711: hypothetical protein +FIG00629711 FIG00629712: hypothetical protein +FIG00629712 FIG00629713: hypothetical protein +FIG00629713 FIG00629715: hypothetical protein +FIG00629717 positive control factor, putative +FIG00629719 molybdopterin-guanine dinucleotide biosynthesis protein A, putative +FIG00629721 FIG00629722: hypothetical protein +FIG00629722 FIG00629723: hypothetical protein +FIG00629723 FIG00629725: hypothetical protein +FIG00629725 Membrane-embedded metalloprotease YydH +FIG00629731 FIG00629732: hypothetical protein +FIG00629734 FIG00629735: hypothetical protein +FIG00629737 FIG00629738: hypothetical protein +FIG00629741 FIG00629743: hypothetical protein +FIG00629743 FIG00629744: hypothetical protein +FIG00629744 FIG00629745: hypothetical protein +FIG00629745 FIG00629747: hypothetical protein +FIG00629750 conserved hypothetical protein +FIG00629751 FIG00629752: hypothetical protein +FIG00629757 thioredoxin family protein +FIG00629762 FIG00629764: hypothetical protein +FIG00629766 lacto-N-biosidase( EC:3.2.1.52 ) +FIG00629771 methyl-accepting chemotaxis transducer/sensory box protein +FIG00629776 transcriptional antiterminator, BglG family +FIG00629779 FIG00629781: hypothetical protein +FIG00629785 FIG00629786: hypothetical protein +FIG00629786 FIG00629787: hypothetical protein +FIG00629787 FIG00629788: hypothetical protein +FIG00629788 FIG00629789: hypothetical protein +FIG00629792 FIG00629793: hypothetical protein +FIG00629794 FIG00629796: hypothetical protein +FIG00629796 FIG00629797: hypothetical protein +FIG00629797 FIG00629798: hypothetical protein +FIG00629799 FIG00629800: hypothetical protein +FIG00629800 Putative galactosidase +FIG00629801 Transcriptional regulatory protein zraR +FIG00629802 FIG00629803: hypothetical protein +FIG00629804 FIG00629805: hypothetical protein +FIG00629806 FIG00629807: hypothetical protein +FIG00629807 FIG00629808: hypothetical protein +FIG00629808 FIG00629809: hypothetical protein +FIG00629809 FIG00629810: hypothetical protein +FIG00629813 serine proteinase, V8 family +FIG00629814 FIG00629817: hypothetical protein +FIG00629820 FIG00629821: hypothetical protein +FIG00629821 NADPH-flavin oxidoreductase +FIG00629822 FIG00629823: hypothetical protein +FIG00629823 FIG00629826: hypothetical protein +FIG00629826 conjugal transfer protein, putative +FIG00629828 COG2827: putative endonuclease containing a URI domain +FIG00629829 hypothetical protein +FIG00629835 FIG00629836: hypothetical protein +FIG00629836 FIG00629960: hypothetical protein +FIG00629838 FIG00629839: hypothetical protein +FIG00629839 replication-associated protein B +FIG00629841 FIG00629842: hypothetical protein +FIG00629846 FIG00629847: hypothetical protein +FIG00629853 Hypothetical protein HMPREF9502_01760 +FIG00629856 Integrase/recombinase, phage integrase family +FIG00629858 FIG00629859: hypothetical protein +FIG00629862 FIG00629863: hypothetical protein +FIG00629864 FIG00629865: hypothetical protein +FIG00629865 FIG00629866: hypothetical protein +FIG00629867 Cof protein:HAD-superfamily hydrolase, subfamily IIB +FIG00629869 FIG00746184: hypothetical protein +FIG00629870 FIG00629872: hypothetical protein +FIG00629879 Protein of unknown function DUF58 +FIG00629880 MaoC like domain protein +FIG00629881 putative PTS system, IIb component +FIG00629884 FIG00629885: hypothetical protein +FIG00629886 FIG00629887: hypothetical protein +FIG00629891 FIG00629892: hypothetical protein +FIG00629892 FIG00629895: hypothetical protein +FIG00629895 FIG00629896: hypothetical protein +FIG00629898 FIG00629899: hypothetical protein +FIG00629899 FIG00629900: hypothetical protein +FIG00629900 FIG00629901: hypothetical protein +FIG00629901 FIG00629902: hypothetical protein +FIG00629902 hypothetical protein +FIG00629904 FIG00629905: hypothetical protein +FIG00629906 FIG00629907: hypothetical protein +FIG00629907 FIG00629908: hypothetical protein +FIG00629911 FIG00629912: hypothetical protein +FIG00629912 FIG00629913: hypothetical protein +FIG00629913 FIG00629914: hypothetical protein +FIG00629914 FIG00629915: hypothetical protein +FIG00629915 sugar-binding transcriptional regulator, GntR family +FIG00629916 Autolysin response regulator +FIG00629917 FIG00629921: hypothetical protein +FIG00629921 transcriptional regulator +FIG00629927 FIG00629928: hypothetical protein +FIG00629930 FIG00629931: hypothetical protein +FIG00629931 FIG00629932: hypothetical protein +FIG00629933 FIG00629934: hypothetical protein +FIG00629934 FIG00629935: hypothetical protein +FIG00629940 transcriptional regulator, MarR family +FIG00629941 FIG00629943: hypothetical protein +FIG00629948 FIG00629949: hypothetical protein +FIG00629950 hypothetical protein +FIG00629952 FIG00629953: hypothetical protein +FIG00629954 vrlI protein, putative +FIG00629956 FIG00629957: hypothetical protein +FIG00629957 FIG00629958: hypothetical protein +FIG00629958 FIG00629959: hypothetical protein +FIG00629963 FIG00629964: hypothetical protein +FIG00629964 aminotransferase( EC:2.6.1.- ) +FIG00629966 FIG00629968: hypothetical protein +FIG00629971 similar to transcriptional regulator +FIG00629975 Tn916, transcriptional regulator, putative +FIG00629977 FIG00629978: hypothetical protein +FIG00629978 LmrB +FIG00629980 FIG00629981: hypothetical protein +FIG00629990 FIG00629991: hypothetical protein +FIG00629991 Oligopeptide ABC transporter, periplasmic oligopeptide-binding protein oppA (TC 3.A.1.5.1) +FIG00629992 FIG00629994: hypothetical protein +FIG00629994 FIG00629995: hypothetical protein +FIG00629995 FIG00629996: hypothetical protein +FIG00629996 minor structural protein, putative +FIG00629997 FIG00629998: hypothetical protein +FIG00629999 FIG00630003: hypothetical protein +FIG00630009 FIG00630011: hypothetical protein +FIG00630011 FIG00630012: hypothetical protein +FIG00630016 FIG00630017: hypothetical protein +FIG00630017 FIG00630018: hypothetical protein +FIG00630018 FIG00630019: hypothetical protein +FIG00630019 FIG00630022: hypothetical protein +FIG00630022 PTS system, mannose/fructose/sorbose family, IIC component +FIG00630023 phosphoenolpyruvate-dependent sugar phosphotransferase system EIID, probable fructose specific +FIG00630025 FIG00630026: hypothetical protein +FIG00630026 FIG00630027: hypothetical protein +FIG00630027 recombination protein U, putative +FIG00630028 lactose transport system (permease) +FIG00630030 Surface exclusion protein Sea1/PrgA +FIG00630031 FIG00630032: hypothetical protein +FIG00630034 FIG00630035: hypothetical protein +FIG00630035 FIG00630036: hypothetical protein +FIG00630036 FIG00630039: hypothetical protein +FIG00630043 FIG00630045: hypothetical protein +FIG00630046 FIG00630048: hypothetical protein +FIG00630051 FIG00630055: hypothetical protein +FIG00630056 FIG00630057: hypothetical protein +FIG00630058 FIG00630063: hypothetical protein +FIG00630063 FIG00630064: hypothetical protein +FIG00630065 FIG00630066: hypothetical protein +FIG00630066 FIG00630068: hypothetical protein +FIG00630068 FIG00630070: hypothetical protein +FIG00630070 FIG00630072: hypothetical protein +FIG00630072 FIG00630073: hypothetical protein +FIG00630073 FIG00630074: hypothetical protein +FIG00630074 Protein of unknown function DUF218 +FIG00630076 holin +FIG00630077 FIG00630078: hypothetical protein +FIG00630080 FIG00630081: hypothetical protein +FIG00630081 FIG00630083: hypothetical protein +FIG00630085 Predicted nucleoside-diphosphate-sugar epimerase +FIG00630086 FIG00630087: hypothetical protein +FIG00630088 FIG00630091: hypothetical protein +FIG00630091 FIG00630092: hypothetical protein +FIG00630092 FIG00630094: hypothetical protein +FIG00630095 FIG00630096: hypothetical protein +FIG00630096 FIG00630098: hypothetical protein +FIG00630106 FIG00630107: hypothetical protein +FIG00630109 FIG00630110: hypothetical protein +FIG00630112 FIG00630113: hypothetical protein +FIG00630115 FIG00630116: hypothetical protein +FIG00630116 FIG00630117: hypothetical protein +FIG00630117 FIG00630118: hypothetical protein +FIG00630121 FIG00630122: hypothetical protein +FIG00630122 FIG00630125: hypothetical protein +FIG00630125 FIG00630127: hypothetical protein +FIG00630127 FIG00630129: hypothetical protein +FIG00630129 FIG00630131: hypothetical protein +FIG00630131 FIG00630132: hypothetical protein +FIG00630133 FIG00630134: hypothetical protein +FIG00630134 FIG00630136: hypothetical protein +FIG00630136 FIG00630137: hypothetical protein +FIG00630137 FIG00630139: hypothetical protein +FIG00630140 FIG00630141: hypothetical protein +FIG00630141 FIG00630142: hypothetical protein +FIG00630142 FIG00630143: hypothetical protein +FIG00630144 prophage Lp1 protein 51 +FIG00630146 FIG00630149: hypothetical protein +FIG00630150 FIG00630151: hypothetical protein +FIG00630151 FIG00630152: hypothetical protein +FIG00630155 FIG00630156: hypothetical protein +FIG00630157 FIG00630159: hypothetical protein +FIG00630159 YbaK/prolyl-tRNA synthetase associated region +FIG00630163 FIG00630164: hypothetical protein +FIG00630164 FIG00630165: hypothetical protein +FIG00630165 FIG00630166: hypothetical protein +FIG00630166 FIG00630169: hypothetical protein +FIG00630171 FIG00630172: hypothetical protein +FIG00630175 FIG00630176: hypothetical protein +FIG00630177 6-aminohexanoate-cyclic-dimer hydrolase, putative +FIG00630188 FIG00630189: hypothetical protein +FIG00630192 FIG00630194: hypothetical protein +FIG00630196 FIG00630197: hypothetical protein +FIG00630197 FIG00630198: hypothetical protein +FIG00630198 putative aminoglycoside 6-adenylyltansferase +FIG00630200 Sugar isomerase (SIS) +FIG00630203 FIG00630204: hypothetical protein +FIG00630204 FIG01240125: hypothetical protein +FIG00630208 protein probably involved in xylan degradation; possible xylan esterase +FIG00630209 PTS system, hyaluronate-oligosaccharide-specific IIA component (EC 2.7.1.69) +FIG00630216 Pheromone response surface protein PrgC +FIG00630220 FIG00630221: hypothetical protein +FIG00630222 FIG00630224: hypothetical protein +FIG00630224 FIG00630227: hypothetical protein +FIG00630228 FIG00630229: hypothetical protein +FIG00630231 FIG00630233: hypothetical protein +FIG00630233 FIG00630235: hypothetical protein +FIG00630237 conserved hypothetical protein TIGR00481 +FIG00630241 Replication initiation and membrane attachment +FIG00630244 acyl carrier protein phosphodiesterase( EC:3.1.4.14 ) +FIG00630245 FIG00630246: hypothetical protein +FIG00630246 FIG00630247: hypothetical protein +FIG00630252 FIG00630256: hypothetical protein +FIG00630256 Protein of unknown function UPF0118 +FIG00630257 helix-turn-helix domain protein +FIG00630258 FIG00630259: hypothetical protein +FIG00630261 FIG00630262: hypothetical protein +FIG00630262 FIG00630263: hypothetical protein +FIG00630263 FIG00630265: hypothetical protein +FIG00630265 FIG00630266: hypothetical protein +FIG00630268 FIG00630269: hypothetical protein +FIG00630269 FIG00630274: hypothetical protein +FIG00630279 FIG00630281: hypothetical protein +FIG00630281 FIG00630282: hypothetical protein +FIG00630283 FIG00630284: hypothetical protein +FIG00630284 FIG00630285: hypothetical protein +FIG00630285 Mn-containing catalase( EC:1.11.1.6 ) +FIG00630286 FIG00630287: hypothetical protein +FIG00630287 FIG00630288: hypothetical protein +FIG00630292 FIG00630293: hypothetical protein +FIG00630297 collagen adhesin protein +FIG00630298 pentapeptide repeat family protein +FIG00630299 FIG00630300: hypothetical protein +FIG00630300 SPFH domain/band 7 family protein +FIG00630306 FIG00630307: hypothetical protein +FIG00630308 FIG00630311: hypothetical protein +FIG00630311 FIG00630312: hypothetical protein +FIG00630313 FIG00630314: hypothetical protein +FIG00630314 FIG00630317: hypothetical protein +FIG00630317 FIG00630320: hypothetical protein +FIG00630320 Upper collar protein (Connector protein) (Late protein GP10) +FIG00630321 FIG00630322: hypothetical protein +FIG00630322 FIG00630325: hypothetical protein +FIG00630325 transcriptional regulator (TetR/AcrR family) protein +FIG00630327 terminase, small subunit, internal deletion +FIG00630328 FIG00630329: hypothetical protein +FIG00630329 FIG00630330: hypothetical protein +FIG00630330 Activator of (R)-2-hydroxyglutaryl-CoA dehydratase +FIG00630332 FIG00630333: hypothetical protein +FIG00630336 FIG00630337: hypothetical protein +FIG00630338 Recombinase +FIG00630339 FIG00630340: hypothetical protein +FIG00630341 repS protein, putative +FIG00630342 FIG00630343: hypothetical protein +FIG00630343 FIG00630344: hypothetical protein +FIG00630344 similar to glutathione reductase +FIG00630345 FIG00630346: hypothetical protein +FIG00630346 FIG00630347: hypothetical protein +FIG00630347 protease synthase and sporulation negative regulatory protein pai 1 +FIG00630348 FIG00630350: hypothetical protein +FIG00630350 FIG00630351: hypothetical protein +FIG00630352 NAD(P)H dehydrogenase (quinone), putative( EC:1.6.5.2 ) +FIG00630354 FIG00630355: hypothetical protein +FIG00630355 FIG00630356: hypothetical protein +FIG00630356 Central glycolytic genes regulator +FIG00630357 FIG00630358: hypothetical protein +FIG00630358 FIG00630359: hypothetical protein +FIG00630359 FIG00630361: hypothetical protein +FIG00630361 FIG00630362: hypothetical protein +FIG00630362 DSBA oxidoreductase +FIG00630365 General substrate transporter:Major facilitator superfamily +FIG00630368 FIG00630369: hypothetical protein +FIG00630369 FIG00630370: hypothetical protein +FIG00630371 FIG00630372: hypothetical protein +FIG00630372 FIG00630373: hypothetical protein +FIG00630373 FIG00630374: hypothetical protein +FIG00630376 FIG00630377: hypothetical protein +FIG00630377 FIG00630378: hypothetical protein +FIG00630378 FIG00630379: hypothetical protein +FIG00630379 FIG00630380: hypothetical protein +FIG00630380 FIG00630381: hypothetical protein +FIG00630383 FIG00630384: hypothetical protein +FIG00630384 FIG00630385: hypothetical protein +FIG00630385 FIG00630387: hypothetical protein +FIG00630387 FIG00630388: hypothetical protein +FIG00630392 FIG00630393: hypothetical protein +FIG00630397 prophage Lp1 protein 52, endolysin +FIG00630398 FIG00630403: hypothetical protein +FIG00630404 FIG00630405: hypothetical protein +FIG00630405 FIG00630407: hypothetical protein +FIG00630407 47 +FIG00630408 type III leader peptidase family +FIG00630412 FIG00630415: hypothetical protein +FIG00630415 FIG00630416: hypothetical protein +FIG00630417 FIG00630418: hypothetical protein +FIG00630418 FIG00630419: hypothetical protein +FIG00630424 FIG00630425: hypothetical protein +FIG00630426 FIG00630427: hypothetical protein +FIG00630427 FIG00630428: hypothetical protein +FIG00630428 FIG00630429: hypothetical protein +FIG00630432 FIG00630433: hypothetical protein +FIG00630433 Integrase/recombinase, putative, truncated +FIG00630434 FIG00630435: hypothetical protein +FIG00630435 FIG00630439: hypothetical protein +FIG00630439 FIG00630440: hypothetical protein +FIG00630440 FIG00630443: hypothetical protein +FIG00630443 Dolichol-phosphate mannosyltransferase MtrA +FIG00630444 FIG00630446: hypothetical protein +FIG00630447 sugar ABC transporter permease +FIG00630448 FIG00630450: hypothetical protein +FIG00630450 FIG00630453: hypothetical protein +FIG00630457 FIG00630458: hypothetical protein +FIG00630459 FIG00630460: hypothetical protein +FIG00630461 FIG00630462: hypothetical protein +FIG00630465 FIG00630466: hypothetical protein +FIG00630466 FIG00630469: hypothetical protein +FIG00630470 FIG00630474: hypothetical protein +FIG00630477 Band 7 protein, SPFH domain +FIG00630479 FIG00630480: hypothetical protein +FIG00630480 FIG00630481: hypothetical protein +FIG00630484 FIG00630488: hypothetical protein +FIG00630491 FIG00630492: hypothetical protein +FIG00630492 hypothetical protein +FIG00630493 FIG00630496: hypothetical protein +FIG00630499 FIG00630501: hypothetical protein +FIG00630503 FIG00630506: hypothetical protein +FIG00630506 FIG00630508: hypothetical protein +FIG00630510 FIG00630511: hypothetical protein +FIG00630511 FIG00630512: hypothetical protein +FIG00630512 FIG00630515: hypothetical protein +FIG00630520 FIG00630521: hypothetical protein +FIG00630526 FIG00630527: hypothetical protein +FIG00630527 FIG00630528: hypothetical protein +FIG00630531 acetyltransferase, GNAT family( EC:2.3.1.- ) +FIG00630532 FIG00630533: hypothetical protein +FIG00630538 FIG00630542: hypothetical protein +FIG00630542 FIG00630543: hypothetical protein +FIG00630544 FIG00630545: hypothetical protein +FIG00630545 FIG00630548: hypothetical protein +FIG00630549 FIG00630550: hypothetical protein +FIG00630550 FIG00630551: hypothetical protein +FIG00630551 transcriptional repressor of PBSX genes +FIG00630553 FIG00630557: hypothetical protein +FIG00630557 FIG00630558: hypothetical protein +FIG00630558 FIG00630560: hypothetical protein +FIG00630560 FIG00630561: hypothetical protein +FIG00630562 FIG00630563: hypothetical protein +FIG00630564 FIG00630566: hypothetical protein +FIG00630568 FIG00630569: hypothetical protein +FIG00630570 peptidase, M42 family +FIG00630572 FIG00630573: hypothetical protein +FIG00630573 FIG00630575: hypothetical protein +FIG00630575 FIG00630576: hypothetical protein +FIG00630576 FIG00630577: hypothetical protein +FIG00630579 enterocin P precursor +FIG00630580 FIG00630581: hypothetical protein +FIG00630582 FIG00630584: hypothetical protein +FIG00630585 FIG00630586: hypothetical protein +FIG00630588 FIG00630589: hypothetical protein +FIG00630589 FIG00630590: hypothetical protein +FIG00630590 FIG00630591: hypothetical protein +FIG00630593 FIG00630594: hypothetical protein +FIG00630594 FIG00630596: hypothetical protein +FIG00630598 streptomycin 3''-adenylyltransferase, putative +FIG00630600 FIG00630601: hypothetical protein +FIG00630601 LarA: implicated in lactate racemization +FIG00630603 FIG00630605: hypothetical protein +FIG00630608 FIG00630610: hypothetical protein +FIG00630610 FIG00630611: hypothetical protein +FIG00630613 FIG00630614: hypothetical protein +FIG00630616 FIG00630617: hypothetical protein +FIG00630617 FIG00630618: hypothetical protein +FIG00630618 FIG00630619: hypothetical protein +FIG00630626 FIG00630628: hypothetical protein +FIG00630628 FIG00630629: hypothetical protein +FIG00630629 CimH +FIG00630630 FIG00630631: hypothetical protein +FIG00630632 FIG00630633: hypothetical protein +FIG00630635 FIG00630636: hypothetical protein +FIG00630639 FIG00630640: hypothetical protein +FIG00630640 ORF41 +FIG00630641 FIG00630642: hypothetical protein +FIG00630642 FIG00630643: hypothetical protein +FIG00630643 FIG00630644: hypothetical protein +FIG00630644 O-methyltransferase family protein +FIG00630654 FIG00630655: hypothetical protein +FIG00630655 FIG00630659: hypothetical protein +FIG00630660 FIG00630661: hypothetical protein +FIG00630662 FIG00630664: hypothetical protein +FIG00630672 FIG00630674: hypothetical protein +FIG00630674 FIG00630675: hypothetical protein +FIG00630676 FIG00630678: hypothetical protein +FIG00630681 conserved hypothetical protein TIGR01725 +FIG00630682 FIG00630683: hypothetical protein +FIG00630683 FIG00630684: hypothetical protein +FIG00630684 internalin A precursor +FIG00630688 FIG00630690: hypothetical protein +FIG00630690 FIG00630692: hypothetical protein +FIG00630692 FIG00630693: hypothetical protein +FIG00630698 FIG00630699: hypothetical protein +FIG00630703 FIG00630704: hypothetical protein +FIG00630704 FIG00630706: hypothetical protein +FIG00630706 transcriptional regulator, MerR family +FIG00630710 FIG00630711: hypothetical protein +FIG00630711 FIG00630712: hypothetical protein +FIG00630712 FIG00630713: hypothetical protein +FIG00630713 FIG00630715: hypothetical protein +FIG00630716 FIG00630718: hypothetical protein +FIG00630718 FIG00630720: hypothetical protein +FIG00630720 FIG00630721: hypothetical protein +FIG00630722 FIG00630724: hypothetical protein +FIG00630728 FIG00630731: hypothetical protein +FIG00630732 FIG00630733: hypothetical protein +FIG00630733 FIG00630734: hypothetical protein +FIG00630735 FIG00630736: hypothetical protein +FIG00630738 Protein of unknown function DUF1538 +FIG00630742 Phage Rha protein +FIG00630743 FIG00630745: hypothetical protein +FIG00630752 cytolysin immunity CylI +FIG00630761 FIG00630762: hypothetical protein +FIG00630762 regulatory protein, GntR:Bacterial regulatory protein, GntR +FIG00630763 CsbD-like +FIG00630764 FIG00630765: hypothetical protein +FIG00630766 FIG00630767: hypothetical protein +FIG00630767 FIG00630769: hypothetical protein +FIG00630769 FIG00630770: hypothetical protein +FIG00630771 FIG00630773: hypothetical protein +FIG00630774 FIG00630775: hypothetical protein +FIG00630775 FIG00630778: hypothetical protein +FIG00630780 FIG00630781: hypothetical protein +FIG00630781 FIG00630782: hypothetical protein +FIG00630782 FIG00630783: hypothetical protein +FIG00630783 FIG00630784: hypothetical protein +FIG00630785 FIG00630788: hypothetical protein +FIG00630790 FIG00630791: hypothetical protein +FIG00630791 FIG00630793: hypothetical protein +FIG00630797 putative replication protein repa +FIG00630799 FIG00630800: hypothetical protein +FIG00630800 FIG00630801: hypothetical protein +FIG00630802 FIG00630805: hypothetical protein +FIG00630806 FIG00630809: hypothetical protein +FIG00630814 Conserved hypothetical protein ArsC related +FIG00630817 FIG00630819: hypothetical protein +FIG00630819 Orf19 +FIG00630821 FIG00630823: hypothetical protein +FIG00630823 FIG00630825: hypothetical protein +FIG00630834 FIG00630835: hypothetical protein +FIG00630835 FIG00630836: hypothetical protein +FIG00630836 molybdopterin biosynthesis protein (HesA/MoeB/ThiF family protein), putative +FIG00630841 FIG00630842: hypothetical protein +FIG00630842 FIG00630843: hypothetical protein +FIG00630843 PTS sysytem, mannitol-specific enzyme II, B component +FIG00630844 FIG00630846: hypothetical protein +FIG00630849 sodium/dicarboxylate symporter family protein +FIG00630851 FIG00630852: hypothetical protein +FIG00630852 FIG00630856: hypothetical protein +FIG00630856 FIG00630857: hypothetical protein +FIG00630857 FIG00630858: hypothetical protein +FIG00630858 probable PTS system regulatory protein +FIG00630859 FIG00630861: hypothetical protein +FIG00630861 FIG00630862: hypothetical protein +FIG00630862 FIG00630863: hypothetical protein +FIG00630865 hypothetical protein +FIG00630874 FIG00630877: hypothetical protein +FIG00630877 FIG00630878: hypothetical protein +FIG00630878 putative secreted cell wall protein +FIG00630884 FIG00630885: hypothetical protein +FIG00630885 FIG00630888: hypothetical protein +FIG00630888 FIG00630890: hypothetical protein +FIG00630892 FIG00630897: hypothetical protein +FIG00630897 minor head protein +FIG00630903 FIG00630904: hypothetical protein +FIG00630904 NADH peroxidase Npx (EC 1.11.1.1) +FIG00630905 FIG00630906: hypothetical protein +FIG00630906 FIG00630908: hypothetical protein +FIG00630909 FIG00630910: hypothetical protein +FIG00630913 FIG00630916: hypothetical protein +FIG00630921 FIG00630922: hypothetical protein +FIG00630925 FIG00630927: hypothetical protein +FIG00630931 FIG00630932: hypothetical protein +FIG00630932 FIG00630937: hypothetical protein +FIG00630937 FIG00630938: hypothetical protein +FIG00630939 FIG00630940: hypothetical protein +FIG00630940 FIG00630941: hypothetical protein +FIG00630947 FIG00630952: hypothetical protein +FIG00630953 FIG00630954: hypothetical protein +FIG00630954 FIG00630956: hypothetical protein +FIG00630956 FIG00630957: hypothetical protein +FIG00630957 Putative NADPH-quinone oxidoreductase +FIG00630964 FIG00630965: hypothetical protein +FIG00630967 FIG00630968: hypothetical protein +FIG00630968 FIG00630970: hypothetical protein +FIG00630970 FIG00630972: hypothetical protein +FIG00630974 FIG00630976: hypothetical protein +FIG00630976 FIG00630980: hypothetical protein +FIG00630980 FIG00630981: hypothetical protein +FIG00630984 FIG00630985: hypothetical protein +FIG00630986 FIG00630988: hypothetical protein +FIG00630994 FIG00630995: hypothetical protein +FIG00630995 FIG00630997: hypothetical protein +FIG00630997 FIG00630998: hypothetical protein +FIG00631001 FIG00631002: hypothetical protein +FIG00631008 FIG00631011: hypothetical protein +FIG00631011 FIG00631013: hypothetical protein +FIG00631013 FIG00631014: hypothetical protein +FIG00631014 similar to Glycosyl transferases related to UDP-glucuronosyltransferase +FIG00631015 FIG00631016: hypothetical protein +FIG00631016 FIG00631017: hypothetical protein +FIG00631017 FIG00631018: hypothetical protein +FIG00631020 FIG00631022: hypothetical protein +FIG00631025 FIG00631026: hypothetical protein +FIG00631027 FIG00631029: hypothetical protein +FIG00631029 FIG00631030: hypothetical protein +FIG00631030 FIG00631031: hypothetical protein +FIG00631031 FIG00631032: hypothetical protein +FIG00631032 FIG00631033: hypothetical protein +FIG00631033 FIG00631035: hypothetical protein +FIG00631035 FIG00631037: hypothetical protein +FIG00631038 FIG00631040: hypothetical protein +FIG00631041 FIG00631042: hypothetical protein +FIG00631042 Two-component response regulator TrxR +FIG00631043 FIG00631044: hypothetical protein +FIG00631044 FIG00631045: hypothetical protein +FIG00631052 FIG00631053: hypothetical protein +FIG00631055 FIG00631056: hypothetical protein +FIG00631060 FIG00631061: hypothetical protein +FIG00631061 FIG00631062: hypothetical protein +FIG00631062 hypothetical protein +FIG00631063 FIG00631067: hypothetical protein +FIG00631067 FIG00631072: hypothetical protein +FIG00631072 FIG00631073: hypothetical protein +FIG00631073 FIG00631074: hypothetical protein +FIG00631074 FIG00631075: hypothetical protein +FIG00631077 ORF33 +FIG00631078 FIG00631080: hypothetical protein +FIG00631083 42 +FIG00631085 FIG00631087: hypothetical protein +FIG00631087 Phage DNA methylase +FIG00631091 FIG00631092: hypothetical protein +FIG00631093 FIG00631096: hypothetical protein +FIG00631097 FIG00631102: hypothetical protein +FIG00631102 FIG00631104: hypothetical protein +FIG00631106 FIG00631107: hypothetical protein +FIG00631107 FIG00631110: hypothetical protein +FIG00631110 FIG00631111: hypothetical protein +FIG00631113 FIG00631114: hypothetical protein +FIG00631115 polar amino acid ABC uptake transporter substrate binding protein +FIG00631120 FIG00631121: hypothetical protein +FIG00631121 FIG00631124: hypothetical protein +FIG00631124 FIG075815: hypothetical protein +FIG00631126 FIG00631128: hypothetical protein +FIG00631128 FIG00631129: hypothetical protein +FIG00631129 FIG00631131: hypothetical protein +FIG00631131 FIG00631134: hypothetical protein +FIG00631134 FIG00631136: hypothetical protein +FIG00631136 FIG00631140: hypothetical protein +FIG00631140 acetoin utilization protein, truncated +FIG00631146 FIG00631149: hypothetical protein +FIG00631152 FIG00631153: hypothetical protein +FIG00631153 FIG00631155: hypothetical protein +FIG00631156 Predicted dehydrogenase or related protein +FIG00631157 FIG00631158: hypothetical protein +FIG00631159 FIG00631160: hypothetical protein +FIG00631162 FIG00631163: hypothetical protein +FIG00631168 FIG00631170: hypothetical protein +FIG00631170 FIG00631171: hypothetical protein +FIG00631171 FIG00631172: hypothetical protein +FIG00631172 PTS system, galactitol-specific IIB component, putative +FIG00631173 FIG00631174: hypothetical protein +FIG00631175 FIG00631176: hypothetical protein +FIG00631176 FIG00631177: hypothetical protein +FIG00631177 FIG00631178: hypothetical protein +FIG00631178 FIG00631180: hypothetical protein +FIG00631180 FIG00631181: hypothetical protein +FIG00631181 FIG00631183: hypothetical protein +FIG00631191 FIG00631192: hypothetical protein +FIG00631200 N-acylglucosamine 2-epimerase +FIG00631204 FIG00631205: hypothetical protein +FIG00631205 FIG00631206: hypothetical protein +FIG00631206 FIG00631210: hypothetical protein +FIG00631212 DNA topoisomerase domain protein +FIG00631216 FIG00631218: hypothetical protein +FIG00631219 FIG00631220: hypothetical protein +FIG00631220 FIG00631222: hypothetical protein +FIG00631222 Protein of unknown function DUF37 +FIG00631225 FIG00631226: hypothetical protein +FIG00631228 FIG00631230: hypothetical protein +FIG00631230 FIG00631231: hypothetical protein +FIG00631240 FIG00631242: hypothetical protein +FIG00631243 FIG00631244: hypothetical protein +FIG00631246 FIG00631247: hypothetical protein +FIG00631247 FIG00631248: hypothetical protein +FIG00631248 lysis protein +FIG00631251 hypothetical protein +FIG00631255 FIG00631256: hypothetical protein +FIG00631259 FIG00631260: hypothetical protein +FIG00631261 FIG00631262: hypothetical protein +FIG00631262 DNA helicase (putative) +FIG00631263 abortive phage resistance protein, putative +FIG00631270 FIG00631272: hypothetical protein +FIG00631273 FIG00631274: hypothetical protein +FIG00631278 FIG00631282: hypothetical protein +FIG00631283 ORF033 +FIG00631284 FIG00631288: hypothetical protein +FIG00631288 FIG00631289: hypothetical protein +FIG00631293 FIG00631298: hypothetical protein +FIG00631298 FIG00631300: hypothetical protein +FIG00631302 FIG00631303: hypothetical protein +FIG00631304 FIG00631305: hypothetical protein +FIG00631305 FIG00631307: hypothetical protein +FIG00631307 putative extracellular protein +FIG00631308 FIG00631312: hypothetical protein +FIG00631312 Predicted transcriptional regulator (contains HTH domain Mga-type) +FIG00631317 FIG00631318: hypothetical protein +FIG00631318 FIG00631319: hypothetical protein +FIG00631319 FIG00631320: hypothetical protein +FIG00631320 FIG00631321: hypothetical protein +FIG00631322 Phage lysin( EC:3.2.1.17 ) +FIG00631323 FIG00631324: hypothetical protein +FIG00631324 FIG00631325: hypothetical protein +FIG00631325 FIG00631326: hypothetical protein +FIG00631326 FIG00631328: hypothetical protein +FIG00631328 FIG00631329: hypothetical protein +FIG00631329 FIG00631330: hypothetical protein +FIG00631330 FIG00631331: hypothetical protein +FIG00631331 FIG00631332: hypothetical protein +FIG00631336 Eps10K +FIG00631337 FIG00631338: hypothetical protein +FIG00631338 FIG00631339: hypothetical protein +FIG00631339 FIG00631340: hypothetical protein +FIG00631341 FIG00631342: hypothetical protein +FIG00631342 FIG00631343: hypothetical protein +FIG00631346 FIG00631348: hypothetical protein +FIG00631349 FIG00631350: hypothetical protein +FIG00631353 FIG00631354: hypothetical protein +FIG00631355 TraG +FIG00631360 FIG00631361: hypothetical protein +FIG00631361 FIG00631362: hypothetical protein +FIG00631362 FIG00631363: hypothetical protein +FIG00631363 FIG00631364: hypothetical protein +FIG00631364 FIG00631365: hypothetical protein +FIG00631368 FIG00631369: hypothetical protein +FIG00631370 FIG00631372: hypothetical protein +FIG00631372 FIG00631374: hypothetical protein +FIG00631374 FIG00631382: hypothetical protein +FIG00631383 FIG00631384: hypothetical protein +FIG00631384 FIG00631386: hypothetical protein +FIG00631386 FIG00631388: hypothetical protein +FIG00631388 43 +FIG00631391 FIG00631392: hypothetical protein +FIG00631392 FIG00631393: hypothetical protein +FIG00631393 peptide methionine sulfoxide reductase domain protein +FIG00631394 probable glycero-phosphotransferase +FIG00631398 FIG00631399: hypothetical protein +FIG00631404 FIG00631405: hypothetical protein +FIG00631409 FIG00631411: hypothetical protein +FIG00631411 FIG00631412: hypothetical protein +FIG00631412 FIG00631413: hypothetical protein +FIG00631413 FIG00631414: hypothetical protein +FIG00631414 conserved hypothetical protein TIGR01655 +FIG00631415 FIG00631417: hypothetical protein +FIG00631421 ATP-dependent helicase, DEAH-box family, putative +FIG00631426 FIG00631427: hypothetical protein +FIG00631429 Site-specific recombinase, DNA invertase Pin related protein +FIG00631431 FIG00631433: hypothetical protein +FIG00631436 FIG00631437: hypothetical protein +FIG00631437 FIG00631438: hypothetical protein +FIG00631438 hypothetical protein +FIG00631442 FIG00631443: hypothetical protein +FIG00631444 FIG00631445: hypothetical protein +FIG00631447 hypothetical protein +FIG00631448 FIG00631449: hypothetical protein +FIG00631449 bacteriocin-like protein +FIG00631457 FIG00631458: hypothetical protein +FIG00631458 Predicted signal transduction protein with a C-terminal ATPase domain +FIG00631464 Coenzyme F420-dependent N5,N10-methylene tetrahydromethanopterin reductase related flavin-dependent oxidoreductase +FIG00631474 cadmium-translocating P-type ATPase +FIG00631480 erythromycin resistance protein +FIG00631482 FIG00631483: hypothetical protein +FIG00631483 FIG00631484: hypothetical protein +FIG00631484 FIG00631485: hypothetical protein +FIG00631488 heavy metal-binding Cu+ P-type ATPase fragment +FIG00631489 FIG00631490: hypothetical protein +FIG00631490 transcriptional regulator, glucose kinase +FIG00631492 Flagellum-specific ATP synthase FliI +FIG00631498 FIG00631502: hypothetical protein +FIG00631504 FIG00631505: hypothetical protein +FIG00631506 FIG00631508: hypothetical protein +FIG00631508 FIG00631509: hypothetical protein +FIG00631512 FIG00631513: hypothetical protein +FIG00631513 FIG00631514: hypothetical protein +FIG00631514 FIG00631515: hypothetical protein +FIG00631515 FIG00631516: hypothetical protein +FIG00631516 FIG00631517: hypothetical protein +FIG00631517 FIG00631518: hypothetical protein +FIG00631518 FIG00631519: hypothetical protein +FIG00631527 FIG00631530: hypothetical protein +FIG00631531 FIG00631533: hypothetical protein +FIG00631538 FIG00631539: hypothetical protein +FIG00631539 FIG00631542: hypothetical protein +FIG00631542 FIG00631543: hypothetical protein +FIG00631543 FIG00631545: hypothetical protein +FIG00631545 Transcriptional regulator, GntR family, putative +FIG00631546 FIG00631548: hypothetical protein +FIG00631548 FIG00631551: hypothetical protein +FIG00631551 FIG00631552: hypothetical protein +FIG00631552 FIG00631559: hypothetical protein +FIG00631559 FIG00631560: hypothetical protein +FIG00631561 FIG00631562: hypothetical protein +FIG00631562 FIG00631563: hypothetical protein +FIG00631563 FIG00631564: hypothetical protein +FIG00631566 FIG00631571: hypothetical protein +FIG00631571 FIG00631572: hypothetical protein +FIG00631572 FIG00631573: hypothetical protein +FIG00631573 FIG00631574: hypothetical protein +FIG00631574 FIG00631575: hypothetical protein +FIG00631576 FIG00631577: hypothetical protein +FIG00631579 conserved hypothetical protein; possible deacetylase +FIG00631583 FIG00631584: hypothetical protein +FIG00631586 phage site-specific recombinase +FIG00631589 FIG00631591: hypothetical protein +FIG00631591 FIG00631593: hypothetical protein +FIG00631593 FIG00631594: hypothetical protein +FIG00631594 FIG00631595: hypothetical protein +FIG00631595 FIG00631597: hypothetical protein +FIG00631600 FIG00631601: hypothetical protein +FIG00631602 FIG00631603: hypothetical protein +FIG00631603 FIG00631604: hypothetical protein +FIG00631604 FIG00631605: hypothetical protein +FIG00631611 FIG00631614: hypothetical protein +FIG00631615 FIG00631619: hypothetical protein +FIG00631620 FIG00631621: hypothetical protein +FIG00631623 FIG00631624: hypothetical protein +FIG00631626 FIG00631627: hypothetical protein +FIG00631627 FIG00631631: hypothetical protein +FIG00631633 FIG00631634: hypothetical protein +FIG00631637 FIG00631641: hypothetical protein +FIG00631641 FIG00631642: hypothetical protein +FIG00631642 FIG00631643: hypothetical protein +FIG00631645 FIG00631646: hypothetical protein +FIG00631653 FIG00631654: hypothetical protein +FIG00631661 FIG00631662: hypothetical protein +FIG00631667 FIG00631668: hypothetical protein +FIG00631668 hypothetical protein +FIG00631679 FIG00631680: hypothetical protein +FIG00631682 FIG00631683: hypothetical protein +FIG00631692 FIG00631693: hypothetical protein +FIG00631694 FIG00631696: hypothetical protein +FIG00631697 FIG00631698: hypothetical protein +FIG00631698 FIG00631699: hypothetical protein +FIG00631701 FIG00631703: hypothetical protein +FIG00631706 FIG00631707: hypothetical protein +FIG00631708 FIG00631709: hypothetical protein +FIG00631709 conserved hypothetical protein TIGR01630 +FIG00631714 FIG00631715: hypothetical protein +FIG00631718 FIG00631721: hypothetical protein +FIG00631721 FIG00631724: hypothetical protein +FIG00631728 FIG00631736: hypothetical protein +FIG00631737 FIG00631740: hypothetical protein +FIG00631740 FIG00631741: hypothetical protein +FIG00631741 FIG00631745: hypothetical protein +FIG00631745 FIG00631749: hypothetical protein +FIG00631751 FIG00631752: hypothetical protein +FIG00631752 FIG00631753: hypothetical protein +FIG00631755 FIG00631756: hypothetical protein +FIG00631756 FIG00631758: hypothetical protein +FIG00631760 FIG00631761: hypothetical protein +FIG00631761 FIG00631762: hypothetical protein +FIG00631762 FIG00631763: hypothetical protein +FIG00631763 FIG00631765: hypothetical protein +FIG00631765 FIG00631766: hypothetical protein +FIG00631768 FIG00631769: hypothetical protein +FIG00631769 FIG00631772: hypothetical protein +FIG00631772 FIG00631774: hypothetical protein +FIG00631777 FIG00631778: hypothetical protein +FIG00631791 FIG00631792: hypothetical protein +FIG00631793 FIG00631794: hypothetical protein +FIG00631801 FIG00631803: hypothetical protein +FIG00631803 FIG00631804: hypothetical protein +FIG00631805 FIG00631807: hypothetical protein +FIG00631812 FIG00631813: hypothetical protein +FIG00631817 FIG00631818: hypothetical protein +FIG00631818 Replication initiation factor +FIG00631825 FIG00631830: hypothetical protein +FIG00631830 Phage terminase-like protein, small subunit +FIG00631832 FIG00631835: hypothetical protein +FIG00631835 FIG00631836: hypothetical protein +FIG00631838 FIG00631839: hypothetical protein +FIG00631844 Pheromone binding protein TraC/PrgZ +FIG00631845 PTS system, fructose-specific IIA component( EC:2.7.1.69 ) +FIG00631847 FIG00631850: hypothetical protein +FIG00631856 FIG00631857: hypothetical protein +FIG00631866 FIG00631867: hypothetical protein +FIG00631867 FIG00631868: hypothetical protein +FIG00631874 FIG00631876: hypothetical protein +FIG00631876 FIG00631877: hypothetical protein +FIG00631877 FIG00631878: hypothetical protein +FIG00631878 FIG00631880: hypothetical protein +FIG00631880 FIG00631881: hypothetical protein +FIG00631881 FIG00631886: hypothetical protein +FIG00631888 FIG00631890: hypothetical protein +FIG00631893 FIG00631895: hypothetical protein +FIG00631895 FIG00631896: hypothetical protein +FIG00631896 FIG00631897: hypothetical protein +FIG00631899 FIG00631902: hypothetical protein +FIG00631910 FIG00631911: hypothetical protein +FIG00631913 FIG00631914: hypothetical protein +FIG00631924 FIG00631925: hypothetical protein +FIG00631925 FIG00631927: hypothetical protein +FIG00631932 FIG00631933: hypothetical protein +FIG00631935 Small multidrug resistance protein +FIG00631937 LysM domain lipoprotein +FIG00631939 FIG00631941: hypothetical protein +FIG00631941 FIG00631943: hypothetical protein +FIG00631943 FIG00631944: hypothetical protein +FIG00631944 FIG00631945: hypothetical protein +FIG00631947 phage terminase, small subunit, putative, P27 family +FIG00631949 FIG00631950: hypothetical protein +FIG00631955 FIG00631956: hypothetical protein +FIG00631956 FIG00631959: hypothetical protein +FIG00631960 FIG00631961: hypothetical protein +FIG00631961 FIG00631964: hypothetical protein +FIG00631965 FIG00631970: hypothetical protein +FIG00631970 FIG00631972: hypothetical protein +FIG00631972 FIG00631973: hypothetical protein +FIG00631973 Site-specific recombinase, prophage lsa1 integrase +FIG00631976 FIG00631978: hypothetical protein +FIG00631979 FIG00631983: hypothetical protein +FIG00631983 FIG00631984: hypothetical protein +FIG00631985 structural protein +FIG00631986 FIG00631987: hypothetical protein +FIG00631987 FIG00631989: hypothetical protein +FIG00631992 FIG00631993: hypothetical protein +FIG00631993 sigma-54 interaction domain protein +FIG00631994 FIG00631995: hypothetical protein +FIG00631995 FIG00632005: hypothetical protein +FIG00632005 FIG00632008: hypothetical protein +FIG00632008 FIG00632009: hypothetical protein +FIG00632018 FIG00632019: hypothetical protein +FIG00632024 FIG00632027: hypothetical protein +FIG00632027 FIG00632030: hypothetical protein +FIG00632030 FIG00632036: hypothetical protein +FIG00632036 FIG00632038: hypothetical protein +FIG00632038 FIG00632039: hypothetical protein +FIG00632039 FIG00632041: hypothetical protein +FIG00632043 FIG00632046: hypothetical protein +FIG00632047 FIG00632051: hypothetical protein +FIG00632051 FIG00632052: hypothetical protein +FIG00632055 FIG00632057: hypothetical protein +FIG00632057 hypothetical protein +FIG00632062 FIG00632064: hypothetical protein +FIG00632064 FIG00632065: hypothetical protein +FIG00632067 FIG00632068: hypothetical protein +FIG00632068 FIG00632069: hypothetical protein +FIG00632070 CRISPR-associated protein, Csn2 family +FIG00632071 FIG00632072: hypothetical protein +FIG00632074 FIG00632078: hypothetical protein +FIG00632080 FIG00632081: hypothetical protein +FIG00632083 FIG00632087: hypothetical protein +FIG00632088 FIG00632092: hypothetical protein +FIG00632092 FIG00632093: hypothetical protein +FIG00632095 FIG00632096: hypothetical protein +FIG00632096 repE protein +FIG00632097 FIG00632098: hypothetical protein +FIG00632099 FIG00632101: hypothetical protein +FIG00632104 FIG00632106: hypothetical protein +FIG00632106 FIG00632108: hypothetical protein +FIG00632109 FIG00632111: hypothetical protein +FIG00632115 FIG00632117: hypothetical protein +FIG00632119 FIG00632120: hypothetical protein +FIG00632120 Bacteriocin export accessory protein +FIG00632124 FIG00632125: hypothetical protein +FIG00632125 conjugative transposon protein +FIG00632132 FIG00632133: hypothetical protein +FIG00632141 FIG00632142: hypothetical protein +FIG00632142 FIG00632143: hypothetical protein +FIG00632143 FIG00632144: hypothetical protein +FIG00632144 FIG00632148: hypothetical protein +FIG00632149 FIG00632150: hypothetical protein +FIG00632156 FIG00632159: hypothetical protein +FIG00632164 RNA polymerase sigma-70 factor, ECF subfamily +FIG00632168 FIG00632170: hypothetical protein +FIG00632171 FIG00632174: hypothetical protein +FIG00632176 FIG00632178: hypothetical protein +FIG00632178 FIG00632179: hypothetical protein +FIG00632190 FIG00632191: hypothetical protein +FIG00632192 FIG00632193: hypothetical protein +FIG00632193 sugar kinase, putative +FIG00632195 FIG00632197: hypothetical protein +FIG00632197 FIG00632199: hypothetical protein +FIG00632208 FIG00632209: hypothetical protein +FIG00632209 FIG00632210: hypothetical protein +FIG00632210 FIG00632211: hypothetical protein +FIG00632212 FIG00632214: hypothetical protein +FIG00632227 FIG00632230: hypothetical protein +FIG00632230 FIG00632233: hypothetical protein +FIG00632234 FIG00632236: hypothetical protein +FIG00632248 FIG00632250: hypothetical protein +FIG00632252 Drug exporter-1 ABC transporter (DrugE1) family, ATP-binding protein +FIG00632254 FIG00632260: hypothetical protein +FIG00632260 FIG00632261: hypothetical protein +FIG00632264 FIG00632270: hypothetical protein +FIG00632270 FIG00632271: hypothetical protein +FIG00632271 FIG00632272: hypothetical protein +FIG00632272 FIG00632275: hypothetical protein +FIG00632275 MCP domain signal transducer +FIG00632276 endolysin +FIG00632287 FIG00632289: hypothetical protein +FIG00632289 Protein of unknown function DUF161 +FIG00632292 FIG00632293: hypothetical protein +FIG00632296 FIG00632300: hypothetical protein +FIG00632300 FIG00632301: hypothetical protein +FIG00632303 regulatory protein TraE1 +FIG00632304 FIG00632306: hypothetical protein +FIG00632306 FIG00632308: hypothetical protein +FIG00632318 FIG00632319: hypothetical protein +FIG00632319 FIG00632320: hypothetical protein +FIG00632322 FIG00632324: hypothetical protein +FIG00632327 FIG00632328: hypothetical protein +FIG00632328 FIG00632331: hypothetical protein +FIG00632331 FIG00632332: hypothetical protein +FIG00632332 FIG00632333: hypothetical protein +FIG00632333 FIG00632336: hypothetical protein +FIG00632340 FIG00632344: hypothetical protein +FIG00632351 FIG00632352: hypothetical protein +FIG00632362 FIG00632365: hypothetical protein +FIG00632367 FIG00632368: hypothetical protein +FIG00632368 FIG00632369: hypothetical protein +FIG00632369 FIG00632371: hypothetical protein +FIG00632385 FIG00632386: hypothetical protein +FIG00632391 FIG00632398: hypothetical protein +FIG00632399 FIG00632402: hypothetical protein +FIG00632402 Fumarate reductase, flavoprotein subunit precursor (EC 1.3.99.1) +FIG00632406 FIG00632407: hypothetical protein +FIG00632409 transcriptional activator, putative +FIG00632410 FIG00632411: hypothetical protein +FIG00632413 FIG00632415: hypothetical protein +FIG00632415 FIG00632417: hypothetical protein +FIG00632418 FIG00632422: hypothetical protein +FIG00632423 FIG00632425: hypothetical protein +FIG00632427 FIG00632430: hypothetical protein +FIG00632430 FIG00632432: hypothetical protein +FIG00632439 FIG00632441: hypothetical protein +FIG00632446 FIG00632449: hypothetical protein +FIG00632449 FIG00632451: hypothetical protein +FIG00632453 FIG00632454: hypothetical protein +FIG00632455 FIG00632457: hypothetical protein +FIG00632457 FIG00632460: hypothetical protein +FIG00632462 FIG00632464: hypothetical protein +FIG00632468 conjugation protein, TraG/TraD family, (pXO2-16) +FIG00632469 putative glutamate racemase +FIG00632476 FIG00632478: hypothetical protein +FIG00632479 FIG00632481: hypothetical protein +FIG00632481 FIG00632482: hypothetical protein +FIG00632487 FIG00632490: hypothetical protein +FIG00632490 transcriptional regulators-like +FIG00632492 FIG00632493: hypothetical protein +FIG00632493 FIG00632498: hypothetical protein +FIG00632498 lower collar protein +FIG00632501 FIG00632503: hypothetical protein +FIG00632503 FIG00632505: hypothetical protein +FIG00632505 FIG00632506: hypothetical protein +FIG00632506 FIG00632508: hypothetical protein +FIG00632519 FIG00632520: hypothetical protein +FIG00632532 FIG00632534: hypothetical protein +FIG00632534 bacitracin transport ATP-binding protein bcrA +FIG00632535 FIG00632538: hypothetical protein +FIG00632540 FIG00632541: hypothetical protein +FIG00632546 FIG00632547: hypothetical protein +FIG00632549 putative recombination protein / Single-stranded DNA-binding protein +FIG00632550 FIG00632554: hypothetical protein +FIG00632561 FIG00632562: hypothetical protein +FIG00632563 FIG00632564: hypothetical protein +FIG00632564 FIG00632565: hypothetical protein +FIG00632568 FIG00632572: hypothetical protein +FIG00632572 FIG00632574: hypothetical protein +FIG00632574 FIG00632575: hypothetical protein +FIG00632575 FIG00632576: hypothetical protein +FIG00632581 FIG00632586: hypothetical protein +FIG00632586 FIG00632587: hypothetical protein +FIG00632587 FIG00632594: hypothetical protein +FIG00632594 COG3711: Transcriptional antiterminator +FIG00632595 FIG00632599: hypothetical protein +FIG00632606 FIG00632609: hypothetical protein +FIG00632612 FIG00632613: hypothetical protein +FIG00632613 FIG00632616: hypothetical protein +FIG00632617 FIG00632619: hypothetical protein +FIG00632619 Major head protein (Late protein Gp8) +FIG00632623 FIG00632625: hypothetical protein +FIG00632629 FIG00632631: hypothetical protein +FIG00632634 FIG00632636: hypothetical protein +FIG00632636 FIG00632638: hypothetical protein +FIG00632640 FIG00632641: hypothetical protein +FIG00632641 FIG00632642: hypothetical protein +FIG00632649 FIG00632650: hypothetical protein +FIG00632653 FIG00632654: hypothetical protein +FIG00632658 FIG00632660: hypothetical protein +FIG00632661 FIG00632662: hypothetical protein +FIG00632662 FIG00632663: hypothetical protein +FIG00632663 hypothetical protein +FIG00632669 FIG00632675: hypothetical protein +FIG00632675 FIG00632678: hypothetical protein +FIG00632682 FIG00632688: hypothetical protein +FIG00632688 FIG00632689: hypothetical protein +FIG00632689 FIG00632691: hypothetical protein +FIG00632691 Protein of unknown function DUF1294 +FIG00632692 FIG00632693: hypothetical protein +FIG00632693 FIG00632698: hypothetical protein +FIG00632703 FIG00632704: hypothetical protein +FIG00632704 FIG00632705: hypothetical protein +FIG00632706 ORF032 +FIG00632708 FIG00632709: hypothetical protein +FIG00632710 FIG00632720: hypothetical protein +FIG00632729 FIG00632730: hypothetical protein +FIG00632737 FIG00632739: hypothetical protein +FIG00632744 FIG00632748: hypothetical protein +FIG00632750 FIG00632751: hypothetical protein +FIG00632751 Coenzyme PQQ synthesis protein E (pqqE-4) +FIG00632758 FIG00632759: hypothetical protein +FIG00632759 FIG00632760: hypothetical protein +FIG00632761 FIG00632765: hypothetical protein +FIG00632768 FIG00632769: hypothetical protein +FIG00632771 FIG00632772: hypothetical protein +FIG00632773 Protein of unknown function DUF624 +FIG00632774 FIG00632775: hypothetical protein +FIG00632775 FIG00632781: hypothetical protein +FIG00632781 FIG00632782: hypothetical protein +FIG00632792 FIG00632797: hypothetical protein +FIG00632797 FIG00632799: hypothetical protein +FIG00632802 FIG00632803: hypothetical protein +FIG00632803 FIG00632804: hypothetical protein +FIG00632820 FIG00632821: hypothetical protein +FIG00632821 FIG00632822: hypothetical protein +FIG00632822 FIG00632824: hypothetical protein +FIG00632824 FIG00632828: hypothetical protein +FIG00632828 FIG00632833: hypothetical protein +FIG00632833 FIG00632836: hypothetical protein +FIG00632836 FIG00632837: hypothetical protein +FIG00632837 FIG00632839: hypothetical protein +FIG00632840 FIG00632843: hypothetical protein +FIG00632843 FIG00632846: hypothetical protein +FIG00632846 FIG00632847: hypothetical protein +FIG00632852 FIG00632854: hypothetical protein +FIG00632854 FIG00632856: hypothetical protein +FIG00632858 FIG00632859: hypothetical protein +FIG00632863 cell wall surface anchor family protein +FIG00632876 FIG00632877: hypothetical protein +FIG00632880 FIG00632881: hypothetical protein +FIG00632882 FIG00632886: hypothetical protein +FIG00632887 FIG00632888: hypothetical protein +FIG00632889 FIG00632895: hypothetical protein +FIG00632897 FIG00632898: hypothetical protein +FIG00632909 FIG00632911: hypothetical protein +FIG00632913 FIG00632914: hypothetical protein +FIG00632916 FIG00632917: hypothetical protein +FIG00632919 FIG00632920: hypothetical protein +FIG00632920 FIG00632922: hypothetical protein +FIG00632922 C4-dicarboxylate anaerobic carrier +FIG00632924 FIG00632925: hypothetical protein +FIG00632925 FIG00632927: hypothetical protein +FIG00632927 FIG00632928: hypothetical protein +FIG00632928 polysaccharide lyase, family 8 +FIG00632930 FIG00632933: hypothetical protein +FIG00632940 FIG00632946: hypothetical protein +FIG00632948 FIG00632950: hypothetical protein +FIG00632950 FIG00632952: hypothetical protein +FIG00632952 FIG00632953: hypothetical protein +FIG00632962 FIG00632963: hypothetical protein +FIG00632963 FIG00632964: hypothetical protein +FIG00632968 FIG00632969: hypothetical protein +FIG00632983 polysaccharide biosynthesis protein CpsL +FIG00632987 FIG00632988: hypothetical protein +FIG00632988 FIG00632994: hypothetical protein +FIG00632996 FIG00632999: hypothetical protein +FIG00632999 probable transcriptional repressor +FIG00633001 phage associated repressor, putative +FIG00633009 FIG00633011: hypothetical protein +FIG00633011 FIG00633015: hypothetical protein +FIG00633015 FIG00633019: hypothetical protein +FIG00633019 FIG00633022: hypothetical protein +FIG00633034 FIG00633037: hypothetical protein +FIG00633037 FIG00633039: hypothetical protein +FIG00633045 FIG00633046: hypothetical protein +FIG00633046 FIG00633047: hypothetical protein +FIG00633047 FIG00633052: hypothetical protein +FIG00633052 hypothetical protein +FIG00633053 FIG00633054: hypothetical protein +FIG00633055 FIG00633056: hypothetical protein +FIG00633056 FIG00633058: hypothetical protein +FIG00633074 FIG00633080: hypothetical protein +FIG00633080 FIG00633081: hypothetical protein +FIG00633081 FIG00633083: hypothetical protein +FIG00633083 FIG00633084: hypothetical protein +FIG00633084 UvaB +FIG00633091 FIG00633097: hypothetical protein +FIG00633097 ORF psi +FIG00633098 FIG00633099: hypothetical protein +FIG00633104 FIG00633107: hypothetical protein +FIG00633107 FIG00633109: hypothetical protein +FIG00633110 Response regulator (CheY-like receiver domain and a HTH) +FIG00633111 ORF phi +FIG00633117 FIG00633118: hypothetical protein +FIG00633118 FIG00633120: hypothetical protein +FIG00633124 FIG00633126: hypothetical protein +FIG00633126 FIG00633127: hypothetical protein +FIG00633133 FIG00633134: hypothetical protein +FIG00633134 FIG00633140: hypothetical protein +FIG00633147 FIG00633152: hypothetical protein +FIG00633158 FIG00633161: hypothetical protein +FIG00633161 FIG00633162: hypothetical protein +FIG00633162 FIG00633163: hypothetical protein +FIG00633174 FIG00633175: hypothetical protein +FIG00633175 Tn916, NLP/P60 family protein +FIG00633177 FIG00633178: hypothetical protein +FIG00633178 FIG00633179: hypothetical protein +FIG00633179 FIG00633180: hypothetical protein +FIG00633180 FIG00633181: hypothetical protein +FIG00633182 FIG00633186: hypothetical protein +FIG00633186 FIG00633187: hypothetical protein +FIG00633187 FIG00633188: hypothetical protein +FIG00633190 Pheromone cAM373 precursor lipoprotein CamE +FIG00633191 FIG00633196: hypothetical protein +FIG00633196 FIG00633197: hypothetical protein +FIG00633197 FIG00633198: hypothetical protein +FIG00633206 FIG00633209: hypothetical protein +FIG00633209 FIG00633221: hypothetical protein +FIG00633221 FIG00633225: hypothetical protein +FIG00633225 FIG00633237: hypothetical protein +FIG00633241 FIG00633244: hypothetical protein +FIG00633244 FIG00633248: hypothetical protein +FIG00633249 FIG00633250: hypothetical protein +FIG00633250 FIG00633253: hypothetical protein +FIG00633263 FIG00633264: hypothetical protein +FIG00633264 FIG00633266: hypothetical protein +FIG00633266 FIG00633268: hypothetical protein +FIG00633275 SalK-like protein +FIG00633286 FIG00633287: hypothetical protein +FIG00633287 FIG00633291: hypothetical protein +FIG00633296 ATP-binding region, ATPase-like:Histidine kinase internal region +FIG00633303 FIG00633304: hypothetical protein +FIG00633304 conserved domain protein +FIG00633306 FIG00633308: hypothetical protein +FIG00633309 FIG00633315: hypothetical protein +FIG00633315 FIG00633316: hypothetical protein +FIG00633316 FIG00633319: hypothetical protein +FIG00633319 FIG00633320: hypothetical protein +FIG00633330 FIG00633333: hypothetical protein +FIG00633333 FIG00633334: hypothetical protein +FIG00633334 FIG00633335: hypothetical protein +FIG00633335 FIG00633336: hypothetical protein +FIG00633342 FIG00633346: hypothetical protein +FIG00633348 FIG00633351: hypothetical protein +FIG00633357 FIG00633360: hypothetical protein +FIG00633360 FIG00633365: hypothetical protein +FIG00633365 FIG00633366: hypothetical protein +FIG00633369 FIG00633371: hypothetical protein +FIG00633374 FIG00633375: hypothetical protein +FIG00633378 FIG00633381: hypothetical protein +FIG00633383 FIG00633384: hypothetical protein +FIG00633384 FIG00633385: hypothetical protein +FIG00633402 FIG00633406: hypothetical protein +FIG00633406 FIG00633407: hypothetical protein +FIG00633407 PsiE protein homolog +FIG00633432 flagellar operon protein +FIG00633433 hypothetical protein +FIG00633435 FIG00633436: hypothetical protein +FIG00633442 FIG00633443: hypothetical protein +FIG00633453 FIG00633454: hypothetical protein +FIG00633458 FIG00633459: hypothetical protein +FIG00633474 FIG00633475: hypothetical protein +FIG00633475 FIG00633477: hypothetical protein +FIG00633477 FIG00633480: hypothetical protein +FIG00633480 FIG00633482: hypothetical protein +FIG00633486 FIG00633494: hypothetical protein +FIG00633500 FIG00633501: hypothetical protein +FIG00633501 FIG00633502: hypothetical protein +FIG00633503 FIG00633505: hypothetical protein +FIG00633505 FIG00633510: hypothetical protein +FIG00633510 FIG00633511: hypothetical protein +FIG00633511 FIG00633513: hypothetical protein +FIG00633515 FIG00633516: hypothetical protein +FIG00633538 FIG00633540: hypothetical protein +FIG00633542 FIG00633543: hypothetical protein +FIG00633548 FIG00633551: hypothetical protein +FIG00633551 surface protein (LPXTG motif) +FIG00633553 FIG00633554: hypothetical protein +FIG00633554 FIG00633555: hypothetical protein +FIG00633555 FIG00633560: hypothetical protein +FIG00633569 FIG00633571: hypothetical protein +FIG00633571 FIG00633572: hypothetical protein +FIG00633572 carbohydrate kinase, pfkB family +FIG00633573 SWIM Zn-finger +FIG00633583 accessory gene regulator protein A +FIG00633584 FIG00633585: hypothetical protein +FIG00633585 FIG00633590: hypothetical protein +FIG00633595 FIG00633597: hypothetical protein +FIG00633609 FIG00633611: hypothetical protein +FIG00633613 FIG00633616: hypothetical protein +FIG00633616 FIG00633618: hypothetical protein +FIG00633623 TrsE-like protein +FIG00633627 FIG00633628: hypothetical protein +FIG00633632 FIG00633641: hypothetical protein +FIG00633654 FIG00633656: hypothetical protein +FIG00633656 FIG00633660: hypothetical protein +FIG00633662 FIG00633663: hypothetical protein +FIG00633669 FIG00633670: hypothetical protein +FIG00633677 hypothetical protein +FIG00633684 FIG00633685: hypothetical protein +FIG00633685 FIG00633687: hypothetical protein +FIG00633693 Mg2+ transporter protein, CorA-like +FIG00633695 FIG00633698: hypothetical protein +FIG00633698 FIG00633700: hypothetical protein +FIG00633700 FIG00633702: hypothetical protein +FIG00633702 FIG00633709: hypothetical protein +FIG00633709 FIG00633711: hypothetical protein +FIG00633738 CopS protein +FIG00633742 Superfamily II DNA/RNA helicase, SNF2 family +FIG00633746 acylglycerophosphoethanolamine acyltransferase +FIG00633760 FIG00633762: hypothetical protein +FIG00633764 FIG00633766: hypothetical protein +FIG00633772 FIG00633773: hypothetical protein +FIG00633773 FIG00633774: hypothetical protein +FIG00633776 FIG00633779: hypothetical protein +FIG00633779 FIG00633787: hypothetical protein +FIG00633787 TraF +FIG00633794 FIG00633796: hypothetical protein +FIG00633811 FIG00633815: hypothetical protein +FIG00633820 conserved hypothetical protein +FIG00633825 FIG00633828: hypothetical protein +FIG00633828 FIG00633834: hypothetical protein +FIG00633842 FIG00633845: hypothetical protein +FIG00633850 hypothetical protein +FIG00633866 FIG00633867: hypothetical protein +FIG00633867 PTS system, IID component +FIG00633874 Putative phage-related 1,4-beta-N-acetyl muramidase (cell wall hydrolase)( EC:3.2.1.17 ) +FIG00633882 FIG00633887: hypothetical protein +FIG00633888 putative invasin +FIG00633891 FIG00633897: hypothetical protein +FIG00633900 FIG00633901: hypothetical protein +FIG00633904 FIG00633905: hypothetical protein +FIG00633906 putative effector protein +FIG00633908 FIG004614: Putative cytoplasmic protein +FIG00633911 FIG00633915: hypothetical protein +FIG00633915 FIG00895798: hypothetical protein +FIG00633919 Predicted ATP-dependent endonuclease of the OLD family, YbjD subgroup +FIG00633921 Twin-arginine translocation pathway signal sequence domain protein +FIG00633925 COG2907: Amine oxidase, flavin-containing +FIG00633930 Amylovoran biosynthesis protein amsC +FIG00633936 FIG00633937: hypothetical protein +FIG00633937 Outer membrane protein C precursor +FIG00633942 FIG00633943: hypothetical protein +FIG00633943 Plasmid partition protein ParG +FIG00633944 FIG00633945: hypothetical protein +FIG00633945 Metallo-dependent hydrolases, subgroup B +FIG00633948 Transcriptional regulator for fatty acid degradation FadR, GntR family +FIG00633949 FIG00633950: hypothetical protein +FIG00633950 Putative flagellar assembly regulatory protein, Flk +FIG00633955 FIG00633956: hypothetical protein +FIG00633956 FIG00633957: hypothetical protein +FIG00633957 FIG00633958: hypothetical protein +FIG00633960 FIG00633961: hypothetical protein +FIG00633961 FIG00633962: hypothetical protein +FIG00633962 FIG00633963: hypothetical protein +FIG00633968 FIG00633971: hypothetical protein +FIG00633971 FIG00633973: hypothetical protein +FIG00633973 FIG00633974: hypothetical protein +FIG00633974 type III secretion protein HrcQb +FIG00633978 FIG00633981: hypothetical protein +FIG00633981 MFS Superfamily tartrate transporter +FIG00633983 FIG00633984: hypothetical protein +FIG00633985 FIG00633986: hypothetical protein +FIG00633986 putative HrpW chaperone +FIG00633987 FIG00633989: hypothetical protein +FIG00633992 FIG00633994: hypothetical protein +FIG00633998 probable thioesterase protein +FIG00634007 FIG00634008: hypothetical protein +FIG00634008 probable membrane protein yjeI +FIG00634011 CRISPR-associated protein, Cse2 family +FIG00634014 Ner-like regulatory protein +FIG00634018 FIG00634019: hypothetical protein +FIG00634020 Cation transport protein chaC +FIG00634031 FIG00634033: hypothetical protein +FIG00634037 probable acyltransferase protein +FIG00634060 FIG00634062: hypothetical protein +FIG00634063 SanA protein +FIG00634071 Rhs-family protein +FIG00634075 Putative Na(+)/H(+) exchanger protein, CPA1 family precursor +FIG00634079 FIG00634080: hypothetical protein +FIG00634080 FIG00634081: hypothetical protein +FIG00634081 HrpE +FIG00634086 FIG00634092: hypothetical protein +FIG00634101 FIG00634105: hypothetical protein +FIG00634108 FIG00634113: hypothetical protein +FIG00634114 Spermidine export protein MdtJ +FIG00634115 FIG00809136: hypothetical protein +FIG00634117 FIG00634119: hypothetical protein +FIG00634119 FIG00634120: hypothetical protein +FIG00634130 HrpV +FIG00634131 FIG00634132: hypothetical protein +FIG00634140 FIG00634143: hypothetical protein +FIG00634143 Protein ydgH precursor +FIG00634159 Uncharacterized protein YeaG +FIG00634167 FIG00634168: hypothetical protein +FIG00634169 FIG00634170: hypothetical protein +FIG00634172 FIG00634174: hypothetical protein +FIG00634174 FIG00634175: hypothetical protein +FIG00634175 TrkA, Potassium channel-family protein +FIG00634179 Type III secretion inner membrane protein (YscT,HrcT,SpaR,EscT,EpaR1,homologous to flagellar export components) +FIG00634184 SrfB +FIG00634186 conserved hypothetical protein; putative YCII-related domain +FIG00634196 HrpF +FIG00634198 Uncharacterized metabolite ABC transporter in Enterobacteriaceae, ATP-binding protein EC-YbbA +FIG00634199 FIG00634204: hypothetical protein +FIG00634207 FIG00634208: hypothetical protein +FIG00634208 Asp-tRNAAsn/Glu-tRNAGln amidotransferase A subunit and related amidases +FIG00634219 FIG00634220: hypothetical protein +FIG00634220 Putative cell division protein precursor +FIG00634222 Probable lipoprotein nlpC precursor +FIG00634228 FIG00634229: hypothetical protein +FIG00634229 putative chaparone +FIG00634232 FIG00634233: hypothetical protein +FIG00634238 FIG00634239: hypothetical protein +FIG00634245 FIG00634247: hypothetical protein +FIG00634247 FIG00634249: hypothetical protein +FIG00634249 FIG003003: hypothetical protein +FIG00634251 CshE pilin +FIG00634255 FIG00634256: hypothetical protein +FIG00634256 FIG00634257: hypothetical protein +FIG00634257 Unknown, probable ABC transporter +FIG00634258 FIG00634261: hypothetical protein +FIG00634261 FIG00634262: hypothetical protein +FIG00634262 type III secretion apparatus SpaR +FIG00634276 hypothetical protein Pfl_5213 +FIG00634283 Peroxiredoxin family protein/glutaredoxin +FIG00634291 DNA-damage-inducible protein F +FIG00634312 FIG00634313: hypothetical protein +FIG00634313 Flagellar basal-body P-ring formation protein flgA +FIG00634326 FIG00634327: hypothetical protein +FIG00634330 FIG00634334: hypothetical protein +FIG00634334 FIG00634335: hypothetical protein +FIG00634335 FIG00634338: hypothetical protein +FIG00634338 FIG00634339: hypothetical protein +FIG00634339 FIG00634341: hypothetical protein +FIG00634341 FIG00634342: hypothetical protein +FIG00634342 FIG00634343: hypothetical protein +FIG00634344 Protein phosphatase 2C-like:Protein phosphatase 2C-like +FIG00634356 FIG00634357: hypothetical protein +FIG00634357 FIG00634358: hypothetical protein +FIG00634358 Outer membrane protein F precursor +FIG00634363 FIG00634366: hypothetical protein +FIG00634368 FIG00634370: hypothetical protein +FIG00634371 Hrp pili protein hrpA (TTSS pilin hrpA) +FIG00634375 FIG00634377: hypothetical protein +FIG00634389 Periplasmic protein related to spheroblast formation +FIG00634397 Hypothetical Zinc-finger containing protein +FIG00634401 FIG00634403: hypothetical protein +FIG00634403 FIG00634404: hypothetical protein +FIG00634404 FIG00634405: hypothetical protein +FIG00634410 type III secretion system protein +FIG00634411 FIG01045656: hypothetical protein +FIG00634415 FIG00634417: hypothetical protein +FIG00634417 FIG00634419: hypothetical protein +FIG00634419 FIG00634422: hypothetical protein +FIG00634422 DcrB protein precursor +FIG00634429 HrpO +FIG00634430 FIG00634431: hypothetical protein +FIG00634431 FIG00634433: hypothetical protein +FIG00634433 FIG00634435: hypothetical protein +FIG00634435 FIG00634439: hypothetical protein +FIG00634439 FIG00634443: hypothetical protein +FIG00634443 tyrosine recombinase +FIG00634444 Hypothetical lipoprotein yajI +FIG00634451 FIG00634453: hypothetical protein +FIG00634455 FIG002577: Putative lipoprotein precursor +FIG00634457 FIG00634458: hypothetical protein +FIG00634458 FIG00634460: hypothetical protein +FIG00634460 FIG00634462: hypothetical protein +FIG00634462 FIG00634464: hypothetical protein +FIG00634471 Phosphate starvation-inducible protein PsiF +FIG00634473 FIG00634477: hypothetical protein +FIG00634477 Putative outer membrane lipoprotein +FIG00634482 PefC +FIG00634483 Putative two-component system sensor kinase +FIG00634488 FIG00634489: hypothetical protein +FIG00634489 Putative ABC transporter, ATP-binding protein +FIG00634493 Exodeoxyribonuclease X (EC 3.1.11.-) +FIG00634494 FIG00634494: possible peptidase +FIG00634495 FIG00634496: hypothetical protein +FIG00634496 FIG00634497: hypothetical protein +FIG00634497 YbjC protein, clustered with oxygen-insensitive NADPH nitroreductase +FIG00634499 Probable secreted protein +FIG00634503 FIG00634505: hypothetical protein +FIG00634505 FIG00634509: hypothetical protein +FIG00634509 FIG00634511: hypothetical protein +FIG00634512 FIG00634513: hypothetical protein +FIG00634513 FIG00634514: hypothetical protein +FIG00634520 FIG00634522: hypothetical protein +FIG00634522 hypothetical protein +FIG00634527 FIG00634528: hypothetical protein +FIG00634543 FIG00634544: hypothetical protein +FIG00634555 Putative carboxymethylenebutenolidase (EC 3.1.1.45) +FIG00634560 general secretion pathway lipoprotein +FIG00634574 N-ethylmaleimide reductase (EC 1.-.-.-) +FIG00634576 Putative negative regulator +FIG00634581 FIG00634586: hypothetical protein +FIG00634590 FIG00634594: hypothetical protein +FIG00634596 FIG00634599: hypothetical protein +FIG00634599 putative signaling membrane protein +FIG00634603 Stationary phase inducible protein CsiE +FIG00634605 FIG00634607: hypothetical protein +FIG00634607 FIG00634610: hypothetical protein +FIG00634610 protein of unknown function DUF882 +FIG00634615 FIG00634617: hypothetical protein +FIG00634621 FIG00634622: hypothetical protein +FIG00634628 FIG01219827: hypothetical protein +FIG00634631 FIG00634635: hypothetical protein +FIG00634643 FIG00634644: hypothetical protein +FIG00634651 FIG00614178: hypothetical protein +FIG00634664 FIG00634665: hypothetical protein +FIG00634665 FIG00634670: hypothetical protein +FIG00634670 FIG00634671: hypothetical protein +FIG00634680 FIG00634681: hypothetical protein +FIG00634681 YcfA protein +FIG00634683 FIG00634684: hypothetical protein +FIG00634690 CRISPR-associated protein, Csy3 family +FIG00634691 FIG00634692: hypothetical protein +FIG00634692 Putative outer membrane protein +FIG00634697 FIG00634700: hypothetical protein +FIG00634700 FIG00634702: hypothetical protein +FIG00634706 FIG00634709: hypothetical protein +FIG00634709 FIG00634711: hypothetical protein +FIG00634718 Putative cytochrome oxidase +FIG00634728 FIG00634729: hypothetical protein +FIG00634729 protein of unknown function DUF1471 +FIG00634739 FIG00634740: hypothetical protein +FIG00634744 FIG00634746: hypothetical protein +FIG00634751 Spermidine export protein MdtI +FIG00634757 FIG00634758: hypothetical protein +FIG00634766 FIG00634768: hypothetical protein +FIG00634769 FIG00634770: hypothetical protein +FIG00634770 type I restriction enzyme HsdR, putative +FIG00634776 FIG00634780: hypothetical protein +FIG00634788 FIG00634789: hypothetical protein +FIG00634798 FIG00634799: hypothetical protein +FIG00634805 membrane-bound metal-dependent hydrolase +FIG00634807 FIG00634817: hypothetical protein +FIG00634818 FIG00634819: hypothetical protein +FIG00634825 protein of unknown function DUF883, ElaB +FIG00634827 FIG00634828: hypothetical protein +FIG00634828 FIG00634830: hypothetical protein +FIG00634830 FIG00634832: hypothetical protein +FIG00634832 COG3916: N-acyl-L-homoserine lactone synthetase +FIG00634837 FIG00634841: hypothetical protein +FIG00634841 FUSARIC ACID RESISTANCE PROTEIN FUSB / FUSARIC ACID RESISTANCE PROTEIN FUSC +FIG00634845 Putative exported protein +FIG00634864 Amylovoran biosynthesis protein amsF precursor +FIG00634867 COG4095: Uncharacterized conserved protein +FIG00634869 FIG00634875: hypothetical protein +FIG00634875 FIG00634876: hypothetical protein +FIG00634878 FIG00634879: hypothetical protein +FIG00634879 FIG00634881: hypothetical protein +FIG00634881 FIG00634883: hypothetical protein +FIG00634884 FIG00634889: hypothetical protein +FIG00634889 FIG00634892: hypothetical protein +FIG00634892 phage transcriptional activator, Ogr/delta +FIG00634893 COG1451: Predicted metal-dependent hydrolase +FIG00634894 FIG00634896: hypothetical protein +FIG00634897 FIG00634901: hypothetical protein +FIG00634903 Calcium/proton antiporter +FIG00634908 FIG00634911: hypothetical protein +FIG00634911 FIG00896276: hypothetical protein +FIG00634913 FIG00634917: hypothetical protein +FIG00634918 Diaminobutyrate--2-oxoglutarate aminotransferase (EC 2.6.1.76) +FIG00634919 FIG00634920: hypothetical protein +FIG00634920 type III effector HopZ3 +FIG00634927 FIG00634929: hypothetical protein +FIG00634930 FIG00634932: hypothetical protein +FIG00634932 Putative ATPase component of ABC transporter with duplicated ATPase domain +FIG00634933 FIG00634936: hypothetical protein +FIG00634937 FIG00613981: hypothetical protein +FIG00634939 FIG00634942: hypothetical protein +FIG00634943 FIG00634944: hypothetical protein +FIG00634944 FIG00634946: hypothetical protein +FIG00634946 FIG00634949: hypothetical protein +FIG00634950 FIG00634952: hypothetical protein +FIG00634953 FIG00634954: hypothetical protein +FIG00634968 rRNA small subunit methyltransferase J +FIG00634973 FIG00634977: hypothetical protein +FIG00634977 FIG00634979: hypothetical protein +FIG00634979 COG4571: Outer membrane protease( EC:3.4.21.87 ) +FIG00634980 FIG00634981: hypothetical protein +FIG00634982 FIG00634984: hypothetical protein +FIG00634996 Mn-dependent transcriptional regulator MntR +FIG00635002 FIG00635003: hypothetical protein +FIG00635003 FIG00635005: hypothetical protein +FIG00635011 FIG00635013: hypothetical protein +FIG00635026 COG3141: Uncharacterized protein conserved in bacteria +FIG00635027 AraC family transcriptional regulator +FIG00635030 FIG00635033: hypothetical protein +FIG00635033 FIG00635037: hypothetical protein +FIG00635037 bacteriophage regulatory protein +FIG00635038 FIG00635042: hypothetical protein +FIG00635042 FIG00635043: hypothetical protein +FIG00635043 FIG00635048: hypothetical protein +FIG00635051 FIG00635055: hypothetical protein +FIG00635055 HrpW +FIG00635060 mcbg protein, putative +FIG00635064 metal dependent phosphohydrolase +FIG00635065 FIG00635066: hypothetical protein +FIG00635078 FIG00635079: hypothetical protein +FIG00635082 FIG00635084: hypothetical protein +FIG00635084 FIG00895632: hypothetical protein +FIG00635089 FIG00635091: hypothetical protein +FIG00635093 FIG00635094: hypothetical protein +FIG00635095 K88 minor fimbrial subunit faeH precursor +FIG00635104 COG0076: Glutamate decarboxylase and related PLP-dependent proteins +FIG00635105 FIG00635108: hypothetical protein +FIG00635108 Putative large exoprotein involved in heme utilization or adhesion of ShlA/HecA/FhaA family +FIG00635113 Acidic protein msyB +FIG00635114 FIG00635121: hypothetical protein +FIG00635121 FIG00635122: hypothetical protein +FIG00635128 FIG00635129: hypothetical protein +FIG00635132 COG0286: Type I restriction-modification system methyltransferase subunit +FIG00635160 FIG00635161: hypothetical protein +FIG00635167 FIG00635168: hypothetical protein +FIG00635168 late embryogenesis abundant (LEA) domain-containing protein +FIG00635171 FIG00635177: hypothetical protein +FIG00635183 FIG00635185: hypothetical protein +FIG00635185 FIG00635187: hypothetical protein +FIG00635187 FIG00635189: hypothetical protein +FIG00635189 FIG00635197: hypothetical protein +FIG00635197 Two-component system response regulator OmpR +FIG00635202 probable transcriptional regulator, LysR family +FIG00635205 FIG00635207: hypothetical protein +FIG00635207 COG0642: Signal transduction histidine kinase +FIG00635213 FIG00635214: hypothetical protein +FIG00635214 Mg(2+) transport ATPase protein B +FIG00635216 N-methyl-L-amino-acid oxidase (EC 1.5.3.2); N-methyl-L-tryptophan oxidase (EC 1.5.3.-) +FIG00635219 FIG00635220: hypothetical protein +FIG00635220 FIG00635223: hypothetical protein +FIG00635223 FIG00635224: hypothetical protein +FIG00635224 FIG00635225: hypothetical protein +FIG00635226 probable deoR-family transcriptional regulatory protein +FIG00635231 FIG00635232: hypothetical protein +FIG00635232 Yop effector YopH +FIG00635235 FIG00635236: hypothetical protein +FIG00635240 K88 minor fimbrial subunit faeI precursor +FIG00635246 FIG00635250: hypothetical protein +FIG00635250 FIG00635253: hypothetical protein +FIG00635253 FIG00635255: hypothetical protein +FIG00635259 Putative invasin +FIG00635263 FIG00635264: hypothetical protein +FIG00635266 FIG00635267: hypothetical protein +FIG00635292 FIG00635293: hypothetical protein +FIG00635293 FIG00635294: hypothetical protein +FIG00635310 ThiF +FIG00635323 Putative exopolysaccharide production protein ExoZ +FIG00635334 Death ON curing protein +FIG00635370 FIG00635375: hypothetical protein +FIG00635376 Presumed portal vertex protein +FIG00635424 FIG00635425: hypothetical protein +FIG00635425 FIG00635427: hypothetical protein +FIG00635440 FIG00635442: hypothetical protein +FIG00635446 FIG00635447: hypothetical protein +FIG00635447 FIG00635450: hypothetical protein +FIG00635450 FIG00635455: hypothetical protein +FIG00635455 FIG00635470: hypothetical protein +FIG00635470 Putative o-acyltransferase, CysE/LacA/LpxA/NodL family +FIG00635471 FIG00635474: hypothetical protein +FIG00635476 FIG00635478: hypothetical protein +FIG00635478 FIG00635481: hypothetical protein +FIG00635483 Signal transduction response regulator, C-terminal effector +FIG00635499 DspF +FIG00635508 FIG00635511: hypothetical protein +FIG00635516 Amylovoran biosynthesis glycosyltransferase amsB (EC 2.-.-.-) +FIG00635518 FIG00635527: hypothetical protein +FIG00635537 FIG00635541: hypothetical protein +FIG00635549 Amylovoran biosynthesis glycosyltransferase amsE (EC 2.-.-.-) +FIG00635557 Flagellar biosynthesis protein flgN +FIG00635563 FIG00635564: hypothetical protein +FIG00635567 putative cytochrome oxidase subunit +FIG00635569 FIG00635573: hypothetical protein +FIG00635573 FIG00635574: hypothetical protein +FIG00635574 FIG00635576: hypothetical protein +FIG00635576 FIG00635582: hypothetical protein +FIG00635582 Cell volume regulation protein A +FIG00635586 FIG00635597: hypothetical protein +FIG00635597 FIG00635598: hypothetical protein +FIG00635603 HrpP +FIG00635607 FIG00635608: hypothetical protein +FIG00635608 FIG00635612: hypothetical protein +FIG00635612 FIG00635613: hypothetical protein +FIG00635613 type III secretion apparatus SpaO +FIG00635615 FIG00635628: hypothetical protein +FIG00635641 FIG00635646: hypothetical protein +FIG00635646 FIG00635648: hypothetical protein +FIG00635662 FIG00635666: hypothetical protein +FIG00635666 FIG00635672: hypothetical protein +FIG00635679 FIG00635682: hypothetical protein +FIG00635683 FIG00635690: hypothetical protein +FIG00635721 FIG00635723: hypothetical protein +FIG00635765 FIG00635770: hypothetical protein +FIG00635774 FIG00635776: hypothetical protein +FIG00635783 FIG00635786: hypothetical protein +FIG00635800 Beta-ketoacyl synthase( EC:2.3.1.94 ) +FIG00635862 FIG00635863: hypothetical protein +FIG00635863 Nitrogen regulation protein NtrX +FIG00635864 SMR/MUTS FAMILY PROTEIN +FIG00635865 FIG00635866: hypothetical protein +FIG00635868 FIG00635869: hypothetical protein +FIG00635871 FIG00635873: hypothetical protein +FIG00635873 FIG00635876: hypothetical protein +FIG00635878 FIG00635880: hypothetical protein +FIG00635880 FIG00635881: hypothetical protein +FIG00635881 FIG00635882: hypothetical protein +FIG00635882 Pathogenesis-related protein 1b precursor +FIG00635884 FIG00635887: hypothetical protein +FIG00635889 FIG00635890: hypothetical protein +FIG00635890 FIG00635892: hypothetical protein +FIG00635893 FIG00635895: hypothetical protein +FIG00635895 FIG00635896: hypothetical protein +FIG00635896 DNA invertase gene rlgA +FIG00635900 FIG00635901: hypothetical protein +FIG00635901 FIG00635902: hypothetical protein +FIG00635906 FIG00635908: hypothetical protein +FIG00635908 FIG00635909: hypothetical protein +FIG00635909 small-conductance mechanosensitive channel +FIG00635920 FIG00635921: hypothetical protein +FIG00635921 FIG00635922: hypothetical protein +FIG00635922 FIG00635924: hypothetical protein +FIG00635924 FIG00635927: hypothetical protein +FIG00635927 FIG00635930: hypothetical protein +FIG00635930 Eukaryotic translation initiation factor 3 subunit 10 +FIG00635933 FIG00635934: hypothetical protein +FIG00635934 S-adenosylmethionine:diacylglycerol 3-amino-3-carboxypropyl transferase +FIG00635935 FIG00635936: hypothetical protein +FIG00635936 FIG00635938: hypothetical protein +FIG00635938 FIG00635939: hypothetical protein +FIG00635947 FIG00635951: hypothetical protein +FIG00635952 FIG00635954: hypothetical protein +FIG00635958 FIG00635959: hypothetical protein +FIG00635959 FIG00635963: hypothetical protein +FIG00635963 FIG00635964: hypothetical protein +FIG00635964 FIG00635965: hypothetical protein +FIG00635965 FIG00635967: hypothetical protein +FIG00635967 FIG00635968: hypothetical protein +FIG00635969 FIG00635971: hypothetical protein +FIG00635972 FIG00635973: hypothetical protein +FIG00635973 FIG00635975: hypothetical protein +FIG00635975 Bll8156 protein +FIG00635977 FIG00635979: hypothetical protein +FIG00635979 FIG00635982: hypothetical protein +FIG00635988 FIG00635990: hypothetical protein +FIG00635990 FIG00635991: hypothetical protein +FIG00635998 FIG00635999: hypothetical protein +FIG00635999 FIG00636002: hypothetical protein +FIG00636003 FIG00636007: hypothetical protein +FIG00636007 FIG00636008: hypothetical protein +FIG00636014 FIG00636015: hypothetical protein +FIG00636015 FIG00636016: hypothetical protein +FIG00636016 FIG00636017: hypothetical protein +FIG00636017 FIG00636018: hypothetical protein +FIG00636018 FIG00636020: hypothetical protein +FIG00636020 FIG00636025: hypothetical protein +FIG00636027 FIG00636028: hypothetical protein +FIG00636028 FIG00636029: hypothetical protein +FIG00636029 FIG00636030: hypothetical protein +FIG00636031 FIG00636032: hypothetical protein +FIG00636032 FIG00636033: hypothetical protein +FIG00636035 FIG00636037: hypothetical protein +FIG00636037 FIG00636040: hypothetical protein +FIG00636040 FIG00636045: hypothetical protein +FIG00636045 FIG00636046: hypothetical protein +FIG00636046 FIG00636047: hypothetical protein +FIG00636050 FIG00636051: hypothetical protein +FIG00636053 FIG00636055: hypothetical protein +FIG00636059 FIG00636061: hypothetical protein +FIG00636062 FIG00636064: hypothetical protein +FIG00636065 FIG00636068: hypothetical protein +FIG00636068 FIG00636069: hypothetical protein +FIG00636079 FIG00636080: hypothetical protein +FIG00636084 FIG00636085: hypothetical protein +FIG00636085 FIG00636087: hypothetical protein +FIG00636090 FIG00636093: hypothetical protein +FIG00636094 FIG00636097: hypothetical protein +FIG00636097 FIG00636098: hypothetical protein +FIG00636098 FIG00636099: hypothetical protein +FIG00636102 FIG00636104: hypothetical protein +FIG00636104 FIG00636105: hypothetical protein +FIG00636107 FIG00636112: hypothetical protein +FIG00636118 FIG00636121: hypothetical protein +FIG00636124 FIG00636125: hypothetical protein +FIG00636125 FIG00636127: hypothetical protein +FIG00636130 FIG00636135: hypothetical protein +FIG00636135 FIG00636136: hypothetical protein +FIG00636139 FIG00636141: hypothetical protein +FIG00636145 FIG00636146: hypothetical protein +FIG00636146 FIG00636148: hypothetical protein +FIG00636149 Metallo-beta-lactamase L1 precursor (Beta-lactamase type II) (EC 3.5.2.6) +FIG00636154 FIG00636156: hypothetical protein +FIG00636156 FIG00636158: hypothetical protein +FIG00636158 FIG00636160: hypothetical protein +FIG00636160 FIG00636163: hypothetical protein +FIG00636163 FIG00636165: hypothetical protein +FIG00636165 FIG00636168: hypothetical protein +FIG00636168 FIG00636170: hypothetical protein +FIG00636170 FIG00636171: hypothetical protein +FIG00636173 FIG00636177: hypothetical protein +FIG00636182 putative lysine decarboxylase +FIG00636184 FIG00636185: hypothetical protein +FIG00636186 FIG00636188: hypothetical protein +FIG00636204 FIG00636205: hypothetical protein +FIG00636205 FIG00636206: hypothetical protein +FIG00636209 FIG00636210: hypothetical protein +FIG00636213 FIG00636215: hypothetical protein +FIG00636215 FIG00636216: hypothetical protein +FIG00636216 DNA-directed RNA polymerase specialized sigma subunit, +FIG00636217 FIG00636218: hypothetical protein +FIG00636218 Short-chain alcohol dehydrogenase of unknown specificity +FIG00636220 FIG00636222: hypothetical protein +FIG00636222 FIG00636223: hypothetical protein +FIG00636223 FIG00636224: hypothetical protein +FIG00636224 FIG00636225: hypothetical protein +FIG00636225 FIG00636226: hypothetical protein +FIG00636227 putative dihydroflavonol-4-reductase +FIG00636236 FIG00636240: hypothetical protein +FIG00636243 FIG00636244: hypothetical protein +FIG00636244 FIG00636249: hypothetical protein +FIG00636249 FIG00636251: hypothetical protein +FIG00636252 FIG00636254: hypothetical protein +FIG00636254 FIG00636257: hypothetical protein +FIG00636257 FIG00636259: hypothetical protein +FIG00636259 putative polysaccharide biosynthesis protein CpsL +FIG00636261 Nickel-cobalt-cadmium resistance protein nccX +FIG00636263 FIG00636267: hypothetical protein +FIG00636270 Calcium-binding EF-hand protein +FIG00636275 Beta lactamase-related protein +FIG00636278 FIG00636279: hypothetical protein +FIG00636279 FIG00636284: hypothetical protein +FIG00636286 FIG00636289: hypothetical protein +FIG00636295 FIG00636297: hypothetical protein +FIG00636299 FIG00636301: hypothetical protein +FIG00636301 FIG00636302: hypothetical protein +FIG00636305 FIG00636307: hypothetical protein +FIG00636307 FIG00636309: hypothetical protein +FIG00636316 FIG00636317: hypothetical protein +FIG00636317 FIG00636318: hypothetical protein +FIG00636318 FIG00636320: hypothetical protein +FIG00636320 FIG00636323: hypothetical protein +FIG00636324 FIG00636325: hypothetical protein +FIG00636329 ABC-type multidrug transport system ATPase component +FIG00636334 FIG00636335: hypothetical protein +FIG00636344 Gene Transfer Agent tail tape measure +FIG00636345 sensory box histidine kinase/response regulator +FIG00636347 Rod shape-determining protein MreD +FIG00636348 FIG00636349: hypothetical protein +FIG00636349 FIG00636352: hypothetical protein +FIG00636352 FIG00636355: hypothetical protein +FIG00636355 FIG00636357: hypothetical protein +FIG00636357 FIG00636358: hypothetical protein +FIG00636358 FIG00636359: hypothetical protein +FIG00636362 FIG00636363: hypothetical protein +FIG00636367 FIG00636369: hypothetical protein +FIG00636370 FIG00636371: hypothetical protein +FIG00636371 FIG00636372: hypothetical protein +FIG00636374 FIG00636375: hypothetical protein +FIG00636378 FIG00636379: hypothetical protein +FIG00636379 FIG00636380: hypothetical protein +FIG00636387 FIG00636388: hypothetical protein +FIG00636388 FIG00636390: hypothetical protein +FIG00636391 FIG00636394: hypothetical protein +FIG00636394 FIG00636395: hypothetical protein +FIG00636398 FIG00636399: hypothetical protein +FIG00636400 FIG00636402: hypothetical protein +FIG00636402 FIG00636403: hypothetical protein +FIG00636403 FIG00636405: hypothetical protein +FIG00636405 FIG00636406: hypothetical protein +FIG00636407 FIG00636408: hypothetical protein +FIG00636408 FIG00636410: hypothetical protein +FIG00636410 FIG00636412: hypothetical protein +FIG00636412 FIG00636416: hypothetical protein +FIG00636416 FIG00636419: hypothetical protein +FIG00636419 FIG00636420: hypothetical protein +FIG00636421 FIG00636423: hypothetical protein +FIG00636423 FIG00636425: hypothetical protein +FIG00636426 FIG00636427: hypothetical protein +FIG00636427 FIG00636428: hypothetical protein +FIG00636428 FIG00636430: hypothetical protein +FIG00636431 FIG00636432: hypothetical protein +FIG00636437 FIG00636438: hypothetical protein +FIG00636445 FIG00636450: hypothetical protein +FIG00636450 FIG00636453: hypothetical protein +FIG00636455 Gene Transfer Agent NlpC/P60 family peptidase +FIG00636456 50S ribosomal protein L13 +FIG00636460 FIG00636462: hypothetical protein +FIG00636462 FIG00636464: hypothetical protein +FIG00636464 FIG00636468: hypothetical protein +FIG00636470 TPR/sulfotransferase domain protein +FIG00636472 FIG00636479: hypothetical protein +FIG00636479 FIG00636480: hypothetical protein +FIG00636481 FIG00636482: hypothetical protein +FIG00636482 FIG00636483: hypothetical protein +FIG00636483 FIG00636485: hypothetical protein +FIG00636501 FIG00636505: hypothetical protein +FIG00636506 FIG00636508: hypothetical protein +FIG00636508 FIG00636510: hypothetical protein +FIG00636510 FIG00636512: hypothetical protein +FIG00636512 similar to hedgehog protein +FIG00636523 FIG00636524: hypothetical protein +FIG00636524 FIG00636527: hypothetical protein +FIG00636534 FIG00636535: hypothetical protein +FIG00636537 ABC-type transport system permease component +FIG00636538 FIG00636539: hypothetical protein +FIG00636543 FIG00636546: hypothetical protein +FIG00636546 FIG00636548: hypothetical protein +FIG00636548 FIG00636549: hypothetical protein +FIG00636552 FIG00636553: hypothetical protein +FIG00636555 FIG00636556: hypothetical protein +FIG00636556 flagellar protein FlgJ-like protein +FIG00636558 FIG00636561: hypothetical protein +FIG00636562 FIG00636565: hypothetical protein +FIG00636565 FIG00636567: hypothetical protein +FIG00636567 FIG00636570: hypothetical protein +FIG00636570 FIG00636571: hypothetical protein +FIG00636574 FIG00636576: hypothetical protein +FIG00636576 FIG00636577: hypothetical protein +FIG00636577 FIG00636578: hypothetical protein +FIG00636578 S-adenosyl-L-homocysteine hydrolase +FIG00636579 FIG00636582: hypothetical protein +FIG00636585 FIG00636587: hypothetical protein +FIG00636592 FIG00636593: hypothetical protein +FIG00636595 FIG00636596: hypothetical protein +FIG00636597 FIG00636598: hypothetical protein +FIG00636598 FIG00636599: hypothetical protein +FIG00636599 FIG00636602: hypothetical protein +FIG00636606 FIG00636607: hypothetical protein +FIG00636607 FIG00636608: hypothetical protein +FIG00636608 FIG00636609: hypothetical protein +FIG00636612 FIG00636613: hypothetical protein +FIG00636613 FIG00636615: hypothetical protein +FIG00636616 FIG00636617: hypothetical protein +FIG00636618 FIG00636620: hypothetical protein +FIG00636620 FIG00636621: hypothetical protein +FIG00636625 FIG00636626: hypothetical protein +FIG00636634 FIG00636635: hypothetical protein +FIG00636635 FIG00636636: hypothetical protein +FIG00636636 FIG00636638: hypothetical protein +FIG00636640 FIG00636645: hypothetical protein +FIG00636645 FIG00636647: hypothetical protein +FIG00636647 FIG00636649: hypothetical protein +FIG00636649 FIG00636650: hypothetical protein +FIG00636650 FIG00636652: hypothetical protein +FIG00636652 FIG00636657: hypothetical protein +FIG00636661 FIG00636663: hypothetical protein +FIG00636663 FIG00636666: hypothetical protein +FIG00636672 FIG00636673: hypothetical protein +FIG00636673 FIG00636674: hypothetical protein +FIG00636675 FIG00636676: hypothetical protein +FIG00636684 FIG00636689: hypothetical protein +FIG00636689 FIG00636693: hypothetical protein +FIG00636693 Outer membrane protein-like +FIG00636695 FIG00636702: hypothetical protein +FIG00636702 FIG00636704: hypothetical protein +FIG00636704 FIG00636705: hypothetical protein +FIG00636710 FIG00636711: hypothetical protein +FIG00636711 FIG00636712: hypothetical protein +FIG00636712 FIG00636713: hypothetical protein +FIG00636715 FIG00636718: hypothetical protein +FIG00636718 FIG00636720: hypothetical protein +FIG00636720 FIG00636721: hypothetical protein +FIG00636721 FIG00636723: hypothetical protein +FIG00636737 FIG00636741: hypothetical protein +FIG00636741 FIG00636742: hypothetical protein +FIG00636742 FIG00636743: hypothetical protein +FIG00636743 FIG00636748: hypothetical protein +FIG00636748 FIG00636751: hypothetical protein +FIG00636751 FIG00636753: hypothetical protein +FIG00636753 FIG00636758: hypothetical protein +FIG00636758 FIG00636765: hypothetical protein +FIG00636765 FIG00636767: hypothetical protein +FIG00636768 FIG00636769: hypothetical protein +FIG00636769 FIG00636770: hypothetical protein +FIG00636770 FIG00636771: hypothetical protein +FIG00636771 FIG00636772: hypothetical protein +FIG00636775 FIG00636776: hypothetical protein +FIG00636778 FIG00636783: hypothetical protein +FIG00636785 FIG00636789: hypothetical protein +FIG00636789 FIG00636791: hypothetical protein +FIG00636802 FIG00636803: hypothetical protein +FIG00636803 FIG00636804: hypothetical protein +FIG00636805 Gene Transfer Agent FAD/FMN-containing dehydrogenase +FIG00636806 FIG00636807: hypothetical protein +FIG00636807 DNA topoisomerase IV subunit B +FIG00636809 FIG00636813: hypothetical protein +FIG00636813 FIG00636815: hypothetical protein +FIG00636815 FIG00636819: hypothetical protein +FIG00636819 Type IV conjugative transfer system lipoprotein +FIG00636822 FIG00636824: hypothetical protein +FIG00636826 FIG00636829: hypothetical protein +FIG00636830 FIG00636832: hypothetical protein +FIG00636832 FIG00636833: hypothetical protein +FIG00636833 FIG00636836: hypothetical protein +FIG00636836 FIG00636840: hypothetical protein +FIG00636840 FIG00636841: hypothetical protein +FIG00636842 FIG00636843: hypothetical protein +FIG00636843 FIG00636844: hypothetical protein +FIG00636844 FIG00636845: hypothetical protein +FIG00636849 FIG00636853: hypothetical protein +FIG00636853 FIG00636856: hypothetical protein +FIG00636856 FIG00636859: hypothetical protein +FIG00636859 FIG00636863: hypothetical protein +FIG00636864 putative LPS biosynthesis protein WbpG +FIG00636867 FIG00636869: hypothetical protein +FIG00636870 FIG00636873: hypothetical protein +FIG00636873 FIG00636874: hypothetical protein +FIG00636885 FIG00636889: hypothetical protein +FIG00636889 FIG00636890: hypothetical protein +FIG00636890 FIG00636892: hypothetical protein +FIG00636892 FIG00636893: hypothetical protein +FIG00636893 FIG00636898: hypothetical protein +FIG00636901 FIG00636905: hypothetical protein +FIG00636905 FIG00636909: hypothetical protein +FIG00636912 FIG00636916: hypothetical protein +FIG00636920 FIG00636923: hypothetical protein +FIG00636929 FIG00636930: hypothetical protein +FIG00636931 FIG00636936: hypothetical protein +FIG00636937 FIG00636938: hypothetical protein +FIG00636939 FIG00636940: hypothetical protein +FIG00636940 FIG00636943: hypothetical protein +FIG00636943 FIG00636946: hypothetical protein +FIG00636946 FIG00636949: hypothetical protein +FIG00636949 FIG00636950: hypothetical protein +FIG00636950 possible peptidyl-prolyl isomerase +FIG00636957 FIG00636958: hypothetical protein +FIG00636959 FIG00636961: hypothetical protein +FIG00636961 FIG00607287: hypothetical protein +FIG00636972 FIG00636973: hypothetical protein +FIG00636978 FIG00636979: hypothetical protein +FIG00636982 FIG00636985: hypothetical protein +FIG00636985 Sensory transduction histidine kinases +FIG00636990 FIG00636991: hypothetical protein +FIG00636991 FIG00636993: hypothetical protein +FIG00636993 FIG00636994: hypothetical protein +FIG00636998 FIG00636999: hypothetical protein +FIG00636999 FIG00637001: hypothetical protein +FIG00637011 FIG00637013: hypothetical protein +FIG00637013 FIG00637014: hypothetical protein +FIG00637016 FIG00637017: hypothetical protein +FIG00637019 FIG00637022: hypothetical protein +FIG00637022 FIG00637023: hypothetical protein +FIG00637025 FIG00637027: hypothetical protein +FIG00637027 FIG00637029: hypothetical protein +FIG00637029 FIG00637030: hypothetical protein +FIG00637030 FIG00637033: hypothetical protein +FIG00637034 FIG00637036: hypothetical protein +FIG00637036 FIG00637041: hypothetical protein +FIG00637041 FIG00637042: hypothetical protein +FIG00637045 ycfI, putative structural proteins +FIG00637046 FIG00637048: hypothetical protein +FIG00637060 FIG00637061: hypothetical protein +FIG00637070 FIG00637072: hypothetical protein +FIG00637072 Predicted aminoglycoside phosphotransferase +FIG00637073 FIG00637075: hypothetical protein +FIG00637083 FIG00637084: hypothetical protein +FIG00637087 FIG00637089: hypothetical protein +FIG00637089 FIG00637091: hypothetical protein +FIG00637092 Conserved hypothetical protein, gene in Ubiquinol-cytochrome C chaperone locus +FIG00637093 FIG00637095: hypothetical protein +FIG00637100 FIG00637101: hypothetical protein +FIG00637115 FIG00637116: hypothetical protein +FIG00637116 FIG00637118: hypothetical protein +FIG00637121 FIG00637123: hypothetical protein +FIG00637126 FIG00637128: hypothetical protein +FIG00637128 LYSOZYME M1 (EC 3.2.1.17) +FIG00637133 FIG00637134: hypothetical protein +FIG00637134 phosphate regulon transcriptional regulatory protein +FIG00637138 FIG00637141: hypothetical protein +FIG00637141 FIG00637144: hypothetical protein +FIG00637145 FIG00637146: hypothetical protein +FIG00637148 FIG00637150: hypothetical protein +FIG00637152 FIG00637154: hypothetical protein +FIG00637159 FIG00637162: hypothetical protein +FIG00637162 oxidoreductase (secreted protein) +FIG00637165 FIG00637166: hypothetical protein +FIG00637166 FIG00637168: hypothetical protein +FIG00637169 FIG00637170: hypothetical protein +FIG00637170 FIG00637171: hypothetical protein +FIG00637172 FIG00637173: hypothetical protein +FIG00637182 FIG00637183: hypothetical protein +FIG00637183 FIG00637185: hypothetical protein +FIG00637189 FIG00637194: hypothetical protein +FIG00637198 FIG00637202: hypothetical protein +FIG00637204 FIG00637205: hypothetical protein +FIG00637218 FIG00637221: hypothetical protein +FIG00637223 FIG00637225: hypothetical protein +FIG00637225 FIG00637229: hypothetical protein +FIG00637231 FIG00637233: hypothetical protein +FIG00637240 FIG00637246: hypothetical protein +FIG00637258 Gene Transfer Agent associated protein Sala_2001 +FIG00637262 FIG00637263: hypothetical protein +FIG00637273 GcrA cell cycle regulator +FIG00637278 FIG00637279: hypothetical protein +FIG00637279 FIG00637280: hypothetical protein +FIG00637283 FIG00637285: hypothetical protein +FIG00637286 FIG00637288: hypothetical protein +FIG00637295 FIG00637296: hypothetical protein +FIG00637300 FIG00637301: hypothetical protein +FIG00637302 FIG00637303: hypothetical protein +FIG00637303 FIG00637305: hypothetical protein +FIG00637305 FIG00637310: hypothetical protein +FIG00637310 FIG00637312: hypothetical protein +FIG00637318 FIG00637321: hypothetical protein +FIG00637328 Patatin-like phospholipase family protein +FIG00637338 FIG00637339: hypothetical protein +FIG00637339 FIG00637340: hypothetical protein +FIG00637359 FIG00637362: hypothetical protein +FIG00637363 FIG00637368: hypothetical protein +FIG00637368 FIG00637371: hypothetical protein +FIG00637371 FIG00637373: hypothetical protein +FIG00637381 FIG00637382: hypothetical protein +FIG00637397 FIG00637399: hypothetical protein +FIG00637399 FIG00637401: hypothetical protein +FIG00637401 FIG00637403: hypothetical protein +FIG00637403 FIG00637409: hypothetical protein +FIG00637412 FIG00637415: hypothetical protein +FIG00637440 FIG00637443: hypothetical protein +FIG00637445 FIG00637448: hypothetical protein +FIG00637453 FIG00637457: hypothetical protein +FIG00637460 FIG00637461: hypothetical protein +FIG00637461 FIG00637465: hypothetical protein +FIG00637479 FIG00637484: hypothetical protein +FIG00637491 FIG00637492: hypothetical protein +FIG00637501 luciferase-like +FIG00637505 FIG00637507: hypothetical protein +FIG00637507 Symbiosis island integrase +FIG00637525 FIG00637528: hypothetical protein +FIG00637544 FIG00637551: hypothetical protein +FIG00637554 FIG00637560: hypothetical protein +FIG00637560 FIG00637561: hypothetical protein +FIG00637572 Sigma factor, ECF-like +FIG00637573 FIG00637574: hypothetical protein +FIG00637580 FIG00637581: hypothetical protein +FIG00637582 FIG00637586: hypothetical protein +FIG00637600 putative salt-induced outer membrane protein +FIG00637610 FIG00637611: hypothetical protein +FIG00637615 FIG00637619: hypothetical protein +FIG00637620 FIG00637622: hypothetical protein +FIG00637624 FIG00637634: hypothetical protein +FIG00637651 Putative protein disulfide isomerase +FIG00637655 FIG00637659: hypothetical protein +FIG00637667 FIG00637668: hypothetical protein +FIG00637673 FIG00637674: hypothetical protein +FIG00637680 FIG00637681: hypothetical protein +FIG00637686 peptidyl-prolyl cis-trans isomerase A +FIG00637688 FIG00637691: hypothetical protein +FIG00637691 FIG00637693: hypothetical protein +FIG00637717 FIG00637723: hypothetical protein +FIG00637734 FIG00637738: hypothetical protein +FIG00637741 FIG00637743: hypothetical protein +FIG00637749 FIG00637750: hypothetical protein +FIG00637767 FIG00637772: hypothetical protein +FIG00637816 FIG00637825: hypothetical protein +FIG00637832 FIG00637835: hypothetical protein +FIG00637839 FIG00637848: hypothetical protein +FIG00637854 FIG00637855: hypothetical protein +FIG00637855 hypothetical protein +FIG00637857 Uncharacterized outer membrane usher protein yqiG precursor +FIG00637859 FIG00637861: hypothetical protein +FIG00637861 FIG00637862: hypothetical protein +FIG00637865 FIG00637867: hypothetical protein +FIG00637867 FIG00637868: hypothetical protein +FIG00637868 FIG00637869: hypothetical protein +FIG00637869 FIG00637870: hypothetical protein +FIG00637870 Head decoration protein +FIG00637871 FIG00637873: hypothetical protein +FIG00637873 FIG00637874: hypothetical protein +FIG00637874 FIG00637875: hypothetical protein +FIG00637879 FIG00637880: hypothetical protein +FIG00637880 FIG00637881: hypothetical protein +FIG00637881 FIG00637882: hypothetical protein +FIG00637882 FIG00637883: hypothetical protein +FIG00637883 FIG00637884: hypothetical protein +FIG00637884 FIG00637885: hypothetical protein +FIG00637885 FIG00637886: hypothetical protein +FIG00637886 FIG00637887: hypothetical protein +FIG00637890 Molybdate metabolism regulator +FIG00637893 FIG00637894: hypothetical protein +FIG00637894 FIG00637895: hypothetical protein +FIG00637895 FIG00637897: hypothetical protein +FIG00637897 FIG00637898: hypothetical protein +FIG00637899 FIG00637900: hypothetical protein +FIG00637900 FIG00637902: hypothetical protein +FIG00637902 FIG00640156: hypothetical protein +FIG00637904 FIG00637905: hypothetical protein +FIG00637905 FIG00637906: hypothetical protein +FIG00637906 FIG00637907: hypothetical protein +FIG00637907 FIG00637909: hypothetical protein +FIG00637909 FIG00637910: hypothetical protein +FIG00637910 Putative sulfite oxidase subunit YedY +FIG00637911 FIG00637914: hypothetical protein +FIG00637914 FIG00637915: hypothetical protein +FIG00637915 hypothetical protein +FIG00637918 FIG00637919: hypothetical protein +FIG00637919 FIG00637920: hypothetical protein +FIG00637923 FIG00638841: hypothetical protein +FIG00637928 FIG00637930: hypothetical protein +FIG00637930 FIG00637931: hypothetical protein +FIG00637931 FIG00637932: hypothetical protein +FIG00637932 FIG00637933: hypothetical protein +FIG00637933 FIG00637934: hypothetical protein +FIG00637934 Uncharacterized protein YkfH +FIG00637936 Hypothetical fimbrial chaperone ycbF precursor +FIG00637941 FIG00637942: hypothetical protein +FIG00637944 FIG00637948: hypothetical protein +FIG00637948 FIG00637949: hypothetical protein +FIG00637949 FIG00637950: hypothetical protein +FIG00637950 FIG00637952: hypothetical protein +FIG00637952 FIG00637954: hypothetical protein +FIG00637954 FIG00637955: hypothetical protein +FIG00637955 YcfF/hinT protein: a purine nucleoside phosphoramidase +FIG00637956 FIG00637957: hypothetical protein +FIG00637957 FIG00637958: hypothetical protein +FIG00637958 FIG00637959: hypothetical protein +FIG00637959 unknown protein encoded by prophage CP-933O +FIG00637962 FIG00637963: hypothetical protein +FIG00637963 FIG00639830: hypothetical protein +FIG00637965 FIG00637966: hypothetical protein +FIG00637966 FIG00637967: hypothetical protein +FIG00637967 FIG00637968: hypothetical protein +FIG00637968 Transposase ECs0136 +FIG00637969 FIG00637970: hypothetical protein +FIG00637970 Terminase small subunit +FIG00637971 FIG00637972: hypothetical protein +FIG00637972 FIG00637973: hypothetical protein +FIG00637976 FIG00637977: hypothetical protein +FIG00637977 FIG00637979: hypothetical protein +FIG00637980 FIG00637981: hypothetical protein +FIG00637981 FIG00637982: hypothetical protein +FIG00637982 FIG00637984: hypothetical protein +FIG00637987 FIG00637989: hypothetical protein +FIG00637989 FIG00637990: hypothetical protein +FIG00637990 Inner membrane metabolite transport protein YgcS +FIG00637991 FIG00637992: hypothetical protein +FIG00637994 FIG00637995: hypothetical protein +FIG00637995 FIG00637996: hypothetical protein +FIG00637997 FIG00637998: hypothetical protein +FIG00637998 FIG00637999: hypothetical protein +FIG00637999 FIG00638000: hypothetical protein +FIG00638000 FIG00638001: hypothetical protein +FIG00638006 FIG00638007: hypothetical protein +FIG00638007 FIG00638009: hypothetical protein +FIG00638013 FIG00638014: hypothetical protein +FIG00638014 FIG00638016: hypothetical protein +FIG00638016 FIG00638017: hypothetical protein +FIG00638018 FIG01068360: hypothetical protein +FIG00638019 hypothetical protein ECs1673 +FIG00638026 FIG00638027: hypothetical protein +FIG00638027 unknown function +FIG00638028 FIG00638029: hypothetical protein +FIG00638029 FIG00638030: hypothetical protein +FIG00638030 FIG00638031: hypothetical protein +FIG00638031 FIG00638032: hypothetical protein +FIG00638033 FIG00638034: hypothetical protein +FIG00638034 FIG00638035: hypothetical protein +FIG00638036 FIG00638037: hypothetical protein +FIG00638037 Uncharacterized protein YqeH +FIG00638038 FIG00638040: hypothetical protein +FIG00638044 FIG00638045: hypothetical protein +FIG00638045 FIG00638046: hypothetical protein +FIG00638048 FIG00638049: hypothetical protein +FIG00638049 Phospholipase/carboxylesterase family protein (EC 3.1.-.-) +FIG00638051 FIG00638052: hypothetical protein +FIG00638052 FIG00638053: hypothetical protein +FIG00638053 FIG00638054: hypothetical protein +FIG00638054 FIG00638055: hypothetical protein +FIG00638057 FIG00638060: hypothetical protein +FIG00638060 FIG00638062: hypothetical protein +FIG00638066 FIG00638067: hypothetical protein +FIG00638067 hypothetical protein +FIG00638068 hypothetical protein +FIG00638069 FIG00638070: hypothetical protein +FIG00638070 FIG00638071: hypothetical protein +FIG00638072 FIG00638073: hypothetical protein +FIG00638073 FIG00638074: hypothetical protein +FIG00638074 FIG00638075: hypothetical protein +FIG00638075 FIG00638076: hypothetical protein +FIG00638076 FIG00638077: hypothetical protein +FIG00638077 FIG00638078: hypothetical protein +FIG00638079 FIG00638083: hypothetical protein +FIG00638083 FIG00638086: hypothetical protein +FIG00638086 FIG00638087: hypothetical protein +FIG00638087 FIG00638088: hypothetical protein +FIG00638088 FIG00638089: hypothetical protein +FIG00638089 FIG00638090: hypothetical protein +FIG00638090 FIG00638091: hypothetical protein +FIG00638091 FIG00638092: hypothetical protein +FIG00638092 FIG00638093: hypothetical protein +FIG00638093 FIG00638094: hypothetical protein +FIG00638094 hypothetical protein +FIG00638095 FIG00638096: hypothetical protein +FIG00638097 FIG00638098: hypothetical protein +FIG00638098 FIG00638099: hypothetical protein +FIG00638099 FIG00638100: hypothetical protein +FIG00638100 FIG00638101: hypothetical protein +FIG00638101 FIG00638102: hypothetical protein +FIG00638102 FIG00638104: hypothetical protein +FIG00638105 FIG00638106: hypothetical protein +FIG00638106 FIG00638107: hypothetical protein +FIG00638107 FIG00638108: hypothetical protein +FIG00638109 FIG00638110: hypothetical protein +FIG00638110 FIG00638113: hypothetical protein +FIG00638113 FIG00638116: hypothetical protein +FIG00638116 FIG00638117: hypothetical protein +FIG00638117 FIG00638118: hypothetical protein +FIG00638118 FIG00638119: hypothetical protein +FIG00638119 Putative transporter +FIG00638120 FIG00638121: hypothetical protein +FIG00638121 FIG00638123: hypothetical protein +FIG00638126 FIG00642701: hypothetical protein +FIG00638127 FIG00638128: hypothetical protein +FIG00638128 FIG00638130: hypothetical protein +FIG00638130 FIG00638132: hypothetical protein +FIG00638134 FIG00638135: hypothetical protein +FIG00638135 FIG00638136: hypothetical protein +FIG00638136 FIG00638137: hypothetical protein +FIG00638137 FIG00638138: hypothetical protein +FIG00638139 FIG00638140: hypothetical protein +FIG00638140 FIG00638142: hypothetical protein +FIG00638142 FIG00638143: hypothetical protein +FIG00638143 FIG00638146: hypothetical protein +FIG00638146 FIG00638148: hypothetical protein +FIG00638148 FIG00638149: hypothetical protein +FIG00638150 FIG00638152: hypothetical protein +FIG00638161 Aliphatic amidase AmiE (EC 3.5.1.4) +FIG00638162 FIG00638163: hypothetical protein +FIG00638163 FIG00638164: hypothetical protein +FIG00638164 FIG00638165: hypothetical protein +FIG00638165 FIG00638166: hypothetical protein +FIG00638166 FIG00638167: hypothetical protein +FIG00638167 FIG00638168: hypothetical protein +FIG00638168 FIG00638169: hypothetical protein +FIG00638169 FIG00638170: hypothetical protein +FIG00638170 FIG00638171: hypothetical protein +FIG00638171 FIG00638175: hypothetical protein +FIG00638175 Division inhibition protein dicB +FIG00638182 FIG00638183: hypothetical protein +FIG00638186 FIG00639870: hypothetical protein +FIG00638187 FIG00638188: hypothetical protein +FIG00638188 probable lipoprotein +FIG00638190 FIG00638193: hypothetical protein +FIG00638193 FIG00638196: hypothetical protein +FIG00638196 FIG00638198: hypothetical protein +FIG00638198 FIG00638199: hypothetical protein +FIG00638200 FIG00638201: hypothetical protein +FIG00638201 FIG00638204: hypothetical protein +FIG00638204 FIG00638205: hypothetical protein +FIG00638205 FIG00638206: hypothetical protein +FIG00638206 FIG00638207: hypothetical protein +FIG00638207 FIG00638209: hypothetical protein +FIG00638214 FIG00638215: hypothetical protein +FIG00638215 FIG00638216: hypothetical protein +FIG00638217 FIG00638218: hypothetical protein +FIG00638218 FIG00638220: hypothetical protein +FIG00638220 FIG00638221: hypothetical protein +FIG00638223 FIG00638224: hypothetical protein +FIG00638224 FIG00638227: hypothetical protein +FIG00638227 FIG00638228: hypothetical protein +FIG00638228 FIG00638229: hypothetical protein +FIG00638229 Replication regulatory protein repA2 (Protein copB) +FIG00638230 FIG00638231: hypothetical protein +FIG00638231 corresponds to STY4175 from Accession AL513382: Salmonella typhi CT18 +FIG00638232 Anthranilate phosphoribosyltransferase like (EC 2.4.2.18) +FIG00638234 FIG00638235: hypothetical protein +FIG00638235 FIG007491: hypothetical protein YeeN +FIG00638236 orf, conserved hypothetical protein +FIG00638237 FIG00638239: hypothetical protein +FIG00638239 FIG00638240: hypothetical protein +FIG00638241 FIG00638244: hypothetical protein +FIG00638244 FIG00638245: hypothetical protein +FIG00638245 FIG00638246: hypothetical protein +FIG00638247 Resolvase +FIG00638252 FIG00638254: hypothetical protein +FIG00638254 FIG00638255: hypothetical protein +FIG00638258 FIG00638259: hypothetical protein +FIG00638260 FIG00638261: hypothetical protein +FIG00638261 FIG00638263: hypothetical protein +FIG00638263 hypothetical protein +FIG00638264 FIG00638265: hypothetical protein +FIG00638266 FIG00638267: hypothetical protein +FIG00638267 FIG00638269: hypothetical protein +FIG00638269 Probable electron transfer flavoprotein-quinone oxidoreductase YgcN (EC 1.5.5.-) +FIG00638270 FIG00638271: hypothetical protein +FIG00638271 COG4197: Uncharacterized protein conserved in bacteria, prophage-related +FIG00638275 FIG00638276: hypothetical protein +FIG00638276 FIG00638277: hypothetical protein +FIG00638280 FIG01047590: hypothetical protein +FIG00638283 Phage major tail tube protein +FIG00638284 hypothetical protein +FIG00638287 FIG00638289: hypothetical protein +FIG00638290 FIG00638291: hypothetical protein +FIG00638292 FIG00765533: hypothetical protein +FIG00638294 FIG00638295: hypothetical protein +FIG00638295 FIG00639187: hypothetical protein +FIG00638297 FIG00638298: membrane protein YfbV +FIG00638298 FIG00638301: hypothetical protein +FIG00638301 FIG00638302: hypothetical protein +FIG00638305 Phage head-to-tail joining protein +FIG00638307 FIG00638308: hypothetical protein +FIG00638308 FIG00638309: hypothetical protein +FIG00638309 FIG00638310: hypothetical protein +FIG00638310 FIG00638311: hypothetical protein +FIG00638311 FIG00638312: hypothetical protein +FIG00638312 FIG00638313: hypothetical protein +FIG00638313 FIG00638314: hypothetical protein +FIG00638314 FIG00638315: hypothetical protein +FIG00638315 FIG01047205: hypothetical protein +FIG00638317 FIG00638318: hypothetical protein +FIG00638318 alcohol dehydrogenase, zinc-binding domain protein +FIG00638319 FIG00638320: hypothetical protein +FIG00638321 FIG00638322: hypothetical protein +FIG00638325 FIG00638326: hypothetical protein +FIG00638329 FIG00638331: hypothetical protein +FIG00638335 FIG00638339: hypothetical protein +FIG00638339 FIG00638340: hypothetical protein +FIG00638340 FIG00638342: hypothetical protein +FIG00638342 FIG00638343: hypothetical protein +FIG00638343 COG1280: Putative threonine efflux protein +FIG00638349 Glycerol-3-phosphate regulon repressor +FIG00638350 FIG00638351: hypothetical protein +FIG00638351 FIG00638352: hypothetical protein +FIG00638352 CP4-6 prophage; predicted phage integrase +FIG00638354 FIG00638355: hypothetical protein +FIG00638355 FIG00638357: hypothetical protein +FIG00638357 FIG00638358: hypothetical protein +FIG00638358 FIG00638359: hypothetical protein +FIG00638359 FIG00638360: hypothetical protein +FIG00638362 FIG00638363: hypothetical protein +FIG00638363 FIG00638364: hypothetical protein +FIG00638364 FIG00638365: hypothetical protein +FIG00638365 FIG004064: hypothetical protein +FIG00638367 FIG00638368: hypothetical protein +FIG00638368 FIG00638370: hypothetical protein +FIG00638370 FIG00638371: hypothetical protein +FIG00638375 FIG00638376: hypothetical protein +FIG00638376 FIG00638377: hypothetical protein +FIG00638377 FIG00638378: hypothetical protein +FIG00638378 FIG00638379: hypothetical protein +FIG00638379 FIG00638380: hypothetical protein +FIG00638381 FIG00639948: hypothetical protein +FIG00638382 FIG00638384: hypothetical protein +FIG00638387 FIG00638388: hypothetical protein +FIG00638391 FIG00638392: hypothetical protein +FIG00638393 FIG00638394: hypothetical protein +FIG00638394 FIG00638395: hypothetical protein +FIG00638395 FIG00638396: hypothetical protein +FIG00638397 FIG00638398: hypothetical protein +FIG00638398 FIG00638399: hypothetical protein +FIG00638399 FIG00638401: hypothetical protein +FIG00638401 FIG00638402: hypothetical protein +FIG00638402 FIG00638403: hypothetical protein +FIG00638407 FIG00638409: hypothetical protein +FIG00638409 Phage or Prophage Related +FIG00638410 FIG00638411: hypothetical protein +FIG00638411 hypothetical protein +FIG00638415 YeeU protein (antitoxin to YeeV) +FIG00638416 FIG00638417: hypothetical protein +FIG00638418 FIG00638421: hypothetical protein +FIG00638421 FIG00638422: hypothetical protein +FIG00638422 FIG00638423: hypothetical protein +FIG00638423 FIG00638424: hypothetical protein +FIG00638424 FIG00638425: hypothetical protein +FIG00638425 FIG00638426: hypothetical protein +FIG00638428 FIG00638429: hypothetical protein +FIG00638429 FIG00638431: hypothetical protein +FIG00638431 FIG00638432: hypothetical protein +FIG00638435 FIG00638436: hypothetical protein +FIG00638436 FIG00638438: hypothetical protein +FIG00638438 FIG00638442: hypothetical protein +FIG00638442 FIG00638444: hypothetical protein +FIG00638446 FIG00638448: hypothetical protein +FIG00638448 FIG00638450: hypothetical protein +FIG00638450 FIG00638451: hypothetical protein +FIG00638451 FIG004088: inner membrane protein YebE +FIG00638456 FIG00638457: hypothetical protein +FIG00638457 FIG00638459: hypothetical protein +FIG00638459 FIG00638461: hypothetical protein +FIG00638461 FIG00774734: hypothetical protein +FIG00638463 FIG00638465: hypothetical protein +FIG00638465 FIG00638466: hypothetical protein +FIG00638466 FIG00638467: hypothetical protein +FIG00638469 FIG00638470: hypothetical protein +FIG00638470 FIG00638471: hypothetical protein +FIG00638471 FIG00638472: hypothetical protein +FIG00638473 FIG00638474: hypothetical protein +FIG00638474 FIG00638475: hypothetical protein +FIG00638475 FIG00638476: hypothetical protein +FIG00638477 FIG00638478: hypothetical protein +FIG00638478 Uncharacterized protein YgcG +FIG00638479 FIG00638480: hypothetical protein +FIG00638480 FIG01046459: hypothetical protein +FIG00638481 FIG00638487: hypothetical protein +FIG00638487 FIG00638489: hypothetical protein +FIG00638490 FIG00638492: hypothetical protein +FIG00638492 FIG00638493: hypothetical protein +FIG00638493 FIG00638494: hypothetical protein +FIG00638494 FIG00638495: hypothetical protein +FIG00638495 FIG00638496: hypothetical protein +FIG00638497 FIG00638498: hypothetical protein +FIG00638498 FIG00638499: hypothetical protein +FIG00638499 Branched-chain amino acid transport, AzlD +FIG00638500 FIG00638501: hypothetical protein +FIG00638501 hypothetical protein +FIG00638503 FIG00638504: hypothetical protein +FIG00638504 FIG00638505: hypothetical protein +FIG00638505 FIG00638507: hypothetical protein +FIG00638507 FIG00638508: hypothetical protein +FIG00638508 FIG00638509: hypothetical protein +FIG00638509 FIG00638510: hypothetical protein +FIG00638510 Uncharacterized sugar kinase YgcE (EC 2.7.1.-) +FIG00638511 FIG00638513: hypothetical protein +FIG00638513 FIG00638514: hypothetical protein +FIG00638514 FIG00638515: hypothetical protein +FIG00638515 UPF0441 protein ygiB +FIG00638516 FIG00638517: hypothetical protein +FIG00638517 FIG00638518: hypothetical protein +FIG00638518 FIG00638519: hypothetical protein +FIG00638519 FIG00638520: hypothetical protein +FIG00638520 FIG00638522: hypothetical protein +FIG00638522 FIG00638523: hypothetical protein +FIG00638523 FIG00638524: hypothetical protein +FIG00638524 FIG00638525: hypothetical protein +FIG00638525 FIG00638526: hypothetical protein +FIG00638526 FIG00638528: hypothetical protein +FIG00638529 Membrane-bound metal-dependent hydrolase YdjM, induced during SOS response +FIG00638530 FIG00638531: hypothetical protein +FIG00638533 FIG00638536: hypothetical protein +FIG00638536 FIG00638537: hypothetical protein +FIG00638541 FIG00638542: hypothetical protein +FIG00638544 FIG01199806: hypothetical protein +FIG00638545 Predicted FAD containing dehydrogenase +FIG00638547 FIG00638548: hypothetical protein +FIG00638549 putative phage replication protein +FIG00638551 hypothetical protein +FIG00638552 Uncharacterized protein YjiC +FIG00638556 FIG00638557: hypothetical protein +FIG00638557 FIG00638558: hypothetical protein +FIG00638558 FIG00638559: hypothetical protein +FIG00638559 FIG00638561: hypothetical protein +FIG00638562 FIG00638563: hypothetical protein +FIG00638563 FIG00638564: hypothetical protein +FIG00638564 FIG00638566: hypothetical protein +FIG00638566 FIG00638567: hypothetical protein +FIG00638567 FIG00638568: hypothetical protein +FIG00638569 FIG00638574: hypothetical protein +FIG00638574 FIG00638575: hypothetical protein +FIG00638575 FIG00638576: hypothetical protein +FIG00638576 FIG00638577: hypothetical protein +FIG00638581 FIG00638587: hypothetical protein +FIG00638587 FIG00638589: hypothetical protein +FIG00638589 hypothetical protein +FIG00638591 Intergenic-region protein +FIG00638594 FIG00638595: hypothetical protein +FIG00638595 FIG00638596: hypothetical protein +FIG00638596 FIG00638598: hypothetical protein +FIG00638598 FIG00638599: hypothetical protein +FIG00638599 FIG00638601: hypothetical protein +FIG00638601 FIG00638602: hypothetical protein +FIG00638602 FIG00638603: hypothetical protein +FIG00638604 fragment +FIG00638606 FIG00638607: hypothetical protein +FIG00638608 FIG00638610: hypothetical protein +FIG00638614 FIG00638615: hypothetical protein +FIG00638615 FIG00638616: hypothetical protein +FIG00638617 FIG00638618: hypothetical protein +FIG00638620 DNA stabilization, phage-associated +FIG00638622 Putative electron transfer flavoprotein subunit YgcQ +FIG00638625 FIG00638627: hypothetical protein +FIG00638627 FIG00638628: hypothetical protein +FIG00638628 FIG00638630: hypothetical protein +FIG00638630 FIG00638631: hypothetical protein +FIG00638631 FIG00638633: hypothetical protein +FIG00638633 FIG00638634: hypothetical protein +FIG00638634 FIG00638635: hypothetical protein +FIG00638639 FIG00638640: hypothetical protein +FIG00638641 FIG00638642: hypothetical protein +FIG00638642 Tail protein +FIG00638643 FIG00638644: hypothetical protein +FIG00638645 FIG00638648: hypothetical protein +FIG00638650 FIG00638651: hypothetical protein +FIG00638652 FIG00638653: hypothetical protein +FIG00638653 FIG00638658: hypothetical protein +FIG00638658 FIG00638659: hypothetical protein +FIG00638663 FIG00638665: hypothetical protein +FIG00638665 FIG00638666: hypothetical protein +FIG00638666 FIG00638667: hypothetical protein +FIG00638667 FIG00638668: hypothetical protein +FIG00638668 FIG00638669: hypothetical protein +FIG00638672 FIG00638673: hypothetical protein +FIG00638673 FIG00638674: hypothetical protein +FIG00638675 FIG00638676: hypothetical protein +FIG00638676 Zinc transport protein ZntB +FIG00638677 FIG00638679: hypothetical protein +FIG00638679 FIG00638682: hypothetical protein +FIG00638682 FIG00638683: hypothetical protein +FIG00638683 FIG00638684: hypothetical protein +FIG00638685 FIG00638687: hypothetical protein +FIG00638687 FIG00638688: hypothetical protein +FIG00638689 FIG00638691: hypothetical protein +FIG00638692 FIG00638693: hypothetical protein +FIG00638694 FIG00638695: hypothetical protein +FIG00638696 FIG00638697: hypothetical protein +FIG00638698 FIG00638699: hypothetical protein +FIG00638699 Endopeptidase (EC 3.4.-.-) +FIG00638702 FIG00638703: hypothetical protein +FIG00638703 FIG00638705: hypothetical protein +FIG00638705 FIG00638707: hypothetical protein +FIG00638707 FIG00638710: hypothetical protein +FIG00638710 FIG00638711: hypothetical protein +FIG00638711 FIG00638714: hypothetical protein +FIG00638714 FIG00638716: hypothetical protein +FIG00638716 FIG00638717: hypothetical protein +FIG00638717 FIG00638718: hypothetical protein +FIG00638720 FIG00638721: hypothetical protein +FIG00638722 FIG00638723: hypothetical protein +FIG00638724 hypothetical protein +FIG00638726 Transcriptional regulator, AraC/XylS family +FIG00638727 FIG00638728: hypothetical protein +FIG00638728 FIG00638729: hypothetical protein +FIG00638729 FIG00638730: hypothetical protein +FIG00638730 FIG00638731: hypothetical protein +FIG00638731 Transglycosylase, Slt family +FIG00638733 FIG00638734: hypothetical protein +FIG00638734 FIG00638736: hypothetical protein +FIG00638736 FIG00638737: hypothetical protein +FIG00638737 FIG00638738: hypothetical protein +FIG00638738 AidA-I adhesin-like protein +FIG00638741 FIG00638742: hypothetical protein +FIG00638742 FIG00638743: hypothetical protein +FIG00638743 FIG00638744: hypothetical protein +FIG00638744 FIG00638745: hypothetical protein +FIG00638745 FIG01200175: hypothetical protein +FIG00638748 hypothetical protein +FIG00638750 FIG00638752: hypothetical protein +FIG00638752 FIG00638753: hypothetical protein +FIG00638753 FIG00638754: hypothetical protein +FIG00638755 FIG00638756: hypothetical protein +FIG00638756 hypothetical protein +FIG00638757 FIG001196: Membrane protein YedZ +FIG00638762 FIG00638763: hypothetical protein +FIG00638763 FIG00638764: hypothetical protein +FIG00638765 FIG00638766: hypothetical protein +FIG00638766 FIG00638768: hypothetical protein +FIG00638769 FIG00638770: hypothetical protein +FIG00638772 FIG00638773: hypothetical protein +FIG00638773 FIG00638774: hypothetical protein +FIG00638774 FIG00638775: hypothetical protein +FIG00638775 FIG00638776: hypothetical protein +FIG00638777 FIG00638782: hypothetical protein +FIG00638782 Lipoprotein +FIG00638783 Bundle-forming pilus protein BfpC +FIG00638787 FIG00638791: hypothetical protein +FIG00638791 FIG00638793: hypothetical protein +FIG00638793 FIG00638794: hypothetical protein +FIG00638795 FIG00638797: hypothetical protein +FIG00638797 FIG00638799: hypothetical protein +FIG00638799 FIG00638800: hypothetical protein +FIG00638800 FIG00638802: hypothetical protein +FIG00638802 FIG00638803: hypothetical protein +FIG00638803 FIG00638804: hypothetical protein +FIG00638807 FIG00638808: hypothetical protein +FIG00638810 FIG00638811: hypothetical protein +FIG00638811 3-hydroxypropionate dehydrogenase (EC 1.1.1.298) +FIG00638812 FIG00638813: hypothetical protein +FIG00638813 CPZ-55 prophage; predicted protein +FIG00638815 FIG00638816: hypothetical protein +FIG00638817 FIG00638818: hypothetical protein +FIG00638818 FIG00638819: hypothetical protein +FIG00638821 FIG00638822: hypothetical protein +FIG00638824 FIG00638825: hypothetical protein +FIG00638825 FIG00638826: hypothetical protein +FIG00638826 FIG00638827: hypothetical protein +FIG00638831 FIG00638834: hypothetical protein +FIG00638834 FIG00638837: hypothetical protein +FIG00638839 FIG00638840: hypothetical protein +FIG00638841 FIG00638844: hypothetical protein +FIG00638845 FIG00638848: hypothetical protein +FIG00638850 FIG00638851: hypothetical protein +FIG00638851 FIG00638853: hypothetical protein +FIG00638853 FIG00638854: hypothetical protein +FIG00638854 FIG00638855: hypothetical protein +FIG00638855 FIG00638856: hypothetical protein +FIG00638856 FIG00638857: hypothetical protein +FIG00638857 FIG00638858: hypothetical protein +FIG00638858 Aspartate N-acetyltransferase (EC 2.3.1.17) +FIG00638859 FIG00639155: hypothetical protein +FIG00638860 FIG00638862: hypothetical protein +FIG00638862 FIG00638863: hypothetical protein +FIG00638863 FIG00638865: hypothetical protein +FIG00638866 FIG00638868: hypothetical protein +FIG00638868 FIG00638869: hypothetical protein +FIG00638869 FIG00638870: hypothetical protein +FIG00638877 FIG00638879: hypothetical protein +FIG00638881 FIG00638882: hypothetical protein +FIG00638882 Putative fimbrial protein +FIG00638883 orf, hypothetical protein +FIG00638885 FIG00638886: hypothetical protein +FIG00638886 FIG00638888: hypothetical protein +FIG00638888 FIG00638890: hypothetical protein +FIG00638892 FIG00638893: hypothetical protein +FIG00638893 FIG00638894: hypothetical protein +FIG00638894 FIG00638895: hypothetical protein +FIG00638895 FIG00638896: hypothetical protein +FIG00638896 FIG00638899: hypothetical protein +FIG00638899 FIG00638900: hypothetical protein +FIG00638900 FIG00638901: hypothetical protein +FIG00638902 COG5283: Phage-related tail protein +FIG00638905 FIG00638906: hypothetical protein +FIG00638906 FIG00638908: hypothetical protein +FIG00638908 FIG00638909: hypothetical protein +FIG00638909 FIG00638911: hypothetical protein +FIG00638912 FIG00639802: hypothetical protein +FIG00638916 FIG00638918: hypothetical protein +FIG00638920 Putative DNA-binding protein Roi of bacteriophage BP-933W +FIG00638921 FIG00638922: hypothetical protein +FIG00638922 FIG00638923: hypothetical protein +FIG00638926 FIG00638927: hypothetical protein +FIG00638927 FIG00638928: hypothetical protein +FIG00638928 FIG00638930: hypothetical protein +FIG00638930 FIG00638931: hypothetical protein +FIG00638933 FIG00638936: hypothetical protein +FIG00638938 FIG00638939: hypothetical protein +FIG00638939 FIG00638940: hypothetical protein +FIG00638940 FIG00638941: hypothetical protein +FIG00638945 FIG00638946: hypothetical protein +FIG00638951 FIG00638952: hypothetical protein +FIG00638952 FIG00638953: hypothetical protein +FIG00638953 FIG00638954: hypothetical protein +FIG00638954 FIG00638956: hypothetical protein +FIG00638956 FIG00638957: hypothetical protein +FIG00638958 FIG00638959: hypothetical protein +FIG00638959 FIG00638960: hypothetical protein +FIG00638960 FIG00638961: hypothetical protein +FIG00638961 FIG00638962: hypothetical protein +FIG00638964 Baseplate assembly protein J +FIG00638965 FIG00638966: hypothetical protein +FIG00638967 FIG00638968: hypothetical protein +FIG00638968 FIG00638969: hypothetical protein +FIG00638969 hypothetical protein +FIG00638975 FIG00638980: hypothetical protein +FIG00638982 FIG00638983: hypothetical protein +FIG00638983 FIG00638984: hypothetical protein +FIG00638984 FIG00638986: hypothetical protein +FIG00638986 FIG00638988: hypothetical protein +FIG00638988 FIG00638989: hypothetical protein +FIG00638989 FIG00638990: hypothetical protein +FIG00638990 FIG00638992: hypothetical protein +FIG00638992 FIG00638993: hypothetical protein +FIG00638993 FIG002082: Protein sirB2 +FIG00638996 FIG00638997: hypothetical protein +FIG00638997 putative prophage integrase +FIG00638998 FIG00638999: hypothetical protein +FIG00639000 FIG00639001: hypothetical protein +FIG00639002 Holin +FIG00639003 Inner membrane protein YqcE +FIG00639004 FIG00639005: hypothetical protein +FIG00639007 unknown protein encoded by prophage CP-933T +FIG00639009 FIG00639010: hypothetical protein +FIG00639010 Putative terminase small subunit +FIG00639014 FIG00639015: hypothetical protein +FIG00639015 FIG00639016: hypothetical protein +FIG00639019 FIG00639021: hypothetical protein +FIG00639021 FIG00639023: hypothetical protein +FIG00639026 FIG00639027: hypothetical protein +FIG00639028 FIG00639029: hypothetical protein +FIG00639029 FIG00639030: hypothetical protein +FIG00639030 FIG00639031: hypothetical protein +FIG00639031 FIG00639033: hypothetical protein +FIG00639033 hypothetical protein +FIG00639036 FIG00639039: hypothetical protein +FIG00639040 FIG00641599: hypothetical protein +FIG00639044 FIG00639045: hypothetical protein +FIG00639045 FIG00639050: hypothetical protein +FIG00639050 FIG00639051: hypothetical protein +FIG00639060 FIG00639061: hypothetical protein +FIG00639061 FIG00639062: hypothetical protein +FIG00639062 FIG00639065: hypothetical protein +FIG00639065 FIG00639066: hypothetical protein +FIG00639067 Hypothetical protein yfdR +FIG00639068 FIG00639069: hypothetical protein +FIG00639071 FIG00639074: hypothetical protein +FIG00639074 FIG00639076: hypothetical protein +FIG00639079 FIG00639082: hypothetical protein +FIG00639082 FIG00639083: hypothetical protein +FIG00639083 FIG00639085: hypothetical protein +FIG00639086 Hypothetical rem protein +FIG00639089 FIG00639090: hypothetical protein +FIG00639091 FIG00639094: hypothetical protein +FIG00639094 FIG00639097: hypothetical protein +FIG00639101 FIG00639102: hypothetical protein +FIG00639102 FIG00639103: hypothetical protein +FIG00639107 FIG00639109: hypothetical protein +FIG00639109 FIG00639110: hypothetical protein +FIG00639110 hypothetical protein +FIG00639111 FIG00639112: hypothetical protein +FIG00639113 FIG00639114: hypothetical protein +FIG00639119 FIG00639120: hypothetical protein +FIG00639120 FIG00639127: hypothetical protein +FIG00639127 FIG00639128: hypothetical protein +FIG00639128 unknown protein encoded by prophage CP-933K +FIG00639130 FIG00639131: hypothetical protein +FIG00639131 ABC-type sugar transport system, ATP-binding protein (EC 3.6.3.17) +FIG00639134 FIG00639135: hypothetical protein +FIG00639138 FIG01069320: hypothetical protein +FIG00639140 FIG00639141: hypothetical protein +FIG00639141 FIG00639142: hypothetical protein +FIG00639143 FIG00639144: hypothetical protein +FIG00639144 FIG00639146: hypothetical protein +FIG00639146 FIG00639150: hypothetical protein +FIG00639150 FIG00639151: hypothetical protein +FIG00639151 FIG00639152: hypothetical protein +FIG00639152 FIG00639153: hypothetical protein +FIG00639153 FIG00639154: hypothetical protein +FIG00639155 hypothetical protein +FIG00639160 FIG00639161: hypothetical protein +FIG00639161 FIG00639166: hypothetical protein +FIG00639166 hypothetical protein +FIG00639167 FIG00639168: hypothetical protein +FIG00639171 FIG00639173: hypothetical protein +FIG00639176 Protein lysB +FIG00639177 FIG00639178: hypothetical protein +FIG00639185 FIG00639186: hypothetical protein +FIG00639187 Oxidoreductase FAD/NAD(P)-binding:Oxidoreductase FAD-binding region precursor +FIG00639190 FIG00639191: hypothetical protein +FIG00639192 FIG00639193: hypothetical protein +FIG00639194 FIG00639195: hypothetical protein +FIG00639197 FIG00639198: hypothetical protein +FIG00639198 FIG00639200: hypothetical protein +FIG00639200 FIG00639201: hypothetical protein +FIG00639202 FIG00639204: hypothetical protein +FIG00639209 FIG00639210: hypothetical protein +FIG00639210 FIG00639211: hypothetical protein +FIG00639214 FIG00639215: hypothetical protein +FIG00639216 FIG00639217: hypothetical protein +FIG00639217 FIG00639218: hypothetical protein +FIG00639218 FIG00639220: hypothetical protein +FIG00639223 FIG00639224: hypothetical protein +FIG00639224 FIG00639226: hypothetical protein +FIG00639226 FIG00639228: hypothetical protein +FIG00639228 FIG00639229: hypothetical protein +FIG00639231 FIG00639232: hypothetical protein +FIG00639232 hypothetical protein +FIG00639235 FIG00639237: hypothetical protein +FIG00639237 FIG00639238: hypothetical protein +FIG00639238 FIG00639240: hypothetical protein +FIG00639240 FIG00639241: hypothetical protein +FIG00639241 FIG00639242: hypothetical protein +FIG00639246 FIG00639247: hypothetical protein +FIG00639248 FIG00639249: hypothetical protein +FIG00639249 RelF inactive antibacterial toxin protein +FIG00639250 FIG00639251: hypothetical protein +FIG00639251 FIG00639255: hypothetical protein +FIG00639258 FIG00639260: hypothetical protein +FIG00639260 FIG00639261: hypothetical protein +FIG00639261 FIG00639262: hypothetical protein +FIG00639262 FIG00639264: hypothetical protein +FIG00639268 FIG00639271: hypothetical protein +FIG00639273 Electron transfer flavoprotein, beta subunit +FIG00639274 ABC transporter, solute-binding protein +FIG00639278 FIG00639279: hypothetical protein +FIG00639279 FIG00639284: hypothetical protein +FIG00639284 Exodeoxyribonuclease encoded by cryptic prophage CP-933P +FIG00639285 FIG00639287: hypothetical protein +FIG00639288 FIG00639291: hypothetical protein +FIG00639291 FIG00639292: hypothetical protein +FIG00639294 FIG00639295: hypothetical protein +FIG00639298 FIG00639301: hypothetical protein +FIG00639303 FIG00639304: hypothetical protein +FIG00639304 FIG00639305: hypothetical protein +FIG00639305 FIG00639306: hypothetical protein +FIG00639306 FIG00639307: hypothetical protein +FIG00639307 FIG00639310: hypothetical protein +FIG00639310 FIG00639311: hypothetical protein +FIG00639311 FIG00639312: hypothetical protein +FIG00639312 FIG00639313: hypothetical protein +FIG00639313 FIG00639314: hypothetical protein +FIG00639317 hypothetical protein +FIG00639318 FIG00639319: hypothetical protein +FIG00639319 FIG00639321: hypothetical protein +FIG00639321 FIG00639322: hypothetical protein +FIG00639322 FIG00639323: hypothetical protein +FIG00639323 FIG00639324: hypothetical protein +FIG00639325 Putative Q antiterminator encoded by prophage CP-933P +FIG00639327 FIG00639329: hypothetical protein +FIG00639329 FIG01069112: hypothetical protein +FIG00639331 FIG00639332: hypothetical protein +FIG00639332 putative phosphotransferase system protein( EC:2.7.1.69 ) +FIG00639333 FIG00639334: hypothetical protein +FIG00639334 FIG00639336: hypothetical protein +FIG00639337 Putative regulator of cell division encoded by prophage CP-933O +FIG00639339 FIG00639341: hypothetical protein +FIG00639341 Phage NinI serine/threonine phosphatase +FIG00639342 FIG00639346: hypothetical protein +FIG00639349 FIG00639350: hypothetical protein +FIG00639350 FIG00639352: hypothetical protein +FIG00639352 FIG00639353: hypothetical protein +FIG00639354 FIG00639355: hypothetical protein +FIG00639357 FIG00639358: hypothetical protein +FIG00639360 FIG00639362: hypothetical protein +FIG00639362 FIG00639363: hypothetical protein +FIG00639363 FIG00639367: hypothetical protein +FIG00639367 FIG00639368: hypothetical protein +FIG00639369 FIG00639370: hypothetical protein +FIG00639370 hypothetical protein +FIG00639372 FIG00639373: hypothetical protein +FIG00639373 FIG00639374: hypothetical protein +FIG00639375 FIG00639376: hypothetical protein +FIG00639377 FIG00639379: hypothetical protein +FIG00639379 FIG00639381: hypothetical protein +FIG00639381 FIG00639382: hypothetical protein +FIG00639382 FIG00639383: hypothetical protein +FIG00639383 FIG00639389: hypothetical protein +FIG00639389 FIG00639390: hypothetical protein +FIG00639391 FIG00639392: hypothetical protein +FIG00639395 FIG00639396: hypothetical protein +FIG00639397 FIG00639398: hypothetical protein +FIG00639402 FIG00639403: hypothetical protein +FIG00639404 FIG00639406: hypothetical protein +FIG00639406 membrane; Transport of small molecules: Cations +FIG00639407 Orf5 protein +FIG00639413 FIG00639415: hypothetical protein +FIG00639415 FIG00639416: hypothetical protein +FIG00639421 FIG00639422: hypothetical protein +FIG00639422 FIG00639423: hypothetical protein +FIG00639428 FIG00639430: hypothetical protein +FIG00639440 FIG00639441: hypothetical protein +FIG00639441 FIG00639442: hypothetical protein +FIG00639442 FIG00639443: hypothetical protein +FIG00639444 FIG00639446: hypothetical protein +FIG00639446 FIG00639447: hypothetical protein +FIG00639447 FIG00639451: hypothetical protein +FIG00639451 FIG00639453: hypothetical protein +FIG00639453 FIG00639454: hypothetical protein +FIG00639454 FIG00639455: hypothetical protein +FIG00639455 FIG00639456: hypothetical protein +FIG00639456 FIG00639457: hypothetical protein +FIG00639457 FIG00639460: hypothetical protein +FIG00639460 FIG00639461: hypothetical protein +FIG00639461 FIG00639467: hypothetical protein +FIG00639469 stable plasmid inheritance protein +FIG00639470 FIG00639471: hypothetical protein +FIG00639471 TraI +FIG00639476 FIG00640900: hypothetical protein +FIG00639480 FIG00639481: hypothetical protein +FIG00639481 FIG00639484: hypothetical protein +FIG00639484 COG0086: DNA-directed RNA polymerase, beta' subunit/160 kD subunit +FIG00639486 FIG00639487: hypothetical protein +FIG00639490 FIG00639491: hypothetical protein +FIG00639491 FIG00639493: hypothetical protein +FIG00639498 hypothetical protein +FIG00639500 FIG00639501: hypothetical protein +FIG00639501 Aldo-keto reductase +FIG00639504 Z5092 protein +FIG00639505 FIG00639506: hypothetical protein +FIG00639511 FIG00639518: hypothetical protein +FIG00639518 FIG00639520: hypothetical protein +FIG00639521 FIG00639524: hypothetical protein +FIG00639524 FIG00639525: hypothetical protein +FIG00639525 hypothetical protein +FIG00639526 FIG00639527: hypothetical protein +FIG00639531 FIG00642040: hypothetical protein +FIG00639534 Putative antirestriction protein +FIG00639536 FIG01220105: hypothetical protein +FIG00639537 FIG00639538: hypothetical protein +FIG00639542 FIG00639543: hypothetical protein +FIG00639544 FIG00639545: hypothetical protein +FIG00639545 FIG00639546: hypothetical protein +FIG00639547 FIG00639548: hypothetical protein +FIG00639549 FIG00639550: hypothetical protein +FIG00639552 FIG00639553: hypothetical protein +FIG00639553 FIG00639556: hypothetical protein +FIG00639558 FIG00639559: hypothetical protein +FIG00639559 FIG00639560: hypothetical protein +FIG00639560 Putative tRNA ligase +FIG00639562 FIG00639563: hypothetical protein +FIG00639563 FIG00639566: hypothetical protein +FIG00639566 FIG00639570: hypothetical protein +FIG00639570 YdaB +FIG00639573 FIG00639575: hypothetical protein +FIG00639579 FIG00639580: hypothetical protein +FIG00639580 FIG00641476: hypothetical protein +FIG00639581 FIG00639582: hypothetical protein +FIG00639584 FIG00639586: hypothetical protein +FIG00639586 FIG00639587: hypothetical protein +FIG00639592 Orf80 +FIG00639597 FIG00639598: hypothetical protein +FIG00639604 FIG00639605: hypothetical protein +FIG00639605 ORF8 +FIG00639607 FIG01071003: hypothetical protein +FIG00639610 FIG00921676: hypothetical protein +FIG00639611 FIG00639616: hypothetical protein +FIG00639616 FIG00639617: hypothetical protein +FIG00639619 FIG00639620: hypothetical protein +FIG00639620 FIG00639626: hypothetical protein +FIG00639626 FIG00639629: hypothetical protein +FIG00639629 FIG00639632: hypothetical protein +FIG00639635 FIG00639638: hypothetical protein +FIG00639642 Dca +FIG00639643 FIG00639645: hypothetical protein +FIG00639650 FIG00639651: hypothetical protein +FIG00639651 FIG00639653: hypothetical protein +FIG00639653 FIG00639655: hypothetical protein +FIG00639658 FIG00639659: hypothetical protein +FIG00639663 FIG00639664: hypothetical protein +FIG00639664 FIG00639665: hypothetical protein +FIG00639668 FIG00639669: hypothetical protein +FIG00639669 FIG00639671: hypothetical protein +FIG00639671 putative antirepressor protein +FIG00639678 FIG00639679: hypothetical protein +FIG00639685 FIG00639686: hypothetical protein +FIG00639693 FIG00639694: hypothetical protein +FIG00639696 FIG00639699: hypothetical protein +FIG00639700 FIG00640097: hypothetical protein +FIG00639711 Mu-like prophage FluMu protein gp36 +FIG00639718 FIG00639719: hypothetical protein +FIG00639720 FIG00639721: hypothetical protein +FIG00639721 FIG00639722: hypothetical protein +FIG00639725 FIG00639726: hypothetical protein +FIG00639726 FIG00639727: hypothetical protein +FIG00639727 FIG00639728: hypothetical protein +FIG00639730 FIG00639731: hypothetical protein +FIG00639731 FIG00639732: hypothetical protein +FIG00639732 Putative virion morphogenesis protein +FIG00639738 FIG00639739: hypothetical protein +FIG00639740 FIG01219977: hypothetical protein +FIG00639747 FIG00639748: hypothetical protein +FIG00639748 FIG00639749: hypothetical protein +FIG00639749 FIG00639751: hypothetical protein +FIG00639755 FIG00639757: hypothetical protein +FIG00639759 FIG00639761: hypothetical protein +FIG00639762 FIG00639763: hypothetical protein +FIG00639766 FIG00639767: hypothetical protein +FIG00639768 FIG00639769: hypothetical protein +FIG00639773 FIG00639775: hypothetical protein +FIG00639778 FIG00639779: hypothetical protein +FIG00639780 FIG00639781: hypothetical protein +FIG00639781 COG0550: Topoisomerase IA +FIG00639782 FIG00639787: hypothetical protein +FIG00639787 FIG00639788: hypothetical protein +FIG00639794 FIG00639795: hypothetical protein +FIG00639795 FIG00639796: hypothetical protein +FIG00639796 FIG00639797: hypothetical protein +FIG00639800 FIG00639801: hypothetical protein +FIG00639802 FIG00639803: hypothetical protein +FIG00639803 Hypothetical response regulatory protein ygeK +FIG00639804 FIG00639809: hypothetical protein +FIG00639809 FIG00639810: hypothetical protein +FIG00639810 FIG00639812: hypothetical protein +FIG00639812 FIG00639814: hypothetical protein +FIG00639814 FIG00639815: hypothetical protein +FIG00639815 FIG00639817: hypothetical protein +FIG00639817 FIG00639818: hypothetical protein +FIG00639819 FIG00639822: hypothetical protein +FIG00639822 FIG00639826: hypothetical protein +FIG00639826 FIG00639828: hypothetical protein +FIG00639828 FIG00639829: hypothetical protein +FIG00639830 FIG00639831: hypothetical protein +FIG00639831 Pertactin precursor +FIG00639832 FIG00639836: hypothetical protein +FIG00639836 FIG00639842: hypothetical protein +FIG00639843 FIG00639844: hypothetical protein +FIG00639846 gene 66 protein +FIG00639853 FIG00639855: hypothetical protein +FIG00639858 FIG00639859: hypothetical protein +FIG00639859 FIG00639860: hypothetical protein +FIG00639860 FIG00639861: hypothetical protein +FIG00639862 repressor +FIG00639863 FIG00639866: hypothetical protein +FIG00639866 FIG00639867: hypothetical protein +FIG00639870 FIG01047791: hypothetical protein +FIG00639872 FIG01221266: hypothetical protein +FIG00639874 FIG01070373: hypothetical protein +FIG00639876 FIG00639877: hypothetical protein +FIG00639884 FIG00639885: hypothetical protein +FIG00639885 FIG00639887: hypothetical protein +FIG00639887 FIG00639888: hypothetical protein +FIG00639889 FIG00639891: hypothetical protein +FIG00639892 FIG00639895: hypothetical protein +FIG00639895 FIG00639899: hypothetical protein +FIG00639899 FIG00639900: hypothetical protein +FIG00639902 FIG00639903: hypothetical protein +FIG00639903 FIG00639905: hypothetical protein +FIG00639907 FIG00639908: hypothetical protein +FIG00639908 FIG00639909: hypothetical protein +FIG00639909 FIG00641990: hypothetical protein +FIG00639917 FIG00639918: hypothetical protein +FIG00639918 FIG00639919: hypothetical protein +FIG00639919 putative regulator; Regulation (Phage or Prophage Related) +FIG00639920 FIG00639921: hypothetical protein +FIG00639924 adhesin/invasin-like protein [similarity] +FIG00639926 FIG00639929: hypothetical protein +FIG00639931 FIG00639934: hypothetical protein +FIG00639934 FIG00639935: hypothetical protein +FIG00639941 FIG00639943: hypothetical protein +FIG00639943 FIG00639944: hypothetical protein +FIG00639944 FIG00639945: hypothetical protein +FIG00639945 FIG00639948: hypothetical protein +FIG00639948 FIG00639949: hypothetical protein +FIG00639949 FIG00639950: hypothetical protein +FIG00639950 FIG00639951: hypothetical protein +FIG00639953 FIG00639954: hypothetical protein +FIG00639955 putative bacteriophage baseplate protein +FIG00639957 FIG00639958: hypothetical protein +FIG00639959 FIG00639961: hypothetical protein +FIG00639961 FIG00639962: hypothetical protein +FIG00639972 FIG00639973: hypothetical protein +FIG00639974 FIG00639976: hypothetical protein +FIG00639979 FIG00639980: hypothetical protein +FIG00639980 FIG00639981: hypothetical protein +FIG00639981 FIG00639982: hypothetical protein +FIG00639982 FIG00639988: hypothetical protein +FIG00639988 FIG00639989: hypothetical protein +FIG00639989 FIG00639990: hypothetical protein +FIG00639995 hypothetical protein +FIG00639999 FIG00640000: hypothetical protein +FIG00640002 FIG00640003: hypothetical protein +FIG00640003 FIG00640004: hypothetical protein +FIG00640005 FIG00640006: hypothetical protein +FIG00640012 FIG00640016: hypothetical protein +FIG00640016 FIG00640019: hypothetical protein +FIG00640019 FIG00640020: hypothetical protein +FIG00640021 FIG00640022: hypothetical protein +FIG00640023 FIG00640024: hypothetical protein +FIG00640026 FIG00640027: hypothetical protein +FIG00640027 FIG00640028: hypothetical protein +FIG00640031 FIG00640033: hypothetical protein +FIG00640040 FIG00640041: hypothetical protein +FIG00640041 FIG00640042: hypothetical protein +FIG00640042 FIG00640043: hypothetical protein +FIG00640053 FIG00640055: hypothetical protein +FIG00640058 FIG00640059: hypothetical protein +FIG00640059 FIG00640062: hypothetical protein +FIG00640065 FIG00640071: hypothetical protein +FIG00640071 FIG00640072: hypothetical protein +FIG00640072 FIG00640074: hypothetical protein +FIG00640074 hypothetical protein +FIG00640075 FIG00640076: hypothetical protein +FIG00640076 FIG00640077: hypothetical protein +FIG00640079 FIG00640082: hypothetical protein +FIG00640084 Phage EaA protein +FIG00640093 FIG00640094: hypothetical protein +FIG00640098 FIG00640100: hypothetical protein +FIG00640100 FIG00640102: hypothetical protein +FIG00640104 FIG00640106: hypothetical protein +FIG00640111 FIG00640112: hypothetical protein +FIG00640112 FIG00640114: hypothetical protein +FIG00640118 FIG00640120: hypothetical protein +FIG00640123 FIG00640125: hypothetical protein +FIG00640129 TrbB protein +FIG00640131 FIG00640133: hypothetical protein +FIG00640133 FIG00640134: hypothetical protein +FIG00640134 FIG00640136: hypothetical protein +FIG00640136 FIG00640138: hypothetical protein +FIG00640138 FIG00640139: hypothetical protein +FIG00640139 FIG00640140: hypothetical protein +FIG00640140 FIG00640141: hypothetical protein +FIG00640141 FIG00640142: hypothetical protein +FIG00640147 COG3311: Predicted transcriptional regulator +FIG00640150 hypothetical protein +FIG00640156 hypothetical protein +FIG00640158 FIG00640159: hypothetical protein +FIG00640163 FIG00640165: hypothetical protein +FIG00640165 FIG00640166: hypothetical protein +FIG00640166 FIG00640168: hypothetical protein +FIG00640168 FIG00640169: hypothetical protein +FIG00640173 hypothetical protein +FIG00640174 FIG00640175: hypothetical protein +FIG00640175 FIG00640176: hypothetical protein +FIG00640183 FIG00640184: hypothetical protein +FIG00640185 FIG00640186: hypothetical protein +FIG00640192 FIG00640193: hypothetical protein +FIG00640193 FIG00640194: hypothetical protein +FIG00640205 FIG00640206: hypothetical protein +FIG00640210 FIG00641597: hypothetical protein +FIG00640215 RecT protein +FIG00640216 FIG00640217: hypothetical protein +FIG00640217 FIG00640218: hypothetical protein +FIG00640218 FIG00640219: hypothetical protein +FIG00640219 FIG00640221: hypothetical protein +FIG00640221 FIG00640222: hypothetical protein +FIG00640222 FIG00640226: hypothetical protein +FIG00640226 FIG00640227: hypothetical protein +FIG00640227 FIG00640229: hypothetical protein +FIG00640231 FIG00640233: hypothetical protein +FIG00640233 Phage NinX +FIG00640237 FIG00640239: hypothetical protein +FIG00640239 FIG00640240: hypothetical protein +FIG00640240 FIG00640244: hypothetical protein +FIG00640244 putative DNA damage-inducible protein +FIG00640245 FIG00640248: hypothetical protein +FIG00640248 FIG00642677: hypothetical protein +FIG00640249 FIG00640252: hypothetical protein +FIG00640253 FIG00640257: hypothetical protein +FIG00640257 FIG00640258: hypothetical protein +FIG00640264 cII protein +FIG00640265 FIG00640267: hypothetical protein +FIG00640267 FIG00640268: hypothetical protein +FIG00640269 FIG00640270: hypothetical protein +FIG00640270 FIG00640272: hypothetical protein +FIG00640274 FIG00640276: hypothetical protein +FIG00640276 FIG00640277: hypothetical protein +FIG00640277 FIG00640278: hypothetical protein +FIG00640288 FIG00640289: hypothetical protein +FIG00640289 FIG00640290: hypothetical protein +FIG00640291 FIG00640292: hypothetical protein +FIG00640292 FIG00640293: hypothetical protein +FIG00640299 FIG00640302: hypothetical protein +FIG00640302 FIG00638186: hypothetical protein +FIG00640304 FIG00640305: hypothetical protein +FIG00640305 FIG00640306: hypothetical protein +FIG00640307 FIG00640314: hypothetical protein +FIG00640314 FIG00640315: hypothetical protein +FIG00640315 FIG01201734: hypothetical protein +FIG00640317 FIG00640321: hypothetical protein +FIG00640321 FIG00640322: hypothetical protein +FIG00640322 FIG00640323: hypothetical protein +FIG00640323 Phage coat protein +FIG00640329 FIG00640330: hypothetical protein +FIG00640330 FIG00640332: hypothetical protein +FIG00640341 FIG00640343: hypothetical protein +FIG00640345 FIG00640347: hypothetical protein +FIG00640360 FIG00640361: hypothetical protein +FIG00640369 YdfA protein +FIG00640371 FIG00640373: hypothetical protein +FIG00640373 FIG00640374: hypothetical protein +FIG00640374 FIG00640380: hypothetical protein +FIG00640380 FIG00640385: hypothetical protein +FIG00640386 FIG00640387: hypothetical protein +FIG00640388 FIG00640392: hypothetical protein +FIG00640393 Phage tail X +FIG00640397 FIG00640398: hypothetical protein +FIG00640398 FIG00640400: hypothetical protein +FIG00640403 FIG00640404: hypothetical protein +FIG00640404 FIG00640406: hypothetical protein +FIG00640406 FIG00640408: hypothetical protein +FIG00640408 FIG00640410: hypothetical protein +FIG00640410 FIG00640415: hypothetical protein +FIG00640415 FIG00640420: hypothetical protein +FIG00640421 FIG00640422: hypothetical protein +FIG00640423 FIG00640424: hypothetical protein +FIG00640424 FIG00640425: hypothetical protein +FIG00640425 FIG00640428: hypothetical protein +FIG00640428 FIG00640430: hypothetical protein +FIG00640433 FIG00640434: hypothetical protein +FIG00640439 FIG00640442: hypothetical protein +FIG00640451 FIG00640453: hypothetical protein +FIG00640453 FIG00640454: hypothetical protein +FIG00640454 FIG00640455: hypothetical protein +FIG00640455 FIG00640460: hypothetical protein +FIG00640461 FIG00640465: hypothetical protein +FIG00640465 FIG00640466: hypothetical protein +FIG00640467 FIG00640468: hypothetical protein +FIG00640468 FIG00640473: hypothetical protein +FIG00640473 FIG00640476: hypothetical protein +FIG00640476 putative phage tail protein +FIG00640477 hypothetical protein +FIG00640483 FIG00640487: hypothetical protein +FIG00640495 FIG00640500: hypothetical protein +FIG00640500 FIG00640501: hypothetical protein +FIG00640501 FIG00640502: hypothetical protein +FIG00640502 FIG00640503: hypothetical protein +FIG00640506 FIG00640507: hypothetical protein +FIG00640508 FIG00640509: hypothetical protein +FIG00640509 FIG00640511: hypothetical protein +FIG00640515 FIG00640516: hypothetical protein +FIG00640517 FIG00640518: hypothetical protein +FIG00640518 hypothetical protein +FIG00640519 FIG00640522: hypothetical protein +FIG00640522 FIG00640523: hypothetical protein +FIG00640523 FIG00640524: hypothetical protein +FIG00640524 FIG00640525: hypothetical protein +FIG00640526 FIG00640527: hypothetical protein +FIG00640528 hypothetical protein +FIG00640532 FIG00640535: hypothetical protein +FIG00640535 FIG00640536: hypothetical protein +FIG00640539 FIG00640540: hypothetical protein +FIG00640540 FIG00640542: hypothetical protein +FIG00640543 FIG00640544: hypothetical protein +FIG00640545 FIG00640547: hypothetical protein +FIG00640547 FIG00640548: hypothetical protein +FIG00640551 FIG00640552: hypothetical protein +FIG00640553 FIG00640554: hypothetical protein +FIG00640554 FIG00640556: hypothetical protein +FIG00640559 FIG00640560: hypothetical protein +FIG00640562 FIG00640564: hypothetical protein +FIG00640568 FIG00640569: hypothetical protein +FIG00640569 Phage exonuclease (EC 3.1.11.3); Putative phage-encoded enzyme involved in integration-recombination +FIG00640574 FIG00640575: hypothetical protein +FIG00640582 FIG00640584: hypothetical protein +FIG00640586 FIG00640587: hypothetical protein +FIG00640589 FIG00640590: hypothetical protein +FIG00640590 Putative sugar kinase, PfkB family protein (EC 2.7.1.-) +FIG00640591 FIG00640594: hypothetical protein +FIG00640594 FIG00640597: hypothetical protein +FIG00640597 FIG00640598: hypothetical protein +FIG00640601 FIG00640604: hypothetical protein +FIG00640605 hypothetical protein +FIG00640608 FIG00640609: hypothetical protein +FIG00640609 Uncharacterized protein YjfM +FIG00640610 FIG00640611: hypothetical protein +FIG00640611 FIG00640612: hypothetical protein +FIG00640612 FIG00640614: hypothetical protein +FIG00640616 FIG00640618: hypothetical protein +FIG00640618 FIG00640619: hypothetical protein +FIG00640620 FIG00640621: hypothetical protein +FIG00640621 FIG00640622: hypothetical protein +FIG00640622 FIG00640624: hypothetical protein +FIG00640624 FIG00640628: hypothetical protein +FIG00640628 FIG00640631: hypothetical protein +FIG00640631 FIG00640632: hypothetical protein +FIG00640639 FIG00640640: hypothetical protein +FIG00640640 FIG00640641: hypothetical protein +FIG00640641 major pilin subunit PapA +FIG00640646 FIG00640648: hypothetical protein +FIG00640652 FIG00640654: hypothetical protein +FIG00640655 FIG00640657: hypothetical protein +FIG00640658 FIG00640659: hypothetical protein +FIG00640663 FIG00640666: hypothetical protein +FIG00640670 FIG00640671: hypothetical protein +FIG00640673 FIG00639588: hypothetical protein +FIG00640676 FIG00640677: hypothetical protein +FIG00640677 FIG00640678: hypothetical protein +FIG00640678 FIG00640680: hypothetical protein +FIG00640680 FIG00640682: hypothetical protein +FIG00640682 FIG00640689: hypothetical protein +FIG00640691 FIG00640692: hypothetical protein +FIG00640692 FIG00640693: hypothetical protein +FIG00640693 FIG00640694: hypothetical protein +FIG00640694 FIG00640695: hypothetical protein +FIG00640696 putative endopeptidase protein Rz of prophage CP-933K( EC:3.4.- ) +FIG00640699 FIG00641766: hypothetical protein +FIG00640707 FIG00640713: hypothetical protein +FIG00640713 FIG00637998: hypothetical protein +FIG00640715 FIG00640718: hypothetical protein +FIG00640727 FIG00640728: hypothetical protein +FIG00640729 FIG00640731: hypothetical protein +FIG00640731 FIG00640735: hypothetical protein +FIG00640735 FIG00640737: hypothetical protein +FIG00640737 FIG00640740: hypothetical protein +FIG00640740 FIG00640743: hypothetical protein +FIG00640743 FIG00640744: hypothetical protein +FIG00640744 FIG00640748: hypothetical protein +FIG00640748 FIG00640753: hypothetical protein +FIG00640753 ORF30 +FIG00640755 FIG00640756: hypothetical protein +FIG00640757 FIG00640758: hypothetical protein +FIG00640763 FIG00640766: hypothetical protein +FIG00640770 FIG00640771: hypothetical protein +FIG00640771 FIG00640773: hypothetical protein +FIG00640774 FIG00640775: hypothetical protein +FIG00640778 Alpha-amylase (EC 3.2.1.1) (1,4-alpha-D-glucan glucanohydrolase) (GLYCOGENASE) +FIG00640780 FIG00640783: hypothetical protein +FIG00640783 FIG00640785: hypothetical protein +FIG00640785 FIG00640789: hypothetical protein +FIG00640789 FIG00640791: hypothetical protein +FIG00640795 FIG00640798: hypothetical protein +FIG00640798 FIG00640801: hypothetical protein +FIG00640801 FIG00640802: hypothetical protein +FIG00640802 FIG00640803: hypothetical protein +FIG00640804 FIG00640806: hypothetical protein +FIG00640808 FIG00640809: hypothetical protein +FIG00640809 FIG00640810: hypothetical protein +FIG00640811 FIG00640812: hypothetical protein +FIG00640812 FIG00640813: hypothetical protein +FIG00640813 FIG00640814: hypothetical protein +FIG00640814 FIG00640815: hypothetical protein +FIG00640815 FIG01070003: hypothetical protein +FIG00640816 FIG00640819: hypothetical protein +FIG00640819 FIG00640820: hypothetical protein +FIG00640821 FIG00640822: hypothetical protein +FIG00640822 hypothetical protein +FIG00640830 FIG00640832: hypothetical protein +FIG00640838 COG1396: Predicted transcriptional regulators +FIG00640841 FIG00640843: hypothetical protein +FIG00640843 CcdB toxin protein +FIG00640844 FIG00640846: hypothetical protein +FIG00640846 FIG00640847: hypothetical protein +FIG00640847 FIG00640850: hypothetical protein +FIG00640851 replication initiation protein +FIG00640862 FIG00640863: hypothetical protein +FIG00640866 FIG00640869: hypothetical protein +FIG00640871 FIG00640873: hypothetical protein +FIG00640873 FIG00640874: hypothetical protein +FIG00640874 FIG00640875: hypothetical protein +FIG00640875 FIG00640876: hypothetical protein +FIG00640876 FIG00640877: hypothetical protein +FIG00640878 essential recombination function protein Erf +FIG00640885 FIG01067849: hypothetical protein +FIG00640889 Phage holin +FIG00640890 FIG00640891: hypothetical protein +FIG00640892 FIG00640893: hypothetical protein +FIG00640893 FIG00640898: hypothetical protein +FIG00640898 FIG00640899: hypothetical protein +FIG00640899 FIG01068879: hypothetical protein +FIG00640903 FIG00640904: hypothetical protein +FIG00640906 FIG00640910: hypothetical protein +FIG00640912 FIG00640915: hypothetical protein +FIG00640915 FIG00640917: hypothetical protein +FIG00640917 FIG00640918: hypothetical protein +FIG00640918 FIG00640920: hypothetical protein +FIG00640920 FIG00640921: hypothetical protein +FIG00640923 FIG00640927: hypothetical protein +FIG00640930 FIG00640935: hypothetical protein +FIG00640936 FIG00640941: hypothetical protein +FIG00640941 FIG00640942: hypothetical protein +FIG00640943 FIG00640945: hypothetical protein +FIG00640947 FIG00640949: hypothetical protein +FIG00640951 FIG00640952: hypothetical protein +FIG00640952 FIG00640959: hypothetical protein +FIG00640959 FIG00640962: hypothetical protein +FIG00640962 FIG00640963: hypothetical protein +FIG00640978 FIG00640982: hypothetical protein +FIG00640982 FIG01070144: hypothetical protein +FIG00640983 Putative minor tail protein +FIG00640987 FIG00640988: hypothetical protein +FIG00640992 FIG00640995: hypothetical protein +FIG00641000 FIG00641006: hypothetical protein +FIG00641007 FIG00641009: hypothetical protein +FIG00641014 FIG00641015: hypothetical protein +FIG00641017 FIG00641018: hypothetical protein +FIG00641020 FIG00641021: hypothetical protein +FIG00641021 FIG00641023: hypothetical protein +FIG00641023 FIG00641024: hypothetical protein +FIG00641024 FIG00641025: hypothetical protein +FIG00641025 FIG00641026: hypothetical protein +FIG00641026 FIG00641027: hypothetical protein +FIG00641036 FIG00641039: hypothetical protein +FIG00641039 hypothetical +FIG00641040 FIG00641044: hypothetical protein +FIG00641050 FIG00641052: hypothetical protein +FIG00641053 FIG00641056: hypothetical protein +FIG00641058 putative membrane; Protection responses: Cell killing (Phage or Prophage Related) +FIG00641059 FIG00641064: hypothetical protein +FIG00641064 FIG00641067: hypothetical protein +FIG00641070 FIG00641072: hypothetical protein +FIG00641073 FIG00641074: hypothetical protein +FIG00641074 FIG00641077: hypothetical protein +FIG00641079 FIG00641080: hypothetical protein +FIG00641080 FIG00641081: hypothetical protein +FIG00641084 FIG00641086: hypothetical protein +FIG00641086 FIG00641088: hypothetical protein +FIG00641088 FIG00641089: hypothetical protein +FIG00641089 FIG00641090: hypothetical protein +FIG00641092 FIG00641093: hypothetical protein +FIG00641093 FIG00641096: hypothetical protein +FIG00641096 FIG00641097: hypothetical protein +FIG00641097 FIG00641098: hypothetical protein +FIG00641098 FIG00641100: hypothetical protein +FIG00641100 FIG00641102: hypothetical protein +FIG00641102 FIG00641106: hypothetical protein +FIG00641106 FIG00641110: hypothetical protein +FIG00641111 FIG00641112: hypothetical protein +FIG00641112 FIG00641114: hypothetical protein +FIG00641116 FIG00641123: hypothetical protein +FIG00641132 FIG00641133: hypothetical protein +FIG00641133 FIG00641134: hypothetical protein +FIG00641136 FIG00641137: hypothetical protein +FIG00641148 FIG00641149: hypothetical protein +FIG00641149 FIG00641150: hypothetical protein +FIG00641150 FIG00641151: hypothetical protein +FIG00641155 FIG00641156: hypothetical protein +FIG00641156 FIG00641157: hypothetical protein +FIG00641159 FIG00641160: hypothetical protein +FIG00641160 FIG00641161: hypothetical protein +FIG00641162 FIG00641166: hypothetical protein +FIG00641167 FIG00641170: hypothetical protein +FIG00641170 FIG00641173: hypothetical protein +FIG00641173 FIG00641174: hypothetical protein +FIG00641175 FIG00641176: hypothetical protein +FIG00641176 FIG00641177: hypothetical protein +FIG00641177 FIG00641182: hypothetical protein +FIG00641184 FIG00641185: hypothetical protein +FIG00641189 FIG00641190: hypothetical protein +FIG00641203 FIG00641207: hypothetical protein +FIG00641216 FIG00641220: hypothetical protein +FIG00641220 FIG00641222: hypothetical protein +FIG00641222 FIG00641226: hypothetical protein +FIG00641226 FIG00641229: hypothetical protein +FIG00641229 FIG00641231: hypothetical protein +FIG00641237 FIG00641238: hypothetical protein +FIG00641238 PTS system, fructose-specific IIABC component (EC 2.7.1.69) +FIG00641262 FIG00641263: hypothetical protein +FIG00641263 FIG00641264: hypothetical protein +FIG00641264 FIG00641266: hypothetical protein +FIG00641266 FIG00641267: hypothetical protein +FIG00641267 FIG00638873: hypothetical protein +FIG00641268 FIG00641270: hypothetical protein +FIG00641270 FIG00641273: hypothetical protein +FIG00641273 FIG00641278: hypothetical protein +FIG00641282 FIG00641285: hypothetical protein +FIG00641287 FIG00641289: hypothetical protein +FIG00641290 FIG00641291: hypothetical protein +FIG00641301 FIG00641303: hypothetical protein +FIG00641303 COG0554: Glycerol kinase +FIG00641305 FIG00641309: hypothetical protein +FIG00641310 FIG00641311: hypothetical protein +FIG00641313 FIG00641314: hypothetical protein +FIG00641314 FIG00641315: hypothetical protein +FIG00641315 FIG00641317: hypothetical protein +FIG00641317 FIG00641318: hypothetical protein +FIG00641318 adherence and invasion outermembrane protein (Inv,enhances Peyer's patches colonization) +FIG00641329 FIG00641333: hypothetical protein +FIG00641335 FIG00641340: hypothetical protein +FIG00641340 FIG00641341: hypothetical protein +FIG00641343 FIG00641346: hypothetical protein +FIG00641348 FIG00641350: hypothetical protein +FIG00641353 FIG00641354: hypothetical protein +FIG00641354 FIG00641361: hypothetical protein +FIG00641361 hypothetical protein +FIG00641374 hypothetical protein +FIG00641381 FIG00641384: hypothetical protein +FIG00641385 FIG00641386: hypothetical protein +FIG00641386 FIG00641388: hypothetical protein +FIG00641388 FIG00641392: hypothetical protein +FIG00641393 FIG00641394: hypothetical protein +FIG00641395 probable prophage membrane protein STY1040 +FIG00641399 FIG00641400: hypothetical protein +FIG00641401 FIG00641404: hypothetical protein +FIG00641411 FIG00641419: hypothetical protein +FIG00641419 probable major tail subunit +FIG00641420 FIG00641421: hypothetical protein +FIG00641421 FIG00641423: hypothetical protein +FIG00641425 FIG00641426: hypothetical protein +FIG00641426 FIG00641427: hypothetical protein +FIG00641428 FIG00641430: hypothetical protein +FIG00641432 FIG00641434: hypothetical protein +FIG00641437 FIG00641438: hypothetical protein +FIG00641442 FIG00641443: hypothetical protein +FIG00641443 FIG00641444: hypothetical protein +FIG00641444 FIG00641449: hypothetical protein +FIG00641457 FIG00641460: hypothetical protein +FIG00641462 FIG00641463: hypothetical protein +FIG00641468 FIG00641470: hypothetical protein +FIG00641470 FIG00641471: hypothetical protein +FIG00641471 FIG00641473: hypothetical protein +FIG00641491 Thiol:disulfide involved in conjugative transfer +FIG00641493 putative antitermination protein Q +FIG00641496 FIG00641497: hypothetical protein +FIG00641502 FIG00641503: hypothetical protein +FIG00641505 hypothetical protein +FIG00641510 FIG00641512: hypothetical protein +FIG00641512 IncH1 plasmid conjugative transfer protein TrhV +FIG00641513 FIG00641514: hypothetical protein +FIG00641517 FIG00641518: hypothetical protein +FIG00641520 FIG00641523: hypothetical protein +FIG00641523 FIG00641524: hypothetical protein +FIG00641524 FIG00641526: hypothetical protein +FIG00641538 FIG00641539: hypothetical protein +FIG00641546 FIG00641548: hypothetical protein +FIG00641548 FIG00641558: hypothetical protein +FIG00641558 cII +FIG00641560 FIG00641561: hypothetical protein +FIG00641569 FIG00641572: hypothetical protein +FIG00641575 FIG00641576: hypothetical protein +FIG00641576 FIG00641577: hypothetical protein +FIG00641577 FIG00641578: hypothetical protein +FIG00641584 FIG00641586: hypothetical protein +FIG00641586 mu-like bacteriophage G protein 2 +FIG00641587 FIG00641589: hypothetical protein +FIG00641600 FIG00638288: hypothetical protein +FIG00641602 FIG00641603: hypothetical protein +FIG00641603 FIG00641604: hypothetical protein +FIG00641604 FIG00641605: hypothetical protein +FIG00641606 FIG00641608: hypothetical protein +FIG00641608 FIG00641609: hypothetical protein +FIG00641613 FIG00641614: hypothetical protein +FIG00641620 FIG00641622: hypothetical protein +FIG00641623 FIG00641624: hypothetical protein +FIG00641634 FIG00641636: hypothetical protein +FIG00641636 FIG00641637: hypothetical protein +FIG00641641 FIG00641642: hypothetical protein +FIG00641644 FIG00641645: hypothetical protein +FIG00641645 FIG00641647: hypothetical protein +FIG00641647 FIG00641648: hypothetical protein +FIG00641648 FIG00641649: hypothetical protein +FIG00641651 FIG00641652: hypothetical protein +FIG00641652 hypothetical protein; Unknown protein. Putative secreted protein +FIG00641654 FIG00641656: hypothetical protein +FIG00641656 FIG00641663: hypothetical protein +FIG00641669 FIG00641671: hypothetical protein +FIG00641676 FIG00641678: hypothetical protein +FIG00641678 FIG00641683: hypothetical protein +FIG00641695 Prophage lambda integrase +FIG00641696 entry exclusion protein 2 +FIG00641697 FIG00641699: hypothetical protein +FIG00641699 FIG00641702: hypothetical protein +FIG00641702 FIG00641703: hypothetical protein +FIG00641703 FIG00641704: hypothetical protein +FIG00641704 hypothetical protein ECs5230 +FIG00641706 FIG00641707: hypothetical protein +FIG00641712 FIG00641713: hypothetical protein +FIG00641721 FIG00641722: hypothetical protein +FIG00641723 FIG00641724: hypothetical protein +FIG00641725 FIG00641729: hypothetical protein +FIG00641729 hypothetical protein +FIG00641732 FIG00641733: hypothetical protein +FIG00641741 FIG00641742: hypothetical protein +FIG00641742 FIG00641743: hypothetical protein +FIG00641744 FIG00641745: hypothetical protein +FIG00641755 FIG00641756: hypothetical protein +FIG00641756 FIG00641757: hypothetical protein +FIG00641761 FIG00641762: hypothetical protein +FIG00641762 FIG00641763: hypothetical protein +FIG00641763 FIG00641764: hypothetical protein +FIG00641767 FIG00641772: hypothetical protein +FIG00641773 FIG00641780: hypothetical protein +FIG00641783 FIG00641784: hypothetical protein +FIG00641793 FIG00641800: hypothetical protein +FIG00641800 Phage endonuclease +FIG00641802 FIG00641804: hypothetical protein +FIG00641804 FIG00641806: hypothetical protein +FIG00641806 FIG00641808: hypothetical protein +FIG00641809 FIG00641814: hypothetical protein +FIG00641814 FIG00641822: hypothetical protein +FIG00641822 FIG00641824: hypothetical protein +FIG00641824 FIG00641828: hypothetical protein +FIG00641828 FIG00641829: hypothetical protein +FIG00641835 FIG00641840: hypothetical protein +FIG00641847 FIG00641850: hypothetical protein +FIG00641850 Icd-like protein +FIG00641852 FIG00641855: hypothetical protein +FIG00641855 FIG00641858: hypothetical protein +FIG00641858 hypothetical protein +FIG00641865 FIG00641869: hypothetical protein +FIG00641869 FIG00641874: hypothetical protein +FIG00641877 FIG00641878: hypothetical protein +FIG00641878 FIG00641879: hypothetical protein +FIG00641879 FIG00641881: hypothetical protein +FIG00641887 FIG00641893: hypothetical protein +FIG00641893 FIG00641894: hypothetical protein +FIG00641896 FIG00641899: hypothetical protein +FIG00641899 hypothetical protein +FIG00641904 FIG00641909: hypothetical protein +FIG00641910 FIG00641916: hypothetical protein +FIG00641918 FIG00641921: hypothetical protein +FIG00641921 FIG00641922: hypothetical protein +FIG00641922 hypothetical protein +FIG00641930 FIG00641931: hypothetical protein +FIG00641933 FIG00641934: hypothetical protein +FIG00641934 FIG00641936: hypothetical protein +FIG00641946 FIG00641950: hypothetical protein +FIG00641951 hypothetical protein +FIG00641960 FIG00641962: hypothetical protein +FIG00641962 FIG00641964: hypothetical protein +FIG00641973 FIG00641974: hypothetical protein +FIG00641974 FIG00641975: hypothetical protein +FIG00641977 FIG00641978: hypothetical protein +FIG00641978 Putative prophage repressor CI +FIG00641987 FIG00641988: hypothetical protein +FIG00641988 FIG00641989: hypothetical protein +FIG00641989 FIG00641990: hypothetical protein +FIG00641990 FIG00641991: hypothetical protein +FIG00641996 FIG00641997: hypothetical protein +FIG00641997 FIG00641998: hypothetical protein +FIG00641998 FIG00641999: hypothetical protein +FIG00642000 FIG00642006: hypothetical protein +FIG00642006 FIG00642007: hypothetical protein +FIG00642010 FIG00642011: hypothetical protein +FIG00642026 FIG00642030: hypothetical protein +FIG00642030 FIG00642032: hypothetical protein +FIG00642033 FIG00642034: hypothetical protein +FIG00642035 FIG00642036: hypothetical protein +FIG00642040 FIG00642041: hypothetical protein +FIG00642044 FIG00642056: hypothetical protein +FIG00642058 FIG00642059: hypothetical protein +FIG00642059 FIG00642063: hypothetical protein +FIG00642063 FIG00642064: hypothetical protein +FIG00642064 FIG00642070: hypothetical protein +FIG00642071 FIG00642081: hypothetical protein +FIG00642081 FIG00642086: hypothetical protein +FIG00642087 FIG00642090: hypothetical protein +FIG00642090 FIG00642092: hypothetical protein +FIG00642093 FIG00642097: hypothetical protein +FIG00642097 lytic transglycosylase, catalytic +FIG00642109 FIG00642113: hypothetical protein +FIG00642113 FIG00642114: hypothetical protein +FIG00642114 FIG00642118: hypothetical protein +FIG00642118 FIG00642121: hypothetical protein +FIG00642125 FIG00642126: hypothetical protein +FIG00642126 FIG00642131: hypothetical protein +FIG00642133 O antigen polymerase Wzy +FIG00642134 FIG00642135: hypothetical protein +FIG00642138 RNA-directed DNA polymerase (EC 2.7.7.49), msDNA specific +FIG00642139 putative antirepressor +FIG00642154 FIG00642161: hypothetical protein +FIG00642170 FIG00642174: hypothetical protein +FIG00642174 FIG00642175: hypothetical protein +FIG00642175 FIG00642176: hypothetical protein +FIG00642176 ORF-66 +FIG00642178 FIG00642179: hypothetical protein +FIG00642179 FIG00642180: hypothetical protein +FIG00642180 FIG00642186: hypothetical protein +FIG00642186 FIG00642187: hypothetical protein +FIG00642190 FIG00642192: hypothetical protein +FIG00642192 FIG00642193: hypothetical protein +FIG00642193 FIG00642194: hypothetical protein +FIG00642197 FIG00642200: hypothetical protein +FIG00642203 FIG00642204: hypothetical protein +FIG00642211 FIG00642212: hypothetical protein +FIG00642212 hypothetical protein +FIG00642220 hypothetical protein +FIG00642221 FIG00642224: hypothetical protein +FIG00642240 FIG00642241: hypothetical protein +FIG00642241 FIG00642242: hypothetical protein +FIG00642245 FIG00642251: hypothetical protein +FIG00642251 FIG00642252: hypothetical protein +FIG00642254 YacB +FIG00642258 FIG00642259: hypothetical protein +FIG00642262 FIG00642264: hypothetical protein +FIG00642264 FIG00642265: hypothetical protein +FIG00642265 FIG00642267: hypothetical protein +FIG00642269 FIG00642273: hypothetical protein +FIG00642273 hypothetical protein +FIG00642279 FIG00642282: hypothetical protein +FIG00642283 FIG01047866: hypothetical protein +FIG00642293 FIG00642295: hypothetical protein +FIG00642295 FIG00642297: hypothetical protein +FIG00642299 FIG01046993: hypothetical protein +FIG00642304 FIG00642305: hypothetical protein +FIG00642306 FIG00642307: hypothetical protein +FIG00642307 FIG00642308: hypothetical protein +FIG00642308 FIG00642309: hypothetical protein +FIG00642310 FIG00642311: hypothetical protein +FIG00642314 FIG00642318: hypothetical protein +FIG00642322 FIG00642323: hypothetical protein +FIG00642323 FIG00642326: hypothetical protein +FIG00642329 FIG00642330: hypothetical protein +FIG00642330 FIG00642335: hypothetical protein +FIG00642335 FIG00642336: hypothetical protein +FIG00642337 FIG00642340: hypothetical protein +FIG00642342 FIG00642343: hypothetical protein +FIG00642343 FIG00642344: hypothetical protein +FIG00642344 FIG00642345: hypothetical protein +FIG00642345 FIG00642346: hypothetical protein +FIG00642363 FIG01046174: hypothetical protein +FIG00642381 FIG00642382: hypothetical protein +FIG00642383 FIG00642389: hypothetical protein +FIG00642396 FIG00642398: hypothetical protein +FIG00642398 FIG00642400: hypothetical protein +FIG00642400 FIG00643006: hypothetical protein +FIG00642402 FIG00642405: hypothetical protein +FIG00642407 Orf4 +FIG00642409 FIG00642410: hypothetical protein +FIG00642411 FIG00642415: hypothetical protein +FIG00642415 FIG00642416: hypothetical protein +FIG00642416 FIG00642418: hypothetical protein +FIG00642418 FIG00642419: hypothetical protein +FIG00642422 IncH1 plasmid conjugative transfer partition protein ParM +FIG00642430 FIG00642432: hypothetical protein +FIG00642432 hypothetical protein +FIG00642438 FIG00642442: hypothetical protein +FIG00642448 FIG00642451: hypothetical protein +FIG00642451 porin, autotransporter (AT) family +FIG00642460 FIG01048529: hypothetical protein +FIG00642468 FIG00642471: hypothetical protein +FIG00642471 FIG00642472: hypothetical protein +FIG00642472 YadA +FIG00642481 FIG00642485: hypothetical protein +FIG00642485 FIG00642488: hypothetical protein +FIG00642488 FIG00642489: hypothetical protein +FIG00642493 FIG00642495: hypothetical protein +FIG00642495 FIG00642496: hypothetical protein +FIG00642496 FIG00642497: hypothetical protein +FIG00642504 FIG01047460: hypothetical protein +FIG00642525 FIG00642527: hypothetical protein +FIG00642527 FIG00642528: hypothetical protein +FIG00642530 orf; Unknown function +FIG00642533 FIG00642536: hypothetical protein +FIG00642536 Holliday junction resolvase / Crossover junction endodeoxyribonuclease rusA (EC 3.1.22.-) +FIG00642537 FIG00642538: hypothetical protein +FIG00642546 FIG00642550: hypothetical protein +FIG00642550 FIG00642552: hypothetical protein +FIG00642552 FIG00923477: hypothetical protein +FIG00642560 FIG00642563: hypothetical protein +FIG00642564 FIG00642565: hypothetical protein +FIG00642570 FIG00642572: hypothetical protein +FIG00642572 FIG00642573: hypothetical protein +FIG00642580 Putative tail component of prophage CP-933K +FIG00642587 FIG00642588: hypothetical protein +FIG00642593 Origin specific replication binding factor +FIG00642596 hypothetical protein +FIG00642603 putative enzyme; Lysis (Phage or Prophage Related) +FIG00642618 FIG00642619: hypothetical protein +FIG00642626 hypothetical protein +FIG00642628 FIG00642631: hypothetical protein +FIG00642632 FIG00642633: hypothetical protein +FIG00642633 IncH1 plasmid conjugative transfer protein Orf4 +FIG00642635 FIG00642638: hypothetical protein +FIG00642638 FIG00642639: hypothetical protein +FIG00642650 FIG00642651: hypothetical protein +FIG00642651 FIG00642655: hypothetical protein +FIG00642655 FIG00642656: hypothetical protein +FIG00642656 FIG00642657: hypothetical protein +FIG00642657 Unknown function +FIG00642664 FIG00642676: hypothetical protein +FIG00642677 putative Q antiterminator encoded by prophage CP-933P +FIG00642679 WbbD +FIG00642680 FIG00642683: hypothetical protein +FIG00642683 FIG00642684: hypothetical protein +FIG00642684 Putative kinase +FIG00642687 FIG00642688: hypothetical protein +FIG00642696 FIG00642700: hypothetical protein +FIG00642708 FIG00642710: hypothetical protein +FIG00642710 FIG00642713: hypothetical protein +FIG00642716 Gp42.1 +FIG00642724 FIG00642725: hypothetical protein +FIG00642727 FIG00642728: hypothetical protein +FIG00642728 FIG00642729: hypothetical protein +FIG00642729 FIG00642734: hypothetical protein +FIG00642734 FIG00642735: hypothetical protein +FIG00642743 TrbA +FIG00642745 FIG00642746: hypothetical protein +FIG00642746 FIG00642749: hypothetical protein +FIG00642751 FIG00642753: hypothetical protein +FIG00642756 FIG00642757: hypothetical protein +FIG00642764 FIG00642772: hypothetical protein +FIG00642773 hypothetical protein +FIG00642780 FIG00642781: hypothetical protein +FIG00642783 FIG00642784: hypothetical protein +FIG00642784 FIG00642785: hypothetical protein +FIG00642795 FIG00642796: hypothetical protein +FIG00642796 FIG00642799: hypothetical protein +FIG00642799 FIG01069272: hypothetical protein +FIG00642804 FIG00642806: hypothetical protein +FIG00642806 FIG00642809: hypothetical protein +FIG00642809 IncH1 plasmid conjugative transfer protein Orf16 +FIG00642810 FIG00642812: hypothetical protein +FIG00642817 FIG00642822: hypothetical protein +FIG00642822 FIG00642824: hypothetical protein +FIG00642828 Copper-binding protein PcoE +FIG00642831 bacteriophage protein homolog lin2591 +FIG00642833 FIG00642834: hypothetical protein +FIG00642834 FIG00642839: hypothetical protein +FIG00642857 FIG00642859: hypothetical protein +FIG00642860 FIG00642864: hypothetical protein +FIG00642864 FIG00642870: hypothetical protein +FIG00642876 FIG00642878: hypothetical protein +FIG00642880 FIG00642882: hypothetical protein +FIG00642882 FIG00642886: hypothetical protein +FIG00642895 FIG00642897: hypothetical protein +FIG00642897 FIG00642899: hypothetical protein +FIG00642900 FIG00642903: hypothetical protein +FIG00642903 FIG00642905: hypothetical protein +FIG00642905 FIG00642906: hypothetical protein +FIG00642906 FIG00642907: hypothetical protein +FIG00642907 FIG00642908: hypothetical protein +FIG00642908 FIG00642909: hypothetical protein +FIG00642914 FIG00642918: hypothetical protein +FIG00642919 FIG00642920: hypothetical protein +FIG00642920 FIG00642924: hypothetical protein +FIG00642942 FIG00642943: hypothetical protein +FIG00642947 FIG00642948: hypothetical protein +FIG00642952 FIG00642953: hypothetical protein +FIG00642953 FIG00642954: hypothetical protein +FIG00642966 FIG00642967: hypothetical protein +FIG00642969 FIG00642974: hypothetical protein +FIG00642974 hypothetical protein +FIG00642975 FIG00642976: hypothetical protein +FIG00642976 DNA adenine methylase +FIG00642981 FIG00642984: hypothetical protein +FIG00642994 hypothetical protein +FIG00642998 FIG00643005: hypothetical protein +FIG00643022 FIG01221575: hypothetical protein +FIG00643026 FIG00643029: hypothetical protein +FIG00643029 FIG00643035: hypothetical protein +FIG00643035 FIG00643041: hypothetical protein +FIG00643041 FIG00643042: hypothetical protein +FIG00643043 hypothetical protein +FIG00643045 FIG00643049: hypothetical protein +FIG00643066 FIG00643068: hypothetical protein +FIG00643075 FIG00643079: hypothetical protein +FIG00643079 FIG00643081: hypothetical protein +FIG00643082 FIG00643083: hypothetical protein +FIG00643089 KilA protein +FIG00643094 phage-related baseplate protein +FIG00643097 FIG00643098: hypothetical protein +FIG00643098 FIG00643099: hypothetical protein +FIG00643099 FIG00643100: hypothetical protein +FIG00643100 FIG00643102: hypothetical protein +FIG00643103 FIG01047424: hypothetical protein +FIG00643104 FIG00643116: hypothetical protein +FIG00643124 FIG00643125: hypothetical protein +FIG00643125 FIG00643126: hypothetical protein +FIG00643135 FIG00643143: hypothetical protein +FIG00643145 FIG00643146: hypothetical protein +FIG00643151 FIG00643152: hypothetical protein +FIG00643161 FIG00643164: hypothetical protein +FIG00643165 FIG00643171: hypothetical protein +FIG00643173 FIG00643174: hypothetical protein +FIG00643196 FIG00643199: hypothetical protein +FIG00643199 FIG00643201: hypothetical protein +FIG00643201 FIG00643203: hypothetical protein +FIG00643212 FIG00643213: hypothetical protein +FIG00643214 FIG00643217: hypothetical protein +FIG00643234 FIG00643235: hypothetical protein +FIG00643235 FIG00643236: hypothetical protein +FIG00643238 FIG00643239: hypothetical protein +FIG00643241 FIG00643242: hypothetical protein +FIG00643244 FIG00643245: hypothetical protein +FIG00643247 FIG00643253: hypothetical protein +FIG00643254 FIG00643256: hypothetical protein +FIG00643257 FIG00643260: hypothetical protein +FIG00643260 FIG00643269: hypothetical protein +FIG00643269 FIG00643276: hypothetical protein +FIG00643276 FIG00643277: hypothetical protein +FIG00643296 FIG00643297: hypothetical protein +FIG00643297 hypothetical protein +FIG00643306 FIG00643307: hypothetical protein +FIG00643307 putative anti-repressor protein +FIG00643308 hypothetical protein +FIG00643309 Protein NinG +FIG00643313 FIG00643314: hypothetical protein +FIG00643343 putative phage tail fiber protein H +FIG00643344 FIG00643352: hypothetical protein +FIG00643353 FIG00643355: hypothetical protein +FIG00643356 putative Glycosyltransferase +FIG00643362 FIG00643364: hypothetical protein +FIG00643365 FIG01048479: hypothetical protein +FIG00643377 FIG00643378: hypothetical protein +FIG00643380 FIG00643383: hypothetical protein +FIG00643397 FIG00643399: hypothetical protein +FIG00643399 GntR family regulator protein +FIG00643412 FIG00643417: hypothetical protein +FIG00643423 FIG00643425: hypothetical protein +FIG00643426 FIG00643427: hypothetical protein +FIG00643439 FIG00643440: hypothetical protein +FIG00643440 AntA/AntB antirepressor domain protein +FIG00643475 FIG00643476: hypothetical protein +FIG00643476 FIG00643479: hypothetical protein +FIG00643483 Attachment invasion locus protein precursor +FIG00643490 FIG00643492: hypothetical protein +FIG00643502 FIG00643513: hypothetical protein +FIG00643525 FIG00643532: hypothetical protein +FIG00643533 FIG00643538: hypothetical protein +FIG00643540 FIG00643543: hypothetical protein +FIG00643543 putative recombinase +FIG00643548 FIG00643552: hypothetical protein +FIG00643552 FIG00643553: hypothetical protein +FIG00643553 FIG00643565: hypothetical protein +FIG00643584 FIG00643591: hypothetical protein +FIG00643591 FIG00643602: hypothetical protein +FIG00643605 FIG00643620: hypothetical protein +FIG00643620 FIG00643621: hypothetical protein +FIG00643622 FIG00643624: hypothetical protein +FIG00643625 FIG00643626: hypothetical protein +FIG00643631 FIG00643632: hypothetical protein +FIG00643632 FIG00643635: hypothetical protein +FIG00643635 FIG00643637: hypothetical protein +FIG00643637 FIG00643638: hypothetical protein +FIG00643638 FIG00643651: hypothetical protein +FIG00643651 FIG00643653: hypothetical protein +FIG00643663 Antitermination protein Q +FIG00643666 FIG00643670: hypothetical protein +FIG00643677 FIG00643686: hypothetical protein +FIG00643697 hypothetical protein +FIG00643703 FIG00643706: hypothetical protein +FIG00643709 FIG00643710: hypothetical protein +FIG00643710 FIG00643719: hypothetical protein +FIG00643744 FIG00643747: hypothetical protein +FIG00643755 FIG00643756: hypothetical protein +FIG00643766 FIG00643767: hypothetical protein +FIG00643771 FIG00643775: hypothetical protein +FIG00643780 FIG00643781: hypothetical protein +FIG00643818 FIG00643819: hypothetical protein +FIG00643828 FIG00643829: hypothetical protein +FIG00643837 Iron-sulfur cluster assembly protein SufD / Cysteine desulfurase (EC 2.8.1.7), SufS subfamily; Selenocysteine lyase( EC:4.4.1.16 ) subunit +FIG00643841 FIG00643843: hypothetical protein +FIG00643843 FIG00643845: hypothetical protein +FIG00643864 FIG00643867: hypothetical protein +FIG00643867 FIG00643868: hypothetical protein +FIG00643869 FIG00643870: hypothetical protein +FIG00643895 FIG00643896: hypothetical protein +FIG00643900 FIG00643914: hypothetical protein +FIG00643932 FIG00643933: hypothetical protein +FIG00643938 FIG00643946: hypothetical protein +FIG00643952 FIG00643960: hypothetical protein +FIG00643968 FIG00643969: hypothetical protein +FIG00643974 FIG00643980: hypothetical protein +FIG00643980 FIG00643981: hypothetical protein +FIG00643981 YDFB protein +FIG00644003 FIG00644005: hypothetical protein +FIG00644006 probable transcription regulator +FIG00644033 FIG00644035: hypothetical protein +FIG00644036 FIG00644038: hypothetical protein +FIG00644044 FIG00644045: hypothetical protein +FIG00644045 FIG00644052: hypothetical protein +FIG00644066 FIG00644067: hypothetical protein +FIG00644075 FIG00644076: hypothetical protein +FIG00644081 FIG00644082: hypothetical protein +FIG00644117 FIG00644121: hypothetical protein +FIG00644121 FIG00644122: hypothetical protein +FIG00644138 FIG00644139: hypothetical protein +FIG00644140 FIG00644143: hypothetical protein +FIG00644143 hypothetical protein +FIG00644152 FIG00644162: hypothetical protein +FIG00644162 Oligogalacturonide-Rhamnogalacturonide-specific porin +FIG00644167 IncH1 plasmid conjugative transfer protein TrhO +FIG00644180 FIG00644183: hypothetical protein +FIG00644186 FIG00644187: hypothetical protein +FIG00644200 FIG00644201: hypothetical protein +FIG00644208 FIG00644209: hypothetical protein +FIG00644211 FIG00644212: hypothetical protein +FIG00644219 COG1112: Superfamily I DNA and RNA helicases and helicase subunits +FIG00644223 FIG00644231: hypothetical protein +FIG00644231 FIG00644232: hypothetical protein +FIG00644233 anion transporter +FIG00644259 FIG00644263: hypothetical protein +FIG00644263 FIG00644270: hypothetical protein +FIG00644271 FIG00644273: hypothetical protein +FIG00644273 FIG00644274: hypothetical protein +FIG00644293 FIG00644297: hypothetical protein +FIG00644297 FIG00644304: hypothetical protein +FIG00644306 FIG00644308: hypothetical protein +FIG00644344 FIG00644345: hypothetical protein +FIG00644346 FIG00644348: hypothetical protein +FIG00644348 FIG00644353: hypothetical protein +FIG00644369 FIG00644370: hypothetical protein +FIG00644370 FIG00644371: hypothetical protein +FIG00644371 FIG00644376: hypothetical protein +FIG00644386 FIG00644392: hypothetical protein +FIG00644395 FIG00644397: hypothetical protein +FIG00644397 FIG00644398: hypothetical protein +FIG00644403 FIG00644405: hypothetical protein +FIG00644414 FIG00644416: hypothetical protein +FIG00644435 FIG00644436: hypothetical protein +FIG00644436 K88 fimbrial protein AC precursor +FIG00644442 hypothetical protein +FIG00644445 FIG00644448: hypothetical protein +FIG00644460 FIG00644466: hypothetical protein +FIG00644477 FIG00644484: hypothetical protein +FIG00644490 FIG00644491: hypothetical protein +FIG00644493 Uncharacterized protein YaiN in in formaldehyde detoxification operon +FIG00644497 FIG00644506: hypothetical protein +FIG00644506 FIG00644514: hypothetical protein +FIG00644514 Putative cytochrome C-type biogenesis protein +FIG00644535 FIG00644541: hypothetical protein +FIG00644553 FIG00644559: hypothetical protein +FIG00644566 FIG00644578: hypothetical protein +FIG00644591 FIG00644593: hypothetical protein +FIG00644599 Putative phosphatase +FIG00644609 hypothetical protein +FIG00644610 FIG00644618: hypothetical protein +FIG00644655 FIG01068810: hypothetical protein +FIG00644682 FIG00644688: hypothetical protein +FIG00644688 FIG00644689: hypothetical protein +FIG00644693 FIG00644701: hypothetical protein +FIG00644717 FIG00644720: hypothetical protein +FIG00644754 FIG00644756: hypothetical protein +FIG00644765 FIG00644768: hypothetical protein +FIG00644778 FIG00644780: hypothetical protein +FIG00644780 DNA processing protein DprA, putative +FIG00644781 FIG00644782: hypothetical protein +FIG00644782 DNA-cytosine methyltransferase( EC:2.1.1.37 ) +FIG00644797 FIG00644798: hypothetical protein +FIG00644803 FIG00644807: hypothetical protein +FIG00644816 putative exported phage-related protein +FIG00644829 FIG00644832: hypothetical protein +FIG00644832 FIG00644833: hypothetical protein +FIG00644857 FIG01047789: hypothetical protein +FIG00644859 FIG00644860: hypothetical protein +FIG00644863 FIG00644864: hypothetical protein +FIG00644865 FIG01045937: hypothetical protein +FIG00644869 COG1132: ABC-type multidrug transport system, ATPase and permease components +FIG00644871 FIG00644878: hypothetical protein +FIG00644905 FIG00644907: hypothetical protein +FIG00644921 FIG00644922: hypothetical protein +FIG00644935 FIG00644938: hypothetical protein +FIG00644961 FIG00644963: hypothetical protein +FIG00644993 FIG00644994: hypothetical protein +FIG00644994 FIG00644998: hypothetical protein +FIG00645004 IncI1 plasmid conjugative transfer protein PilJ +FIG00645009 FIG00645011: hypothetical protein +FIG00645012 FIG00645016: hypothetical protein +FIG00645016 FIG00645017: hypothetical protein +FIG00645020 FIG00645021: hypothetical protein +FIG00645023 FIG00645025: hypothetical protein +FIG00645025 MobA/MobL protein +FIG00645039 FIG00645040: hypothetical protein +FIG00645042 FIG00645044: hypothetical protein +FIG00645044 FIG00645045: hypothetical protein +FIG00645045 FIG00645047: hypothetical protein +FIG00645047 FIG00645050: hypothetical protein +FIG00645050 FIG00645051: hypothetical protein +FIG00645051 FIG00645053: hypothetical protein +FIG00645053 FIG00645056: hypothetical protein +FIG00645056 FIG00645057: hypothetical protein +FIG00645057 FIG01031812: hypothetical protein +FIG00645066 FIG00645071: hypothetical protein +FIG00645073 FIG00645074: hypothetical protein +FIG00645074 FIG00514608: hypothetical protein +FIG00645084 FIG00645085: hypothetical protein +FIG00645086 FIG00645087: hypothetical protein +FIG00645087 Stage II sporulation protein P +FIG00645088 FIG00645089: hypothetical protein +FIG00645090 FIG00645091: hypothetical protein +FIG00645094 FIG01032483: hypothetical protein +FIG00645108 FIG00645110: hypothetical protein +FIG00645116 FIG00645117: hypothetical protein +FIG00645125 FIG00645127: hypothetical protein +FIG00645127 FIG00645131: hypothetical protein +FIG00645131 FIG00645132: hypothetical protein +FIG00645140 peptidase, U32 family large subunit [C1] +FIG00645142 FIG00645143: hypothetical protein +FIG00645145 FIG00645146: hypothetical protein +FIG00645147 FIG00645149: hypothetical protein +FIG00645149 FIG00645151: hypothetical protein +FIG00645155 FIG00645157: hypothetical protein +FIG00645157 Sulfur transfer protein involved in thiamine biosynthesis +FIG00645160 FIG00645162: hypothetical protein +FIG00645163 nickase +FIG00645166 FIG00645168: hypothetical protein +FIG00645168 FIG00645169: hypothetical protein +FIG00645169 FIG00645171: hypothetical protein +FIG00645171 FIG00645173: hypothetical protein +FIG00645174 FIG00645175: hypothetical protein +FIG00645176 FIG00645177: hypothetical protein +FIG00645177 FIG00645179: hypothetical protein +FIG00645186 FIG00645188: hypothetical protein +FIG00645195 FIG00645196: hypothetical protein +FIG00645196 FIG00645197: hypothetical protein +FIG00645197 FIG00645199: hypothetical protein +FIG00645199 FIG00645200: hypothetical protein +FIG00645203 FIG00645204: hypothetical protein +FIG00645206 FIG00645208: hypothetical protein +FIG00645210 FIG00645211: hypothetical protein +FIG00645211 FIG00645213: hypothetical protein +FIG00645213 FIG00645215: hypothetical protein +FIG00645219 FIG00645220: hypothetical protein +FIG00645220 FIG00645221: hypothetical protein +FIG00645224 FIG00645225: hypothetical protein +FIG00645229 AP4A hydrolase +FIG00645230 FIG00645231: hypothetical protein +FIG00645231 FIG00645234: hypothetical protein +FIG00645234 FIG00645237: hypothetical protein +FIG00645237 FIG00645240: hypothetical protein +FIG00645241 FIG00645242: hypothetical protein +FIG00645242 FIG00645247: hypothetical protein +FIG00645248 FIG00645250: hypothetical protein +FIG00645250 FIG00645252: hypothetical protein +FIG00645252 FIG00645253: hypothetical protein +FIG00645253 FIG00645254: hypothetical protein +FIG00645254 FIG00645255: hypothetical protein +FIG00645255 FIG00645257: hypothetical protein +FIG00645267 FIG00645271: hypothetical protein +FIG00645283 FIG00645286: hypothetical protein +FIG00645286 FIG00645288: hypothetical protein +FIG00645288 FIG00645289: hypothetical protein +FIG00645289 FIG00645290: hypothetical protein +FIG00645290 Mov34/MPN/PAD-1 +FIG00645293 FIG00645295: hypothetical protein +FIG00645295 FIG00645302: hypothetical protein +FIG00645302 FIG00645304: hypothetical protein +FIG00645305 FIG00645307: hypothetical protein +FIG00645321 FIG00645322: hypothetical protein +FIG00645323 FIG00645324: hypothetical protein +FIG00645324 FIG00645325: hypothetical protein +FIG00645327 SOS-response transcriptional repressor, LexA( EC:3.4.21.88 ) +FIG00645330 FIG007421: forespore shell protein +FIG00645334 Protein vanZ +FIG00645338 FIG00645339: hypothetical protein +FIG00645350 FIG00645351: hypothetical protein +FIG00645359 FIG00645363: hypothetical protein +FIG00645364 FIG00645365: hypothetical protein +FIG00645368 Putative HTH-type transcriptional regulator ybaO +FIG00645369 FIG00645371: hypothetical protein +FIG00645375 FIG00645378: hypothetical protein +FIG00645378 FIG00645380: hypothetical protein +FIG00645382 FIG00645384: hypothetical protein +FIG00645384 FIG00645388: hypothetical protein +FIG00645393 CDS_ID OB2508 +FIG00645402 FIG00645405: hypothetical protein +FIG00645405 FIG00645407: hypothetical protein +FIG00645408 FIG00645411: hypothetical protein +FIG00645411 flagellar biosynthesis +FIG00645417 FIG00645420: hypothetical protein +FIG00645437 FIG00645438: hypothetical protein +FIG00645438 FIG00645440: hypothetical protein +FIG00645441 FIG00645443: hypothetical protein +FIG00645455 FIG00645459: hypothetical protein +FIG00645476 FIG00645481: hypothetical protein +FIG00645481 FIG00645487: hypothetical protein +FIG00645492 Spore protease GPR related protein +FIG00645529 FIG00645535: hypothetical protein +FIG00645535 FIG00645541: hypothetical protein +FIG00645542 EAL +FIG00645569 FIG00645571: hypothetical protein +FIG00645571 FIG00645575: hypothetical protein +FIG00645581 FIG00645588: hypothetical protein +FIG00645606 FIG01225334: hypothetical protein +FIG00645614 FIG00645616: hypothetical protein +FIG00645616 FIG00645618: hypothetical protein +FIG00645621 Type IV pilus biogenesis protein PilM / Type IV pilus biogenesis protein PilN +FIG00645623 FIG00645638: hypothetical protein +FIG00645638 HD-GYP hydrolase domain protein +FIG00645641 FIG00645643: hypothetical protein +FIG00645652 FIG00645654: hypothetical protein +FIG00645654 FIG00645655: hypothetical protein +FIG00645657 FIG00645658: hypothetical protein +FIG00645658 FIG00645659: hypothetical protein +FIG00645675 FIG00645691: hypothetical protein +FIG00645728 FIG00645730: hypothetical protein +FIG00645733 FIG00645735: hypothetical protein +FIG00645737 FIG00645741: hypothetical protein +FIG00645741 FIG00645743: hypothetical protein +FIG00645750 FIG00645752: hypothetical protein +FIG00645752 FIG00645758: hypothetical protein +FIG00645769 Possible metallo-beta-lactamase family protein +FIG00645771 FIG00645776: hypothetical protein +FIG00645780 FIG00645781: hypothetical protein +FIG00645786 FIG00645789: hypothetical protein +FIG00645791 FIG00645799: hypothetical protein +FIG00645799 FIG00645800: hypothetical protein +FIG00645805 FIG00645807: hypothetical protein +FIG00645807 FIG00645818: hypothetical protein +FIG00645818 FIG00645822: hypothetical protein +FIG00645843 FIG00645844: hypothetical protein +FIG00645844 FIG00645848: hypothetical protein +FIG00645848 FIG00645849: hypothetical protein +FIG00645855 Prokaryotic N-terminal methylation site precursor +FIG00645858 FIG00645860: hypothetical protein +FIG00645870 FIG00645872: hypothetical protein +FIG00645885 alternate gene name: jofA +FIG00645895 FIG00645898: hypothetical protein +FIG00645906 FIG00645908: hypothetical protein +FIG00645908 FIG00645911: hypothetical protein +FIG00645911 Thioredoxin-like oxidoreductases +FIG00645924 FIG00645928: hypothetical protein +FIG00645943 FIG00645946: hypothetical protein +FIG00645946 FIG00645947: hypothetical protein +FIG00645947 FIG00645948: hypothetical protein +FIG00645955 FIG00645958: hypothetical protein +FIG00645958 FIG00645964: hypothetical protein +FIG00645970 FIG00645976: hypothetical protein +FIG00645976 FIG00645978: hypothetical protein +FIG00645980 Type IV pilus biogenesis protein PilO +FIG00645986 riboflavin biosynthesis +FIG00645997 FIG00646006: hypothetical protein +FIG00646011 FIG00646013: hypothetical protein +FIG00646013 Leucine-rich protein +FIG00646023 FIG00646026: hypothetical protein +FIG00646049 FIG00646053: hypothetical protein +FIG00646060 FIG00646062: hypothetical protein +FIG00646064 FIG00646065: hypothetical protein +FIG00646069 FIG00646075: hypothetical protein +FIG00646091 FIG00646096: hypothetical protein +FIG00646098 ComK +FIG00646105 FIG00646109: hypothetical protein +FIG00646127 FIG00646129: hypothetical protein +FIG00646130 FIG00646132: hypothetical protein +FIG00646132 flagellar biosynthesis (flhS-related protein) +FIG00646146 FIG00646155: hypothetical protein +FIG00646158 FIG00646163: hypothetical protein +FIG00646168 FIG00646176: hypothetical protein +FIG00646181 FIG00646185: hypothetical protein +FIG00646197 ComK regulator +FIG00646204 FIG00646205: hypothetical protein +FIG00646209 FIG00646210: hypothetical protein +FIG00646225 FIG00646227: hypothetical protein +FIG00646229 FIG00646232: hypothetical protein +FIG00646234 FIG00646236: hypothetical protein +FIG00646264 Peptidase T (EC 3.4.11.4) +FIG00646266 FIG00646269: hypothetical protein +FIG00646282 GNAT family acetyltransferase Bsu1853 (YoaA) +FIG00646304 FIG00646310: hypothetical protein +FIG00646315 FIG00646317: hypothetical protein +FIG00646325 FIG00646331: hypothetical protein +FIG00646345 FIG00646351: hypothetical protein +FIG00646372 FIG00646373: hypothetical protein +FIG00646374 FIG00646377: hypothetical protein +FIG00646417 FIG00646419: hypothetical protein +FIG00646428 FIG00646438: hypothetical protein +FIG00646445 FIG00646455: hypothetical protein +FIG00646468 FIG00646469: hypothetical protein +FIG00646469 FIG00646473: hypothetical protein +FIG00646482 FIG00646485: hypothetical protein +FIG00646497 FIG00646498: hypothetical protein +FIG00646518 FIG00646520: hypothetical protein +FIG00646526 FIG00646530: hypothetical protein +FIG00646535 FIG00646541: hypothetical protein +FIG00646557 FIG00646558: hypothetical protein +FIG00646560 FIG00646565: hypothetical protein +FIG00646573 FIG00646587: hypothetical protein +FIG00646592 Core component SCO2325 of predicted cobalamin ECF transporter +FIG00646595 Cytidine/deoxycytidylate deaminase, zinc-binding region +FIG00646597 FIG00646604: hypothetical protein +FIG00646604 FIG00646605: hypothetical protein +FIG00646608 FIG00646609: hypothetical protein +FIG00646630 FIG00646635: hypothetical protein +FIG00646635 FIG00646636: hypothetical protein +FIG00646637 FIG00646649: hypothetical protein +FIG00646655 Regulatory protein spx +FIG00646659 FIG00646662: hypothetical protein +FIG00646690 YfjT +FIG00646701 FIG00646710: hypothetical protein +FIG00646721 FIG00646726: hypothetical protein +FIG00646774 FIG00646775: hypothetical protein +FIG00646805 FIG00646818: hypothetical protein +FIG00646845 FIG00646845: hypothetical YMCA protein +FIG00646864 FIG00646867: hypothetical protein +FIG00646869 FIG00646870: hypothetical protein +FIG00646871 FIG00646872: hypothetical protein +FIG00646872 FIG00646873: hypothetical protein +FIG00646873 FIG00646874: hypothetical protein +FIG00646875 FIG00646876: hypothetical protein +FIG00646876 FIG00646877: hypothetical protein +FIG00646881 FIG00646882: hypothetical protein +FIG00646883 FIG00646885: hypothetical protein +FIG00646892 penicillin-resistant DD-carboxypeptidase +FIG00646893 FIG00646894: hypothetical protein +FIG00646894 FIG00646896: hypothetical protein +FIG00646896 FIG00646897: hypothetical protein +FIG00646897 FIG00646898: hypothetical protein +FIG00646898 FIG00646899: hypothetical protein +FIG00646900 FIG00646902: hypothetical protein +FIG00646902 FIG00646903: hypothetical protein +FIG00646903 FIG00646906: hypothetical protein +FIG00646908 FIG00646909: hypothetical protein +FIG00646909 FIG00646911: hypothetical protein +FIG00646912 FIG00646913: hypothetical protein +FIG00646913 FIG00646915: hypothetical protein +FIG00646915 FIG00646916: hypothetical protein +FIG00646916 FIG00646917: hypothetical protein +FIG00646917 FIG00646919: hypothetical protein +FIG00646919 FIG00646920: hypothetical protein +FIG00646921 FIG00646922: hypothetical protein +FIG00646923 FIG00646925: hypothetical protein +FIG00646926 FIG00646929: hypothetical protein +FIG00646939 FIG00646940: hypothetical protein +FIG00646945 FIG00646946: hypothetical protein +FIG00646947 FIG00646948: hypothetical protein +FIG00646949 FIG00646952: hypothetical protein +FIG00646953 FIG00646954: hypothetical protein +FIG00646955 FIG00646956: hypothetical protein +FIG00646956 Sporulation protein YtfJ +FIG00646958 Ferredoxin:(2Fe-2S)-binding +FIG00646959 FIG00646961: hypothetical protein +FIG00646961 FIG00646962: hypothetical protein +FIG00646962 large terminase subunit +FIG00646964 FIG00646965: hypothetical protein +FIG00646965 FIG00646967: hypothetical protein +FIG00646967 FIG00646970: hypothetical protein +FIG00646975 COG0561: Predicted hydrolases of the HAD superfamily +FIG00646977 FIG00646979: hypothetical protein +FIG00646979 FIG00646981: hypothetical protein +FIG00646983 FIG00646984: hypothetical protein +FIG00646984 FIG00646985: hypothetical protein +FIG00646986 FIG00646988: hypothetical protein +FIG00646991 FIG00646992: hypothetical protein +FIG00646992 FIG00646993: hypothetical protein +FIG00646993 FIG00646994: hypothetical protein +FIG00646995 FIG00646996: hypothetical protein +FIG00646999 FIG00647003: hypothetical protein +FIG00647003 FIG00647004: hypothetical protein +FIG00647005 FIG00647007: hypothetical protein +FIG00647008 FIG00647009: hypothetical protein +FIG00647011 FIG00647012: hypothetical protein +FIG00647013 uncharacterized small protein, homolog of Treponema (6136517) +FIG00647014 FIG00647015: hypothetical protein +FIG00647018 FIG00647019: hypothetical protein +FIG00647022 FIG137478: Hypothetical protein YbgI +FIG00647025 FIG00647026: hypothetical protein +FIG00647030 FIG00647031: hypothetical protein +FIG00647031 FIG00647032: hypothetical protein +FIG00647032 FIG00647033: hypothetical protein +FIG00647035 FIG00647036: hypothetical protein +FIG00647040 FIG00647041: hypothetical protein +FIG00647041 FIG00647042: hypothetical protein +FIG00647043 FIG00647045: hypothetical protein +FIG00647045 FIG00647046: hypothetical protein +FIG00647055 FIG00647057: hypothetical protein +FIG00647059 FIG00647060: hypothetical protein +FIG00647060 FIG00647062: hypothetical protein +FIG00647062 FIG00647063: hypothetical protein +FIG00647063 FIG00647064: hypothetical protein +FIG00647064 FIG00647067: hypothetical protein +FIG00647068 FIG00647069: hypothetical protein +FIG00647069 FIG00647071: hypothetical protein +FIG00647073 FIG00647074: hypothetical protein +FIG00647075 FIG00647078: hypothetical protein +FIG00647085 FIG00647088: hypothetical protein +FIG00647090 FIG00647092: hypothetical protein +FIG00647092 FIG00647093: hypothetical protein +FIG00647096 FIG00647097: hypothetical protein +FIG00647097 FIG00647098: hypothetical protein +FIG00647098 FIG00647099: hypothetical protein +FIG00647099 FIG00647100: hypothetical protein +FIG00647103 FIG00647104: hypothetical protein +FIG00647104 FIG00647105: hypothetical protein +FIG00647105 FIG00647106: hypothetical protein +FIG00647108 FIG00647109: hypothetical protein +FIG00647109 putative glycosyl transferase family 2 +FIG00647112 FIG00647115: hypothetical protein +FIG00647115 FIG00647116: hypothetical protein +FIG00647117 FIG00647119: hypothetical protein +FIG00647119 FIG00647120: hypothetical protein +FIG00647122 FIG00647123: hypothetical protein +FIG00647127 FIG00647128: hypothetical protein +FIG00647129 FIG00647130: hypothetical protein +FIG00647133 FIG00647134: hypothetical protein +FIG00647134 pseudouridine synthase, RluA family +FIG00647135 23S rRNA m1G745 methyltransferase RrmA( EC:2.1.1.51 ) +FIG00647136 FIG00647138: hypothetical protein +FIG00647139 FIG00647140: hypothetical protein +FIG00647140 FIG00647143: hypothetical protein +FIG00647148 FIG00647151: hypothetical protein +FIG00647152 FIG00647153: hypothetical protein +FIG00647157 ABC transporter ATP-binding/transmembrane protein +FIG00647158 FIG00523952: hypothetical protein +FIG00647164 FIG00647165: hypothetical protein +FIG00647166 FIG00647168: hypothetical protein +FIG00647169 FIG00647170: hypothetical protein +FIG00647170 FIG00647171: hypothetical protein +FIG00647172 FIG00647173: hypothetical protein +FIG00647174 FIG00647175: hypothetical protein +FIG00647176 peptidyl-prolyl cis-trans isomerase( EC:5.2.1.8 ) +FIG00647178 FIG00647179: hypothetical protein +FIG00647179 FIG00647180: hypothetical protein +FIG00647180 FIG00647182: hypothetical protein +FIG00647193 FIG00647194: hypothetical protein +FIG00647194 FIG00647195: hypothetical protein +FIG00647195 FIG00647196: hypothetical protein +FIG00647196 FIG00647197: hypothetical protein +FIG00647200 FIG00647201: hypothetical protein +FIG00647203 FIG00647204: hypothetical protein +FIG00647204 putative amino acid ABC transporter, ATP-binding protein +FIG00647214 FIG00647216: hypothetical protein +FIG00647222 Two Component Transcriptional Regulator, AraC family +FIG00647225 FIG00647226: hypothetical protein +FIG00647227 FIG00647230: hypothetical protein +FIG00647238 FIG00647240: hypothetical protein +FIG00647240 FIG00647241: hypothetical protein +FIG00647241 FIG00647242: hypothetical protein +FIG00647243 FIG00647246: hypothetical protein +FIG00647250 FIG00647251: hypothetical protein +FIG00647253 FIG00647254: hypothetical protein +FIG00647254 FIG00647255: hypothetical protein +FIG00647255 FIG00647257: hypothetical protein +FIG00647257 FIG00647258: hypothetical protein +FIG00647258 FIG00647261: hypothetical protein +FIG00647261 FIG00647262: hypothetical protein +FIG00647266 FIG00647269: hypothetical protein +FIG00647271 FIG00647273: hypothetical protein +FIG00647273 FIG00647274: hypothetical protein +FIG00647276 FIG00647277: hypothetical protein +FIG00647281 Ferric-uptake regulator +FIG00647282 FIG00647283: hypothetical protein +FIG00647284 FIG00647287: hypothetical protein +FIG00647288 FIG00647289: hypothetical protein +FIG00647290 FIG00647291: hypothetical protein +FIG00647292 FIG00647293: hypothetical protein +FIG00647297 FIG00647298: hypothetical protein +FIG00647299 FIG00647300: hypothetical protein +FIG00647301 FIG00647304: hypothetical protein +FIG00647304 FIG00647306: hypothetical protein +FIG00647307 FIG00647309: hypothetical protein +FIG00647311 FIG00647312: hypothetical protein +FIG00647320 FIG00647322: hypothetical protein +FIG00647330 FIG00647331: hypothetical protein +FIG00647331 FIG00647332: hypothetical protein +FIG00647379 FIG00647384: hypothetical protein +FIG00647440 Predicted galactoside ABC transporter type II, permease protein 2 +FIG00647505 Predicted galactoside ABC transporter type II, sugar-binding protein +FIG00647523 Polymerase/histidinol phosphatase +FIG00647773 Putative novel glycerol kinase, FGGY family +FIG00647977 electron transfer protein, putative +FIG00647981 FIG00648017: hypothetical protein +FIG00648019 CDP-abequose synthase +FIG00648045 conserved hypothetical protein TIGR00486 +FIG00648046 FIG00648047: hypothetical protein +FIG00648047 FIG00648048: hypothetical protein +FIG00648048 FIG00648049: hypothetical protein +FIG00648049 FIG00648050: hypothetical protein +FIG00648050 FIG00648051: hypothetical protein +FIG00648051 FIG00648052: hypothetical protein +FIG00648052 FIG00648053: hypothetical protein +FIG00648056 FIG00648057: hypothetical protein +FIG00648059 Streptomycin adenylyltransferase +FIG00648064 FIG00648065: hypothetical protein +FIG00648074 FIG00648076: hypothetical protein +FIG00648077 FIG00648079: hypothetical protein +FIG00648085 FIG00648086: hypothetical protein +FIG00648091 FIG00648092: hypothetical protein +FIG00648097 probable transcriptional regulator, AraC family +FIG00648099 FIG00648100: hypothetical protein +FIG00648103 FIG00648104: hypothetical protein +FIG00648104 FIG00648105: hypothetical protein +FIG00648105 FIG00648106: hypothetical protein +FIG00648106 FIG00648107: hypothetical protein +FIG00648107 FIG00648108: hypothetical protein +FIG00648109 FIG00648110: hypothetical protein +FIG00648110 Protein of unknown function DUF208 +FIG00648113 FIG00648116: hypothetical protein +FIG00648116 FIG00648117: hypothetical protein +FIG00648117 FIG00648118: hypothetical protein +FIG00648121 FIG00648122: hypothetical protein +FIG00648122 FIG00648124: hypothetical protein +FIG00648135 FIG00648136: hypothetical protein +FIG00648137 FIG00648139: hypothetical protein +FIG00648139 FIG00648140: hypothetical protein +FIG00648140 FIG00648142: hypothetical protein +FIG00648144 FIG00648145: hypothetical protein +FIG00648145 transcriptional antiterminator, bglG family +FIG00648146 FIG00648147: hypothetical protein +FIG00648151 FIG00648153: hypothetical protein +FIG00648153 FIG00648154: hypothetical protein +FIG00648154 FIG00648155: hypothetical protein +FIG00648155 FIG00648156: hypothetical protein +FIG00648156 ABC transporter, permease/ATP-binding protein +FIG00648157 FIG00648158: hypothetical protein +FIG00648161 FIG00648162: hypothetical protein +FIG00648163 FIG00648164: hypothetical protein +FIG00648169 FIG00648170: hypothetical protein +FIG00648171 FIG00648173: hypothetical protein +FIG00648173 FIG00648174: hypothetical protein +FIG00648180 FIG00648184: hypothetical protein +FIG00648184 FIG00648185: hypothetical protein +FIG00648185 FIG00648186: hypothetical protein +FIG00648186 ADP-ribosyl-(dinitrogen reductase) hydrolase( EC:3.2.2.24 ) +FIG00648188 FIG00648189: hypothetical protein +FIG00648189 FIG00648191: hypothetical protein +FIG00648191 related to 4-hydroxybenzoyl-CoA reductase (HcrB) ; probable nicotine dehydrogenase chain A +FIG00648194 FIG00648195: hypothetical protein +FIG00648198 FIG00648199: hypothetical protein +FIG00648199 FIG00648201: hypothetical protein +FIG00648211 modulator of DNA gyrase family protein +FIG00648212 FIG00648213: hypothetical protein +FIG00648214 FIG00648215: hypothetical protein +FIG00648216 FIG00648217: hypothetical protein +FIG00648217 FIG00648218: hypothetical protein +FIG00648219 FIG00648220: hypothetical protein +FIG00648227 FIG00648228: hypothetical protein +FIG00648228 FIG00648229: hypothetical protein +FIG00648229 FIG00648230: hypothetical protein +FIG00648232 FIG00648233: hypothetical protein +FIG00648233 FIG00648235: hypothetical protein +FIG00648236 FIG00648237: hypothetical protein +FIG00648237 MDR-type ABC transporter (membrane associated ATPase) +FIG00648238 FIG00648240: hypothetical protein +FIG00648240 FIG00648242: hypothetical protein +FIG00648244 FIG00648245: hypothetical protein +FIG00648246 FIG00648247: hypothetical protein +FIG00648247 FIG00648248: hypothetical protein +FIG00648248 Uncharacterized conserved protein, YTFE family +FIG00648254 FIG00648255: hypothetical protein +FIG00648255 FIG00648256: hypothetical protein +FIG00648256 FIG00648258: hypothetical protein +FIG00648258 FIG00648259: hypothetical protein +FIG00648259 FIG00648260: hypothetical protein +FIG00648260 FIG00648261: hypothetical protein +FIG00648261 FIG00648262: hypothetical protein +FIG00648262 FIG00648265: hypothetical protein +FIG00648265 FIG00648268: hypothetical protein +FIG00648268 FIG00648270: hypothetical protein +FIG00648270 FIG00648272: hypothetical protein +FIG00648273 FIG00648274: hypothetical protein +FIG00648274 FIG00648275: hypothetical protein +FIG00648275 FIG00648276: hypothetical protein +FIG00648276 FIG00648277: hypothetical protein +FIG00648278 FIG00648279: hypothetical protein +FIG00648289 FIG00648292: hypothetical protein +FIG00648295 FIG00648297: hypothetical protein +FIG00648297 FIG00648298: hypothetical protein +FIG00648298 FIG00648300: hypothetical protein +FIG00648301 FIG00648302: hypothetical protein +FIG00648302 FIG00648304: hypothetical protein +FIG00648304 FIG00648305: hypothetical protein +FIG00648307 FIG00648308: hypothetical protein +FIG00648308 FIG00648309: hypothetical protein +FIG00648309 FIG00648312: hypothetical protein +FIG00648312 FIG00648313: hypothetical protein +FIG00648333 FIG00648334: hypothetical protein +FIG00648334 FIG00648336: hypothetical protein +FIG00648338 FIG00648339: hypothetical protein +FIG00648339 FIG00648340: hypothetical protein +FIG00648340 FIG00648341: hypothetical protein +FIG00648341 FIG00648343: hypothetical protein +FIG00648343 FIG00648344: hypothetical protein +FIG00648344 FIG00648345: hypothetical protein +FIG00648346 FIG00648348: hypothetical protein +FIG00648348 FIG00648349: hypothetical protein +FIG00648349 FIG00648350: hypothetical protein +FIG00648352 GrdX protein +FIG00648355 FIG00648356: hypothetical protein +FIG00648363 FIG00648364: hypothetical protein +FIG00648364 FIG00648366: hypothetical protein +FIG00648371 putative transmembrane CAAX amino terminal protease family +FIG00648373 FIG00648375: hypothetical protein +FIG00648375 FIG00648376: hypothetical protein +FIG00648376 FIG00648379: hypothetical protein +FIG00648382 FIG00648383: hypothetical protein +FIG00648383 FIG00648384: hypothetical protein +FIG00648386 FIG00648387: hypothetical protein +FIG00648387 FIG00648388: hypothetical protein +FIG00648388 FIG00648389: hypothetical protein +FIG00648389 FIG00648390: hypothetical protein +FIG00648393 FIG00648394: hypothetical protein +FIG00648395 FIG00648396: hypothetical protein +FIG00648400 FIG00648401: hypothetical protein +FIG00648402 FIG00648403: hypothetical protein +FIG00648403 Iron-sulfur binding reductase +FIG00648406 FIG00648407: hypothetical protein +FIG00648408 FIG00648410: hypothetical protein +FIG00648415 FIG00648416: hypothetical protein +FIG00648416 FIG00648417: hypothetical protein +FIG00648417 FIG00648418: hypothetical protein +FIG00648420 FIG00648421: hypothetical protein +FIG00648423 FIG00648424: hypothetical protein +FIG00648424 FIG00648425: hypothetical protein +FIG00648425 FIG00648426: hypothetical protein +FIG00648426 FIG00648429: hypothetical protein +FIG00648429 FIG00648430: hypothetical protein +FIG00648435 FIG00648436: hypothetical protein +FIG00648436 FIG00648437: hypothetical protein +FIG00648438 FIG00648439: hypothetical protein +FIG00648440 FIG00648442: hypothetical protein +FIG00648442 FIG00648443: hypothetical protein +FIG00648443 FIG00648444: hypothetical protein +FIG00648447 Lipid carrier : UDP-N-acetylgalactosaminyltransferase (EC 2.4.1.-) +FIG00648449 FIG00648451: hypothetical protein +FIG00648452 FIG00648453: hypothetical protein +FIG00648454 FIG00648455: hypothetical protein +FIG00648457 FIG00648459: hypothetical protein +FIG00648459 FIG00648460: hypothetical protein +FIG00648461 FIG00648462: hypothetical protein +FIG00648463 FIG00648464: hypothetical protein +FIG00648465 degV family protein +FIG00648468 FIG00648469: hypothetical protein +FIG00648471 FIG00648472: hypothetical protein +FIG00648472 FIG00648473: hypothetical protein +FIG00648475 rRNA methylase +FIG00648476 FIG00648477: hypothetical protein +FIG00648481 FIG00648482: hypothetical protein +FIG00648482 FIG00648483: hypothetical protein +FIG00648485 FIG00648486: hypothetical protein +FIG00648486 FIG00648487: hypothetical protein +FIG00648487 FIG00648488: hypothetical protein +FIG00648490 Protein of unknown function DUF296 +FIG00648491 FIG00648492: hypothetical protein +FIG00648492 FIG00648493: hypothetical protein +FIG00648493 FIG00648494: hypothetical protein +FIG00648495 FIG00648496: hypothetical protein +FIG00648496 FIG00648497: hypothetical protein +FIG00648497 Bis(5'-nucleosyl)-tetraphosphatase (Asymmetrical) (EC 3.6.1.17) +FIG00648498 FIG00648500: hypothetical protein +FIG00648502 FIG00648503: hypothetical protein +FIG00648507 FIG00648509: hypothetical protein +FIG00648509 DUF1432 domain-containing protein +FIG00648512 FIG00648513: hypothetical protein +FIG00648516 FIG00648517: hypothetical protein +FIG00648523 FIG00648524: hypothetical protein +FIG00648524 FIG00648525: hypothetical protein +FIG00648526 FIG00648527: hypothetical protein +FIG00648528 FIG00520426: hypothetical protein +FIG00648531 FIG00648532: hypothetical protein +FIG00648533 FIG00648536: hypothetical protein +FIG00648540 FIG00648541: hypothetical protein +FIG00648541 FIG00648542: hypothetical protein +FIG00648543 Tagatose-6-phosphate kinase (EC 2.7.1.144) (Phosphotagatokinase) +FIG00648546 FIG00648547: hypothetical protein +FIG00648547 FIG00648549: hypothetical protein +FIG00648549 FIG00648550: hypothetical protein +FIG00648554 multidrug resistance ABC transporter, ATP-binding protein and permease +FIG00648556 Choloylglycine hydrolase (Bile salt hydrolase)( EC:3.5.1.24 ) +FIG00648558 FIG00648559: hypothetical protein +FIG00648562 FIG00648565: hypothetical protein +FIG00648565 FIG00648566: hypothetical protein +FIG00648566 FIG00648567: hypothetical protein +FIG00648567 FIG00648569: hypothetical protein +FIG00648572 FIG00648574: hypothetical protein +FIG00648574 FIG00648575: hypothetical protein +FIG00648575 FIG00648576: hypothetical protein +FIG00648578 FIG00648579: hypothetical protein +FIG00648579 FIG00648581: hypothetical protein +FIG00648584 FIG00648585: hypothetical protein +FIG00648588 FIG00648589: hypothetical protein +FIG00648589 SAM-dependent methyltransferase SCO3452 (UbiE paralog) +FIG00648592 thioredoxin-related +FIG00648604 FIG00648605: hypothetical protein +FIG00648606 Uncharacterized protein, homolog of gi|2274936 Eubacterium acidaminophilum +FIG00648607 FIG00648608: hypothetical protein +FIG00648608 FIG00648609: hypothetical protein +FIG00648609 FIG00648610: hypothetical protein +FIG00648611 FIG00648612: hypothetical protein +FIG00648612 Putative phosphohydrolase +FIG00648616 8-oxoguanine-DNA-glycosylase +FIG00648617 FIG00648618: hypothetical protein +FIG00648618 Hydroxymethylpyrimidine phosphate kinase ThiD (EC 2.7.4.7) +FIG00648619 FIG00648620: hypothetical protein +FIG00648620 FIG00648621: hypothetical protein +FIG00648622 ATP:guanido phosphotransferase family protein +FIG00648629 FIG00648631: hypothetical protein +FIG00648631 CarD-like transcriptional regulator +FIG00648639 FIG00648640: hypothetical protein +FIG00648640 FIG00648642: hypothetical protein +FIG00648644 FIG00648645: hypothetical protein +FIG00648650 FIG00648651: hypothetical protein +FIG00648651 FIG00648653: hypothetical protein +FIG00648655 FIG00648656: hypothetical protein +FIG00648660 FIG00648661: hypothetical protein +FIG00648662 FIG00648663: hypothetical protein +FIG00648669 FIG00648670: hypothetical protein +FIG00648671 FIG00648672: hypothetical protein +FIG00648672 FIG00648676: hypothetical protein +FIG00648682 FIG00648683: hypothetical protein +FIG00648685 FIG00648686: hypothetical protein +FIG00648687 FIG00648688: hypothetical protein +FIG00648688 FIG00648690: hypothetical protein +FIG00648691 FIG00648692: hypothetical protein +FIG00648692 probable electron transfer protein +FIG00648693 FIG00648694: hypothetical protein +FIG00648694 FIG00648695: hypothetical protein +FIG00648695 FIG00648696: hypothetical protein +FIG00648696 Hybrid cluster protein +FIG00648697 FIG00648698: hypothetical protein +FIG00648698 FIG00648699: hypothetical protein +FIG00648699 FIG00648700: hypothetical protein +FIG00648700 FIG00648701: hypothetical protein +FIG00648701 FIG00648702: hypothetical protein +FIG00648702 FIG00648704: hypothetical protein +FIG00648705 FIG00648706: hypothetical protein +FIG00648706 FIG00648708: hypothetical protein +FIG00648708 FIG00648711: hypothetical protein +FIG00648714 FIG00648715: hypothetical protein +FIG00648724 FIG00648725: hypothetical protein +FIG00648725 FIG00648726: hypothetical protein +FIG00648727 FIG00648729: hypothetical protein +FIG00648729 FIG00648732: hypothetical protein +FIG00648732 FIG00648733: hypothetical protein +FIG00648733 FIG00648734: hypothetical protein +FIG00648737 FIG00648738: hypothetical protein +FIG00648738 GatB/Yqey domain protein +FIG00648739 FIG00648740: hypothetical protein +FIG00648740 small multidrug export protein (QacE) +FIG00648746 pyridoxal phosphate-dependent enzyme +FIG00648747 FIG00648748: hypothetical protein +FIG00648748 FIG00648749: hypothetical protein +FIG00648749 FIG00648752: hypothetical protein +FIG00648754 FIG00648755: hypothetical protein +FIG00648756 FIG00648757: hypothetical protein +FIG00648759 FIG00648760: hypothetical protein +FIG00648760 thermonuclease( EC:3.1.31.1 ) +FIG00648761 FIG00648762: hypothetical protein +FIG00648764 FIG00648765: hypothetical protein +FIG00648765 FIG00648767: hypothetical protein +FIG00648767 FIG00648768: hypothetical protein +FIG00648768 FIG00648769: hypothetical protein +FIG00648769 FIG00648770: hypothetical protein +FIG00648773 FIG00648774: hypothetical protein +FIG00648777 FIG00648780: hypothetical protein +FIG00648796 FIG00648805: hypothetical protein +FIG00648805 FIG00648807: hypothetical protein +FIG00648807 FIG00648809: hypothetical protein +FIG00648816 FIG00648817: hypothetical protein +FIG00648825 FIG00648828: hypothetical protein +FIG00648830 FIG00648832: hypothetical protein +FIG00648843 FIG00648844: hypothetical protein +FIG00648844 FIG00648845: hypothetical protein +FIG00648845 FIG00648847: hypothetical protein +FIG00648847 FIG00648850: hypothetical protein +FIG00648851 FIG00648852: hypothetical protein +FIG00648852 FIG00648854: hypothetical protein +FIG00648865 FIG00648866: hypothetical protein +FIG00648866 FIG00648870: hypothetical protein +FIG00648870 FIG00648872: hypothetical protein +FIG00648880 glycosyl hydrolase, family 30 +FIG00648892 FIG00648894: hypothetical protein +FIG00648904 FIG00648907: hypothetical protein +FIG00648907 FIG00648908: hypothetical protein +FIG00648913 FIG00648915: hypothetical protein +FIG00648926 FIG00648930: hypothetical protein +FIG00648932 FIG00648934: hypothetical protein +FIG00648968 FIG00648969: hypothetical protein +FIG00648970 FIG00648971: hypothetical protein +FIG00648982 FIG00648984: hypothetical protein +FIG00648992 FIG00648993: hypothetical protein +FIG00648993 FIG00648996: hypothetical protein +FIG00648999 FIG00649004: hypothetical protein +FIG00649004 FIG00649007: hypothetical protein +FIG00649007 FIG00649008: hypothetical protein +FIG00649035 FIG00649036: hypothetical protein +FIG00649036 Alpha/beta hydrolase superfamily +FIG00649044 FIG00649047: hypothetical protein +FIG00649049 FIG00649050: hypothetical protein +FIG00649050 FIG00649054: hypothetical protein +FIG00649054 FIG00649055: hypothetical protein +FIG00649055 FIG00649061: hypothetical protein +FIG00649062 FIG00649063: hypothetical protein +FIG00649063 Outer membrane protein A +FIG00649065 FIG00649072: hypothetical protein +FIG00649072 FIG00649073: hypothetical protein +FIG00649079 FIG00649080: hypothetical protein +FIG00649082 FIG00649085: hypothetical protein +FIG00649085 FIG00649086: hypothetical protein +FIG00649086 Glycosyl hydrolase, BNR repeat precursor +FIG00649093 FIG00649096: hypothetical protein +FIG00649111 FIG170317: hypothetical protein +FIG00649125 FIG00649126: hypothetical protein +FIG00649129 FIG00649132: hypothetical protein +FIG00649132 FIG00649134: hypothetical protein +FIG00649134 FIG00649149: hypothetical protein +FIG00649149 FIG00649154: hypothetical protein +FIG00649154 FIG00649156: hypothetical protein +FIG00649156 FIG00649159: hypothetical protein +FIG00649172 FIG00649173: hypothetical protein +FIG00649180 FIG00649182: hypothetical protein +FIG00649185 FIG00649187: hypothetical protein +FIG00649187 FIG00649188: hypothetical protein +FIG00649190 FIG00649191: hypothetical protein +FIG00649191 FIG00649201: hypothetical protein +FIG00649201 FIG00649204: hypothetical protein +FIG00649217 FIG00649225: hypothetical protein +FIG00649225 FIG00649226: hypothetical protein +FIG00649234 FIG00649236: hypothetical protein +FIG00649242 FIG00649243: hypothetical protein +FIG00649245 FIG00649246: hypothetical protein +FIG00649246 FIG00649251: hypothetical protein +FIG00649258 FIG00649260: hypothetical protein +FIG00649282 Phosphoglycerate/bisphosphoglycerate mutase +FIG00649287 FIG00649292: hypothetical protein +FIG00649299 FIG00649306: hypothetical protein +FIG00649306 FIG00649307: hypothetical protein +FIG00649309 Thioesterase superfamily +FIG00649312 FIG00649317: hypothetical protein +FIG00649325 FIG00649326: hypothetical protein +FIG00649326 FIG00649340: hypothetical protein +FIG00649340 FIG00649341: hypothetical protein +FIG00649346 FIG00649348: hypothetical protein +FIG00649348 Phosphodiesterase/alkaline phosphatase D (EC 3.1.3.1) +FIG00649356 FIG00649359: hypothetical protein +FIG00649372 FIG00649374: hypothetical protein +FIG00649374 FIG00649378: hypothetical protein +FIG00649378 Possible heptosyltransferase +FIG00649386 FIG00649387: hypothetical protein +FIG00649400 FIG00649403: hypothetical protein +FIG00649416 FIG00649417: hypothetical protein +FIG00649417 FIG00649419: hypothetical protein +FIG00649432 FIG00649434: hypothetical protein +FIG00649434 FIG00649439: hypothetical protein +FIG00649439 FIG00649443: hypothetical protein +FIG00649448 FIG00649449: hypothetical protein +FIG00649460 FIG00649462: hypothetical protein +FIG00649462 FIG00649467: hypothetical protein +FIG00649475 Twin-arginine translocation pathway signal precursor +FIG00649482 FIG00649492: hypothetical protein +FIG00649497 FIG00649500: hypothetical protein +FIG00649511 FIG00649514: hypothetical protein +FIG00649532 FIG00649541: hypothetical protein +FIG00649547 FIG00649556: hypothetical protein +FIG00649556 FIG00649562: hypothetical protein +FIG00649574 FIG00649577: hypothetical protein +FIG00649577 FIG00649580: hypothetical protein +FIG00649581 FIG00649582: hypothetical protein +FIG00649582 FIG00649583: hypothetical protein +FIG00649583 FIG00649584: hypothetical protein +FIG00649589 FIG00649591: hypothetical protein +FIG00649592 FIG00649594: hypothetical protein +FIG00649624 FIG00649626: hypothetical protein +FIG00649626 FIG00649627: hypothetical protein +FIG00649630 FIG00649631: hypothetical protein +FIG00649647 FIG00649651: hypothetical protein +FIG00649652 FIG00649654: hypothetical protein +FIG00649656 N-formylkynurenine (Aryl-) formamidase (EC 3.5.1.9) +FIG00649660 FIG00649665: hypothetical protein +FIG00649665 FIG00649679: hypothetical protein +FIG00649683 FIG00649684: hypothetical protein +FIG00649704 FIG00649706: hypothetical protein +FIG00649709 FIG00649710: hypothetical protein +FIG00649716 FIG00649718: hypothetical protein +FIG00649744 FIG00649749: hypothetical protein +FIG00649755 FIG00649756: hypothetical protein +FIG00649757 FIG00649758: hypothetical protein +FIG00649758 FIG00649766: hypothetical protein +FIG00649783 FIG00649784: hypothetical protein +FIG00649797 FIG00649798: hypothetical protein +FIG00649798 FIG00649805: hypothetical protein +FIG00649805 FIG00649806: hypothetical protein +FIG00649842 FIG00649844: hypothetical protein +FIG00649844 FIG00649846: hypothetical protein +FIG00649863 FIG00649865: hypothetical protein +FIG00649865 FIG00649872: hypothetical protein +FIG00649872 liver stage antigen, putative +FIG00649874 Leucine aminopeptidase-related protein +FIG00649875 FIG00649878: hypothetical protein +FIG00649878 FIG00649879: hypothetical protein +FIG00649922 FIG00649927: hypothetical protein +FIG00649930 FIG00649935: hypothetical protein +FIG00649960 Calcium-binding protein +FIG00649964 FIG00649969: hypothetical protein +FIG00649969 FIG00649979: hypothetical protein +FIG00649979 FIG00649982: hypothetical protein +FIG00649982 FIG00649983: hypothetical protein +FIG00649983 FIG00649987: hypothetical protein +FIG00649994 FIG00649999: hypothetical protein +FIG00650007 FIG00650008: hypothetical protein +FIG00650047 FIG00650051: hypothetical protein +FIG00650063 FIG00650065: hypothetical protein +FIG00650065 FIG00650101: hypothetical protein +FIG00650101 FIG00650109: hypothetical protein +FIG00650122 FIG00650124: hypothetical protein +FIG00650146 FIG00650148: hypothetical protein +FIG00650153 FIG00650154: hypothetical protein +FIG00650154 FIG00650156: hypothetical protein +FIG00650156 FIG00650168: hypothetical protein +FIG00650173 FIG00650197: hypothetical protein +FIG00650199 FIG00650201: hypothetical protein +FIG00650205 FIG00650209: hypothetical protein +FIG00650209 FIG00650212: hypothetical protein +FIG00650213 FIG00650222: hypothetical protein +FIG00650228 FIG00650232: hypothetical protein +FIG00650232 Dipeptidyl peptidase VI +FIG00650233 FIG00650240: hypothetical protein +FIG00650262 FIG00650265: hypothetical protein +FIG00650272 FIG00650277: hypothetical protein +FIG00650289 FIG00650290: hypothetical protein +FIG00650300 FIG00650312: hypothetical protein +FIG00650314 FIG00650334: hypothetical protein +FIG00650336 FIG00650346: hypothetical protein +FIG00650349 FIG00650353: hypothetical protein +FIG00650379 FIG00650386: hypothetical protein +FIG00650386 FIG00650387: hypothetical protein +FIG00650393 FIG00650394: hypothetical protein +FIG00650415 FIG00650427: hypothetical protein +FIG00650427 FIG00650431: hypothetical protein +FIG00650456 FIG00650468: hypothetical protein +FIG00650478 FIG00650479: hypothetical protein +FIG00650546 putative: Cytochrome c oxidase subunit CcoQ (EC 1.9.3.1) +FIG00650565 FIG00650567: hypothetical protein +FIG00650577 FIG00651956: hypothetical protein +FIG00650579 FIG00650585: hypothetical protein +FIG00650585 FIG00650586: hypothetical protein +FIG00650586 FIG00650592: hypothetical protein +FIG00650592 FIG00650610: hypothetical protein +FIG00650614 FIG00650618: hypothetical protein +FIG00650630 cytochrome cbb3 oxidase maturation protein CcoH +FIG00650645 FIG00650647: hypothetical protein +FIG00650647 FIG00650653: hypothetical protein +FIG00650668 FIG00650675: hypothetical protein +FIG00650675 FIG00650676: hypothetical protein +FIG00650690 FIG00650697: hypothetical protein +FIG00650730 FIG00650732: hypothetical protein +FIG00650732 FIG00650734: hypothetical protein +FIG00650742 putative universal stress protein UspA +FIG00650764 FIG00650767: hypothetical protein +FIG00650790 FIG00650806: hypothetical protein +FIG00650846 FIG00650847: hypothetical protein +FIG00650847 FIG00650854: hypothetical protein +FIG00650856 FIG00935740: hypothetical protein +FIG00650860 EAL/GGDEF/PAS domain protein +FIG00650889 FIG00650892: hypothetical protein +FIG00650924 FIG00650925: hypothetical protein +FIG00650936 FIG00650941: hypothetical protein +FIG00650941 FIG00650944: hypothetical protein +FIG00651027 FIG00651036: hypothetical protein +FIG00651095 FIG00651097: hypothetical protein +FIG00651097 FIG00651111: hypothetical protein +FIG00651111 FIG00651127: hypothetical protein +FIG00651179 FIG00651180: hypothetical protein +FIG00651195 FIG00651212: hypothetical protein +FIG00651241 FIG00651242: hypothetical protein +FIG00651242 FIG00651253: hypothetical protein +FIG00651313 FIG00651316: hypothetical protein +FIG00651320 Thioredoxin disulfide isomerase +FIG00651329 FIG00651335: hypothetical protein +FIG00651337 FIG00651353: hypothetical protein +FIG00651395 FIG00651415: hypothetical protein +FIG00651452 SclB protein +FIG00651485 Gll2767 protein +FIG00651489 FIG00651490: hypothetical protein +FIG00651497 Ankyrin 1 +FIG00651504 FIG00651507: hypothetical protein +FIG00651544 FIG00651548: hypothetical protein +FIG00651556 FIG00651573: hypothetical protein +FIG00651575 FIG00651588: hypothetical protein +FIG00651588 Lipid IVA 3-deoxy-D-manno-octulosonic acid transferase (EC 2.4.99.12) [often with (EC 2.4.99.13) also] +FIG00651651 FIG00651652: hypothetical protein +FIG00651706 FIG00651711: hypothetical protein +FIG00651722 FIG00651728: hypothetical protein +FIG00651750 FIG00651751: hypothetical protein +FIG00651756 FIG00651759: hypothetical protein +FIG00651761 FIG01018965: hypothetical protein +FIG00651769 FIG00651772: hypothetical protein +FIG00651774 FIG00651775: hypothetical protein +FIG00651775 FIG00651784: hypothetical protein +FIG00651792 FIG00651795: hypothetical protein +FIG00651795 FIG00651796: hypothetical protein +FIG00651796 FIG00651798: hypothetical protein +FIG00651803 FIG00651808: hypothetical protein +FIG00651808 FIG00651809: hypothetical protein +FIG00651809 FIG00651810: hypothetical protein +FIG00651810 FIG00651812: hypothetical protein +FIG00651812 FIG00651816: hypothetical protein +FIG00651816 FIG00651817: hypothetical protein +FIG00651817 FIG00651819: hypothetical protein +FIG00651819 FIG00651820: hypothetical protein +FIG00651820 FIG00651823: hypothetical protein +FIG00651823 FIG00651824: hypothetical protein +FIG00651824 FIG00651828: hypothetical protein +FIG00651828 FIG00651829: hypothetical protein +FIG00651830 FIG00651831: hypothetical protein +FIG00651831 FIG00651832: hypothetical protein +FIG00651832 FIG00651833: hypothetical protein +FIG00651833 FIG00651834: hypothetical protein +FIG00651834 FIG00651837: hypothetical protein +FIG00651837 FIG00651843: hypothetical protein +FIG00651843 FIG00651847: hypothetical protein +FIG00651847 FIG00651849: hypothetical protein +FIG00651849 FIG00651850: hypothetical protein +FIG00651850 FIG00651851: hypothetical protein +FIG00651851 FIG01018923: hypothetical protein +FIG00651855 FIG00651861: hypothetical protein +FIG00651863 FIG00651865: hypothetical protein +FIG00651865 FIG00651869: hypothetical protein +FIG00651869 FIG00651871: hypothetical protein +FIG00651871 FIG00651877: hypothetical protein +FIG00651879 FIG00651883: hypothetical protein +FIG00651889 FIG00651891: hypothetical protein +FIG00651891 FIG00651893: hypothetical protein +FIG00651896 3-beta hydroxysteroid dehydrogenase/isomerase family protein +FIG00651898 FIG00651902: hypothetical protein +FIG00651903 FIG00651910: hypothetical protein +FIG00651910 FIG00651911: hypothetical protein +FIG00651911 Putative nucleoside transporter yegT +FIG00651916 FIG00651918: hypothetical protein +FIG00651918 FIG00651920: hypothetical protein +FIG00651920 FIG00651922: hypothetical protein +FIG00651922 CpsF +FIG00651924 FIG00651925: hypothetical protein +FIG00651925 FIG00651926: hypothetical protein +FIG00651930 FIG00651931: hypothetical protein +FIG00651931 L-alanyl-gamma-D-glutamyl-L-diamino acid endopeptidase +FIG00651935 FIG00651936: hypothetical protein +FIG00651936 FIG00651937: hypothetical protein +FIG00651937 FIG00651938: hypothetical protein +FIG00651938 FIG00651946: hypothetical protein +FIG00651946 FIG00651948: hypothetical protein +FIG00651949 FIG00651950: hypothetical protein +FIG00651950 FIG00651954: hypothetical protein +FIG00651956 FIG00651957: hypothetical protein +FIG00651957 FIG00651958: hypothetical protein +FIG00651958 FIG00651960: hypothetical protein +FIG00651960 FIG00651961: hypothetical protein +FIG00651963 FIG00651965: hypothetical protein +FIG00651965 FIG00651968: hypothetical protein +FIG00651969 FIG00651970: hypothetical protein +FIG00651974 FIG00654436: hypothetical protein +FIG00651978 FIG00651979: hypothetical protein +FIG00651979 DNA-binding response regulator/sensor histidine kinase +FIG00651982 FIG00651985: hypothetical protein +FIG00651985 FIG00651987: hypothetical protein +FIG00651987 FIG00651988: hypothetical protein +FIG00651988 FIG00651989: hypothetical protein +FIG00651989 FIG00651993: hypothetical protein +FIG00651997 FIG00652000: hypothetical protein +FIG00652000 FIG00652002: hypothetical protein +FIG00652002 FIG00652007: hypothetical protein +FIG00652009 FIG00652010: hypothetical protein +FIG00652013 FIG00652014: hypothetical protein +FIG00652014 FIG00652016: hypothetical protein +FIG00652016 FIG00652019: hypothetical protein +FIG00652028 FIG00652029: hypothetical protein +FIG00652029 FIG00652032: hypothetical protein +FIG00652040 FIG00652041: hypothetical protein +FIG00652046 FIG00652051: hypothetical protein +FIG00652051 FIG00652054: hypothetical protein +FIG00652058 FIG00652060: hypothetical protein +FIG00652060 FIG00652062: hypothetical protein +FIG00652062 FIG00652070: hypothetical protein +FIG00652070 FIG00652073: hypothetical protein +FIG00652075 FIG00652078: hypothetical protein +FIG00652078 FIG00652079: hypothetical protein +FIG00652079 FIG00652081: hypothetical protein +FIG00652081 FIG00652085: hypothetical protein +FIG00652086 FIG00652090: hypothetical protein +FIG00652091 FIG00652092: hypothetical protein +FIG00652092 Endo-beta-1,3-glucanase precursor +FIG00652095 FIG00652096: hypothetical protein +FIG00652096 FIG00652097: hypothetical protein +FIG00652097 FIG00652098: hypothetical protein +FIG00652098 FIG00652099: hypothetical protein +FIG00652102 D-aminopeptidase (EC 3.4.11.19) +FIG00652103 FIG00652105: hypothetical protein +FIG00652113 FIG00652114: hypothetical protein +FIG00652114 FIG00652115: hypothetical protein +FIG00652115 FIG00652119: hypothetical protein +FIG00652119 FIG00652121: hypothetical protein +FIG00652122 FIG00652123: hypothetical protein +FIG00652123 FIG00652124: hypothetical protein +FIG00652124 FIG00652129: hypothetical protein +FIG00652129 FIG00652135: hypothetical protein +FIG00652139 Probable sulfatase atsG (EC 3.1.6.-) +FIG00652144 FIG00652146: hypothetical protein +FIG00652146 FIG00652148: hypothetical protein +FIG00652151 FIG00652152: hypothetical protein +FIG00652152 FIG00652153: hypothetical protein +FIG00652153 Similar to coenzyme PQQ synthesis protein B +FIG00652157 FIG00652158: hypothetical protein +FIG00652162 FIG00652163: hypothetical protein +FIG00652163 FIG00652167: hypothetical protein +FIG00652167 FIG00652178: hypothetical protein +FIG00652178 FIG00652179: hypothetical protein +FIG00652179 FIG00652180: hypothetical protein +FIG00652180 FIG00652188: hypothetical protein +FIG00652198 FIG00652203: hypothetical protein +FIG00652207 FIG00652208: hypothetical protein +FIG00652209 FIG00652210: hypothetical protein +FIG00652211 FIG00652212: hypothetical protein +FIG00652212 FIG00652213: hypothetical protein +FIG00652213 FIG00652219: hypothetical protein +FIG00652219 FIG00652222: hypothetical protein +FIG00652222 FIG00652225: hypothetical protein +FIG00652225 FIG00652231: hypothetical protein +FIG00652234 FIG00652237: hypothetical protein +FIG00652237 FIG01019282: hypothetical protein +FIG00652241 FIG00652242: hypothetical protein +FIG00652242 FIG00652247: hypothetical protein +FIG00652247 FIG00652253: hypothetical protein +FIG00652253 FIG00652254: hypothetical protein +FIG00652254 FIG00652261: hypothetical protein +FIG00652261 FIG00652266: hypothetical protein +FIG00652267 FIG00652269: hypothetical protein +FIG00652269 FIG00652270: hypothetical protein +FIG00652270 FIG00652271: hypothetical protein +FIG00652271 FIG00652275: hypothetical protein +FIG00652275 FIG00652276: hypothetical protein +FIG00652277 Probable arylsulfate sulfotransferase +FIG00652280 FIG00652282: hypothetical protein +FIG00652284 FIG00652286: hypothetical protein +FIG00652286 FIG00652288: hypothetical protein +FIG00652288 FIG00652289: hypothetical protein +FIG00652289 FIG00652290: hypothetical protein +FIG00652290 FIG00652291: hypothetical protein +FIG00652291 FIG00652294: hypothetical protein +FIG00652294 FIG00652295: hypothetical protein +FIG00652300 FIG00652304: hypothetical protein +FIG00652309 FIG00652311: hypothetical protein +FIG00652311 FIG00652314: hypothetical protein +FIG00652314 FIG00652326: hypothetical protein +FIG00652326 FIG00652330: hypothetical protein +FIG00652330 FIG01018917: hypothetical protein +FIG00652336 FIG00652340: hypothetical protein +FIG00652341 FIG00652342: hypothetical protein +FIG00652342 FIG00652343: hypothetical protein +FIG00652344 FIG00652346: hypothetical protein +FIG00652346 FIG00652349: hypothetical protein +FIG00652350 FIG00652352: hypothetical protein +FIG00652352 FIG00652353: hypothetical protein +FIG00652353 FIG00652355: hypothetical protein +FIG00652355 FIG00652356: hypothetical protein +FIG00652356 Bll6474 protein +FIG00652358 FIG00652360: hypothetical protein +FIG00652367 FIG00652368: hypothetical protein +FIG00652368 FIG00652373: hypothetical protein +FIG00652373 FIG00652375: hypothetical protein +FIG00652375 FIG00652378: hypothetical protein +FIG00652378 FIG00652380: hypothetical protein +FIG00652380 FIG00652384: hypothetical protein +FIG00652384 FIG00652385: hypothetical protein +FIG00652385 FIG00652388: hypothetical protein +FIG00652390 FIG00652391: hypothetical protein +FIG00652391 FIG00930353: hypothetical protein +FIG00652392 FIG00652395: hypothetical protein +FIG00652395 FIG00652396: hypothetical protein +FIG00652396 FIG00652398: hypothetical protein +FIG00652398 FIG00652403: hypothetical protein +FIG00652403 FIG00652404: hypothetical protein +FIG00652404 FIG00652408: hypothetical protein +FIG00652408 FIG00652412: hypothetical protein +FIG00652412 FIG00652414: hypothetical protein +FIG00652414 FIG00652416: hypothetical protein +FIG00652422 FIG00652424: hypothetical protein +FIG00652424 FIG00652433: hypothetical protein +FIG00652433 FIG00652434: hypothetical protein +FIG00652434 FIG00652436: hypothetical protein +FIG00652438 FIG00652439: hypothetical protein +FIG00652439 FIG00652440: hypothetical protein +FIG00652455 FIG00652462: hypothetical protein +FIG00652462 FIG00652463: hypothetical protein +FIG00652466 FIG00652467: hypothetical protein +FIG00652467 FIG00652471: hypothetical protein +FIG00652471 FIG00652474: hypothetical protein +FIG00652474 FIG00652478: hypothetical protein +FIG00652478 FIG00652479: hypothetical protein +FIG00652481 FIG00652487: hypothetical protein +FIG00652487 FIG00652488: hypothetical protein +FIG00652488 FIG00652492: hypothetical protein +FIG00652492 putative MarR-family regulatory protein +FIG00652494 FIG00652495: hypothetical protein +FIG00652495 FIG00652502: hypothetical protein +FIG00652504 FIG00652505: hypothetical protein +FIG00652506 FIG00652507: hypothetical protein +FIG00652507 FIG00652511: hypothetical protein +FIG00652513 FIG00652518: hypothetical protein +FIG00652519 FIG00652521: hypothetical protein +FIG00652521 FIG00652522: hypothetical protein +FIG00652522 FIG00652523: hypothetical protein +FIG00652523 FIG00652524: hypothetical protein +FIG00652532 FIG00652537: hypothetical protein +FIG00652540 FIG00652545: hypothetical protein +FIG00652545 FIG00652549: hypothetical protein +FIG00652553 FIG00652554: hypothetical protein +FIG00652554 FIG00652556: hypothetical protein +FIG00652557 FIG00652558: hypothetical protein +FIG00652558 FIG00652567: hypothetical protein +FIG00652571 FIG00652572: hypothetical protein +FIG00652572 probable cytochrome c precursor +FIG00652575 FIG00652577: hypothetical protein +FIG00652577 FIG00652578: hypothetical protein +FIG00652587 FIG00652590: hypothetical protein +FIG00652591 FIG00652592: hypothetical protein +FIG00652592 FIG00652596: hypothetical protein +FIG00652596 FIG00652598: hypothetical protein +FIG00652598 FIG00652599: hypothetical protein +FIG00652599 FIG00652601: hypothetical protein +FIG00652601 FIG00652603: hypothetical protein +FIG00652611 FIG00652613: hypothetical protein +FIG00652613 FIG00652615: hypothetical protein +FIG00652615 X-pro dipeptidyl-peptidase (EC 3.4.14.11) +FIG00652616 FIG00652621: hypothetical protein +FIG00652621 FIG00652622: hypothetical protein +FIG00652622 FIG00652623: hypothetical protein +FIG00652624 Bsl7504 protein +FIG00652627 FIG00652628: hypothetical protein +FIG00652628 FIG00652631: hypothetical protein +FIG00652631 FIG00652634: hypothetical protein +FIG00652636 FIG00652637: hypothetical protein +FIG00652647 FIG00652648: hypothetical protein +FIG00652648 FIG00652649: hypothetical protein +FIG00652649 FIG00652650: hypothetical protein +FIG00652653 FIG00652655: hypothetical protein +FIG00652655 FIG00652660: hypothetical protein +FIG00652664 FIG00652665: hypothetical protein +FIG00652665 FIG00652669: hypothetical protein +FIG00652669 FIG00652671: hypothetical protein +FIG00652671 FIG00652672: hypothetical protein +FIG00652672 FIG00652673: hypothetical protein +FIG00652673 FIG00652678: hypothetical protein +FIG00652678 FIG00652682: hypothetical protein +FIG00652682 FIG00652683: hypothetical protein +FIG00652683 FIG00652686: hypothetical protein +FIG00652686 FIG00652688: hypothetical protein +FIG00652688 FIG00652690: hypothetical protein +FIG00652690 conserved hypothetical protein-putative membrane lipoprotein +FIG00652693 FIG00652694: hypothetical protein +FIG00652698 FIG00652700: hypothetical protein +FIG00652700 FIG00652702: hypothetical protein +FIG00652702 FIG00652704: hypothetical protein +FIG00652706 FIG00652707: hypothetical protein +FIG00652707 secreted protein containing PHP domain-likely a phosphoesterase +FIG00652709 FIG00652711: hypothetical protein +FIG00652711 FIG00652712: hypothetical protein +FIG00652712 FIG00652713: hypothetical protein +FIG00652714 FIG00652716: hypothetical protein +FIG00652716 FIG00652719: hypothetical protein +FIG00652719 FIG00652722: hypothetical protein +FIG00652724 FIG00652725: hypothetical protein +FIG00652727 FIG00652730: hypothetical protein +FIG00652733 FIG00652748: hypothetical protein +FIG00652748 FIG00652751: hypothetical protein +FIG00652752 FIG00652754: hypothetical protein +FIG00652754 FIG00652755: hypothetical protein +FIG00652755 Erythrocyte binding protein 3 +FIG00652757 FIG00652759: hypothetical protein +FIG00652759 Phosphoglycerol transferase and related proteins,alkaline phosphatase superfamily (EC 2.7.8.20) +FIG00652768 FIG00652771: hypothetical protein +FIG00652772 FIG00652774: hypothetical protein +FIG00652774 FIG00652775: hypothetical protein +FIG00652775 FIG00652778: hypothetical protein +FIG00652778 FIG00652781: hypothetical protein +FIG00652783 FIG00652786: hypothetical protein +FIG00652786 FIG00652788: hypothetical protein +FIG00652788 FIG00652795: hypothetical protein +FIG00652795 FIG00652796: hypothetical protein +FIG00652796 FIG00652797: hypothetical protein +FIG00652797 FIG00652799: hypothetical protein +FIG00652799 FIG00652803: hypothetical protein +FIG00652803 conserved protein of unknown function +FIG00652804 FIG00652807: hypothetical protein +FIG00652807 FIG00652811: hypothetical protein +FIG00652811 FIG00652813: hypothetical protein +FIG00652813 FIG00652814: hypothetical protein +FIG00652814 FIG00652816: hypothetical protein +FIG00652816 FIG00652825: hypothetical protein +FIG00652825 FIG00652828: hypothetical protein +FIG00652828 FIG00652833: hypothetical protein +FIG00652834 FIG00652836: hypothetical protein +FIG00652836 Na-K-Cl cotransporter +FIG00652841 FIG00652851: hypothetical protein +FIG00652851 FIG00652856: hypothetical protein +FIG00652856 FIG00652857: hypothetical protein +FIG00652872 protein containing tetratricopeptide repeats +FIG00652874 FIG00652875: hypothetical protein +FIG00652879 FIG00652885: hypothetical protein +FIG00652885 FIG00652892: hypothetical protein +FIG00652892 FIG00652896: hypothetical protein +FIG00652898 Probable transcription regulator, MerR family +FIG00652899 FIG00652900: hypothetical protein +FIG00652900 FIG00652902: hypothetical protein +FIG00652902 FIG00652905: hypothetical protein +FIG00652908 FIG00652918: hypothetical protein +FIG00652918 lipase, putative esterase +FIG00652921 putative gualylate cyclase protein +FIG00652925 FIG00652927: hypothetical protein +FIG00652936 FIG00652940: hypothetical protein +FIG00652940 conserved hypothetical protein, membrane (DUF395) +FIG00652949 FIG00652950: hypothetical protein +FIG00652950 FIG00652951: hypothetical protein +FIG00652951 FIG00652954: hypothetical protein +FIG00652954 FIG00652959: hypothetical protein +FIG00652959 FIG00652964: hypothetical protein +FIG00652964 FIG00652965: hypothetical protein +FIG00652968 FIG00652971: hypothetical protein +FIG00652971 FIG00652972: hypothetical protein +FIG00652972 FIG00652973: hypothetical protein +FIG00652973 FIG00652981: hypothetical protein +FIG00652981 FIG00652982: hypothetical protein +FIG00652982 FIG00652994: hypothetical protein +FIG00652994 FIG00653000: hypothetical protein +FIG00653003 FIG00653004: hypothetical protein +FIG00653004 FIG00653005: hypothetical protein +FIG00653005 FIG00653006: hypothetical protein +FIG00653006 FIG00653007: hypothetical protein +FIG00653007 FIG00653008: hypothetical protein +FIG00653008 FIG00653009: hypothetical protein +FIG00653012 FIG00653014: hypothetical protein +FIG00653014 FIG00653015: hypothetical protein +FIG00653015 DNA-directed RNA polymerase specialized sigma subunits, sigma24 homologs +FIG00653017 FIG00653027: hypothetical protein +FIG00653027 FIG00653028: hypothetical protein +FIG00653028 FIG00653032: hypothetical protein +FIG00653032 FIG00653035: hypothetical protein +FIG00653035 putative AraC-family regulatory protein +FIG00653041 FIG00653042: hypothetical protein +FIG00653042 FIG00653044: hypothetical protein +FIG00653044 FIG00653045: hypothetical protein +FIG00653045 Sec-independent protein translocase protein TatE, putative +FIG00653047 FIG00653052: hypothetical protein +FIG00653052 FIG00653053: hypothetical protein +FIG00653053 MGC79502 protein +FIG00653059 FIG00655051: hypothetical protein +FIG00653061 FIG00653064: hypothetical protein +FIG00653064 FIG00653065: hypothetical protein +FIG00653065 FIG00653066: hypothetical protein +FIG00653066 FIG00653067: hypothetical protein +FIG00653073 FIG00653075: hypothetical protein +FIG00653082 FIG00653083: hypothetical protein +FIG00653083 FIG00653084: hypothetical protein +FIG00653084 FIG00653086: hypothetical protein +FIG00653086 Two-component response regulator of nitrate reduction +FIG00653088 FIG00653093: hypothetical protein +FIG00653093 Probable CPS biosynthesis glycosyltransferase (EC 2.7.-.-) +FIG00653096 FIG00653097: hypothetical protein +FIG00653097 FIG00653100: hypothetical protein +FIG00653100 FIG00653103: hypothetical protein +FIG00653108 FIG00653109: hypothetical protein +FIG00653109 FIG00653113: hypothetical protein +FIG00653113 FIG00653121: hypothetical protein +FIG00653121 FIG00653124: hypothetical protein +FIG00653124 putative oxidoreductase/dehydrogenase +FIG00653131 FIG00653132: hypothetical protein +FIG00653132 FIG00653133: hypothetical protein +FIG00653133 FIG00653136: hypothetical protein +FIG00653137 FIG00653138: hypothetical protein +FIG00653138 FIG00653139: hypothetical protein +FIG00653139 FIG00653141: hypothetical protein +FIG00653144 FIG00653146: hypothetical protein +FIG00653146 FIG00653150: hypothetical protein +FIG00653154 FIG00653155: hypothetical protein +FIG00653155 FIG00653157: hypothetical protein +FIG00653157 FIG00653159: hypothetical protein +FIG00653159 FIG00653161: hypothetical protein +FIG00653161 FIG00653164: hypothetical protein +FIG00653164 FIG00653170: hypothetical protein +FIG00653175 FIG00653186: hypothetical protein +FIG00653186 FIG00653191: hypothetical protein +FIG00653193 FIG00653198: hypothetical protein +FIG00653198 Rhodanese-like precursor +FIG00653199 FIG00653200: hypothetical protein +FIG00653200 FIG00653203: hypothetical protein +FIG00653203 FIG00653217: hypothetical protein +FIG00653220 Nitrogen regulation protein NtrY +FIG00653222 FIG00653234: hypothetical protein +FIG00653234 FIG00653236: hypothetical protein +FIG00653236 universal stress protein +FIG00653245 FIG00653249: hypothetical protein +FIG00653249 FIG00653250: hypothetical protein +FIG00653250 FIG00653251: hypothetical protein +FIG00653255 FIG00653261: hypothetical protein +FIG00653266 FIG00653267: hypothetical protein +FIG00653271 FIG00653272: hypothetical protein +FIG00653272 FIG00653273: hypothetical protein +FIG00653273 FIG00653275: hypothetical protein +FIG00653275 chromate transporter, chromate ion transporter (CHR) family +FIG00653283 FIG00653285: hypothetical protein +FIG00653287 FIG00653288: hypothetical protein +FIG00653288 FIG00653290: hypothetical protein +FIG00653290 FIG00653304: hypothetical protein +FIG00653304 FIG00653306: hypothetical protein +FIG00653306 FIG00653309: hypothetical protein +FIG00653309 FIG00653313: hypothetical protein +FIG00653313 FIG00653315: hypothetical protein +FIG00653315 FIG00653318: hypothetical protein +FIG00653318 FIG00653321: hypothetical protein +FIG00653321 FIG00653326: hypothetical protein +FIG00653326 FIG00653327: hypothetical protein +FIG00653328 FIG00653330: hypothetical protein +FIG00653330 FIG00653339: hypothetical protein +FIG00653339 FIG00653340: hypothetical protein +FIG00653355 FIG00653357: hypothetical protein +FIG00653357 FIG00653358: hypothetical protein +FIG00653358 FIG00653360: hypothetical protein +FIG00653360 FIG00653361: hypothetical protein +FIG00653361 FIG00653364: hypothetical protein +FIG00653364 FIG00653367: hypothetical protein +FIG00653367 FIG00653369: hypothetical protein +FIG00653386 FIG00652157: hypothetical protein +FIG00653400 FIG00653406: hypothetical protein +FIG00653415 FIG00653420: hypothetical protein +FIG00653425 FIG00653426: hypothetical protein +FIG00653430 FIG00653431: hypothetical protein +FIG00653434 FIG00656682: hypothetical protein +FIG00653458 NifU-like domain +FIG00653468 FIG00652504: hypothetical protein +FIG00653481 FIG00653483: hypothetical protein +FIG00653484 FIG00653491: hypothetical protein +FIG00653491 dextranase precursor +FIG00653502 FIG00652936: hypothetical protein +FIG00653506 FIG00653508: hypothetical protein +FIG00653510 FIG00653512: hypothetical protein +FIG00653513 FIG00653516: hypothetical protein +FIG00653516 FIG00651863: hypothetical protein +FIG00653562 FIG00653563: hypothetical protein +FIG00653570 Sensory transduction histidine kinase precursor (EC 2.7.3.-) +FIG00653576 FIG00653582: hypothetical protein +FIG00653605 FIG00653606: hypothetical protein +FIG00653606 FIG00650146: hypothetical protein +FIG00653614 FIG00653626: hypothetical protein +FIG00653627 cytochrome cbb3 oxidase maturation protein CcoH +FIG00653635 FIG00653638: hypothetical protein +FIG00653647 FIG00653651: hypothetical protein +FIG00653664 FIG00652540: hypothetical protein +FIG00653667 FIG00653669: hypothetical protein +FIG00653675 FIG00653676: hypothetical protein +FIG00653678 FIG00653679: hypothetical protein +FIG00653682 FIG00653685: hypothetical protein +FIG00653690 arabinosidase +FIG00653700 Endo-1,3-beta-glucanase +FIG00653714 FIG00653715: hypothetical protein +FIG00653722 FIG00653723: hypothetical protein +FIG00653725 FIG00653727: hypothetical protein +FIG00653727 Sialic acid-specific 9-O-acetylesterase +FIG00653773 FIG00653775: hypothetical protein +FIG00653780 FIG00653783: hypothetical protein +FIG00653783 Metalloprotease MEP2 +FIG00653786 FIG00653791: hypothetical protein +FIG00653799 FIG00653801: hypothetical protein +FIG00653801 FIG00653802: hypothetical protein +FIG00653823 FIG00653829: hypothetical protein +FIG00653851 FIG00653853: hypothetical protein +FIG00653865 FIG00652455: hypothetical protein +FIG00653868 FIG00653872: hypothetical protein +FIG00653880 FIG00653882: hypothetical protein +FIG00653909 FIG00651997: hypothetical protein +FIG00653930 FIG00653932: hypothetical protein +FIG00653954 FIG00653968: hypothetical protein +FIG00653968 FIG00652714: hypothetical protein +FIG00653973 FIG00652698: hypothetical protein +FIG00653981 Glucan endo-1,3-beta-glucosidase A1 precursor (EC 3.2.1.39) ((1->3)-beta-glucan endohydrolase) ((1->3)-beta-glucanase A1) +FIG00654008 FIG00654010: hypothetical protein +FIG00654016 FIG00654018: hypothetical protein +FIG00654018 FIG00653137: hypothetical protein +FIG00654021 FIG00654025: hypothetical protein +FIG00654035 FIG00654036: hypothetical protein +FIG00654039 Putative periplasmic protein-TrxB +FIG00654056 Predicted ATP-binding protein involved in virulence +FIG00654066 FIG00654068: hypothetical protein +FIG00654068 FIG00654073: hypothetical protein +FIG00654073 FIG00654088: hypothetical protein +FIG00654089 FIG00654093: hypothetical protein +FIG00654093 FIG00654095: hypothetical protein +FIG00654122 FIG00654124: hypothetical protein +FIG00654132 FIG00654134: hypothetical protein +FIG00654137 FIG00930071: hypothetical protein +FIG00654156 FIG00654159: hypothetical protein +FIG00654174 FIG00654178: hypothetical protein +FIG00654189 FIG00654190: hypothetical protein +FIG00654190 FIG00654191: hypothetical protein +FIG00654195 possible sensor for regulator EvgA( EC:2.7.3.- ) +FIG00654214 FIG00654216: hypothetical protein +FIG00654226 FIG00654230: hypothetical protein +FIG00654235 FIG00654239: hypothetical protein +FIG00654241 FIG01121394: hypothetical protein +FIG00654245 FIG00654249: hypothetical protein +FIG00654252 FIG00654254: hypothetical protein +FIG00654255 FIG00654260: hypothetical protein +FIG00654264 FIG00652591: hypothetical protein +FIG00654277 FIG00654278: hypothetical protein +FIG00654286 FIG00654292: hypothetical protein +FIG00654297 FIG00654303: hypothetical protein +FIG00654314 FIG00654319: hypothetical protein +FIG00654325 FIG00654330: hypothetical protein +FIG00654349 MoxR protein +FIG00654365 FIG00654368: hypothetical protein +FIG00654379 Gll1663 protein +FIG00654381 FIG00654385: hypothetical protein +FIG00654412 FIG00653073: hypothetical protein +FIG00654425 FIG00654431: hypothetical protein +FIG00654466 FIG00654478: hypothetical protein +FIG00654481 FIG00654483: hypothetical protein +FIG00654492 FIG00654497: hypothetical protein +FIG00654497 FIG00654500: hypothetical protein +FIG00654506 FIG00654508: hypothetical protein +FIG00654517 FIG00654518: hypothetical protein +FIG00654528 FIG00654529: hypothetical protein +FIG00654532 FIG00654533: hypothetical protein +FIG00654533 FIG00654535: hypothetical protein +FIG00654535 FIG00652336: hypothetical protein +FIG00654612 FIG00654613: hypothetical protein +FIG00654618 FIG00654622: hypothetical protein +FIG00654666 FIG00654670: hypothetical protein +FIG00654713 FIG00654715: hypothetical protein +FIG00654722 FIG00654723: hypothetical protein +FIG00654723 FIG00654727: hypothetical protein +FIG00654731 FIG00651935: hypothetical protein +FIG00654734 FIG00654737: hypothetical protein +FIG00654754 FIG00654761: hypothetical protein +FIG00654769 mobilizable transposon, tnpA protein +FIG00654776 FIG01123047: hypothetical protein +FIG00654777 FIG00654784: hypothetical protein +FIG00654784 FIG00657108: hypothetical protein +FIG00654787 Kojibiose phosphorylase (EC 2.4.1.230) +FIG00654799 FIG00654810: hypothetical protein +FIG00654815 FIG00654820: hypothetical protein +FIG00654825 FIG00654834: hypothetical protein +FIG00654842 FIG00654844: hypothetical protein +FIG00654848 membrane protein, inferred for ABFAE pathway +FIG00654851 Collagenase precursor (EC 3.4.-.-) +FIG00654877 FIG00654881: hypothetical protein +FIG00654887 FIG00654896: hypothetical protein +FIG00654912 FIG00654914: hypothetical protein +FIG00654927 FIG00654935: hypothetical protein +FIG00654942 FIG00654946: hypothetical protein +FIG00654946 FIG00654947: hypothetical protein +FIG00654988 FIG00654990: hypothetical protein +FIG00655031 FIG00655032: hypothetical protein +FIG00655032 FIG00655041: hypothetical protein +FIG00655042 FIG00655044: hypothetical protein +FIG00655044 Related to 5' to 3' DNA helicase +FIG00655083 FIG00655084: hypothetical protein +FIG00655084 FIG00655088: hypothetical protein +FIG00655127 FIG00655135: hypothetical protein +FIG00655166 FIG00655167: hypothetical protein +FIG00655167 Lipoprotein-releasing system ATP-binding protein lolD +FIG00655179 FIG00655180: hypothetical protein +FIG00655205 FIG00655207: hypothetical protein +FIG00655216 FIG00655224: hypothetical protein +FIG00655224 multiple sugar-binding ABC transporter, ATP-binding protein +FIG00655239 FIG00655251: hypothetical protein +FIG00655290 Mannan endo-1,4-beta-mannosidase precursor (EC 3.2.1.78) (Mannanase A) +FIG00655292 FIG00655294: hypothetical protein +FIG00655311 FIG00655318: hypothetical protein +FIG00655347 FIG00655349: hypothetical protein +FIG00655367 FIG00655368: hypothetical protein +FIG00655412 FIG00655413: hypothetical protein +FIG00655438 Zinc protease (EC 3.4.-.-) +FIG00655482 FIG00655490: hypothetical protein +FIG00655512 FIG00655513: hypothetical protein +FIG00655534 FIG00655535: hypothetical protein +FIG00655597 FIG00655604: hypothetical protein +FIG00655633 FIG00655640: hypothetical protein +FIG00655660 FIG00655669: hypothetical protein +FIG00655669 FIG00655674: hypothetical protein +FIG00655674 FIG00655675: hypothetical protein +FIG00655690 FIG00652934: hypothetical protein +FIG00655696 Lipid A export ATP-binding/permease protein MsbA (EC 3.6.3.25) +FIG00655707 FIG00655709: hypothetical protein +FIG00655740 L-galactonate dehydrogenase (EC 1.1.1.-) / Sorbitol dehydrogenase (EC 1.1.1.14) +FIG00655758 FIG00655764: hypothetical protein +FIG00655764 FIG00652968: hypothetical protein +FIG00655795 NmrA family protein +FIG00655797 FIG00652419: hypothetical protein +FIG00655820 FIG00655828: hypothetical protein +FIG00655828 FIG00655831: hypothetical protein +FIG00655850 FIG00655851: hypothetical protein +FIG00655857 FIG00655865: hypothetical protein +FIG00655896 FIG00655898: hypothetical protein +FIG00655914 FIG01019089: hypothetical protein +FIG00655927 FIG00655935: hypothetical protein +FIG00655944 FIG00655948: hypothetical protein +FIG00655965 Immunoreactive 84kD antigen PG93 +FIG00656005 FIG00656010: hypothetical protein +FIG00656014 FIG00656025: hypothetical protein +FIG00656025 FIG00651924: hypothetical protein +FIG00656058 ATP-dependent RNA helicase, DEAD box family +FIG00656066 FIG00656067: hypothetical protein +FIG00656077 FIG00656078: hypothetical protein +FIG00656088 FIG00656092: hypothetical protein +FIG00656103 FIG00656108: hypothetical protein +FIG00656111 Pectate lyase (EC 4.2.2.2) +FIG00656212 FIG00656220: hypothetical protein +FIG00656224 FIG00656225: hypothetical protein +FIG00656229 FIG00656230: hypothetical protein +FIG00656234 FIG00656238: hypothetical protein +FIG00656247 FIG00656249: hypothetical protein +FIG00656255 FIG00656258: hypothetical protein +FIG00656278 FIG00656281: hypothetical protein +FIG00656331 FIG00656339: hypothetical protein +FIG00656401 FIG00656409: hypothetical protein +FIG00656420 FIG01019338: hypothetical protein +FIG00656423 Probable peptidyl-prolyl cis-trans isomerase (EC 5.2.1.8) +FIG00656460 Cytochrome P450 hydroxylase +FIG00656492 FIG00656493: hypothetical protein +FIG00656497 FIG00656499: hypothetical protein +FIG00656517 FIG00656523: hypothetical protein +FIG00656523 GPW/gp25 family protein +FIG00656546 FIG00652651: hypothetical protein +FIG00656584 FIG00656585: hypothetical protein +FIG00656585 FIG00656586: hypothetical protein +FIG00656648 FIG00656649: hypothetical protein +FIG00656667 Cell well associated RhsD protein +FIG00656718 FIG00656719: hypothetical protein +FIG00656765 FIG00656771: hypothetical protein +FIG00656788 FIG00656792: hypothetical protein +FIG00656840 Type IV pilus biogenesis protein PilN +FIG00657042 FIG00657056: hypothetical protein +FIG00657142 Putative chemotaxis protein-glutamate methylesterase (EC 3.1.1.61) +FIG00657145 Possible Neuromedin U precursor +FIG00657157 Asl0491 protein +FIG00657181 FIG00657190: hypothetical protein +FIG00657191 FIG00653041: hypothetical protein +FIG00657216 Probable acylaminoacyl-peptidase +FIG00657235 FIG00652438: hypothetical protein +FIG00657259 FIG00657261: hypothetical protein +FIG00657314 alpha-L-rhamnosidase +FIG00657320 FIG00613413: hypothetical protein +FIG00657328 FIG00657329: hypothetical protein +FIG00657397 probable transcription regulator protein +FIG00657431 FIG00657433: hypothetical protein +FIG00657433 FIG00657434: hypothetical protein +FIG00657434 organic solvent tolerance protein OstA +FIG00657436 FIG00657437: hypothetical protein +FIG00657437 FIG00657438: hypothetical protein +FIG00657438 FIG00657440: hypothetical protein +FIG00657440 hypothetical protein +FIG00657441 FIG00657442: hypothetical protein +FIG00657442 FIG00657445: hypothetical protein +FIG00657445 FIG00657446: hypothetical protein +FIG00657448 FIG00657450: hypothetical protein +FIG00657452 FIG00657453: hypothetical protein +FIG00657453 FIG00657455: hypothetical protein +FIG00657455 FIG00657457: hypothetical protein +FIG00657457 FIG00657458: hypothetical protein +FIG00657458 FIG00657459: hypothetical protein +FIG00657459 FIG00657460: hypothetical protein +FIG00657462 FIG00657463: hypothetical protein +FIG00657463 FIG00657464: hypothetical protein +FIG00657464 FIG00657467: hypothetical protein +FIG00657467 FIG00657468: hypothetical protein +FIG00657468 FIG00657469: hypothetical protein +FIG00657469 FIG00657470: hypothetical protein +FIG00657470 FIG00657473: hypothetical protein +FIG00657473 FIG00657474: hypothetical protein +FIG00657474 FIG00657475: hypothetical protein +FIG00657475 FIG00657476: hypothetical protein +FIG00657476 FIG00657477: hypothetical protein +FIG00657477 FIG00657480: hypothetical protein +FIG00657481 Protein of unknown function DUF819 +FIG00657482 FIG00657484: hypothetical protein +FIG00657484 FIG00657485: hypothetical protein +FIG00657485 FIG00657486: hypothetical protein +FIG00657489 FIG00657490: hypothetical protein +FIG00657490 FIG00657491: hypothetical protein +FIG00657496 FIG00657497: hypothetical protein +FIG00657498 FIG00657499: hypothetical protein +FIG00657499 FIG00657500: hypothetical protein +FIG00657500 FIG00657501: hypothetical protein +FIG00657501 FIG00657503: hypothetical protein +FIG00657503 FIG00657504: hypothetical protein +FIG00657504 FIG00657505: hypothetical protein +FIG00657507 FIG00657508: hypothetical protein +FIG00657508 hypothetical protein +FIG00657510 FIG00657511: hypothetical protein +FIG00657511 UPF0341 protein FTW_0787 +FIG00657512 FIG004436: Protein related to deoxyribodipyrimidine photolyase +FIG00657517 FIG00657518: hypothetical protein +FIG00657518 FIG00657520: hypothetical protein +FIG00657520 FIG00657521: hypothetical protein +FIG00657521 FIG00657523: hypothetical protein +FIG00657523 FIG00657524: hypothetical protein +FIG00657524 FIG00657525: hypothetical protein +FIG00657525 FIG00657527: hypothetical protein +FIG00657528 FIG00657530: hypothetical protein +FIG00657530 FIG00657532: hypothetical protein +FIG00657532 FIG00657533: hypothetical protein +FIG00657533 FIG00657534: hypothetical protein +FIG00657534 FIG00657535: hypothetical protein +FIG00657538 FIG00657539: hypothetical protein +FIG00657540 CRISPR-associated protein Cas2 +FIG00657541 FIG00657542: hypothetical protein +FIG00657542 FIG00657543: hypothetical protein +FIG00657543 FIG00657544: hypothetical protein +FIG00657544 FIG00657546: hypothetical protein +FIG00657546 FIG00657547: hypothetical protein +FIG00657547 FIG00657548: hypothetical protein +FIG00657549 FIG00657550: hypothetical protein +FIG00657550 FIG00657551: hypothetical protein +FIG00657551 Haloacid dehalogenase-like hydrolase family protein +FIG00657552 FIG00657553: hypothetical protein +FIG00657553 FIG00657554: hypothetical protein +FIG00657554 FIG00657555: hypothetical protein +FIG00657555 FIG00657556: hypothetical protein +FIG00657557 FIG00657558: hypothetical protein +FIG00657558 FIG00657560: hypothetical protein +FIG00657560 FIG00657565: hypothetical protein +FIG00657565 FIG00657567: hypothetical protein +FIG00657567 FIG00657569: hypothetical protein +FIG00657573 FIG00657574: hypothetical protein +FIG00657574 FIG00657575: hypothetical protein +FIG00657575 FIG00657577: hypothetical protein +FIG00657582 FIG00657583: hypothetical protein +FIG00657583 FIG00657585: hypothetical protein +FIG00657585 FIG00657586: hypothetical protein +FIG00657586 COG2862: Predicted membrane protein +FIG00657601 FIG00657602: hypothetical protein +FIG00657602 FIG00657604: hypothetical protein +FIG00657604 FIG00657606: hypothetical protein +FIG00657606 FIG00657608: hypothetical protein +FIG00657608 putative acetyltransferase +FIG00657609 FIG00657610: hypothetical protein +FIG00657610 CRISPR-associated protein, Csx12 family +FIG00657611 FIG00657612: hypothetical protein +FIG00657612 FIG00657613: hypothetical protein +FIG00657614 FIG00657615: hypothetical protein +FIG00657615 FIG00657616: hypothetical protein +FIG00657621 FIG00657624: hypothetical protein +FIG00657624 FIG00657625: hypothetical protein +FIG00657625 FIG00657626: hypothetical protein +FIG00657626 FIG00657627: hypothetical protein +FIG00657628 FIG00657631: hypothetical protein +FIG00657631 FIG00657632: hypothetical protein +FIG00657632 FIG00657633: hypothetical protein +FIG00657633 FIG00657634: hypothetical protein +FIG00657635 FIG00657636: hypothetical protein +FIG00657636 FIG00657637: hypothetical protein +FIG00657637 FIG00657638: hypothetical protein +FIG00657638 FIG00657639: hypothetical protein +FIG00657639 FIG00657640: hypothetical protein +FIG00657640 FIG00657641: hypothetical protein +FIG00657643 FIG00657645: hypothetical protein +FIG00657645 FIG00657647: hypothetical protein +FIG00657647 FIG00657648: hypothetical protein +FIG00657648 FIG00657650: hypothetical protein +FIG00657650 FIG00657651: hypothetical protein +FIG00657651 FIG00657652: hypothetical protein +FIG00657652 FIG00657653: hypothetical protein +FIG00657653 FIG00657654: hypothetical protein +FIG00657654 FIG00657656: hypothetical protein +FIG00657658 FIG00657660: hypothetical protein +FIG00657660 FIG00657661: hypothetical protein +FIG00657661 FIG00657662: hypothetical protein +FIG00657662 FIG00657663: hypothetical protein +FIG00657664 Oxidoreductase, short chain dehydrogenase/reductase family (EC 1.1.1.100) +FIG00657667 FIG00657670: hypothetical protein +FIG00657670 FIG00657673: hypothetical protein +FIG00657673 FIG00657674: hypothetical protein +FIG00657674 FIG00657675: hypothetical protein +FIG00657676 FIG00657677: hypothetical protein +FIG00657678 FIG00657684: hypothetical protein +FIG00657684 FIG00657685: hypothetical protein +FIG00657687 FIG00657688: hypothetical protein +FIG00657690 FIG00657691: hypothetical protein +FIG00657691 FIG00657692: hypothetical protein +FIG00657692 FIG00657693: hypothetical protein +FIG00657693 FIG00657694: hypothetical protein +FIG00657694 Type IV pili lipoprotein +FIG00657696 Multidrug transporter +FIG00657699 FIG00657703: hypothetical protein +FIG00657703 FIG00657705: hypothetical protein +FIG00657706 similar to beta-(1-3)-glucosyl transferase GB:AAC62210 GI:3687658 from [Bradyrhizobium japonicum], cellulose synthase from Agrobacterium tumeficiens [gi:710492] and Agrobacterium radiobacter [gi:710493]; contains Pfam glycosyl transferase, group 2 family protein domain PF00535; go_function: transferase activity, transferring glycosyl groups [goid 0016757]; go_function: cellulose synthase activity [goid 0016759] / glycosyl transferase family 2 protein +FIG00657707 FIG00657708: hypothetical protein +FIG00657709 FIG00657710: hypothetical protein +FIG00657710 hypothetical protein +FIG00657711 FIG00657712: hypothetical protein +FIG00657712 FIG00657713: hypothetical protein +FIG00657714 FIG00657715: hypothetical protein +FIG00657716 FIG00657717: hypothetical protein +FIG00657717 FIG00657720: hypothetical protein +FIG00657720 FIG00657721: hypothetical protein +FIG00657721 FIG00657722: hypothetical protein +FIG00657722 MFS family major facilitator transporter, probable multidrug resistance protein +FIG00657723 FIG00657725: hypothetical protein +FIG00657726 FIG00657729: hypothetical protein +FIG00657731 FIG00657732: hypothetical protein +FIG00657733 FIG00657734: hypothetical protein +FIG00657734 FIG00657735: hypothetical protein +FIG00657735 FIG00657737: hypothetical protein +FIG00657738 FIG00657739: hypothetical protein +FIG00657739 FIG00657740: hypothetical protein +FIG00657740 FIG00657741: hypothetical protein +FIG00657744 Glutamine amidotransferases class-II family protein +FIG00657745 FIG00657747: hypothetical protein +FIG00657747 FIG00657748: hypothetical protein +FIG00657748 hypothetical protein +FIG00657750 FIG00657751: hypothetical protein +FIG00657751 FIG00657752: hypothetical protein +FIG00657752 FIG00657753: hypothetical protein +FIG00657753 FIG00657754: hypothetical protein +FIG00657754 FIG00657755: hypothetical protein +FIG00657755 FIG00657757: hypothetical protein +FIG00657758 FIG00657760: hypothetical protein +FIG00657760 FIG00657761: hypothetical protein +FIG00657761 FIG00657762: hypothetical protein +FIG00657762 FIG00657763: hypothetical protein +FIG00657763 FIG00657764: hypothetical protein +FIG00657764 FIG00657766: hypothetical protein +FIG00657767 FIG00657768: hypothetical protein +FIG00657768 hypothetical protein +FIG00657770 L-aspartate beta-decarboxylase (EC 4.1.1.12) +FIG00657771 FIG00657772: hypothetical protein +FIG00657772 FIG00657773: hypothetical protein +FIG00657773 hypothetical protein +FIG00657774 FIG00657775: hypothetical protein +FIG00657777 FIG00657780: hypothetical protein +FIG00657780 CRISPR-associated protein, Csx12 family +FIG00657781 FIG00657782: hypothetical protein +FIG00657783 FIG00657785: hypothetical protein +FIG00657785 FIG00657786: hypothetical protein +FIG00657786 FIG00657787: hypothetical protein +FIG00657787 FIG00657789: hypothetical protein +FIG00657789 FIG00657790: hypothetical protein +FIG00657793 FIG00657794: hypothetical protein +FIG00657794 FIG00657795: hypothetical protein +FIG00657796 FIG00657797: hypothetical protein +FIG00657797 Uncharacterized protein YrbB +FIG00657798 FIG00657799: hypothetical protein +FIG00657800 FIG00657801: hypothetical protein +FIG00657801 FIG00657802: hypothetical protein +FIG00657802 FIG00657805: hypothetical protein +FIG00657808 FIG00657809: hypothetical protein +FIG00657809 FIG00657812: hypothetical protein +FIG00657812 FIG00657813: hypothetical protein +FIG00657813 FIG00657815: hypothetical protein +FIG00657815 FIG00657816: hypothetical protein +FIG00657817 FIG00657819: hypothetical protein +FIG00657819 FIG00657822: hypothetical protein +FIG00657822 FIG00657823: hypothetical protein +FIG00657824 FIG00657825: hypothetical protein +FIG00657825 FIG00657826: hypothetical protein +FIG00657826 FIG00657827: hypothetical protein +FIG00657827 FIG00657828: hypothetical protein +FIG00657828 FIG00657829: hypothetical protein +FIG00657830 FIG00657831: hypothetical protein +FIG00657832 FIG00657833: hypothetical protein +FIG00657833 FIG00657834: hypothetical protein +FIG00657834 FIG00657838: hypothetical protein +FIG00657839 FIG00657841: hypothetical protein +FIG00657842 FIG00657844: hypothetical protein +FIG00657844 FIG00657846: hypothetical protein +FIG00657846 FIG00657847: hypothetical protein +FIG00657847 FIG00657848: hypothetical protein +FIG00657851 FIG00657852: hypothetical protein +FIG00657852 tryptophan repressor binding protein-like flavidoxin +FIG00657857 FIG00657859: hypothetical protein +FIG00657859 FIG00657860: hypothetical protein +FIG00657865 FIG00657866: hypothetical protein +FIG00657866 FIG00657868: hypothetical protein +FIG00657868 Succinylglutamate desuccinylase/aspartoacylase +FIG00657870 FIG00657871: hypothetical protein +FIG00657871 FIG00657874: hypothetical protein +FIG00657874 FIG00657875: hypothetical protein +FIG00657875 major facilitator superfamily (MFS) transport protein +FIG00657876 FIG00657879: hypothetical protein +FIG00657880 Glutamine amidotransferase, class I (EC 6.3.5.2) +FIG00657881 FIG00657885: hypothetical protein +FIG00657887 FIG00657888: hypothetical protein +FIG00657888 FIG00657889: hypothetical protein +FIG00657889 FIG00657890: hypothetical protein +FIG00657890 FIG00657892: hypothetical protein +FIG00657893 FIG00657894: hypothetical protein +FIG00657894 FIG00657895: hypothetical protein +FIG00657896 FIG00657897: hypothetical protein +FIG00657899 FIG00657902: hypothetical protein +FIG00657903 FIG00657904: hypothetical protein +FIG00657904 FIG00657905: hypothetical protein +FIG00657905 FIG00657906: hypothetical protein +FIG00657908 FIG00657911: hypothetical protein +FIG00657911 FIG00657913: hypothetical protein +FIG00657916 FIG00657922: hypothetical protein +FIG00657922 FIG00657923: hypothetical protein +FIG00657923 FIG00657924: hypothetical protein +FIG00657924 FIG00657927: hypothetical protein +FIG00657927 FIG00657931: hypothetical protein +FIG00657931 FIG00657932: hypothetical protein +FIG00657932 FIG00657934: hypothetical protein +FIG00657937 FIG00657938: hypothetical protein +FIG00657942 FIG00657943: hypothetical protein +FIG00657943 FIG00657945: hypothetical protein +FIG00657948 FIG00657949: hypothetical protein +FIG00657950 FIG00657951: hypothetical protein +FIG00657951 FIG00657952: hypothetical protein +FIG00657952 FIG00657953: hypothetical protein +FIG00657953 FIG00657954: hypothetical protein +FIG00657954 FIG00657956: hypothetical protein +FIG00657957 FIG00657960: hypothetical protein +FIG00657963 FIG00657964: hypothetical protein +FIG00657964 FIG00657965: hypothetical protein +FIG00657965 FIG00657966: hypothetical protein +FIG00657967 FIG00657969: hypothetical protein +FIG00657969 FIG00657970: hypothetical protein +FIG00657970 FIG00657971: hypothetical protein +FIG00657971 FIG00657973: hypothetical protein +FIG00657973 FIG00657974: hypothetical protein +FIG00657975 FIG00657978: hypothetical protein +FIG00657982 FIG00657983: hypothetical protein +FIG00657983 FIG00657984: hypothetical protein +FIG00657984 FIG00657985: hypothetical protein +FIG00657985 FIG00657987: hypothetical protein +FIG00657987 FIG00657991: hypothetical protein +FIG00657991 FIG00657992: hypothetical protein +FIG00657994 FIG00657995: hypothetical protein +FIG00657995 FIG00657997: hypothetical protein +FIG00658002 FIG00658003: hypothetical protein +FIG00658003 FIG00658007: hypothetical protein +FIG00658007 FIG00658008: hypothetical protein +FIG00658008 FIG00658011: hypothetical protein +FIG00658011 FIG00658012: hypothetical protein +FIG00658012 FIG00658013: hypothetical protein +FIG00658013 FIG00658014: hypothetical protein +FIG00658014 FIG00658017: hypothetical protein +FIG00658018 FIG00658019: hypothetical protein +FIG00658019 FIG00658020: hypothetical protein +FIG00658020 FIG00658021: hypothetical protein +FIG00658021 FIG00658022: hypothetical protein +FIG00658022 FIG00658024: hypothetical protein +FIG00658024 FIG00658026: hypothetical protein +FIG00658028 FIG00658029: hypothetical protein +FIG00658029 FIG00658031: hypothetical protein +FIG00658031 hypothetical protein +FIG00658032 hypothetical protein +FIG00658033 FIG00658034: hypothetical protein +FIG00658034 FIG00658035: hypothetical protein +FIG00658039 FIG00658041: hypothetical protein +FIG00658047 FIG00658048: hypothetical protein +FIG00658050 FIG00658051: hypothetical protein +FIG00658051 FIG00658052: hypothetical protein +FIG00658052 FIG00658053: hypothetical protein +FIG00658053 FIG00658054: hypothetical protein +FIG00658056 FIG00658057: hypothetical protein +FIG00658057 FIG00658058: hypothetical protein +FIG00658058 FIG00658061: hypothetical protein +FIG00658065 FIG00658067: hypothetical protein +FIG00658068 FIG00658069: hypothetical protein +FIG00658073 FIG00658074: hypothetical protein +FIG00658074 FIG00658077: hypothetical protein +FIG00658077 FIG00658078: hypothetical protein +FIG00658078 FIG00658079: hypothetical protein +FIG00658081 FIG00658082: hypothetical protein +FIG00658083 FIG00658084: hypothetical protein +FIG00658084 FIG00658086: hypothetical protein +FIG00658088 FIG00658089: hypothetical protein +FIG00658089 FIG00658090: hypothetical protein +FIG00658090 FIG00658091: hypothetical protein +FIG00658091 FIG00658092: hypothetical protein +FIG00658093 FIG00658095: hypothetical protein +FIG00658095 hypothetical protein +FIG00658099 FIG00658102: hypothetical protein +FIG00658102 FIG00658104: hypothetical protein +FIG00658104 FIG00658105: hypothetical protein +FIG00658105 FIG00658106: hypothetical protein +FIG00658106 FIG00658111: hypothetical protein +FIG00658111 Lead, cadmium, zinc and mercury transporting ATPase (EC 3.6.3.3) (EC 3.6.3.5); Copper-translocating P-type ATPase (EC 3.6.3.4) +FIG00658120 FIG00658123: hypothetical protein +FIG00658125 FIG00658126: hypothetical protein +FIG00658126 FIG00658129: hypothetical protein +FIG00658132 FIG00658133: hypothetical protein +FIG00658138 FIG00658139: hypothetical protein +FIG00658139 FIG00658141: hypothetical protein +FIG00658142 FIG00658143: hypothetical protein +FIG00658143 hypothetical protein +FIG00658145 FIG00658146: hypothetical protein +FIG00658148 FIG00658151: hypothetical protein +FIG00658154 FIG00658155: hypothetical protein +FIG00658156 FIG00658158: hypothetical protein +FIG00658160 FIG00658161: hypothetical protein +FIG00658165 FIG00658166: hypothetical protein +FIG00658168 FIG00658170: hypothetical protein +FIG00658177 FIG00658179: hypothetical protein +FIG00658181 FIG00658182: hypothetical protein +FIG00658182 FIG00658183: hypothetical protein +FIG00658184 FIG00658186: hypothetical protein +FIG00658186 FIG00658187: hypothetical protein +FIG00658187 FIG00658188: hypothetical protein +FIG00658188 FIG00658189: hypothetical protein +FIG00658189 FIG00658190: hypothetical protein +FIG00658192 FIG00658193: hypothetical protein +FIG00658194 fatty acid hydroxylase +FIG00658195 hypothetical protein +FIG00658196 FIG00658199: hypothetical protein +FIG00658199 FIG00658200: hypothetical protein +FIG00658200 FIG00658204: hypothetical protein +FIG00658204 FIG00658210: hypothetical protein +FIG00658210 FIG00658211: hypothetical protein +FIG00658211 FIG00658212: hypothetical protein +FIG00658214 FIG00658217: hypothetical protein +FIG00658217 FIG00658219: hypothetical protein +FIG00658219 FIG00658220: hypothetical protein +FIG00658220 FIG00658222: hypothetical protein +FIG00658222 FIG00658223: hypothetical protein +FIG00658223 FIG00658224: hypothetical protein +FIG00658225 FIG00658226: hypothetical protein +FIG00658234 FIG00658237: hypothetical protein +FIG00658237 FIG00658239: hypothetical protein +FIG00658241 FIG00658242: hypothetical protein +FIG00658242 FIG00658243: hypothetical protein +FIG00658244 FIG00658245: hypothetical protein +FIG00658245 FIG00658249: hypothetical protein +FIG00658249 FIG00658252: hypothetical protein +FIG00658259 FIG137478: Hypothetical protein YbgI +FIG00658262 FIG00658272: hypothetical protein +FIG00658272 FIG00658273: hypothetical protein +FIG00658273 FIG00658274: hypothetical protein +FIG00658274 FIG00658276: hypothetical protein +FIG00658279 FIG00658280: hypothetical protein +FIG00658283 FIG00658284: hypothetical protein +FIG00658284 FIG00658286: hypothetical protein +FIG00658288 FIG00658289: hypothetical protein +FIG00658293 FIG00658296: hypothetical protein +FIG00658296 possible cytochrome P450 hydroxylase superfamily proteins +FIG00658298 FIG00658299: hypothetical protein +FIG00658299 hypothetical protein +FIG00658303 Putative S-transferase +FIG00658304 FIG00658307: hypothetical protein +FIG00658321 FIG00658324: hypothetical protein +FIG00658324 hypothetical protein +FIG00658333 Glycoprotein gp2 +FIG00658343 FIG00658345: hypothetical protein +FIG00658345 possible Ribosomal protein L11 +FIG00658353 putative phospholipase D family protein +FIG00658357 FIG00658359: hypothetical protein +FIG00658359 FIG00658360: hypothetical protein +FIG00658362 FIG00658363: hypothetical protein +FIG00658366 FIG00658367: hypothetical protein +FIG00658367 FIG00658371: hypothetical protein +FIG00658382 FIG00658385: hypothetical protein +FIG00658387 FIG00658388: hypothetical protein +FIG00658388 hypothetical protein +FIG00658393 FIG00658394: hypothetical protein +FIG00658394 FIG00658396: hypothetical protein +FIG00658401 FIG00658403: hypothetical protein +FIG00658408 FIG00658409: hypothetical protein +FIG00658416 hypothetical protein +FIG00658422 FIG00658423: hypothetical protein +FIG00658423 FIG00658427: hypothetical protein +FIG00658429 FIG00658432: hypothetical protein +FIG00658435 FIG00658436: hypothetical protein +FIG00658436 FIG00658440: hypothetical protein +FIG00658445 FIG00658447: hypothetical protein +FIG00658448 FIG00658450: hypothetical protein +FIG00658471 FIG00658472: hypothetical protein +FIG00658477 FIG00658478: hypothetical protein +FIG00658478 FIG00658481: hypothetical protein +FIG00658481 FIG00658484: hypothetical protein +FIG00658484 FIG00658485: hypothetical protein +FIG00658485 FIG00658489: hypothetical protein +FIG00658489 FIG00658491: hypothetical protein +FIG00658491 FIG00658492: hypothetical protein +FIG00658507 FIG00658512: hypothetical protein +FIG00658513 FIG00658518: hypothetical protein +FIG00658523 FIG00658527: hypothetical protein +FIG00658539 FIG00658541: hypothetical protein +FIG00658543 FIG00658544: hypothetical protein +FIG00658544 hypothetical protein +FIG00658545 FIG00658549: hypothetical protein +FIG00658549 FIG00658550: hypothetical protein +FIG00658550 FIG00658551: hypothetical protein +FIG00658552 FIG00658554: hypothetical protein +FIG00658554 FIG00658555: hypothetical protein +FIG00658562 FIG00658564: hypothetical protein +FIG00658564 FIG00658566: hypothetical protein +FIG00658570 FIG00658574: hypothetical protein +FIG00658578 FIG00658581: hypothetical protein +FIG00658581 FIG00658582: hypothetical protein +FIG00658582 FIG00658583: hypothetical protein +FIG00658588 hypothetical protein +FIG00658594 FIG00658595: hypothetical protein +FIG00658598 FIG00658599: hypothetical protein +FIG00658599 FIG00658600: hypothetical protein +FIG00658600 hypothetical protein +FIG00658603 Magnesium and cobalt transport protein CorA +FIG00658632 FIG00658634: hypothetical protein +FIG00658642 FIG00658644: hypothetical protein +FIG00658644 FIG00658645: hypothetical protein +FIG00658645 FIG00658646: hypothetical protein +FIG00658663 organic solvent tolerance protein +FIG00658671 FIG00658674: hypothetical protein +FIG00658674 FIG00658675: hypothetical protein +FIG00658675 FIG00658679: hypothetical protein +FIG00658695 NADH oxidase( EC:1.6.99.3 ) +FIG00658717 FIG00658721: hypothetical protein +FIG00658721 FIG00658723: hypothetical protein +FIG00658726 FIG00658728: hypothetical protein +FIG00658728 FIG00658731: hypothetical protein +FIG00658731 FIG00658732: hypothetical protein +FIG00658748 FIG00658751: hypothetical protein +FIG00658751 FIG00658753: hypothetical protein +FIG00658760 FIG00658761: hypothetical protein +FIG00658761 FIG00658768: hypothetical protein +FIG00658788 FIG00658791: hypothetical protein +FIG00658791 FIG00658795: hypothetical protein +FIG00658801 FIG00658806: hypothetical protein +FIG00658806 FIG00658811: hypothetical protein +FIG00658811 FIG00658815: hypothetical protein +FIG00658815 FIG00658818: hypothetical protein +FIG00658822 FIG00658824: hypothetical protein +FIG00658857 FIG00658861: hypothetical protein +FIG00658861 FIG00658870: hypothetical protein +FIG00658873 FIG00658874: hypothetical protein +FIG00658884 FIG00658888: hypothetical protein +FIG00658896 FIG00658897: hypothetical protein +FIG00658899 FIG00658904: hypothetical protein +FIG00658919 FIG00658921: hypothetical protein +FIG00658922 FIG00658924: hypothetical protein +FIG00658924 FIG00658933: hypothetical protein +FIG00658933 FIG00658934: hypothetical protein +FIG00658943 FIG00658946: hypothetical protein +FIG00658947 peptidase C60, sortase A and B +FIG00658951 Extracellular serine proteinase precursor (EC 3.4.21.-) +FIG00658974 FIG00658977: hypothetical protein +FIG00658983 FIG00658984: hypothetical protein +FIG00658984 FIG00658985: hypothetical protein +FIG00658986 FIG311564: hypothetical protein +FIG00658992 FIG00658995: hypothetical protein +FIG00658995 FIG00659000: hypothetical protein +FIG00659000 FIG00659001: hypothetical protein +FIG00659001 FIG00659002: hypothetical protein +FIG00659012 FIG00659016: hypothetical protein +FIG00659016 FIG00659017: hypothetical protein +FIG00659019 FIG00659021: hypothetical protein +FIG00659024 FIG00659035: hypothetical protein +FIG00659037 FIG00659039: hypothetical protein +FIG00659045 FIG00659046: hypothetical protein +FIG00659052 FIG00659053: hypothetical protein +FIG00659053 FIG00659058: hypothetical protein +FIG00659060 FIG00659064: hypothetical protein +FIG00659064 FIG00659065: hypothetical protein +FIG00659066 FIG00659070: hypothetical protein +FIG00659070 FIG00659072: hypothetical protein +FIG00659076 FIG00659077: hypothetical protein +FIG00659077 FIG00659083: hypothetical protein +FIG00659084 FIG00659085: hypothetical protein +FIG00659088 FIG00659090: hypothetical protein +FIG00659090 FIG00659091: hypothetical protein +FIG00659092 FIG00659095: hypothetical protein +FIG00659099 putative ATP/GTP-binding protein protein +FIG00659101 FIG00659102: hypothetical protein +FIG00659118 FIG00659119: hypothetical protein +FIG00659141 YhdH, a putative quinone oxidoreductase +FIG00659145 FIG00659146: hypothetical protein +FIG00659146 FIG00659147: hypothetical protein +FIG00659157 FIG00659159: hypothetical protein +FIG00659162 FIG00659166: hypothetical protein +FIG00659166 FIG00659167: hypothetical protein +FIG00659167 Polynucleotide kinase (EC 2.7.1.78) +FIG00659172 FIG00659173: hypothetical protein +FIG00659181 FIG00659184: hypothetical protein +FIG00659186 FIG00659188: hypothetical protein +FIG00659188 FIG00659189: hypothetical protein +FIG00659189 FIG00659190: hypothetical protein +FIG00659194 Zn-dependent proteases +FIG00659203 PROBABLE METHYLTRANSFERASE (EC 2.1.1.-) +FIG00659205 FIG00659207: hypothetical protein +FIG00659215 FIG00659217: hypothetical protein +FIG00659217 FIG00659222: hypothetical protein +FIG00659222 FIG00659224: hypothetical protein +FIG00659224 FIG00659225: hypothetical protein +FIG00659225 FIG00659226: hypothetical protein +FIG00659226 FIG00659231: hypothetical protein +FIG00659233 FIG00659234: hypothetical protein +FIG00659240 FIG00659244: hypothetical protein +FIG00659264 FIG00659271: hypothetical protein +FIG00659271 FIG00659272: hypothetical protein +FIG00659272 FIG00659274: hypothetical protein +FIG00659280 FIG00659282: hypothetical protein +FIG00659282 FIG00659283: hypothetical protein +FIG00659285 FIG00659286: hypothetical protein +FIG00659290 FIG00659292: hypothetical protein +FIG00659293 FIG00659294: hypothetical protein +FIG00659297 O-methyltransferase clustered with LanBC +FIG00659299 FIG00659301: hypothetical protein +FIG00659301 FIG00659306: hypothetical protein +FIG00659306 integration host factor +FIG00659309 FIG00659311: hypothetical protein +FIG00659311 FIG00659312: hypothetical protein +FIG00659312 Phosphoribosylglycinamide formyltransferase (EC 2.1.2.2) / IMP cyclohydrolase (EC 3.5.4.10) / Phosphoribosylaminoimidazolecarboxamide formyltransferase (EC 2.1.2.3) +FIG00659317 FIG00659318: hypothetical protein +FIG00659339 Transfer protein traSA +FIG00659344 FIG00659350: hypothetical protein +FIG00659354 FIG00659359: hypothetical protein +FIG00659359 FIG00659363: hypothetical protein +FIG00659366 FIG00659368: hypothetical protein +FIG00659370 Peptidyl-prolyl cis-trans isomerase (PPIase) (Rotamase) (partial match)( EC:5.2.1.8 ) +FIG00659371 FIG00659372: hypothetical protein +FIG00659372 FIG00659373: hypothetical protein +FIG00659375 FIG00659378: hypothetical protein +FIG00659383 FIG027937: secreted protein +FIG00659385 FIG00659394: hypothetical protein +FIG00659401 FIG00659402: hypothetical protein +FIG00659404 FIG00659407: hypothetical protein +FIG00659407 FIG00659409: hypothetical protein +FIG00659410 hypothetical protein; putative signal peptide; DNA binding and excisionase domains +FIG00659427 FIG00659429: hypothetical protein +FIG00659429 FIG00659432: hypothetical protein +FIG00659432 Magnesium and cobalt transport protein CorA +FIG00659441 FIG00659442: hypothetical protein +FIG00659444 FIG00659446: hypothetical protein +FIG00659454 FIG00659458: hypothetical protein +FIG00659458 FIG00659465: hypothetical protein +FIG00659465 FIG00659467: hypothetical protein +FIG00659467 FIG00659469: hypothetical protein +FIG00659472 FIG00659475: hypothetical protein +FIG00659475 FIG00659477: hypothetical protein +FIG00659489 Uncharacterized RNA methyltransferase SCO5901 (EC 2.1.1.-) +FIG00659491 FIG00659494: hypothetical protein +FIG00659494 FIG00659496: hypothetical protein +FIG00659496 FIG00659498: hypothetical protein +FIG00659498 FIG00659502: hypothetical protein +FIG00659504 Amidohydrolase 2 +FIG00659510 FIG00659511: hypothetical protein +FIG00659514 Ser/Thr protein kinase (EC 2.7.11.1) +FIG00659517 FIG00659518: hypothetical protein +FIG00659520 FIG00659521: hypothetical protein +FIG00659521 FIG00659524: hypothetical protein +FIG00659524 FIG00659528: hypothetical protein +FIG00659528 FIG00659529: hypothetical protein +FIG00659534 protein of unknown function DUF1526 +FIG00659537 FIG00659538: hypothetical protein +FIG00659540 Tellurite resistance TerB +FIG00659546 FIG00659547: hypothetical protein +FIG00659549 FIG00659550: hypothetical protein +FIG00659560 FIG00659563: hypothetical protein +FIG00659563 FIG00659564: hypothetical protein +FIG00659565 FIG00659568: hypothetical protein +FIG00659577 FIG00659578: hypothetical protein +FIG00659580 FIG00659581: hypothetical protein +FIG00659589 FIG00659591: hypothetical protein +FIG00659594 FIG00659596: hypothetical protein +FIG00659602 FIG00659603: hypothetical protein +FIG00659603 FIG00659604: hypothetical protein +FIG00659607 conserved hypothetical protein; putative Winged helix DNA-binding domain +FIG00659615 FIG00659617: hypothetical protein +FIG00659627 FIG083739: Putative secreted protein +FIG00659637 FIG00659641: hypothetical protein +FIG00659641 FIG00659648: hypothetical protein +FIG00659654 FIG00659657: hypothetical protein +FIG00659661 FIG00659662: hypothetical protein +FIG00659669 Putative tellurium resistance protein (partial match) +FIG00659681 FIG00659685: hypothetical protein +FIG00659685 FIG00659686: hypothetical protein +FIG00659686 FIG00659688: hypothetical protein +FIG00659700 FIG00659701: hypothetical protein +FIG00659707 hypothetical protein; putative lipoprotein +FIG00659709 putative monooxygenase with luciferase-like ATPase activity +FIG00659710 FIG00659711: hypothetical protein +FIG00659720 ergothioneine biosynthesis protein EgtB +FIG00659724 FIG00659725: hypothetical protein +FIG00659727 FIG00659728: hypothetical protein +FIG00659729 FIG00659731: hypothetical protein +FIG00659731 FIG00659732: hypothetical protein +FIG00659733 FIG00659737: hypothetical protein +FIG00659737 FIG00659740: hypothetical protein +FIG00659759 FIG00659762: hypothetical protein +FIG00659769 FIG00659771: hypothetical protein +FIG00659771 POSSIBLE CONSERVED LIPOPROTEIN LPQP +FIG00659773 FIG00659774: hypothetical protein +FIG00659775 FIG00659777: hypothetical protein +FIG00659777 FIG00659778: hypothetical protein +FIG00659778 FIG00659779: hypothetical protein +FIG00659779 sulfotransferase +FIG00659786 FIG00659791: hypothetical protein +FIG00659793 FIG00659794: hypothetical protein +FIG00659800 FIG00659801: hypothetical protein +FIG00659803 FIG00659811: hypothetical protein +FIG00659813 FIG00659819: hypothetical protein +FIG00659821 Acyl-[acyl-carrier-protein] desaturase, chloroplast precursor (EC 1.14.19.2) +FIG00659829 FIG00659831: hypothetical protein +FIG00659831 FIG00659836: hypothetical protein +FIG00659843 FIG00659844: hypothetical protein +FIG00659844 FIG00659845: hypothetical protein +FIG00659845 FIG00659851: hypothetical protein +FIG00659851 FIG00659852: hypothetical protein +FIG00659855 putative NADPH-dependent FMN reductase +FIG00659869 FIG00659871: hypothetical protein +FIG00659887 FIG00659889: hypothetical protein +FIG00659889 FIG00659892: hypothetical protein +FIG00659892 FIG00659895: hypothetical protein +FIG00659895 FIG00659902: hypothetical protein +FIG00659902 methylamine utilization protein MauE, putative +FIG00659903 protein arginine methyltransferase type 2 (SDMA formation) +FIG00659910 FIG00659912: hypothetical protein +FIG00659914 Bll6640 protein +FIG00659931 FIG00659934: hypothetical protein +FIG00659934 putative alkylated DNA repair protein +FIG00659942 FIG00659943: hypothetical protein +FIG00659943 FIG00659947: hypothetical protein +FIG00659947 FIG00659951: hypothetical protein +FIG00659952 FIG00659953: hypothetical protein +FIG00659953 FIG00659961: hypothetical protein +FIG00659961 FIG00659964: hypothetical protein +FIG00659967 FIG00659968: hypothetical protein +FIG00659968 FIG00659970: hypothetical protein +FIG00659972 FIG00659978: hypothetical protein +FIG00659978 FIG00659983: hypothetical protein +FIG00659983 FIG00659984: hypothetical protein +FIG00659985 FIG00659986: hypothetical protein +FIG00659997 possible dipeptidase +FIG00660007 FIG00660009: hypothetical protein +FIG00660011 FIG00660014: hypothetical protein +FIG00660015 FIG00660016: hypothetical protein +FIG00660019 FIG00660020: hypothetical protein +FIG00660020 FIG00660023: hypothetical protein +FIG00660024 FIG00660025: hypothetical protein +FIG00660032 FIG00660036: hypothetical protein +FIG00660036 FIG00660037: hypothetical protein +FIG00660041 FIG00660045: hypothetical protein +FIG00660045 FIG00660058: hypothetical protein +FIG00660058 FIG00660060: hypothetical protein +FIG00660061 FIG00660066: hypothetical protein +FIG00660082 FIG00660083: hypothetical protein +FIG00660083 FIG00660085: hypothetical protein +FIG00660086 Mycofactocin radical SAM maturase +FIG00660102 FIG00660105: hypothetical protein +FIG00660106 FIG00660110: hypothetical protein +FIG00660113 FIG00660114: hypothetical protein +FIG00660119 FIG00660121: hypothetical protein +FIG00660121 FIG00660122: hypothetical protein +FIG00660123 FIG00660124: hypothetical protein +FIG00660128 FIG00660129: hypothetical protein +FIG00660133 FIG00660135: hypothetical protein +FIG00660135 FIG00660138: hypothetical protein +FIG00660153 FIG00660154: hypothetical protein +FIG00660158 FIG00660159: hypothetical protein +FIG00660159 putative serine/threonine kinase anti-sigma factor +FIG00660160 FIG00660162: hypothetical protein +FIG00660164 FIG00660166: hypothetical protein +FIG00660166 FIG00660167: hypothetical protein +FIG00660167 N-carbamoylputrescine amidase (3.5.1.53) / Aliphatic amidase AmiE (EC 3.5.1.4) +FIG00660178 FIG00660179: hypothetical protein +FIG00660192 FIG00660194: hypothetical protein +FIG00660195 FIG00660197: hypothetical protein +FIG00660200 Alkylhydroperoxidase AhpD core domain +FIG00660211 N-carbamoylputrescine amidase (3.5.1.53) / Omega amidase (Nit2 homolog) +FIG00660219 FIG00660220: hypothetical protein +FIG00660242 FIG00660243: hypothetical protein +FIG00660248 FIG00660257: hypothetical protein +FIG00660268 Putative C1 regulatory protein +FIG00660269 COG1872 +FIG00660270 FIG00660275: hypothetical protein +FIG00660297 FIG00660298: hypothetical protein +FIG00660303 FIG00660304: hypothetical protein +FIG00660306 FIG00660310: hypothetical protein +FIG00660310 FIG00660313: hypothetical protein +FIG00660313 FIG00660317: hypothetical protein +FIG00660328 FIG00660335: hypothetical protein +FIG00660335 putative electron transport protein +FIG00660342 FIG00660343: hypothetical protein +FIG00660348 FIG00660351: hypothetical protein +FIG00660351 FIG00660354: hypothetical protein +FIG00660354 FIG00660356: hypothetical protein +FIG00660360 FIG00660362: hypothetical protein +FIG00660362 TVG0570508 protein +FIG00660370 FIG00660372: hypothetical protein +FIG00660381 FIG00660383: hypothetical protein +FIG00660383 FIG00660384: hypothetical protein +FIG00660400 FIG00660401: hypothetical protein +FIG00660401 FIG00660403: hypothetical protein +FIG00660410 FIG00660417: hypothetical protein +FIG00660417 FIG00660422: hypothetical protein +FIG00660422 FIG00660425: hypothetical protein +FIG00660427 FIG00660430: hypothetical protein +FIG00660430 FIG00660431: hypothetical protein +FIG00660431 Putative integral membrane protein (partial match) +FIG00660438 FIG00660439: hypothetical protein +FIG00660439 FIG00660444: hypothetical protein +FIG00660444 FIG01129398: hypothetical protein +FIG00660448 FIG00660449: hypothetical protein +FIG00660449 FIG00660454: hypothetical protein +FIG00660454 FIG00660456: hypothetical protein +FIG00660459 FIG00660460: hypothetical protein +FIG00660460 anti-sigma factor +FIG00660462 FIG00660464: hypothetical protein +FIG00660464 UDP-N-acetylglucosamine:LPS N-acetylglucosamine transferase-like +FIG00660466 FIG00660471: hypothetical protein +FIG00660473 FIG00660474: hypothetical protein +FIG00660484 FIG00660490: hypothetical protein +FIG00660496 FIG00660497: hypothetical protein +FIG00660497 FIG00660498: hypothetical protein +FIG00660498 FIG00660499: hypothetical protein +FIG00660500 short chain oxidoreductase +FIG00660507 FIG00660511: hypothetical protein +FIG00660511 FIG00660512: hypothetical protein +FIG00660512 FIG00660517: hypothetical protein +FIG00660525 FIG00660527: hypothetical protein +FIG00660529 TOMM biosynthesis docking scaffold (protein D) +FIG00660535 FIG00660536: hypothetical protein +FIG00660551 FIG00660552: hypothetical protein +FIG00660560 GntR-family transcription regulator +FIG00660570 FIG00660572: hypothetical protein +FIG00660581 FIG00660582: hypothetical protein +FIG00660582 FIG00660583: hypothetical protein +FIG00660596 FIG00660597: hypothetical protein +FIG00660601 FIG00660602: hypothetical protein +FIG00660605 FIG00660607: hypothetical protein +FIG00660627 FIG00660634: hypothetical protein +FIG00660635 FIG00660636: hypothetical protein +FIG00660638 FIG00660641: hypothetical protein +FIG00660641 FIG00660644: hypothetical protein +FIG00660657 FIG00660658: hypothetical protein +FIG00660664 FIG00660665: hypothetical protein +FIG00660665 FIG00660670: hypothetical protein +FIG00660670 FIG00660677: hypothetical protein +FIG00660677 FIG00660682: hypothetical protein +FIG00660682 protein of unknown function DUF305 +FIG00660683 FIG00660685: hypothetical protein +FIG00660685 FIG00660691: hypothetical protein +FIG00660691 FIG00660694: hypothetical protein +FIG00660695 FIG00660696: hypothetical protein +FIG00660696 FIG00660702: hypothetical protein +FIG00660702 FIG00660703: hypothetical protein +FIG00660722 FIG00660726: hypothetical protein +FIG00660735 FIG00660737: hypothetical protein +FIG00660738 FIG00660739: hypothetical protein +FIG00660742 FIG00660744: hypothetical protein +FIG00660744 FIG00660746: hypothetical protein +FIG00660754 FIG00660756: hypothetical protein +FIG00660756 FIG00660758: hypothetical protein +FIG00660759 FIG00660760: hypothetical protein +FIG00660765 FIG00660766: hypothetical protein +FIG00660766 FIG00660768: hypothetical protein +FIG00660768 FIG00660769: hypothetical protein +FIG00660770 Putative mannosyltransferase +FIG00660774 FIG00660775: hypothetical protein +FIG00660775 FIG00660777: hypothetical protein +FIG00660784 FIG00660786: hypothetical protein +FIG00660787 FIG00660790: hypothetical protein +FIG00660790 FIG00660796: hypothetical protein +FIG00660796 FIG00660799: hypothetical protein +FIG00660805 FIG00660807: hypothetical protein +FIG00660807 FIG00660811: hypothetical protein +FIG00660811 FIG00660812: hypothetical protein +FIG00660814 FIG00660816: hypothetical protein +FIG00660816 FIG00660817: hypothetical protein +FIG00660817 FIG00660821: hypothetical protein +FIG00660821 FIG00660823: hypothetical protein +FIG00660831 FIG00660839: hypothetical protein +FIG00660839 FIG00660840: hypothetical protein +FIG00660846 FIG00660847: hypothetical protein +FIG00660861 FIG00660862: hypothetical protein +FIG00660862 FIG00660866: hypothetical protein +FIG00660866 FIG00660870: hypothetical protein +FIG00660870 FIG00660872: hypothetical protein +FIG00660873 putative merR-family transcriptional regulator +FIG00660874 Collagen alpha-1(I) chain precursor +FIG00660876 FIG00660877: hypothetical protein +FIG00660877 anti-sigma-factor antagonist (STAS) domain protein +FIG00660894 FIG00660896: hypothetical protein +FIG00660896 FIG00660900: hypothetical protein +FIG00660900 FIG00660901: hypothetical protein +FIG00660903 FIG00660905: hypothetical protein +FIG00660909 FIG00660912: hypothetical protein +FIG00660914 FIG00660916: hypothetical protein +FIG00660916 FIG00660921: hypothetical protein +FIG00660922 FIG00660925: hypothetical protein +FIG00660929 Glycoside hydrolase, family 43 +FIG00660933 FIG00660934: hypothetical protein +FIG00660934 FIG00660939: hypothetical protein +FIG00660939 FIG00660942: hypothetical protein +FIG00660945 FIG00660946: hypothetical protein +FIG00660946 FIG00660948: hypothetical protein +FIG00660948 FIG00660949: hypothetical protein +FIG00660952 N5,N10-methylenetetrahydromethanopterin reductase-related protein, Tbis_3526 family +FIG00660956 FIG00660957: hypothetical protein +FIG00660957 FIG00660959: hypothetical protein +FIG00660961 FIG00660963: hypothetical protein +FIG00660976 FIG00660977: hypothetical protein +FIG00660980 FIG00660986: hypothetical protein +FIG00660989 FIG00660991: hypothetical protein +FIG00660992 FIG00660995: hypothetical protein +FIG00661002 FIG00661004: hypothetical protein +FIG00661010 ROK +FIG00661015 FIG00661016: hypothetical protein +FIG00661016 FIG00661021: hypothetical protein +FIG00661025 FIG00661026: hypothetical protein +FIG00661026 FIG00661027: hypothetical protein +FIG00661052 FIG00661055: hypothetical protein +FIG00661062 FIG00661066: hypothetical protein +FIG00661066 FIG00661067: hypothetical protein +FIG00661069 FIG00661073: hypothetical protein +FIG00661089 FIG00661092: hypothetical protein +FIG00661103 FIG00661104: hypothetical protein +FIG00661115 FIG00661116: hypothetical protein +FIG00661116 FIG00661117: hypothetical protein +FIG00661125 FIG00661130: hypothetical protein +FIG00661140 hypothetical protein; putative Metallo-phosphoesterase domain +FIG00661145 FIG00661147: hypothetical protein +FIG00661149 FIG00661150: hypothetical protein +FIG00661157 FIG00661159: hypothetical protein +FIG00661170 conserved hypothetical protein; putative bacterial luciferase domain +FIG00661172 Lanthionine biosynthesis protein LanB +FIG00661187 FIG00661190: hypothetical protein +FIG00661190 FIG00661194: hypothetical protein +FIG00661194 FIG00661195: hypothetical protein +FIG00661197 FIG00661206: hypothetical protein +FIG00661207 FIG00661209: hypothetical protein +FIG00661209 Uncharacterized protein PA2024 +FIG00661215 FIG00661217: hypothetical protein +FIG00661217 putative peptide transporter +FIG00661219 FIG00661221: hypothetical protein +FIG00661223 Mycofactocin system small protein +FIG00661225 FIG00661226: hypothetical protein +FIG00661226 FIG00661229: hypothetical protein +FIG00661229 FIG00661240: hypothetical protein +FIG00661250 FIG00661252: hypothetical protein +FIG00661252 FIG00661256: hypothetical protein +FIG00661256 FIG00661261: hypothetical protein +FIG00661262 FIG00661263: hypothetical protein +FIG00661263 hypothetical protein; putative zinc finger domain +FIG00661269 FIG00661271: hypothetical protein +FIG00661279 FIG00661284: hypothetical protein +FIG00661284 FIG00661286: hypothetical protein +FIG00661287 FIG00661291: hypothetical protein +FIG00661296 FIG00661299: hypothetical protein +FIG00661299 FIG00661300: hypothetical protein +FIG00661300 FIG00661305: hypothetical protein +FIG00661307 FIG00661308: hypothetical protein +FIG00661308 protein of unknown function DUF1271 +FIG00661309 arylmalonate decarboxylase +FIG00661331 FIG00661333: hypothetical protein +FIG00661339 ferredoxin 1 +FIG00661340 FIG00661341: hypothetical protein +FIG00661350 FIG00661355: hypothetical protein +FIG00661360 FIG00661364: hypothetical protein +FIG00661364 FIG00661373: hypothetical protein +FIG00661373 FIG00661374: hypothetical protein +FIG00661374 FIG00661375: hypothetical protein +FIG00661375 FIG00661377: hypothetical protein +FIG00661377 FIG00661378: hypothetical protein +FIG00661379 FIG00660200: hypothetical protein +FIG00661382 FIG00661384: hypothetical protein +FIG00661387 putative permease; multidrug efflux protein +FIG00661389 peptidase S49 +FIG00661393 FIG00661395: hypothetical protein +FIG00661401 FIG00661403: hypothetical protein +FIG00661404 Protein of unknown function DUF397 +FIG00661406 FIG00661408: hypothetical protein +FIG00661408 FIG00661409: hypothetical protein +FIG00661409 conserved hypothetical phage tail protein +FIG00661412 Helix-turn-helix, AraC type:ThiJ/PfpI +FIG00661419 FIG00661420: hypothetical protein +FIG00661429 FIG00661432: hypothetical protein +FIG00661445 FIG00661446: hypothetical protein +FIG00661458 Putative oxidoreductase in arabinose utilization cluster +FIG00661479 FIG00661482: hypothetical protein +FIG00661484 Alkyldihydroxyacetonephosphate synthase (EC 2.5.1.26) +FIG00661485 ABC-type multidrug transport system ATPase and permease components +FIG00661486 FIG00661487: hypothetical protein +FIG00661487 2-polyprenyl-6-methoxyphenol hydroxylase and related FAD-dependent oxidoreductases +FIG00661500 FIG00661503: hypothetical protein +FIG00661509 FIG00661511: hypothetical protein +FIG00661511 FIG00661513: hypothetical protein +FIG00661513 FIG024784: Integral membrane protein related to pyrimidine synthesis +FIG00661519 FIG00661522: hypothetical protein +FIG00661522 ABC peptide transporter; membrane component +FIG00661528 FIG00661532: hypothetical protein +FIG00661535 FIG00661536: hypothetical protein +FIG00661556 FIG00661562: hypothetical protein +FIG00661562 FIG00661563: hypothetical protein +FIG00661574 FIG00661576: hypothetical protein +FIG00661579 FIG00661586: hypothetical protein +FIG00661588 FIG00661596: hypothetical protein +FIG00661603 FIG00661607: hypothetical protein +FIG00661607 FIG00661610: hypothetical protein +FIG00661611 FIG00661612: hypothetical protein +FIG00661612 FIG00661622: hypothetical protein +FIG00661627 FIG00661633: hypothetical protein +FIG00661633 hypothetical protein; putative MOSC domain +FIG00661639 FIG00661640: hypothetical protein +FIG00661640 FIG00661644: hypothetical protein +FIG00661657 FIG00661660: hypothetical protein +FIG00661660 FIG00661667: hypothetical protein +FIG00661669 FIG00661670: hypothetical protein +FIG00661683 FIG00661685: hypothetical protein +FIG00661687 FIG00661689: hypothetical protein +FIG00661689 FIG00661690: hypothetical protein +FIG00661690 FIG00661691: hypothetical protein +FIG00661691 FIG00661692: hypothetical protein +FIG00661702 hypothetical protein +FIG00661708 FIG00661709: hypothetical protein +FIG00661712 FIG00661713: hypothetical protein +FIG00661715 FIG00661718: hypothetical protein +FIG00661719 FIG00661720: hypothetical protein +FIG00661720 FIG00661726: hypothetical protein +FIG00661736 FIG00661737: hypothetical protein +FIG00661738 Biphenyl dioxygenase subunit beta (EC 1.14.12.18) (Biphenyl 2,3-dioxygenase) +FIG00661743 FIG00661744: hypothetical protein +FIG00661744 FIG00661750: hypothetical protein +FIG00661754 FIG00661758: hypothetical protein +FIG00661758 FIG00661759: hypothetical protein +FIG00661766 FIG00661767: hypothetical protein +FIG00661772 FIG00661773: hypothetical protein +FIG00661773 FIG00661776: hypothetical protein +FIG00661776 FIG00661778: hypothetical protein +FIG00661778 FIG00661779: hypothetical protein +FIG00661781 POSSIBLE GLUTAREDOXIN PROTEIN +FIG00661782 FIG00661783: hypothetical protein +FIG00661785 FIG00661787: hypothetical protein +FIG00661790 FIG00661793: hypothetical protein +FIG00661812 FIG00661817: hypothetical protein +FIG00661820 FIG00661826: hypothetical protein +FIG00661826 FIG00661827: hypothetical protein +FIG00661827 FIG00661830: hypothetical protein +FIG00661840 FIG00661841: hypothetical protein +FIG00661841 FIG00661846: hypothetical protein +FIG00661848 FIG00661853: hypothetical protein +FIG00661853 FIG00661854: hypothetical protein +FIG00661861 FIG00661863: hypothetical protein +FIG00661863 FIG00661867: hypothetical protein +FIG00661868 FIG00661871: hypothetical protein +FIG00661871 FIG00661874: hypothetical protein +FIG00661874 Bacteriophage (PhiC31) resistance gene pglZ +FIG00661877 FIG00661878: hypothetical protein +FIG00661882 FIG00661883: hypothetical protein +FIG00661886 FIG00661887: hypothetical protein +FIG00661887 FIG00661889: hypothetical protein +FIG00661889 FIG00661892: hypothetical protein +FIG00661892 FIG00661902: hypothetical protein +FIG00661902 FIG00661905: hypothetical protein +FIG00661905 FIG00661908: hypothetical protein +FIG00661914 FIG00661916: hypothetical protein +FIG00661916 FIG00661917: hypothetical protein +FIG00661917 FIG00661919: hypothetical protein +FIG00661923 FIG00661924: hypothetical protein +FIG00661929 ABC transporter sugar permease +FIG00661933 FIG00661935: hypothetical protein +FIG00661942 Lanthionine biosynthesis cyclase LanC +FIG00661945 FIG00661948: hypothetical protein +FIG00661948 FIG00661949: hypothetical protein +FIG00661963 putative Geranylgeranyl hydrogenase +FIG00661967 FIG00661972: hypothetical protein +FIG00661972 FIG00661974: hypothetical protein +FIG00661976 FIG00661979: hypothetical protein +FIG00661986 FIG00661987: hypothetical protein +FIG00661987 FIG00661988: hypothetical protein +FIG00661988 FIG024784: Integral membrane protein related to pyrimidine synthesis +FIG00661993 FIG00661998: hypothetical protein +FIG00662003 FIG00662007: hypothetical protein +FIG00662008 FIG00662011: hypothetical protein +FIG00662013 FIG00662017: hypothetical protein +FIG00662017 FIG00662021: hypothetical protein +FIG00662021 secreted protein +FIG00662037 FIG00662038: hypothetical protein +FIG00662038 FIG00662052: hypothetical protein +FIG00662052 FIG00662057: hypothetical protein +FIG00662069 FIG00662073: hypothetical protein +FIG00662075 FIG00662081: hypothetical protein +FIG00662090 FIG00662092: hypothetical protein +FIG00662092 FIG004853: possible toxin to DivIC +FIG00662108 FIG00662110: hypothetical protein +FIG00662117 Serine/threonine-protein kinase PknA (EC 2.7.11.1) +FIG00662119 FIG00662120: hypothetical protein +FIG00662120 FIG00662121: hypothetical protein +FIG00662121 FIG00662124: hypothetical protein +FIG00662124 FIG00662125: hypothetical protein +FIG00662128 Flavin reductase-like +FIG00662130 Putative sortase (Surface protein transpeptidase) +FIG00662132 PROBABLE CONSERVED TRANSMEMBRANE PROTEIN +FIG00662137 FIG00662140: hypothetical protein +FIG00662141 FIG00662144: hypothetical protein +FIG00662144 FIG00662158: hypothetical protein +FIG00662158 FIG00662164: hypothetical protein +FIG00662164 FIG00662171: hypothetical protein +FIG00662171 FIG00662172: hypothetical protein +FIG00662172 FIG00662178: hypothetical protein +FIG00662199 FIG00662202: hypothetical protein +FIG00662204 Putative hydrolase (partial) +FIG00662206 FIG00662207: hypothetical protein +FIG00662207 FIG00662208: hypothetical protein +FIG00662211 2-deoxy-D-gluconate 3-dehydrogenase( EC:1.1.1.125 ) +FIG00662213 Transcriptional regulator, LacI (Ribose operon repressor) family +FIG00662226 FIG00662233: hypothetical protein +FIG00662242 FIG00662243: hypothetical protein +FIG00662245 FIG00662246: hypothetical protein +FIG00662246 FIG00662249: hypothetical protein +FIG00662249 FIG00662250: hypothetical protein +FIG00662250 FIG00662255: hypothetical protein +FIG00662255 FIG00662256: hypothetical protein +FIG00662265 FIG00662268: hypothetical protein +FIG00662272 hypothetical protein; putative transcriptional regulator +FIG00662279 FIG00662284: hypothetical protein +FIG00662284 FIG00662286: hypothetical protein +FIG00662286 FIG00662287: hypothetical protein +FIG00662287 FIG00662289: hypothetical protein +FIG00662289 FIG00662291: hypothetical protein +FIG00662298 FIG00662313: hypothetical protein +FIG00662314 FIG00662321: hypothetical protein +FIG00662335 FIG00662337: hypothetical protein +FIG00662337 FIG00662338: hypothetical protein +FIG00662344 FIG00662346: hypothetical protein +FIG00662349 transcriptional regulator, SARP family +FIG00662352 FIG00662353: hypothetical protein +FIG00662362 FIG00662363: hypothetical protein +FIG00662363 FIG00662364: hypothetical protein +FIG00662379 FIG00662387: hypothetical protein +FIG00662392 FIG00662395: hypothetical protein +FIG00662395 FIG00662396: hypothetical protein +FIG00662396 FIG00662397: hypothetical protein +FIG00662407 FIG00662409: hypothetical protein +FIG00662416 Undecaprenyl-phosphate N-acetylglucosaminyl 1-phosphate transferase (EC 2.7.8.-) +FIG00662418 FIG00662424: hypothetical protein +FIG00662434 FIG00662435: hypothetical protein +FIG00662435 FIG00662436: hypothetical protein +FIG00662437 FIG00662446: hypothetical protein +FIG00662446 FIG00662452: hypothetical protein +FIG00662452 FIG00662465: hypothetical protein +FIG00662473 FIG00662481: hypothetical protein +FIG00662483 FIG00662487: hypothetical protein +FIG00662487 Membrane protein EccB4, component of Type VII secretion system ESX-4 +FIG00662489 FIG00662495: hypothetical protein +FIG00662495 FIG00662496: hypothetical protein +FIG00662497 FIG00662500: hypothetical protein +FIG00662502 FIG00662503: hypothetical protein +FIG00662504 FIG00662508: hypothetical protein +FIG00662509 FIG00662517: hypothetical protein +FIG00662517 FIG00662523: hypothetical protein +FIG00662528 FIG00662531: hypothetical protein +FIG00662531 FIG00662536: hypothetical protein +FIG00662536 FIG00662539: hypothetical protein +FIG00662539 FIG024795: hypothetical protein +FIG00662546 FIG00662549: hypothetical protein +FIG00662549 FIG00662552: hypothetical protein +FIG00662552 FIG00662554: hypothetical protein +FIG00662558 FIG00662559: hypothetical protein +FIG00662561 FIG00662563: hypothetical protein +FIG00662564 FIG00662570: hypothetical protein +FIG00662577 FIG00662579: hypothetical protein +FIG00662579 FIG00662580: hypothetical protein +FIG00662580 FIG00662582: hypothetical protein +FIG00662582 FIG00662583: hypothetical protein +FIG00662583 FIG00662585: hypothetical protein +FIG00662586 FIG00662589: hypothetical protein +FIG00662594 FIG00662597: hypothetical protein +FIG00662601 putative hydrolase +FIG00662604 FIG00662606: hypothetical protein +FIG00662621 FIG00662622: hypothetical protein +FIG00662622 FIG00662626: hypothetical protein +FIG00662626 9.5 kDa culture filtrate antigen cfp10A +FIG00662627 FIG00662628: hypothetical protein +FIG00662639 FIG00662649: hypothetical protein +FIG00662652 FIG00662654: hypothetical protein +FIG00662666 FIG00662667: hypothetical protein +FIG00662683 FIG00662684: hypothetical protein +FIG00662711 FIG00662712: hypothetical protein +FIG00662716 FIG00662719: hypothetical protein +FIG00662719 FIG00662720: hypothetical protein +FIG00662747 FIG00662748: hypothetical protein +FIG00662748 FIG00662751: hypothetical protein +FIG00662755 FIG00662757: hypothetical protein +FIG00662757 FIG00662759: hypothetical protein +FIG00662759 FIG00662760: hypothetical protein +FIG00662760 FIG00662762: hypothetical protein +FIG00662762 FIG00662763: hypothetical protein +FIG00662763 FIG00662766: hypothetical protein +FIG00662766 FIG00662771: hypothetical protein +FIG00662771 FIG00662777: hypothetical protein +FIG00662777 hypothetical protein associated with LanBC +FIG00662783 FIG00662787: hypothetical protein +FIG00662787 FIG00662788: hypothetical protein +FIG00662788 FIG00662794: hypothetical protein +FIG00662805 FIG00662813: hypothetical protein +FIG00662813 FIG00662827: hypothetical protein +FIG00662840 FIG00662846: hypothetical protein +FIG00662846 FIG00662848: hypothetical protein +FIG00662848 FIG00662851: hypothetical protein +FIG00662863 FIG00662866: hypothetical protein +FIG00662872 FIG00662875: hypothetical protein +FIG00662878 Putative integrase/recombinase y4rA +FIG00662882 FIG00662886: hypothetical protein +FIG00662891 FIG00662897: hypothetical protein +FIG00662897 Lipase, class 2 +FIG00662909 FIG00662910: hypothetical protein +FIG00662910 FIG00662912: hypothetical protein +FIG00662920 FIG00662922: hypothetical protein +FIG00662932 FIG00662934: hypothetical protein +FIG00662934 fadE6 (fadE6) +FIG00662936 FIG00662940: hypothetical protein +FIG00662948 FIG00662949: hypothetical protein +FIG00662950 FIG00662955: hypothetical protein +FIG00662955 FIG00662958: hypothetical protein +FIG00662958 FIG00662960: hypothetical protein +FIG00662986 hypothetical protein; putative Transglutaminase-like domain +FIG00663001 FIG00663006: hypothetical protein +FIG00663013 FIG00663015: hypothetical protein +FIG00663017 FIG00663024: hypothetical protein +FIG00663040 FIG00663041: hypothetical protein +FIG00663071 FIG00663077: hypothetical protein +FIG00663077 FIG00663078: hypothetical protein +FIG00663081 FIG00663087: hypothetical protein +FIG00663088 FIG00663089: hypothetical protein +FIG00663093 FIG00663095: hypothetical protein +FIG00663095 FIG00663098: hypothetical protein +FIG00663098 FIG00663100: hypothetical protein +FIG00663100 FIG00663102: hypothetical protein +FIG00663102 FIG00663108: hypothetical protein +FIG00663108 FIG00663109: hypothetical protein +FIG00663109 Alkyldihydroxyacetonephosphate synthase (EC 2.5.1.26) (Alkyl-DHAP synthase) (Alkylglycerone-phosphate synthase) +FIG00663111 MHYT +FIG00663114 helicase, SNF2 family +FIG00663115 FIG00663118: hypothetical protein +FIG00663119 FIG00663124: hypothetical protein +FIG00663124 FIG00663125: hypothetical protein +FIG00663133 FIG00663136: hypothetical protein +FIG00663140 hypothetical protein; Putative peptidoglycan binding domain +FIG00663142 FIG00663143: hypothetical protein +FIG00663157 FIG00663158: hypothetical protein +FIG00663159 FIG00663162: hypothetical protein +FIG00663181 FIG00663185: hypothetical protein +FIG00663187 SimX4 homolog +FIG00663191 FIG00663192: hypothetical protein +FIG00663192 FIG00663193: hypothetical protein +FIG00663219 FIG00663222: hypothetical protein +FIG00663222 FIG00663226: hypothetical protein +FIG00663228 FIG00663231: hypothetical protein +FIG00663241 FIG00663243: hypothetical protein +FIG00663243 FIG00663245: hypothetical protein +FIG00663253 FIG00663254: hypothetical protein +FIG00663261 FIG00663262: hypothetical protein +FIG00663263 luciferase +FIG00663265 FIG00663266: hypothetical protein +FIG00663278 FIG00663281: hypothetical protein +FIG00663282 FIG00663283: hypothetical protein +FIG00663287 FIG00663289: hypothetical protein +FIG00663290 FIG00663292: hypothetical protein +FIG00663292 FIG00663294: hypothetical protein +FIG00663319 FIG00663320: hypothetical protein +FIG00663328 LpqP +FIG00663357 FIG00663360: hypothetical protein +FIG00663360 Putative FAD-dependent oxidoreductase( EC:1.- ) +FIG00663368 FIG00663370: hypothetical protein +FIG00663377 FIG00663380: hypothetical protein +FIG00663380 SEQ ID NO 11F +FIG00663424 dibenzothiophene desulfurization enzyme A +FIG00663427 FIG00663428: hypothetical protein +FIG00663432 FIG00663435: hypothetical protein +FIG00663443 dolichol-P-glucose synthetase, putative +FIG00663450 FIG00663451: hypothetical protein +FIG00663471 Mandelate racemase/muconate lactonizing enzyme-like protein +FIG00663478 FIG00663483: hypothetical protein +FIG00663507 FIG00663509: hypothetical protein +FIG00663509 Excisionase/Xis, DNA-binding +FIG00663510 FIG00663512: hypothetical protein +FIG00663512 FIG00663517: hypothetical protein +FIG00663518 FIG00663520: hypothetical protein +FIG00663520 FIG00663523: hypothetical protein +FIG00663534 FIG00663535: hypothetical protein +FIG00663540 FIG00663546: hypothetical protein +FIG00663546 FIG00663548: hypothetical protein +FIG00663548 protein of unknown function DUF159 +FIG00663556 FIG00663562: hypothetical protein +FIG00663571 FIG00663578: hypothetical protein +FIG00663581 FIG00663583: hypothetical protein +FIG00663584 FIG00663586: hypothetical protein +FIG00663600 FIG00663605: hypothetical protein +FIG00663617 FIG00663619: hypothetical protein +FIG00663619 FIG00663620: hypothetical protein +FIG00663621 FIG00663622: hypothetical protein +FIG00663623 Bacteriophage (PhiC31) resistance gene pglY +FIG00663630 FIG00663637: hypothetical protein +FIG00663646 FIG00663650: hypothetical protein +FIG00663665 Alpha-methylacyl-CoA racemase( EC:5.1.99.4 ) +FIG00663680 FIG00663683: hypothetical protein +FIG00663701 FIG00663705: hypothetical protein +FIG00663712 FIG00663715: hypothetical protein +FIG00663737 FIG00663738: hypothetical protein +FIG00663740 FIG00663743: hypothetical protein +FIG00663743 FIG00663745: hypothetical protein +FIG00663753 FIG00663754: hypothetical protein +FIG00663754 Probable enoyl-CoA hydratase/3-hydroxyacyl-CoA dehydrogenase, bifunctional enzyme (EC 4.2.1.17) +FIG00663766 FIG00663777: hypothetical protein +FIG00663782 FIG00663783: hypothetical protein +FIG00663790 FIG00663791: hypothetical protein +FIG00663791 FIG00663792: hypothetical protein +FIG00663817 FIG00814443: hypothetical protein +FIG00663822 Dihydroneopterin triphosphate pyrophosphohydolase, putative, Actinobacterial type, NudB-like +FIG00663833 FIG00663834: hypothetical protein +FIG00663834 FIG00663839: hypothetical protein +FIG00663839 FIG00663841: hypothetical protein +FIG00663843 FIG00663844: hypothetical protein +FIG00663846 protein of unknown function DUF692 +FIG00663857 FIG00663860: hypothetical protein +FIG00663869 FIG00663871: hypothetical protein +FIG00663872 FIG00663874: hypothetical protein +FIG00663878 FIG00663879: hypothetical protein +FIG00663902 FIG00663903: hypothetical protein +FIG00663905 FIG00663908: hypothetical protein +FIG00663923 Gas vesicle protein K +FIG00663949 Bll4605 protein +FIG00663960 FIG00663970: hypothetical protein +FIG00663970 FIG00663973: hypothetical protein +FIG00663974 FIG00663978: hypothetical protein +FIG00663981 FIG00663984: hypothetical protein +FIG00663984 FIG00663990: hypothetical protein +FIG00663990 FIG00663991: hypothetical protein +FIG00663991 FIG00663999: hypothetical protein +FIG00664013 FIG00664017: hypothetical protein +FIG00664028 FIG00664032: hypothetical protein +FIG00664035 FIG00664037: hypothetical protein +FIG00664037 FIG00664038: hypothetical protein +FIG00664038 FIG00664040: hypothetical protein +FIG00664052 FIG00664053: hypothetical protein +FIG00664053 RpoS +FIG00664054 FIG00664062: hypothetical protein +FIG00664064 FIG00664072: hypothetical protein +FIG00664073 FIG00664074: hypothetical protein +FIG00664111 FIG00664112: hypothetical protein +FIG00664114 FIG00664124: hypothetical protein +FIG00664124 FIG00664125: hypothetical protein +FIG00664135 FIG00664137: hypothetical protein +FIG00664154 FIG00664158: hypothetical protein +FIG00664164 FIG00664165: hypothetical protein +FIG00664169 FIG00664180: hypothetical protein +FIG00664192 metal transport integral membrane protein +FIG00664200 FIG00664206: hypothetical protein +FIG00664209 FIG00664215: hypothetical protein +FIG00664220 FIG00664221: hypothetical protein +FIG00664224 FIG00664226: hypothetical protein +FIG00664226 FIG00664230: hypothetical protein +FIG00664232 hypothetical protein; putative NUDIX domain +FIG00664236 Putative TetR transcriptional regulator +FIG00664240 FIG00664242: hypothetical protein +FIG00664257 FIG00664259: hypothetical protein +FIG00664260 Hopanoid-associated RND transporter, HpnN +FIG00664279 FIG00664281: hypothetical protein +FIG00664281 FIG00664282: hypothetical protein +FIG00664282 FIG00664283: hypothetical protein +FIG00664301 FIG00664306: hypothetical protein +FIG00664309 FIG00664310: hypothetical protein +FIG00664325 FIG00664329: hypothetical protein +FIG00664377 FIG00664382: hypothetical protein +FIG00664406 FirrV-1-B30 precursor +FIG00664419 FIG01264037: hypothetical protein +FIG00664434 regulatory protein, GntR +FIG00664441 FIG00664443: hypothetical protein +FIG00664444 FIG00664449: hypothetical protein +FIG00664456 FIG00664458: hypothetical protein +FIG00664472 FIG00664474: hypothetical protein +FIG00664477 Bona fide RidA/YjgF/TdcF/RutC subgroup +FIG00664483 FIG00664491: hypothetical protein +FIG00664494 inositol monophosphatase +FIG00664506 FIG00663783: hypothetical protein +FIG00664524 putative ABC-type uncharacterized transport system, substrate-binding protein, membrane component +FIG00664543 FIG00664546: hypothetical protein +FIG00664570 FIG00664572: hypothetical protein +FIG00664601 FIG00664603: hypothetical protein +FIG00664603 FIG00664607: hypothetical protein +FIG00664607 Sulfatase (EC 3.1.6.-) +FIG00664611 FIG00664613: hypothetical protein +FIG00664614 FIG00664615: hypothetical protein +FIG00664633 FIG00664634: hypothetical protein +FIG00664640 FIG00664645: hypothetical protein +FIG00664652 FIG00664669: hypothetical protein +FIG00664687 FIG00664689: hypothetical protein +FIG00664690 FIG00664692: hypothetical protein +FIG00664748 FIG00664751: hypothetical protein +FIG00664754 putative response regulator +FIG00664755 FIG00664756: hypothetical protein +FIG00664783 FIG00664799: hypothetical protein +FIG00664799 FIG00664800: hypothetical protein +FIG00664804 FIG00664806: hypothetical protein +FIG00664808 FIG00664812: hypothetical protein +FIG00664812 Lipid carrier protein or keto acyl-CoA thiolase Ltp3 (EC 2.3.1.16) +FIG00664819 Hypothetical protein; putative Dibenzothiophene desulfurization +FIG00664822 FIG00664823: hypothetical protein +FIG00664833 FIG00664839: hypothetical protein +FIG00664847 TOMM biosynthesis cyclodehydratase (protein C) +FIG00664852 FIG00664854: hypothetical protein +FIG00664856 FIG00664859: hypothetical protein +FIG00664868 FIG00664871: hypothetical protein +FIG00664879 FIG00664885: hypothetical protein +FIG00664892 2-Amino-2-deoxy-isochorismate hydrolase (EC 3.-.-.-) +FIG00664898 FIG00664901: hypothetical protein +FIG00664911 FIG00664917: hypothetical protein +FIG00664921 FIG00664925: hypothetical protein +FIG00664925 FIG00664933: hypothetical protein +FIG00664934 FIG00664939: hypothetical protein +FIG00664941 FIG00664942: hypothetical protein +FIG00664947 FIG00664948: hypothetical protein +FIG00664969 FIG00664970: hypothetical protein +FIG00664977 FIG00664979: hypothetical protein +FIG00664979 FIG00664989: hypothetical protein +FIG00664991 FIG00664994: hypothetical protein +FIG00664994 FIG00664997: hypothetical protein +FIG00665002 FIG00665015: hypothetical protein +FIG00665038 Hypothetical protein; putative methyltransferase +FIG00665078 Epoxide hydrolase 1 (EC 3.3.2.9) +FIG00665098 FIG00665099: hypothetical protein +FIG00665103 FIG00665108: hypothetical protein +FIG00665113 FIG01131824: hypothetical protein +FIG00665120 FIG00665131: hypothetical protein +FIG00665131 FIG00665136: hypothetical protein +FIG00665165 FIG00665172: hypothetical protein +FIG00665173 Acyl-coenzyme A:6-aminopenicillanic-acid-acyltransferase 40 kDa form (EC 2.3.1.164) (Isopenicillin-N N-acyltransferase) [Contains: Acyl-coenzyme A:6-aminopenicillanic-acid-acyltransferase 11 kDa subunit; Acyl-coenzyme A:6-aminopenicillanic-acid-acyltransferase 29 kDa subunit] +FIG00665185 FIG00665187: hypothetical protein +FIG00665192 tunicamycin resistance +FIG00665198 FIG00665199: hypothetical protein +FIG00665200 FIG00665201: hypothetical protein +FIG00665201 FIG00665208: hypothetical protein +FIG00665232 FIG00665236: hypothetical protein +FIG00665288 putative arginine transport protein (ABC superfamily, peri_bind) +FIG00665294 FIG00665297: hypothetical protein +FIG00665302 FIG00665303: hypothetical protein +FIG00665309 FIG00665317: hypothetical protein +FIG00665317 FIG00665318: hypothetical protein +FIG00665322 FIG00665324: hypothetical protein +FIG00665331 FIG00665332: hypothetical protein +FIG00665340 FIG00665345: hypothetical protein +FIG00665346 FIG00665347: hypothetical protein +FIG00665352 FIG00665353: hypothetical protein +FIG00665353 FIG00665361: hypothetical protein +FIG00665363 FIG00665370: hypothetical protein +FIG00665372 FIG00665375: hypothetical protein +FIG00665383 FIG00665386: hypothetical protein +FIG00665403 FIG00665414: hypothetical protein +FIG00665414 FIG00665416: hypothetical protein +FIG00665422 FIG00665423: hypothetical protein +FIG00665426 FIG00665430: hypothetical protein +FIG00665431 FIG00665432: hypothetical protein +FIG00665432 hypothetical protein; putative Esterase/lipase/thioesterase domains +FIG00665444 FIG00665445: hypothetical protein +FIG00665447 FIG00665450: hypothetical protein +FIG00665455 FIG00665457: hypothetical protein +FIG00665457 FIG00665461: hypothetical protein +FIG00665476 FIG00665477: hypothetical protein +FIG00665485 FIG00665486: hypothetical protein +FIG00665486 Dolichol-phosphate mannosyltransferase (EC 2.4.1.83) homolog +FIG00665510 FIG00665512: hypothetical protein +FIG00665512 FIG00665513: hypothetical protein +FIG00665517 FIG00665522: hypothetical protein +FIG00665561 FIG00665565: hypothetical protein +FIG00665568 FIG00665569: hypothetical protein +FIG00665569 FIG00665571: hypothetical protein +FIG00665579 FIG00665581: hypothetical protein +FIG00665586 hypothetical protein; putative Phenylacetic acid degradation-related protein +FIG00665618 FIG00665620: hypothetical protein +FIG00665622 FIG00665624: hypothetical protein +FIG00665629 FIG00665635: hypothetical protein +FIG00665638 FIG00665641: hypothetical protein +FIG00665658 FIG00665664: hypothetical protein +FIG00665669 FIG00665670: hypothetical protein +FIG00665670 FIG00665674: hypothetical protein +FIG00665688 FIG00665693: hypothetical protein +FIG00665706 FIG00665708: hypothetical protein +FIG00665723 FIG00665724: hypothetical protein +FIG00665725 FIG00665727: hypothetical protein +FIG00665727 FIG00665729: hypothetical protein +FIG00665744 putative ATP-dependent helicase +FIG00665751 Putative molybdopterin-guanine dinucleotide biosynthesis protein mobA +FIG00665758 flavin reductase domain protein, FMN-binding +FIG00665766 FIG00665768: hypothetical protein +FIG00665779 FIG00815302: hypothetical protein +FIG00665781 FIG00665782: hypothetical protein +FIG00665797 FIG00665800: hypothetical protein +FIG00665810 FIG00665811: hypothetical protein +FIG00665817 FIG00665829: hypothetical protein +FIG00665839 FIG00665843: hypothetical protein +FIG00665878 FIG00665880: hypothetical protein +FIG00665880 FIG00665882: hypothetical protein +FIG00665894 FIG00665896: hypothetical protein +FIG00665939 FIG00665943: hypothetical protein +FIG00665949 Small Molecule Metabolism; Central intermediary metabolism; sugar-nucleotide biosynthesis, conversions +FIG00665956 FIG00665961: hypothetical protein +FIG00665968 2,4-dienoyl-CoA reductase( EC:1.3.1.34 ) +FIG00665982 Putative ABC-transporter ATP-binding protein( EC:3.6.3.- ) +FIG00666009 FIG00666011: hypothetical protein +FIG00666011 probable DNA-binding protein +FIG00666033 FIG00666034: hypothetical protein +FIG00666053 FIG00666056: hypothetical protein +FIG00666056 ComA operon protein 2 +FIG00666060 FIG00666063: hypothetical protein +FIG00666085 FIG00666089: hypothetical protein +FIG00666109 FIG00666111: hypothetical protein +FIG00666157 Alkaline phosphatase precursor +FIG00666163 FIG00666169: hypothetical protein +FIG00666188 FIG00666190: hypothetical protein +FIG00666190 FIG00666192: hypothetical protein +FIG00666206 FIG00666212: hypothetical protein +FIG00666213 FIG00666222: hypothetical protein +FIG00666222 FIG00666229: hypothetical protein +FIG00666255 FIG00666256: hypothetical protein +FIG00666285 FIG00666287: hypothetical protein +FIG00666287 POSSIBLE CELLULASE CELA1 (ENDOGLUCANASE) (ENDO-1,4-BETA-GLUCANASE) (FI-CMCASE) (CARBOXYMETHYL CELLULASE) (EC 3.2.1.4) +FIG00666290 FIG00666292: hypothetical protein +FIG00666292 putative integral membrane export protein +FIG00666295 putative ABC transporter ATP-binding subunit +FIG00666308 Probable ATP-dependent Clp protease ATP-binding subunit +FIG00666322 Methyltransferase type 12 +FIG00666330 FIG00666341: hypothetical protein +FIG00666362 FIG00666364: hypothetical protein +FIG00666365 protein of unknown function DUF397 +FIG00666376 FIG00666380: hypothetical protein +FIG00666398 FIG00666399: hypothetical protein +FIG00666443 FIG00666445: hypothetical protein +FIG00666451 FIG00666452: hypothetical protein +FIG00666453 FIG00666454: hypothetical protein +FIG00666467 Terminal dioxygenase component of carbazole 1,9a-dioxygenase +FIG00666478 FIG00666479: hypothetical protein +FIG00666500 FIG020554: membrane protein +FIG00666534 FIG00666536: hypothetical protein +FIG00666578 FIG00666586: hypothetical protein +FIG00666624 FIG00666626: hypothetical protein +FIG00666638 FIG00666640: hypothetical protein +FIG00666646 FIG00666652: hypothetical protein +FIG00666652 FIG00666655: hypothetical protein +FIG00666658 FIG00666659: hypothetical protein +FIG00666664 FIG00666665: hypothetical protein +FIG00666688 FIG00666690: hypothetical protein +FIG00666698 FMN-dependent alpha-hydroxy acid dehydrogenase +FIG00666743 FIG00666749: hypothetical protein +FIG00666771 FIG00666776: hypothetical protein +FIG00666776 TOMM export ABC transporter, ATP-binding protein +FIG00666778 FIG00666782: hypothetical protein +FIG00666823 FIG00666829: hypothetical protein +FIG00666839 conserved hypthetical protein; putative FMN-binding split barrel domain (partial match) +FIG00666917 Probable quinone oxidoreductase +FIG00666941 FIG00666942: hypothetical protein +FIG00666962 FIG00666966: hypothetical protein +FIG00666979 FIG00666987: hypothetical protein +FIG00666993 FIG00666994: hypothetical protein +FIG00667008 FIG00667012: hypothetical protein +FIG00667017 FIG00667020: hypothetical protein +FIG00667022 FIG00667027: hypothetical protein +FIG00667027 Response regulator receiver +FIG00667094 FIG00667103: hypothetical protein +FIG00667110 FIG00667112: hypothetical protein +FIG00667112 FIG00667113: hypothetical protein +FIG00667155 FIG00667157: hypothetical protein +FIG00667266 FIG00667269: hypothetical protein +FIG00667270 FIG00667273: hypothetical protein +FIG00667273 FIG00667276: hypothetical protein +FIG00667294 FIG00667298: hypothetical protein +FIG00667334 FIG00667337: hypothetical protein +FIG00667345 FIG00667349: hypothetical protein +FIG00667412 FIG00667414: hypothetical protein +FIG00667421 Putative HTH-type transcriptional regulator Mb0914c +FIG00667474 FIG00667479: hypothetical protein +FIG00667498 FIG00667499: hypothetical protein +FIG00667523 FIG00667524: hypothetical protein +FIG00667529 FIG00667534: hypothetical protein +FIG00667543 FIG00667550: hypothetical protein +FIG00667557 FIG00667564: hypothetical protein +FIG00667600 FIG00667605: hypothetical protein +FIG00667622 FIG00667623: hypothetical protein +FIG00667625 FIG00667626: hypothetical protein +FIG00667648 FIG00667650: hypothetical protein +FIG00667686 FIG00667687: hypothetical protein +FIG00667764 FIG00667770: hypothetical protein +FIG00667825 FIG00667826: hypothetical protein +FIG00667850 FIG00667855: hypothetical protein +FIG00667884 FIG00667886: hypothetical protein +FIG00667886 Sll1504 protein +FIG00667887 Mlr6999 protein +FIG00667913 lipid-transfer protein +FIG00667928 NAD-binding protein, putative +FIG00667942 FIG00667953: hypothetical protein +FIG00667963 FIG00667964: hypothetical protein +FIG00667964 FIG00667968: hypothetical protein +FIG00667981 FIG00667993: hypothetical protein +FIG00668010 FIG00668014: hypothetical protein +FIG00668014 BarH +FIG00668023 FIG00668024: hypothetical protein +FIG00668058 Aquaporin Z / Arsenate reductase (EC 1.20.4.1) +FIG00668060 FIG00668062: hypothetical protein +FIG00668068 NA+/H+ ANTIPORTER NHAC +FIG00668071 FIG00668074: hypothetical protein +FIG00668074 Glutaconyl-CoA decarboxylase delta chain (EC 4.1.1.70) +FIG00668075 FIG00668076: hypothetical protein +FIG00668076 FIG00668078: hypothetical protein +FIG00668078 FIG00668080: hypothetical protein +FIG00668080 Hypothetical Exported Protein +FIG00668085 FIG00668086: hypothetical protein +FIG00668092 FIG00668093: hypothetical protein +FIG00668093 FIG00668094: hypothetical protein +FIG00668094 FIG00668095: hypothetical protein +FIG00668096 FIG00668097: hypothetical protein +FIG00668098 FIG00668099: hypothetical protein +FIG00668100 FIG00668102: hypothetical protein +FIG00668102 FIG00668103: hypothetical protein +FIG00668103 FIG00668104: hypothetical protein +FIG00668104 FIG00668105: hypothetical protein +FIG00668106 FIG00668107: hypothetical protein +FIG00668107 FIG00668108: hypothetical protein +FIG00668108 FIG00668109: hypothetical protein +FIG00668109 FIG00668110: hypothetical protein +FIG00668110 FIG00668111: hypothetical protein +FIG00668113 DNASE I HOMOLOGOUS PROTEIN DHP2 PRECURSOR (EC 3.1.21.-) +FIG00668119 FIG00668120: hypothetical protein +FIG00668120 FIG00668121: hypothetical protein +FIG00668121 FIG00668123: hypothetical protein +FIG00668123 FIG00668125: hypothetical protein +FIG00668129 Glycine betaine transport ATP-binding protein +FIG00668132 Sensory Transduction Protein Kinase +FIG00668133 FIG00668134: hypothetical protein +FIG00668134 FIG00668135: hypothetical protein +FIG00668135 FIG00668136: hypothetical protein +FIG00668136 OXYGEN-INSENSITIVE NAD(P)H NITROREDUCTASE( EC:1.-,EC:1.6.99.7 ) +FIG00668137 Benzoyl-CoA reductase subunit BadE (EC 1.3.99.15) +FIG00668138 FIG00668140: hypothetical protein +FIG00668142 FIG00668143: hypothetical protein +FIG00668145 FIG00668146: hypothetical protein +FIG00668147 FIG00668148: hypothetical protein +FIG00668149 FIG00668150: hypothetical protein +FIG00668150 FIG00668151: hypothetical protein +FIG00668152 Acriflavin resistance periplasmic protein +FIG00668157 FIG00668158: hypothetical protein +FIG00668158 FIG00668160: hypothetical protein +FIG00668160 FIG00668162: hypothetical protein +FIG00668167 FIG00668170: hypothetical protein +FIG00668172 Ketoacyl reductase hetN +FIG00668173 FIG00668175: hypothetical protein +FIG00668175 FIG00668176: hypothetical protein +FIG00668176 FIG00668177: hypothetical protein +FIG00668178 FIG00668179: hypothetical protein +FIG00668179 Serine/threonine protein kinase( EC:2.7.1.37 ) +FIG00668180 FIG00668181: hypothetical protein +FIG00668187 FIG00668188: hypothetical protein +FIG00668188 FIG00668189: hypothetical protein +FIG00668189 FIG00668190: hypothetical protein +FIG00668190 Export ABC transporter +FIG00668193 FIG00668194: hypothetical protein +FIG00668195 FIG00668196: hypothetical protein +FIG00668197 FIG00668198: hypothetical protein +FIG00668198 FIG00668199: hypothetical protein +FIG00668199 FIG00668200: hypothetical protein +FIG00668202 FIG00668203: hypothetical protein +FIG00668203 FIG00668205: hypothetical protein +FIG00668205 FIG00668206: hypothetical protein +FIG00668208 FIG00668209: hypothetical protein +FIG00668211 FIG00668212: hypothetical protein +FIG00668214 FIG00668215: hypothetical protein +FIG00668217 FIG00668218: hypothetical protein +FIG00668218 FIG00668219: hypothetical protein +FIG00668219 Serine racemase( EC:5.1.1.- ) +FIG00668222 Flavodoxins/hemoproteins +FIG00668223 FIG00668224: hypothetical protein +FIG00668224 FIG00668225: hypothetical protein +FIG00668232 FIG00668233: hypothetical protein +FIG00668235 FIG00668236: hypothetical protein +FIG00668236 FIG00668237: hypothetical protein +FIG00668237 FIG00668238: hypothetical protein +FIG00668238 FIG00668239: hypothetical protein +FIG00668240 FIG00668241: hypothetical protein +FIG00668242 FIG00668244: hypothetical protein +FIG00668245 FIG00668246: hypothetical protein +FIG00668246 FIG00668247: hypothetical protein +FIG00668247 putative nucleotide-binding protein +FIG00668250 FIG00668251: hypothetical protein +FIG00668251 FIG00668252: hypothetical protein +FIG00668252 FIG00668253: hypothetical protein +FIG00668255 FIG00668256: hypothetical protein +FIG00668256 FIG00668257: hypothetical protein +FIG00668257 FIG00668258: hypothetical protein +FIG00668259 Two component system histidine kinase +FIG00668264 2-hydroxyglutarate dehydrogenase +FIG00668266 FIG00668267: hypothetical protein +FIG00668267 FIG00668268: hypothetical protein +FIG00668268 FIG00668269: hypothetical protein +FIG00668270 FIG00668271: hypothetical protein +FIG00668273 Two-component sensor kinase czcS +FIG00668275 FIG00668276: hypothetical protein +FIG00668276 FIG00668277: hypothetical protein +FIG00668277 FIG00668278: hypothetical protein +FIG00668281 Oxygen-independent coproporphyrinogen III oxidase +FIG00668282 Oxygen-insensitive NAD(P)H nitroreductase +FIG00668284 FIG00668285: hypothetical protein +FIG00668287 FIG00668288: hypothetical protein +FIG00668288 FIG00668290: hypothetical protein +FIG00668291 FIG00668294: hypothetical protein +FIG00668296 FIG00668297: hypothetical protein +FIG00668297 FIG00668299: hypothetical protein +FIG00668299 FIG00668301: hypothetical protein +FIG00668302 FIG00668303: hypothetical protein +FIG00668304 Lipid IVA 3-deoxy-D-manno-octulosonic acid transferase (EC 2.4.99.12) [often with (EC 2.4.99.13) also] / tRNA (guanine46-N7-)-methyltransferase (EC 2.1.1.33) +FIG00668305 ~213aa hypothetical protein: FIG00668306 +FIG00668306 FIG00668307: hypothetical protein +FIG00668307 Exoenzyme regulatory protein aepA precursor +FIG00668310 CRISPR-associated protein Cas6 +FIG00668313 FIG00668314: hypothetical protein +FIG00668315 FIG00668316: hypothetical protein +FIG00668319 FIG00668320: hypothetical protein +FIG00668322 FIG00668323: hypothetical protein +FIG00668323 FIG00668324: hypothetical protein +FIG00668324 FIG00668325: hypothetical protein +FIG00668325 FIG00668326: hypothetical protein +FIG00668330 FIG00668331: hypothetical protein +FIG00668333 FIG00668334: hypothetical protein +FIG00668334 FIG00668335: hypothetical protein +FIG00668343 FIG00668344: hypothetical protein +FIG00668346 FIG00668347: hypothetical protein +FIG00668347 FIG00668348: hypothetical protein +FIG00668348 FIG00668350: hypothetical protein +FIG00668350 FIG00668351: hypothetical protein +FIG00668351 FIG00668352: hypothetical protein +FIG00668352 Ser/Thr protein kinase( EC:2.7.1.37 ) +FIG00668355 FIG00668356: hypothetical protein +FIG00668359 Phage DNA binding ATPase +FIG00668361 FIG00668362: hypothetical protein +FIG00668365 FIG00668366: hypothetical protein +FIG00668368 FIG00668369: hypothetical protein +FIG00668369 34 kDa membrane antigen precursor +FIG00668373 Iron(III)-binding protein +FIG00668374 FIG00668375: hypothetical protein +FIG00668376 Putative high-affinity iron permease +FIG00668378 FIG00668379: hypothetical protein +FIG00668380 FIG00668381: hypothetical protein +FIG00668381 FIG00668382: hypothetical protein +FIG00668382 Nitrogen regulatory IIA protein (EC 2.7.1.69) +FIG00668384 FIG00668385: hypothetical protein +FIG00668387 FIG00668388: hypothetical protein +FIG00668389 FIG00668390: hypothetical protein +FIG00668390 FIG00668392: hypothetical protein +FIG00668392 FIG00668393: hypothetical protein +FIG00668395 FIG00668396: hypothetical protein +FIG00668396 FIG00668397: hypothetical protein +FIG00668398 Phophatidylinositol-4-phosphate 5-kinase( EC:2.7.1.68 ) +FIG00668399 M. jannaschii predicted coding region MJ1477 +FIG00668400 FIG00668402: hypothetical protein +FIG00668403 FIG00668405: hypothetical protein +FIG00668405 FIG00668406: hypothetical protein +FIG00668410 FIG00668412: hypothetical protein +FIG00668412 Sodium-dependent tryptophan transporter +FIG00668414 FIG00668415: hypothetical protein +FIG00668415 FIG00668416: hypothetical protein +FIG00668420 FIG00668422: hypothetical protein +FIG00668426 FIG00668428: hypothetical protein +FIG00668429 phage terminase, small subunit, P27 family +FIG00668434 FIG00668435: hypothetical protein +FIG00668435 FIG00668436: hypothetical protein +FIG00668438 FIG00668439: hypothetical protein +FIG00668439 FIG00668440: hypothetical protein +FIG00668443 FIG00668444: hypothetical protein +FIG00668445 FIG00668446: hypothetical protein +FIG00668446 FIG00668447: hypothetical protein +FIG00668456 RelB/StbD replicon stabilization protein (antitoxin to RelE/StbE) +FIG00668458 FIG00668459: hypothetical protein +FIG00668459 FIG00668460: hypothetical protein +FIG00668462 FIG00668465: hypothetical protein +FIG00668466 Spermidine/putrescine-binding protein +FIG00668467 INTEGRAL MEMBRANE PROTEIN, YGGT FAMILY +FIG00668472 FIG00668473: hypothetical protein +FIG00668474 FIG00668475: hypothetical protein +FIG00668477 FIG00668478: hypothetical protein +FIG00668478 FIG00668479: hypothetical protein +FIG00668481 FIG00668482: hypothetical protein +FIG00668482 FIG00668484: hypothetical protein +FIG00668487 FIG00668488: hypothetical protein +FIG00668492 FIG00668493: hypothetical protein +FIG00668496 FIG00668497: hypothetical protein +FIG00668497 FIG00668499: hypothetical protein +FIG00668501 FIG00668502: hypothetical protein +FIG00668502 FIG00668503: hypothetical protein +FIG00668506 FIG00668507: hypothetical protein +FIG00668508 FIG00668509: hypothetical protein +FIG00668509 FIG00668510: hypothetical protein +FIG00668510 FIG00668511: hypothetical protein +FIG00668512 FIG00668513: hypothetical protein +FIG00668513 FIG00668514: hypothetical protein +FIG00668518 FIG00668519: hypothetical protein +FIG00668519 possible bacteriophage packaging protein +FIG00668520 FIG00668521: hypothetical protein +FIG00668522 FIG00668523: hypothetical protein +FIG00668525 FIG00668526: hypothetical protein +FIG00668528 ABC transporter integral membrane protein +FIG00668529 FIG00668531: hypothetical protein +FIG00668533 FIG00668534: hypothetical protein +FIG00668537 FIG00668538: hypothetical protein +FIG00668538 FIG00668539: hypothetical protein +FIG00668541 FIG00668542: hypothetical protein +FIG00668547 FIG00668548: hypothetical protein +FIG00668549 FIG00668550: hypothetical protein +FIG00668555 FIG00668557: hypothetical protein +FIG00668557 FIG00668559: hypothetical protein +FIG00668559 FIG00668560: hypothetical protein +FIG00668561 FIG00668563: hypothetical protein +FIG00668563 FIG00668564: hypothetical protein +FIG00668569 FIG00668570: hypothetical protein +FIG00668571 FIG00668572: hypothetical protein +FIG00668572 FIG00668573: hypothetical protein +FIG00668574 FIG00668575: hypothetical protein +FIG00668575 FIG00668576: hypothetical protein +FIG00668576 ~128aa hypothetical protein: FIG00668915 +FIG00668580 FIG00668581: hypothetical protein +FIG00668582 FIG00668583: hypothetical protein +FIG00668583 2',3'-cyclic nucleotide 3'-phosphodiesterase +FIG00668586 FIG00668587: hypothetical protein +FIG00668593 FIG00668594: hypothetical protein +FIG00668598 FIG00668599: hypothetical protein +FIG00668599 FIG00668600: hypothetical protein +FIG00668601 METAL DEPENDENT HYDROLASE +FIG00668602 FIG00668604: hypothetical protein +FIG00668604 FIG00668605: hypothetical protein +FIG00668605 FIG00668606: hypothetical protein +FIG00668613 FIG00668616: hypothetical protein +FIG00668621 FIG00668622: hypothetical protein +FIG00668622 FIG00668623: hypothetical protein +FIG00668624 FIG00668625: hypothetical protein +FIG00668625 FIG00668626: hypothetical protein +FIG00668626 FIG00668628: hypothetical protein +FIG00668629 FIG00668630: hypothetical protein +FIG00668630 Acriflavin resistance protein B +FIG00668632 FIG00668633: hypothetical protein +FIG00668633 FIG00668634: hypothetical protein +FIG00668634 FIG00668635: hypothetical protein +FIG00668636 FIG00668637: hypothetical protein +FIG00668639 FIG00668640: hypothetical protein +FIG00668641 Alkaline shock protein +FIG00668649 FIG00668650: hypothetical protein +FIG00668650 FIG00668651: hypothetical protein +FIG00668657 FIG00668658: hypothetical protein +FIG00668663 8-oxoguanine DNA glycosylase +FIG00668664 FIG00668665: hypothetical protein +FIG00668667 FIG00668668: hypothetical protein +FIG00668674 FIG00668675: hypothetical protein +FIG00668682 FIG00668683: hypothetical protein +FIG00668686 FIG00668687: hypothetical protein +FIG00668691 FIG00668692: hypothetical protein +FIG00668692 FIG00668693: hypothetical protein +FIG00668694 FIG00668695: hypothetical protein +FIG00668697 FIG00668699: hypothetical protein +FIG00668699 PTS SYSTEM, IIA COMPONENT +FIG00668700 FIG00668701: hypothetical protein +FIG00668705 FIG00668706: hypothetical protein +FIG00668706 ABC-type sugar (aldose) transport system, ATPase component +FIG00668707 MORN variant repeat protein +FIG00668709 FIG00668710: hypothetical protein +FIG00668710 FIG00668711: hypothetical protein +FIG00668719 glycerol dehydratase reactivation factor, small subunit +FIG00668726 FIG00668727: hypothetical protein +FIG00668729 FIG00668730: hypothetical protein +FIG00668730 FIG00668731: hypothetical protein +FIG00668732 FIG00668736: hypothetical protein +FIG00668737 FIG00668739: hypothetical protein +FIG00668740 FIG00668741: hypothetical protein +FIG00668742 FIG00668744: hypothetical protein +FIG00668745 FIG00668746: hypothetical protein +FIG00668746 Zinc metalloprotease( EC:3.4.24.- ) +FIG00668748 FIG00668749: hypothetical protein +FIG00668749 FIG00668751: hypothetical protein +FIG00668751 FIG00668753: hypothetical protein +FIG00668753 FIG00668754: hypothetical protein +FIG00668755 FIG00668756: hypothetical protein +FIG00668757 FIG00668759: hypothetical protein +FIG00668760 FIG00668761: hypothetical protein +FIG00668762 3-oxoadipate CoA-transferase subunit B (EC 2.8.3.6); Glutaconate CoA-transferase subunit B (EC 2.8.3.12) +FIG00668764 FIG00668765: hypothetical protein +FIG00668765 ATP-dependent DNA helicase recG( EC:3.6.1.- ) +FIG00668767 FIG00668768: hypothetical protein +FIG00668768 FIG00668769: hypothetical protein +FIG00668770 FIG00668772: hypothetical protein +FIG00668772 Dolichol-phosphate mannosyltransferase( EC:2.4.1.83 ) +FIG00668773 FIG00668774: hypothetical protein +FIG00668774 FIG00668775: hypothetical protein +FIG00668776 microcompartments protein +FIG00668777 Sodium-dependent tyrosine transporter +FIG00668779 FIG00668782: hypothetical protein +FIG00668784 FIG00668785: hypothetical protein +FIG00668785 FIG00668786: hypothetical protein +FIG00668787 Phage-like element PBSX protein xkdT +FIG00668789 FIG00668791: hypothetical protein +FIG00668791 FIG00668792: hypothetical protein +FIG00668792 FIG00668793: hypothetical protein +FIG00668796 Multidrug resistance protein 2 +FIG00668798 FIG00668799: hypothetical protein +FIG00668799 FIG00668800: hypothetical protein +FIG00668801 FIG00668802: hypothetical protein +FIG00668802 FIG00668803: hypothetical protein +FIG00668804 FIG00668805: hypothetical protein +FIG00668810 FIG00668811: hypothetical protein +FIG00668816 FIG00668817: hypothetical protein +FIG00668817 FIG00668818: hypothetical protein +FIG00668819 FIG00668820: hypothetical protein +FIG00668820 15 kDa lipoprotein precursor +FIG00668821 PTS system, glucose-specific IIA component +FIG00668822 FIG00668823: hypothetical protein +FIG00668823 FIG00668825: hypothetical protein +FIG00668825 FIG00668826: hypothetical protein +FIG00668829 FIG00668830: hypothetical protein +FIG00668831 FIG00668832: hypothetical protein +FIG00668832 FIG00668833: hypothetical protein +FIG00668837 Tetracenomycin polyketide synthesis O-methyltransferase tcmP +FIG00668840 FIG00668841: hypothetical protein +FIG00668841 FIG00668842: hypothetical protein +FIG00668843 FIG00668846: hypothetical protein +FIG00668853 FIG00668854: hypothetical protein +FIG00668856 FIG00668857: hypothetical protein +FIG00668858 FIG00668861: hypothetical protein +FIG00668861 FIG00668862: hypothetical protein +FIG00668866 FIG00668867: hypothetical protein +FIG00668869 FIG00668871: hypothetical protein +FIG00668871 FIG00668874: hypothetical protein +FIG00668877 FIG00668879: hypothetical protein +FIG00668880 FIG00668881: hypothetical protein +FIG00668882 FIG00668884: hypothetical protein +FIG00668884 ATP synthase protein I, sodium ion specific +FIG00668887 Tricarboxylate transport membrane protein TctB +FIG00668890 FIG00668892: hypothetical protein +FIG00668893 FIG00668894: hypothetical protein +FIG00668894 nitrate ABC transporter, ATP-binding protein +FIG00668900 Malonate transporter +FIG00668901 FIG00668903: hypothetical protein +FIG00668904 FIG00668905: hypothetical protein +FIG00668908 FIG00668909: hypothetical protein +FIG00668909 FIG00668911: hypothetical protein +FIG00668913 ~128aa hypothetical protein: FIG00668915 +FIG00668915 FIG00668917: hypothetical protein +FIG00668917 FIG00668918: hypothetical protein +FIG00668919 FIG00668920: hypothetical protein +FIG00668922 FIG00668923: hypothetical protein +FIG00668924 FIG00668925: hypothetical protein +FIG00668925 FIG00668926: hypothetical protein +FIG00668926 FIG00668927: hypothetical protein +FIG00668930 FIG00668931: hypothetical protein +FIG00668931 FIG00668932: hypothetical protein +FIG00668932 FIG00668936: hypothetical protein +FIG00668936 Prohibitin +FIG00668942 FIG00668944: hypothetical protein +FIG00668945 FIG00668946: hypothetical protein +FIG00668946 FIG00668949: hypothetical protein +FIG00668949 FIG00668950: hypothetical protein +FIG00668951 FIG00668952: hypothetical protein +FIG00668955 FIG00668957: hypothetical protein +FIG00668957 FIG00668958: hypothetical protein +FIG00668963 FIG00668964: hypothetical protein +FIG00668968 FIG00668969: hypothetical protein +FIG00668970 FIG00668971: hypothetical protein +FIG00668971 FIG00668972: hypothetical protein +FIG00668972 FIG00668973: hypothetical protein +FIG00668975 FIG00668977: hypothetical protein +FIG00668977 UNC-44 ANKYRINS +FIG00668978 FIG00668979: hypothetical protein +FIG00668979 FIG00668981: hypothetical protein +FIG00668981 FIG00668983: hypothetical protein +FIG00668983 FIG00668984: hypothetical protein +FIG00668984 hypothetical ribosome-associated protein +FIG00668988 L-alanyl-D-glutamate peptidase( EC:3.4.- ) +FIG00668991 Esterase( EC:3.- ) +FIG00668993 FIG00668994: hypothetical protein +FIG00668995 FIG00668996: hypothetical protein +FIG00668996 FIG00668997: hypothetical protein +FIG00668997 FIG00668998: hypothetical protein +FIG00669000 FIG00669001: hypothetical protein +FIG00669001 FIG00669002: hypothetical protein +FIG00669002 FIG00669003: hypothetical protein +FIG00669003 unknown next to FUPA32 +FIG00669004 FIG00669005: hypothetical protein +FIG00669005 FIG00669006: hypothetical protein +FIG00669008 FIG00669009: hypothetical protein +FIG00669010 FIG00669011: hypothetical protein +FIG00669014 FIG00669015: hypothetical protein +FIG00669015 FIG00669017: hypothetical protein +FIG00669018 Prolipoprotein diacylglyceryltransferase +FIG00669020 SPOIID HOMOLOG +FIG00669021 FIG00669022: hypothetical protein +FIG00669025 FIG00669026: hypothetical protein +FIG00669029 FIG00669030: hypothetical protein +FIG00669031 FIG00669032: hypothetical protein +FIG00669032 FIG00669033: hypothetical protein +FIG00669034 NADH dehydrogenase, similar to nitrite reductase +FIG00669037 FIG00669038: hypothetical protein +FIG00669041 FIG00669042: hypothetical protein +FIG00669048 FIG00669049: hypothetical protein +FIG00669049 FIG00669050: hypothetical protein +FIG00669051 FIG00669052: hypothetical protein +FIG00669052 FIG00669054: hypothetical protein +FIG00669056 FIG00669057: hypothetical protein +FIG00669058 probable ABC transporter +FIG00669059 FIG00669060: hypothetical protein +FIG00669060 FIG00669061: hypothetical protein +FIG00669064 FIG00669065: hypothetical protein +FIG00669066 Lipopolysaccharide N-acetylglucosaminyltransferase +FIG00669074 Threonine/Serine Exporter +FIG00669077 FIG00669078: hypothetical protein +FIG00669078 replication initiator protein A +FIG00669079 FIG00669080: hypothetical protein +FIG00669080 FIG00669081: hypothetical protein +FIG00669081 FIG00669087: hypothetical protein +FIG00669088 FIG00669089: hypothetical protein +FIG00669089 FIG00669090: hypothetical protein +FIG00669093 FIG00669094: hypothetical protein +FIG00669095 FIG00669096: hypothetical protein +FIG00669097 FIG00669099: hypothetical protein +FIG00669101 FIG00669102: hypothetical protein +FIG00669103 Zinc metalloprotease +FIG00669109 FIG00669111: hypothetical protein +FIG00669112 FIG00669113: hypothetical protein +FIG00669113 FIG00669114: hypothetical protein +FIG00669118 FIG00669119: hypothetical protein +FIG00669120 carbamoyl phosphate synthase L chain( EC:6.3.4.16,EC:6.4.1.1 ) +FIG00669128 FIG00669129: hypothetical protein +FIG00669130 FIG00669131: hypothetical protein +FIG00669131 FIG00669134: hypothetical protein +FIG00669134 FIG00669135: hypothetical protein +FIG00669135 IRON-SULFUR FLAVOPROTEIN +FIG00669137 FIG00669138: hypothetical protein +FIG00669141 Hemin receptor +FIG00669143 FIG00669145: hypothetical protein +FIG00669147 FIG00669148: hypothetical protein +FIG00669148 FIG00669149: hypothetical protein +FIG00669149 FIG00669150: hypothetical protein +FIG00669150 FIG00669151: hypothetical protein +FIG00669155 FIG00669157: hypothetical protein +FIG00669161 FIG00669162: hypothetical protein +FIG00669163 FIG00669166: hypothetical protein +FIG00669171 FIG00669172: hypothetical protein +FIG00669172 FIG00669173: hypothetical protein +FIG00669175 FIG00669178: hypothetical protein +FIG00669178 FIG00669179: hypothetical protein +FIG00669180 FIG00669181: hypothetical protein +FIG00669185 DNA-DAMAGE-INDUCIBLE PROTEIN +FIG00669187 FIG00669188: hypothetical protein +FIG00669189 FIG00669190: hypothetical protein +FIG00669195 FIG00669196: hypothetical protein +FIG00669196 FIG00669197: hypothetical protein +FIG00669197 FIG00669198: hypothetical protein +FIG00669199 FIG00669200: hypothetical protein +FIG00669203 FIG00669204: hypothetical protein +FIG00669215 FIG00669216: hypothetical protein +FIG00669219 FIG00669222: hypothetical protein +FIG00669222 FIG00669223: hypothetical protein +FIG00669225 FIG00669226: hypothetical protein +FIG00669227 DNA-repair protein +FIG00669229 FIG00669230: hypothetical protein +FIG00669234 FIG00669235: hypothetical protein +FIG00669235 Propanediol dehydratase medium subunit (EC 4.2.1.28) +FIG00669237 FIG00669238: hypothetical protein +FIG00669239 FIG00669243: hypothetical protein +FIG00669243 FIG00669244: hypothetical protein +FIG00669244 FIG00669245: hypothetical protein +FIG00669245 LOS biosynthesis enzyme LBGB +FIG00669249 FIG00669250: hypothetical protein +FIG00669256 FIG00669257: hypothetical protein +FIG00669257 FIG00669259: hypothetical protein +FIG00669259 FIG00669260: hypothetical protein +FIG00669260 FIG00669261: hypothetical protein +FIG00669268 FIG00669269: hypothetical protein +FIG00669272 FIG00669273: hypothetical protein +FIG00669274 FIG00669275: hypothetical protein +FIG00669275 FIG00669276: hypothetical protein +FIG00669281 FIG00669282: hypothetical protein +FIG00669285 FIG00669286: hypothetical protein +FIG00669286 Outer membrane porin F +FIG00669298 FIG00669299: hypothetical protein +FIG00669301 FIG00669302: hypothetical protein +FIG00669302 Coproporphyrinogen III oxidase +FIG00669303 FIG00669304: hypothetical protein +FIG00669306 FIG00669307: hypothetical protein +FIG00669309 FIG00669310: hypothetical protein +FIG00669311 FIG00669313: hypothetical protein +FIG00669314 FIG00669317: hypothetical protein +FIG00669323 FIG00669325: hypothetical protein +FIG00669330 LexA repressor( EC:3.4.21.88 ) +FIG00669333 FIG00669334: hypothetical protein +FIG00669334 FIG00669335: hypothetical protein +FIG00669337 FIG00669339: hypothetical protein +FIG00669339 FIG00669340: hypothetical protein +FIG00669345 FIG00669346: hypothetical protein +FIG00669348 Neutrophil-activating protein A +FIG00669352 FIG00669355: hypothetical protein +FIG00669357 FIG00669358: hypothetical protein +FIG00669358 FIG00669359: hypothetical protein +FIG00669361 FIG00669363: hypothetical protein +FIG00669365 FIG00669368: hypothetical protein +FIG00669372 FIG00669374: hypothetical protein +FIG00669375 FIG00669381: hypothetical protein +FIG00669386 Melibiose carrier protein +FIG00669389 FIG00669390: hypothetical protein +FIG00669391 24 kDa outer membrane protein precursor +FIG00669392 FIG00669393: hypothetical protein +FIG00669393 FIG00669394: hypothetical protein +FIG00669394 FIG00669396: hypothetical protein +FIG00669406 FIG00669407: hypothetical protein +FIG00669409 FIG00669410: hypothetical protein +FIG00669412 FIG00669413: hypothetical protein +FIG00669414 FIG00669415: hypothetical protein +FIG00669415 FIG00669416: hypothetical protein +FIG00669419 flavoredoxin +FIG00669423 FIG00669424: hypothetical protein +FIG00669428 FIG00669429: hypothetical protein +FIG00669429 Transcriptional regulatory protein, LYSR family +FIG00669431 FIG00669432: hypothetical protein +FIG00669433 FIG00669434: hypothetical protein +FIG00669436 FIG00669438: hypothetical protein +FIG00669439 FIG00669442: hypothetical protein +FIG00669447 FIG00669448: hypothetical protein +FIG00669448 FIG00669449: hypothetical protein +FIG00669450 FIG00669452: hypothetical protein +FIG00669454 FIG00669457: hypothetical protein +FIG00669458 FIG00669459: hypothetical protein +FIG00669459 FIG00669460: hypothetical protein +FIG00669460 FIG00669461: hypothetical protein +FIG00669470 FIG00669471: hypothetical protein +FIG00669471 FIG00669472: hypothetical protein +FIG00669473 FIG00669474: hypothetical protein +FIG00669474 FIG00669475: hypothetical protein +FIG00669481 FIG00669482: hypothetical protein +FIG00669482 FIG00669483: hypothetical protein +FIG00669483 FIG00669484: hypothetical protein +FIG00669487 FIG00669488: hypothetical protein +FIG00669490 FIG00669491: hypothetical protein +FIG00669492 FIG00669493: hypothetical protein +FIG00669493 FIG00669494: hypothetical protein +FIG00669494 FIG00669495: hypothetical protein +FIG00669495 FIG00669496: hypothetical protein +FIG00669497 FIG00669498: hypothetical protein +FIG00669508 FIG00669509: hypothetical protein +FIG00669515 Phosphohydrolase (MUTT/NUDIX family protein) +FIG00669518 FIG00669519: hypothetical protein +FIG00669519 FIG00670480: hypothetical protein +FIG00669522 FIG00669523: hypothetical protein +FIG00669523 FIG00669524: hypothetical protein +FIG00669524 FIG00669525: hypothetical protein +FIG00669528 FIG00669529: hypothetical protein +FIG00669534 TRANSPORTER, LysE family +FIG00669537 FIG00669539: hypothetical protein +FIG00669540 Gluconate 5-dehydrogenase +FIG00669541 FIG00669542: hypothetical protein +FIG00669542 FIG00669543: hypothetical protein +FIG00669545 FIG00669547: hypothetical protein +FIG00669549 FIG00669552: hypothetical protein +FIG00669552 FIG00669553: hypothetical protein +FIG00669553 FIG00669554: hypothetical protein +FIG00669559 FIG00669560: hypothetical protein +FIG00669564 FIG00669565: hypothetical protein +FIG00669565 FIG00669566: hypothetical protein +FIG00669568 FIG00669569: hypothetical protein +FIG00669580 HigA protein (antitoxin to HigB) +FIG00669581 FIG00669583: hypothetical protein +FIG00669593 FIG00669594: hypothetical protein +FIG00669595 FIG00669596: hypothetical protein +FIG00669597 FIG00669598: hypothetical protein +FIG00669598 FIG00669603: hypothetical protein +FIG00669605 FIG00669606: hypothetical protein +FIG00669609 FIG00669611: hypothetical protein +FIG00669612 Biotin--protein ligase (EC 6.3.4.9, EC 6.3.4.10, EC 6.3.4.11, EC 6.3.4.15) +FIG00669617 Serine/threonine protein phosphatase( EC:3.1.3.16 ) +FIG00669618 FIG00669619: hypothetical protein +FIG00669619 putative permease of ABC transporter +FIG00669621 FIG00669622: hypothetical protein +FIG00669622 ATPase, ParA FAMILY +FIG00669623 FIG00669624: hypothetical protein +FIG00669626 COME operon protein 3 +FIG00669630 FIG00669631: hypothetical protein +FIG00669632 FIG00669633: hypothetical protein +FIG00669633 FIG00669634: hypothetical protein +FIG00669637 FIG00669638: hypothetical protein +FIG00669640 FIG00669641: hypothetical protein +FIG00669645 FIG00669646: hypothetical protein +FIG00669649 FIG00669651: hypothetical protein +FIG00669653 FIG00669656: hypothetical protein +FIG00669658 FIG00669659: hypothetical protein +FIG00669659 FIG00669660: hypothetical protein +FIG00669660 Possible sulfatase +FIG00669662 FIG00669666: hypothetical protein +FIG00669676 N-acyl-L-amino acid amidohydrolase( EC:3.5.1.14 ) +FIG00669677 probable serine O-acetyltransferase +FIG00669679 FIG00669680: hypothetical protein +FIG00669681 FIG00669682: hypothetical protein +FIG00669684 Hypothetical membrane-spanning Protein +FIG00669686 FIG00669687: hypothetical protein +FIG00669696 FIG00669697: hypothetical protein +FIG00669701 FIG00669702: hypothetical protein +FIG00669702 FIG00669703: hypothetical protein +FIG00669704 FIG00669705: hypothetical protein +FIG00669708 FIG00669709: hypothetical protein +FIG00669710 FIG00669711: hypothetical protein +FIG00669711 FIG00669712: hypothetical protein +FIG00669715 FIG00669716: hypothetical protein +FIG00669719 FIG00669720: hypothetical protein +FIG00669721 FIG00669722: hypothetical protein +FIG00669727 Oxygen-independent coproporphyrinogen III oxidase (EC 1.-.-.-) +FIG00669728 putative [2Fe-2S]-binding subunit of oxidoreductase +FIG00669730 FIG00669731: hypothetical protein +FIG00669731 FIG00669732: CRISPR-associated protein Csx8 +FIG00669735 FIG00669736: hypothetical protein +FIG00669736 FIG00669737: hypothetical protein +FIG00669741 FIG00669742: hypothetical protein +FIG00669742 FIG00669744: hypothetical protein +FIG00669744 FIG00669745: hypothetical protein +FIG00669751 TRAP dicarboxylate transporter- DctP subunit +FIG00669752 FIG00669754: hypothetical protein +FIG00669757 phage major tail tube protein +FIG00669762 FIG00669763: hypothetical protein +FIG00669764 FIG00669766: hypothetical protein +FIG00669766 Hypothetical exported 24-amino acid repeat protein +FIG00669767 FIG00669768: hypothetical protein +FIG00669771 FIG00669772: hypothetical protein +FIG00669772 FIG00669773: hypothetical protein +FIG00669777 HIPA protein +FIG00669782 FIG00669783: hypothetical protein +FIG00669785 FIG00669786: hypothetical protein +FIG00669792 FIG00669793: hypothetical protein +FIG00669793 FIG00669794: hypothetical protein +FIG00669796 FIG00669797: hypothetical protein +FIG00669797 TRANSCRIPTION REGULATOR, CRP FAMILY +FIG00669799 FIG00669800: hypothetical protein +FIG00669805 FIG00669806: hypothetical protein +FIG00669806 FIG00671629: hypothetical protein +FIG00669807 FIG00669808: hypothetical protein +FIG00669808 FIG00669809: hypothetical protein +FIG00669809 FIG00669810: hypothetical protein +FIG00669815 Ferrichrome-binding periplasmic protein +FIG00669818 abortive infection bacteriophage resistance protein +FIG00669828 FIG00669830: hypothetical protein +FIG00669830 FIG00669832: hypothetical protein +FIG00669832 FIG00669833: hypothetical protein +FIG00669833 FIG00669834: hypothetical protein +FIG00669836 FIG00669837: hypothetical protein +FIG00669840 FIG00669841: hypothetical protein +FIG00669847 FIG00669849: hypothetical protein +FIG00669854 FIG00669855: hypothetical protein +FIG00669870 FIG00669872: hypothetical protein +FIG00669872 FIG00669873: hypothetical protein +FIG00669873 Conjugal transfer protein TrbG +FIG00669879 FIG00669880: hypothetical protein +FIG00669883 FIG00669884: hypothetical protein +FIG00669885 FIG00669886: hypothetical protein +FIG00669886 FIG00669888: hypothetical protein +FIG00669894 Glycine betaine transport system permease protein / Glycine betaine-binding protein +FIG00669897 Thioredoxin-like protein +FIG00669903 FIG00669905: hypothetical protein +FIG00669910 FIG00669912: hypothetical protein +FIG00669912 phage late control D family protein +FIG00669913 Methylaspartate mutase S chain (EC 5.4.99.1) +FIG00669914 FIG00669915: hypothetical protein +FIG00669915 FIG00669916: hypothetical protein +FIG00669916 FIG00669917: hypothetical protein +FIG00669918 FIG00669920: hypothetical protein +FIG00669923 FIG00669924: hypothetical protein +FIG00669924 FIG00669925: hypothetical protein +FIG00669925 FIG00669926: hypothetical protein +FIG00669926 FIG00669927: hypothetical protein +FIG00669934 FIG00669938: hypothetical protein +FIG00669938 FIG00669940: hypothetical protein +FIG00669940 FIG00669941: hypothetical protein +FIG00669943 FIG00669944: hypothetical protein +FIG00669949 FIG00669950: hypothetical protein +FIG00669950 FIG00669951: hypothetical protein +FIG00669955 FIG00669956: hypothetical protein +FIG00669958 FIG00669959: hypothetical protein +FIG00669961 DNA TOPOLOGY MODULATION PROTEIN FLAR-RELATED PROTEIN +FIG00669965 FIG00669966: hypothetical protein +FIG00669969 FIG00669970: hypothetical protein +FIG00669979 FIG00669980: hypothetical protein +FIG00669987 4-hydroxybutanoyl-CoA dehydratase (EC 4.2.1.-) / Vinylacetyl-CoA Delta-isomerase (EC 5.3.3.3) +FIG00669989 FIG00669991: hypothetical protein +FIG00669993 FIG00669994: hypothetical protein +FIG00669994 DNA-binding response regulator ArlR +FIG00669995 FIG00669996: hypothetical protein +FIG00670006 FIG00670008: hypothetical protein +FIG00670009 FIG00670010: hypothetical protein +FIG00670015 FIG00670016: hypothetical protein +FIG00670017 FIG00670018: hypothetical protein +FIG00670019 FIG00670022: hypothetical protein +FIG00670022 FIG00670023: hypothetical protein +FIG00670023 nucleotide-binding protein +FIG00670024 FIG00670025: hypothetical protein +FIG00670029 FIG00670030: hypothetical protein +FIG00670034 ESTERASE +FIG00670036 FIG00670038: hypothetical protein +FIG00670039 FIG00670040: hypothetical protein +FIG00670042 FIG00670046: hypothetical protein +FIG00670053 FIG00670054: hypothetical protein +FIG00670057 FIG00670058: hypothetical protein +FIG00670058 tRNA pseudouridine synthase A (EC 5.4.99.12) (tRNA-uridine isomerase I) (tRNA pseudouridylate synthase I) +FIG00670065 FIG00670066: hypothetical protein +FIG00670066 FIG00670067: hypothetical protein +FIG00670067 FIG00670070: hypothetical protein +FIG00670070 FIG00670071: hypothetical protein +FIG00670072 CRISPR-associated protein Cas5: FIG00670073 +FIG00670075 FIG00670076: hypothetical protein +FIG00670080 FIG00670085: hypothetical protein +FIG00670085 FIG00670088: hypothetical protein +FIG00670090 phage-like element pbsx protein xkdT +FIG00670091 FIG00670092: hypothetical protein +FIG00670092 sensor protein fixL( EC:2.7.3.- ) +FIG00670093 Diamine acetyltransferase( EC:2.3.1.57 ) +FIG00670094 FIG00670095: hypothetical protein +FIG00670098 FIG00670099: hypothetical protein +FIG00670099 FIG00670100: hypothetical protein +FIG00670101 FIG00670102: hypothetical protein +FIG00670102 FIG00670103: hypothetical protein +FIG00670103 FIG00670105: hypothetical protein +FIG00670105 FIG00670108: hypothetical protein +FIG00670109 FIG00670110: hypothetical protein +FIG00670110 Riboflavin transporter impX +FIG00670123 FIG00670124: hypothetical protein +FIG00670125 FIG00670127: hypothetical protein +FIG00670128 FIG00670129: hypothetical protein +FIG00670130 FIG00670132: hypothetical protein +FIG00670133 FIG00670135: hypothetical protein +FIG00670135 similar to Uncharacterized conserved protein +FIG00670136 FIG00670138: hypothetical protein +FIG00670138 FIG00670139: hypothetical protein +FIG00670139 FIG00670140: hypothetical protein +FIG00670140 FIG00670141: hypothetical protein +FIG00670141 FIG00670142: hypothetical protein +FIG00670147 Adenine-specific methyltransferase( EC:2.1.1.72 ) +FIG00670148 FIG00670149: hypothetical protein +FIG00670151 FIG00670152: hypothetical protein +FIG00670152 LOS BIOSYNTHESIS ENZYME LBGB +FIG00670153 FIG00670154: hypothetical protein +FIG00670155 FIG00670156: hypothetical protein +FIG00670156 FIG00670157: hypothetical protein +FIG00670159 FIG00670160: hypothetical protein +FIG00670161 FIG00670162: hypothetical protein +FIG00670162 Xylose repressor +FIG00670172 FIG00670174: hypothetical protein +FIG00670175 FIG00670177: hypothetical protein +FIG00670177 FIG00670178: hypothetical protein +FIG00670178 FIG00670179: hypothetical protein +FIG00670179 FIG00670180: hypothetical protein +FIG00670181 FIG00670182: hypothetical protein +FIG00670191 FIG00670192: hypothetical protein +FIG00670199 FIG00670201: hypothetical protein +FIG00670203 FIG00670204: hypothetical protein +FIG00670212 FIG00670214: hypothetical protein +FIG00670219 FIG00670220: hypothetical protein +FIG00670221 FIG00670222: hypothetical protein +FIG00670222 FIG00670223: hypothetical protein +FIG00670224 FIG00670225: hypothetical protein +FIG00670225 FIG00670226: hypothetical protein +FIG00670226 FIG00670228: hypothetical protein +FIG00670232 Calcium-transporting ATPase( EC:3.6.3.8 ) +FIG00670233 FIG00670234: hypothetical protein +FIG00670234 FIG00670235: hypothetical protein +FIG00670240 COG0300: Short-chain dehydrogenases of various substrate specificities +FIG00670249 FIG00670251: hypothetical protein +FIG00670251 FIG00670252: hypothetical protein +FIG00670253 FIG00670254: hypothetical protein +FIG00670254 FIG00670255: hypothetical protein +FIG00670256 FIG00670257: hypothetical protein +FIG00670262 FIG00670263: hypothetical protein +FIG00670265 FIG00670266: hypothetical protein +FIG00670270 FIG00670272: hypothetical protein +FIG00670275 FIG00670276: hypothetical protein +FIG00670277 FIG00670279: hypothetical protein +FIG00670279 FIG00670280: hypothetical protein +FIG00670280 METHYLTRANSFERASE +FIG00670281 FIG00670282: hypothetical protein +FIG00670283 FIG00670284: hypothetical protein +FIG00670290 FIG00670292: hypothetical protein +FIG00670292 FIG00670293: hypothetical protein +FIG00670296 FIG00670297: hypothetical protein +FIG00670300 FIG00670301: hypothetical protein +FIG00670308 FIG00670309: hypothetical protein +FIG00670310 FIG00670311: hypothetical protein +FIG00670311 FIG00670312: hypothetical protein +FIG00670312 FIG00670313: hypothetical protein +FIG00670316 FIG00670317: hypothetical protein +FIG00670318 FIG00670320: hypothetical protein +FIG00670321 Phophatidylinositol-4-phosphate 5-kinase +FIG00670327 FIG00670330: hypothetical protein +FIG00670330 FIG00670331: hypothetical protein +FIG00670331 FIG00670332: hypothetical protein +FIG00670334 FIG00670335: hypothetical protein +FIG00670341 FIG00670342: hypothetical protein +FIG00670343 FIG00670344: hypothetical protein +FIG00670351 FIG00670352: hypothetical protein +FIG00670359 FIG00670360: hypothetical protein +FIG00670369 FIG00670370: hypothetical protein +FIG00670370 FIG00670371: hypothetical protein +FIG00670374 FIG00670375: hypothetical protein +FIG00670375 DNA polymerase, bacteriophage-type +FIG00670387 FIG00670388: hypothetical protein +FIG00670389 FIG00670391: hypothetical protein +FIG00670394 FIG00670396: hypothetical protein +FIG00670400 FIG00670401: hypothetical protein +FIG00670404 FIG00670405: hypothetical protein +FIG00670405 FIG00670406: hypothetical protein +FIG00670406 FIG00670407: hypothetical protein +FIG00670407 FIG00670411: hypothetical protein +FIG00670411 FIG00670412: hypothetical protein +FIG00670415 FIG00670416: hypothetical protein +FIG00670416 FIG00670418: hypothetical protein +FIG00670424 FIG00670425: hypothetical protein +FIG00670425 FIG00670427: hypothetical protein +FIG00670428 FIG00670430: hypothetical protein +FIG00670431 nonribosomal peptide synthetase +FIG00670433 FIG00670435: hypothetical protein +FIG00670435 FIG00670436: hypothetical protein +FIG00670440 FIG00670441: hypothetical protein +FIG00670442 23S rRNA m(1)G 745 methyltransferase +FIG00670444 FIG00670445: hypothetical protein +FIG00670449 FIG00670451: hypothetical protein +FIG00670457 FIG00670458: hypothetical protein +FIG00670461 FIG00670462: hypothetical protein +FIG00670464 FIG00670466: hypothetical protein +FIG00670466 FIG00670467: hypothetical protein +FIG00670468 FIG00670469: hypothetical protein +FIG00670469 FIG00670470: hypothetical protein +FIG00670473 FIG00670474: hypothetical protein +FIG00670474 FIG00670475: hypothetical protein +FIG00670475 FIG00670476: hypothetical protein +FIG00670476 FIG00670477: hypothetical protein +FIG00670481 FIG00670482: hypothetical protein +FIG00670485 FIG00670486: hypothetical protein +FIG00670492 FIG00670493: hypothetical protein +FIG00670499 FIG00670500: hypothetical protein +FIG00670500 FIG00670501: hypothetical protein +FIG00670503 FIG00670504: hypothetical protein +FIG00670504 FIG00670505: hypothetical protein +FIG00670505 FIG00670506: hypothetical protein +FIG00670506 FIG00670508: hypothetical protein +FIG00670510 FIG00670511: hypothetical protein +FIG00670516 FIG00670518: hypothetical protein +FIG00670520 FIG00670521: hypothetical protein +FIG00670521 FIG00670522: hypothetical protein +FIG00670525 FIG00670526: hypothetical protein +FIG00670531 FIG00670532: hypothetical protein +FIG00670533 Glycosyl transferase, putative +FIG00670534 FIG00670535: hypothetical protein +FIG00670536 FIG00670537: hypothetical protein +FIG00670538 FIG00670539: hypothetical protein +FIG00670539 FIG00670541: hypothetical protein +FIG00670545 FIG00670547: hypothetical protein +FIG00670548 Acetyltransferase( EC:2.3.1.- ) +FIG00670551 FIG00670552: hypothetical protein +FIG00670554 alternate gene name: ipa-11d +FIG00670556 FIG00670557: hypothetical protein +FIG00670557 Cysteine permease +FIG00670558 FIG00670559: hypothetical protein +FIG00670560 FIG00670561: hypothetical protein +FIG00670562 FIG00670563: hypothetical protein +FIG00670565 putative phage structural protein +FIG00670570 FIG00670571: hypothetical protein +FIG00670571 FIG00670572: hypothetical protein +FIG00670572 FIG00670575: hypothetical protein +FIG00670575 FIG00670577: hypothetical protein +FIG00670577 FIG00670578: hypothetical protein +FIG00670579 FIG00670581: hypothetical protein +FIG00670581 FIG00670582: hypothetical protein +FIG00670587 FIG00670588: hypothetical protein +FIG00670588 FIG00670589: hypothetical protein +FIG00670594 Spore photoproduct +FIG00670606 FIG00670608: hypothetical protein +FIG00670609 FIG00670610: hypothetical protein +FIG00670611 FIG00670612: hypothetical protein +FIG00670614 FIG00670616: hypothetical protein +FIG00670616 FIG00670618: hypothetical protein +FIG00670618 FIG00670622: hypothetical protein +FIG00670627 FIG00670629: hypothetical protein +FIG00670629 FIG00670630: hypothetical protein +FIG00670630 Cholinephosphate cytidylyltransferase( EC:2.7.7.15 ) +FIG00670633 phage baseplate assembly protein V +FIG00670635 FIG00670636: hypothetical protein +FIG00670636 FIG00670637: hypothetical protein +FIG00670642 FIG00670644: hypothetical protein +FIG00670645 FIG00670646: hypothetical protein +FIG00670648 FIG00670649: hypothetical protein +FIG00670650 FIG00670651: hypothetical protein +FIG00670652 FIG00670653: hypothetical protein +FIG00670653 FIG00670654: hypothetical protein +FIG00670655 FIG00670656: hypothetical protein +FIG00670666 FIG00670668: hypothetical protein +FIG00670671 FIG00670672: hypothetical protein +FIG00670673 FIG00670674: hypothetical protein +FIG00670675 FIG00670676: hypothetical protein +FIG00670676 FIG00670678: hypothetical protein +FIG00670683 FIG00670684: hypothetical protein +FIG00670684 FIG00670685: hypothetical protein +FIG00670697 FIG00670700: hypothetical protein +FIG00670703 FIG00670705: hypothetical protein +FIG00670707 FIG00670708: hypothetical protein +FIG00670711 unknown next to FUPA32 +FIG00670715 FIG00670717: hypothetical protein +FIG00670718 FIG00670719: hypothetical protein +FIG00670720 FIG00670721: hypothetical protein +FIG00670721 Integrase/recombinase +FIG00670729 Outer membrane protein P1 +FIG00670731 FIG00670732: hypothetical protein +FIG00670734 FIG00670735: hypothetical protein +FIG00670735 Similar to nicotianamine synthase +FIG00670743 FIG00670744: hypothetical protein +FIG00670758 FIG00670759: hypothetical protein +FIG00670762 FIG00670763: hypothetical protein +FIG00670763 FIG00670764: hypothetical protein +FIG00670766 FIG00670767: hypothetical protein +FIG00670767 FIG00670768: hypothetical protein +FIG00670770 FIG00670773: hypothetical protein +FIG00670787 FIG00670788: hypothetical protein +FIG00670791 FIG00670792: hypothetical protein +FIG00670792 FIG00670794: hypothetical protein +FIG00670802 FIG00670803: hypothetical protein +FIG00670803 FIG00670805: hypothetical protein +FIG00670806 FIG00670809: hypothetical protein +FIG00670812 IAA acetyltransferase( EC:2.3.1.- ) +FIG00670816 peptidase S15 +FIG00670817 FIG00670818: hypothetical protein +FIG00670820 FIG00670821: hypothetical protein +FIG00670823 FIG00670824: hypothetical protein +FIG00670825 FIG00670826: hypothetical protein +FIG00670827 FIG00670828: hypothetical protein +FIG00670828 FIG00670829: hypothetical protein +FIG00670835 FIG00670837: hypothetical protein +FIG00670847 FIG00670848: hypothetical protein +FIG00670851 FIG00670852: hypothetical protein +FIG00670855 FIG00670856: hypothetical protein +FIG00670856 FIG00670857: hypothetical protein +FIG00670859 FIG00670860: hypothetical protein +FIG00670861 FIG00670862: hypothetical protein +FIG00670867 Zinc-transporting ATPase +FIG00670871 FIG00670872: hypothetical protein +FIG00670882 FIG00670883: hypothetical protein +FIG00670883 FIG00670885: hypothetical protein +FIG00670891 putative aldose 1-epimerase +FIG00670894 FIG00670895: hypothetical protein +FIG00670898 FIG00670899: hypothetical protein +FIG00670903 Domain of unknown function DUF1537 +FIG00670907 FIG00670909: hypothetical protein +FIG00670913 FIG00670916: hypothetical protein +FIG00670921 FIG00670922: hypothetical protein +FIG00670922 FIG00670923: hypothetical protein +FIG00670925 GTP pyrophosphokinase +FIG00670933 FIG00670934: hypothetical protein +FIG00670935 FIG00670937: hypothetical protein +FIG00670947 FIG00670948: hypothetical protein +FIG00670948 FIG00670949: hypothetical protein +FIG00670951 FIG00670952: hypothetical protein +FIG00670958 FIG00670959: hypothetical protein +FIG00670961 FIG00670962: hypothetical protein +FIG00670963 FIG00670964: hypothetical protein +FIG00670964 FIG00670965: hypothetical protein +FIG00670965 FIG00670966: hypothetical protein +FIG00670979 FIG00670980: hypothetical protein +FIG00670982 FIG00670983: hypothetical protein +FIG00670988 TrbL/VirB6 plasmid conjugal transfer protein +FIG00670990 FIG00670992: hypothetical protein +FIG00671003 FIG00671004: hypothetical protein +FIG00671006 FIG00671007: hypothetical protein +FIG00671010 FIG00671011: hypothetical protein +FIG00671012 FIG00671013: hypothetical protein +FIG00671013 FIG00671014: hypothetical protein +FIG00671018 FIG00671019: hypothetical protein +FIG00671022 FIG00671023: hypothetical protein +FIG00671024 FIG00671025: hypothetical protein +FIG00671025 FIG00671027: hypothetical protein +FIG00671029 FIG00671032: hypothetical protein +FIG00671041 FIG00671042: hypothetical protein +FIG00671042 FIG00671043: hypothetical protein +FIG00671051 FIG00671052: hypothetical protein +FIG00671062 FIG00671063: hypothetical protein +FIG00671065 FIG00671067: hypothetical protein +FIG00671076 FIG00671079: hypothetical protein +FIG00671080 Phage-like element PBSX protein xkdQ +FIG00671085 FIG00671086: hypothetical protein +FIG00671088 FIG00671091: hypothetical protein +FIG00671093 FIG00671094: hypothetical protein +FIG00671094 FIG00671095: hypothetical protein +FIG00671095 Tetrathionate reductase subunit B +FIG00671104 FIG00671105: hypothetical protein +FIG00671105 FIG00671106: hypothetical protein +FIG00671121 FIG00671125: hypothetical protein +FIG00671128 FIG00671129: hypothetical protein +FIG00671149 FIG00671151: hypothetical protein +FIG00671153 Resolvase-like:Recombinase +FIG00671164 putative nitrogen regulatory IIA protein (enzyme IIA-ntr) (phosphotransferase enzyme II, A component) +FIG00671169 FIG00671170: hypothetical protein +FIG00671173 FIG00671176: hypothetical protein +FIG00671177 FMN-binding +FIG00671178 FIG00671180: hypothetical protein +FIG00671208 FIG00671209: hypothetical protein +FIG00671210 FIG00671212: hypothetical protein +FIG00671212 FIG00671213: hypothetical protein +FIG00671213 FIG00671214: hypothetical protein +FIG00671214 FIG00671215: hypothetical protein +FIG00671216 FIG00671217: hypothetical protein +FIG00671219 transcription regulator (enhancement of xylanase A production) BH0900 +FIG00671225 terminase small subunit +FIG00671230 FIG00671231: hypothetical protein +FIG00671231 FIG00671232: hypothetical protein +FIG00671235 FIG00671236: hypothetical protein +FIG00671236 FIG00671238: hypothetical protein +FIG00671243 FIG00671244: hypothetical protein +FIG00671244 FIG00671246: hypothetical protein +FIG00671246 FIG00671247: hypothetical protein +FIG00671247 FIG00671248: hypothetical protein +FIG00671255 protein of unknown function DUF454 +FIG00671258 FIG00671260: hypothetical protein +FIG00671260 FIG00671261: hypothetical protein +FIG00671264 FIG00671265: hypothetical protein +FIG00671266 FIG00671267: hypothetical protein +FIG00671269 FIG00671271: hypothetical protein +FIG00671272 FIG00671273: hypothetical protein +FIG00671273 amidohydrolase( EC:3.5.1.- ) +FIG00671274 FIG00671275: hypothetical protein +FIG00671278 DNA processing chain A +FIG00671282 FIG00671283: hypothetical protein +FIG00671302 FIG00671303: hypothetical protein +FIG00671305 FIG00671306: hypothetical protein +FIG00671324 FIG00671325: hypothetical protein +FIG00671335 FIG00671337: hypothetical protein +FIG00671342 FIG00671343: hypothetical protein +FIG00671345 Cell division protein ftsZ +FIG00671350 periplasmic component of efflux system +FIG00671352 FIG00671353: hypothetical protein +FIG00671356 FIG00671357: hypothetical protein +FIG00671359 FIG00671339: hypothetical protein +FIG00671377 FIG00671380: hypothetical protein +FIG00671384 putitive LPS biosynthesis protein +FIG00671389 FIG00671390: hypothetical protein +FIG00671394 FIG00671395: hypothetical protein +FIG00671400 FIG00671401: hypothetical protein +FIG00671404 FIG00671405: hypothetical protein +FIG00671405 FIG00671406: hypothetical protein +FIG00671407 FIG00671408: hypothetical protein +FIG00671408 FIG00671409: hypothetical protein +FIG00671412 FIG00671413: hypothetical protein +FIG00671414 FIG00671415: hypothetical protein +FIG00671418 FIG00671419: hypothetical protein +FIG00671424 FIG00671426: hypothetical protein +FIG00671427 FIG00671428: hypothetical protein +FIG00671435 Phage DNA primase +FIG00671437 FIG00671438: hypothetical protein +FIG00671442 Probable glycosyl transferase (EC 2.4.-.-) +FIG00671443 putative primase/helicase +FIG00671457 Type II restriction enzyme DpnII (EC 3.1.21.4) (Endonuclease DpnII) (R.DpnII) +FIG00671478 FIG00671479: hypothetical protein +FIG00671484 Amino acid carrier protein alsT +FIG00671488 FIG00671490: hypothetical protein +FIG00671495 FIG00671496: hypothetical protein +FIG00671496 FIG00671497: hypothetical protein +FIG00671504 FIG00671505: hypothetical protein +FIG00671506 FIG00671507: hypothetical protein +FIG00671508 FIG00671511: hypothetical protein +FIG00671511 FIG00671512: hypothetical protein +FIG00671524 FIG00671525: hypothetical protein +FIG00671525 FIG00671526: hypothetical protein +FIG00671527 FIG00671528: hypothetical protein +FIG00671531 FIG00671532: hypothetical protein +FIG00671532 FIG00671534: hypothetical protein +FIG00671545 FIG00671546: hypothetical protein +FIG00671552 FIG00671553: hypothetical protein +FIG00671561 FIG00671563: hypothetical protein +FIG00671582 FIG00671583: hypothetical protein +FIG00671594 putative metal-binding protein +FIG00671614 FIG00671615: hypothetical protein +FIG00671615 FIG00671616: hypothetical protein +FIG00671616 FIG00671617: hypothetical protein +FIG00671617 FIG00671618: hypothetical protein +FIG00671621 FIG00671622: hypothetical protein +FIG00671622 FIG00671623: hypothetical protein +FIG00671623 putative bacteriophage DNA transposition protein B +FIG00671632 FIG00671633: hypothetical protein +FIG00671638 FIG00671640: hypothetical protein +FIG00671649 FIG00671651: hypothetical protein +FIG00671658 FIG00671659: hypothetical protein +FIG00671660 FIG00671663: hypothetical protein +FIG00671673 FIG00671674: hypothetical protein +FIG00671703 Citrate lyase acyl carrier protein CitD +FIG00671717 FIG00671718: hypothetical protein +FIG00671743 FIG00671744: hypothetical protein +FIG00671744 FIG00671746: hypothetical protein +FIG00671767 FIG00671768: hypothetical protein +FIG00671779 FIG00671780: hypothetical protein +FIG00671782 FIG00671783: hypothetical protein +FIG00671798 FIG00671799: hypothetical protein +FIG00671803 Heat shock protein 15 +FIG00671812 FIG00671814: hypothetical protein +FIG00671827 FIG00671828: hypothetical protein +FIG00671828 FIG00671829: hypothetical protein +FIG00671830 FIG00671832: hypothetical protein +FIG00671837 FIG00671838: hypothetical protein +FIG00671858 FIG00671859: hypothetical protein +FIG00671865 FIG00671866: hypothetical protein +FIG00671868 FIG00671870: hypothetical protein +FIG00671870 FIG00671871: hypothetical protein +FIG00671885 FIG00671886: hypothetical protein +FIG00671894 FIG00671899: hypothetical protein +FIG00671903 COG1462: Uncharacterized protein involved in formation of curli polymers +FIG00671914 FIG00424242: hypothetical protein +FIG00671916 COG1524: Uncharacterized proteins of the AP superfamily +FIG00671918 histidine kinase sensor of two component system +FIG00671919 Sortase (surface protein transpeptidase) +FIG00671927 widely conserved MoxR-like protein in magnesium chelatase family +FIG00671928 FIG00671929: hypothetical protein +FIG00671930 FIG00424428: hypothetical protein +FIG00671932 putative exodeoxyribonuclease V +FIG00671933 FIG00671934: hypothetical protein +FIG00671936 FIG00671937: hypothetical protein +FIG00671937 FIG00425592: hypothetical protein +FIG00671938 FIG00671939: hypothetical protein +FIG00671939 possible rRNA methylase +FIG00671942 4-hydroxybenzoate polyprenyltransferase and related prenyltransferases +FIG00671948 FIG00671949: hypothetical protein +FIG00671950 FIG00671951: hypothetical protein +FIG00671954 FIG00671957: hypothetical protein +FIG00671957 FIG00671960: hypothetical protein +FIG00671960 FIG00671961: hypothetical protein +FIG00671962 FIG00671964: hypothetical protein +FIG00671965 FIG00671967: hypothetical protein +FIG00671967 FIG00671968: hypothetical protein +FIG00671971 possible protease HtpX +FIG00671972 FIG00671973: hypothetical protein +FIG00671975 FIG00671976: hypothetical protein +FIG00671978 FIG00425582: hypothetical protein +FIG00671979 FIG00671980: hypothetical protein +FIG00671984 FIG00671985: hypothetical protein +FIG00671985 FIG00671986: hypothetical protein +FIG00671986 putative histidine kinase, ScnK homolog +FIG00671990 FIG005666: putative helicase +FIG00671995 FIG00671996: hypothetical protein +FIG00672000 Uncharacterized protein containing a divergent version of the methyl-accepting chemotaxis-like domain +FIG00672004 FIG00424069: hypothetical protein +FIG00672005 hydrolase, haloacid dehalogenase-like family +FIG00672006 PROBABLE CONSERVED INTEGRAL MEMBRANE ALANINE AND LEUCINE RICH PROTEIN +FIG00672007 FIG00672008: hypothetical protein +FIG00672008 FIG00672009: hypothetical protein +FIG00672013 FIG00672014: hypothetical protein +FIG00672014 FIG00672016: hypothetical protein +FIG00672016 FIG00672017: hypothetical protein +FIG00672017 FIG00672019: hypothetical protein +FIG00672019 FIG00672020: hypothetical protein +FIG00672020 FIG00672021: hypothetical protein +FIG00672023 possible transport protein +FIG00672024 FIG00672025: hypothetical protein +FIG00672027 possible secreted peptidyl-prolyl cis-trans isomerase protein +FIG00672031 FIG00672032: hypothetical protein +FIG00672032 4-nitrophenylphosphatase (EC 3.1.3.41) +FIG00672033 Cystathionine beta-lyase, type II (EC 4.4.1.8) +FIG00672034 FIG00672035: hypothetical protein +FIG00672035 FIG00672036: hypothetical protein +FIG00672036 FIG00672037: hypothetical protein +FIG00672037 putative glycosyl transferase domain protein +FIG00672040 FIG00423972: hypothetical protein +FIG00672043 FIG00672044: hypothetical protein +FIG00672045 FIG00672046: hypothetical protein +FIG00672048 COG0515: Serine/threonine protein kinase +FIG00672051 FIG00672052: hypothetical protein +FIG00672053 FIG00672054: hypothetical protein +FIG00672055 FIG00672056: hypothetical protein +FIG00672056 FIG00672057: hypothetical protein +FIG00672057 FIG00672058: hypothetical protein +FIG00672059 ABC-type cobalt transport system, ATPase component +FIG00672062 FIG00672064: hypothetical protein +FIG00672064 FIG00672065: hypothetical protein +FIG00672066 COG2304: Uncharacterized protein containing a von Willebrand factor type A (vWA) domain +FIG00672067 FIG00672068: hypothetical protein +FIG00672069 FIG00672070: hypothetical protein +FIG00672070 narrowly conserved hypothetical membrane protein +FIG00672074 FIG00672075: hypothetical protein +FIG00672076 FIG00672077: hypothetical protein +FIG00672078 FIG00672079: hypothetical protein +FIG00672085 FIG00672086: hypothetical protein +FIG00672086 FIG00672087: hypothetical protein +FIG00672088 FIG00672090: hypothetical protein +FIG00672092 FIG00672093: hypothetical protein +FIG00672101 FIG00672103: hypothetical protein +FIG00672103 FIG00356309: hypothetical protein +FIG00672105 FIG00672106: hypothetical protein +FIG00672106 FIG00672107: hypothetical protein +FIG00672107 FIG00672109: hypothetical protein +FIG00672109 FIG00672110: hypothetical protein +FIG00672111 FIG00672113: hypothetical protein +FIG00672115 FIG00672116: hypothetical protein +FIG00672119 FIG00672120: hypothetical protein +FIG00672121 FIG00672124: hypothetical protein +FIG00672126 FIG00672127: hypothetical protein +FIG00672129 possible acetyltransferase +FIG00672131 FIG027937: secreted protein +FIG00672133 FIG00424910: hypothetical protein +FIG00672136 FIG00672137: hypothetical protein +FIG00672138 FIG00424909: hypothetical protein +FIG00672139 COG3189: Uncharacterized conserved protein +FIG00672140 FIG00672141: hypothetical protein +FIG00672143 FIG00672145: hypothetical protein +FIG00672145 FIG00672147: hypothetical protein +FIG00672149 FIG00672151: hypothetical protein +FIG00672151 FIG00672152: hypothetical protein +FIG00672152 FIG00672153: hypothetical protein +FIG00672153 FIG00672154: hypothetical protein +FIG00672154 FIG00672155: hypothetical protein +FIG00672156 COG4166: ABC-type oligopeptide transport system, periplasmic component +FIG00672158 FIG00423867: hypothetical protein +FIG00672161 COG0477: Permeases of the major facilitator superfamily +FIG00672163 FIG00672164: hypothetical protein +FIG00672164 FIG00672165: hypothetical protein +FIG00672165 FUPA23 P-type ATPase +FIG00672166 FIG00672167: hypothetical protein +FIG00672167 FIG00818182: hypothetical protein +FIG00672169 FIG00672170: hypothetical protein +FIG00672174 FIG00672175: hypothetical protein +FIG00672180 putative dipeptidase +FIG00672185 FIG00672186: hypothetical protein +FIG00672186 FIG00672187: hypothetical protein +FIG00672187 FIG00672188: hypothetical protein +FIG00672188 FIG00672189: hypothetical protein +FIG00672190 FIG00672191: hypothetical protein +FIG00672193 FIG00672195: hypothetical protein +FIG00672196 FIG00672197: hypothetical protein +FIG00672197 FIG00424410: hypothetical protein +FIG00672198 Response regulator of two-component system +FIG00672199 FIG00672200: hypothetical protein +FIG00672206 FIG00672207: hypothetical protein +FIG00672210 FIG00424295: hypothetical protein +FIG00672211 FIG00672212: hypothetical protein +FIG00672223 COG5512: Zn-ribbon-containing, possibly RNA-binding protein and truncated derivatives +FIG00672228 FIG00672229: hypothetical protein +FIG00672229 FIG00672230: hypothetical protein +FIG00672234 FIG00423926: hypothetical protein +FIG00672235 FIG00424614: hypothetical protein +FIG00672236 FIG00672237: hypothetical protein +FIG00672241 FIG00672242: hypothetical protein +FIG00672242 FIG00672243: hypothetical protein +FIG00672244 FIG00672245: hypothetical protein +FIG00672245 FIG00672247: hypothetical protein +FIG00672247 CRISPR-associated protein +FIG00672250 FIG00672252: hypothetical protein +FIG00672252 sugar binding-protein dependent transporter system permease +FIG00672254 FIG00424359: hypothetical protein +FIG00672258 FIG00672260: hypothetical protein +FIG00672261 Serine/threonine-protein kinase RIO1 (EC 2.7.11.1) +FIG00672266 glutamate-binding protein of ABC transporter system +FIG00672267 FIG00425858: hypothetical protein +FIG00672271 FIG00424197: hypothetical protein +FIG00672275 FIG00424144: hypothetical protein +FIG00672277 FIG00672278: hypothetical protein +FIG00672280 FIG00672281: hypothetical protein +FIG00672282 Fe2+ ABC transporter, ATP-binding subunit +FIG00672284 FIG00423848: hypothetical protein +FIG00672286 FIG00672289: hypothetical protein +FIG00672289 FIG00672291: hypothetical protein +FIG00672292 FIG00672294: hypothetical protein +FIG00672296 probable cation-transporting ATPase V +FIG00672299 FIG00672300: hypothetical protein +FIG00672303 COG4932: Predicted outer membrane protein +FIG00672306 FIG00672307: hypothetical protein +FIG00672307 probable MutT1 protein +FIG00672308 narrowly conserved hypothetical protein +FIG00672311 FIG00672312: hypothetical protein +FIG00672315 FIG00672316: hypothetical protein +FIG00672316 FIG00672317: hypothetical protein +FIG00672319 FIG00672320: hypothetical protein +FIG00672325 FIG00672327: hypothetical protein +FIG00672327 Uncharacterized protein SCO5199 +FIG00672329 FIG00672330: hypothetical protein +FIG00672331 FIG00424960: hypothetical protein +FIG00672332 competence protein +FIG00672333 FIG00672334: hypothetical protein +FIG00672335 FIG00672336: hypothetical protein +FIG00672336 FIG215594: Membrane spanning protein +FIG00672339 RumE protein +FIG00672342 FIG00672343: hypothetical protein +FIG00672343 FIG00672344: hypothetical protein +FIG00672345 FIG00672346: hypothetical protein +FIG00672347 FIG00672349: hypothetical protein +FIG00672349 FIG00672350: hypothetical protein +FIG00672352 FIG00672353: hypothetical protein +FIG00672356 proline iminopeptidase +FIG00672359 Protoporphyrinogen oxidase +FIG00672361 FIG00672362: hypothetical protein +FIG00672364 putative ABC transport system membrane protein +FIG00672370 FIG00423794: hypothetical protein +FIG00672372 FIG00672374: hypothetical protein +FIG00672374 FIG00672378: hypothetical protein +FIG00672379 probable permease protein of ABC transporter system +FIG00672381 FIG00672383: hypothetical protein +FIG00672383 FIG00672385: hypothetical protein +FIG00672388 FIG00672389: hypothetical protein +FIG00672391 FIG00672392: hypothetical protein +FIG00672393 Conserved protein DUF552 +FIG00672394 FK506-binding protein, peptidyl-prolyl cis-trans isomerase (EC 5.2.1.8) +FIG00672395 FIG00672396: hypothetical protein +FIG00672398 FIG00672399: hypothetical protein +FIG00672399 Macrolide 2'-phosphotransferase +FIG00672401 FIG00672402: hypothetical protein +FIG00672403 FIG00672405: hypothetical protein +FIG00672407 FIG00672408: hypothetical protein +FIG00672408 FIG00424299: hypothetical protein +FIG00672409 FIG00672410: hypothetical protein +FIG00672412 FIG00672414: hypothetical protein +FIG00672416 FIG00424102: hypothetical protein +FIG00672417 FIG00672418: hypothetical protein +FIG00672421 FIG00672423: hypothetical protein +FIG00672427 FIG00672429: hypothetical protein +FIG00672429 FIG00672430: hypothetical protein +FIG00672430 FIG00672431: hypothetical protein +FIG00672431 FIG00672433: hypothetical protein +FIG00672434 Putative esterase family +FIG00672437 FIG00424036: hypothetical protein +FIG00672439 FIG00672440: hypothetical protein +FIG00672444 FIG00672445: hypothetical protein +FIG00672445 FIG00672446: hypothetical protein +FIG00672447 FIG00672449: hypothetical protein +FIG00672450 FIG00672451: hypothetical protein +FIG00672452 possible permease protein of ABC transporter system +FIG00672453 FIG00672454: hypothetical protein +FIG00672454 histidine kinase sensor of two-component system +FIG00672461 FIG00672462: hypothetical protein +FIG00672463 FIG00672464: hypothetical protein +FIG00672464 FIG00672466: hypothetical protein +FIG00672467 FIG00424732: hypothetical protein +FIG00672470 FIG00672472: hypothetical protein +FIG00672472 FIG00672473: hypothetical protein +FIG00672475 ABC transporter, integral membrane subunit +FIG00672477 alpha-amylase +FIG00672483 FIG00672484: hypothetical protein +FIG00672487 Putative ABC transport system exported protein +FIG00672488 narrowly conserved hypothetical protein with possible DNA interaction motif +FIG00672493 FIG00424610: hypothetical protein +FIG00672495 possible phospholipase/carboxylesterase +FIG00672498 Fimbrial subunit type 1 precursor +FIG00672500 FIG00672501: hypothetical protein +FIG00672504 FIG00672505: hypothetical protein +FIG00672509 FIG00672510: hypothetical protein +FIG00672513 FIG00672514: hypothetical protein +FIG00672515 FIG00672517: hypothetical protein +FIG00672517 FIG00672518: hypothetical protein +FIG00672518 Permeases +FIG00672520 FIG00672522: hypothetical protein +FIG00672524 FIG00672525: hypothetical protein +FIG00672528 FIG00672530: hypothetical protein +FIG00672531 FIG00672532: hypothetical protein +FIG00672532 Putative glycosilase +FIG00672533 FIG00672534: hypothetical protein +FIG00672539 FIG00672540: hypothetical protein +FIG00672545 FIG00672546: hypothetical protein +FIG00672546 Pseudouridine kinase, ribokinase/adenosine kinase/pfkB family +FIG00672549 FIG00672551: hypothetical protein +FIG00672554 FIG00672556: hypothetical protein +FIG00672559 COG1879: ABC-type sugar transport system, periplasmic component +FIG00672563 FIG00672565: hypothetical protein +FIG00672567 FIG00672568: hypothetical protein +FIG00672570 FIG00672571: hypothetical protein +FIG00672572 FIG00672573: hypothetical protein +FIG00672573 FIG00672575: hypothetical protein +FIG00672575 FIG00672576: hypothetical protein +FIG00672577 FIG00672580: hypothetical protein +FIG00672581 FIG00672582: hypothetical protein +FIG00672582 FIG00672583: hypothetical protein +FIG00672583 FIG00672585: hypothetical protein +FIG00672585 FIG00672586: hypothetical protein +FIG00672588 FIG00672589: hypothetical protein +FIG00672589 FIG00672590: hypothetical protein +FIG00672590 FIG00672592: hypothetical protein +FIG00672592 FIG00672593: hypothetical protein +FIG00672593 FIG00672594: hypothetical protein +FIG00672594 FIG00672595: hypothetical protein +FIG00672595 FIG00672596: hypothetical protein +FIG00672596 heat shock protein class I (low molecular weight) +FIG00672597 FIG00672600: hypothetical protein +FIG00672600 ATP-dependent Clp protease-like +FIG00672601 FIG00672606: hypothetical protein +FIG00672607 FIG00672608: hypothetical protein +FIG00672608 FIG00672609: hypothetical protein +FIG00672609 Sigma-G-dependent sporulation specific SASP protein +FIG00672611 FIG00672612: hypothetical protein +FIG00672616 FIG00672617: hypothetical protein +FIG00672617 FIG00672618: hypothetical protein +FIG00672618 FIG00672619: hypothetical protein +FIG00672619 FIG00672620: hypothetical protein +FIG00672621 FIG00672622: hypothetical protein +FIG00672622 FIG00672629: hypothetical protein +FIG00672629 FIG00672631: hypothetical protein +FIG00672631 FIG00672632: hypothetical protein +FIG00672632 conserved protein YhfK +FIG00672633 FIG00672635: hypothetical protein +FIG00672635 Putative sodium-glucose/galactose cotransporter +FIG00672638 FIG00672639: hypothetical protein +FIG00672639 FIG00672640: hypothetical protein +FIG00672640 FIG00672642: hypothetical protein +FIG00672646 FIG00672647: hypothetical protein +FIG00672647 FIG00672648: hypothetical protein +FIG00672649 FIG00672651: hypothetical protein +FIG00672652 bacteriophage-related protein +FIG00672655 FIG00672657: hypothetical protein +FIG00672660 FIG00672662: hypothetical protein +FIG00672662 FIG00672663: hypothetical protein +FIG00672665 FIG00672666: hypothetical protein +FIG00672666 FIG00672667: hypothetical protein +FIG00672668 FIG00672669: hypothetical protein +FIG00672669 Type IV pilus biogenesis protein PilN +FIG00672671 FIG00672672: hypothetical protein +FIG00672672 CbaB and cbaA genes for subunit II and subunit I of b(o/a)3-type cytochrome c oxidase +FIG00672675 FIG00672677: hypothetical protein +FIG00672677 FIG00672678: hypothetical protein +FIG00672678 FIG00672679: hypothetical protein +FIG00672679 FIG00672681: hypothetical protein +FIG00672681 FIG00672682: hypothetical protein +FIG00672684 FIG00672685: hypothetical protein +FIG00672685 CDS_ID OB0907 +FIG00672686 FIG00672687: hypothetical protein +FIG00672687 polysaccharide ABC transporter permease +FIG00672689 FIG00672690: hypothetical protein +FIG00672691 FIG00672692: hypothetical protein +FIG00672692 FIG00672693: hypothetical protein +FIG00672693 sporulation control protein +FIG00672694 FIG00672695: hypothetical protein +FIG00672695 FIG00672696: hypothetical protein +FIG00672696 FIG00672697: hypothetical protein +FIG00672697 FIG00672699: hypothetical protein +FIG00672700 FIG00672701: hypothetical protein +FIG00672709 FIG00672711: hypothetical protein +FIG00672711 FIG00672712: hypothetical protein +FIG00672712 FIG00672713: hypothetical protein +FIG00672713 FIG00672714: hypothetical protein +FIG00672714 FIG00672715: hypothetical protein +FIG00672715 DNA-binding protein +FIG00672718 FIG00672719: hypothetical protein +FIG00672721 FIG00672722: hypothetical protein +FIG00672722 Spore germination protein XC (pXO1-112) +FIG00672723 FIG00672725: hypothetical protein +FIG00672725 Stress response Hsp-like protein +FIG00672727 FIG00672728: hypothetical protein +FIG00672731 FIG00672732: hypothetical protein +FIG00672741 FIG00672742: hypothetical protein +FIG00672743 FIG00672745: hypothetical protein +FIG00672745 FIG00672747: hypothetical protein +FIG00672747 FIG00672748: hypothetical protein +FIG00672748 FIG00672749: hypothetical protein +FIG00672749 FIG00672750: hypothetical protein +FIG00672751 FIG00672752: hypothetical protein +FIG00672752 FIG00672754: hypothetical protein +FIG00672754 FIG00672756: hypothetical protein +FIG00672756 FIG00672757: hypothetical protein +FIG00672759 Flagellar protein fliT +FIG00672761 FIG00672765: hypothetical protein +FIG00672765 FIG00672766: hypothetical protein +FIG00672766 FIG00672767: hypothetical protein +FIG00672767 Polysaccharide deacetylase; possible chitooligosaccharide deacetylase (EC 3.5.1.41) +FIG00672768 FIG00672769: hypothetical protein +FIG00672769 Hydrolase, alpha/beta superfamily +FIG00672771 FIG00672772: hypothetical protein +FIG00672774 Serine/threonine-protein kinase (EC 2.7.1.-) +FIG00672775 FIG00672776: hypothetical protein +FIG00672778 FIG00672779: hypothetical protein +FIG00672779 FIG00672780: hypothetical protein +FIG00672780 FIG00672784: hypothetical protein +FIG00672784 FIG00672785: hypothetical protein +FIG00672786 FIG00672787: hypothetical protein +FIG00672787 FIG00672790: hypothetical protein +FIG00672790 FIG00672792: hypothetical protein +FIG00672792 FIG00672793: hypothetical protein +FIG00672793 FIG00672794: hypothetical protein +FIG00672800 FIG00672801: hypothetical protein +FIG00672803 FIG00672805: hypothetical protein +FIG00672805 FIG00672806: hypothetical protein +FIG00672806 FIG00672807: hypothetical protein +FIG00672807 FIG00672810: hypothetical protein +FIG00672810 FIG00672811: hypothetical protein +FIG00672811 FIG00672812: hypothetical protein +FIG00672812 FIG00672813: hypothetical protein +FIG00672813 FIG00672814: hypothetical protein +FIG00672814 FIG00672816: hypothetical protein +FIG00672816 lantibiotic ABC transporter (ATP-binding protein) +FIG00672817 FIG00672818: hypothetical protein +FIG00672818 FIG00672820: hypothetical protein +FIG00672820 FIG00672821: hypothetical protein +FIG00672821 Sporulation protein, YTFJ Bacillus subtilis ortholog +FIG00672822 FIG00672824: hypothetical protein +FIG00672824 FIG00672825: hypothetical protein +FIG00672825 FIG00672827: hypothetical protein +FIG00672827 FIG00672828: hypothetical protein +FIG00672834 FIG00672836: hypothetical protein +FIG00672836 FIG00672837: hypothetical protein +FIG00672837 FIG00672838: hypothetical protein +FIG00672838 spore coat protein +FIG00672839 FIG00672840: hypothetical protein +FIG00672841 FIG00672842: hypothetical protein +FIG00672842 FIG00672843: hypothetical protein +FIG00672843 FIG00672844: hypothetical protein +FIG00672844 FIG00672847: hypothetical protein +FIG00672847 putative membrane protein +FIG00672849 FIG00672852: hypothetical protein +FIG00672854 FIG00672855: hypothetical protein +FIG00672855 FIG00672857: hypothetical protein +FIG00672858 FIG00672860: hypothetical protein +FIG00672861 FIG00672862: hypothetical protein +FIG00672862 FIG00672863: hypothetical protein +FIG00672865 FIG00672872: hypothetical protein +FIG00672872 FIG00672873: hypothetical protein +FIG00672874 FIG00672875: hypothetical protein +FIG00672880 FIG00672881: hypothetical protein +FIG00672881 FIG00672882: hypothetical protein +FIG00672882 FIG00672883: hypothetical protein +FIG00672883 FIG00672884: hypothetical protein +FIG00672884 FIG00945534: hypothetical protein +FIG00672886 FIG00672887: hypothetical protein +FIG00672888 FIG00672889: hypothetical protein +FIG00672889 FIG00672890: hypothetical protein +FIG00672891 FIG00672892: hypothetical protein +FIG00672892 FIG00672893: hypothetical protein +FIG00672893 Alkylpyrone O-methyltransferase (B. subtilis BpsB) +FIG00672895 Small, acid-soluble spore protein H 2 +FIG00672896 FIG00672897: hypothetical protein +FIG00672897 FIG00672901: hypothetical protein +FIG00672902 FIG00672904: membrane protein YqhQ +FIG00672904 FIG00672906: hypothetical protein +FIG00672906 FIG00672907: hypothetical protein +FIG00672909 FIG00672910: hypothetical protein +FIG00672911 FIG00672913: hypothetical protein +FIG00672913 FIG00672914: hypothetical protein +FIG00672916 FIG00672918: hypothetical protein +FIG00672919 FIG00672920: hypothetical protein +FIG00672921 FIG00672922: hypothetical protein +FIG00672922 FIG00672923: hypothetical protein +FIG00672927 FIG00672931: hypothetical protein +FIG00672932 FIG00672933: hypothetical protein +FIG00672935 FIG00672937: hypothetical protein +FIG00672937 FIG00672939: hypothetical protein +FIG00672939 FIG00672941: hypothetical protein +FIG00672941 FIG00672947: hypothetical protein +FIG00672951 FIG00672953: hypothetical protein +FIG00672954 FIG00672955: hypothetical protein +FIG00672955 Sporulation-control protein +FIG00672956 FIG00672959: hypothetical protein +FIG00672959 Two component sensor histidine kinase +FIG00672962 FIG00672963: hypothetical protein +FIG00672963 General stress protein +FIG00672964 FIG00672965: hypothetical protein +FIG00672966 FIG00672969: hypothetical protein +FIG00672969 FIG00672971: hypothetical protein +FIG00672971 FIG00672974: hypothetical protein +FIG00672974 FIG00672976: hypothetical protein +FIG00672976 FIG00672977: hypothetical protein +FIG00672977 FIG00672980: hypothetical protein +FIG00672980 FIG00672981: hypothetical protein +FIG00672981 FIG00672983: hypothetical protein +FIG00672983 FIG01226063: hypothetical protein +FIG00672985 FIG00672987: hypothetical protein +FIG00672987 FIG00672988: hypothetical protein +FIG00672988 FIG00672990: hypothetical protein +FIG00672990 FIG00672992: hypothetical protein +FIG00672996 FIG00672998: hypothetical protein +FIG00672999 FIG00673000: hypothetical protein +FIG00673000 FIG00673003: hypothetical protein +FIG00673003 phenylacetic acid catabolism protein +FIG00673005 FIG00673008: hypothetical protein +FIG00673008 FIG00673009: hypothetical protein +FIG00673009 FIG00673011: hypothetical protein +FIG00673011 FIG00673012: hypothetical protein +FIG00673012 FIG00673013: hypothetical protein +FIG00673013 FIG00673015: hypothetical protein +FIG00673015 FIG00673016: hypothetical protein +FIG00673016 FIG00673017: hypothetical protein +FIG00673017 FIG00673019: hypothetical protein +FIG00673021 FIG00673023: hypothetical protein +FIG00673023 asparagine/aspartate rich protein +FIG00673025 TPR repeat protein +FIG00673028 FIG00673030: hypothetical protein +FIG00673031 FIG00673032: hypothetical protein +FIG00673032 FIG00673034: hypothetical protein +FIG00673034 FIG00673035: hypothetical protein +FIG00673035 FIG00673037: hypothetical protein +FIG00673037 FIG00673038: hypothetical protein +FIG00673039 FIG00673041: hypothetical protein +FIG00673042 FIG00673043: hypothetical protein +FIG00673043 FIG00673044: hypothetical protein +FIG00673046 FIG00673047: hypothetical protein +FIG00673047 FIG00673048: hypothetical protein +FIG00673048 FIG00673049: hypothetical protein +FIG00673050 FIG00673051: hypothetical protein +FIG00673051 FIG00673052: hypothetical protein +FIG00673052 FIG00673053: hypothetical protein +FIG00673054 FIG00673055: hypothetical protein +FIG00673055 FIG00673056: hypothetical protein +FIG00673056 FIG00673057: hypothetical protein +FIG00673057 FIG00673059: hypothetical protein +FIG00673059 FIG00673061: hypothetical protein +FIG00673062 Para-aminobenzoate synthase, amidotransferase component (EC 2.6.1.85) +FIG00673067 FIG00673068: hypothetical protein +FIG00673068 FIG00673070: hypothetical protein +FIG00673070 FIG00673071: hypothetical protein +FIG00673071 FIG00673072: hypothetical protein +FIG00673073 FIG00673074: hypothetical protein +FIG00673077 FIG00673078: hypothetical protein +FIG00673080 FIG00673081: hypothetical protein +FIG00673081 FIG00673082: hypothetical protein +FIG00673082 FIG00673087: hypothetical protein +FIG00673088 Rhomboid family protein +FIG00673090 Lanthionine biosynthesis protein LanM +FIG00673091 FIG00673094: hypothetical protein +FIG00673094 FIG00673095: hypothetical protein +FIG00673095 FIG00673098: hypothetical protein +FIG00673109 FIG00673111: hypothetical protein +FIG00673111 FIG00673112: hypothetical protein +FIG00673112 FIG00673114: hypothetical protein +FIG00673114 FIG062906: hypothetical Membrane Spanning Protein +FIG00673115 FIG00673117: hypothetical protein +FIG00673117 FIG00673118: hypothetical protein +FIG00673118 FIG00673119: hypothetical protein +FIG00673119 FIG00673121: hypothetical protein +FIG00673123 FIG00673124: hypothetical protein +FIG00673124 FIG00673125: hypothetical protein +FIG00673125 FIG00673126: hypothetical protein +FIG00673126 FIG00673127: hypothetical protein +FIG00673128 FIG00673129: hypothetical protein +FIG00673129 FIG00673130: hypothetical protein +FIG00673130 Tetraprenyl-beta-curcumene synthase (EC 4.2.3.130) +FIG00673133 FIG00673136: hypothetical protein +FIG00673136 FIG00673139: hypothetical protein +FIG00673139 FIG00673140: hypothetical protein +FIG00673140 FIG00673141: hypothetical protein +FIG00673141 circularin A precursor +FIG00673144 FIG00673145: hypothetical protein +FIG00673145 FIG00673147: hypothetical protein +FIG00673147 FIG00673151: hypothetical protein +FIG00673154 Ferrous iron uptake system protein A +FIG00673156 FIG00673158: hypothetical protein +FIG00673158 FIG00673159: hypothetical protein +FIG00673159 FIG00673160: hypothetical protein +FIG00673160 FIG00673161: hypothetical protein +FIG00673161 SacPA operon antiterminator +FIG00673163 FIG00673164: hypothetical protein +FIG00673164 FIG00673165: hypothetical protein +FIG00673165 FIG00673167: hypothetical protein +FIG00673167 Type IV pilus biogenesis protein PilO +FIG00673168 FIG00673169: hypothetical protein +FIG00673169 FIG00673170: hypothetical protein +FIG00673170 FIG00673171: hypothetical protein +FIG00673171 FIG00673173: hypothetical protein +FIG00673173 FIG00673174: hypothetical protein +FIG00673174 FIG00673175: hypothetical protein +FIG00673175 FIG00673176: hypothetical protein +FIG00673180 FIG00673181: hypothetical protein +FIG00673189 FIG00673192: hypothetical protein +FIG00673192 Transcription antiterminator GlcT +FIG00673194 FIG00673195: hypothetical protein +FIG00673195 FIG00673196: hypothetical protein +FIG00673196 FIG00673197: hypothetical protein +FIG00673197 FIG00673198: hypothetical protein +FIG00673198 FIG00673199: hypothetical protein +FIG00673199 FIG00673200: hypothetical protein +FIG00673205 FIG00673206: hypothetical protein +FIG00673206 FIG00673207: hypothetical protein +FIG00673210 FIG00673211: hypothetical protein +FIG00673213 FIG00673214: hypothetical protein +FIG00673214 FIG00673215: hypothetical protein +FIG00673216 FIG00673217: hypothetical protein +FIG00673217 FIG00673218: hypothetical protein +FIG00673219 FIG00673220: hypothetical protein +FIG00673220 FIG00673222: hypothetical protein +FIG00673222 FIG00673223: hypothetical protein +FIG00673226 FIG00673227: hypothetical protein +FIG00673228 FIG00673229: hypothetical protein +FIG00673229 FIG00673230: hypothetical protein +FIG00673230 FIG00673231: hypothetical protein +FIG00673232 FIG00673233: hypothetical protein +FIG00673233 FIG00673235: hypothetical protein +FIG00673235 FIG00673236: hypothetical protein +FIG00673236 Type IV pilin PilA +FIG00673237 FIG00673238: hypothetical protein +FIG00673238 FIG00673240: hypothetical protein +FIG00673240 Type IV pilin PilA +FIG00673242 FIG00673243: hypothetical protein +FIG00673247 FIG00673252: hypothetical protein +FIG00673253 FIG00673255: hypothetical protein +FIG00673255 FIG00673256: hypothetical protein +FIG00673260 FIG00673262: hypothetical protein +FIG00673262 FIG00673265: hypothetical protein +FIG00673265 FIG00673266: hypothetical protein +FIG00673266 FIG00673269: hypothetical protein +FIG00673269 FIG00673270: hypothetical protein +FIG00673270 FIG00673271: hypothetical protein +FIG00673271 FIG00673273: hypothetical protein +FIG00673273 FIG00673274: hypothetical protein +FIG00673275 FIG00673277: hypothetical protein +FIG00673280 Integral membrane protein, TerC family +FIG00673282 FIG00673286: hypothetical protein +FIG00673287 FIG00673288: hypothetical protein +FIG00673289 FIG00673290: hypothetical protein +FIG00673291 FIG00673292: hypothetical protein +FIG00673292 FIG00673294: hypothetical protein +FIG00673295 disulfide bond formation protein B +FIG00673296 FIG00673297: hypothetical protein +FIG00673297 FIG00673298: hypothetical protein +FIG00673302 Acyl-CoA reductase (EC 1.2.1.50) +FIG00673303 FIG00673305: hypothetical protein +FIG00673305 FIG00673306: hypothetical protein +FIG00673308 FIG00673309: hypothetical protein +FIG00673309 FIG00673310: hypothetical protein +FIG00673316 FIG00673317: hypothetical protein +FIG00673317 FIG00673318: hypothetical protein +FIG00673319 FIG00673320: hypothetical protein +FIG00673320 FIG00673321: hypothetical protein +FIG00673322 FIG00673324: hypothetical protein +FIG00673326 FIG00673328: hypothetical protein +FIG00673330 FIG00673333: hypothetical protein +FIG00673333 FIG00673334: hypothetical protein +FIG00673334 FIG00673335: hypothetical protein +FIG00673341 FIG00673342: hypothetical protein +FIG00673342 FIG00673345: hypothetical protein +FIG00673345 FIG00673346: hypothetical protein +FIG00673347 FIG00673348: hypothetical protein +FIG00673348 FIG00673349: hypothetical protein +FIG00673349 FIG00673350: hypothetical protein +FIG00673353 FIG00673354: hypothetical protein +FIG00673354 FIG00673355: hypothetical protein +FIG00673355 FIG00673356: hypothetical protein +FIG00673356 FIG00673357: hypothetical protein +FIG00673357 FIG00673358: hypothetical protein +FIG00673358 FIG00673359: hypothetical protein +FIG00673359 FIG00673361: hypothetical protein +FIG00673362 FIG00673364: hypothetical protein +FIG00673364 carboxyl-terminal processing protease +FIG00673365 FIG00673367: hypothetical protein +FIG00673367 Ribonucleoside-diphosphate reductase (EC 1.17.4.1) +FIG00673368 FIG00673369: hypothetical protein +FIG00673369 FIG00673370: hypothetical protein +FIG00673370 FIG00673371: hypothetical protein +FIG00673375 FIG00673377: hypothetical protein +FIG00673380 FIG00673381: hypothetical protein +FIG00673383 FIG00673384: hypothetical protein +FIG00673384 FIG00673387: hypothetical protein +FIG00673387 FIG00673390: hypothetical protein +FIG00673390 FIG00673392: hypothetical protein +FIG00673392 FIG00673393: hypothetical protein +FIG00673393 FIG00673395: hypothetical protein +FIG00673395 FIG00673396: hypothetical protein +FIG00673396 FIG00673397: hypothetical protein +FIG00673397 FIG00673398: hypothetical protein +FIG00673398 FIG00673399: hypothetical protein +FIG00673399 FIG00673400: hypothetical protein +FIG00673401 FIG00673402: hypothetical protein +FIG00673404 FIG00673406: hypothetical protein +FIG00673406 FIG00673407: hypothetical protein +FIG00673408 FIG00673409: hypothetical protein +FIG00673409 FIG00673410: hypothetical protein +FIG00673413 FIG00673415: hypothetical protein +FIG00673415 Lmo2045 protein +FIG00673416 FIG00673417: hypothetical protein +FIG00673417 FIG00673419: hypothetical protein +FIG00673419 Alpha-ribazole-5'-phosphate phosphatase +FIG00673423 FIG00674946: hypothetical protein +FIG00673424 FIG00673425: hypothetical protein +FIG00673426 FIG00673428: hypothetical protein +FIG00673433 FIG00673438: hypothetical protein +FIG00673438 FIG00673439: hypothetical protein +FIG00673440 FIG00673443: hypothetical protein +FIG00673443 FIG00673445: hypothetical protein +FIG00673445 FIG00673448: hypothetical protein +FIG00673449 FIG00673454: hypothetical protein +FIG00673456 FIG00673458: hypothetical protein +FIG00673459 FIG00673460: hypothetical protein +FIG00673461 FIG00673462: hypothetical protein +FIG00673462 FIG00673463: hypothetical protein +FIG00673463 FIG00673465: hypothetical protein +FIG00673467 FIG00673468: hypothetical protein +FIG00673469 FIG00673470: hypothetical protein +FIG00673470 FIG00673471: hypothetical protein +FIG00673472 FIG00673473: hypothetical protein +FIG00673474 FIG00673476: hypothetical protein +FIG00673476 Squalene-hopene cyclase +FIG00673478 FIG00673480: hypothetical protein +FIG00673480 FIG00673484: hypothetical protein +FIG00673487 FIG00673489: hypothetical protein +FIG00673493 FIG00673495: hypothetical protein +FIG00673495 FIG00673496: hypothetical protein +FIG00673496 FIG00673497: hypothetical protein +FIG00673497 FIG00673499: hypothetical protein +FIG00673500 FIG00673501: hypothetical protein +FIG00673503 FIG00673504: hypothetical protein +FIG00673505 FIG00673506: hypothetical protein +FIG00673506 FIG00673508: hypothetical protein +FIG00673508 FIG00673509: hypothetical protein +FIG00673509 FIG00673513: hypothetical protein +FIG00673513 similar to hypothetical protein +FIG00673515 FIG00673516: hypothetical protein +FIG00673516 FIG00673522: hypothetical protein +FIG00673522 NADH dehydrogenase +FIG00673526 FIG00673530: hypothetical protein +FIG00673534 FIG00673535: hypothetical protein +FIG00673537 FIG00673538: hypothetical protein +FIG00673538 FIG00673539: hypothetical protein +FIG00673541 phosphotriesterase family protein +FIG00673542 Bypass-of-forespore protein C +FIG00673543 FIG00673544: hypothetical protein +FIG00673545 FIG00673546: hypothetical protein +FIG00673546 dolichyl-phosphate mannose synthase +FIG00673547 FIG00673548: hypothetical protein +FIG00673548 FIG00673549: hypothetical protein +FIG00673549 TrsE protein +FIG00673552 Zinc metallohydrolase, metallo-beta-lactamase family (EC 3.5.2.6) +FIG00673556 FIG00673557: hypothetical protein +FIG00673557 Alr0191 protein +FIG00673558 Patative DNA/RNA helicase SNF2 family +FIG00673562 FIG00673567: hypothetical protein +FIG00673567 FIG00673568: hypothetical protein +FIG00673568 FIG00673569: hypothetical protein +FIG00673569 FIG00673570: hypothetical protein +FIG00673570 FIG00673571: hypothetical protein +FIG00673571 PTS system, lactose/cellobiose specific IIB subunit +FIG00673576 FIG00673577: hypothetical protein +FIG00673577 FIG00673578: hypothetical protein +FIG00673587 Transcriptional regulator MerR family +FIG00673588 FIG00673589: hypothetical protein +FIG00673589 FIG00673594: hypothetical protein +FIG00673594 FIG00673596: hypothetical protein +FIG00673597 FIG00673598: hypothetical protein +FIG00673598 FIG00673599: hypothetical protein +FIG00673599 FIG00673600: hypothetical protein +FIG00673600 FIG00673601: hypothetical protein +FIG00673601 FIG00673602: hypothetical protein +FIG00673602 FIG00673603: hypothetical protein +FIG00673604 FIG00673605: hypothetical protein +FIG00673608 FIG00673609: hypothetical protein +FIG00673609 FIG00673610: hypothetical protein +FIG00673610 FIG00673611: hypothetical protein +FIG00673611 FIG00673613: hypothetical protein +FIG00673613 FIG00673615: hypothetical protein +FIG00673616 FIG00673619: hypothetical protein +FIG00673619 FIG00673620: hypothetical protein +FIG00673623 FIG00673625: hypothetical protein +FIG00673625 FIG00673626: hypothetical protein +FIG00673627 FIG00673628: hypothetical protein +FIG00673633 FIG00673634: hypothetical protein +FIG00673634 FIG00673635: hypothetical protein +FIG00673635 FIG00673636: hypothetical protein +FIG00673636 FIG00673638: hypothetical protein +FIG00673638 FIG00673640: hypothetical protein +FIG00673640 FIG00673641: hypothetical protein +FIG00673642 FIG00673643: hypothetical protein +FIG00673643 FIG00673644: hypothetical protein +FIG00673644 FIG00673645: hypothetical protein +FIG00673645 FIG00673646: hypothetical protein +FIG00673649 FIG00673650: hypothetical protein +FIG00673650 FIG00673651: hypothetical protein +FIG00673651 FIG00673653: hypothetical protein +FIG00673659 FIG00673660: hypothetical protein +FIG00673660 FIG00673661: hypothetical protein +FIG00673661 FIG00673663: hypothetical protein +FIG00673663 Sporulation kinase A +FIG00673664 FIG00673666: hypothetical protein +FIG00673667 FIG00673669: hypothetical protein +FIG00673670 FIG00673672: hypothetical protein +FIG00673672 FIG00673674: hypothetical protein +FIG00673674 FIG00673676: hypothetical protein +FIG00673676 FIG00673678: hypothetical protein +FIG00673678 FIG00673679: hypothetical protein +FIG00673681 Predicted xylanase/chitin deacetylase +FIG00673683 FIG00673684: hypothetical protein +FIG00673685 FIG00673686: hypothetical protein +FIG00673689 FIG00673691: hypothetical protein +FIG00673693 FIG00673695: hypothetical protein +FIG00673695 FIG00673696: hypothetical protein +FIG00673696 FIG00673697: hypothetical protein +FIG00673697 NADH dehydrogenase (ubiquinone) chain 4( EC:1.6.5.3 ) +FIG00673701 FIG00673703: hypothetical protein +FIG00673703 FIG00673704: hypothetical protein +FIG00673704 FIG00673705: hypothetical protein +FIG00673706 FIG00673707: hypothetical protein +FIG00673714 FIG00673715: hypothetical protein +FIG00673720 FIG00673721: hypothetical protein +FIG00673721 FIG00673723: hypothetical protein +FIG00673724 FIG00673725: hypothetical protein +FIG00673725 Transcriptional regulator, repressor of the glutamine synthetase, MerR family +FIG00673727 FIG00673728: hypothetical protein +FIG00673736 FIG00673737: hypothetical protein +FIG00673740 FIG00673741: hypothetical protein +FIG00673741 FIG00673742: hypothetical protein +FIG00673745 FIG00673746: hypothetical protein +FIG00673746 FIG00673749: hypothetical protein +FIG00673749 FIG00673750: hypothetical protein +FIG00673750 FIG00673752: hypothetical protein +FIG00673752 FIG00673753: hypothetical protein +FIG00673753 FIG00673756: hypothetical protein +FIG00673756 FIG00673758: hypothetical protein +FIG00673760 FIG00673762: hypothetical protein +FIG00673763 FIG00673765: hypothetical protein +FIG00673769 FIG00673772: hypothetical protein +FIG00673777 FIG00673778: hypothetical protein +FIG00673778 sigma54 specific transcriptional regulator with PAS sensor, Fis family +FIG00673780 FIG00673782: hypothetical protein +FIG00673782 FIG00673783: hypothetical protein +FIG00673783 FIG00673786: hypothetical protein +FIG00673786 FIG00673787: hypothetical protein +FIG00673787 FIG00673788: hypothetical protein +FIG00673789 FIG00673790: hypothetical protein +FIG00673791 FIG00673793: hypothetical protein +FIG00673793 FIG00673796: hypothetical protein +FIG00673796 FIG00673800: hypothetical protein +FIG00673800 FIG00673803: hypothetical protein +FIG00673803 similar to DNA replication protein +FIG00673806 transcriptional regulator (marR family) +FIG00673808 FIG00673811: hypothetical protein +FIG00673811 FIG00673812: hypothetical protein +FIG00673812 FIG00673813: hypothetical protein +FIG00673822 FIG00673823: hypothetical protein +FIG00673823 FIG00673824: hypothetical protein +FIG00673824 FIG00673825: hypothetical protein +FIG00673828 phosphoesterase +FIG00673830 FIG00673832: hypothetical protein +FIG00673838 FIG00673839: hypothetical protein +FIG00673839 N-acylamino acid racemase @ O-succinylbenzoate synthase (EC 4.2.1.113) +FIG00673847 helix-turn-helix containing protein Cj1387c +FIG00673852 drug-efflux transporter +FIG00673859 FIG00673860: hypothetical protein +FIG00673860 FIG00673862: hypothetical protein +FIG00673862 FIG00673863: hypothetical protein +FIG00673863 FIG00673864: hypothetical protein +FIG00673867 FIG00673869: hypothetical protein +FIG00673871 FIG00673872: hypothetical protein +FIG00673872 FIG00673874: hypothetical protein +FIG00673877 FIG00673878: hypothetical protein +FIG00673879 FIG00673880: hypothetical protein +FIG00673883 FIG00673884: hypothetical protein +FIG00673884 FIG00673885: hypothetical protein +FIG00673885 FIG00673886: hypothetical protein +FIG00673886 FIG00673887: hypothetical protein +FIG00673887 FIG00673890: hypothetical protein +FIG00673890 FIG00673891: hypothetical protein +FIG00673891 FIG00673892: hypothetical protein +FIG00673898 FIG00673900: hypothetical protein +FIG00673900 FIG00673901: hypothetical protein +FIG00673901 FIG00673905: hypothetical protein +FIG00673905 FIG00673909: hypothetical protein +FIG00673909 FIG00673910: hypothetical protein +FIG00673910 YbbJ +FIG00673911 FIG00673913: hypothetical protein +FIG00673916 FIG00673919: hypothetical protein +FIG00673919 FIG00673924: hypothetical protein +FIG00673924 FIG00673926: hypothetical protein +FIG00673926 FIG00673927: hypothetical protein +FIG00673930 FIG00673931: hypothetical protein +FIG00673931 FIG00673932: hypothetical protein +FIG00673932 FIG00673934: hypothetical protein +FIG00673934 FIG01225334: hypothetical protein +FIG00673936 FIG00673937: hypothetical protein +FIG00673937 FIG00673940: hypothetical protein +FIG00673942 FIG00673943: hypothetical protein +FIG00673943 FIG00673944: hypothetical protein +FIG00673945 FIG00673946: hypothetical protein +FIG00673946 FIG00673947: hypothetical protein +FIG00673947 FIG00673948: hypothetical protein +FIG00673948 FIG00673949: hypothetical protein +FIG00673950 FIG00673952: hypothetical protein +FIG00673952 FIG00673953: hypothetical protein +FIG00673954 FIG00673955: hypothetical protein +FIG00673956 FIG00673959: hypothetical protein +FIG00673964 FIG00673968: hypothetical protein +FIG00673968 FIG00673969: hypothetical protein +FIG00673969 Uncharacterized protein Bsub YpbR +FIG00673971 FIG00673972: hypothetical protein +FIG00673972 FIG00673973: hypothetical protein +FIG00673973 FIG00673974: hypothetical protein +FIG00673974 FIG00673977: hypothetical protein +FIG00673977 FIG00673978: hypothetical protein +FIG00673981 FIG00673985: hypothetical protein +FIG00673989 FIG00673990: hypothetical protein +FIG00673990 FIG00673992: hypothetical protein +FIG00673992 phage-related protein (tail protein) +FIG00673995 FIG00673996: hypothetical protein +FIG00673996 FIG00673997: hypothetical protein +FIG00673997 FIG00674000: hypothetical protein +FIG00674000 FIG00674001: hypothetical protein +FIG00674010 FIG00674012: hypothetical protein +FIG00674012 FIG00674013: hypothetical protein +FIG00674013 FIG00674014: hypothetical protein +FIG00674019 FIG00674020: hypothetical protein +FIG00674020 FIG00674021: hypothetical protein +FIG00674021 FIG00674022: hypothetical protein +FIG00674022 FIG00674023: hypothetical protein +FIG00674023 FIG00674025: hypothetical protein +FIG00674028 FIG00674029: hypothetical protein +FIG00674029 FIG00674030: hypothetical protein +FIG00674030 FIG00674032: hypothetical protein +FIG00674041 FIG00674042: hypothetical protein +FIG00674042 FIG00674043: hypothetical protein +FIG00674045 FIG00674046: hypothetical protein +FIG00674046 FIG00674047: hypothetical protein +FIG00674050 FIG00674053: hypothetical protein +FIG00674061 FIG00674062: hypothetical protein +FIG00674063 FIG00674066: hypothetical protein +FIG00674066 FIG00674070: hypothetical protein +FIG00674071 FIG00674072: hypothetical protein +FIG00674072 Arylsulfatase regulator Fe-S oxidoreductase +FIG00674074 FIG00674075: hypothetical protein +FIG00674075 FIG00674076: hypothetical protein +FIG00674076 FIG00674077: hypothetical protein +FIG00674077 hypothetical protein BH2232 +FIG00674086 FIG00674087: hypothetical protein +FIG00674087 FIG00674089: hypothetical protein +FIG00674091 FIG00674092: hypothetical protein +FIG00674092 FIG00674094: hypothetical protein +FIG00674094 FIG00674096: hypothetical protein +FIG00674100 FIG00674102: hypothetical protein +FIG00674102 Type IV pilin PilA +FIG00674103 FIG00674104: hypothetical protein +FIG00674104 FIG00674105: hypothetical protein +FIG00674105 FIG00674106: hypothetical protein +FIG00674106 FIG00674107: hypothetical protein +FIG00674107 FIG00674108: hypothetical protein +FIG00674110 FIG00674112: hypothetical protein +FIG00674112 FIG00674118: hypothetical protein +FIG00674118 FIG00674119: hypothetical protein +FIG00674123 FIG00674124: hypothetical protein +FIG00674124 FIG00674127: hypothetical protein +FIG00674127 FIG00674133: hypothetical protein +FIG00674133 FIG00674135: hypothetical protein +FIG00674135 FIG00674137: hypothetical protein +FIG00674138 FIG00674139: hypothetical protein +FIG00674140 FIG00674141: hypothetical protein +FIG00674141 FIG00674142: hypothetical protein +FIG00674142 FIG00674143: hypothetical protein +FIG00674144 putative esterase/lipase +FIG00674146 FIG00674147: hypothetical protein +FIG00674150 FIG00674151: hypothetical protein +FIG00674153 FIG00674154: hypothetical protein +FIG00674154 FIG00674156: hypothetical protein +FIG00674158 FIG00674159: hypothetical protein +FIG00674164 FIG00674166: hypothetical protein +FIG00674168 Nitrogen-fixing NifU, C-terminal:Rieske [2Fe-2S] region +FIG00674174 FIG00674176: hypothetical protein +FIG00674176 FIG00674179: hypothetical protein +FIG00674184 FIG00674185: hypothetical protein +FIG00674185 FIG00674186: hypothetical protein +FIG00674186 FIG00674189: hypothetical protein +FIG00674191 FIG00674194: hypothetical protein +FIG00674194 FIG00674196: hypothetical protein +FIG00674196 FIG00674199: hypothetical protein +FIG00674199 FIG00674202: hypothetical protein +FIG00674202 YvlB +FIG00674204 FIG00674207: hypothetical protein +FIG00674208 hypothetical protein GK2762 +FIG00674209 FIG00674211: hypothetical protein +FIG00674212 FIG00674213: hypothetical protein +FIG00674216 FIG00674217: hypothetical protein +FIG00674221 FIG00674223: hypothetical protein +FIG00674223 FIG00674224: hypothetical protein +FIG00674225 FIG00674226: hypothetical protein +FIG00674226 FIG00674229: hypothetical protein +FIG00674230 FIG00674234: hypothetical protein +FIG00674234 multidrug ABC transporter (permease) +FIG00674236 FIG00674237: hypothetical protein +FIG00674237 FIG00674238: hypothetical protein +FIG00674238 FIG00674240: hypothetical protein +FIG00674241 FIG00674242: hypothetical protein +FIG00674244 FIG00674245: hypothetical protein +FIG00674245 FIG00674249: hypothetical protein +FIG00674251 Invasion associated protein p60 +FIG00674253 FIG00674256: hypothetical protein +FIG00674256 FIG00674258: hypothetical protein +FIG00674261 FIG00674263: hypothetical protein +FIG00674264 FIG00674265: hypothetical protein +FIG00674266 FIG00674267: hypothetical protein +FIG00674269 FIG00674271: hypothetical protein +FIG00674271 FIG00674272: hypothetical protein +FIG00674274 FIG00674277: hypothetical protein +FIG00674280 ABC transporter periplasmic binding protein yphF +FIG00674287 FIG00674288: hypothetical protein +FIG00674288 FIG00674292: hypothetical protein +FIG00674294 FIG00674296: hypothetical protein +FIG00674296 FIG00674297: hypothetical protein +FIG00674303 hypothetical protein +FIG00674305 FIG00674306: hypothetical protein +FIG00674306 FIG00674307: hypothetical protein +FIG00674307 FIG00674308: hypothetical protein +FIG00674308 FIG00674309: hypothetical protein +FIG00674310 FIG00674311: hypothetical protein +FIG00674311 FIG00674313: hypothetical protein +FIG00674313 FIG00674314: hypothetical protein +FIG00674316 FIG00674318: hypothetical protein +FIG00674318 FIG00674319: hypothetical protein +FIG00674320 FIG00674321: hypothetical protein +FIG00674321 FIG00674322: hypothetical protein +FIG00674326 FIG00674327: hypothetical protein +FIG00674334 FIG00674336: hypothetical protein +FIG00674338 FIG00674341: hypothetical protein +FIG00674341 FIG00674342: hypothetical protein +FIG00674343 FIG00674346: hypothetical protein +FIG00674348 FIG00674349: hypothetical protein +FIG00674350 FIG00674351: hypothetical protein +FIG00674351 FIG00674354: hypothetical protein +FIG00674354 FIG00674355: hypothetical protein +FIG00674355 FIG00674356: hypothetical protein +FIG00674356 phosphosugar-binding protein +FIG00674357 FIG00674360: hypothetical protein +FIG00674360 FIG00674361: hypothetical protein +FIG00674362 FIG00674363: hypothetical protein +FIG00674368 FIG00674369: hypothetical protein +FIG00674369 FIG00674371: hypothetical protein +FIG00674373 FIG00674374: hypothetical protein +FIG00674381 FIG00674382: hypothetical protein +FIG00674390 Dipeptidyl aminopeptidases/acylaminoacyl-peptidases +FIG00674392 Uncharacterized phage protein (possible DNA packaging) +FIG00674393 FIG00674395: hypothetical protein +FIG00674395 FIG00674399: hypothetical protein +FIG00674399 FIG00674401: hypothetical protein +FIG00674401 multidrug resistance protein homolog +FIG00674403 FIG00674405: hypothetical protein +FIG00674405 FIG00674406: hypothetical protein +FIG00674406 AMP-binding enzyme +FIG00674410 FIG00674413: hypothetical protein +FIG00674413 FIG00674414: hypothetical protein +FIG00674414 FIG00674415: hypothetical protein +FIG00674415 FIG00674416: hypothetical protein +FIG00674420 FIG00674421: hypothetical protein +FIG00674421 FIG00674422: hypothetical protein +FIG00674422 FIG00674426: hypothetical protein +FIG00674426 FIG00674427: hypothetical protein +FIG00674427 FIG00674428: hypothetical protein +FIG00674430 FIG00674431: hypothetical protein +FIG00674431 FIG00674432: hypothetical protein +FIG00674437 FIG00674438: hypothetical protein +FIG00674438 FIG00674441: hypothetical protein +FIG00674441 FIG00674442: hypothetical protein +FIG00674445 FIG00674447: hypothetical protein +FIG00674447 FIG00674448: hypothetical protein +FIG00674448 FIG00674450: hypothetical protein +FIG00674450 FIG00674452: hypothetical protein +FIG00674454 FIG00674455: hypothetical protein +FIG00674456 FIG00674457: hypothetical protein +FIG00674457 FIG00674459: hypothetical protein +FIG00674459 FIG00674461: hypothetical protein +FIG00674464 FIG00674465: hypothetical protein +FIG00674466 FIG00674467: hypothetical protein +FIG00674470 FIG00674471: hypothetical protein +FIG00674473 FIG00674474: hypothetical protein +FIG00674474 FIG00674475: hypothetical protein +FIG00674475 FIG00674479: hypothetical protein +FIG00674480 FIG00674481: hypothetical protein +FIG00674481 Propanediol dehydratase reactivation factor small subunit +FIG00674489 FIG00674491: hypothetical protein +FIG00674491 FIG00674492: hypothetical protein +FIG00674492 Protein crcB homolog 1 +FIG00674493 FIG00674496: hypothetical protein +FIG00674496 FIG00674498: hypothetical protein +FIG00674499 FIG00674500: hypothetical protein +FIG00674500 protein of unknown function DUF1641 +FIG00674501 FIG00674503: hypothetical protein +FIG00674503 FIG00674506: hypothetical protein +FIG00674507 FIG00674508: hypothetical protein +FIG00674508 FIG00674509: hypothetical protein +FIG00674509 FIG00674510: hypothetical protein +FIG00674510 FIG00674511: hypothetical protein +FIG00674512 FIG00674513: hypothetical protein +FIG00674513 FIG00674514: hypothetical protein +FIG00674523 FIG00674524: hypothetical protein +FIG00674526 FIG00674528: hypothetical protein +FIG00674528 FIG00674529: hypothetical protein +FIG00674529 FIG00674530: hypothetical protein +FIG00674531 FIG00674532: hypothetical protein +FIG00674533 FIG00674534: hypothetical protein +FIG00674534 FIG00674536: hypothetical protein +FIG00674536 FIG00674538: hypothetical protein +FIG00674539 FIG00674540: hypothetical protein +FIG00674543 FIG00674544: hypothetical protein +FIG00674544 FIG00674550: hypothetical protein +FIG00674552 FIG00674554: hypothetical protein +FIG00674554 FIG00674555: hypothetical protein +FIG00674555 FIG00674559: hypothetical protein +FIG00674565 FIG00674567: hypothetical protein +FIG00674568 FIG00674572: hypothetical protein +FIG00674572 FIG00674573: hypothetical protein +FIG00674575 FIG00674576: hypothetical protein +FIG00674576 Putative NTP pyrophosphohydrolase +FIG00674581 FIG00674582: hypothetical protein +FIG00674593 FIG00674594: hypothetical protein +FIG00674595 FIG00674596: hypothetical protein +FIG00674601 FIG00674603: hypothetical protein +FIG00674603 Tn5252, Orf 21 protein, internal deletion +FIG00674605 FIG00674606: hypothetical protein +FIG00674607 FIG00674611: hypothetical protein +FIG00674614 FIG00674616: hypothetical protein +FIG00674616 Two-component response regulator ComA +FIG00674625 FIG00674627: hypothetical protein +FIG00674630 FIG00674631: hypothetical protein +FIG00674631 FIG00674633: hypothetical protein +FIG00674634 Acetobutylicum phosphotransbutyrylase +FIG00674637 FIG00674639: hypothetical protein +FIG00674641 FIG00674642: hypothetical protein +FIG00674642 FIG00674644: hypothetical protein +FIG00674644 FIG00674648: hypothetical protein +FIG00674648 FIG00674649: hypothetical protein +FIG00674649 FIG00674650: hypothetical protein +FIG00674650 FIG00674651: hypothetical protein +FIG00674652 FIG00674653: hypothetical protein +FIG00674653 FIG00674657: hypothetical protein +FIG00674669 FIG00674670: hypothetical protein +FIG00674670 FIG00674672: hypothetical protein +FIG00674682 FIG00674683: hypothetical protein +FIG00674686 FIG00674687: hypothetical protein +FIG00674687 FIG00674693: hypothetical protein +FIG00674693 FIG00674694: hypothetical protein +FIG00674694 FIG00674697: hypothetical protein +FIG00674697 FIG00674698: hypothetical protein +FIG00674700 FIG00674704: hypothetical protein +FIG00674704 regulator of polyketide synthase expression, putative +FIG00674707 FIG00674708: hypothetical protein +FIG00674708 FIG00674709: hypothetical protein +FIG00674709 FIG00674710: hypothetical protein +FIG00674714 FIG00674717: hypothetical protein +FIG00674717 FIG00674719: hypothetical protein +FIG00674720 FIG00674721: hypothetical protein +FIG00674724 FIG00674725: hypothetical protein +FIG00674725 FIG00674726: hypothetical protein +FIG00674731 FIG00674733: hypothetical protein +FIG00674737 FIG00674738: hypothetical protein +FIG00674746 P21 precursor +FIG00674758 FIG00674759: hypothetical protein +FIG00674759 FIG00674760: hypothetical protein +FIG00674760 FIG00674761: hypothetical protein +FIG00674761 FIG00674764: hypothetical protein +FIG00674765 FIG00674768: hypothetical protein +FIG00674768 FIG00674774: hypothetical protein +FIG00674774 FIG00674777: hypothetical protein +FIG00674778 FIG00674780: hypothetical protein +FIG00674780 FIG00674783: hypothetical protein +FIG00674785 FIG00674788: hypothetical protein +FIG00674794 FIG00674795: hypothetical protein +FIG00674796 FIG00674797: hypothetical protein +FIG00674803 FIG00674808: hypothetical protein +FIG00674815 FIG00674817: hypothetical protein +FIG00674817 FIG00674818: hypothetical protein +FIG00674818 FIG00674819: hypothetical protein +FIG00674820 Encapsulating protein for a DyP-type peroxidase or ferritin-like protein oligomers +FIG00674822 FIG00674823: hypothetical protein +FIG00674823 FIG00674824: hypothetical protein +FIG00674829 COG4638: Phenylpropionate dioxygenase and related ring-hydroxylating dioxygenases, large terminal subunit +FIG00674833 FIG00674834: hypothetical protein +FIG00674843 FIG00674844: hypothetical protein +FIG00674844 FIG00674845: hypothetical protein +FIG00674845 FIG00674848: hypothetical protein +FIG00674848 FIG00674849: hypothetical protein +FIG00674849 FIG00674850: hypothetical protein +FIG00674869 FIG00674870: hypothetical protein +FIG00674879 FIG00674882: hypothetical protein +FIG00674885 FIG00674888: hypothetical protein +FIG00674888 FIG00674891: hypothetical protein +FIG00674893 FIG00674894: hypothetical protein +FIG00674900 FIG00674901: hypothetical protein +FIG00674901 FIG00674902: hypothetical protein +FIG00674905 FIG00674906: hypothetical protein +FIG00674906 FIG00674907: hypothetical protein +FIG00674907 FIG00674909: hypothetical protein +FIG00674911 FIG00674912: hypothetical protein +FIG00674912 FIG00674913: hypothetical protein +FIG00674913 FIG00674914: hypothetical protein +FIG00674916 Uncharacterised protein family UPF0157 (COG2320) +FIG00674917 FIG00674918: hypothetical protein +FIG00674922 FIG00674927: hypothetical protein +FIG00674927 FIG00674928: hypothetical protein +FIG00674928 FIG00674933: hypothetical protein +FIG00674933 FIG00674934: hypothetical protein +FIG00674940 FIG00674941: hypothetical protein +FIG00674946 acetyltransferase (GNAT family) +FIG00674956 FIG00674957: hypothetical protein +FIG00674957 FIG00674960: hypothetical protein +FIG00674960 CirC protein +FIG00674961 FIG00674962: hypothetical protein +FIG00674971 FIG00674974: hypothetical protein +FIG00674974 FIG00674976: hypothetical protein +FIG00674984 FIG00674985: hypothetical protein +FIG00674985 FIG00674986: hypothetical protein +FIG00674986 FIG00674990: hypothetical protein +FIG00674995 FIG00674996: hypothetical protein +FIG00674996 FIG00674997: hypothetical protein +FIG00674997 FIG00674998: hypothetical protein +FIG00675000 FIG00675002: hypothetical protein +FIG00675003 FIG00675005: hypothetical protein +FIG00675008 FIG00675009: hypothetical protein +FIG00675014 FIG00675015: hypothetical protein +FIG00675015 FIG00675017: hypothetical protein +FIG00675017 FIG00675018: hypothetical protein +FIG00675018 FIG00675019: hypothetical protein +FIG00675020 FIG00675021: hypothetical protein +FIG00675022 FIG00675024: hypothetical protein +FIG00675024 FIG00675025: hypothetical protein +FIG00675033 FIG00675036: hypothetical protein +FIG00675045 FIG00675048: hypothetical protein +FIG00675048 FIG00675051: hypothetical protein +FIG00675051 FIG00675053: hypothetical protein +FIG00675053 FIG00675055: hypothetical protein +FIG00675055 FIG00675057: hypothetical protein +FIG00675057 FIG00675061: hypothetical protein +FIG00675063 FIG00675065: hypothetical protein +FIG00675067 ATPase component of ABC transporter with duplicated ATPase domains +FIG00675073 FIG00675078: hypothetical protein +FIG00675078 Long-chain-fatty-acid--luciferin-component ligase (EC 6.2.1.19) +FIG00675079 Conserved protein YfhJ +FIG00675080 FIG00675084: hypothetical protein +FIG00675085 FIG00675086: hypothetical protein +FIG00675086 FIG00675088: hypothetical protein +FIG00675096 FIG00675097: hypothetical protein +FIG00675097 FIG00675098: hypothetical protein +FIG00675102 FIG00675103: hypothetical protein +FIG00675106 FIG00675107: hypothetical protein +FIG00675107 FIG00675110: hypothetical protein +FIG00675121 FIG00675122: hypothetical protein +FIG00675122 transcriptional regulator, MerR family protein +FIG00675123 FIG00675124: hypothetical protein +FIG00675126 FIG00675127: hypothetical protein +FIG00675127 FIG00675129: hypothetical protein +FIG00675132 FIG00675133: hypothetical protein +FIG00675133 FIG00675134: hypothetical protein +FIG00675136 FIG00675137: hypothetical protein +FIG00675144 FIG00675145: hypothetical protein +FIG00675145 FIG00675147: hypothetical protein +FIG00675148 FIG00675150: hypothetical protein +FIG00675150 FIG00675151: hypothetical protein +FIG00675151 FIG00675152: hypothetical protein +FIG00675153 FIG00675154: hypothetical protein +FIG00675154 FIG00675160: hypothetical protein +FIG00675160 FIG00675164: hypothetical protein +FIG00675173 FIG00675175: hypothetical protein +FIG00675175 FIG00675180: hypothetical protein +FIG00675181 D-alanyl-aminopeptidase +FIG00675183 FIG00675188: hypothetical protein +FIG00675189 FIG00675194: hypothetical protein +FIG00675194 FIG00675195: hypothetical protein +FIG00675207 FIG00675208: hypothetical protein +FIG00675209 Mitogen-activated protein kinase kinase kinase kinase 4 (EC 2.7.11.1) +FIG00675213 FIG00675217: hypothetical protein +FIG00675220 FIG00675221: hypothetical protein +FIG00675221 FIG00675222: hypothetical protein +FIG00675229 FIG00675231: hypothetical protein +FIG00675231 FIG00675236: hypothetical protein +FIG00675256 FIG00675257: hypothetical protein +FIG00675260 FIG00675268: hypothetical protein +FIG00675269 FIG00675271: hypothetical protein +FIG00675271 FIG00675272: hypothetical protein +FIG00675272 FIG00675274: hypothetical protein +FIG00675274 FIG00675278: hypothetical protein +FIG00675278 FIG00675283: hypothetical protein +FIG00675286 FIG00675287: hypothetical protein +FIG00675294 FIG00675298: hypothetical protein +FIG00675298 FIG00675300: hypothetical protein +FIG00675300 FIG00675302: hypothetical protein +FIG00675302 FIG00675305: hypothetical protein +FIG00675305 FIG00675314: hypothetical protein +FIG00675314 FIG00675317: hypothetical protein +FIG00675317 Programmed cell death toxin YdcE +FIG00675320 FIG00675321: hypothetical protein +FIG00675328 FIG00675331: hypothetical protein +FIG00675334 FIG00675336: hypothetical protein +FIG00675346 FIG00675349: hypothetical protein +FIG00675349 FIG00675357: hypothetical protein +FIG00675357 FIG00675363: hypothetical protein +FIG00675365 FIG00675366: hypothetical protein +FIG00675372 FIG00675374: hypothetical protein +FIG00675378 FIG00675379: hypothetical protein +FIG00675379 FIG00675380: hypothetical protein +FIG00675385 FIG00675386: hypothetical protein +FIG00675386 FIG00675387: hypothetical protein +FIG00675399 FIG00675401: hypothetical protein +FIG00675410 FIG00675411: hypothetical protein +FIG00675418 FIG00675420: hypothetical protein +FIG00675420 FIG00675421: hypothetical protein +FIG00675421 FIG00675425: hypothetical protein +FIG00675435 FIG00675436: hypothetical protein +FIG00675441 Mutator mutT protein (7,8-dihydro-8-oxoguanine-triphosphatase)( EC:3.6.1.- ) +FIG00675447 FIG00675449: hypothetical protein +FIG00675452 FIG00675453: hypothetical protein +FIG00675455 FIG00675456: hypothetical protein +FIG00675458 FIG00675461: hypothetical protein +FIG00675469 FIG00675471: hypothetical protein +FIG00675471 FIG00675472: hypothetical protein +FIG00675472 FIG00675477: hypothetical protein +FIG00675478 FIG00675479: hypothetical protein +FIG00675479 FIG00675480: hypothetical protein +FIG00675480 FIG00675481: hypothetical protein +FIG00675481 FIG00675482: hypothetical protein +FIG00675489 FIG00675494: hypothetical protein +FIG00675494 FIG00675495: hypothetical protein +FIG00675495 FIG00675501: hypothetical protein +FIG00675501 FIG00675502: hypothetical protein +FIG00675519 YkyA +FIG00675528 FIG00675530: hypothetical protein +FIG00675541 FIG00675542: hypothetical protein +FIG00675564 FIG00675566: hypothetical protein +FIG00675566 FIG00675568: hypothetical protein +FIG00675572 FIG00675574: hypothetical protein +FIG00675575 FIG00675576: hypothetical protein +FIG00675578 FIG00675579: hypothetical protein +FIG00675579 FIG00675580: hypothetical protein +FIG00675588 FIG00675589: hypothetical protein +FIG00675589 FIG00675591: hypothetical protein +FIG00675591 FIG00675595: hypothetical protein +FIG00675595 FIG00675597: hypothetical protein +FIG00675600 FIG00675601: hypothetical protein +FIG00675602 FIG00675605: hypothetical protein +FIG00675606 FIG00675607: hypothetical protein +FIG00675607 FIG00675608: hypothetical protein +FIG00675615 FIG00675616: hypothetical protein +FIG00675618 FIG00675622: hypothetical protein +FIG00675622 FIG00675628: hypothetical protein +FIG00675630 Carbon monoxide dehydrogenase medium chain (EC 1.2.99.2) parolog +FIG00675645 Acetaldehyde dehydrogenase, ethanolamine utilization cluster (EC 1.2.1.10) +FIG00675647 FIG00675648: hypothetical protein +FIG00675649 Uncharacterised protein family UPF0157 (COG2320) +FIG00675653 putative small multidrug resistance transmembrane protein +FIG00675665 FIG00675669: hypothetical protein +FIG00675684 FIG00675686: hypothetical protein +FIG00675687 FIG00675688: hypothetical protein +FIG00675688 FIG00675690: hypothetical protein +FIG00675690 FIG00675691: hypothetical protein +FIG00675691 FIG00675692: hypothetical protein +FIG00675694 FIG00675696: hypothetical protein +FIG00675699 FIG00675700: hypothetical protein +FIG00675704 FIG00675705: hypothetical protein +FIG00675706 FIG00675707: hypothetical protein +FIG00675708 FIG00675709: hypothetical protein +FIG00675711 FIG00675712: hypothetical protein +FIG00675712 ABC transporter precursor +FIG00675716 FIG00675721: hypothetical protein +FIG00675730 FIG00675731: hypothetical protein +FIG00675731 FIG00675737: hypothetical protein +FIG00675738 FIG00675739: hypothetical protein +FIG00675739 FIG00675740: hypothetical protein +FIG00675741 FIG00675742: hypothetical protein +FIG00675755 FIG00675756: hypothetical protein +FIG00675757 FIG00675759: hypothetical protein +FIG00675759 FIG00675761: hypothetical protein +FIG00675762 oxidoreductase, short chain dehydrogenase/reductase family( EC:1.1.1.276 ) +FIG00675764 conserved repeat domain +FIG00675766 FIG00675770: hypothetical protein +FIG00675770 transcriptional regulator, Fis family +FIG00675776 FIG00675777: hypothetical protein +FIG00675777 FIG00675778: hypothetical protein +FIG00675778 tellurite resistance protein-related protein +FIG00675779 FIG00675781: hypothetical protein +FIG00675781 dnaJ domain protein +FIG00675786 Type IV fimbrial biogenesis protein PilW +FIG00675789 Response regulator receiver:LytTr DNA-binding region +FIG00675790 FIG00675791: hypothetical protein +FIG00675791 Sigma-54-dependent transcriptional activator +FIG00675792 FIG00675794: hypothetical protein +FIG00675795 FIG00675797: hypothetical protein +FIG00675797 FIG00675798: hypothetical protein +FIG00675798 FIG00675799: hypothetical protein +FIG00675799 FIG00675800: hypothetical protein +FIG00675801 FIG00675806: hypothetical protein +FIG00675808 FIG00675813: hypothetical protein +FIG00675813 FIG00675817: hypothetical protein +FIG00675817 FIG00675819: hypothetical protein +FIG00675824 FIG00675825: hypothetical protein +FIG00675827 FIG00675828: hypothetical protein +FIG00675828 HPP family protein +FIG00675829 FIG00675830: hypothetical protein +FIG00675833 FIG00675834: hypothetical protein +FIG00675837 FIG00675838: hypothetical protein +FIG00675838 FIG00675840: hypothetical protein +FIG00675843 FIG00675844: hypothetical protein +FIG00675846 FIG00675847: hypothetical protein +FIG00675850 FIG00675852: hypothetical protein +FIG00675852 FIG00675856: hypothetical protein +FIG00675856 peptidase M1, membrane alanine aminopeptidase +FIG00675857 FIG00675858: hypothetical protein +FIG00675858 FIG00675861: hypothetical protein +FIG00675866 FIG00675867: hypothetical protein +FIG00675867 FIG00675868: hypothetical protein +FIG00675869 Acetyltransferase (isoleucine patch superfamily)-like protein +FIG00675871 FIG00675872: hypothetical protein +FIG00675873 LysM domain/NLP/P60 family protein +FIG00675874 FIG00675875: hypothetical protein +FIG00675876 ABC-type uncharacterized transport system periplasmic component-like protein +FIG00675880 FIG00675881: hypothetical protein +FIG00675881 FIG00675882: hypothetical protein +FIG00675883 Thiosulfate sulfurtransferase( EC:2.8.1.1 ) +FIG00675887 Core component CbiM of cobalt ECF transporter / Additional substrate-specific component CbiN of cobalt ECF transporter +FIG00675898 FIG00675899: hypothetical protein +FIG00675899 FIG00675900: hypothetical protein +FIG00675900 FIG00675901: hypothetical protein +FIG00675909 FIG00675915: hypothetical protein +FIG00675915 FIG00675916: hypothetical protein +FIG00675916 FIG00675917: hypothetical protein +FIG00675917 FIG00675920: hypothetical protein +FIG00675920 FIG00675922: hypothetical protein +FIG00675923 FIG00675924: hypothetical protein +FIG00675924 FIG00675925: hypothetical protein +FIG00675925 Transcriptional regulatory protein algP +FIG00675929 FIG00675930: hypothetical protein +FIG00675930 FIG00675932: hypothetical protein +FIG00675932 FIG00675933: hypothetical protein +FIG00675934 smr domain protein +FIG00675943 FIG00675945: hypothetical protein +FIG00675945 ferredoxin family protein, putative +FIG00675952 FIG00675957: hypothetical protein +FIG00675958 FIG00675959: hypothetical protein +FIG00675961 FIG00675962: hypothetical protein +FIG00675962 FIG00675963: hypothetical protein +FIG00675963 FIG00675964: hypothetical protein +FIG00675967 FIG00675970: hypothetical protein +FIG00675970 FIG00675972: hypothetical protein +FIG00675972 FIG00675974: hypothetical protein +FIG00675974 FIG00675975: hypothetical protein +FIG00675980 FIG00675982: hypothetical protein +FIG00675985 Type IV pilus biogenesis protein PilE +FIG00675987 sodium/hydrogen exchanger family/TrkA domain protein +FIG00675990 FIG00675993: hypothetical protein +FIG00675993 response regulator receiver protein +FIG00675997 NHL repeat domain protein +FIG00676003 FIG00676004: hypothetical protein +FIG00676007 FIG00676008: hypothetical protein +FIG00676012 FIG00676014: hypothetical protein +FIG00676022 Hpt sensor hybrid histidine kinase +FIG00676025 FIG00676031: hypothetical protein +FIG00676031 FIG00676035: hypothetical protein +FIG00676038 FIG00676040: hypothetical protein +FIG00676041 FIG00676045: hypothetical protein +FIG00676045 FIG00676051: hypothetical protein +FIG00676053 FIG00676054: hypothetical protein +FIG00676057 FIG00676058: hypothetical protein +FIG00676058 FIG00676060: hypothetical protein +FIG00676062 trypsin domain/PDZ domain protein +FIG00676068 FIG00676069: hypothetical protein +FIG00676073 FIG00676074: hypothetical protein +FIG00676074 FIG00676077: hypothetical protein +FIG00676082 FIG00676083: hypothetical protein +FIG00676083 FIG00676086: hypothetical protein +FIG00676086 FIG00676088: hypothetical protein +FIG00676088 Uncharacterized protein DUF1284, possibly iron-sulphur binding +FIG00676089 FIG00676090: hypothetical protein +FIG00676094 FIG00676096: hypothetical protein +FIG00676098 FIG00676099: hypothetical protein +FIG00676110 FIG00676111: hypothetical protein +FIG00676113 FIG00676115: hypothetical protein +FIG00676121 FIG00676123: hypothetical protein +FIG00676123 FIG00676126: hypothetical protein +FIG00676127 FIG00676129: hypothetical protein +FIG00676129 FIG00676131: hypothetical protein +FIG00676131 FIG00676137: hypothetical protein +FIG00676137 FIG00676140: hypothetical protein +FIG00676140 FIG00676142: hypothetical protein +FIG00676142 FIG00676143: hypothetical protein +FIG00676143 FIG00676144: hypothetical protein +FIG00676144 FIG00676149: hypothetical protein +FIG00676150 FIG00676152: hypothetical protein +FIG00676152 FIG00676153: hypothetical protein +FIG00676153 FIG00676154: hypothetical protein +FIG00676159 FIG00676160: hypothetical protein +FIG00676160 FIG00676161: hypothetical protein +FIG00676161 FIG00676165: hypothetical protein +FIG00676166 FIG00676167: hypothetical protein +FIG00676167 FIG00676170: hypothetical protein +FIG00676181 FIG00676182: hypothetical protein +FIG00676187 Fe(III) reductase, beta subunit +FIG00676191 FIG00676194: hypothetical protein +FIG00676194 FIG00676195: hypothetical protein +FIG00676207 protein of unknown function DUF156 +FIG00676209 FIG00676213: hypothetical protein +FIG00676214 FIG00676218: hypothetical protein +FIG00676220 FIG00676225: hypothetical protein +FIG00676233 FIG00676237: hypothetical protein +FIG00676237 FIG00676238: hypothetical protein +FIG00676238 FIG00676239: hypothetical protein +FIG00676239 FIG00676241: hypothetical protein +FIG00676241 FIG00676242: hypothetical protein +FIG00676254 FIG00676255: hypothetical protein +FIG00676259 FIG00676260: hypothetical protein +FIG00676261 FIG00676262: hypothetical protein +FIG00676263 FIG00676265: hypothetical protein +FIG00676265 FIG00676266: hypothetical protein +FIG00676266 FIG00676267: hypothetical protein +FIG00676275 FIG00676276: hypothetical protein +FIG00676277 FIG00676279: hypothetical protein +FIG00676279 protein of unknown function DUF1058 +FIG00676282 secreted Zn-dependent protease-like +FIG00676295 FIG00676296: hypothetical protein +FIG00676298 FIG00676303: hypothetical protein +FIG00676306 FIG00676307: hypothetical protein +FIG00676309 FIG00676310: hypothetical protein +FIG00676321 FIG00676323: hypothetical protein +FIG00676326 FIG00676327: hypothetical protein +FIG00676328 FIG00676332: hypothetical protein +FIG00676340 FIG00676343: hypothetical protein +FIG00676344 FIG00677367: hypothetical protein +FIG00676355 FIG00676357: hypothetical protein +FIG00676362 FIG00676365: hypothetical protein +FIG00676367 FIG00676368: hypothetical protein +FIG00676369 FIG00676374: hypothetical protein +FIG00676374 FIG00676375: hypothetical protein +FIG00676377 FIG00676378: hypothetical protein +FIG00676378 FIG00676382: hypothetical protein +FIG00676390 FIG00676393: hypothetical protein +FIG00676395 lipoprotein, NLP/P60 family, putative +FIG00676399 FIG00676402: hypothetical protein +FIG00676402 FIG00676403: hypothetical protein +FIG00676410 FIG00676413: hypothetical protein +FIG00676413 FIG00676417: hypothetical protein +FIG00676417 FIG00676418: hypothetical protein +FIG00676422 FIG00676427: hypothetical protein +FIG00676432 FIG00676434: hypothetical protein +FIG00676434 FIG00676435: hypothetical protein +FIG00676435 FIG00676438: hypothetical protein +FIG00676439 FIG00676440: hypothetical protein +FIG00676440 FIG00676442: hypothetical protein +FIG00676442 FIG00676446: hypothetical protein +FIG00676447 FIG00676448: hypothetical protein +FIG00676448 mce-related protein +FIG00676454 FIG00676455: hypothetical protein +FIG00676458 FIG00676459: hypothetical protein +FIG00676459 FIG00676462: hypothetical protein +FIG00676463 FIG00676465: hypothetical protein +FIG00676466 FIG00676472: hypothetical protein +FIG00676472 FIG00676474: hypothetical protein +FIG00676475 Uncharacterized secreted protein associated with spyDAC +FIG00676476 LamB porin family protein, putative +FIG00676478 FIG00676480: hypothetical protein +FIG00676481 FIG00676482: hypothetical protein +FIG00676482 FIG00676483: hypothetical protein +FIG00676490 FIG00676491: hypothetical protein +FIG00676491 FIG00676492: hypothetical protein +FIG00676496 FIG00676500: hypothetical protein +FIG00676502 cytochrome c family protein, putative +FIG00676509 FIG00676511: hypothetical protein +FIG00676512 FIG00676514: hypothetical protein +FIG00676517 FIG00676520: hypothetical protein +FIG00676524 FIG00676525: hypothetical protein +FIG00676530 chemotaxis protein CheY +FIG00676532 FIG00676533: hypothetical protein +FIG00676539 Class I peptide chain release factor +FIG00676541 FIG00676547: hypothetical protein +FIG00676547 decaheme cytochrome c +FIG00676552 FIG00676553: hypothetical protein +FIG00676554 FIG00676557: hypothetical protein +FIG00676557 response regulator receiver modulated PilZ sensor protein +FIG00676560 UDP-glucose/GDP-mannose dehydrogenase +FIG00676568 FIG00676570: hypothetical protein +FIG00676575 FIG00676576: hypothetical protein +FIG00676576 FIG00676577: hypothetical protein +FIG00676580 FIG00676584: hypothetical protein +FIG00676597 FIG00676598: hypothetical protein +FIG00676610 FIG00676611: hypothetical protein +FIG00676611 FIG00676612: hypothetical protein +FIG00676615 FIG00676617: hypothetical protein +FIG00676623 FIG00676624: hypothetical protein +FIG00676624 FIG00676627: hypothetical protein +FIG00676627 FIG00676630: hypothetical protein +FIG00676630 FIG00676638: hypothetical protein +FIG00676638 NrfJ +FIG00676639 FIG00676643: hypothetical protein +FIG00676643 FIG00676644: hypothetical protein +FIG00676650 FIG00676651: hypothetical protein +FIG00676655 FIG00676656: hypothetical protein +FIG00676659 FIG00676661: hypothetical protein +FIG00676661 protein of unknown function DUF819 +FIG00676662 FIG00676665: hypothetical protein +FIG00676665 Metal-dependent phosphohydrolase +FIG00676678 peptidase, U32 family +FIG00676682 FIG00676683: hypothetical protein +FIG00676683 FIG00676685: hypothetical protein +FIG00676685 FIG00676686: hypothetical protein +FIG00676689 FIG00676690: hypothetical protein +FIG00676691 FIG00676692: hypothetical protein +FIG00676692 FIG00676694: hypothetical protein +FIG00676694 Ni,Fe-hydrogenase III small subunit +FIG00676695 FIG00676696: hypothetical protein +FIG00676696 Adenosine deaminase (EC 3.5.4.4), alternative form +FIG00676702 FIG00676704: hypothetical protein +FIG00676706 FIG00676710: hypothetical protein +FIG00676710 FIG00676712: hypothetical protein +FIG00676712 FIG00676715: hypothetical protein +FIG00676718 FIG00676719: hypothetical protein +FIG00676719 FIG00676721: hypothetical protein +FIG00676722 FIG00676725: hypothetical protein +FIG00676728 LytB-related protein +FIG00676729 FIG00676733: hypothetical protein +FIG00676733 FIG00676734: hypothetical protein +FIG00676741 FIG00676742: hypothetical protein +FIG00676742 FIG00676745: hypothetical protein +FIG00676746 FIG00676747: hypothetical protein +FIG00676749 FIG00676750: hypothetical protein +FIG00676751 FIG00676752: hypothetical protein +FIG00676752 FIG00676755: hypothetical protein +FIG00676758 FIG00676759: hypothetical protein +FIG00676763 FIG00676769: hypothetical protein +FIG00676771 FIG00676773: hypothetical protein +FIG00676774 FIG00676776: hypothetical protein +FIG00676776 FIG00676780: hypothetical protein +FIG00676781 FIG00676782: hypothetical protein +FIG00676783 comEA protein-related protein +FIG00676785 FIG00676786: hypothetical protein +FIG00676788 FIG00676789: hypothetical protein +FIG00676792 PDZ/DHR/GLGF domain protein +FIG00676802 FIG00676804: hypothetical protein +FIG00676804 FIG00676805: hypothetical protein +FIG00676806 FIG00676807: hypothetical protein +FIG00676808 FIG00676811: hypothetical protein +FIG00676811 FIG00676813: hypothetical protein +FIG00676817 FIG00676821: hypothetical protein +FIG00676821 FIG00676822: hypothetical protein +FIG00676824 FIG00676826: hypothetical protein +FIG00676838 FIG00676839: hypothetical protein +FIG00676842 FIG00676847: hypothetical protein +FIG00676858 FIG00676860: hypothetical protein +FIG00676863 FIG00676866: hypothetical protein +FIG00676866 FIG00676867: hypothetical protein +FIG00676872 FIG00676875: hypothetical protein +FIG00676882 FIG00676883: hypothetical protein +FIG00676892 FIG00676893: hypothetical protein +FIG00676899 FIG00676900: hypothetical protein +FIG00676901 FIG00676907: hypothetical protein +FIG00676907 FIG00676908: hypothetical protein +FIG00676908 FIG00676910: hypothetical protein +FIG00676921 FIG00676931: hypothetical protein +FIG00676936 FIG00676938: hypothetical protein +FIG00676943 FIG00676944: hypothetical protein +FIG00676950 FIG00676951: hypothetical protein +FIG00676951 FIG00676956: hypothetical protein +FIG00676956 FIG00676957: hypothetical protein +FIG00676961 purine-binding chemotaxis protein CheW, putative +FIG00676962 FIG00676964: hypothetical protein +FIG00676964 FIG00676965: hypothetical protein +FIG00676965 FIG00676968: hypothetical protein +FIG00676970 methyl accepting chemotaxis protein, putative +FIG00676973 FIG00676974: hypothetical protein +FIG00676974 FIG00676977: hypothetical protein +FIG00676977 FIG00676978: hypothetical protein +FIG00676986 FIG00676989: hypothetical protein +FIG00676989 FIG00676990: hypothetical protein +FIG00676994 FIG00676997: hypothetical protein +FIG00677009 FIG00677012: hypothetical protein +FIG00677013 FIG00677015: hypothetical protein +FIG00677018 FIG00677019: hypothetical protein +FIG00677024 FIG00677025: hypothetical protein +FIG00677028 FIG00677030: hypothetical protein +FIG00677030 FIG00677035: hypothetical protein +FIG00677036 protein of unknown function UPF0153 +FIG00677037 FIG00677039: hypothetical protein +FIG00677039 FIG00677041: hypothetical protein +FIG00677041 FIG00677043: hypothetical protein +FIG00677045 FIG00677047: hypothetical protein +FIG00677047 FIG00677048: hypothetical protein +FIG00677048 capsule biosynthesis protein, putative +FIG00677049 protein of unknown function DUF147 +FIG00677050 FIG00677052: hypothetical protein +FIG00677052 FIG00677053: hypothetical protein +FIG00677059 FIG00677061: hypothetical protein +FIG00677061 FIG00677067: hypothetical protein +FIG00677069 FIG00677073: hypothetical protein +FIG00677075 Capsule assembly protein +FIG00677077 protein of unknown function DUF224, cysteine-rich region domain protein +FIG00677086 FIG00677092: hypothetical protein +FIG00677092 FIG00677093: hypothetical protein +FIG00677093 FIG00677094: hypothetical protein +FIG00677094 YaeQ family protein +FIG00677095 FIG00677096: hypothetical protein +FIG00677101 FIG00677103: hypothetical protein +FIG00677108 FIG00677109: hypothetical protein +FIG00677111 FIG00677112: hypothetical protein +FIG00677114 Outer membrane protein, RND efflux system precursor +FIG00677117 FIG00677121: hypothetical protein +FIG00677122 FIG00677126: hypothetical protein +FIG00677126 FIG00677129: hypothetical protein +FIG00677132 FIG00677133: hypothetical protein +FIG00677133 FIG00677138: hypothetical protein +FIG00677138 FIG00677139: hypothetical protein +FIG00677139 FIG00677140: hypothetical protein +FIG00677144 FIG00677145: hypothetical protein +FIG00677145 FIG00677146: hypothetical protein +FIG00677146 FIG00677147: hypothetical protein +FIG00677153 putative Zn-dependent protease containing TPR repeats +FIG00677156 FIG00677158: hypothetical protein +FIG00677160 FIG00677162: hypothetical protein +FIG00677164 FIG00677165: hypothetical protein +FIG00677167 FIG00677169: hypothetical protein +FIG00677169 FIG00677170: hypothetical protein +FIG00677185 FIG00677187: hypothetical protein +FIG00677187 FIG00677188: hypothetical protein +FIG00677190 FIG00677191: hypothetical protein +FIG00677194 GPW/gp25 family protein +FIG00677197 FIG00677198: hypothetical protein +FIG00677218 Sigma-54-dependent transcriptional regulator +FIG00677223 FIG00677224: hypothetical protein +FIG00677231 ADP-ribosyl-[dinitrogen reductase] glycohydrolase (EC 3.2.2.24) +FIG00677233 flagellar FlbT family protein +FIG00677234 FIG00677236: hypothetical protein +FIG00677236 putative signal transduction histidine kinase sensor +FIG00677239 FIG00677242: hypothetical protein +FIG00677251 FIG00677253: hypothetical protein +FIG00677253 rubredoxin-oxygen oxidoreductase, putative +FIG00677257 FIG00677259: hypothetical protein +FIG00677260 FIG00677262: hypothetical protein +FIG00677273 FIG00677274: hypothetical protein +FIG00677274 FIG00677275: hypothetical protein +FIG00677279 FIG00677281: hypothetical protein +FIG00677288 DNA polymerase beta family +FIG00677289 FIG00677290: hypothetical protein +FIG00677290 FIG00677295: hypothetical protein +FIG00677303 FIG00677304: hypothetical protein +FIG00677305 FIG00677306: hypothetical protein +FIG00677306 FIG00677307: hypothetical protein +FIG00677314 FIG00677315: hypothetical protein +FIG00677321 FIG00677322: hypothetical protein +FIG00677322 FIG00677323: hypothetical protein +FIG00677323 Similar to non-heme chloroperoxidase, sll5080 homolog +FIG00677346 FIG00677347: hypothetical protein +FIG00677347 FIG00677348: hypothetical protein +FIG00677352 FIG00677353: hypothetical protein +FIG00677356 FIG00677357: hypothetical protein +FIG00677360 Sporulation protein and related proteins +FIG00677374 FIG00677380: hypothetical protein +FIG00677381 FIG00677384: hypothetical protein +FIG00677388 FIG00677389: hypothetical protein +FIG00677392 FIG00677393: hypothetical protein +FIG00677397 FIG00677398: hypothetical protein +FIG00677398 FIG00677399: hypothetical protein +FIG00677401 FIG00677403: hypothetical protein +FIG00677403 FIG00677404: hypothetical protein +FIG00677405 FIG00677409: hypothetical protein +FIG00677415 FIG00677416: hypothetical protein +FIG00677416 FIG00677417: hypothetical protein +FIG00677417 FIG00677418: hypothetical protein +FIG00677418 FIG00677419: hypothetical protein +FIG00677424 FIG00677425: hypothetical protein +FIG00677425 FIG00677426: hypothetical protein +FIG00677426 FIG00677427: hypothetical protein +FIG00677427 FIG00677431: hypothetical protein +FIG00677431 FIG00677432: hypothetical protein +FIG00677433 FIG00677434: hypothetical protein +FIG00677434 FIG00677435: hypothetical protein +FIG00677435 FIG00677437: hypothetical protein +FIG00677438 FIG00677439: hypothetical protein +FIG00677439 FIG00677440: hypothetical protein +FIG00677440 FIG00677442: hypothetical protein +FIG00677443 FIG00677444: hypothetical protein +FIG00677448 FIG00677451: hypothetical protein +FIG00677451 FIG00677455: hypothetical protein +FIG00677455 FIG00677459: hypothetical protein +FIG00677466 FIG00677468: hypothetical protein +FIG00677470 FIG00677473: hypothetical protein +FIG00677491 FIG00677495: hypothetical protein +FIG00677495 FIG00677496: hypothetical protein +FIG00677496 FIG00677497: hypothetical protein +FIG00677497 FIG00677499: hypothetical protein +FIG00677503 FIG00677504: hypothetical protein +FIG00677506 FIG00677508: hypothetical protein +FIG00677521 FIG00677523: hypothetical protein +FIG00677523 FIG00677524: hypothetical protein +FIG00677527 FIG00677529: hypothetical protein +FIG00677530 FIG00677535: hypothetical protein +FIG00677537 FIG00677538: hypothetical protein +FIG00677538 Hypothetical reductase +FIG00677540 FIG00677541: hypothetical protein +FIG00677541 FIG00677543: hypothetical protein +FIG00677548 sensor histidine kinase/GGDEF domain protein +FIG00677555 FIG00677556: hypothetical protein +FIG00677556 FIG00677557: hypothetical protein +FIG00677573 FIG00677575: hypothetical protein +FIG00677575 FIG00677576: hypothetical protein +FIG00677576 FIG00677577: hypothetical protein +FIG00677581 FIG00677584: hypothetical protein +FIG00677584 FIG00677585: hypothetical protein +FIG00677591 FIG00677593: hypothetical protein +FIG00677593 FIG00677595: hypothetical protein +FIG00677595 FIG00677596: hypothetical protein +FIG00677596 FIG00677597: hypothetical protein +FIG00677597 FIG00677598: hypothetical protein +FIG00677598 FIG00677601: hypothetical protein +FIG00677613 FIG00677614: hypothetical protein +FIG00677614 FIG00677620: hypothetical protein +FIG00677620 FIG00677622: hypothetical protein +FIG00677622 FIG00677623: hypothetical protein +FIG00677629 protein of unknown function DUF354 +FIG00677630 Cytochrome c assembly protein +FIG00677638 FIG00677639: hypothetical protein +FIG00677639 FIG00677643: hypothetical protein +FIG00677643 FIG00677645: hypothetical protein +FIG00677645 FIG00677647: hypothetical protein +FIG00677653 FIG00677655: hypothetical protein +FIG00677657 FIG00677659: hypothetical protein +FIG00677660 FIG00677662: hypothetical protein +FIG00677662 FIG00677663: hypothetical protein +FIG00677663 FIG00677665: hypothetical protein +FIG00677665 FIG00678533: hypothetical protein +FIG00677673 FIG00677679: hypothetical protein +FIG00677679 FIG00677683: hypothetical protein +FIG00677689 FIG00677692: hypothetical protein +FIG00677692 FIG00677693: hypothetical protein +FIG00677694 Possible subunit of benzoyl-CoA reductase/2-hydroxyglutaryl-CoA dehydratase +FIG00677695 FIG00677701: hypothetical protein +FIG00677701 FIG00677702: hypothetical protein +FIG00677702 FIG00677705: hypothetical protein +FIG00677705 FIG00677706: hypothetical protein +FIG00677706 FIG00677710: hypothetical protein +FIG00677716 DNA uptake lipoprotein +FIG00677719 FIG00677720: hypothetical protein +FIG00677724 FIG00677729: hypothetical protein +FIG00677729 flagellar basal body protein FlhB +FIG00677732 FIG00677737: hypothetical protein +FIG00677737 FIG00677738: hypothetical protein +FIG00677739 FIG00677740: hypothetical protein +FIG00677740 CheR methyltransferase, SAM binding domain protein, putative +FIG00677747 FIG00677750: hypothetical protein +FIG00677756 FIG00677761: hypothetical protein +FIG00677762 FIG00677763: hypothetical protein +FIG00677773 FIG00677774: hypothetical protein +FIG00677780 FIG00677782: hypothetical protein +FIG00677783 FIG00677786: hypothetical protein +FIG00677789 FIG00677790: hypothetical protein +FIG00677790 FIG00677792: hypothetical protein +FIG00677792 FIG00677793: hypothetical protein +FIG00677793 FIG00677795: hypothetical protein +FIG00677795 FIG00677796: hypothetical protein +FIG00677800 FIG00677801: hypothetical protein +FIG00677801 FIG00677802: hypothetical protein +FIG00677802 FIG00677806: hypothetical protein +FIG00677808 FIG00677809: hypothetical protein +FIG00677809 FIG00677810: hypothetical protein +FIG00677810 FIG00677811: hypothetical protein +FIG00677813 FIG00677814: hypothetical protein +FIG00677815 phosphohistidine phosphatase, SixA +FIG00677824 FIG00677827: hypothetical protein +FIG00677827 FIG00677830: hypothetical protein +FIG00677833 FIG00677834: hypothetical protein +FIG00677834 FIG00677836: hypothetical protein +FIG00677836 FIG00677838: hypothetical protein +FIG00677839 FIG00677840: hypothetical protein +FIG00677840 FIG00677841: hypothetical protein +FIG00677841 FIG00677842: hypothetical protein +FIG00677844 COG1872 +FIG00677845 Water Stress and Hypersensitive response +FIG00677848 FIG00677849: hypothetical protein +FIG00677858 ATP:dephospho-CoA triphosphoribosyl transferase +FIG00677860 capK related-protein +FIG00677862 ferrous iron transport protein B +FIG00677869 FIG00677873: hypothetical protein +FIG00677875 Zn-ribbon-containing, possibly RNA-binding protein and truncated derivatives +FIG00677890 FIG00677893: hypothetical protein +FIG00677893 FIG00677896: hypothetical protein +FIG00677905 FIG00677906: hypothetical protein +FIG00677910 FIG00677911: hypothetical protein +FIG00677914 Two component transcriptional regulator, winged helix family +FIG00677915 FIG00677916: hypothetical protein +FIG00677924 Bifunctional acetyl transferase/isomerase +FIG00677926 FIG00677927: hypothetical protein +FIG00677927 FIG00677928: hypothetical protein +FIG00677928 FIG00677929: hypothetical protein +FIG00677929 FIG00677930: hypothetical protein +FIG00677931 membrane protein-like protein +FIG00677937 FIG00677938: hypothetical protein +FIG00677945 FIG00677951: hypothetical protein +FIG00677951 FIG00677952: hypothetical protein +FIG00677952 FIG00677953: hypothetical protein +FIG00677954 transcriptional regulator, Ros/MucR family +FIG00677957 FIG00677959: hypothetical protein +FIG00677959 FIG00677961: hypothetical protein +FIG00677961 FIG00677962: hypothetical protein +FIG00677966 FIG00677967: hypothetical protein +FIG00677969 FIG00677970: hypothetical protein +FIG00677970 FIG00677972: hypothetical protein +FIG00677973 FIG00677976: hypothetical protein +FIG00677984 response regulator receiver modulated metal dependent phosphohydrolase +FIG00677993 FIG00677994: hypothetical protein +FIG00677996 FIG00677997: hypothetical protein +FIG00677997 redox-active disulfide protein 2 +FIG00678004 FIG00678010: hypothetical protein +FIG00678013 FIG00678015: hypothetical protein +FIG00678016 FIG00678017: hypothetical protein +FIG00678017 FIG00678018: hypothetical protein +FIG00678021 FIG00678022: hypothetical protein +FIG00678025 FIG00678029: hypothetical protein +FIG00678043 FIG00678044: hypothetical protein +FIG00678047 FIG00678048: hypothetical protein +FIG00678049 FIG00678050: hypothetical protein +FIG00678053 FIG00678054: hypothetical protein +FIG00678056 FIG00678060: hypothetical protein +FIG00678061 FIG00678062: hypothetical protein +FIG00678081 FIG00678083: hypothetical protein +FIG00678084 FIG00678086: hypothetical protein +FIG00678086 FIG00678088: hypothetical protein +FIG00678097 FIG00678103: hypothetical protein +FIG00678106 FIG00678112: hypothetical protein +FIG00678112 Aldehyde:ferredoxin oxidoreductase +FIG00678118 FIG00678121: hypothetical protein +FIG00678121 CHASE domain/sensory box-containing nucleotide cyclase, putative +FIG00678122 PROBABLE TRANSCRIPTIONAL REGULATORY DNA-BINDING TRANSCRIPTION REGULATOR PROTEIN +FIG00678125 FIG00678126: hypothetical protein +FIG00678126 FIG00678127: hypothetical protein +FIG00678127 Predicted secretion system W ATPase PilM-like +FIG00678128 hypothetical protein +FIG00678131 FIG00678134: hypothetical protein +FIG00678134 FIG00678136: hypothetical protein +FIG00678142 FIG00678143: hypothetical protein +FIG00678144 FIG00678146: hypothetical protein +FIG00678148 FIG00678149: hypothetical protein +FIG00678149 FIG00680391: hypothetical protein +FIG00678160 FIG00678161: hypothetical protein +FIG00678164 FIG00678165: hypothetical protein +FIG00678179 FIG00678180: hypothetical protein +FIG00678181 regulator of chromosome condensation, RCC1 +FIG00678188 FIG00678189: hypothetical protein +FIG00678193 FIG00678195: hypothetical protein +FIG00678196 FIG00678197: hypothetical protein +FIG00678198 FIG00678201: hypothetical protein +FIG00678202 FIG00678203: hypothetical protein +FIG00678203 FIG00678207: hypothetical protein +FIG00678208 FIG00678209: hypothetical protein +FIG00678209 FIG00678211: hypothetical protein +FIG00678212 FIG00678213: hypothetical protein +FIG00678213 CheW protein +FIG00678218 Formylmethanofuran dehydrogenase subunit E-like protein +FIG00678222 FIG00678223: hypothetical protein +FIG00678223 FIG00678224: hypothetical protein +FIG00678225 FIG00678228: hypothetical protein +FIG00678233 FIG00678236: hypothetical protein +FIG00678236 FIG00678237: hypothetical protein +FIG00678237 FIG00678238: hypothetical protein +FIG00678249 FIG00678250: hypothetical protein +FIG00678251 FIG00678252: hypothetical protein +FIG00678252 FIG00678253: hypothetical protein +FIG00678255 FIG00678257: hypothetical protein +FIG00678257 FIG00678258: hypothetical protein +FIG00678258 response regulator/GGDEF domain protein +FIG00678259 FIG00678260: hypothetical protein +FIG00678260 FIG00678261: hypothetical protein +FIG00678261 FIG00678265: hypothetical protein +FIG00678265 FIG00678266: hypothetical protein +FIG00678268 FIG00678269: hypothetical protein +FIG00678269 FIG00678272: hypothetical protein +FIG00678272 FIG00678273: hypothetical protein +FIG00678289 FIG00678292: hypothetical protein +FIG00678293 FIG00678296: hypothetical protein +FIG00678296 FIG00678297: hypothetical protein +FIG00678297 related to glutamate dehydrogenase +FIG00678309 FIG00678310: hypothetical protein +FIG00678323 FIG00678326: hypothetical protein +FIG00678333 FIG00678336: hypothetical protein +FIG00678341 thioredoxin family protein, selenocysteine-containing +FIG00678365 putative outer membrane lipoprotein-sorting protein +FIG00678367 CheD +FIG00678370 FIG00678371: hypothetical protein +FIG00678375 FIG00678378: hypothetical protein +FIG00678382 FIG00678384: hypothetical protein +FIG00678389 FIG00678390: hypothetical protein +FIG00678390 protein of unknown function DUF77 +FIG00678393 FIG00678396: hypothetical protein +FIG00678398 FIG00678401: hypothetical protein +FIG00678401 FIG00678403: hypothetical protein +FIG00678403 FIG00678405: hypothetical protein +FIG00678407 FIG00678410: hypothetical protein +FIG00678410 CRISPR-associated protein Cas2 +FIG00678416 FIG00678419: hypothetical protein +FIG00678419 FIG00678422: hypothetical protein +FIG00678424 FIG00678425: hypothetical protein +FIG00678425 FIG00678426: hypothetical protein +FIG00678426 FIG00678429: hypothetical protein +FIG00678431 FIG00678433: hypothetical protein +FIG00678435 UbiA prenyltransferase +FIG00678437 FIG00678439: hypothetical protein +FIG00678439 FIG00678441: hypothetical protein +FIG00678442 FIG00678444: hypothetical protein +FIG00678456 FIG00678459: hypothetical protein +FIG00678467 FIG00678468: hypothetical protein +FIG00678469 FIG00678471: hypothetical protein +FIG00678475 FIG00678476: hypothetical protein +FIG00678476 FIG00678477: hypothetical protein +FIG00678477 FIG00678482: hypothetical protein +FIG00678484 FIG00678485: hypothetical protein +FIG00678485 FIG00678487: hypothetical protein +FIG00678489 FIG00678492: hypothetical protein +FIG00678515 FIG00678524: hypothetical protein +FIG00678524 FIG00678525: hypothetical protein +FIG00678536 FIG00678538: hypothetical protein +FIG00678538 ResB protein required for cytochrome c biosynthesis-like +FIG00678543 FIG00678549: hypothetical protein +FIG00678560 FIG00678563: hypothetical protein +FIG00678563 FIG00678570: hypothetical protein +FIG00678570 FIG00678573: hypothetical protein +FIG00678573 Predicted secretion system W protein GspG-like +FIG00678582 FIG00678583: hypothetical protein +FIG00678583 FIG00678586: hypothetical protein +FIG00678597 FIG00678600: hypothetical protein +FIG00678600 FIG00678601: hypothetical protein +FIG00678603 FIG00678604: hypothetical protein +FIG00678604 FIG00678610: hypothetical protein +FIG00678610 FIG00678614: hypothetical protein +FIG00678617 FIG00678619: hypothetical protein +FIG00678623 Glycosyltransferase +FIG00678624 FIG00678625: hypothetical protein +FIG00678625 FIG00678628: hypothetical protein +FIG00678628 FIG00678630: hypothetical protein +FIG00678632 FIG00678635: hypothetical protein +FIG00678635 FIG00678636: hypothetical protein +FIG00678643 FIG00678644: hypothetical protein +FIG00678652 FIG00678653: hypothetical protein +FIG00678654 FIG00678659: hypothetical protein +FIG00678663 FIG00678665: hypothetical protein +FIG00678665 FIG00678667: hypothetical protein +FIG00678677 FIG00678678: hypothetical protein +FIG00678681 FIG00678684: hypothetical protein +FIG00678685 FIG00678688: hypothetical protein +FIG00678688 FIG00678689: hypothetical protein +FIG00678689 FIG00678690: hypothetical protein +FIG00678693 peptidylprolyl isomerase, FKBP-type +FIG00678702 FIG00678706: hypothetical protein +FIG00678706 FIG00678707: hypothetical protein +FIG00678715 FIG00678716: hypothetical protein +FIG00678716 FIG00678719: hypothetical protein +FIG00678731 FIG00678733: hypothetical protein +FIG00678733 protein of unknown function DUF329 +FIG00678736 FIG00678737: hypothetical protein +FIG00678741 FIG00678742: hypothetical protein +FIG00678745 Zinc finger, CDGSH-type +FIG00678764 FIG00678765: hypothetical protein +FIG00678765 FIG00678766: hypothetical protein +FIG00678767 FIG00678768: hypothetical protein +FIG00678768 NDP-hexose 2,3-dehydratase +FIG00678771 FIG00678772: hypothetical protein +FIG00678776 FIG00678783: hypothetical protein +FIG00678786 FIG00678787: hypothetical protein +FIG00678787 FIG00678789: hypothetical protein +FIG00678789 FIG00678790: hypothetical protein +FIG00678791 FIG00678792: hypothetical protein +FIG00678793 FIG00678795: hypothetical protein +FIG00678797 FIG00678801: hypothetical protein +FIG00678801 FIG00678804: hypothetical protein +FIG00678811 FIG00678812: hypothetical protein +FIG00678817 FIG00678822: hypothetical protein +FIG00678822 cation-transport ATPase, E1-E2 family +FIG00678849 FIG00678851: hypothetical protein +FIG00678856 FIG00678857: hypothetical protein +FIG00678857 FIG00678860: hypothetical protein +FIG00678867 Nitroalkane oxidizing family protein +FIG00678868 FIG00678870: hypothetical protein +FIG00678870 FIG00678877: hypothetical protein +FIG00678884 FIG00678886: hypothetical protein +FIG00678889 FIG00678890: hypothetical protein +FIG00678891 FIG00678893: hypothetical protein +FIG00678894 FIG00678898: hypothetical protein +FIG00678901 transcriptional modulator of MazE/toxin, MazF +FIG00678903 FIG00678904: hypothetical protein +FIG00678904 FIG00678910: hypothetical protein +FIG00678910 FIG00678914: hypothetical protein +FIG00678920 FIG00678921: hypothetical protein +FIG00678931 hydrogenase (NiFe) small subunit HydA( EC:1.12.99.6 ) +FIG00678935 FIG00678936: hypothetical protein +FIG00678941 FIG00678943: hypothetical protein +FIG00678951 FIG00678953: hypothetical protein +FIG00678954 FIG00678956: hypothetical protein +FIG00678956 FIG00678957: hypothetical protein +FIG00678959 FIG00678961: hypothetical protein +FIG00678961 Hemerythrin-like, metal-binding +FIG00678963 FIG00678969: hypothetical protein +FIG00678970 FIG00678972: hypothetical protein +FIG00678972 FIG00678977: hypothetical protein +FIG00678980 FIG00678982: hypothetical protein +FIG00678984 FIG00678987: hypothetical protein +FIG00678987 transcriptional regulator containing an HTH domain fused to a Zn-ribbon-like protein +FIG00679003 FIG00679007: hypothetical protein +FIG00679009 protein of unknown function DUF1316 +FIG00679014 FIG00679017: hypothetical protein +FIG00679017 FIG00679020: hypothetical protein +FIG00679020 FIG00910374: hypothetical protein +FIG00679030 FIG00679034: hypothetical protein +FIG00679039 FIG00679040: hypothetical protein +FIG00679043 FIG00679044: hypothetical protein +FIG00679045 FIG00679047: hypothetical protein +FIG00679047 FIG00679048: hypothetical protein +FIG00679059 FIG00679061: hypothetical protein +FIG00679061 Hsp33 protein +FIG00679066 FIG00679067: hypothetical protein +FIG00679073 FIG00679074: hypothetical protein +FIG00679083 superfamily I DNA and RNA helicases-like protein +FIG00679086 FIG00679088: hypothetical protein +FIG00679089 FIG00679090: hypothetical protein +FIG00679095 Chalcone and stilbene synthases domain protein +FIG00679098 FIG00679099: hypothetical protein +FIG00679099 FIG00679100: hypothetical protein +FIG00679100 FIG00679102: hypothetical protein +FIG00679105 FIG00679106: hypothetical protein +FIG00679106 FIG00679108: hypothetical protein +FIG00679108 GAF domain/His Kinase A domain/HD domain protein +FIG00679111 FIG00679112: hypothetical protein +FIG00679113 FIG00679114: hypothetical protein +FIG00679115 FIG00679116: hypothetical protein +FIG00679116 FIG00679119: hypothetical protein +FIG00679119 FIG00679121: hypothetical protein +FIG00679125 anti-sigma-28 factor, FlgM +FIG00679131 FIG00679132: hypothetical protein +FIG00679133 FIG00679137: hypothetical protein +FIG00679139 rubrerythrin +FIG00679144 FIG00679149: hypothetical protein +FIG00679151 Glutamate synthase +FIG00679165 Ribulose-5-phosphate 4-epimerase and related epimerases and aldolases +FIG00679168 FIG00679170: hypothetical protein +FIG00679179 FIG00679182: hypothetical protein +FIG00679182 FIG00679184: hypothetical protein +FIG00679191 FIG00679192: hypothetical protein +FIG00679192 FIG00679193: hypothetical protein +FIG00679194 FIG00679196: hypothetical protein +FIG00679202 FIG00679205: hypothetical protein +FIG00679205 FIG00679206: hypothetical protein +FIG00679210 FIG00679212: hypothetical protein +FIG00679213 FIG00679214: hypothetical protein +FIG00679217 FIG00679218: hypothetical protein +FIG00679223 FIG00679225: hypothetical protein +FIG00679225 FIG00679227: hypothetical protein +FIG00679227 FIG00679232: hypothetical protein +FIG00679233 FIG00679235: hypothetical protein +FIG00679238 FIG00679247: hypothetical protein +FIG00679249 FIG00679255: hypothetical protein +FIG00679265 FIG00679267: hypothetical protein +FIG00679267 FIG00679269: hypothetical protein +FIG00679269 FIG00679273: hypothetical protein +FIG00679283 FIG00679287: hypothetical protein +FIG00679287 FIG00679288: hypothetical protein +FIG00679291 FIG00679292: hypothetical protein +FIG00679295 FIG00679296: hypothetical protein +FIG00679297 FIG00679298: hypothetical protein +FIG00679298 FIG00679299: hypothetical protein +FIG00679299 FIG00679300: hypothetical protein +FIG00679304 FIG00679308: hypothetical protein +FIG00679308 sensory box protein/sigma-54 dependent transcriptional regulator +FIG00679321 FIG00679325: hypothetical protein +FIG00679342 PBS lyase HEAT-like repeat protein +FIG00679356 FIG00679358: hypothetical protein +FIG00679358 branched-chain amino acid permease (azaleucine resistance)-like +FIG00679360 FIG00679362: hypothetical protein +FIG00679364 FIG00679367: hypothetical protein +FIG00679367 FIG00679368: hypothetical protein +FIG00679373 Predicted metal-binding protein +FIG00679376 FIG00679378: hypothetical protein +FIG00679378 FIG00679380: hypothetical protein +FIG00679384 FIG00679385: hypothetical protein +FIG00679387 FIG00679390: hypothetical protein +FIG00679391 FIG00679392: hypothetical protein +FIG00679394 protein of unknown function DUF500 +FIG00679399 FIG00679401: hypothetical protein +FIG00679408 FIG00679409: hypothetical protein +FIG00679412 FIG00679421: hypothetical protein +FIG00679421 FIG00679426: hypothetical protein +FIG00679430 FIG00679431: hypothetical protein +FIG00679436 moaA/nifB/pqqE family protein +FIG00679439 FIG00679440: hypothetical protein +FIG00679440 FIG00679443: hypothetical protein +FIG00679449 FIG00679450: hypothetical protein +FIG00679465 FIG00679466: hypothetical protein +FIG00679467 FIG00679470: hypothetical protein +FIG00679475 FIG00679478: hypothetical protein +FIG00679478 FIG00679482: hypothetical protein +FIG00679482 acyl-CoA thioester hydrolase, putative +FIG00679487 FIG00679488: hypothetical protein +FIG00679492 ATP-binding region, ATPase-like:Histidine kinase, HAMP region:Histidine kinase A-like +FIG00679497 FIG00679499: hypothetical protein +FIG00679502 FIG00679510: hypothetical protein +FIG00679510 FIG00679511: hypothetical protein +FIG00679518 Fusaric acid resistance protein conserved region +FIG00679527 FIG00679528: hypothetical protein +FIG00679528 FIG00679530: hypothetical protein +FIG00679532 FIG00679543: hypothetical protein +FIG00679543 FIG00679548: hypothetical protein +FIG00679551 FIG00679554: hypothetical protein +FIG00679554 FIG00679559: hypothetical protein +FIG00679562 FIG00679566: hypothetical protein +FIG00679566 FIG00679568: hypothetical protein +FIG00679568 FIG00679569: hypothetical protein +FIG00679569 FIG00679570: hypothetical protein +FIG00679570 FIG00679576: hypothetical protein +FIG00679584 FIG00679585: hypothetical protein +FIG00679585 FIG00679586: hypothetical protein +FIG00679586 FIG00679589: hypothetical protein +FIG00679599 FIG00679608: hypothetical protein +FIG00679610 FIG00679612: hypothetical protein +FIG00679613 FIG00679617: hypothetical protein +FIG00679617 apo-citrate lyase phosphoribosyl-dephospho-CoA transferase, putative +FIG00679622 FIG00679625: hypothetical protein +FIG00679644 FIG00679646: hypothetical protein +FIG00679665 FIG00679666: hypothetical protein +FIG00679685 FIG00679687: hypothetical protein +FIG00679691 FIG00679694: hypothetical protein +FIG00679694 FIG00679697: hypothetical protein +FIG00679699 FIG00679703: hypothetical protein +FIG00679705 FIG00679708: hypothetical protein +FIG00679708 FIG00679710: hypothetical protein +FIG00679710 Two-component response regulator W +FIG00679722 FIG00679724: hypothetical protein +FIG00679724 FIG00679727: hypothetical protein +FIG00679732 FIG00679736: hypothetical protein +FIG00679738 FIG00679739: hypothetical protein +FIG00679743 FIG00679746: hypothetical protein +FIG00679746 FIG00679749: hypothetical protein +FIG00679756 FIG00679758: hypothetical protein +FIG00679760 sterol desaturase +FIG00679762 FIG00679763: hypothetical protein +FIG00679767 FIG00679768: hypothetical protein +FIG00679769 Predicted protease of the collagenase family +FIG00679775 FIG00679777: hypothetical protein +FIG00679783 FIG00679784: hypothetical protein +FIG00679798 Similar to carbon monoxide dehydrogenase corrinoid/iron-sulfur protein +FIG00679802 FIG00679806: hypothetical protein +FIG00679814 FIG00679816: hypothetical protein +FIG00679816 FIG00679825: hypothetical protein +FIG00679825 FIG00679827: hypothetical protein +FIG00679827 FIG00679831: hypothetical protein +FIG00679837 FIG00679853: hypothetical protein +FIG00679854 FIG00679855: hypothetical protein +FIG00679855 FIG00679858: hypothetical protein +FIG00679872 FIG00679879: hypothetical protein +FIG00679880 FIG00679881: hypothetical protein +FIG00679890 FIG00679891: hypothetical protein +FIG00679891 FIG00679896: hypothetical protein +FIG00679896 FIG00679904: hypothetical protein +FIG00679921 cytoplasmic membrane protein FsxA +FIG00679923 FIG00679924: hypothetical protein +FIG00679926 FIG00679929: hypothetical protein +FIG00679929 FIG00679930: hypothetical protein +FIG00679930 FIG00679931: hypothetical protein +FIG00679931 FIG00679932: hypothetical protein +FIG00679940 AhpC/Tsa family protein @ selenocysteine-containing +FIG00679960 FIG00679965: hypothetical protein +FIG00679968 AhpC/Tsa family protein, selenocysteine-containing +FIG00679972 FIG00679974: hypothetical protein +FIG00680001 FIG00680003: hypothetical protein +FIG00680018 FIG00680020: hypothetical protein +FIG00680020 FIG00680022: hypothetical protein +FIG00680022 FIG00680024: hypothetical protein +FIG00680037 FIG00680042: hypothetical protein +FIG00680048 FIG00680049: hypothetical protein +FIG00680063 FIG00680065: hypothetical protein +FIG00680065 FIG00680068: hypothetical protein +FIG00680073 FIG00680074: hypothetical protein +FIG00680074 FIG00680076: hypothetical protein +FIG00680079 FIG00680083: hypothetical protein +FIG00680083 C4-dicarboxylate transporter, anaerobic +FIG00680089 FIG00680092: hypothetical protein +FIG00680092 FIG00680093: hypothetical protein +FIG00680093 FIG00680096: hypothetical protein +FIG00680096 FIG00680098: hypothetical protein +FIG00680101 FIG00680104: hypothetical protein +FIG00680120 FIG00680121: hypothetical protein +FIG00680135 FIG00680136: hypothetical protein +FIG00680139 FIG00680140: hypothetical protein +FIG00680156 FIG00680161: hypothetical protein +FIG00680163 FIG00680164: hypothetical protein +FIG00680164 putative DNA repair exonuclease +FIG00680169 FIG00680171: hypothetical protein +FIG00680171 FIG00680176: hypothetical protein +FIG00680176 FIG00680178: hypothetical protein +FIG00680191 FIG00680192: hypothetical protein +FIG00680192 FIG00680198: hypothetical protein +FIG00680198 FIG00680200: hypothetical protein +FIG00680200 FIG00680201: hypothetical protein +FIG00680201 thymocyte protein Thy28 +FIG00680202 putative thiol:disulfide interchange protein YneN +FIG00680222 FIG00680223: hypothetical protein +FIG00680226 FIG00680227: hypothetical protein +FIG00680228 FIG00680233: hypothetical protein +FIG00680234 FIG00680235: hypothetical protein +FIG00680235 FIG00680239: hypothetical protein +FIG00680257 FIG00680258: hypothetical protein +FIG00680258 FIG00680260: hypothetical protein +FIG00680268 FIG00680273: hypothetical protein +FIG00680275 FIG00680277: hypothetical protein +FIG00680277 FIG00680280: hypothetical protein +FIG00680280 FIG00680281: hypothetical protein +FIG00680281 FIG00680287: hypothetical protein +FIG00680287 FIG00680288: hypothetical protein +FIG00680301 FIG00680302: hypothetical protein +FIG00680302 FIG00680307: hypothetical protein +FIG00680311 FIG00680316: hypothetical protein +FIG00680318 FIG00680321: hypothetical protein +FIG00680325 FIG00680329: hypothetical protein +FIG00680341 regulatory protein, IclR +FIG00680343 FIG00680344: hypothetical protein +FIG00680344 FIG00680345: hypothetical protein +FIG00680355 FIG00680360: hypothetical protein +FIG00680371 FIG00680374: hypothetical protein +FIG00680374 FIG00680380: hypothetical protein +FIG00680391 FIG00680394: hypothetical protein +FIG00680399 FIG00680400: hypothetical protein +FIG00680400 FIG00680402: hypothetical protein +FIG00680402 FIG00680409: hypothetical protein +FIG00680423 FIG00680428: hypothetical protein +FIG00680442 FIG00680443: hypothetical protein +FIG00680452 putative HD superfamily hydrolase +FIG00680484 FIG00680489: hypothetical protein +FIG00680489 FIG00679680: hypothetical protein +FIG00680492 FIG00680494: hypothetical protein +FIG00680503 FIG00680506: hypothetical protein +FIG00680506 FIG00680511: hypothetical protein +FIG00680516 FIG00680518: hypothetical protein +FIG00680518 FIG00680520: hypothetical protein +FIG00680520 cyclase/dehydrase +FIG00680521 ALDEHYDE FERREDOXIN OXIDOREDUCTASE (EC 1.2.7.-) +FIG00680528 FIG00680529: hypothetical protein +FIG00680531 FIG00680533: hypothetical protein +FIG00680547 FIG00680551: hypothetical protein +FIG00680556 Plasmid associated gene product APECO1_O1R37 +FIG00680557 FIG00680560: hypothetical protein +FIG00680561 acyl-CoA hydrolase-like protein +FIG00680574 FIG00680575: hypothetical protein +FIG00680575 FIG00680578: hypothetical protein +FIG00680578 FIG00680581: hypothetical protein +FIG00680581 Extracellular solute-binding protein, family 1 precursor +FIG00680584 FIG00680589: hypothetical protein +FIG00680589 N-terminal acetyltransferase +FIG00680591 FIG00680594: hypothetical protein +FIG00680615 FIG00680617: hypothetical protein +FIG00680620 FIG00680621: hypothetical protein +FIG00680623 FIG00680625: hypothetical protein +FIG00680625 FIG00680631: hypothetical protein +FIG00680631 FIG00680633: hypothetical protein +FIG00680645 FIG00680647: hypothetical protein +FIG00680660 FIG00680663: hypothetical protein +FIG00680663 FIG00680667: hypothetical protein +FIG00680667 FIG00680669: hypothetical protein +FIG00680669 FIG00680671: hypothetical protein +FIG00680671 FIG00680672: hypothetical protein +FIG00680680 FIG00680682: hypothetical protein +FIG00680682 FIG00680683: hypothetical protein +FIG00680713 FIG00680718: hypothetical protein +FIG00680729 FIG00680731: hypothetical protein +FIG00680743 FIG00680744: hypothetical protein +FIG00680744 Response regulatory protein +FIG00680747 FIG00680749: hypothetical protein +FIG00680750 FIG00680753: hypothetical protein +FIG00680753 FIG00680754: hypothetical protein +FIG00680754 FIG00680756: hypothetical protein +FIG00680760 FIG00680771: hypothetical protein +FIG00680771 FIG00680781: hypothetical protein +FIG00680781 FIG00680783: hypothetical protein +FIG00680796 FIG00680798: hypothetical protein +FIG00680805 FIG00680807: hypothetical protein +FIG00680810 FIG00680811: hypothetical protein +FIG00680825 FIG00680828: hypothetical protein +FIG00680843 FIG00680844: hypothetical protein +FIG00680849 FIG00680850: hypothetical protein +FIG00680864 FIG00680866: hypothetical protein +FIG00680866 FIG00680872: hypothetical protein +FIG00680883 FIG00680887: hypothetical protein +FIG00680900 FIG00680908: hypothetical protein +FIG00680927 FIG00680931: hypothetical protein +FIG00680941 FIG00680942: hypothetical protein +FIG00680947 FIG00680948: hypothetical protein +FIG00680948 FIG00680950: hypothetical protein +FIG00680971 FIG00680972: hypothetical protein +FIG00680972 pyridoxamine 5'-phosphate oxidase-related, FMN-binding +FIG00680994 FIG00680996: hypothetical protein +FIG00681002 FIG00681003: hypothetical protein +FIG00681003 FIG00681008: hypothetical protein +FIG00681008 FIG00681010: hypothetical protein +FIG00681029 FIG00681032: hypothetical protein +FIG00681032 FIG00681033: hypothetical protein +FIG00681036 FIG00681041: hypothetical protein +FIG00681041 FIG00681043: hypothetical protein +FIG00681047 FIG00681054: hypothetical protein +FIG00681054 FIG00681056: hypothetical protein +FIG00681059 FIG00681070: hypothetical protein +FIG00681089 FIG00681090: hypothetical protein +FIG00681097 purine-binding chemotaxis protein CheW +FIG00681124 FIG00681125: hypothetical protein +FIG00681129 FIG00681130: hypothetical protein +FIG00681130 FIG00681132: hypothetical protein +FIG00681132 FIG00681139: hypothetical protein +FIG00681159 FIG00681161: hypothetical protein +FIG00681167 cytochrome oxidase maturation protein, cbb3-type +FIG00681187 FIG00681188: hypothetical protein +FIG00681201 heavy metal sensor signal transduction histidine kinase +FIG00681205 FIG00681206: hypothetical protein +FIG00681214 FIG00681215: hypothetical protein +FIG00681224 FIG00681232: hypothetical protein +FIG00681248 FIG00681251: hypothetical protein +FIG00681251 FIG00681253: hypothetical protein +FIG00681256 FIG00681257: hypothetical protein +FIG00681257 CopG domain protein DNA-binding domain protein +FIG00681262 LOC124976 protein +FIG00681285 lipoprotein, putative +FIG00681291 FIG00681295: hypothetical protein +FIG00681301 protein of unknown function DUF1255 +FIG00681320 FIG00681323: hypothetical protein +FIG00681324 FIG00681328: hypothetical protein +FIG00681328 FIG00681333: hypothetical protein +FIG00681369 phosphate ABC transporter phosphate-binding protein +FIG00681406 FIG00681409: hypothetical protein +FIG00681410 FIG00681412: hypothetical protein +FIG00681413 FIG00681415: hypothetical protein +FIG00681439 FIG00681444: hypothetical protein +FIG00681447 FIG00681464: hypothetical protein +FIG00681879 UDP-sugar hydrolase (EC 3.6.1.45) / 5'-nucleotidase (EC 3.1.3.5) +FIG00682112 FIG00682122: hypothetical protein +FIG00682552 FIG004853: possible toxin to DivIC +FIG00682802 FIG00682826: hypothetical protein +FIG00682872 protein of unknown function DUF1326 +FIG00682996 FIG00682997: hypothetical protein +FIG00683186 FIG00683188: hypothetical protein +FIG00683299 similar to Dehydrogenases (flavoproteins) +FIG00683302 Alcohol dehydrogenase GroES-like protein +FIG00683654 Acyltransferase mdmB (EC 2.3.1.-) +FIG00683667 FIG00683678: hypothetical protein +FIG00683793 FIG00821400: hypothetical protein +FIG00683917 possible alkanal monooxygenase +FIG00684045 FIG00684046: hypothetical protein +FIG00684151 FIG00684152: hypothetical protein +FIG00684312 possible WhiE protein +FIG00684317 FIG00684334: hypothetical protein +FIG00684432 siderophore binding protein +FIG00684713 cation-transporting ATPase PacL homolog +FIG00684883 FIG00684884: hypothetical protein +FIG00685140 FIG00685143: hypothetical protein +FIG00685562 FIG00685563: hypothetical protein +FIG00685647 Type IV pilus biogenesis protein PilN +FIG00685688 FIG00685691: hypothetical protein +FIG00685693 similarity to galactose oxidase +FIG00685747 probable thioesterase +FIG00685786 pore-forming membrane protein SmpX homolog +FIG00685924 FIG00685926: hypothetical protein +FIG00686416 metalloprotease MEP1 homolog +FIG00686536 FIG00686539: hypothetical protein +FIG00686615 probable phytase +FIG00686631 FIG137771: hypothetical protein +FIG00686818 probable proteinase +FIG00686870 VapC toxin protein +FIG00686952 FIG00686957: hypothetical protein +FIG00687075 probable glucosyltransferase EpsF homolog +FIG00687216 FIG00687231: hypothetical protein +FIG00687285 Outer membrane protein/protective antigen OMA87 +FIG00687286 FIG00687288: hypothetical protein +FIG00687292 FIG00687295: hypothetical protein +FIG00687297 FIG00687298: hypothetical protein +FIG00687304 FIG00687305: hypothetical protein +FIG00687305 FIG00687307: hypothetical protein +FIG00687309 Probable DNA-methyltransferase (DNA-modification methylase) protein +FIG00687316 FIG00687318: hypothetical protein +FIG00687318 FIG00687319: hypothetical protein +FIG00687323 FIG00687324: hypothetical protein +FIG00687328 Large protein containing transglutaminase-like domain +FIG00687338 FIG00687339: hypothetical protein +FIG00687355 FIG00687356: hypothetical protein +FIG00687356 FIG00687360: hypothetical protein +FIG00687364 FIG00687365: hypothetical protein +FIG00687365 FIG00687366: hypothetical protein +FIG00687366 Acetyltransferase including N-acetylase of ribosomal protein-like protein +FIG00687367 FIG00687372: hypothetical protein +FIG00687372 FIG00687374: hypothetical protein +FIG00687378 FIG00687380: hypothetical protein +FIG00687387 FIG00687388: hypothetical protein +FIG00687395 FIG00687396: hypothetical protein +FIG00687396 FIG00687397: hypothetical protein +FIG00687398 FIG00687399: hypothetical protein +FIG00687399 FIG00687400: hypothetical protein +FIG00687404 Hypothetical membrane-spanning protein +FIG00687412 FIG00687421: hypothetical protein +FIG00687421 FIG00687422: hypothetical protein +FIG00687451 FIG00687453: hypothetical protein +FIG00687453 FIG00687457: hypothetical protein +FIG00687457 FIG00687460: hypothetical protein +FIG00687461 FIG00687462: hypothetical protein +FIG00687473 formate hydrogenlyase subunit 5 +FIG00687474 FIG00687475: hypothetical protein +FIG00687477 FIG00687480: hypothetical protein +FIG00687482 FIG00687483: hypothetical protein +FIG00687497 FIG00687504: hypothetical protein +FIG00687504 FIG00687505: hypothetical protein +FIG00687507 HPR(SER) kinase( EC:2.7.1.-,EC:3.1.3.- ) +FIG00687513 FIG00687514: hypothetical protein +FIG00687514 FIG00687516: hypothetical protein +FIG00687521 FIG00687522: hypothetical protein +FIG00687522 FIG00687528: hypothetical protein +FIG00687528 putative SPFH domain protein +FIG00687539 FIG00687540: hypothetical protein +FIG00687572 FIG00687573: hypothetical protein +FIG00687588 FIG00687590: hypothetical protein +FIG00687593 conserved hypothetical protein, UPF0033 family +FIG00687600 FIG00687604: hypothetical protein +FIG00687619 Fatty acid hydroxylase-like protein +FIG00687639 FIG00687643: hypothetical protein +FIG00687652 FIG00687654: hypothetical protein +FIG00687661 FIG00687662: hypothetical protein +FIG00687663 FIG00687665: hypothetical protein +FIG00687666 FIG01010325: hypothetical protein +FIG00687669 FIG00687673: hypothetical protein +FIG00687683 FIG00687684: hypothetical protein +FIG00687685 Probable glycosyltransferase +FIG00687687 FIG00687688: hypothetical protein +FIG00687689 FIG00687691: hypothetical protein +FIG00687691 FIG00687694: hypothetical protein +FIG00687699 FIG00687700: hypothetical protein +FIG00687700 Small heat shock protein +FIG00687708 FIG00687709: hypothetical protein +FIG00687709 FIG00687710: hypothetical protein +FIG00687717 Dipeptide transport system permease protein dppC +FIG00687725 FIG00687727: hypothetical protein +FIG00687743 FIG00687745: hypothetical protein +FIG00687751 FIG00687754: hypothetical protein +FIG00687756 FIG00687759: hypothetical protein +FIG00687764 FIG00687765: hypothetical protein +FIG00687778 sensory transduction protein kinase( EC:2.7.3.- ) +FIG00687780 Capsule polysaccharide export protein +FIG00687781 FIG00687785: hypothetical protein +FIG00687793 FIG00687794: hypothetical protein +FIG00687797 FIG00687798: hypothetical protein +FIG00687798 FIG00687800: hypothetical protein +FIG00687800 FIG00687805: hypothetical protein +FIG00687813 two component system histidine kinase( EC:2.7.3.- ) +FIG00687814 FIG00687815: hypothetical protein +FIG00687820 FIG00687822: hypothetical protein +FIG00687831 FIG00687834: hypothetical protein +FIG00687850 FIG00687851: hypothetical protein +FIG00687855 FIG00687856: hypothetical protein +FIG00687858 FIG00687859: hypothetical protein +FIG00687859 FIG00687860: hypothetical protein +FIG00687860 FIG00687862: hypothetical protein +FIG00687875 FIG00687882: hypothetical protein +FIG00687882 FIG00687883: hypothetical protein +FIG00687899 FIG00687900: hypothetical protein +FIG00687909 polysaccharide biosynthesis protein CapD +FIG00687938 FIG00687939: hypothetical protein +FIG00687949 FIG00687951: hypothetical protein +FIG00687951 FIG00687952: hypothetical protein +FIG00687959 FIG00687962: hypothetical protein +FIG00687970 FIG00687971: hypothetical protein +FIG00687974 FIG00687977: hypothetical protein +FIG00687977 FIG00687978: hypothetical protein +FIG00687982 Fe-S oxidoreductase +FIG00687983 FIG00687985: hypothetical protein +FIG00687992 FIG00687994: hypothetical protein +FIG00687997 Aromatic-L-amino-acid decarboxylase +FIG00688000 FIG00688001: hypothetical protein +FIG00688001 FIG00688004: hypothetical protein +FIG00688008 FIG00688012: hypothetical protein +FIG00688021 Mg ion P-type ATPase +FIG00688027 FIG00688028: hypothetical protein +FIG00688028 FIG00688031: hypothetical protein +FIG00688040 FIG00688041: hypothetical protein +FIG00688042 FIG00688043: hypothetical protein +FIG00688043 FIG00688044: hypothetical protein +FIG00688044 FIG00688046: hypothetical protein +FIG00688051 FIG00688053: hypothetical protein +FIG00688065 Peptidyl-prolyl cis-trans isomerase precursor( EC:5.2.1.8 ) +FIG00688071 FIG00688074: hypothetical protein +FIG00688078 Putative HlyD-family protein +FIG00688081 FIG00688082: hypothetical protein +FIG00688083 FIG00688084: hypothetical protein +FIG00688090 FIG00688091: hypothetical protein +FIG00688091 FIG00688094: hypothetical protein +FIG00688114 FIG00688116: hypothetical protein +FIG00688118 FIG00688120: hypothetical protein +FIG00688130 Mll4235 protein +FIG00688132 FIG00688134: hypothetical protein +FIG00688138 FIG00688144: hypothetical protein +FIG00688148 FIG00688149: hypothetical protein +FIG00688165 FIG00688167: hypothetical protein +FIG00688168 FIG00688170: hypothetical protein +FIG00688172 FIG00688175: hypothetical protein +FIG00688175 FIG00688177: hypothetical protein +FIG00688178 FIG00688179: hypothetical protein +FIG00688192 FIG00688194: hypothetical protein +FIG00688194 FIG00688197: hypothetical protein +FIG00688203 FIG00688205: hypothetical protein +FIG00688205 FIG00688206: hypothetical protein +FIG00688209 FIG00688210: hypothetical protein +FIG00688213 FIG00688215: hypothetical protein +FIG00688227 FIG00688228: hypothetical protein +FIG00688264 FIG00688268: hypothetical protein +FIG00688273 FIG00688277: hypothetical protein +FIG00688293 FIG00688300: hypothetical protein +FIG00688300 FIG00688301: hypothetical protein +FIG00688325 FIG00688326: hypothetical protein +FIG00688327 FIG00688330: hypothetical protein +FIG00688330 FIG00688331: hypothetical protein +FIG00688331 FIG00688332: hypothetical protein +FIG00688332 FIG00688333: hypothetical protein +FIG00688335 FIG00688337: hypothetical protein +FIG00688342 FIG00688344: hypothetical protein +FIG00688360 FIG00688361: hypothetical protein +FIG00688366 FIG00688367: hypothetical protein +FIG00688383 FIG00564975: hypothetical protein +FIG00688386 Outer-membrane lipoprotein carrier protein +FIG00688387 FIG00688388: hypothetical protein +FIG00688392 FIG00688393: hypothetical protein +FIG00688420 FIG00688424: hypothetical protein +FIG00688425 FIG00688430: hypothetical protein +FIG00688435 FIG00688441: hypothetical protein +FIG00688445 FIG00688446: hypothetical protein +FIG00688449 FIG00688452: hypothetical protein +FIG00688459 FIG00688460: hypothetical protein +FIG00688484 FIG00688486: hypothetical protein +FIG00688494 FIG00688495: hypothetical protein +FIG00688506 FIG00688509: hypothetical protein +FIG00688514 FIG00688519: hypothetical protein +FIG00688522 FIG00688523: hypothetical protein +FIG00688525 cytidine/deoxycytidylate deaminase family protein +FIG00688535 FIG00688539: hypothetical protein +FIG00688560 Ribonuclease D related protein +FIG00688564 FIG00688567: hypothetical protein +FIG00688567 Bll4106 protein +FIG00688590 Putative toluene tolerance protein +FIG00688596 FIG00688598: hypothetical protein +FIG00688614 FIG00688616: hypothetical protein +FIG00688616 FIG00688617: hypothetical protein +FIG00688617 FIG00688619: hypothetical protein +FIG00688636 FIG00688639: hypothetical protein +FIG00688642 FIG00688643: hypothetical protein +FIG00688643 terminase +FIG00688686 FIG00688687: hypothetical protein +FIG00688697 FIG00688700: hypothetical protein +FIG00688710 FIG00688714: hypothetical protein +FIG00688714 FIG00688716: hypothetical protein +FIG00688723 FIG00688726: hypothetical protein +FIG00688742 FIG00688753: hypothetical protein +FIG00688756 FIG00688757: hypothetical protein +FIG00688779 electron transport protein SCO1/SenC +FIG00688781 FIG00688782: hypothetical protein +FIG00688812 FIG00688818: hypothetical protein +FIG00688823 FIG00688825: hypothetical protein +FIG00688825 FIG00688827: hypothetical protein +FIG00688850 FIG00688851: hypothetical protein +FIG00688851 FIG00688852: hypothetical protein +FIG00688860 FIG00688862: hypothetical protein +FIG00688869 ribose ABC transporter ATP-binding +FIG00688894 DNA double-strand break repair Rad50 ATPase +FIG00688895 FIG00688896: hypothetical protein +FIG00688907 FIG00688908: hypothetical protein +FIG00688950 TonB dependent receptor +FIG00688955 FIG00688965: hypothetical protein +FIG00688989 FIG00688991: hypothetical protein +FIG00689008 FIG00689009: hypothetical protein +FIG00689072 2-oxo-4-hydroxy-4-carboxy--5-ureidoimidazoline (OHCU) decarboxylase +FIG00689274 FIG00689276: hypothetical protein +FIG00689327 probable myosin-crossreactive antigen +FIG00689357 FIG00689363: hypothetical protein +FIG00689402 FIG00689406: hypothetical protein +FIG00689409 Putative glucarate/galactarate transporter +FIG00689445 BfpH protein (involved in biogenesis of type IV pili) +FIG00689488 FIG00689489: hypothetical protein +FIG00689493 FIG00689500: hypothetical protein +FIG00689551 Smr protein/MutS2 +FIG00689673 FIG00689674: hypothetical protein +FIG00689712 FIG00689714: hypothetical protein +FIG00689747 FIG00689748: hypothetical protein +FIG00689819 Glycosyltransferase related protein +FIG00689850 Membrane-bound transport protein +FIG00689898 putative sulfate-binding protein +FIG00689963 Chemotactic signal-response protein CheL +FIG00690025 BRO domain protein domain protein +FIG00690049 Putative peroxidase +FIG00690209 FIG00690219: hypothetical protein +FIG00690268 export ABC transporter ATP-binding protein / export ABC transporter permease protein +FIG00690307 FIG00994657: hypothetical protein +FIG00690316 FIG00690329: hypothetical protein +FIG00690580 nitrilotriacetate monooxygenase component A( EC:1.14.13.- ) +FIG00690583 Conserved hypothetical integral membrane protein YrbE A Subgroup +FIG00690597 POSSIBLE ACYL-COA DEHYDROGENASE FADE36 +FIG00690730 Haemin-degrading family protein precursor +FIG00690763 possible nodulation protein +FIG00690836 Plasmid encoded restriction endonuclease Per +FIG00691085 Siderophore biosynthesis non-ribosomal peptide synthetase modules +FIG00691191 carboxylesterase +FIG00691226 FIG00691228: hypothetical protein +FIG00691472 Serine/threonine protein kinase PknL (EC 2.7.11.1) +FIG00691587 possible phosphotransferase +FIG00691618 Type IV secretory pathway VirD4 components-like protein +FIG00691621 Conserved hypothetical integral membrane protein YrbE1B +FIG00692008 N-acyl-L-amino acid amidohydrolase AmiA1 (EC 3.5.1.-) +FIG00692037 Mitomycin radical oxidase (EC 1.5.3.-) +FIG00692249 possible subtilisin +FIG00692326 DNA cytosine methyltransferase M.NgoMIII +FIG00692617 FIG00692620: hypothetical protein +FIG00692652 possible lysyl tRNA synthetase-like protein +FIG00692697 FIG00692701: hypothetical protein +FIG00692701 probable sufite oxidase( EC:1.8.3.1 ) +FIG00692835 POSSIBLE MEMBRANE PROTEIN +FIG00692981 conserved hypothetical protein; putative Antibiotic biosynthesis monooxygenase domain +FIG00693142 FIG00693147: hypothetical protein +FIG00693174 FIG00997776: hypothetical protein +FIG00693252 Surface antigen gene +FIG00693308 FIG00693309: hypothetical protein +FIG00693338 FIG00693340: hypothetical protein +FIG00693340 FIG00693341: hypothetical protein +FIG00693349 FIG00693350: hypothetical protein +FIG00693415 FIG00693418: hypothetical protein +FIG00693422 FIG00693424: hypothetical protein +FIG00693424 FIG00693426: hypothetical protein +FIG00693440 FIG00693446: hypothetical protein +FIG00693450 FIG00693453: hypothetical protein +FIG00693525 FIG00693527: hypothetical protein +FIG00693572 FIG00693574: hypothetical protein +FIG00693583 FIG00693586: hypothetical protein +FIG00693654 FIG00693656: hypothetical protein +FIG00693656 FIG00693657: hypothetical protein +FIG00693706 Sll0445 protein +FIG00693740 FIG00693742: hypothetical protein +FIG00693747 Sperm nuclear basic protein PL-I isoform PLIb +FIG00693837 FIG00693845: hypothetical protein +FIG00693847 FIG00693848: hypothetical protein +FIG00693857 Mll0579 protein +FIG00693947 FIG00693950: hypothetical protein +FIG00693967 FIG01019581: hypothetical protein +FIG00693971 Two-component sensor histidine kinase involved in degradative enzyme +FIG00694039 FIG00694040: hypothetical protein +FIG00694056 FIG00694062: hypothetical protein +FIG00694108 FIG00694109: hypothetical protein +FIG00694114 FIG00694116: hypothetical protein +FIG00694160 Protein containing response regulator receiver domain +FIG00694177 FIG00694178: hypothetical protein +FIG00694190 S23 ribosomal protein +FIG00694202 CDF family cation efflux protein +FIG00694244 FIG00694245: hypothetical protein +FIG00694284 FIG00694287: hypothetical protein +FIG00694325 sensory box sensor histidine kinase +FIG00694337 FIG00694346: hypothetical protein +FIG00694355 FIG00694364: hypothetical protein +FIG00694395 FIG00694399: hypothetical protein +FIG00694407 UPF0102 protein BT_2236 +FIG00694471 FIG00694474: hypothetical protein +FIG00694528 FIG00694529: hypothetical protein +FIG00694536 FIG00694541: hypothetical protein +FIG00694554 phosphotyrosine protein phosphatase +FIG00694580 FIG00694581: hypothetical protein +FIG00694584 COG2335: Secreted and surface protein containing fasciclin-like repeats +FIG00694591 FIG01019121: hypothetical protein +FIG00694594 FIG00694599: hypothetical protein +FIG00694599 FIG00694601: hypothetical protein +FIG00694618 FIG00694621: hypothetical protein +FIG00694666 FIG00694667: hypothetical protein +FIG00694687 FIG00694694: hypothetical protein +FIG00694743 FIG00694750: hypothetical protein +FIG00694764 FIG00694768: hypothetical protein +FIG00694786 MdsD protein precursor +FIG00694806 FIG00694807: hypothetical protein +FIG00694812 Sensory box sensor histidine kinase +FIG00694817 FIG00694818: hypothetical protein +FIG00694852 FIG00694858: hypothetical protein +FIG00694875 FIG00694876: hypothetical protein +FIG00694893 FIG00694894: hypothetical protein +FIG00694968 serotype-specific glucosyl transferase +FIG00694995 fructose-2,6-bisphosphatase( EC:5.4.2.1,EC:3.1.3.46 ) +FIG00695108 FIG00695110: hypothetical protein +FIG00695189 Bll0688 protein +FIG00695326 permease YjgP/YjgQ +FIG00695393 FIG00695394: hypothetical protein +FIG00695513 Mll1661 protein +FIG00695626 Soluble lytic murein transglycosylase and related regulatory proteins (some contain LysM/invasin domains) +FIG00695718 FIG00695719: hypothetical protein +FIG00695810 Hypothetical protein, homolog of fig|393130.3.peg.2627 +FIG00695944 Glutamyl aminopeptidase (EC 3.4.11.7); Deblocking aminopeptidase +FIG00696023 MgtC/SapB family protein +FIG00696037 FIG00696038: hypothetical protein +FIG00696046 FIG00696050: hypothetical protein +FIG00696052 FIG00696053: hypothetical protein +FIG00696053 FIG00696054: hypothetical protein +FIG00696054 FIG002657: hypothetical protein +FIG00696056 FIG00696057: hypothetical protein +FIG00696057 FIG00696059: hypothetical protein +FIG00696059 FIG00696060: hypothetical protein +FIG00696061 FIG00696063: hypothetical protein +FIG00696063 predicted transcriptional regulator +FIG00696064 FIG00696065: hypothetical protein +FIG00696065 FIG00696066: hypothetical protein +FIG00696066 ImpA +FIG00696073 Fe(3+) ions import ATP-binding protein fbpC (EC 3.6.3.30) +FIG00696076 FIG00696078: hypothetical protein +FIG00696078 FIG00696080: hypothetical protein +FIG00696082 FIG00696085: hypothetical protein +FIG00696085 FIG00696090: hypothetical protein +FIG00696090 FIG00696091: hypothetical protein +FIG00696099 FIG00696100: hypothetical protein +FIG00696101 FIG00696102: hypothetical protein +FIG00696105 FIG00696107: hypothetical protein +FIG00696107 FIG00696108: hypothetical protein +FIG00696108 FIG00696109: hypothetical protein +FIG00696109 FIG00696110: hypothetical protein +FIG00696110 Outer membrane protein P2 precursor +FIG00696111 FIG00696112: hypothetical protein +FIG00696112 FIG00696114: hypothetical protein +FIG00696114 FIG00696122: hypothetical protein +FIG00696122 FIG00696123: hypothetical protein +FIG00696126 FIG00696127: hypothetical protein +FIG00696127 NinG recombination protein +FIG00696128 TraX family protein +FIG00696129 FIG00696135: hypothetical protein +FIG00696135 FIG00696138: hypothetical protein +FIG00696142 FIG00696143: hypothetical protein +FIG00696143 FIG00696147: hypothetical protein +FIG00696148 FIG00696150: hypothetical protein +FIG00696150 FIG00698115: hypothetical protein +FIG00696152 FIG00696159: hypothetical protein +FIG00696159 FIG00696160: hypothetical protein +FIG00696161 FIG00696162: hypothetical protein +FIG00696162 FIG00696164: hypothetical protein +FIG00696164 Orf33 +FIG00696167 FIG00696170: hypothetical protein +FIG00696170 FIG00696171: hypothetical protein +FIG00696171 CrcB +FIG00696180 FIG00696183: hypothetical protein +FIG00696185 FIG00696187: hypothetical protein +FIG00696187 FIG00696188: hypothetical protein +FIG00696198 FIG00696199: hypothetical protein +FIG00696199 FIG00696200: hypothetical protein +FIG00696200 FIG00696203: hypothetical protein +FIG00696203 FIG00696205: hypothetical protein +FIG00696205 FIG00696207: hypothetical protein +FIG00696207 possible N-acylneuraminate cytidylyltransferase( EC:2.7.7.43 ) +FIG00696208 Baseplate +FIG00696210 aspartate-semialdehyde dehydrogenase +FIG00696212 FIG00696214: hypothetical protein +FIG00696214 Protein HI0205 precursor +FIG00696220 FIG00696222: hypothetical protein +FIG00696222 FIG00696225: hypothetical protein +FIG00696225 Acetolactate synthase large subunit, truncated? +FIG00696227 FIG00696230: hypothetical protein +FIG00696230 FIG00696234: hypothetical protein +FIG00696243 FIG00696244: hypothetical protein +FIG00696244 FIG00696245: hypothetical protein +FIG00696246 FIG00696247: hypothetical protein +FIG00696250 ISSo9, nucleotidyltransferase domain protein +FIG00696251 FIG00696253: hypothetical protein +FIG00696253 FIG00696255: hypothetical protein +FIG00696255 FIG00696256: hypothetical protein +FIG00696256 FIG00696257: hypothetical protein +FIG00696257 FIG00696258: hypothetical protein +FIG00696262 FIG00696263: hypothetical protein +FIG00696264 FIG00696265: hypothetical protein +FIG00696268 FIG00696269: hypothetical protein +FIG00696269 virulence-associated protein B +FIG00696270 FIG00696272: hypothetical protein +FIG00696272 HTH-type transcriptional regulator hmrR +FIG00696281 FIG00696282: hypothetical protein +FIG00696284 FIG00696286: hypothetical protein +FIG00696289 FIG00696293: hypothetical protein +FIG00696293 FIG00696294: hypothetical protein +FIG00696298 FIG00696299: hypothetical protein +FIG00696300 FIG00696301: hypothetical protein +FIG00696305 COG2161: Antitoxin of toxin-antitoxin stability system +FIG00696309 FIG00696313: hypothetical protein +FIG00696313 FIG00696314: hypothetical protein +FIG00696314 FIG00696315: hypothetical protein +FIG00696316 FIG00696317: hypothetical protein +FIG00696317 FIG00696319: hypothetical protein +FIG00696319 FIG00696321: hypothetical protein +FIG00696321 Modification methylase HindIII (EC 2.1.1.72) (Adenine-specific methyltransferase HindIII) (M.HindIII) +FIG00696331 protein transport protein +FIG00696332 FIG00696335: hypothetical protein +FIG00696336 FIG00696337: hypothetical protein +FIG00696337 possible PurR family transcriptional regulator +FIG00696338 FIG00696339: hypothetical protein +FIG00696339 Opacity protein opA66 precursor +FIG00696341 FIG00696342: hypothetical protein +FIG00696343 Predicted permeases +FIG00696344 FIG00696345: hypothetical protein +FIG00696345 FIG00696346: hypothetical protein +FIG00696348 Permeases of the major facilitator superfamily +FIG00696352 FIG00696353: hypothetical protein +FIG00696353 Ni,Fe-hydrogenase III component G +FIG00696359 FIG00696361: hypothetical protein +FIG00696361 FIG00696362: hypothetical protein +FIG00696365 Amino acid permeases +FIG00696367 FIG00696369: hypothetical protein +FIG00696369 Lipooligosaccharide biosynthesis protein lex-1 (EC 2.-.-.-) +FIG00696370 lipooligosaccharide galactosyltransferase II +FIG00696372 FIG00696376: hypothetical protein +FIG00696376 AAA ATPase, central region +FIG00696382 putative accessory processing protein +FIG00696383 Citrate carrier/transporter +FIG00696384 SseA protein +FIG00696388 FIG00696389: hypothetical protein +FIG00696391 FIG00696393: hypothetical protein +FIG00696393 FIG00696394: hypothetical protein +FIG00696394 putative F17-like fimbrial chaperone +FIG00696403 Possible phage-related protein +FIG00696404 FIG00696405: hypothetical protein +FIG00696406 FIG00696408: hypothetical protein +FIG00696408 FIG00696412: hypothetical protein +FIG00696417 FIG00696418: hypothetical protein +FIG00696418 FiwA protein +FIG00696419 FIG00696420: hypothetical protein +FIG00696420 FIG00696423: hypothetical protein +FIG00696423 FIG00696425: hypothetical protein +FIG00696425 FIG00696429: hypothetical protein +FIG00696435 FIG00696436: hypothetical protein +FIG00696436 FIG00696438: hypothetical protein +FIG00696442 FIG00696443: hypothetical protein +FIG00696454 FIG00696456: hypothetical protein +FIG00696461 FIG00696462: hypothetical protein +FIG00696462 FIG00696463: hypothetical protein +FIG00696465 FIG00696466: hypothetical protein +FIG00696466 FIG00696467: hypothetical protein +FIG00696467 FIG00696468: hypothetical protein +FIG00696473 FIG00696476: hypothetical protein +FIG00696476 adhesion and penetration protein Hap +FIG00696482 FIG00696486: hypothetical protein +FIG00696486 FIG00696487: hypothetical protein +FIG00696489 FIG00696492: hypothetical protein +FIG00696499 FIG00696504: hypothetical protein +FIG00696504 Probable ribonuclease HI0526 precursor +FIG00696515 FIG00696516: hypothetical protein +FIG00696517 FIG00696520: hypothetical protein +FIG00696522 FIG00696530: hypothetical protein +FIG00696531 FIG00696533: hypothetical protein +FIG00696533 FIG00696537: hypothetical protein +FIG00696537 FIG00696538: hypothetical protein +FIG00696543 mercuric ion transport protein +FIG00696546 FIG00696547: hypothetical protein +FIG00696548 FIG00696550: hypothetical protein +FIG00696550 FIG00696551: hypothetical protein +FIG00696553 FIG00696554: hypothetical protein +FIG00696556 FIG00696557: hypothetical protein +FIG00696561 Citrate lyase, gamma subunit +FIG00696563 FIG00696564: hypothetical protein +FIG00696564 FIG00696565: hypothetical protein +FIG00696565 FIG00696566: hypothetical protein +FIG00696570 FIG00696571: hypothetical protein +FIG00696571 FIG00696574: hypothetical protein +FIG00696574 FIG00696575: hypothetical protein +FIG00696575 FIG00696576: hypothetical protein +FIG00696576 FIG00696580: hypothetical protein +FIG00696580 dimethyladenosine transferase +FIG00696582 FIG00696583: hypothetical protein +FIG00696587 FIG00696589: hypothetical protein +FIG00696596 Transcriptional factor MdcH +FIG00696600 FIG00696602: hypothetical protein +FIG00696604 Mlr8006 protein +FIG00696607 COG0859: ADP-heptose:LPS heptosyltransferase +FIG00696610 hypothetical protein +FIG00696613 periplasmic serine protease do +FIG00696616 putative major capsid protein +FIG00696619 FIG00696620: hypothetical protein +FIG00696620 FIG00696624: hypothetical protein +FIG00696624 FIG00696625: hypothetical protein +FIG00696625 FIG00782386: hypothetical protein +FIG00696629 Leader peptidase (Prepilin peptidase) (EC 3.4.23.43) / N-methyltransferase (EC 2.1.1.-) +FIG00696644 FIG00696648: hypothetical protein +FIG00696648 FIG00782409: hypothetical protein +FIG00696651 FIG00696652: hypothetical protein +FIG00696652 FIG00696653: hypothetical protein +FIG00696653 FIG00696654: hypothetical protein +FIG00696655 FIG00696657: hypothetical protein +FIG00696658 FIG00696665: hypothetical protein +FIG00696667 FIG00696669: hypothetical protein +FIG00696669 Predicted periplasmic lipoprotein +FIG00696673 FIG00696674: hypothetical protein +FIG00696674 FIG00696675: hypothetical protein +FIG00696679 Ribosomal large subunit pseudouridine synthase C (EC 4.2.1.70) +FIG00696683 FIG00696687: hypothetical protein +FIG00696687 ABC transporter ATP-binding protein uup-1 +FIG00696692 FIG00696694: hypothetical protein +FIG00696694 Lytic enzyme +FIG00696703 prophage integrase +FIG00696713 FIG00696714: hypothetical protein +FIG00696714 Mu phage DNA transposition protein B +FIG00696716 FIG00696717: hypothetical protein +FIG00696717 ABC-type Fe3+-siderophore transport system, permease component +FIG00696720 FIG00696722: hypothetical protein +FIG00696723 FIG00696724: hypothetical protein +FIG00696724 FIG00696726: hypothetical protein +FIG00696733 FIG00696734: hypothetical protein +FIG00696745 predicted membrane-bound metallopeptidase +FIG00696746 FIG00696747: hypothetical protein +FIG00696748 FIG00696749: hypothetical protein +FIG00696749 FIG00696750: hypothetical protein +FIG00696750 FIG00696751: hypothetical protein +FIG00696751 FIG00696753: hypothetical protein +FIG00696753 FIG00696754: hypothetical protein +FIG00696756 probable phage integrase +FIG00696761 FIG00696763: hypothetical protein +FIG00696765 COG0762 +FIG00696766 Pyrimidine operon attenuation protein/uracil phosphoribosyltransferase +FIG00696767 FIG00696771: hypothetical protein +FIG00696780 Oxidoreductase, zinc-binding dehydrogenase family (EC 1.1.1.-) +FIG00696789 Chain A, Hia 992-1098 +FIG00696805 FIG00696806: hypothetical protein +FIG00696806 FIG00696808: hypothetical protein +FIG00696822 putative fimbrial biogenesis and twitching motility protein PilF-like protein +FIG00696824 FIG00696825: hypothetical protein +FIG00696834 FIG00696836: hypothetical protein +FIG00696846 FIG00696850: hypothetical protein +FIG00696850 FIG00696851: hypothetical protein +FIG00696851 FIG00696852: hypothetical protein +FIG00696852 FIG00696856: hypothetical protein +FIG00696861 FIG00696862: hypothetical protein +FIG00696863 FIG00696867: hypothetical protein +FIG00696867 probable thiosulfate sulfur transferase +FIG00696876 FIG00696879: hypothetical protein +FIG00696880 FIG00696884: hypothetical protein +FIG00696890 FIG00696891: hypothetical protein +FIG00696891 FIG00698364: hypothetical protein +FIG00696893 FIG00696895: hypothetical protein +FIG00696897 FIG00696901: hypothetical protein +FIG00696901 FIG00696902: hypothetical protein +FIG00696907 FIG00696908: hypothetical protein +FIG00696912 FIG00696914: hypothetical protein +FIG00696914 FIG00696916: hypothetical protein +FIG00696916 FIG00696918: hypothetical protein +FIG00696918 FIG00696922: hypothetical protein +FIG00696923 FIG00696925: hypothetical protein +FIG00696930 hypothetical protein +FIG00696935 FIG00696938: hypothetical protein +FIG00696940 prevent-host-death protein +FIG00696948 FIG00696949: hypothetical protein +FIG00696950 FIG00696951: hypothetical protein +FIG00696952 putative ferrichrome iron receptor precursor +FIG00696957 DNA repair protein radC homolog +FIG00696960 FIG00696961: hypothetical protein +FIG00696961 FIG00696967: hypothetical protein +FIG00696967 FIG00919961: hypothetical protein +FIG00696968 FIG00696969: hypothetical protein +FIG00696969 FIG00696970: hypothetical protein +FIG00696970 FIG00696972: hypothetical protein +FIG00696975 FIG00696982: hypothetical protein +FIG00696982 FIG00696983: hypothetical protein +FIG00696983 FIG00696985: hypothetical protein +FIG00696985 FIG00696986: hypothetical protein +FIG00696991 FIG00696993: hypothetical protein +FIG00696993 FIG00696997: hypothetical protein +FIG00696997 Arylsulfatase regulator (Fe-S oxidoreductase) +FIG00697008 FIG00697009: hypothetical protein +FIG00697009 Mu-like phage C protein, possible positive regulator of late transcription +FIG00697010 FIG00697012: hypothetical protein +FIG00697014 FIG00697018: hypothetical protein +FIG00697021 FIG00697022: hypothetical protein +FIG00697022 FIG00697023: hypothetical protein +FIG00697023 FIG00697026: hypothetical protein +FIG00697026 FIG00697027: hypothetical protein +FIG00697027 FIG00697029: hypothetical protein +FIG00697030 truncated suppressor of ftsI protein +FIG00697035 Modification methylase HphIA (EC 2.1.1.37) (Cytosine-specific methyltransferase HphIA) (M.HphIA) (M.Hphi(C)) +FIG00697036 Transcriptional regulator, MerR family +FIG00697040 FIG00697043: hypothetical protein +FIG00697043 FIG00697044: hypothetical protein +FIG00697054 B2295 +FIG00697055 FIG00697056: hypothetical protein +FIG00697056 nucleotidyltransferase +FIG00697069 FIG00697070: hypothetical protein +FIG00697073 Mu-like prophage FluMu G protein 2 +FIG00697085 FIG00354716: hypothetical protein +FIG00697090 FIG00697091: hypothetical protein +FIG00697097 FIG00697098: hypothetical protein +FIG00697098 hypothetical protein +FIG00697099 FIG00697107: hypothetical protein +FIG00697135 FIG00697141: hypothetical protein +FIG00697141 FIG00697143: hypothetical protein +FIG00697153 probable bacteriophage transcriptional regulator +FIG00697156 FIG00697159: hypothetical protein +FIG00697165 FIG00697166: hypothetical protein +FIG00697167 FIG00697169: hypothetical protein +FIG00697169 Trk system potassium uptake protein TrkH +FIG00697175 FIG00697178: hypothetical protein +FIG00697178 FIG00697182: hypothetical protein +FIG00697182 FIG00697183: hypothetical protein +FIG00697183 FIG00697187: hypothetical protein +FIG00697195 HypE protein +FIG00697201 FIG00697202: hypothetical protein +FIG00697202 FIG00697204: hypothetical protein +FIG00697210 FIG00697214: hypothetical protein +FIG00697214 conserved hypothetical protein HI0074 +FIG00697216 ABC-type Fe3+-hydroxamate transport system, periplasmic component; FhuD +FIG00697217 FIG00697218: hypothetical protein +FIG00697223 Zinc-binding UPF0243 protein yacG +FIG00697240 FIG00697241: hypothetical protein +FIG00697241 FIG00697242: hypothetical protein +FIG00697242 FIG00697246: hypothetical protein +FIG00697257 FIG00697258: hypothetical protein +FIG00697258 putative ABC-type chelated iron transport system, permease component +FIG00697265 FIG00697267: hypothetical protein +FIG00697270 FIG00697271: hypothetical protein +FIG00697274 transcriptional activator-regulatory protein +FIG00697304 FIG00697309: hypothetical protein +FIG00697309 FIG00697310: hypothetical protein +FIG00697311 FIG00697312: hypothetical protein +FIG00697312 FIG00697315: hypothetical protein +FIG00697320 FIG00697322: hypothetical protein +FIG00697328 FIG00697329: hypothetical protein +FIG00697329 FIG00697330: hypothetical protein +FIG00697339 FIG00697347: hypothetical protein +FIG00697350 FIG00697354: hypothetical protein +FIG00697356 FIG00697357: hypothetical protein +FIG00697357 HicA +FIG00697363 Probable type II restriction enzyme HindVP (EC 3.1.21.4) (Endonuclease HindVP) (R.HindVP) +FIG00697368 FIG00697375: hypothetical protein +FIG00697382 FIG00697384: hypothetical protein +FIG00697384 Parvulin-like peptidyl-prolyl isomerase +FIG00697389 hypothetical protein +FIG00697403 FIG00697407: hypothetical protein +FIG00697407 Restriction enzyme BgcI subunit beta (EC 3.1.21.-) (S.BcgI) +FIG00697410 FIG00697412: hypothetical protein +FIG00697414 FIG00697418: hypothetical protein +FIG00697418 FIG00697419: hypothetical protein +FIG00697421 FIG00697424: hypothetical protein +FIG00697436 FIG00697438: hypothetical protein +FIG00697438 Acyl-[acyl-carrier-protein]--UDP-N-acetylglucosamine O-acyltransferase (EC 2.3.1.129) +FIG00697441 probable phage-related protein +FIG00697442 FIG00697443: hypothetical protein +FIG00697449 FIG00697453: hypothetical protein +FIG00697453 FIG00697454: hypothetical protein +FIG00697454 FIG00697455: hypothetical protein +FIG00697466 FIG00697467: hypothetical protein +FIG00697467 FIG00697468: hypothetical protein +FIG00697472 FIG00697477: hypothetical protein +FIG00697478 FIG00697479: hypothetical protein +FIG00697485 FIG00697486: hypothetical protein +FIG00697486 AfuC( EC:3.6.3.30 ) +FIG00697487 FIG00697489: hypothetical protein +FIG00697489 FIG00697490: hypothetical protein +FIG00697491 FIG00697492: hypothetical protein +FIG00697492 FIG00697494: hypothetical protein +FIG00697506 FIG00697507: hypothetical protein +FIG00697508 FIG00697509: hypothetical protein +FIG00697514 putative prophage repressor CI +FIG00697519 FIG00697527: hypothetical protein +FIG00697527 FIG00697529: hypothetical protein +FIG00697529 FIG00697530: hypothetical protein +FIG00697530 lipopolysaccharide biosynthesis protein +FIG00697552 hypothetical protein +FIG00697554 Permeases of the major facilitator superfamily +FIG00697560 FIG00697565: hypothetical protein +FIG00697569 Haemophilus-specific protein, uncharacterized +FIG00697570 FIG00697573: hypothetical protein +FIG00697577 FIG00697578: hypothetical protein +FIG00697578 Hsf-like protein +FIG00697580 two component signal transduction system protein +FIG00697596 FIG00697600: hypothetical protein +FIG00697601 FIG00697602: hypothetical protein +FIG00697604 FIG00697612: hypothetical protein +FIG00697612 FIG00697614: hypothetical protein +FIG00697616 iron chelatin ABC transporter periplasmic-binding protein +FIG00697618 FIG00697621: hypothetical protein +FIG00697621 FIG00697622: hypothetical protein +FIG00697627 FIG00697629: hypothetical protein +FIG00697636 FIG00697638: hypothetical protein +FIG00697641 FIG00697642: hypothetical protein +FIG00697642 Mu-like phage gp25 +FIG00697643 FIG00697647: hypothetical protein +FIG00697656 lipoprotein HlpB +FIG00697660 FIG00697661: hypothetical protein +FIG00697661 FIG00697662: hypothetical protein +FIG00697664 FIG00697665: hypothetical protein +FIG00697672 FIG00697677: hypothetical protein +FIG00697678 FIG00697681: hypothetical protein +FIG00697681 FIG00697683: hypothetical protein +FIG00697683 FIG00697684: hypothetical protein +FIG00697706 FIG00697708: hypothetical protein +FIG00697708 EspP +FIG00697710 COG4185: Uncharacterized protein conserved in bacteria +FIG00697722 FIG00697725: hypothetical protein +FIG00697725 Homolog of fucose/glucose/galactose permeases +FIG00697736 FIG00697739: hypothetical protein +FIG00697739 FIG00697740: hypothetical protein +FIG00697743 FIG00697744: hypothetical protein +FIG00697761 FIG00697762: hypothetical protein +FIG00697762 FIG00697768: hypothetical protein +FIG00697768 FIG00697772: hypothetical protein +FIG00697772 FIG00697777: hypothetical protein +FIG00697778 FIG00697784: hypothetical protein +FIG00697796 FIG00697801: hypothetical protein +FIG00697807 RstR-like phage repressor protein +FIG00697817 FIG00697818: hypothetical protein +FIG00697818 FIG00697820: hypothetical protein +FIG00697824 ENSANGP00000000114 +FIG00697834 FIG00697842: hypothetical protein +FIG00697842 FIG00697844: hypothetical protein +FIG00697844 putative methyl-accepting chemotaxis protein +FIG00697845 Phage-related capsid packaging protein +FIG00697847 FIG00697848: hypothetical protein +FIG00697848 FIG00697849: hypothetical protein +FIG00697849 hypothetical protein +FIG00697854 FIG00697855: hypothetical protein +FIG00697858 FIG00697860: hypothetical protein +FIG00697865 FIG00697867: hypothetical protein +FIG00697867 FIG00697868: hypothetical protein +FIG00697869 hypothetical protein +FIG00697872 FIG00697873: hypothetical protein +FIG00697876 FIG00697877: hypothetical protein +FIG00697877 FIG00697878: hypothetical protein +FIG00697884 FIG00697887: hypothetical protein +FIG00697887 FIG00697888: hypothetical protein +FIG00697892 prophage MuMc02, nuclease, putative +FIG00697895 FIG00697897: hypothetical protein +FIG00697900 FIG00697901: hypothetical protein +FIG00697904 FIG00697909: hypothetical protein +FIG00697912 hypothetical protein +FIG00697933 Putative periplasmic protein YibQ, distant homology with nucleoside diphosphatase and polysaccharide deacetylase +FIG00697934 FIG00697940: hypothetical protein +FIG00697940 FIG00697944: hypothetical protein +FIG00697944 putative single stranded DNA-binding protien +FIG00697947 FIG00697951: hypothetical protein +FIG00697952 putative phage tail component +FIG00697960 Uncharacterized protein PM1437 +FIG00697966 FIG00697967: hypothetical protein +FIG00697967 FIG00697968: hypothetical protein +FIG00697968 FIG00697976: hypothetical protein +FIG00697986 hypothetical protein +FIG00697987 FIG00697991: hypothetical protein +FIG00697995 FIG00697996: hypothetical protein +FIG00697996 Predicted P-loop ATPase +FIG00698014 FIG00698018: hypothetical protein +FIG00698029 FIG00698030: hypothetical protein +FIG00698030 FIG00698033: hypothetical protein +FIG00698033 FIG00698041: hypothetical protein +FIG00698042 FIG00698045: hypothetical protein +FIG00698045 FIG00698046: hypothetical protein +FIG00698056 FIG00698059: hypothetical protein +FIG00698059 FIG00698062: hypothetical protein +FIG00698062 FIG00698070: hypothetical protein +FIG00698070 FIG00698071: hypothetical protein +FIG00698076 FIG00698078: hypothetical protein +FIG00698079 FIG00698081: hypothetical protein +FIG00698083 FIG00698086: hypothetical protein +FIG00698097 FIG00698101: hypothetical protein +FIG00698117 FIG00698123: hypothetical protein +FIG00698126 COG0272: NAD-dependent DNA ligase (contains BRCT domain type II) +FIG00698131 FIG00698132: hypothetical protein +FIG00698156 FIG00698159: hypothetical protein +FIG00698162 FIG00698163: hypothetical protein +FIG00698183 FIG00698185: hypothetical protein +FIG00698192 FIG00698195: hypothetical protein +FIG00698197 FIG00698198: hypothetical protein +FIG00698198 FIG00698199: hypothetical protein +FIG00698202 FIG00698204: hypothetical protein +FIG00698206 FIG00698208: hypothetical protein +FIG00698210 G protein +FIG00698213 FIG00698217: hypothetical protein +FIG00698217 FIG00698219: hypothetical protein +FIG00698224 FIG00698231: hypothetical protein +FIG00698247 cytosine specific DNA methyltransferase (BSP6IM) +FIG00698255 FIG00698256: hypothetical protein +FIG00698256 FIG00698262: hypothetical protein +FIG00698275 FIG00698276: hypothetical protein +FIG00698279 FIG00698286: hypothetical protein +FIG00698304 Phage-related tail fibre protein +FIG00698307 FIG00698309: hypothetical protein +FIG00698313 FIG00698323: hypothetical protein +FIG00698323 FIG00698324: hypothetical protein +FIG00698324 FIG00698325: hypothetical protein +FIG00698325 FIG00698326: hypothetical protein +FIG00698333 putative site specific recombinase +FIG00698337 Uncharacterized protein conserved in bacteria +FIG00698362 inorganic polyphosphate/ATP-NAD kinase( EC:2.7.1.23 ) +FIG00698364 FIG00698369: hypothetical protein +FIG00698380 FIG00698381: hypothetical protein +FIG00698390 FIG00698394: hypothetical protein +FIG00698397 FIG00698398: hypothetical protein +FIG00698398 AphA-like protein +FIG00698415 FIG00698416: hypothetical protein +FIG00698420 FIG00698421: hypothetical protein +FIG00698428 FIG00698435: hypothetical protein +FIG00698436 FIG00698438: hypothetical protein +FIG00698439 FIG00698440: hypothetical protein +FIG00698452 FIG00698456: hypothetical protein +FIG00698457 FIG00698459: hypothetical protein +FIG00698462 Hypothetical YciO protein, TsaC/YrdC paralog +FIG00698463 FIG00698466: hypothetical protein +FIG00698466 BASEPLATE +FIG00698467 FIG00698468: hypothetical protein +FIG00698469 FIG00698470: hypothetical protein +FIG00698472 FIG00698473: hypothetical protein +FIG00698476 FIG00698479: hypothetical protein +FIG00698487 Replicase +FIG00698494 FIG00698500: hypothetical protein +FIG00698500 FIG00698503: hypothetical protein +FIG00698508 FIG00698509: hypothetical protein +FIG00698511 FIG00698522: hypothetical protein +FIG00698528 FIG00698529: hypothetical protein +FIG00698546 E16 protein +FIG00698555 FIG00698556: hypothetical protein +FIG00698558 FIG00698560: hypothetical protein +FIG00698564 FIG00698572: hypothetical protein +FIG00698578 Putative phage tail core protein +FIG00698586 putative F17-like fimbrial usher +FIG00698589 FIG00698594: hypothetical protein +FIG00698598 FIG00698599: hypothetical protein +FIG00698609 FIG00698611: hypothetical protein +FIG00698611 FIG00698626: hypothetical protein +FIG00698636 FIG00698637: hypothetical protein +FIG00698637 FIG00698638: hypothetical protein +FIG00698652 FIG00698663: hypothetical protein +FIG00698665 FIG00698668: hypothetical protein +FIG00698670 FIG00698677: hypothetical protein +FIG00698677 FIG00698681: hypothetical protein +FIG00698698 5-methylaminomethyl-2-thiouridine-forming enzyme mnmC +FIG00698706 FIG00698709: hypothetical protein +FIG00698712 FIG00698721: hypothetical protein +FIG00698725 FIG00698728: hypothetical protein +FIG00698728 FIG00698733: hypothetical protein +FIG00698750 ParA-like protein +FIG00698753 FIG00698758: hypothetical protein +FIG00698758 FIG00698761: hypothetical protein +FIG00698761 FIG00698762: hypothetical protein +FIG00698774 FIG00698777: hypothetical protein +FIG00698794 hypothetical protein +FIG00698811 FIG00698819: hypothetical protein +FIG00698825 thiamine-phosphate pyrophosphorylase( EC:2.5.1.3 ) +FIG00698829 FIG00698837: hypothetical protein +FIG00698856 FIG00698863: hypothetical protein +FIG00698878 FIG00698880: hypothetical protein +FIG00698880 FIG00698883: hypothetical protein +FIG00698884 FIG00698886: hypothetical protein +FIG00698898 FIG00698901: hypothetical protein +FIG00698901 FIG00698905: hypothetical protein +FIG00698909 1-deoxy-D-xylulose 5-phosphate reductoisomerase( EC:1.1.1.267 ) +FIG00698914 FIG00698920: hypothetical protein +FIG00698933 putative lytic protein Rz1 +FIG00698952 FIG00698959: hypothetical protein +FIG00698959 FIG00698961: hypothetical protein +FIG00698961 FIG00698968: hypothetical protein +FIG00698978 hypothetical protein +FIG00698991 aminobenzoyl-glutamate utilization protein A +FIG00698998 FIG00699006: hypothetical protein +FIG00699019 FIG00699020: hypothetical protein +FIG00699020 FIG00699024: hypothetical protein +FIG00699072 FIG00699074: hypothetical protein +FIG00699074 FIG00699075: hypothetical protein +FIG00699075 FIG00699080: hypothetical protein +FIG00699121 FIG00699128: hypothetical protein +FIG00699131 FIG00699132: hypothetical protein +FIG00699151 FIG00699157: hypothetical protein +FIG00699157 FIG00699159: hypothetical protein +FIG00699169 possible prophage CP4-57 regulatory protein +FIG00699181 FIG00699182: hypothetical protein +FIG00699187 FIG00699188: hypothetical protein +FIG00699194 FIG00699199: hypothetical protein +FIG00699199 FIG00699204: hypothetical protein +FIG00699205 Septum formation initiator +FIG00699214 FIG00699223: hypothetical protein +FIG00699255 FIG00699267: hypothetical protein +FIG00699326 FIG00699332: hypothetical protein +FIG00699332 FIG00699333: hypothetical protein +FIG00699346 FIG00699349: hypothetical protein +FIG00699429 Type III restriction enzyme, res subunit:DEAD/DEAH box helicase, N-terminal +FIG00699436 FIG00699440: hypothetical protein +FIG00699444 FIG00699445: hypothetical protein +FIG00699492 LgtG +FIG00699535 FIG00699537: hypothetical protein +FIG00699635 FIG00699641: hypothetical protein +FIG00699715 Predicted extracellular and/or outer membrane deoxyribonuclease HCH_00356 +FIG00699739 FIG00699740: hypothetical protein +FIG00699952 FIG00699954: hypothetical protein +FIG00700171 Fetal brain protein 239 +FIG00700181 FIG00700184: hypothetical protein +FIG00700327 FIG00956269: hypothetical protein +FIG00700331 FIG00957120: hypothetical protein +FIG00700346 extracellular endoglucanase precursor +FIG00700447 FIG00700452: hypothetical protein +FIG00700629 conserved hypothetical protein-putative phosphatase +FIG00700754 FIG00785054: hypothetical protein +FIG00700755 FIG00700760: hypothetical protein +FIG00700963 FIG00700969: hypothetical protein +FIG00701170 FIG01036274: hypothetical protein +FIG00701182 FIG00701186: hypothetical protein +FIG00701197 FIG00701198: hypothetical protein +FIG00701312 FIG00701318: hypothetical protein +FIG00701367 FIG00701370: hypothetical protein +FIG00701370 hypothetical protein +FIG00701405 Cytochrome C551 peroxidase (EC 1.11.1.5) +FIG00701648 FIG00701650: hypothetical protein +FIG00701740 FIG00701741: hypothetical protein +FIG00701790 FIG00785302: hypothetical protein +FIG00701870 FIG00701872: hypothetical protein +FIG00701982 VacJ-like lipoprotein precursor +FIG00702003 FIG00784196: hypothetical protein +FIG00702157 FIG00702158: hypothetical protein +FIG00702181 putative LysR-type regulator +FIG00702183 predicted protein tyrosine phosphatase +FIG00702195 FIG00784668: hypothetical protein +FIG00702207 FIG00785475: hypothetical protein +FIG00702335 Bona fide RidA/YjgF/TdcF/RutC subgroup +FIG00702364 FIG00702366: hypothetical protein +FIG00702387 putative ABC transporter protein +FIG00702468 FIG00924954: hypothetical protein +FIG00702509 Type III secretion host injection and negative regulator protein (YopD) +FIG00702548 The iron-vibriobactin/enterobactin uptake porter +FIG00702633 FIG00702637: hypothetical protein +FIG00702947 N-formimidoyl fortimicin A synthase +FIG00703100 acetyl-CoA synthetase +FIG00703174 FIG00703175: hypothetical protein +FIG00704238 peptidase, M1 (aminopeptidase N) family( EC:3.4.11.- ) +FIG00705279 developmental histidine kinase sensor +FIG00705289 FIG00705311: hypothetical protein +FIG00706169 FIG00706173: hypothetical protein +FIG00706173 alkyl hydroperoxide reductase/ Thiol specific antioxidant/ Mal allergen +FIG00706279 FIG00706295: hypothetical protein +FIG00706308 polysaccharide deacetylase domain protein +FIG00706362 FIG00706369: hypothetical protein +FIG00706499 FIG00706509: hypothetical protein +FIG00706753 two component, sigma54 specific, transcriptional regulator, Fis family +FIG00707076 Methanol dehydrogenase regulator (MoxR) homolog +FIG00707158 FIG00707166: hypothetical protein +FIG00707855 collaborates/cooperates with ARF (alternate reading frame) protein, putative +FIG00707936 FIG00707944: hypothetical protein +FIG00707987 L. lactis predicted coding region ORF00041 +FIG00708043 Uncharacterized protein Mb2598c +FIG00708075 FIG00708079: hypothetical protein +FIG00708447 putative metal dependent phosphohydrolase +FIG00708533 FIG00708548: hypothetical protein +FIG00708556 FIG00708559: hypothetical protein +FIG00708559 FIG00708568: hypothetical protein +FIG00708591 FIG00708593: hypothetical protein +FIG00708660 FIG00708661: hypothetical protein +FIG00708917 stage II sporulation protein P +FIG00709252 FIG00709287: hypothetical protein +FIG00709292 FIG00709303: hypothetical protein +FIG00709743 CRISPR-associated protein, Csh1 family +FIG00709965 FIG00709970: hypothetical protein +FIG00710107 FIG00710108: hypothetical protein +FIG00710108 FIG00388820: hypothetical protein +FIG00710109 FIG00710110: hypothetical protein +FIG00710110 FIG00710111: hypothetical protein +FIG00710111 FIG00710114: hypothetical protein +FIG00710117 FIG00710119: hypothetical protein +FIG00710119 FIG00710123: hypothetical protein +FIG00710123 FIG00387961: hypothetical protein +FIG00710124 FIG00710126: hypothetical protein +FIG00710126 FIG00710128: hypothetical protein +FIG00710135 FIG00710140: hypothetical protein +FIG00710140 putative type IIS restriction/modification enzyme +FIG00710142 FIG00710144: hypothetical protein +FIG00710144 FIG00710146: hypothetical protein +FIG00710146 FIG00710147: hypothetical protein +FIG00710147 FIG00710148: hypothetical protein +FIG00710152 FIG00710154: hypothetical protein +FIG00710161 FIG00710162: hypothetical protein +FIG00710162 FIG00710164: hypothetical protein +FIG00710165 FIG00710166: hypothetical protein +FIG00710167 FIG00710171: hypothetical protein +FIG00710171 FIG00710172: hypothetical protein +FIG00710172 FIG00710174: hypothetical protein +FIG00710174 FIG00710175: hypothetical protein +FIG00710175 FIG00710176: hypothetical protein +FIG00710176 FIG00710177: hypothetical protein +FIG00710180 FIG00710511: hypothetical protein +FIG00710184 FIG00710187: hypothetical protein +FIG00710189 FIG00710191: hypothetical protein +FIG00710192 FIG00710197: hypothetical protein +FIG00710197 FIG00710198: hypothetical protein +FIG00710198 FIG00710199: hypothetical protein +FIG00710204 FIG00710205: hypothetical protein +FIG00710208 Membrane-bound metallopeptidase +FIG00710211 FIG00710213: hypothetical protein +FIG00710213 FIG00710214: hypothetical protein +FIG00710216 FIG00710217: hypothetical protein +FIG00710220 FIG00710221: hypothetical protein +FIG00710225 FIG00710226: hypothetical protein +FIG00710226 FIG00710227: hypothetical protein +FIG00710227 FIG00710230: hypothetical protein +FIG00710231 FIG00710232: hypothetical protein +FIG00710232 FIG00710233: hypothetical protein +FIG00710233 FIG00710234: hypothetical protein +FIG00710234 FIG00710235: hypothetical protein +FIG00710235 FIG00710236: hypothetical protein +FIG00710236 FIG00710238: hypothetical protein +FIG00710238 putative PROCESSING PROTEASE +FIG00710240 FIG00710242: hypothetical protein +FIG00710242 FIG00710243: hypothetical protein +FIG00710243 FIG00712321: hypothetical protein +FIG00710246 FIG00710249: hypothetical protein +FIG00710249 FIG00710251: hypothetical protein +FIG00710259 FIG00710260: hypothetical protein +FIG00710260 FIG00710261: hypothetical protein +FIG00710261 FIG00710263: hypothetical protein +FIG00710263 FIG00710266: hypothetical protein +FIG00710266 Permease YjgP/YjgQ +FIG00710267 FIG00710269: hypothetical protein +FIG00710269 FIG00710270: hypothetical protein +FIG00710270 FIG00710271: hypothetical protein +FIG00710271 two-component response regulator family protein +FIG00710272 Putative polysaccharide deacetylase +FIG00710273 FIG00710274: hypothetical protein +FIG00710274 FIG00710276: hypothetical protein +FIG00710277 FIG00710278: hypothetical protein +FIG00710278 FIG00710279: hypothetical protein +FIG00710285 FIG00710286: hypothetical protein +FIG00710286 FIG00710287: hypothetical protein +FIG00710287 FIG00710288: hypothetical protein +FIG00710292 FIG00710294: hypothetical protein +FIG00710294 FIG00710295: hypothetical protein +FIG00710295 FIG00710299: hypothetical protein +FIG00710299 FIG00710303: hypothetical protein +FIG00710304 FIG00710306: hypothetical protein +FIG00710306 FIG00710308: hypothetical protein +FIG00710310 FIG00710315: hypothetical protein +FIG00710323 FIG00710327: hypothetical protein +FIG00710331 FIG00710332: hypothetical protein +FIG00710332 FIG00710333: hypothetical protein +FIG00710333 FIG00710334: hypothetical protein +FIG00710334 FIG00710335: hypothetical protein +FIG00710340 FIG00710343: hypothetical protein +FIG00710343 FIG00710344: hypothetical protein +FIG00710344 FIG00710345: hypothetical protein +FIG00710347 FIG00710348: hypothetical protein +FIG00710350 FIG00710351: hypothetical protein +FIG00710351 FIG00710352: hypothetical protein +FIG00710352 FIG00710354: hypothetical protein +FIG00710357 FIG00710359: hypothetical protein +FIG00710359 FIG00710360: hypothetical protein +FIG00710360 FIG00710361: hypothetical protein +FIG00710361 FIG00710362: hypothetical protein +FIG00710366 FIG00710367: hypothetical protein +FIG00710367 FIG00710369: hypothetical protein +FIG00710369 FIG00710372: hypothetical protein +FIG00710372 FIG00710373: hypothetical protein +FIG00710374 UDP-4-amino-4,6-dideoxy-N-acetyl-beta-L-altrosamine N-acetyltransferase (EC 2.3.1.202) +FIG00710375 FIG00710380: hypothetical protein +FIG00710380 FIG00710384: hypothetical protein +FIG00710384 FIG00710388: hypothetical protein +FIG00710388 FIG00710389: hypothetical protein +FIG00710389 Phospholipid-lipopolysaccharide ABC transporter +FIG00710390 FIG00710391: hypothetical protein +FIG00710394 FIG00710395: hypothetical protein +FIG00710395 FIG00710396: hypothetical protein +FIG00710402 FIG00710403: hypothetical protein +FIG00710403 putative Outer membrane protein +FIG00710405 FIG00710407: hypothetical protein +FIG00710407 FIG00710408: hypothetical protein +FIG00710408 FIG00710409: hypothetical protein +FIG00710409 FIG00710410: hypothetical protein +FIG00710411 FIG00710412: hypothetical protein +FIG00710412 FIG00710413: hypothetical protein +FIG00710413 DNA poymerase III subunit delta' (EC 2.7.7.7) +FIG00710415 FIG00710420: hypothetical protein +FIG00710420 FIG00710422: hypothetical protein +FIG00710422 FIG00710423: hypothetical protein +FIG00710423 FIG00710427: hypothetical protein +FIG00710427 FIG00710428: hypothetical protein +FIG00710431 FIG00710432: hypothetical protein +FIG00710434 FIG00710436: hypothetical protein +FIG00710437 FIG00710438: hypothetical protein +FIG00710438 FIG00710441: hypothetical protein +FIG00710442 FIG00710443: hypothetical protein +FIG00710443 FIG00710444: hypothetical protein +FIG00710444 FIG00710445: hypothetical protein +FIG00710445 FIG00710446: hypothetical protein +FIG00710446 FIG00710447: hypothetical protein +FIG00710447 restriction enzyme BcgI alpha chain-like protein( EC:2.1.1.72 ) +FIG00710448 FIG00710449: hypothetical protein +FIG00710450 FIG00710451: hypothetical protein +FIG00710451 FIG00710452: hypothetical protein +FIG00710454 FIG00710457: hypothetical protein +FIG00710459 FIG00710461: hypothetical protein +FIG00710461 FIG00710462: hypothetical protein +FIG00710462 FIG00710464: hypothetical protein +FIG00710464 FIG00710465: hypothetical protein +FIG00710465 FIG00710466: hypothetical protein +FIG00710466 FIG00710468: hypothetical protein +FIG00710468 FIG00710469: hypothetical protein +FIG00710472 FIG00710473: hypothetical protein +FIG00710473 FIG00710474: hypothetical protein +FIG00710474 FIG00710475: hypothetical protein +FIG00710475 FIG00710476: hypothetical protein +FIG00710476 FIG00713045: hypothetical protein +FIG00710477 FIG00710480: hypothetical protein +FIG00710480 FIG00710481: hypothetical protein +FIG00710481 FIG00710482: hypothetical protein +FIG00710482 FIG00710484: hypothetical protein +FIG00710485 FIG00710486: hypothetical protein +FIG00710490 FIG00710491: hypothetical protein +FIG00710491 FIG00710492: hypothetical protein +FIG00710492 FIG00710494: hypothetical protein +FIG00710494 FIG00710495: hypothetical protein +FIG00710495 putative metal-dependent hydrolase fragment 2 +FIG00710498 Protein of unknown function, DUF583 superfamily +FIG00710499 FIG00710500: hypothetical protein +FIG00710500 Highly acidic protein +FIG00710501 FIG00710502: hypothetical protein +FIG00710510 FIG00710512: hypothetical protein +FIG00710512 FIG00710515: hypothetical protein +FIG00710515 FIG00710516: hypothetical protein +FIG00710516 FIG00710520: hypothetical protein +FIG00710526 FIG00710527: hypothetical protein +FIG00710528 FIG00710530: hypothetical protein +FIG00710534 FIG00710537: hypothetical protein +FIG00710538 FIG00710539: hypothetical protein +FIG00710539 FIG00710542: hypothetical protein +FIG00710544 FIG00710546: hypothetical protein +FIG00710546 FIG00710547: hypothetical protein +FIG00710548 FIG00710550: hypothetical protein +FIG00710550 FIG00710551: hypothetical protein +FIG00710551 TYPE II DNA MODIFICATION ENZYME (METHYLTRANSFERASE) +FIG00710552 FIG00710553: hypothetical protein +FIG00710553 FIG00710554: hypothetical protein +FIG00710555 SULFATE ADENYLYLTRANSFERASE( EC:2.7.7.4 ) +FIG00710558 FIG00710559: hypothetical protein +FIG00710559 FIG00710560: hypothetical protein +FIG00710560 FIG00387830: hypothetical protein +FIG00710562 FIG00710564: hypothetical protein +FIG00710565 Lyzozyme M1 (1,4-beta-N-acetylmuramidase) (EC 3.2.1.17) +FIG00710572 FOG: TPR repeat, SEL1 subfamily +FIG00710576 Possible flagellar protein +FIG00710581 FIG00710582: hypothetical protein +FIG00710582 FIG00710584: hypothetical protein +FIG00710584 FIG00710585: hypothetical protein +FIG00710585 FIG00710586: hypothetical protein +FIG00710590 FIG00710594: hypothetical protein +FIG00710594 FIG00710595: hypothetical protein +FIG00710595 FIG00710596: hypothetical protein +FIG00710600 FIG00710601: hypothetical protein +FIG00710601 FIG00710606: hypothetical protein +FIG00710606 FIG00710608: hypothetical protein +FIG00710608 Octaprenyl diphosphate synthase (EC 2.5.1.90) +FIG00710610 FIG00710611: hypothetical protein +FIG00710615 HIT family protein +FIG00710620 FIG00710621: hypothetical protein +FIG00710621 Modification methylase EcoRI (EC 2.1.1.72) +FIG00710622 FIG00710623: hypothetical protein +FIG00710627 FIG00710629: hypothetical protein +FIG00710629 FIG00710632: hypothetical protein +FIG00710632 FIG00710633: hypothetical protein +FIG00710634 FIG00710635: hypothetical protein +FIG00710635 FIG00710638: hypothetical protein +FIG00710638 FIG00710639: hypothetical protein +FIG00710639 Putative ABC transporter ATP binding protein +FIG00710640 FIG00710641: hypothetical protein +FIG00710641 FIG00710642: hypothetical protein +FIG00710642 FIG00712149: hypothetical protein +FIG00710643 FIG00710644: hypothetical protein +FIG00710644 FIG00710646: hypothetical protein +FIG00710646 FIG00710647: hypothetical protein +FIG00710647 FIG00710648: hypothetical protein +FIG00710650 FIG00710652: hypothetical protein +FIG00710656 FIG00710657: hypothetical protein +FIG00710658 FIG00710659: hypothetical protein +FIG00710660 FIG00710662: hypothetical protein +FIG00710662 FIG00710663: hypothetical protein +FIG00710663 FIG00710665: hypothetical protein +FIG00710665 FIG00710668: hypothetical protein +FIG00710668 FIG00710670: hypothetical protein +FIG00710672 FIG00710673: hypothetical protein +FIG00710673 FIG00710676: hypothetical protein +FIG00710676 FIG00712138: hypothetical protein +FIG00710679 FIG00710682: hypothetical protein +FIG00710682 FIG00710685: hypothetical protein +FIG00710686 hypothetical protein +FIG00710687 FIG00710688: hypothetical protein +FIG00710688 FIG00710689: hypothetical protein +FIG00710689 FIG00710692: hypothetical protein +FIG00710692 FIG00710693: hypothetical protein +FIG00710693 FIG00710694: hypothetical protein +FIG00710694 FIG00710696: hypothetical protein +FIG00710696 FIG00710700: hypothetical protein +FIG00710700 FIG00710701: hypothetical protein +FIG00710704 FIG00710706: hypothetical protein +FIG00710711 FIG00710712: hypothetical protein +FIG00710712 FIG00710713: hypothetical protein +FIG00710713 FIG00710714: hypothetical protein +FIG00710717 FIG00710718: hypothetical protein +FIG00710718 FIG00710719: hypothetical protein +FIG00710719 FIG00710721: hypothetical protein +FIG00710721 FIG00710722: hypothetical protein +FIG00710722 FIG00710723: hypothetical protein +FIG00710727 FIG00710728: hypothetical protein +FIG00710728 ABC transporter, putative +FIG00710730 FIG00710732: hypothetical protein +FIG00710738 FIG00710740: hypothetical protein +FIG00710740 FIG00710744: hypothetical protein +FIG00710747 FIG00710748: hypothetical protein +FIG00710748 HYPOTHETICAL INTEGRAL MEMBRANE PROTEIN +FIG00710750 FIG00710751: hypothetical protein +FIG00710751 FIG00710752: hypothetical protein +FIG00710752 FIG00710753: hypothetical protein +FIG00710753 FIG00710755: hypothetical protein +FIG00710756 FIG00711083: hypothetical protein +FIG00710758 FIG00710761: hypothetical protein +FIG00710762 FIG00710764: hypothetical protein +FIG00710766 FIG00710767: hypothetical protein +FIG00710767 FIG00710768: hypothetical protein +FIG00710769 FIG00710770: hypothetical protein +FIG00710770 FIG00710771: hypothetical protein +FIG00710777 FIG00710779: hypothetical protein +FIG00710779 FIG00710781: hypothetical protein +FIG00710781 FIG00710782: hypothetical protein +FIG00710782 FIG00710784: hypothetical protein +FIG00710788 FIG00710791: hypothetical protein +FIG00710791 cag pathogenicity island protein Q +FIG00710795 FIG00710796: hypothetical protein +FIG00710798 FIG00710800: hypothetical protein +FIG00710800 FIG00710802: hypothetical protein +FIG00710802 FIG00710803: hypothetical protein +FIG00710803 FIG00710804: hypothetical protein +FIG00710804 FIG00710807: hypothetical protein +FIG00710807 FIG00710809: hypothetical protein +FIG00710809 FIG00710811: hypothetical protein +FIG00710813 FIG00710814: hypothetical protein +FIG00710814 FIG00710815: hypothetical protein +FIG00710815 FIG00710817: hypothetical protein +FIG00710817 FIG00710818: hypothetical protein +FIG00710826 FIG00710827: hypothetical protein +FIG00710827 FIG00710828: hypothetical protein +FIG00710830 FIG00710832: hypothetical protein +FIG00710837 FIG00710838: hypothetical protein +FIG00710838 FIG00710840: hypothetical protein +FIG00710840 FIG00710843: hypothetical protein +FIG00710843 FIG00710845: hypothetical protein +FIG00710845 FIG00710846: hypothetical protein +FIG00710846 FIG00710847: hypothetical protein +FIG00710848 FIG00710856: hypothetical protein +FIG00710856 FIG00710857: hypothetical protein +FIG00710857 FIG00710858: hypothetical protein +FIG00710858 FIG00710860: hypothetical protein +FIG00710860 FIG00710861: hypothetical protein +FIG00710861 FIG00710863: hypothetical protein +FIG00710864 FIG00710867: hypothetical protein +FIG00710869 putative histidine kinase sensor protein +FIG00710870 FIG00710873: hypothetical protein +FIG00710873 FIG00710874: hypothetical protein +FIG00710875 protease (pqqE) +FIG00710877 FIG00710880: hypothetical protein +FIG00710880 FIG00710881: hypothetical protein +FIG00710881 FIG00710882: hypothetical protein +FIG00710882 FIG00710883: hypothetical protein +FIG00710883 FIG00710886: hypothetical protein +FIG00710886 FIG00710887: hypothetical protein +FIG00710888 FIG00710889: hypothetical protein +FIG00710889 FIG00710891: hypothetical protein +FIG00710895 putative endonuclease G( EC:3.1.30.- ) +FIG00710896 FIG00710900: hypothetical protein +FIG00710900 FIG00710902: hypothetical protein +FIG00710902 FIG00710904: hypothetical protein +FIG00710904 FIG00710906: hypothetical protein +FIG00710906 FIG00710908: hypothetical protein +FIG00710908 FIG00710910: hypothetical protein +FIG00710911 FIG00710912: hypothetical protein +FIG00710912 FIG00710913: hypothetical protein +FIG00710914 FIG00710916: hypothetical protein +FIG00710916 FIG00710917: hypothetical protein +FIG00710919 ulcer-associated gene restriction endonuclease (iceA) +FIG00710920 FIG00710921: hypothetical protein +FIG00710924 FIG00710927: hypothetical protein +FIG00710927 FIG00710928: hypothetical protein +FIG00710932 FIG00710933: hypothetical protein +FIG00710934 FIG00710936: hypothetical protein +FIG00710936 FIG00710940: hypothetical protein +FIG00710940 FIG00710941: hypothetical protein +FIG00710941 FIG00710942: hypothetical protein +FIG00710942 FIG00710943: hypothetical protein +FIG00710943 Putative zinc protease +FIG00710946 FIG00710948: hypothetical protein +FIG00710948 FIG00710950: hypothetical protein +FIG00710954 FIG00710955: hypothetical protein +FIG00710958 FIG00710960: hypothetical protein +FIG00710963 FIG00710964: hypothetical protein +FIG00710967 FIG00710968: hypothetical protein +FIG00710972 FIG00710974: hypothetical protein +FIG00710982 adenine specific DNA methyltransferase +FIG00710987 FIG00710988: hypothetical protein +FIG00710988 FIG00710990: hypothetical protein +FIG00710990 FIG00710991: hypothetical protein +FIG00710994 FIG00710995: hypothetical protein +FIG00710995 FIG00710997: hypothetical protein +FIG00710997 FIG00710998: hypothetical protein +FIG00710999 FIG00711000: hypothetical protein +FIG00711002 FIG00711003: hypothetical protein +FIG00711003 FIG00711005: hypothetical protein +FIG00711005 FIG00711007: hypothetical protein +FIG00711009 FIG00711012: hypothetical protein +FIG00711013 FIG00711018: hypothetical protein +FIG00711020 FIG00711021: hypothetical protein +FIG00711026 N-Acetylneuraminate cytidylyltransferase (EC 2.7.7.43) / Glycosyltransferase type I +FIG00711028 FIG00711029: hypothetical protein +FIG00711029 FIG00711035: hypothetical protein +FIG00711037 FIG00711038: hypothetical protein +FIG00711038 FIG00711039: hypothetical protein +FIG00711040 FIG00711041: hypothetical protein +FIG00711048 FIG00711049: hypothetical protein +FIG00711051 FIG00711052: hypothetical protein +FIG00711052 FIG00711053: hypothetical protein +FIG00711053 FIG00711056: hypothetical protein +FIG00711056 FIG00711057: hypothetical protein +FIG00711057 FIG00711058: hypothetical protein +FIG00711060 VirB7 +FIG00711061 FIG00711062: hypothetical protein +FIG00711062 FIG00711068: hypothetical protein +FIG00711068 FIG00711069: hypothetical protein +FIG00711069 FIG00711074: hypothetical protein +FIG00711074 FIG00711075: hypothetical protein +FIG00711075 FIG00711080: hypothetical protein +FIG00711080 FIG00711081: hypothetical protein +FIG00711083 FIG00711084: hypothetical protein +FIG00711084 FIG00711085: hypothetical protein +FIG00711088 FIG00711089: hypothetical protein +FIG00711089 FIG00711093: hypothetical protein +FIG00711093 FIG00711094: hypothetical protein +FIG00711094 FIG00711095: hypothetical protein +FIG00711096 FIG00711097: hypothetical protein +FIG00711097 FIG00711098: hypothetical protein +FIG00711098 FIG00711099: hypothetical protein +FIG00711099 FIG00711100: hypothetical protein +FIG00711100 FIG00711102: hypothetical protein +FIG00711103 FIG00711104: hypothetical protein +FIG00711104 FIG00711106: hypothetical protein +FIG00711106 FIG00711107: hypothetical protein +FIG00711107 putative hexapeptide repeat acetyltransferase +FIG00711110 FIG00711111: hypothetical protein +FIG00711119 FIG00711122: hypothetical protein +FIG00711122 FIG00711123: hypothetical protein +FIG00711123 FIG00711124: hypothetical protein +FIG00711124 FIG00711125: hypothetical protein +FIG00711126 FIG00711128: hypothetical protein +FIG00711128 FIG00711131: hypothetical protein +FIG00711134 FIG00711135: hypothetical protein +FIG00711136 FIG00711139: hypothetical protein +FIG00711139 FIG00711141: hypothetical protein +FIG00711144 FIG00711145: hypothetical protein +FIG00711145 helicase +FIG00711146 Molybdenum cofactor biosynthesis protein MoaD +FIG00711147 FIG00711148: hypothetical protein +FIG00711149 FIG00711153: hypothetical protein +FIG00711153 FIG00711154: hypothetical protein +FIG00711154 FIG00711156: hypothetical protein +FIG00711159 FIG00711161: hypothetical protein +FIG00711161 FIG00711163: hypothetical protein +FIG00711163 FIG00711166: hypothetical protein +FIG00711167 FIG00711170: hypothetical protein +FIG00711170 FIG00711172: hypothetical protein +FIG00711175 FIG00711177: hypothetical protein +FIG00711183 FIG00711184: hypothetical protein +FIG00711184 FIG00711187: hypothetical protein +FIG00711187 FIG00711188: hypothetical protein +FIG00711188 FIG00711192: hypothetical protein +FIG00711192 FIG00711194: hypothetical protein +FIG00711194 2-polyprenyl-3-methyl-5-hydroxy-6-metoxy-1, 4-benzoquinol methylase +FIG00711198 Glutamine ABC transporter, permease protein GlnP +FIG00711201 cag pathogenicity island protein B +FIG00711202 FIG00711203: hypothetical protein +FIG00711203 FIG00711207: hypothetical protein +FIG00711209 FIG00711210: hypothetical protein +FIG00711210 FIG00711213: hypothetical protein +FIG00711215 FIG00711220: hypothetical protein +FIG00711220 FIG00711227: hypothetical protein +FIG00711227 FIG00711231: hypothetical protein +FIG00711231 FIG00711232: hypothetical protein +FIG00711232 FIG00711233: hypothetical protein +FIG00711237 FIG00711243: hypothetical protein +FIG00711243 FIG00711245: hypothetical protein +FIG00711245 FIG00711248: hypothetical protein +FIG00711248 FIG00711249: hypothetical protein +FIG00711250 FIG00711251: hypothetical protein +FIG00711251 FIG00711252: hypothetical protein +FIG00711264 FIG00711265: hypothetical protein +FIG00711265 FIG00711266: hypothetical protein +FIG00711269 FIG00711270: hypothetical protein +FIG00711271 FIG00711272: hypothetical protein +FIG00711272 FIG00711273: hypothetical protein +FIG00711274 FIG00711276: hypothetical protein +FIG00711281 FIG00711283: hypothetical protein +FIG00711283 FIG00711284: hypothetical protein +FIG00711286 FIG00711288: hypothetical protein +FIG00711288 FIG00711289: hypothetical protein +FIG00711289 FIG00711290: hypothetical protein +FIG00711295 poly E-rich protein +FIG00711296 FIG00711297: hypothetical protein +FIG00711303 Guanine-hypoxanthine permease +FIG00711307 FIG00711309: hypothetical protein +FIG00711311 FIG00711312: hypothetical protein +FIG00711313 Carboxy-terminal processing protease (EC 3.4.21.102) +FIG00711326 FIG00711330: hypothetical protein +FIG00711330 FIG00711332: hypothetical protein +FIG00711332 FIG00711334: hypothetical protein +FIG00711334 FIG00711336: hypothetical protein +FIG00711336 FIG00711337: hypothetical protein +FIG00711341 FIG00710376: hypothetical protein +FIG00711343 FIG00711344: hypothetical protein +FIG00711344 FIG00711345: hypothetical protein +FIG00711345 FIG00711346: hypothetical protein +FIG00711349 FIG00711353: hypothetical protein +FIG00711353 FIG00711357: hypothetical protein +FIG00711364 FIG00711365: hypothetical protein +FIG00711365 FIG00711367: hypothetical protein +FIG00711367 FIG00711369: hypothetical protein +FIG00711369 FIG00711372: hypothetical protein +FIG00711382 glutamine ABC transporter permease GlnP +FIG00711385 FIG00711386: hypothetical protein +FIG00711386 FIG00711388: hypothetical protein +FIG00711393 FIG00711399: hypothetical protein +FIG00711399 Adenine specific DNA methyltransferase +FIG00711404 FIG00711406: hypothetical protein +FIG00711408 FIG00711411: hypothetical protein +FIG00711411 FIG00711412: hypothetical protein +FIG00711416 putative metal-dependent hydrolase fragment 1 +FIG00711417 FIG00711419: hypothetical protein +FIG00711426 FIG00711428: hypothetical protein +FIG00711429 FIG00711430: hypothetical protein +FIG00711430 FIG00711431: hypothetical protein +FIG00711431 FIG00711432: hypothetical protein +FIG00711439 FIG00711442: hypothetical protein +FIG00711442 FIG00711443: hypothetical protein +FIG00711443 FIG00711444: hypothetical protein +FIG00711444 FIG00711446: hypothetical protein +FIG00711446 tetracycline resistance protein tetA(P), putative +FIG00711451 FIG00711453: hypothetical protein +FIG00711453 FIG00711455: hypothetical protein +FIG00711455 FIG00711458: hypothetical protein +FIG00711459 CAPSULAR POLYSACCHARIDE SYNTHESIS ENZYME CAP5I +FIG00711460 FIG00711461: hypothetical protein +FIG00711461 FIG00711464: hypothetical protein +FIG00711465 FIG00711469: hypothetical protein +FIG00711469 FIG00711471: hypothetical protein +FIG00711478 FIG00711481: hypothetical protein +FIG00711481 FIG00711482: hypothetical protein +FIG00711482 FIG00711485: hypothetical protein +FIG00711486 FIG00711488: hypothetical protein +FIG00711488 FIG00711489: hypothetical protein +FIG00711489 FIG00711491: hypothetical protein +FIG00711493 FIG00711494: hypothetical protein +FIG00711504 FIG00711506: hypothetical protein +FIG00711506 FIG00711507: hypothetical protein +FIG00711513 FIG00711516: hypothetical protein +FIG00711516 FIG00711517: hypothetical protein +FIG00711518 cag pathogenicity island protein (cag15) +FIG00711522 FIG00711523: hypothetical protein +FIG00711523 PUTATIVE NUCLEOTIDE PHOSPHORIBOSYLTRANSFERASE +FIG00711537 FIG00711538: hypothetical protein +FIG00711538 FIG00711540: hypothetical protein +FIG00711540 FIG00711543: hypothetical protein +FIG00711549 FIG00711550: hypothetical protein +FIG00711556 FIG00711558: hypothetical protein +FIG00711558 FIG00711561: hypothetical protein +FIG00711561 FIG00711566: hypothetical protein +FIG00711566 FIG00711568: hypothetical protein +FIG00711568 FIG00711569: hypothetical protein +FIG00711573 FIG00711575: hypothetical protein +FIG00711578 FIG00711579: hypothetical protein +FIG00711581 hypothetical protein +FIG00711582 FIG00711585: hypothetical protein +FIG00711587 FIG00711588: hypothetical protein +FIG00711588 FIG00711589: hypothetical protein +FIG00711591 FIG00711592: hypothetical protein +FIG00711592 Peptidase, M23/M37 family +FIG00711594 FIG00711595: hypothetical protein +FIG00711595 FIG00711599: hypothetical protein +FIG00711621 FIG00711625: hypothetical protein +FIG00711627 FIG00711628: hypothetical protein +FIG00711628 FIG00711630: hypothetical protein +FIG00711630 FIG00711631: hypothetical protein +FIG00711631 FIG00711635: hypothetical protein +FIG00711636 FIG00711637: hypothetical protein +FIG00711637 FIG00711638: hypothetical protein +FIG00711640 FIG00711644: hypothetical protein +FIG00711646 FIG00711648: hypothetical protein +FIG00711648 FIG00711650: hypothetical protein +FIG00711654 FIG00711659: hypothetical protein +FIG00711666 FIG00711669: hypothetical protein +FIG00711673 FIG00711674: hypothetical protein +FIG00711685 FIG00711686: hypothetical protein +FIG00711686 FIG00711689: hypothetical protein +FIG00711689 FIG00711691: hypothetical protein +FIG00711691 FIG00711692: hypothetical protein +FIG00711692 FIG00711693: hypothetical protein +FIG00711701 FIG00711703: hypothetical protein +FIG00711704 FIG00711707: hypothetical protein +FIG00711707 FIG00711708: hypothetical protein +FIG00711714 FIG00711719: hypothetical protein +FIG00711722 FIG00711727: hypothetical protein +FIG00711729 FIG00711731: hypothetical protein +FIG00711731 methyl-accepting chemotaxis protein (tlpA) +FIG00711732 FIG00711733: hypothetical protein +FIG00711735 FIG00711737: hypothetical protein +FIG00711737 FIG00711738: hypothetical protein +FIG00711738 Outer-membrane lipoprotein carrier protein precursor +FIG00711740 FIG00711742: hypothetical protein +FIG00711742 FIG00711746: hypothetical protein +FIG00711746 FIG00711748: hypothetical protein +FIG00711758 FIG00711759: hypothetical protein +FIG00711770 FIG00711771: hypothetical protein +FIG00711773 FIG00711774: hypothetical protein +FIG00711784 FIG00711785: hypothetical protein +FIG00711785 FIG00711790: hypothetical protein +FIG00711790 CAAX prenyl protease 1, putative +FIG00711794 phage uncharacterized protein, putative +FIG00711798 FIG00711801: hypothetical protein +FIG00711801 FIG00711802: hypothetical protein +FIG00711808 FIG00711809: hypothetical protein +FIG00711809 transcription regulator LysR family VCA0542 , putative +FIG00711810 FIG00711815: hypothetical protein +FIG00711815 FIG00711817: hypothetical protein +FIG00711824 FIG00711827: hypothetical protein +FIG00711828 FIG00711831: hypothetical protein +FIG00711831 FIG00711834: hypothetical protein +FIG00711834 FIG00711838: hypothetical protein +FIG00711838 FIG00711839: hypothetical protein +FIG00711840 FIG00711841: hypothetical protein +FIG00711841 FIG00711847: hypothetical protein +FIG00711847 FIG01209319: hypothetical protein +FIG00711851 FIG00711853: hypothetical protein +FIG00711860 FIG00711865: hypothetical protein +FIG00711867 FIG00711868: hypothetical protein +FIG00711871 type I restriction enzyme +FIG00711873 FIG00711874: hypothetical protein +FIG00711879 FIG00711880: hypothetical protein +FIG00711893 FIG00711895: hypothetical protein +FIG00711902 FIG00711905: hypothetical protein +FIG00711905 FIG00711906: hypothetical protein +FIG00711906 FIG00711908: hypothetical protein +FIG00711908 FIG00711909: hypothetical protein +FIG00711909 FIG00711910: hypothetical protein +FIG00711910 FIG00711911: hypothetical protein +FIG00711915 FIG00711917: hypothetical protein +FIG00711917 P-type DNA transfer ATPase VirB11 +FIG00711921 FIG00711926: hypothetical protein +FIG00711929 FLAVOPROTEIN +FIG00711937 FIG00711941: hypothetical protein +FIG00711941 FIG00711943: hypothetical protein +FIG00711944 FIG00711945: hypothetical protein +FIG00711946 osmoprotection ATP-binding protein +FIG00711949 FIG00711955: hypothetical protein +FIG00711958 FIG00711959: hypothetical protein +FIG00711961 Predicted permease YjgP/YjgQ family +FIG00711969 FIG00711970: hypothetical protein +FIG00711970 FIG00711974: hypothetical protein +FIG00711975 FIG00711977: hypothetical protein +FIG00711977 FIG00711978: hypothetical protein +FIG00711978 COG2194: Predicted membrane-associated, metal-dependent hydrolase +FIG00711986 FIG00711987: hypothetical protein +FIG00711987 FIG00711988: hypothetical protein +FIG00711988 Probable septum site-determining protein minC +FIG00711989 FIG00711992: hypothetical protein +FIG00711992 FIG00712000: hypothetical protein +FIG00712001 FIG00712002: hypothetical protein +FIG00712002 FIG00712006: hypothetical protein +FIG00712006 FIG00712009: hypothetical protein +FIG00712009 FIG00712012: hypothetical protein +FIG00712012 FIG00712015: hypothetical protein +FIG00712015 FIG00712016: hypothetical protein +FIG00712016 FIG00712019: hypothetical protein +FIG00712019 FIG00712020: hypothetical protein +FIG00712031 FIG00712032: hypothetical protein +FIG00712034 FIG00712035: hypothetical protein +FIG00712035 FIG00712038: hypothetical protein +FIG00712038 FIG00712039: hypothetical protein +FIG00712039 FIG00712041: hypothetical protein +FIG00712041 FIG00712043: hypothetical protein +FIG00712043 Probable membrane protein Cj0124c +FIG00712048 FIG00712051: hypothetical protein +FIG00712052 FIG00712054: hypothetical protein +FIG00712056 FIG00712057: hypothetical protein +FIG00712060 FIG00712061: hypothetical protein +FIG00712061 FIG00712062: hypothetical protein +FIG00712062 FIG00712064: hypothetical protein +FIG00712064 FIG00712065: hypothetical protein +FIG00712065 FIG00712067: hypothetical protein +FIG00712067 FIG00712068: hypothetical protein +FIG00712068 FIG00712070: hypothetical protein +FIG00712076 FIG00712080: hypothetical protein +FIG00712080 FIG00712087: hypothetical protein +FIG00712090 FIG00712094: hypothetical protein +FIG00712095 FIG00712098: hypothetical protein +FIG00712101 FIG00712103: hypothetical protein +FIG00712106 FIG00712109: hypothetical protein +FIG00712109 FIG00712110: hypothetical protein +FIG00712110 FIG00626672: hypothetical protein +FIG00712111 FIG00712115: hypothetical protein +FIG00712115 FIG00712117: hypothetical protein +FIG00712117 FIG00712118: hypothetical protein +FIG00712119 FIG00712120: hypothetical protein +FIG00712120 FIG00712122: hypothetical protein +FIG00712122 FIG00712123: hypothetical protein +FIG00712123 FIG00712124: hypothetical protein +FIG00712126 FIG00712131: hypothetical protein +FIG00712131 FIG00712136: hypothetical protein +FIG00712136 FIG00712137: hypothetical protein +FIG00712138 FIG00712141: hypothetical protein +FIG00712141 FIG00712142: hypothetical protein +FIG00712143 FIG00712144: hypothetical protein +FIG00712152 FIG00712154: hypothetical protein +FIG00712154 FIG00712156: hypothetical protein +FIG00712156 FIG00712166: hypothetical protein +FIG00712167 FIG00712169: hypothetical protein +FIG00712169 FIG00712171: hypothetical protein +FIG00712171 FIG00712176: hypothetical protein +FIG00712184 FIG00712185: hypothetical protein +FIG00712185 FIG00712188: hypothetical protein +FIG00712188 FIG00712190: hypothetical protein +FIG00712190 FIG00712197: hypothetical protein +FIG00712197 FIG00712199: hypothetical protein +FIG00712200 FIG00712204: hypothetical protein +FIG00712204 Probable protease htpX homolog +FIG00712206 FIG00712209: hypothetical protein +FIG00712213 FIG00712220: hypothetical protein +FIG00712223 FIG00712225: hypothetical protein +FIG00712228 FIG00712229: hypothetical protein +FIG00712230 FIG00712231: hypothetical protein +FIG00712231 FIG00712233: hypothetical protein +FIG00712237 Modification methylase EcoRV (EC 2.1.1.72) (Adenine-specific methyltransferase EcoRV) (M.EcoRV) +FIG00712246 FIG00712247: hypothetical protein +FIG00712263 FIG00712264: hypothetical protein +FIG00712264 FIG00712265: hypothetical protein +FIG00712268 FIG00712270: hypothetical protein +FIG00712272 FIG00712273: hypothetical protein +FIG00712273 FIG00712274: hypothetical protein +FIG00712274 putative nucleotidyl-sugar pyranose mutase +FIG00712283 FIG00712285: hypothetical protein +FIG00712285 DUF89 domain of unknown function +FIG00712287 FIG00712289: hypothetical protein +FIG00712292 FIG00712295: hypothetical protein +FIG00712295 FIG00712297: hypothetical protein +FIG00712305 FIG00712308: hypothetical protein +FIG00712308 FIG00712312: hypothetical protein +FIG00712312 FIG00712316: hypothetical protein +FIG00712328 FIG00712332: hypothetical protein +FIG00712333 FIG00712334: hypothetical protein +FIG00712335 FIG00712338: hypothetical protein +FIG00712338 FIG00712341: hypothetical protein +FIG00712367 FIG00712372: hypothetical protein +FIG00712377 FIG00712378: hypothetical protein +FIG00712379 FIG00712380: hypothetical protein +FIG00712383 FIG00712384: hypothetical protein +FIG00712388 FIG00712391: hypothetical protein +FIG00712391 FIG00712397: hypothetical protein +FIG00712397 FIG00712398: hypothetical protein +FIG00712398 FIG00712399: hypothetical protein +FIG00712400 FIG00712402: hypothetical protein +FIG00712404 FIG00712405: hypothetical protein +FIG00712410 FIG00712415: hypothetical protein +FIG00712415 FIG00712416: hypothetical protein +FIG00712416 FIG00712418: hypothetical protein +FIG00712421 FIG00712423: hypothetical protein +FIG00712424 FIG00712431: hypothetical protein +FIG00712431 FIG00712432: hypothetical protein +FIG00712432 FIG00712434: hypothetical protein +FIG00712440 FIG00712442: hypothetical protein +FIG00712451 FIG00712452: hypothetical protein +FIG00712453 FIG00712456: hypothetical protein +FIG00712458 FIG00712460: hypothetical protein +FIG00712466 FIG00712468: hypothetical protein +FIG00712468 hypothetical protein +FIG00712470 FIG00712471: hypothetical protein +FIG00712477 FIG00712478: hypothetical protein +FIG00712478 FIG00712479: hypothetical protein +FIG00712483 FIG00712484: hypothetical protein +FIG00712484 FIG00712485: hypothetical protein +FIG00712489 FIG00712494: hypothetical protein +FIG00712504 FIG00712513: hypothetical protein +FIG00712525 PUTATIVE INTEGRAL MEMBRANE PROTEIN +FIG00712527 FIG00712528: hypothetical protein +FIG00712530 FIG00712533: hypothetical protein +FIG00712536 FIG00712539: hypothetical protein +FIG00712539 FIG00712540: hypothetical protein +FIG00712540 FIG00712544: hypothetical protein +FIG00712544 FIG00712546: hypothetical protein +FIG00712549 FIG00712552: hypothetical protein +FIG00712552 FIG00712553: hypothetical protein +FIG00712553 FIG00712555: hypothetical protein +FIG00712556 Putative lipoprotein +FIG00712560 FIG00712561: hypothetical protein +FIG00712563 FIG00712564: hypothetical protein +FIG00712565 FIG00712567: hypothetical protein +FIG00712567 FIG00712570: hypothetical protein +FIG00712577 FIG00712582: hypothetical protein +FIG00712582 FIG00712586: hypothetical protein +FIG00712591 FIG00712592: hypothetical protein +FIG00712592 FIG00712594: hypothetical protein +FIG00712594 FIG00712596: hypothetical protein +FIG00712596 FIG00712597: hypothetical protein +FIG00712599 FIG00712604: hypothetical protein +FIG00712608 vacuolating cytotoxin fragment +FIG00712610 FIG00712615: hypothetical protein +FIG00712615 FIG00712616: hypothetical protein +FIG00712616 FIG00712617: hypothetical protein +FIG00712617 FIG00712627: hypothetical protein +FIG00712629 FIG00712632: hypothetical protein +FIG00712632 FIG00712633: hypothetical protein +FIG00712638 FIG00712640: hypothetical protein +FIG00712652 FIG00712653: hypothetical protein +FIG00712653 FIG00712657: hypothetical protein +FIG00712674 FIG00712678: hypothetical protein +FIG00712692 FIG00712693: hypothetical protein +FIG00712693 FIG00712694: hypothetical protein +FIG00712694 FIG00712695: hypothetical protein +FIG00712697 FIG00712699: hypothetical protein +FIG00712701 FIG00712702: hypothetical protein +FIG00712702 FIG00712705: hypothetical protein +FIG00712709 FIG00712716: hypothetical protein +FIG00712716 FIG00712717: hypothetical protein +FIG00712719 FIG00712721: hypothetical protein +FIG00712730 FIG00712732: hypothetical protein +FIG00712732 FIG00712733: hypothetical protein +FIG00712733 FIG00712734: hypothetical protein +FIG00712734 FIG00712740: hypothetical protein +FIG00712750 conserved hypothetical protein-TPR-repeat-containing +FIG00712751 lipoprotein, VacJ family +FIG00712753 type III restriction enzyme R protein +FIG00712758 FIG00712763: hypothetical protein +FIG00712768 FIG00712771: hypothetical protein +FIG00712772 FIG00712775: hypothetical protein +FIG00712775 FIG00712778: hypothetical protein +FIG00712793 FIG00712795: hypothetical protein +FIG00712795 FIG00712796: hypothetical protein +FIG00712801 FIG00712803: hypothetical protein +FIG00712803 FIG00712807: hypothetical protein +FIG00712807 FIG00712810: hypothetical protein +FIG00712810 FIG00712812: hypothetical protein +FIG00712813 FIG00712815: hypothetical protein +FIG00712831 FIG00712834: hypothetical protein +FIG00712843 FIG00712851: hypothetical protein +FIG00712851 FIG00712853: hypothetical protein +FIG00712861 NIFS PROTEIN (FRAGMENT) +FIG00712872 FIG00712874: hypothetical protein +FIG00712874 FIG00712875: hypothetical protein +FIG00712884 FIG00712888: hypothetical protein +FIG00712888 FIG00712892: hypothetical protein +FIG00712892 FIG00712894: hypothetical protein +FIG00712896 FIG00712900: hypothetical protein +FIG00712904 FIG00712907: hypothetical protein +FIG00712911 UDP-2-acetamido-2-deoxy-D-glucuronic acid dehydrogenase (NAD+ cofactor) +FIG00712933 FIG00712937: hypothetical protein +FIG00712948 Type II secretion outermembrane pore forming protein (PulD) +FIG00712963 FIG00712967: hypothetical protein +FIG00712980 DedA family protein +FIG00712988 FIG00712989: hypothetical protein +FIG00712989 FIG00712993: hypothetical protein +FIG00712999 Possible two-component regulator +FIG00713013 FIG00713020: hypothetical protein +FIG00713023 FIG00713024: hypothetical protein +FIG00713031 FIG00713032: hypothetical protein +FIG00713036 FIG00713037: hypothetical protein +FIG00713043 flagellar basal body P-ring biosynthesis protein +FIG00713045 outer membrane protein (omp13) +FIG00713054 FIG00713056: hypothetical protein +FIG00713069 FIG00713077: hypothetical protein +FIG00713077 FIG00713078: hypothetical protein +FIG00713078 FIG00713079: hypothetical protein +FIG00713079 FIG00713082: hypothetical protein +FIG00713082 Molybdenum cofactor biosynthesis protein MoaA +FIG00713084 FIG00713085: hypothetical protein +FIG00713085 FIG00713086: hypothetical protein +FIG00713101 FIG00713102: hypothetical protein +FIG00713102 FIG00713103: hypothetical protein +FIG00713109 ACYL-COA HYDROLASE +FIG00713111 FIG00713115: hypothetical protein +FIG00713115 FIG00713118: hypothetical protein +FIG00713120 FIG00713126: hypothetical protein +FIG00713128 FIG00713131: hypothetical protein +FIG00713131 FIG00713132: hypothetical protein +FIG00713135 FIG00713136: hypothetical protein +FIG00713152 FIG00713159: hypothetical protein +FIG00713159 FIG00713161: hypothetical protein +FIG00713168 FIG00713170: hypothetical protein +FIG00713170 FIG00713179: hypothetical protein +FIG00713179 FIG00713180: hypothetical protein +FIG00713187 FIG00713191: hypothetical protein +FIG00713194 FIG00713196: hypothetical protein +FIG00713196 probable outer membrane protein Cj1721c +FIG00713205 FIG00713206: hypothetical protein +FIG00713206 FIG00713208: hypothetical protein +FIG00713208 putative sugar transferase +FIG00713214 FIG00713221: hypothetical protein +FIG00713221 FIG00713230: hypothetical protein +FIG00713232 FIG00713233: hypothetical protein +FIG00713233 FIG00713238: hypothetical protein +FIG00713248 FIG00713250: hypothetical protein +FIG00713250 FIG00713251: hypothetical protein +FIG00713255 FIG00713256: hypothetical protein +FIG00713283 FIG00713287: hypothetical protein +FIG00713287 FIG00713289: hypothetical protein +FIG00713289 FIG00713296: hypothetical protein +FIG00713302 FIG00713310: hypothetical protein +FIG00713310 FIG00713313: hypothetical protein +FIG00713314 FIG00713315: hypothetical protein +FIG00713317 FIG00713326: hypothetical protein +FIG00713372 FIG00713374: hypothetical protein +FIG00713374 FIG00713378: hypothetical protein +FIG00713378 Probable integral membrane protein Cj1412c +FIG00713389 FIG00713391: hypothetical protein +FIG00713393 restriction endonuclease +FIG00713402 FIG00713403: hypothetical protein +FIG00713425 FIG00713429: hypothetical protein +FIG00713429 INTEGRASE/RECOMBINASE (XERCD FAMILY) +FIG00713437 FIG00713440: hypothetical protein +FIG00713440 FIG00713443: hypothetical protein +FIG00713443 FIG00713444: hypothetical protein +FIG00713447 FIG00713448: hypothetical protein +FIG00713460 predicted ATPase (AAA-family) +FIG00713574 rha protein, phage phi-80 +FIG00713601 FIG00713602: hypothetical protein +FIG00713795 FIG072699: hypothetical protein +FIG00713865 Sporulation-specific protease YabG +FIG00714245 FIG00714246: hypothetical protein +FIG00714613 SNF2-related protein +FIG00714683 Site-specific recombinase XerD +FIG00714956 cobalt-zinc-cadmium resistance protein CzcI +FIG00714969 FIG00714970: hypothetical protein +FIG00714981 FIG00714991: hypothetical protein +FIG00715011 FIG00715012: hypothetical protein +FIG00715040 Putative lipoprotein transmembrane +FIG00715052 FIG00715054: hypothetical protein +FIG00715054 FIG00715057: hypothetical protein +FIG00715057 FIG00715062: hypothetical protein +FIG00715062 FIG00715063: hypothetical protein +FIG00715086 FIG00715087: hypothetical protein +FIG00715087 TRAP transporter solute receptor, TAXI family +FIG00715095 FIG00715096: hypothetical protein +FIG00715096 FIG00715098: hypothetical protein +FIG00715128 FIG00715129: hypothetical protein +FIG00715154 probable ATP-binding ABC transporter protein +FIG00715193 FIG00715195: hypothetical protein +FIG00715197 FIG00715202: hypothetical protein +FIG00715203 FIG00715207: hypothetical protein +FIG00715225 FIG00715228: hypothetical protein +FIG00715228 FIG00715229: hypothetical protein +FIG00715241 FIG00715243: hypothetical protein +FIG00715257 FIG00715260: hypothetical protein +FIG00715272 FIG00715274: hypothetical protein +FIG00715303 FIG00715305: hypothetical protein +FIG00715305 Formyl-coenzyme A transferase (EC 2.8.3.16) +FIG00715310 FIG00715317: hypothetical protein +FIG00715329 FIG00715332: hypothetical protein +FIG00715336 FIG00715337: hypothetical protein +FIG00715337 FIG00715340: hypothetical protein +FIG00715340 FIG00715343: hypothetical protein +FIG00715345 FIG00715346: hypothetical protein +FIG00715371 patatin-related protein +FIG00715374 FIG00715393: hypothetical protein +FIG00715393 FIG00715394: hypothetical protein +FIG00715412 Putative carboxypeptidase. Putative conserved domain: IPR000834 (Peptidase M14, carboxypeptidase A) +FIG00715432 cytochrome c, class IC +FIG00715452 Mg-protoporphyrin IX monomethyl ester oxidative cyclase +FIG00715471 FIG00715472: hypothetical protein +FIG00715504 FIG00715505: hypothetical protein +FIG00715515 FIG00715517: hypothetical protein +FIG00715529 FIG00715532: hypothetical protein +FIG00715532 FIG00715537: hypothetical protein +FIG00715556 FIG00953527: hypothetical protein +FIG00715576 FIG00715582: hypothetical protein +FIG00715600 FIG00715601: hypothetical protein +FIG00715601 FIG00715604: hypothetical protein +FIG00715610 FIG00715614: hypothetical protein +FIG00715621 FIG00715627: hypothetical protein +FIG00715627 FIG00715629: hypothetical protein +FIG00715645 FIG00715646: hypothetical protein +FIG00715707 FIG00715709: hypothetical protein +FIG00715732 Dinucleotide-utilizing enzymes involved in molybdopterin and thiamine biosynthesis family 1 +FIG00715736 FIG00715740: hypothetical protein +FIG00715740 conserved hypothetical protein; putative TRANSMEMBRANE PROTEIN +FIG00715742 FIG00715743: hypothetical protein +FIG00715784 FIG00715786: hypothetical protein +FIG00715793 FIG00715803: hypothetical protein +FIG00715893 FIG00715896: hypothetical protein +FIG00715914 hypothetical protein. Putative conserved domain: IPR000160 diguanylate cyclase (GGDEF) domain) +FIG00715920 FIG00715926: hypothetical protein +FIG00715929 FIG00715930: hypothetical protein +FIG00715939 FIG00715950: hypothetical protein +FIG00715954 FIG00715960: hypothetical protein +FIG00715960 FIG00715964: hypothetical protein +FIG00715980 Putative response regulator receiver domain protein +FIG00716030 FIG00716031: hypothetical protein +FIG00716039 Serine/threonine kinase associate protein KapC +FIG00716101 Mucin-2 precursor (Intestinal mucin-2) +FIG00716237 FIG00716238: hypothetical protein +FIG00716244 FIG00716251: hypothetical protein +FIG00716341 RIKEN cDNA 2610207I16 gene +FIG00716464 protein kinase domain +FIG00716539 FIG00716545: hypothetical protein +FIG00716815 FIG00716816: hypothetical protein +FIG00716820 putative aldo-keto reductase +FIG00716884 FIG00716886: hypothetical protein +FIG00716899 Mll0243 protein +FIG00717073 Two-component sensor histidine kinase-like protein +FIG00717336 FIG00717337: hypothetical protein +FIG00717389 FIG00717392: hypothetical protein +FIG00717453 FIG00717458: hypothetical protein +FIG00717462 rhizosphere expressed protein RhiA +FIG00717611 Ribulose-5-phosphate 4-epimerase and related epimerases and aldolases +FIG00717674 Carboxyl-terminal processing protease +FIG00717716 FIG00717727: hypothetical protein +FIG00717856 FIG00717863: hypothetical protein +FIG00717863 Gll2265 protein +FIG00717932 Bacillolysin precursor (EC 3.4.24.28) (Neutral protease) +FIG00717985 FIG00717994: hypothetical protein +FIG00718271 Putative expression regulator +FIG00718330 Kelch-like protein 1 +FIG00718388 transposase for IS481 element +FIG00718495 FIG00718497: hypothetical protein +FIG00718697 probable ABC transporter, permease component +FIG00718726 Probable lipase/esterase (EC 3.-.-.-) +FIG00718819 Sulfatase-modifying factor 1 precursor (C-alpha-formyglycine-generating enzyme 1) +FIG00718873 FIG01122811: hypothetical protein +FIG00718957 putative DNA modification methyltransferase +FIG00719156 FIG00719161: hypothetical protein +FIG00719223 Gll3542 protein +FIG00719296 FIG00719298: hypothetical protein +FIG00719298 FIG00719299: hypothetical protein +FIG00719300 transcriptional antiterminator, BglG +FIG00719301 FIG00719302: hypothetical protein +FIG00719303 FIG00719306: hypothetical protein +FIG00719306 FIG00719307: hypothetical protein +FIG00719308 FIG00719309: hypothetical protein +FIG00719309 FIG00719310: hypothetical protein +FIG00719310 FIG00719311: hypothetical protein +FIG00719312 FIG00719314: hypothetical protein +FIG00719315 ADP-heptose:LPS heptosyltransferase-like +FIG00719321 FIG00719323: hypothetical protein +FIG00719326 FIG00719327: hypothetical protein +FIG00719327 FIG00719328: hypothetical protein +FIG00719329 dimethylsulfoxide reductase chain B +FIG00719332 FIG00719333: hypothetical protein +FIG00719333 TonB dependent receptor, putative +FIG00719336 FIG00719339: hypothetical protein +FIG00719339 FIG00719340: hypothetical protein +FIG00719340 putative sensory box sensor histidine kinase/response regulator VieS +FIG00719343 FIG00719344: hypothetical protein +FIG00719344 FIG00719345: hypothetical protein +FIG00719345 FIG00719347: hypothetical protein +FIG00719347 FIG00719349: hypothetical protein +FIG00719351 FIG00719353: hypothetical protein +FIG00719353 FIG00719355: hypothetical protein +FIG00719355 FIG00719358: hypothetical protein +FIG00719364 FIG00719365: hypothetical protein +FIG00719366 FIG00719367: hypothetical protein +FIG00719367 FIG00719368: hypothetical protein +FIG00719368 FIG00719369: hypothetical protein +FIG00719369 FIG00719371: hypothetical protein +FIG00719373 Flagellar hook-associated protein FlgK +FIG00719377 FIG00719380: hypothetical protein +FIG00719380 FIG00719382: hypothetical protein +FIG00719383 FIG00719384: hypothetical protein +FIG00719385 Two-component response regulator czcR +FIG00719388 FIG00719390: hypothetical protein +FIG00719390 FIG00719391: hypothetical protein +FIG00719391 FIG00719392: hypothetical protein +FIG00719392 FIG00719393: hypothetical protein +FIG00719393 FIG00719394: hypothetical protein +FIG00719394 FIG00719397: hypothetical protein +FIG00719397 FIG00719399: hypothetical protein +FIG00719403 FIG00719404: hypothetical protein +FIG00719404 FIG00719408: hypothetical protein +FIG00719408 TsaC protein (YrdC domain) required for threonylcarbamoyladenosine t(6)A37 modification in tRNA +FIG00719409 FIG00719410: hypothetical protein +FIG00719411 FIG00719412: hypothetical protein +FIG00719412 FIG00719414: hypothetical protein +FIG00719414 FIG00719416: hypothetical protein +FIG00719416 FIG00719417: hypothetical protein +FIG00719418 FIG00719420: hypothetical protein +FIG00719420 FIG00719421: hypothetical protein +FIG00719421 FIG00719422: hypothetical protein +FIG00719422 FIG00719424: hypothetical protein +FIG00719424 FIG00719426: hypothetical protein +FIG00719426 FIG00719427: hypothetical protein +FIG00719427 FIG00719428: hypothetical protein +FIG00719431 FIG00719432: hypothetical protein +FIG00719432 FIG00719433: hypothetical protein +FIG00719433 FIG00719434: hypothetical protein +FIG00719437 FIG00719438: hypothetical protein +FIG00719438 FIG00719441: hypothetical protein +FIG00719442 FIG00719443: hypothetical protein +FIG00719443 FIG00719444: hypothetical protein +FIG00719444 protein of unknown function DUF1291 +FIG00719445 ABC-type export system, ATP-binding subunit +FIG00719446 FIG00719447: hypothetical protein +FIG00719447 protein of unknown function DUF474 +FIG00719451 FIG00719452: hypothetical protein +FIG00719452 FIG00719453: hypothetical protein +FIG00719453 FIG00719454: hypothetical protein +FIG00719455 flagellar hook assembly protein +FIG00719458 FIG00719459: hypothetical protein +FIG00719459 DNA polymerase III epsilon subunit +FIG00719460 FIG00719462: hypothetical protein +FIG00719463 FIG00719464: hypothetical protein +FIG00719464 FIG00719465: hypothetical protein +FIG00719466 flagellar basal body rod protein FlgB +FIG00719467 protein of unknown function aq_054 +FIG00719469 FIG00719471: hypothetical protein +FIG00719471 FIG00719474: hypothetical protein +FIG00719476 FIG00719477: hypothetical protein +FIG00719477 FIG00719478: hypothetical protein +FIG00719481 FIG00719483: hypothetical protein +FIG00719483 FIG00719484: hypothetical protein +FIG00719485 Carboxymethylenebutenolidase( EC:3.1.1.45 ) +FIG00719486 FIG00719487: hypothetical protein +FIG00719489 FIG00719490: hypothetical protein +FIG00719490 FIG00719492: hypothetical protein +FIG00719494 FIG00719496: hypothetical protein +FIG00719496 FIG00719500: hypothetical protein +FIG00719501 FIG00719502: hypothetical protein +FIG00719506 FIG00719507: hypothetical protein +FIG00719509 FIG00719510: hypothetical protein +FIG00719510 acriflavin resistance periplasmic protein +FIG00719511 FIG00719512: hypothetical protein +FIG00719512 FIG00719514: hypothetical protein +FIG00719517 FIG00719518: hypothetical protein +FIG00719518 FIG00719519: hypothetical protein +FIG00719519 FIG00719520: hypothetical protein +FIG00719525 FIG00719526: hypothetical protein +FIG00719530 FIG00719531: hypothetical protein +FIG00719532 FIG00719533: hypothetical protein +FIG00719534 FIG00719535: hypothetical protein +FIG00719535 FIG00719536: hypothetical protein +FIG00719536 FIG00719542: hypothetical protein +FIG00719542 FIG00719543: hypothetical protein +FIG00719543 FIG00719544: hypothetical protein +FIG00719544 FIG00719545: hypothetical protein +FIG00719545 FIG00719546: hypothetical protein +FIG00719546 acetoin utilization protein +FIG00719548 FIG00719549: hypothetical protein +FIG00719549 FIG00719551: hypothetical protein +FIG00719551 FIG00719552: hypothetical protein +FIG00719552 FIG00719555: hypothetical protein +FIG00719560 FIG00719562: hypothetical protein +FIG00719562 FIG00719564: hypothetical protein +FIG00719565 conserved protein of unknown function; putative SalD +FIG00719566 ferredoxin oxidoreductase gamma subunit +FIG00719567 FIG00719568: hypothetical protein +FIG00719568 FIG00719569: hypothetical protein +FIG00719571 FIG00719572: hypothetical protein +FIG00719572 FIG00719576: hypothetical protein +FIG00719577 FIG00719581: hypothetical protein +FIG00719582 FIG00719584: hypothetical protein +FIG00719586 FIG00719588: hypothetical protein +FIG00719588 FIG00719591: hypothetical protein +FIG00719591 FIG00719594: hypothetical protein +FIG00719594 FIG00719595: hypothetical protein +FIG00719596 FIG00719597: hypothetical protein +FIG00719597 peptidase C39 bacteriocin processing +FIG00719600 tRNA (guanine-N(2)-)-methyltransferase( EC:2.1.1.32 ) +FIG00719601 FIG00719602: hypothetical protein +FIG00719602 FIG00719603: hypothetical protein +FIG00719603 FIG00719604: hypothetical protein +FIG00719604 FIG00719605: hypothetical protein +FIG00719605 FIG00719607: hypothetical protein +FIG00719608 molybdopterin-guainine dinucleotide biosynthesis protein B +FIG00719610 FIG00719611: hypothetical protein +FIG00719612 FIG00719613: hypothetical protein +FIG00719614 FIG00719615: hypothetical protein +FIG00719615 FIG00719617: hypothetical protein +FIG00719619 FIG00719623: hypothetical protein +FIG00719624 FIG00719626: hypothetical protein +FIG00719626 FIG00719627: hypothetical protein +FIG00719632 FIG00719633: hypothetical protein +FIG00719635 FIG00719637: hypothetical protein +FIG00719640 COG2210: Uncharacterized conserved protein +FIG00719646 FIG00719647: hypothetical protein +FIG00719647 FIG00719648: hypothetical protein +FIG00719648 FIG00719649: hypothetical protein +FIG00719651 FIG00719652: hypothetical protein +FIG00719652 FIG00719653: hypothetical protein +FIG00719653 glucose inhibited division protein B +FIG00719658 FIG00719661: hypothetical protein +FIG00719661 protein of unknown function DUF1703 +FIG00719665 FIG00719666: hypothetical protein +FIG00719669 FIG00719670: hypothetical protein +FIG00719670 FIG00719671: hypothetical protein +FIG00719671 FIG00719672: hypothetical protein +FIG00719680 FIG00719682: hypothetical protein +FIG00719682 FIG00719683: hypothetical protein +FIG00719683 FIG00719684: hypothetical protein +FIG00719684 FIG00719687: hypothetical protein +FIG00719687 FIG00719688: hypothetical protein +FIG00719688 FIG00719689: hypothetical protein +FIG00719689 Radical SAM domain protein +FIG00719690 FIG00719691: hypothetical protein +FIG00719691 FIG00719692: hypothetical protein +FIG00719694 FIG00719695: hypothetical protein +FIG00719698 FIG00719699: hypothetical protein +FIG00719699 FIG00719700: hypothetical protein +FIG00719702 FIG00719703: hypothetical protein +FIG00719703 FIG00719705: hypothetical protein +FIG00719706 FIG00719707: hypothetical protein +FIG00719707 FIG00719709: hypothetical protein +FIG00719712 Putative type IIS restriction /modification enzyme, N-terminal half +FIG00719717 FIG00719718: hypothetical protein +FIG00719718 FIG00719719: hypothetical protein +FIG00719719 FIG00719721: hypothetical protein +FIG00719721 FIG00719722: hypothetical protein +FIG00719722 FIG00719723: hypothetical protein +FIG00719723 FIG00719724: hypothetical protein +FIG00719727 FIG00719729: hypothetical protein +FIG00719730 FIG00719731: hypothetical protein +FIG00719732 FIG00719733: hypothetical protein +FIG00719733 FIG00719734: hypothetical protein +FIG00719734 FIG00719735: hypothetical protein +FIG00719735 FIG00719736: hypothetical protein +FIG00719736 Aspartate aminotransferase (EC 2.6.1.1) +FIG00719737 FIG00719738: hypothetical protein +FIG00719738 invasion protein IagB +FIG00719743 FIG00719744: hypothetical protein +FIG00719750 FIG00719751: hypothetical protein +FIG00719751 FIG00719752: hypothetical protein +FIG00719752 FIG00719753: hypothetical protein +FIG00719753 FIG00719754: hypothetical protein +FIG00719755 protein of unknown function DUF343 +FIG00719757 FIG00719760: hypothetical protein +FIG00719760 FIG00719761: hypothetical protein +FIG00719765 FIG00719766: hypothetical protein +FIG00719766 FIG00719768: hypothetical protein +FIG00719768 FIG00719769: hypothetical protein +FIG00719772 FIG00719774: hypothetical protein +FIG00719774 FIG00719775: hypothetical protein +FIG00719775 FIG00719779: hypothetical protein +FIG00719781 FIG00719782: hypothetical protein +FIG00719782 FIG00719783: hypothetical protein +FIG00719783 FIG00719784: hypothetical protein +FIG00719785 FIG00719787: hypothetical protein +FIG00719788 FIG00719789: hypothetical protein +FIG00719789 FIG00719791: hypothetical protein +FIG00719791 FIG00719793: hypothetical protein +FIG00719794 FIG00719795: hypothetical protein +FIG00719795 FIG00719797: hypothetical protein +FIG00719798 FIG00719799: hypothetical protein +FIG00719799 FIG00719801: hypothetical protein +FIG00719801 FIG00719802: hypothetical protein +FIG00719802 FIG00719803: hypothetical protein +FIG00719806 17.4 kDa class I heat shock protein 4 +FIG00719807 FIG00719810: hypothetical protein +FIG00719810 FIG00719813: hypothetical protein +FIG00719813 FIG00719815: hypothetical protein +FIG00719815 FIG00719817: hypothetical protein +FIG00719818 FIG00719819: hypothetical protein +FIG00719821 FIG00719822: hypothetical protein +FIG00719822 125aa long conserved hypothetical protein +FIG00719823 FIG00719824: hypothetical protein +FIG00719824 FIG00719825: hypothetical protein +FIG00719825 FIG00719826: hypothetical protein +FIG00719827 FIG00719828: hypothetical protein +FIG00719828 FIG00719832: hypothetical protein +FIG00719832 FIG00719834: hypothetical protein +FIG00719838 FIG00719840: hypothetical protein +FIG00719841 FIG00719843: hypothetical protein +FIG00719846 FIG00719848: hypothetical protein +FIG00719852 FIG00719853: hypothetical protein +FIG00719858 protein export membrane protein SecG +FIG00719859 FIG00719860: hypothetical protein +FIG00719860 FIG00719863: hypothetical protein +FIG00719863 FIG00719865: hypothetical protein +FIG00719865 FIG00719867: hypothetical protein +FIG00719867 FIG00719869: hypothetical protein +FIG00719870 FIG00719871: hypothetical protein +FIG00719871 FIG00719872: hypothetical protein +FIG00719872 NADH dehydrogenase (ubiquinone) +FIG00719873 FIG00719875: hypothetical protein +FIG00719876 FIG00719877: hypothetical protein +FIG00719877 O-antigen export system permease protein RfbA +FIG00719878 FIG00719879: hypothetical protein +FIG00719879 FIG00719880: hypothetical protein +FIG00719884 FIG00719889: hypothetical protein +FIG00719889 FIG00719890: hypothetical protein +FIG00719892 FIG00719893: hypothetical protein +FIG00719893 FIG00719894: hypothetical protein +FIG00719894 FIG00719895: hypothetical protein +FIG00719897 FIG00719900: hypothetical protein +FIG00719900 FIG00719901: hypothetical protein +FIG00719901 FIG00719902: hypothetical protein +FIG00719902 FIG00719903: hypothetical protein +FIG00719903 FIG00719904: hypothetical protein +FIG00719904 FIG00719905: hypothetical protein +FIG00719905 FIG00719906: hypothetical protein +FIG00719906 FIG00719907: hypothetical protein +FIG00719907 FIG00719908: hypothetical protein +FIG00719908 FIG00719910: hypothetical protein +FIG00719910 FIG00719912: hypothetical protein +FIG00719912 FIG00719914: hypothetical protein +FIG00719914 FIG00719915: hypothetical protein +FIG00719915 FIG00719917: hypothetical protein +FIG00719917 FIG00719919: hypothetical protein +FIG00719919 FIG00719921: hypothetical protein +FIG00719921 FIG00719922: hypothetical protein +FIG00719924 FIG00719925: hypothetical protein +FIG00719928 siroheme synthase +FIG00719929 FIG00719930: hypothetical protein +FIG00719938 FIG00719939: hypothetical protein +FIG00719939 FIG00719940: hypothetical protein +FIG00719941 FIG00719943: hypothetical protein +FIG00719944 FIG00719946: hypothetical protein +FIG00719946 multiple antibiotic resistance-related protein +FIG00719951 Uncharacterized protein aq_1982 +FIG00719952 FIG00719954: hypothetical protein +FIG00719955 probable soluble lytic transglycosylase +FIG00719957 FIG00719958: hypothetical protein +FIG00719958 FIG00719960: hypothetical protein +FIG00719960 FIG00719962: hypothetical protein +FIG00719962 FIG00719963: hypothetical protein +FIG00719963 FIG00719965: hypothetical protein +FIG00719965 FIG00719966: hypothetical protein +FIG00719967 FIG00719969: hypothetical protein +FIG00719969 FIG00719970: hypothetical protein +FIG00719970 FIG00719971: hypothetical protein +FIG00719971 FIG00719972: hypothetical protein +FIG00719972 FIG00719973: hypothetical protein +FIG00719973 FIG00719975: hypothetical protein +FIG00719975 FIG00719976: hypothetical protein +FIG00719976 FIG00719977: hypothetical protein +FIG00719978 FIG00719979: hypothetical protein +FIG00719979 FIG00719980: hypothetical protein +FIG00719980 FIG00719983: hypothetical protein +FIG00719984 Lipoate-protein ligase A / domain of unknown function +FIG00719985 FIG00719986: hypothetical protein +FIG00719987 FIG00719988: hypothetical protein +FIG00719988 FIG00719990: hypothetical protein +FIG00719990 modD protein +FIG00719992 FIG00719993: hypothetical protein +FIG00719993 FIG00719995: hypothetical protein +FIG00719995 FIG00719996: hypothetical protein +FIG00719996 FIG00719999: hypothetical protein +FIG00719999 tetratricopeptide protein +FIG00720001 FIG00720002: hypothetical protein +FIG00720002 FIG00720003: hypothetical protein +FIG00720003 FIG00720008: hypothetical protein +FIG00720009 FIG00720013: hypothetical protein +FIG00720013 FIG00720014: hypothetical protein +FIG00720014 FIG00720016: hypothetical protein +FIG00720016 FIG00720017: hypothetical protein +FIG00720017 FIG00720019: hypothetical protein +FIG00720019 FIG00720020: hypothetical protein +FIG00720020 transcriptional regulator (PhoB-like) +FIG00720022 ATP synthase F0 sector subunit b (EC 3.6.3.14) +FIG00720024 FIG00720025: hypothetical protein +FIG00720025 FIG00720026: hypothetical protein +FIG00720026 FIG00720027: hypothetical protein +FIG00720028 FIG00720030: hypothetical protein +FIG00720031 FIG00720033: hypothetical protein +FIG00720033 FIG00720035: hypothetical protein +FIG00720035 FIG00720036: hypothetical protein +FIG00720036 ser/thr protein kinase +FIG00720037 FIG00720039: hypothetical protein +FIG00720039 FIG00720040: hypothetical protein +FIG00720040 FIG00720041: hypothetical protein +FIG00720043 FIG00720045: hypothetical protein +FIG00720045 FIG00720049: hypothetical protein +FIG00720049 FIG00720051: hypothetical protein +FIG00720057 FIG00720058: hypothetical protein +FIG00720058 Response regulator receiver:Sigma-54 factor, interaction region:Helix-turn-helix, Fis-type +FIG00720060 FIG00720061: hypothetical protein +FIG00720063 FIG00720064: hypothetical protein +FIG00720064 FIG00720066: hypothetical protein +FIG00720066 FIG00720067: hypothetical protein +FIG00720067 FIG00720071: hypothetical protein +FIG00720072 FIG00720076: hypothetical protein +FIG00720076 FIG00720077: hypothetical protein +FIG00720081 FIG00720082: hypothetical protein +FIG00720087 FIG00720088: hypothetical protein +FIG00720088 FIG00720089: hypothetical protein +FIG00720092 FIG00720093: hypothetical protein +FIG00720093 FIG00720094: hypothetical protein +FIG00720094 FIG00720095: hypothetical protein +FIG00720096 FIG00720097: hypothetical protein +FIG00720097 FIG00720099: hypothetical protein +FIG00720103 FIG00720104: hypothetical protein +FIG00720104 FIG00720105: hypothetical protein +FIG00720107 FIG00720108: hypothetical protein +FIG00720111 FIG00720112: hypothetical protein +FIG00720114 FIG00720115: hypothetical protein +FIG00720115 RNA polymerase omega subunit +FIG00720119 FIG00720120: hypothetical protein +FIG00720120 FIG00720122: hypothetical protein +FIG00720124 FIG00720126: hypothetical protein +FIG00720126 FIG00720127: hypothetical protein +FIG00720130 FIG00720132: hypothetical protein +FIG00720132 Membrane conserved hypothetical protein +FIG00720133 FIG00720134: hypothetical protein +FIG00720140 FIG00720141: hypothetical protein +FIG00720142 FIG00720144: hypothetical protein +FIG00720146 FIG00720147: hypothetical protein +FIG00720150 putative bifunctional endo-1,4-beta-xylanase xylA precursor +FIG00720151 FIG00720153: hypothetical protein +FIG00720153 FIG00720155: hypothetical protein +FIG00720156 FIG00720158: hypothetical protein +FIG00720161 FIG00720162: hypothetical protein +FIG00720166 FIG00720167: hypothetical protein +FIG00720167 FIG00720172: hypothetical protein +FIG00720172 FIG00720174: hypothetical protein +FIG00720176 FIG00720180: hypothetical protein +FIG00720181 FIG00720182: hypothetical protein +FIG00720185 FIG00720187: hypothetical protein +FIG00720187 FIG00720188: hypothetical protein +FIG00720188 FIG00720190: hypothetical protein +FIG00720190 hypothetic protein +FIG00720191 FIG00720192: hypothetical protein +FIG00720192 FIG00720194: hypothetical protein +FIG00720196 FIG00720197: hypothetical protein +FIG00720197 FIG00720198: hypothetical protein +FIG00720198 FIG00720199: hypothetical protein +FIG00720199 FIG00720200: hypothetical protein +FIG00720206 FIG00720207: hypothetical protein +FIG00720207 FIG00720209: hypothetical protein +FIG00720211 COG1872 +FIG00720212 FIG00720213: hypothetical protein +FIG00720213 FIG00720216: hypothetical protein +FIG00720216 FIG00720217: hypothetical protein +FIG00720217 FIG00720218: hypothetical protein +FIG00720218 FIG00720221: hypothetical protein +FIG00720223 nitrogen-fixing NifU domain protein +FIG00720225 FIG00720229: hypothetical protein +FIG00720229 FIG00720230: hypothetical protein +FIG00720230 FIG00720231: hypothetical protein +FIG00720232 FIG00720233: hypothetical protein +FIG00720233 FIG00720236: hypothetical protein +FIG00720236 FIG00720237: hypothetical protein +FIG00720237 FIG00720238: hypothetical protein +FIG00720243 FIG010773: NAD-dependent epimerase/dehydratase +FIG00720258 medium-chain-fatty-acid--CoA ligase +FIG00720290 FIG00720292: hypothetical protein +FIG00720331 FIG00720332: hypothetical protein +FIG00720417 FIG00720420: hypothetical protein +FIG00720473 OmpA/MotB domain, possible porin +FIG00720495 FIG00720498: hypothetical protein +FIG00720545 InterPro IPR005135 +FIG00720620 Putative LuxR-family transcriptional regulator +FIG00720640 Possible sulfoacetate exporter +FIG00720675 FIG00720677: hypothetical protein +FIG00720915 InterPro IPR001279 COGs COG0491 +FIG00720979 Uracil DNA glycosylase +FIG00721106 phosphotransferase family protein +FIG00721163 FIG00721166: hypothetical protein +FIG00721229 FIG00721233: hypothetical protein +FIG00721297 FIG00721299: hypothetical protein +FIG00721367 FIG00721371: hypothetical protein +FIG00721417 NnrU family protein, required for expression of nitric oxide and nitrite reductases (Nir and Nor) +FIG00721449 sodium/calcium exchanger +FIG00721454 InterPro IPR003736:IPR006683 COGs COG2050 +FIG00721482 FIG00721487: hypothetical protein +FIG00721521 hypothetical protein, probable phosphoesterase +FIG00721551 FIG00721563: hypothetical protein +FIG00721673 26 kDa periplasmic immunogenic protein precursor +FIG00721711 putative acetyl xylan esterase +FIG00721780 FIG00721781: hypothetical protein +FIG00721798 FIG00721800: hypothetical protein +FIG00721884 FIG00721890: hypothetical protein +FIG00721891 FIG00721892: hypothetical protein +FIG00721895 FIG00920275: hypothetical protein +FIG00721907 FIG00721913: hypothetical protein +FIG00721913 FIG00721917: hypothetical protein +FIG00721917 FIG00721918: hypothetical protein +FIG00721932 FIG00721933: hypothetical protein +FIG00721933 FIG00721934: hypothetical protein +FIG00721938 FIG00721939: hypothetical protein +FIG00721939 putative secretory apparatus +FIG00721943 FIG00721944: hypothetical protein +FIG00721946 FIG00721949: hypothetical protein +FIG00721949 FIG00721952: hypothetical protein +FIG00721955 AAA ATPase +FIG00721962 FIG00721963: hypothetical protein +FIG00721977 FIG00721982: hypothetical protein +FIG00721984 FIG00721987: hypothetical protein +FIG00721988 FIG00721990: hypothetical protein +FIG00721990 FIG00721991: hypothetical protein +FIG00721991 AmpE protein +FIG00721998 FIG00721999: hypothetical protein +FIG00722010 FIG00722011: hypothetical protein +FIG00722011 FIG00722013: hypothetical protein +FIG00722013 Luciferase-like monooxygenase +FIG00722024 FIG00722030: hypothetical protein +FIG00722040 FIG137478: Hypothetical protein YbgI +FIG00722046 Oar-like outer membrane protein protein, OmpA family +FIG00722047 FIG00722048: hypothetical protein +FIG00722048 FIG00722050: hypothetical protein +FIG00722050 FIG00722051: hypothetical protein +FIG00722051 FIG00722056: hypothetical protein +FIG00722056 4-hydroxybenzoyl-CoA thioesterase domain protein (EC 3.1.2.-) +FIG00722061 Cell division protein, FtsN +FIG00722066 FIG00722069: hypothetical protein +FIG00722072 FIG00722074: hypothetical protein +FIG00722078 Probable two-component system response regulator +FIG00722083 Uncharacterized periplasmic binding protein +FIG00722096 FIG00722098: hypothetical protein +FIG00722100 FIG00722103: hypothetical protein +FIG00722103 FIG00722107: hypothetical protein +FIG00722112 FIG00722113: hypothetical protein +FIG00722113 FIG00949460: hypothetical protein +FIG00722114 FIG00722121: hypothetical protein +FIG00722126 Sodium-type flagellar protein MotY +FIG00722130 FIG00722131: hypothetical protein +FIG00722138 FIG00722144: hypothetical protein +FIG00722144 FIG00722151: hypothetical protein +FIG00722164 FIG00722167: hypothetical protein +FIG00722168 FIG00722169: hypothetical protein +FIG00722178 FIG00722182: hypothetical protein +FIG00722182 FIG00722188: hypothetical protein +FIG00722191 FIG00722192: hypothetical protein +FIG00722192 FIG00722195: hypothetical protein +FIG00722195 FIG00722197: hypothetical protein +FIG00722205 Secreted TPR-repeat containing protein +FIG00722206 FIG00722209: hypothetical protein +FIG00722209 FIG00722214: hypothetical protein +FIG00722214 FIG00722217: hypothetical protein +FIG00722217 FIG00722218: hypothetical protein +FIG00722219 FIG00722224: hypothetical protein +FIG00722233 FIG00722234: hypothetical protein +FIG00722234 FIG00722235: hypothetical protein +FIG00722235 FIG00722237: hypothetical protein +FIG00722237 FIG00722239: hypothetical protein +FIG00722241 FIG00951782: hypothetical protein +FIG00722245 FIG059250: hypothetical protein +FIG00722257 FIG00722259: hypothetical protein +FIG00722259 FIG00722260: hypothetical protein +FIG00722260 FIG00722262: hypothetical protein +FIG00722262 FIG00722264: hypothetical protein +FIG00722271 uncharacterized conserved secreted protein, distantly related to OmpA family +FIG00722272 FIG00722274: hypothetical protein +FIG00722277 FIG00722284: hypothetical protein +FIG00722284 Two-component system sensor histidine kinase, phosphate sensing PhoR +FIG00722297 Probable ABC transporter ATP-binding protein +FIG00722319 FIG00722325: hypothetical protein +FIG00722330 FIG00722333: hypothetical protein +FIG00722339 FIG00722341: hypothetical protein +FIG00722341 FIG00722342: hypothetical protein +FIG00722353 FIG00722355: hypothetical protein +FIG00722356 FIG00722363: hypothetical protein +FIG00722363 FIG00722372: hypothetical protein +FIG00722372 FIG00722373: hypothetical protein +FIG00722374 Membrane-fusion protein homolog +FIG00722376 FIG00722377: hypothetical protein +FIG00722387 conserved hypothetical protein [KO:K01992] +FIG00722395 FIG00722404: hypothetical protein +FIG00722404 Predicted secreted or membrane protein +FIG00722407 FIG00722411: hypothetical protein +FIG00722415 uncharacterized conserved membrane protein +FIG00722422 FIG00722426: hypothetical protein +FIG00722426 FIG00722428: hypothetical protein +FIG00722438 FIG00722440: hypothetical protein +FIG00722440 FIG00722443: hypothetical protein +FIG00722443 Amidohydrolase family enzyme +FIG00722446 FIG00722447: hypothetical protein +FIG00722447 FIG00722453: hypothetical protein +FIG00722453 FIG00722456: hypothetical protein +FIG00722461 FIG00722462: hypothetical protein +FIG00722462 FIG00722464: hypothetical protein +FIG00722465 FIG00722467: hypothetical protein +FIG00722467 extracellular nuclease +FIG00722478 FIG00722481: hypothetical protein +FIG00722481 FIG00722488: hypothetical protein +FIG00722491 FIG00722498: hypothetical protein +FIG00722498 FIG00722499: hypothetical protein +FIG00722500 FIG00722504: hypothetical protein +FIG00722504 Chemotaxis protein CheY +FIG00722505 Probable NADPH:quinone reductase +FIG00722522 FIG00722527: hypothetical protein +FIG00722530 FIG00722531: hypothetical protein +FIG00722540 FIG00722544: hypothetical protein +FIG00722549 FIG00722557: hypothetical protein +FIG00722597 Exoenzymes regulatory protein AepA precursor +FIG00722615 Cell division inhibitor Slr1223 (YfcH in EC), contains epimerase/dehydratase and DUF1731 domains +FIG00722617 FIG00722622: hypothetical protein +FIG00722622 FIG00722623: hypothetical protein +FIG00722650 FIG00722663: hypothetical protein +FIG00722683 FIG00722684: hypothetical protein +FIG00722684 FIG00722686: hypothetical protein +FIG00722717 FIG00722721: hypothetical protein +FIG00722734 FIG00722737: hypothetical protein +FIG00722738 probable membrane protein STY2112 +FIG00722743 FIG00722745: hypothetical protein +FIG00722745 FIG00722757: hypothetical protein +FIG00722809 FIG00722813: hypothetical protein +FIG00722820 FIG00722824: hypothetical protein +FIG00722824 Anti-sigma F factor antagonist (spoIIAA-2); Anti-sigma B factor antagonist RsbV +FIG00722831 FIG00722839: hypothetical protein +FIG00722839 FIG00722844: hypothetical protein +FIG00722871 FIG00722878: hypothetical protein +FIG00722891 FIG00722897: hypothetical protein +FIG00722901 FIG00722912: hypothetical protein +FIG00722968 Isopenicillin N-epimerase (EC 5.-.-.-) +FIG00722970 Mll6904 protein +FIG00722989 FIG00672196: hypothetical protein +FIG00723055 FIG00729598: hypothetical protein +FIG00723152 FIG00723163: hypothetical protein +FIG00723173 FIG00723174: hypothetical protein +FIG00723199 FIG01130075: hypothetical protein +FIG00723211 FIG00723212: hypothetical protein +FIG00723274 FIG00723280: hypothetical protein +FIG00723283 lysyl-tRNA synthetase( EC:6.1.1.6 ) +FIG00723345 FIG00723350: hypothetical protein +FIG00723571 FIG00723572: hypothetical protein +FIG00723648 two-component system, sensor protein +FIG00723658 predicted protein of beta-propeller fold +FIG00723674 putative erythropoiesis-stimulating protein +FIG00723707 serine/threonine protein kinase +FIG00723761 FIG00723763: hypothetical protein +FIG00723763 FIG00723764: hypothetical protein +FIG00723831 FIG00723832: hypothetical protein +FIG00723871 FIG00723873: hypothetical protein +FIG00723928 Probable sensor kinase +FIG00723930 FIG01122115: hypothetical protein +FIG00723955 glutamate decarboxylase +FIG00724124 Protein tolB precursor +FIG00724147 FIG00724150: hypothetical protein +FIG00724186 FIG00724187: hypothetical protein +FIG00724280 FIG00724282: hypothetical protein +FIG00724464 PFIG00823557: AC2 (Proteasome assembly chaperone) family +FIG00724474 FIG00724476: hypothetical protein +FIG00724584 FIG00724586: hypothetical protein +FIG00724668 Transport-associated protein +FIG00724702 FIG01121360: hypothetical protein +FIG00724744 FIG01043527: hypothetical protein +FIG00724748 FIG00724749: hypothetical protein +FIG00724978 FIG00762052: hypothetical protein +FIG00724983 MoxR3 +FIG00725032 FIG00725033: hypothetical protein +FIG00725039 FIG00725044: hypothetical protein +FIG00725150 Dienelactone hydrolase family +FIG00725170 FIG00725189: hypothetical protein +FIG00725209 Proteinase inhibitor +FIG00725298 FIG00725299: hypothetical protein +FIG00725514 shikimate transporter ShiA +FIG00725525 ProQ activator of osmoprotectant transporter ProP +FIG00725640 FIG00725644: hypothetical protein +FIG00725721 hypothetical protein +FIG00725773 FIG00725774: hypothetical protein +FIG00725859 FIG00725876: hypothetical protein +FIG00725876 putative oxalate/formate antiporter +FIG00725967 FIG00725968: hypothetical protein +FIG00726322 FIG00726333: hypothetical protein +FIG00726364 ABC-transport protein, ATP-binding component +FIG00726515 Putative Integral membrane protein TerC family +FIG00726618 FIG00726619: hypothetical protein +FIG00726850 major facilitator superfamily transporter +FIG00726903 FIG00726904: hypothetical protein +FIG00727004 flavodoxin-like protein +FIG00727036 Acetylornithine deacetylase/Succinyl-diaminopimelate desuccinylase and related deacylases +FIG00727096 FIG00727099: hypothetical protein +FIG00727102 Similar to F420-dependent glucose-6-phosphate dehydrogenase, Caur_2833 family +FIG00727236 COG0394: Protein-tyrosine-phosphatase +FIG00727284 FIG00727304: hypothetical protein +FIG00727376 FIG00727381: hypothetical protein +FIG00727417 FIG00727418: hypothetical protein +FIG00727531 FIG027937: secreted protein +FIG00727618 FIG00727619: hypothetical protein +FIG00727706 FIG00727708: hypothetical protein +FIG00727815 permease protein of ABC transporter for glutamate +FIG00727847 FIG00727853: hypothetical protein +FIG00727913 FAD linked oxidase domain protein( EC:1.1.3.41 ) +FIG00727921 membrane protein SC1C225c +FIG00727936 cell wall-binding protein +FIG00728126 FIG00728130: hypothetical protein +FIG00728238 Fibronectin, type III:Glycoside hydrolase, family 81 +FIG00728293 FIG00729617: hypothetical protein +FIG00728817 FIG00728819: hypothetical protein +FIG00728959 putative calcium-binding outer membrane-like protein +FIG00728992 Uncharacterized low-complexity proteins-like +FIG00729084 Polysaccharide biosynthesis protein WlaX +FIG00729168 SprB +FIG00729350 FIG00729359: hypothetical protein +FIG00729883 Ubiquinone biosynthesis SAM-dependent O-methyltransferase (EC 2.1.1.-) +FIG00730001 FIG00730003: hypothetical protein +FIG00730021 FIG00730022: hypothetical protein +FIG00730039 FIG00730044: hypothetical protein +FIG00730095 FIG00864354: hypothetical protein +FIG00730121 Clp domain protein +FIG00730152 conserved hypothetical protein, putative amidohydrolase +FIG00730204 FIG00730206: hypothetical protein +FIG00730248 Luciferase-like protein +FIG00730285 formamidopyrimidine-DNA glycosylase( EC:3.2.2.23 ) +FIG00730342 FIG00945369: hypothetical protein +FIG00730526 Probable sufite oxidase (EC 1.8.3.1) +FIG00730691 Citrate transporter +FIG00730771 FIG00734039: hypothetical protein +FIG00730784 putative TfxG-like immunity protein against TfxA-like peptides +FIG00730825 putative sortase-like protein +FIG00730970 transcription regulator AmtR +FIG00730991 Membrane protein-like protein +FIG00731078 FIG00731079: hypothetical protein +FIG00731106 FIG00731112: hypothetical protein +FIG00731180 Acyl-coenzyme A oxidase 1, peroxisomal (EC 1.3.3.6) +FIG00731211 FIG00731214: hypothetical protein +FIG00731235 Metabolite transporter, MFS superfamily protein +FIG00731277 Amino acid permease-associated region +FIG00731278 DNA or RNA helicases of superfamily II +FIG00731289 FIG00731292: hypothetical protein +FIG00731315 Hypothetical ABC transport system, periplasmic component +FIG00731317 FIG00731318: hypothetical protein +FIG00731319 FIG00731320: hypothetical protein +FIG00731320 FIG00731321: hypothetical protein +FIG00731321 FIG00731322: hypothetical protein +FIG00731322 NOHBY218; no homolog in Saccharomyces cerevisiae +FIG00731323 FIG00731324: hypothetical protein +FIG00731326 FIG00731327: hypothetical protein +FIG00731327 FIG00731328: hypothetical protein +FIG00731329 MxcK +FIG00731332 FIG00731333: hypothetical protein +FIG00731333 FIG00731334: hypothetical protein +FIG00731334 FIG00731335: hypothetical protein +FIG00731335 FIG00731336: hypothetical protein +FIG00731336 FIG00731337: hypothetical protein +FIG00731340 FIG00731341: hypothetical protein +FIG00731343 FIG00731345: hypothetical protein +FIG00731345 Manganese catalase (EC 1.11.1.6) +FIG00731346 FIG00731347: hypothetical protein +FIG00731347 FIG00731351: hypothetical protein +FIG00731351 FIG00731353: hypothetical protein +FIG00731353 FIG00731358: hypothetical protein +FIG00731364 FIG00731366: hypothetical protein +FIG00731366 FIG00731367: hypothetical protein +FIG00731367 fumarate reductase/succinate dehydrogenase flavoprotein domain protein +FIG00731373 FIG00731374: hypothetical protein +FIG00731374 FIG00731376: hypothetical protein +FIG00731376 FIG00731377: hypothetical protein +FIG00731378 FIG00731379: hypothetical protein +FIG00731383 FIG00731385: hypothetical protein +FIG00731385 FIG00731387: hypothetical protein +FIG00731387 FIG00731388: hypothetical protein +FIG00731388 FIG00731389: hypothetical protein +FIG00731396 FIG00731397: hypothetical protein +FIG00731399 FIG00731400: hypothetical protein +FIG00731400 FIG00731401: hypothetical protein +FIG00731404 FIG00731405: hypothetical protein +FIG00731405 FIG00731406: hypothetical protein +FIG00731407 FIG00731410: hypothetical protein +FIG00731410 Choline-glycine betaine transporter +FIG00731412 FIG00731414: hypothetical protein +FIG00731414 FIG00731415: hypothetical protein +FIG00731415 FIG00731416: hypothetical protein +FIG00731416 FIG00731417: hypothetical protein +FIG00731417 FIG00731418: hypothetical protein +FIG00731419 FIG00731420: hypothetical protein +FIG00731422 FIG00731424: hypothetical protein +FIG00731428 FIG00731430: hypothetical protein +FIG00731431 FIG00731432: hypothetical protein +FIG00731435 FIG00731437: hypothetical protein +FIG00731438 FIG00731439: hypothetical protein +FIG00731442 Iron(III) ABC transporter, solute-binding protein +FIG00731448 putative two-component response regulator transcriptional regulatory protein +FIG00731453 FIG00731454: hypothetical protein +FIG00731457 FIG00731458: hypothetical protein +FIG00731460 FIG00731461: hypothetical protein +FIG00731468 FIG00731470: hypothetical protein +FIG00731473 FIG00731474: hypothetical protein +FIG00731475 FIG00731477: hypothetical protein +FIG00731479 FIG00731480: hypothetical protein +FIG00731480 FIG00731482: hypothetical protein +FIG00731489 FIG00731492: hypothetical protein +FIG00731492 FIG00731493: hypothetical protein +FIG00731502 FIG00731503: hypothetical protein +FIG00731503 FIG00731504: hypothetical protein +FIG00731509 DNA polymerase IV +FIG00731517 FIG00731518: hypothetical protein +FIG00731524 FIG00731527: hypothetical protein +FIG00731527 FIG00731529: hypothetical protein +FIG00731529 FIG00731530: hypothetical protein +FIG00731536 Putative ABC transporter, periplasmmic iron binding protein precursor +FIG00731537 FIG00731538: hypothetical protein +FIG00731538 FIG00731539: hypothetical protein +FIG00731539 FIG00731541: hypothetical protein +FIG00731541 FIG00731542: hypothetical protein +FIG00731542 Solute-binding periplasmic protein of iron/siderophore ABC transporter +FIG00731543 Multidrug resistance-like ATP-binding protein mdlB +FIG00731544 FIG00731545: hypothetical protein +FIG00731545 DsrB protein +FIG00731546 FIG00731547: hypothetical protein +FIG00731549 FIG00731550: hypothetical protein +FIG00731551 FIG00731552: hypothetical protein +FIG00731553 FIG00731555: hypothetical protein +FIG00731555 FIG00731557: hypothetical protein +FIG00731557 FIG00731559: hypothetical protein +FIG00731561 30S ribosomal subunit protein S22; stationary phase-induced ribosome-associated protein +FIG00731564 FIG00731566: hypothetical protein +FIG00731566 PTS system fructose-like IIB component 2 precursor (EC 2.7.1.69) +FIG00731567 FIG00731568: hypothetical protein +FIG00731568 FIG00731570: hypothetical protein +FIG00731570 FIG00731571: hypothetical protein +FIG00731571 Glucosamine ABC transport system, periplasmic sugar-binding protein +FIG00731575 Protein ybcL precursor +FIG00731583 Transporter, LysE family +FIG00731590 FIG00731592: hypothetical protein +FIG00731598 FIG00731600: hypothetical protein +FIG00731601 FIG00731602: hypothetical protein +FIG00731603 Putative HTH-type transcriptional regulator ycgE +FIG00731605 PTS system fructose-like IIB component 1 precursor (EC 2.7.1.69) +FIG00731609 ascBF operon repressor +FIG00731615 FIG00731616: hypothetical protein +FIG00731617 FIG00984300: hypothetical protein +FIG00731619 FIG00731620: hypothetical protein +FIG00731622 FIG00731623: hypothetical protein +FIG00731624 BAX protein +FIG00731625 FIG00731626: hypothetical protein +FIG00731626 FIG00731629: hypothetical protein +FIG00731629 FIG00731630: hypothetical protein +FIG00731632 Transglycosylase associated protein +FIG00731633 gamma-aminobutyrate (GABA) permease +FIG00731645 FIG00731646: hypothetical protein +FIG00731646 putative fimbrial-like protein +FIG00731652 FIG00731653: hypothetical protein +FIG00731653 FIG00731654: hypothetical protein +FIG00731660 FIG00731661: hypothetical protein +FIG00731663 FIG00731664: hypothetical protein +FIG00731664 FIG00731665: hypothetical protein +FIG00731665 putative phosphotransferase system, lactose/cellobiose-specific IIB subunit +FIG00731667 FIG00731668: hypothetical protein +FIG00731669 FIG00731670: hypothetical protein +FIG00731673 FIG00731674: hypothetical protein +FIG00731675 FIG00731676: hypothetical protein +FIG00731680 FIG00731681: hypothetical protein +FIG00731685 probable pilin chaperone +FIG00731688 FIG00731689: hypothetical protein +FIG00731689 FIG00731690: hypothetical protein +FIG00731691 Hypothetical protein ycgF +FIG00731694 Thiamine pyrophosphate-requiring protein Saci_2281 +FIG00731696 FIG00731698: hypothetical protein +FIG00731698 FIG00731699: hypothetical protein +FIG00731700 hypothetical protein +FIG00731702 FIG00731703: hypothetical protein +FIG00731703 FIG00731704: hypothetical protein +FIG00731704 FIG00731705: hypothetical protein +FIG00731705 FIG00731707: hypothetical protein +FIG00731707 Uncharacterized oxidoreductase ydgJ (EC 1.-.-.-) +FIG00731708 FIG00731709: hypothetical protein +FIG00731710 FIG00731712: hypothetical protein +FIG00731714 FIG00731716: hypothetical protein +FIG00731716 FIG00731721: hypothetical protein +FIG00731722 FIG00731723: hypothetical protein +FIG00731724 Oxygen-insensitive NAD(P)H nitroreductase (EC 1.-.-.-) / Dihydropteridine reductase (EC 1.5.1.34) +FIG00731726 FIG00731729: hypothetical protein +FIG00731729 Endo-b1,4-mannanase 5C +FIG00731731 FIG00731732: hypothetical protein +FIG00731733 Probable ABC transporter, ATP-binding subunit +FIG00731735 FIG00731736: hypothetical protein +FIG00731742 FIG00731743: hypothetical protein +FIG00731743 FIG00731744: hypothetical protein +FIG00731744 FIG00731745: hypothetical protein +FIG00731747 FIG00731748: hypothetical protein +FIG00731748 transporter, NadC family protein +FIG00731749 FIG00731751: hypothetical protein +FIG00731751 FIG00731753: hypothetical protein +FIG00731753 putative 2-component transcriptional regulator +FIG00731754 polymyxin resistance protein B +FIG00731755 FIG00731756: hypothetical protein +FIG00731757 Two-component system sensor protein Z5692 +FIG00731758 FIG00731759: hypothetical protein +FIG00731762 Probable tautomerase ydcE (EC 5.3.2.-) +FIG00731763 4-oxalmesaconate hydratase (EC 4.2.1.83) +FIG00731764 FIG00731765: hypothetical protein +FIG00731765 Orf27 +FIG00731767 FIG00731768: hypothetical protein +FIG00731768 putative bacterial regulatory protein, LysR +FIG00731769 FIG00731769: possible membrane protein +FIG00731773 FIG00731774: hypothetical protein +FIG00731774 FIG00731777: hypothetical protein +FIG00731780 Protein yhjK +FIG00731781 FIG00731784: hypothetical protein +FIG00731785 FIG00731788: hypothetical protein +FIG00731790 FIG00731791: hypothetical protein +FIG00731791 FIG00731792: hypothetical protein +FIG00731792 FIG00731793: hypothetical protein +FIG00731793 FIG00731794: hypothetical protein +FIG00731800 ribosomal-protein-alanine N-acetyltransferase +FIG00731803 FIG00731804: hypothetical protein +FIG00731804 ParB +FIG00731806 Pullulanase secretion protein pulS precursor +FIG00731808 FIG00731809: hypothetical protein +FIG00731809 FIG00731810: hypothetical protein +FIG00731814 putative heptosyl transferase +FIG00731816 FIG00731820: hypothetical protein +FIG00731821 hypothetical protein YjdJ +FIG00731824 Putative ion-channel protein +FIG00731827 FIG00731828: hypothetical protein +FIG00731828 FIG00731830: hypothetical protein +FIG00731830 FIG00731831: hypothetical protein +FIG00731831 Putative transport system permease protein +FIG00731833 FIG00731835: hypothetical protein +FIG00731845 FIG00731846: hypothetical protein +FIG00731850 COG2197: Response regulator containing a CheY-like receiver domain and an HTH DNA-binding domain +FIG00731854 FIG00731855: hypothetical protein +FIG00731855 FIG00731856: hypothetical protein +FIG00731863 FIG00731864: hypothetical protein +FIG00731872 FIG00731873: hypothetical protein +FIG00731877 FIG00731878: hypothetical protein +FIG00731878 FIG00731879: hypothetical protein +FIG00731879 FIG00731881: hypothetical protein +FIG00731881 FIG00731882: hypothetical protein +FIG00731882 Chloride channel protein +FIG00731883 putative lipoprotein +FIG00731884 FIG00731885: hypothetical protein +FIG00731888 FIG00731890: hypothetical protein +FIG00731890 FIG00731893: hypothetical protein +FIG00731899 FIG00731900: hypothetical protein +FIG00731905 FIG00731907: hypothetical protein +FIG00731912 FIG00731913: hypothetical protein +FIG00731913 FIG00731914: hypothetical protein +FIG00731915 Putative prophage membrane protein +FIG00731920 FIG00731921: hypothetical protein +FIG00731921 FIG00731922: hypothetical protein +FIG00731923 FIG00731924: hypothetical protein +FIG00731924 FIG00731925: hypothetical protein +FIG00731926 FIG00731927: hypothetical protein +FIG00731928 FIG00731929: hypothetical protein +FIG00731930 FIG00731931: hypothetical protein +FIG00731931 FIG00731934: hypothetical protein +FIG00731934 response regulator (activator) in two-component regulatory system wtih UhpB, regulates UhpT expression (LuxR/UhpA family) +FIG00731937 FIG00731938: hypothetical protein +FIG00731943 FIG00731944: hypothetical protein +FIG00731949 Lipoprotein spr precursor +FIG00731952 glutamine ABC transporter ATP-binding component +FIG00731955 FIG00731956: hypothetical protein +FIG00731963 FIG00731964: hypothetical protein +FIG00731970 putative bacterial extracellular solute-binding protein, family 3 +FIG00731971 FIG00731972: hypothetical protein +FIG00731972 FIG00731973: hypothetical protein +FIG00731978 major membrane protein I +FIG00731979 FIG00731982: hypothetical protein +FIG00731983 FIG00731984: hypothetical protein +FIG00731986 FIG00731987: hypothetical protein +FIG00731989 FIG00731992: hypothetical protein +FIG00731992 FIG00731993: hypothetical protein +FIG00731993 FIG00731994: hypothetical protein +FIG00731998 FIG00731999: hypothetical protein +FIG00731999 putative positive transcription regulator +FIG00732000 FIG00732001: hypothetical protein +FIG00732008 FIG00732010: hypothetical protein +FIG00732010 Protein nifM +FIG00732013 FIG00732015: hypothetical protein +FIG00732016 FIG00732017: hypothetical protein +FIG00732019 FIG00732020: hypothetical protein +FIG00732021 FIG00732023: hypothetical protein +FIG00732023 FIG00732024: hypothetical protein +FIG00732024 FIG00732026: hypothetical protein +FIG00732027 FIG00732030: hypothetical protein +FIG00732032 FIG00732033: hypothetical protein +FIG00732038 FIG00640199: hypothetical protein +FIG00732042 FIG00732043: hypothetical protein +FIG00732043 FIG00732044: hypothetical protein +FIG00732044 FIG00732047: hypothetical protein +FIG00732049 FIG00732050: hypothetical protein +FIG00732050 FIG00732052: hypothetical protein +FIG00732052 FIG00732053: hypothetical protein +FIG00732053 FIG00732054: hypothetical protein +FIG00732055 FIG00732056: hypothetical protein +FIG00732056 FIG00732057: hypothetical protein +FIG00732057 FIG00732058: hypothetical protein +FIG00732058 benzyl alcohol dehydrogenase +FIG00732061 FIG00732062: hypothetical protein +FIG00732069 probable fimbrial protein staA +FIG00732073 FIG00732074: hypothetical protein +FIG00732076 FIG00732077: hypothetical protein +FIG00732078 FIG00732079: hypothetical protein +FIG00732081 FIG00732082: hypothetical protein +FIG00732088 FIG00732091: hypothetical protein +FIG00732093 FIG00732094: hypothetical protein +FIG00732095 FIG00732096: hypothetical protein +FIG00732096 Fimbrial adhesin precursor +FIG00732097 FIG00732098: hypothetical protein +FIG00732098 FIG00732100: hypothetical protein +FIG00732100 FIG00732101: hypothetical protein +FIG00732105 FIG00732106: hypothetical protein +FIG00732113 FIG00732114: hypothetical protein +FIG00732116 Short-chain type dehydrogenase/reductase (EC 1.-.-.-) +FIG00732122 FIG00732123: hypothetical protein +FIG00732125 FIG00732126: hypothetical protein +FIG00732126 FIG00732127: hypothetical protein +FIG00732127 FIG00732131: hypothetical protein +FIG00732132 FIG00732133: hypothetical protein +FIG00732135 FIG00732137: hypothetical protein +FIG00732138 FIG00732141: hypothetical protein +FIG00732146 FIG00732147: hypothetical protein +FIG00732148 FIG00732149: hypothetical protein +FIG00732151 FIG00732152: hypothetical protein +FIG00732152 FIG00732153: hypothetical protein +FIG00732153 FIG00732154: hypothetical protein +FIG00732160 COG2879, Hypothetical small protein yjiX +FIG00732162 FIG00732163: hypothetical protein +FIG00732165 FIG00732166: hypothetical protein +FIG00732167 FIG00732168: hypothetical protein +FIG00732168 FIG00732169: hypothetical protein +FIG00732170 FIG00732171: hypothetical protein +FIG00732172 Antirestriction protein ArdA +FIG00732176 FIG00732177: hypothetical protein +FIG00732177 predicted glucosamine kinase (EC 2.7.1.8) +FIG00732180 regulatory protein, LacI:Periplasmic binding protein/LacI transcriptional regulator +FIG00732183 FIG00732185: hypothetical protein +FIG00732187 Osmotically inducible lipoprotein E precursor +FIG00732189 FIG00732191: hypothetical protein +FIG00732191 FIG00732192: hypothetical protein +FIG00732192 probable regulatory protein STY1856 +FIG00732193 FIG00732195: hypothetical protein +FIG00732195 FIG00732196: hypothetical protein +FIG00732197 Two-component response-regulatory protein YehT +FIG00732199 FIG00613381: hypothetical protein +FIG00732200 FIG00613710: hypothetical protein +FIG00732201 putative SN-glycerol-3-phosphate transport system permease +FIG00732203 FIG00732204: hypothetical protein +FIG00732204 FIG00905751: hypothetical protein +FIG00732206 FIG00732208: hypothetical protein +FIG00732208 Ribosomal protein S4 and related proteins +FIG00732216 FIG00732217: hypothetical protein +FIG00732217 FIG00732221: hypothetical protein +FIG00732221 FIG00732222: hypothetical protein +FIG00732222 FIG00732223: hypothetical protein +FIG00732223 FIG00732225: hypothetical protein +FIG00732225 Putative transmembrane sugar transport protein +FIG00732226 putative arginine/ornithine antiporter +FIG00732227 FIG00732228: hypothetical protein +FIG00732228 FIG00732228: membrane protein +FIG00732231 UPF0337 protein yjbJ +FIG00732236 acid phosphatase +FIG00732243 possible bacteriophage protein +FIG00732246 FIG00732247: hypothetical protein +FIG00732247 FIG00732248: hypothetical protein +FIG00732248 FIG00732252: hypothetical protein +FIG00732252 Sugar-binding protein precursor +FIG00732254 FIG00732255: hypothetical protein +FIG00732259 FIG00732260: hypothetical protein +FIG00732260 FIG00732261: hypothetical protein +FIG00732261 FIG00732263: hypothetical protein +FIG00732263 FIG00732264: hypothetical protein +FIG00732264 FIG00732265: hypothetical protein +FIG00732265 L(+)-tartrate dehydratase alpha subunit (EC 4.2.1.32) +FIG00732267 FIG00732269: hypothetical protein +FIG00732270 FIG00732272: hypothetical protein +FIG00732274 FIG00732276: hypothetical protein +FIG00732279 Thioredoxin 2 (EC 1.8.1.8) +FIG00732281 FIG00732282: hypothetical protein +FIG00732282 FIG00732284: hypothetical protein +FIG00732285 FIG00732287: hypothetical protein +FIG00732287 Putative acetyltransferase, (GNAT) family +FIG00732288 FIG00732290: hypothetical protein +FIG00732292 FIG00732293: hypothetical protein +FIG00732295 FIG00732296: hypothetical protein +FIG00732296 Protein yifE +FIG00732298 FIG00732299: hypothetical protein +FIG00732299 FIG00732300: hypothetical protein +FIG00732301 FIG00732302: hypothetical protein +FIG00732302 FIG00732303: hypothetical protein +FIG00732305 FIG00732307: hypothetical protein +FIG00732309 FIG01046209: inner membrane protein +FIG00732312 FIG00732313: hypothetical protein +FIG00732318 DNA gyrase inhibitory protein +FIG00732325 FIG00732327: hypothetical protein +FIG00732328 FIG00732331: hypothetical protein +FIG00732331 Putative fimbrial chaparone +FIG00732332 putative hok/gef cell toxic protein +FIG00732333 FIG00732337: hypothetical protein +FIG00732337 FIG00732338: hypothetical protein +FIG00732338 FIG00732339: hypothetical protein +FIG00732343 FIG00732344: hypothetical protein +FIG00732350 B12-dependent methionine synthase +FIG00732358 FIG00732359: hypothetical protein +FIG00732360 FIG00732361: hypothetical protein +FIG00732363 FIG00732364: hypothetical protein +FIG00732366 FIG00732368: hypothetical protein +FIG00732373 FIG00732374: hypothetical protein +FIG00732382 FIG00732383: hypothetical protein +FIG00732383 glucokinase +FIG00732388 FIG00732389: hypothetical protein +FIG00732391 FIG00732392: hypothetical protein +FIG00732392 Probable succinyl-diaminopimelate desuccinylase,DapE (EC 3.5.1.18) +FIG00732394 Protein nifT +FIG00732395 FIG00732396: hypothetical protein +FIG00732398 FIG00732400: hypothetical protein +FIG00732402 Protein ydcF +FIG00732403 FIG00732404: hypothetical protein +FIG00732404 FIG00732405: hypothetical protein +FIG00732405 FIG00732406: hypothetical protein +FIG00732413 FIG00732414: hypothetical protein +FIG00732414 FIG00732415: hypothetical protein +FIG00732415 FIG00732416: hypothetical protein +FIG00732420 FIG00732421: hypothetical protein +FIG00732426 FIG00732427: hypothetical protein +FIG00732427 Putative membrane transport protein +FIG00732430 FIG00732432: hypothetical protein +FIG00732433 FIG00732435: hypothetical protein +FIG00732435 FIG00732436: hypothetical protein +FIG00732438 alpha-dextrin endo-1,6-alpha-glucosidase precursor (pullulanase precursor) +FIG00732440 FIG00732441: hypothetical protein +FIG00732441 FIG00732443: hypothetical protein +FIG00732446 FIG00732447: hypothetical protein +FIG00732450 FIG00732451: hypothetical protein +FIG00732452 FIG00732453: hypothetical protein +FIG00732453 FIG00732454: hypothetical protein +FIG00732454 FIG00732456: hypothetical protein +FIG00732457 FIG00732459: hypothetical protein +FIG00732459 FIG00732460: hypothetical protein +FIG00732461 FIG00732462: hypothetical protein +FIG00732462 FIG00732463: hypothetical protein +FIG00732467 putative glutamine amidotransferase class-I +FIG00732468 FIG00732470: hypothetical protein +FIG00732472 FIG00732473: hypothetical protein +FIG00732475 FIG00732477: hypothetical protein +FIG00732483 FIG00732486: hypothetical protein +FIG00732486 FIG00732487: hypothetical protein +FIG00732498 FIG00732501: hypothetical protein +FIG00732502 Phosphosugar-binding transcriptional regulator, RpiR family +FIG00732511 FIG00732512: hypothetical protein +FIG00732517 FIG00732518: hypothetical protein +FIG00732523 FIG00732525: hypothetical protein +FIG00732525 FIG00732527: hypothetical protein +FIG00732528 FIG00732530: hypothetical protein +FIG00732530 FIG00732534: hypothetical protein +FIG00732538 FIG00732539: hypothetical protein +FIG00732539 Ribosomal protein S3 +FIG00732543 FIG00732545: hypothetical protein +FIG00732549 FIG00732551: hypothetical protein +FIG00732551 FIG00732552: hypothetical protein +FIG00732557 FIG00732558: hypothetical protein +FIG00732561 FIG00732562: hypothetical protein +FIG00732566 FIG00732567: hypothetical protein +FIG00732567 FIG00732568: hypothetical protein +FIG00732568 FIG00732572: hypothetical protein +FIG00732573 FIG00732574: hypothetical protein +FIG00732575 FIG00732578: hypothetical protein +FIG00732586 FIG00732589: hypothetical protein +FIG00732591 PTS family enzyme IIBC component, cellobiose/salicin/arbutin-specific +FIG00732594 FIG00732595: hypothetical protein +FIG00732600 FIG00732601: hypothetical protein +FIG00732601 FIG00732604: hypothetical protein +FIG00732607 Glucokinase regulatory protein +FIG00732610 FIG00732612: hypothetical protein +FIG00732612 FIG00732614: hypothetical protein +FIG00732616 FIG00732617: hypothetical protein +FIG00732618 FIG00732620: hypothetical protein +FIG00732620 FIG00732621: hypothetical protein +FIG00732626 FIG00732630: hypothetical protein +FIG00732630 FIG00732633: hypothetical protein +FIG00732637 phytanoyl-CoA dioxygenase family protein +FIG00732644 putative transcriptional regulator (LysR familiy) +FIG00732648 FIG00732649: hypothetical protein +FIG00732650 FIG00732651: hypothetical protein +FIG00732651 FIG00732652: hypothetical protein +FIG00732652 FIG00732653: hypothetical protein +FIG00732653 FIG00732654: hypothetical protein +FIG00732655 FIG00732657: hypothetical protein +FIG00732673 FIG00732674: hypothetical protein +FIG00732674 Possible membrane transport protein +FIG00732675 putative dTDP-glucose pyrophosphorylase +FIG00732676 FIG00732678: hypothetical protein +FIG00732680 FIG00732681: hypothetical protein +FIG00732687 virulence regulating protein +FIG00732689 FIG00732693: hypothetical protein +FIG00732697 FIG00732699: hypothetical protein +FIG00732704 PsiB protein +FIG00732710 FIG00732711: hypothetical protein +FIG00732712 FIG00732714: hypothetical protein +FIG00732714 FIG00732716: hypothetical protein +FIG00732718 probable phosphoglycerate mutase +FIG00732720 FIG00732721: hypothetical protein +FIG00732726 FIG00732730: hypothetical protein +FIG00732733 Anion permease ArsB/NhaD-like +FIG00732735 FIG00732736: hypothetical protein +FIG00732736 FIG00732737: hypothetical protein +FIG00732737 FIG00732740: hypothetical protein +FIG00732742 Glucosamine ABC transport system, permease protein 1 +FIG00732750 FIG00732756: hypothetical protein +FIG00732760 FIG00732763: hypothetical protein +FIG00732763 Transcriptional regulator PobR, AraC family +FIG00732768 PsiA protein +FIG00732773 Uncharacterized protein ylaB +FIG00732776 FIG00732777: hypothetical protein +FIG00732785 FIG00732786: hypothetical protein +FIG00732786 FIG00732788: hypothetical protein +FIG00732788 FIG00732789: hypothetical protein +FIG00732789 FIG00732790: hypothetical protein +FIG00732794 FIG00732796: hypothetical protein +FIG00732799 FIG00732802: hypothetical protein +FIG00732807 FIG01220476: hypothetical protein +FIG00732808 FIG00732809: hypothetical protein +FIG00732818 FIG00732820: hypothetical protein +FIG00732824 FIG00732825: hypothetical protein +FIG00732825 FIG00732826: hypothetical protein +FIG00732830 Gifsy-2 prophage RecT +FIG00732834 FIG00732835: hypothetical protein +FIG00732839 FIG00732840: hypothetical protein +FIG00732845 COG0438: Glycosyltransferase +FIG00732848 FIG00732849: hypothetical protein +FIG00732850 FIG00732852: hypothetical protein +FIG00732852 FIG00732856: hypothetical protein +FIG00732863 FIG00732864: hypothetical protein +FIG00732877 FIG00732879: hypothetical protein +FIG00732879 FIG00732883: hypothetical protein +FIG00732887 FIG00732888: hypothetical protein +FIG00732889 FIG00732890: hypothetical protein +FIG00732890 FIG00732893: hypothetical protein +FIG00732893 Inner membrane protein YiaA +FIG00732894 FIG00732896: hypothetical protein +FIG00732898 FIG00732902: hypothetical protein +FIG00732902 FIG00732904: hypothetical protein +FIG00732913 FIG00732914: hypothetical protein +FIG00732915 FIG00732917: hypothetical protein +FIG00732918 Putative uncharacterized protein yjeJ +FIG00732919 FIG00732920: hypothetical protein +FIG00732920 FIG00732921: hypothetical protein +FIG00732921 FIG00732922: hypothetical protein +FIG00732922 FIG00732925: hypothetical protein +FIG00732925 FIG00732927: hypothetical protein +FIG00732928 AsmA protein +FIG00732937 FIG00732938: hypothetical protein +FIG00732938 FIG00732940: hypothetical protein +FIG00732948 FIG00732949: hypothetical protein +FIG00732949 FIG00732951: hypothetical protein +FIG00732951 FIG00732952: hypothetical protein +FIG00732952 FIG00732954: hypothetical protein +FIG00732957 FIG00732958: hypothetical protein +FIG00732963 FIG00732965: hypothetical protein +FIG00732965 Tail component protein (Fragment) +FIG00732974 Succinate dehydrogenase/fumarate reductase, flavoprotein subunit +FIG00732982 FIG00732983: hypothetical protein +FIG00732983 FIG00732985: hypothetical protein +FIG00732985 FIG00732987: hypothetical protein +FIG00732991 FIG00732992: hypothetical protein +FIG00732997 FIG00732998: hypothetical protein +FIG00733001 FIG00733003: hypothetical protein +FIG00733007 FIG00733009: hypothetical protein +FIG00733009 Putative LacI-family transcriptional regulatory protein +FIG00733014 pentachlorophenol-4-monooxygenase +FIG00733021 FIG00733022: hypothetical protein +FIG00733022 FIG00733024: hypothetical protein +FIG00733029 COG3326: Predicted membrane protein +FIG00733034 hypothetical protein; Some similarities with a protein of bacteriophage +FIG00733037 FIG00733039: hypothetical protein +FIG00733039 FIG00733042: hypothetical protein +FIG00733044 FIG00733046: hypothetical protein +FIG00733059 FIG00733061: hypothetical protein +FIG00733069 2-component transcriptional regulator +FIG00733087 FIG00733090: hypothetical protein +FIG00733090 Demethylmenaquinone methyltransferase +FIG00733108 FIG00733109: hypothetical protein +FIG00733112 FIG00733113: hypothetical protein +FIG00733113 FIG00733115: hypothetical protein +FIG00733115 FIG00733124: hypothetical protein +FIG00733131 Putative 2-ketogluconate transporter, ACS family-MFS superfamily +FIG00733136 YbjA protein +FIG00733143 FIG00733146: hypothetical protein +FIG00733262 spoU rRNA methylase family protein +FIG00733317 FIG00733321: hypothetical protein +FIG00733444 FIG00733477: hypothetical protein +FIG00733550 putative beta-ketoadipyl CoA thiolase( EC:2.3.1.9 ) +FIG00733558 FIG00733565: hypothetical protein +FIG00733565 FIG00733570: hypothetical protein +FIG00733596 FIG00733622: hypothetical protein +FIG00733802 DNA modification methyltransferase +FIG00733926 FIG00733946: hypothetical protein +FIG00734008 ABC metal ion transporter, substrate-binding protein +FIG00734096 FIG00734100: hypothetical protein +FIG00734100 hypothetical protein possibly connected to lactam utilization and allophanate hydrolase +FIG00734245 FIG00734251: hypothetical protein +FIG00734394 FIG00734405: hypothetical protein +FIG00734431 FIG00734513: hypothetical protein +FIG00734530 FIG00734559: hypothetical protein +FIG00734590 putative extracellular solute-binding lipoprotein +FIG00734853 FIG00734892: hypothetical protein +FIG00735262 FIG187021: hypothetical protein +FIG00735373 FIG00735391: hypothetical protein +FIG00735433 ABC transporter, transmembrane region +FIG00735573 SnoK-like protein +FIG00735574 FIG00735598: hypothetical protein +FIG00736192 putative conserved domain protein +FIG00736249 FIG00736250: hypothetical protein +FIG00736633 FIG00736640: hypothetical protein +FIG00736861 Oxidoreductase homolog +FIG00737211 Putative stomatin/prohibitin-family membrane protease subunit PA4582 +FIG00737588 NrdB +FIG00737678 Aminoglycoside N(3')-acetyltransferase VIII (EC 2.3.1.81) (ACC(3)-VIII) (Aminocyclitol 3-N-acetyltransferase type VIII) +FIG00737808 NADH-dependent dyhydrogenase +FIG00738098 FIG00738105: hypothetical protein +FIG00738308 putative lysR-type transcriptional regulator +FIG00738357 peptidase, alpha-lytic pro domain +FIG00738416 putative membrane associated protein +FIG00738617 putative glutamate uptake system ATP-binding protein +FIG00738693 Transcriptional regulator, MarR family / Acetyltransferase (GNAT) +FIG00738850 FIG00738851: hypothetical protein +FIG00738963 ALPHA-MANNOSIDASE (EC 3.2.1.-) +FIG00739080 cytidine/deoxycytidine deaminase +FIG00739191 Trehalose utilization protein +FIG00739242 dipeptide ABC transporter, permease protein +FIG00739381 Zinc-containing alcohol dehydrogenase superfamily +FIG00739422 FIG00739434: hypothetical protein +FIG00739478 putative binding-protein-dependent integral membrane transport protein +FIG00739522 putative two-component system histidine kinase +FIG00739596 Haloalkane dehalogenase-like protein / AMP-dependent synthetase/ligase in alkane synthesis cluster +FIG00739721 Cell division protein FtsQ +FIG00740014 FIG00740029: hypothetical protein +FIG00740058 Membrane alanine aminopeptidase (EC 3.4.11.2) +FIG00740131 protein-N(pi)-phosphohistidine--sugar phosphotransferase( EC:2.7.1.69 ) +FIG00740240 FIG00740262: hypothetical protein +FIG00740311 FIG00740319: hypothetical protein +FIG00740441 Mpr protein +FIG00740538 FIG00740541: hypothetical protein +FIG00740644 beta-phosphoglucomutase family hydrolase +FIG00740750 FIG00740755: hypothetical protein +FIG00740872 FIG00740874: hypothetical protein +FIG00740882 FIG00740884: hypothetical protein +FIG00740898 Pterin-binding enzyme domain protein +FIG00740900 FIG00740902: hypothetical protein +FIG00740902 FIG00740903: hypothetical protein +FIG00740903 FIG00740906: hypothetical protein +FIG00740913 FIG00740914: hypothetical protein +FIG00740930 FIG00740931: hypothetical protein +FIG00740931 FIG00740933: hypothetical protein +FIG00740942 FIG00740943: hypothetical protein +FIG00740959 FIG00740960: hypothetical protein +FIG00740963 FOG: TPR repeat, SEL1 subfamily +FIG00740966 FIG00740968: hypothetical protein +FIG00740968 FIG00740969: hypothetical protein +FIG00740976 FIG00364969: hypothetical protein +FIG00740987 FIG00740988: hypothetical protein +FIG00740988 FIG00740989: hypothetical protein +FIG00740989 FIG00740990: hypothetical protein +FIG00741012 FIG00741013: hypothetical protein +FIG00741015 putative Omp2b porin +FIG00741075 FIG00741077: hypothetical protein +FIG00741081 Putative dihydroneopterin aldolase protein (EC 4.1.2.25) +FIG00741087 FIG00741089: hypothetical protein +FIG00741089 putative adenylate/guanylate cyclase +FIG00741101 FIG00741102: hypothetical protein +FIG00741102 phosphoesterase, PA-phosphatase related protein +FIG00741118 ABC-type branched-chain amino acid transport systems, periplasmic component +FIG00741143 FIG00741144: hypothetical protein +FIG00741147 FIG00741148: hypothetical protein +FIG00741155 FIG00741159: hypothetical protein +FIG00741161 FIG00741163: hypothetical protein +FIG00741163 FIG00741165: hypothetical protein +FIG00741169 ATP-dependent DNA ligase( EC:6.5.1.1 ) +FIG00741170 putative flagellar protein FlaF +FIG00741172 FIG00741174: hypothetical protein +FIG00741178 FIG00741180: hypothetical protein +FIG00741185 NADH dehydrogenase subunit H( EC:1.6.5.3 ) +FIG00741198 FIG00741200: hypothetical protein +FIG00741211 FIG00741212: hypothetical protein +FIG00741215 FIG00741216: hypothetical protein +FIG00741223 FIG00741226: hypothetical protein +FIG00741234 GGDEF/PAS/PAC-domain containing protein +FIG00741238 FIG00741239: hypothetical protein +FIG00741240 FIG00741241: hypothetical protein +FIG00741244 transcriptional regulator, LyrR family +FIG00741262 FIG00741264: hypothetical protein +FIG00741268 FIG00741269: hypothetical protein +FIG00741273 WD-repeat family protein +FIG00741276 ATP-DEPENDENT PROTEASE SUBUNIT +FIG00741286 FIG00741288: hypothetical protein +FIG00741292 FIG00741296: hypothetical protein +FIG00741296 FIG00741297: hypothetical protein +FIG00741301 FIG00741302: hypothetical protein +FIG00741303 FIG00741304: hypothetical protein +FIG00741304 FIG00741305: hypothetical protein +FIG00741335 FIG00741336: hypothetical protein +FIG00741349 putative endo alpha-1,4 polygalactosaminidase +FIG00741351 FIG00741352: hypothetical protein +FIG00741352 FIG00741354: hypothetical protein +FIG00741358 FIG00741359: hypothetical protein +FIG00741360 Flagellar basal-body rod modification protein FlgD +FIG00741384 FIG00741385: hypothetical protein +FIG00741385 FxsA +FIG00741391 FIG00741393: hypothetical protein +FIG00741396 Bmp family protein +FIG00741402 FIG00741405: hypothetical protein +FIG00741406 FIG00741407: hypothetical protein +FIG00741408 tRNA proofreading protein STM4549 +FIG00741411 Serine/threonine phosphatase PPP (EC 3.1.3.16) +FIG00741423 FIG026291: Hypothetical protein +FIG00741436 FIG00741437: hypothetical protein +FIG00741438 hypothetical permease protein +FIG00741442 FIG00741444: hypothetical protein +FIG00741444 FIG00741446: hypothetical protein +FIG00741454 FIG00741455: hypothetical protein +FIG00741460 cytochrome C oxidase assembly protein +FIG00741466 FIG00741468: hypothetical protein +FIG00741474 4-hydroxy-3-methylbut-2-en-1-yl diphosphate synthase( EC:1.17.4.3 ) +FIG00741477 FIG00741478: hypothetical protein +FIG00741482 transcriptional regulator marR/emrR family protein +FIG00741508 Flagellar protein FlaF +FIG00741533 FIG00741534: hypothetical protein +FIG00741534 Gamma-butyrobetaine,2-oxoglutarate dioxygenase +FIG00741540 FIG00989085: hypothetical protein +FIG00741541 Benzoate transport related protein +FIG00741568 FIG00741570: hypothetical protein +FIG00741570 Holliday junction DNA helicase motor protein +FIG00741588 FIG002577: Putative lipoprotein +FIG00741592 FIG00741594: hypothetical protein +FIG00741598 FIG00741599: hypothetical protein +FIG00741604 putative bactoprenol-linked glucose translocase +FIG00741651 FIG00741652: hypothetical protein +FIG00741665 FIG00741667: hypothetical protein +FIG00741672 FIG00741674: hypothetical protein +FIG00741693 Pca operon transcriptional activator PcaQ +FIG00741702 FIG00741706: hypothetical protein +FIG00741719 FIG00741723: hypothetical protein +FIG00741729 FIG00741730: hypothetical protein +FIG00741735 FIG00741736: hypothetical protein +FIG00741742 FIG00741743: hypothetical protein +FIG00741745 FIG00741746: hypothetical protein +FIG00741753 FIG00741757: hypothetical protein +FIG00741757 FIG00741758: hypothetical protein +FIG00741760 Bacterial regulatory protein LacI, HTH motif:Periplasmic binding protein/LacI transcriptional regulator +FIG00741762 FIG00741763: hypothetical protein +FIG00741794 FIG00741795: hypothetical protein +FIG00741796 FIG00741799: hypothetical protein +FIG00741803 FIG00741804: hypothetical protein +FIG00741821 putative RhtB family transporter, amino acid efflux +FIG00741824 FIG00741826: hypothetical protein +FIG00741826 FIG00741827: hypothetical protein +FIG00741828 FIG00741830: hypothetical protein +FIG00741830 FIG00741832: hypothetical protein +FIG00741835 FIG00794223: hypothetical protein +FIG00741846 Protein YBIS precursor +FIG00741849 FIG00741850: hypothetical protein +FIG00741855 FIG00741858: hypothetical protein +FIG00741863 FIG00741864: hypothetical protein +FIG00741867 Radical SAM domain protein +FIG00741870 Phasin 2 +FIG00741898 FIG00741899: hypothetical protein +FIG00741899 FIG00741900: hypothetical protein +FIG00741922 FIG00741923: hypothetical protein +FIG00741926 putative small integral membrane tranport protein +FIG00741932 FIG00741933: hypothetical protein +FIG00741937 FIG00741938: hypothetical protein +FIG00741938 FIG00741939: hypothetical protein +FIG00741945 FIG00741946: hypothetical protein +FIG00741954 FIG00741955: hypothetical protein +FIG00741964 FIG00741965: hypothetical protein +FIG00741967 FIG00741968: hypothetical protein +FIG00741971 FIG00741973: hypothetical protein +FIG00742002 FIG00742003: hypothetical protein +FIG00742004 FIG00742005: hypothetical protein +FIG00742013 FIG00742015: hypothetical protein +FIG00742017 Oxidoreductase, N-terminal +FIG00742020 FIG00742021: hypothetical protein +FIG00742030 FIG00742031: hypothetical protein +FIG00742031 FIG00742032: hypothetical protein +FIG00742033 FIG00742034: hypothetical protein +FIG00742038 Predicted NAD regulator in Alphaproteobacteria +FIG00742042 FIG00742043: hypothetical protein +FIG00742044 FIG00742045: hypothetical protein +FIG00742061 FIG00742062: hypothetical protein +FIG00742063 FIG00742064: hypothetical protein +FIG00742067 FIG00742068: hypothetical protein +FIG00742068 FIG00742069: hypothetical protein +FIG00742071 FIG00742075: hypothetical protein +FIG00742076 FIG00742077: hypothetical protein +FIG00742077 FIG00742078: hypothetical protein +FIG00742081 FIG00742082: hypothetical protein +FIG00742082 FIG00742084: hypothetical protein +FIG00742084 FIG00742086: hypothetical protein +FIG00742086 FIG00742087: hypothetical protein +FIG00742091 FIG00742093: hypothetical protein +FIG00742093 FIG00742095: hypothetical protein +FIG00742095 Beta-glucosidase (EC 3.2.1.86) +FIG00742100 Hypohetical Teichoic Acid Biosynthesis Protein +FIG00742101 FIG00742102: hypothetical protein +FIG00742110 FIG00742111: hypothetical protein +FIG00742114 surface protein, aggregation promoting factor +FIG00742115 FIG00742116: hypothetical protein +FIG00742118 Bacteriocin immunity protein (putative), membrane-bound protease CAAX family +FIG00742119 contains zinc protease domain +FIG00742123 FIG00742124: hypothetical protein +FIG00742124 DNA polymerase III, alpha subunit (gram-positive type) +FIG00742125 phosphoenolpyruvate-dependent sugar phosphotransferase system EIIC, probable cellobiose specific +FIG00742130 FIG00742131: hypothetical protein +FIG00742131 FIG00742132: hypothetical protein +FIG00742133 FIG00742134: hypothetical protein +FIG00742134 FIG00742136: hypothetical protein +FIG00742137 Integral membrane protein, interacts with FtsH +FIG00742138 FIG00742139: hypothetical protein +FIG00742139 FIG00742140: hypothetical protein +FIG00742143 FIG00742144: hypothetical protein +FIG00742146 FIG00742147: hypothetical protein +FIG00742148 HigB toxin protein +FIG00742152 FIG00742153: hypothetical protein +FIG00742157 FIG00742159: hypothetical protein +FIG00742159 FIG00742160: hypothetical protein +FIG00742160 FIG00742161: hypothetical protein +FIG00742161 Di- and tricarboxylate transporters +FIG00742162 FIG00742167: hypothetical protein +FIG00742170 FIG00742171: hypothetical protein +FIG00742171 Protein tyrosine/serine phosphatase +FIG00742173 FIG00742174: hypothetical protein +FIG00742174 FIG00742177: hypothetical protein +FIG00742178 FIG00742179: hypothetical protein +FIG00742181 acetyltransferases (the isoleucine patch superfamily)( EC:2.3.1.18 ) +FIG00742183 FIG00742184: hypothetical protein +FIG00742185 FIG00742186: hypothetical protein +FIG00742186 FIG00742187: hypothetical protein +FIG00742187 FIG00742188: hypothetical protein +FIG00742188 FIG00742189: hypothetical protein +FIG00742189 FIG00742190: hypothetical protein +FIG00742191 FIG00742193: hypothetical protein +FIG00742197 FIG00742198: hypothetical protein +FIG00742198 FIG00742199: hypothetical protein +FIG00742199 FIG00742200: hypothetical protein +FIG00742200 FIG00742203: hypothetical protein +FIG00742204 FIG00742207: hypothetical protein +FIG00742207 FIG00742210: hypothetical protein +FIG00742211 Unspecified monosaccharide ABC transport system, permease component I +FIG00742212 FIG00742213: hypothetical protein +FIG00742213 FIG00742214: hypothetical protein +FIG00742214 FIG00742215: hypothetical protein +FIG00742215 FIG00742216: hypothetical protein +FIG00742216 FIG00742219: hypothetical protein +FIG00742221 FIG00742223: hypothetical protein +FIG00742223 FIG00742225: hypothetical protein +FIG00742225 FIG00742226: hypothetical protein +FIG00742227 probably aromatic ring hydroxylating enzyme, evidenced by COGnitor ; PaaD-like protein involved in Fe-S cluster assembly +FIG00742231 Transcriptional regulator, xre family +FIG00742232 FIG00742233: hypothetical protein +FIG00742233 protein TrsC +FIG00742236 phage capsid protein +FIG00742237 FIG00742239: hypothetical protein +FIG00742239 FIG00742240: hypothetical protein +FIG00742240 FIG00742241: hypothetical protein +FIG00742241 FIG00742242: hypothetical protein +FIG00742246 FIG00742248: hypothetical protein +FIG00742248 FIG00742249: hypothetical protein +FIG00742250 FIG00742251: hypothetical protein +FIG00742251 FIG00906412: hypothetical protein +FIG00742252 FIG008111: hypothetical protein +FIG00742253 Hypothetical protein SAV1845 +FIG00742255 FIG00742257: hypothetical protein +FIG00742257 FIG00742258: hypothetical protein +FIG00742259 Dipeptidase +FIG00742262 FIG00742263: hypothetical protein +FIG00742266 Bacteriocin helveticin +FIG00742269 FIG00742274: hypothetical protein +FIG00742274 FIG00742275: hypothetical protein +FIG00742284 ABC-type amino acid transport/signal transduction system, periplasmic component/domain +FIG00742287 FIG00742290: hypothetical protein +FIG00742290 FIG00742292: hypothetical protein +FIG00742292 FIG00742293: hypothetical protein +FIG00742293 FIG00742294: hypothetical protein +FIG00742294 FIG00742295: hypothetical protein +FIG00742295 FIG00742296: hypothetical protein +FIG00742298 FIG00742299: hypothetical protein +FIG00742299 FIG00742300: hypothetical protein +FIG00742300 FIG00742301: hypothetical protein +FIG00742301 contains bacterial regulatory deoR domain +FIG00742302 FIG00742306: hypothetical protein +FIG00742306 FIG00742307: hypothetical protein +FIG00742307 FIG00742308: hypothetical protein +FIG00742309 FIG00742311: hypothetical protein +FIG00742312 FIG00742314: hypothetical protein +FIG00742315 FIG00742317: hypothetical protein +FIG00742317 FIG00742318: hypothetical protein +FIG00742318 contains predicted phosphohydrolase domain +FIG00742321 serine/threonine protein kinase( EC:2.7.1.- ) +FIG00742326 FIG00742327: hypothetical protein +FIG00742327 Filamentation induced by cAMP protein Fic +FIG00742329 FIG00742330: hypothetical protein +FIG00742330 Phospholipase A2 family enzyme +FIG00742331 FIG00742332: hypothetical protein +FIG00742332 FIG00742334: hypothetical protein +FIG00742336 FIG00742339: hypothetical protein +FIG00742339 FIG00742340: hypothetical protein +FIG00742340 FIG00742345: hypothetical protein +FIG00742345 sugar specific permease (putative) +FIG00742352 FIG00742355: hypothetical protein +FIG00742355 FIG00742356: hypothetical protein +FIG00742357 FIG00742358: hypothetical protein +FIG00742358 Galactofuranose transferase +FIG00742359 FIG00742360: hypothetical protein +FIG00742360 FIG00742361: hypothetical protein +FIG00742361 FIG00742364: hypothetical protein +FIG00742364 FIG00742365: hypothetical protein +FIG00742370 Major facilitator superfamily permease +FIG00742371 FIG00742372: hypothetical protein +FIG00742377 FIG00742380: hypothetical protein +FIG00742380 FIG00742383: hypothetical protein +FIG00742386 FIG00742387: hypothetical protein +FIG00742387 FIG00742388: hypothetical protein +FIG00742389 FIG00742390: hypothetical protein +FIG00742391 FIG00742392: hypothetical protein +FIG00742392 FIG00742393: hypothetical protein +FIG00742393 FIG00742395: hypothetical protein +FIG00742395 FIG00742396: hypothetical protein +FIG00742397 FIG00742398: hypothetical protein +FIG00742398 FIG00742399: hypothetical protein +FIG00742399 Methylase for ubiquinone/menaquinone biosynthesis +FIG00742400 amino acid ABC transporter, ATP-binding protein +FIG00742401 FIG00742402: hypothetical protein +FIG00742406 FIG00742408: hypothetical protein +FIG00742409 FIG00742411: hypothetical protein +FIG00742411 FIG00742412: hypothetical protein +FIG00742416 FIG00742417: hypothetical protein +FIG00742423 FIG00742424: hypothetical protein +FIG00742424 FIG00742425: hypothetical protein +FIG00742426 solo B3/4 domain (OB-fold DNA/RNA-binding) of Phe-aaRS-beta +FIG00742431 FIG00742432: hypothetical protein +FIG00742432 FIG00742435: hypothetical protein +FIG00742435 FIG00742438: hypothetical protein +FIG00742438 FIG00742439: hypothetical protein +FIG00742444 FIG00742445: hypothetical protein +FIG00742445 FIG00742449: hypothetical protein +FIG00742457 FIG00742458: hypothetical protein +FIG00742459 FIG00742462: hypothetical protein +FIG00742463 FIG00742465: hypothetical protein +FIG00742468 protein TrsE +FIG00742474 FIG00742475: hypothetical protein +FIG00742480 FIG00742481: hypothetical protein +FIG00742481 hypothetical protein +FIG00742482 FIG00742483: hypothetical protein +FIG00742484 primosome, DnaD subunit +FIG00742487 Sugar kinase, ribokinase family +FIG00742488 putative steroid binding protein +FIG00742490 FIG00742491: hypothetical protein +FIG00742491 FIG00742493: hypothetical protein +FIG00742493 FIG00742494: hypothetical protein +FIG00742506 FIG00742507: hypothetical protein +FIG00742509 FIG00742510: hypothetical protein +FIG00742510 FIG00742511: hypothetical protein +FIG00742514 Small conserved protein +FIG00742515 putative mutator protein( EC:3.6.1.- ) +FIG00742518 FIG00742519: hypothetical protein +FIG00742519 FIG00742521: hypothetical protein +FIG00742521 FIG00742522: hypothetical protein +FIG00742522 FIG00742524: hypothetical protein +FIG00742525 thermostable pullulanase( EC:3.2.1.41 ) +FIG00742526 metallophosphoesterase +FIG00742528 FIG00742529: hypothetical protein +FIG00742531 FIG00742532: hypothetical protein +FIG00742532 ribonuclease H-related protein +FIG00742534 FIG00742537: hypothetical protein +FIG00742538 FIG00742539: hypothetical protein +FIG00742541 FIG00742542: hypothetical protein +FIG00742542 FIG00742546: hypothetical protein +FIG00742546 FIG00742549: hypothetical protein +FIG00742550 FIG00742553: hypothetical protein +FIG00742553 Double-stranded beta-helix related protein +FIG00742555 FIG00742556: hypothetical protein +FIG00742556 FIG00742558: hypothetical protein +FIG00742563 FIG00742565: hypothetical protein +FIG00742565 ABC transporter, ATP-binding/permease protein, putative +FIG00742567 FIG00742568: hypothetical protein +FIG00742568 FIG00742569: hypothetical protein +FIG00742569 FIG00627979: hypothetical protein +FIG00742571 FIG00742573: hypothetical protein +FIG00742576 FIG00742580: hypothetical protein +FIG00742585 FIG00742586: hypothetical protein +FIG00742588 FIG00742589: hypothetical protein +FIG00742590 FIG00742591: hypothetical protein +FIG00742598 FIG00742602: hypothetical protein +FIG00742602 FIG00742603: hypothetical protein +FIG00742603 FIG00742604: hypothetical protein +FIG00742605 FIG00742606: hypothetical protein +FIG00742606 FIG00742610: hypothetical protein +FIG00742619 FIG00742620: hypothetical protein +FIG00742620 2-oxoglutarate-malate translocator +FIG00742624 tagatose-6-phosphate kinase +FIG00742626 FIG00742627: hypothetical protein +FIG00742627 FIG00742628: hypothetical protein +FIG00742628 FIG00742629: hypothetical protein +FIG00742633 FIG00742634: hypothetical protein +FIG00742634 FIG00742636: hypothetical protein +FIG00742638 FIG00742639: hypothetical protein +FIG00742639 FIG00742643: hypothetical protein +FIG00742643 FIG00742645: hypothetical protein +FIG00742647 FIG00742648: hypothetical protein +FIG00742648 FIG00742649: hypothetical protein +FIG00742651 FIG00742652: hypothetical protein +FIG00742655 FIG00742656: hypothetical protein +FIG00742661 FIG00742662: hypothetical protein +FIG00742662 FIG00742663: hypothetical protein +FIG00742663 lipase/esterase (putative) +FIG00742670 FIG00742671: hypothetical protein +FIG00742671 FIG00742672: hypothetical protein +FIG00742672 FIG00742673: hypothetical protein +FIG00742675 putative head-tail joining protein +FIG00742678 FIG00742679: hypothetical protein +FIG00742681 NADH oxidase( EC:1.6.99.- ) +FIG00742682 FIG00742683: hypothetical protein +FIG00742684 FIG00742685: hypothetical protein +FIG00742685 FIG00742691: hypothetical protein +FIG00742691 FIG00742692: hypothetical protein +FIG00742692 FIG00742693: hypothetical protein +FIG00742693 FIG00742694: hypothetical protein +FIG00742697 FIG00742699: hypothetical protein +FIG00742699 FIG00742701: hypothetical protein +FIG00742701 FIG00742702: hypothetical protein +FIG00742707 putative arsenate reductase +FIG00742708 FIG00742710: hypothetical protein +FIG00742710 FIG00742711: hypothetical protein +FIG00742711 FIG00742714: hypothetical protein +FIG00742715 FIG00742716: hypothetical protein +FIG00742716 Anthranilate synthase, amidotransferase component like (EC 4.1.3.27) +FIG00742717 FIG00742719: hypothetical protein +FIG00742719 FIG00742720: hypothetical protein +FIG00742720 FIG00742723: hypothetical protein +FIG00742723 FIG00742724: hypothetical protein +FIG00742724 FIG00742725: hypothetical protein +FIG00742729 FIG00742731: hypothetical protein +FIG00742731 FIG00742732: hypothetical protein +FIG00742733 FIG00742734: hypothetical protein +FIG00742737 FIG00742738: hypothetical protein +FIG00742739 FIG00742741: hypothetical protein +FIG00742744 Hypothetical extracellular lipase/esterase precursor +FIG00742754 immunity protein PlnP, membrane-bound protease CAAX family +FIG00742756 FIG00742757: hypothetical protein +FIG00742757 FIG00742758: hypothetical protein +FIG00742758 FIG00742759: hypothetical protein +FIG00742759 FIG00742761: hypothetical protein +FIG00742761 FIG00742762: hypothetical protein +FIG00742768 FIG00742770: hypothetical protein +FIG00742770 FIG00742771: hypothetical protein +FIG00742771 FIG00742772: hypothetical protein +FIG00742772 FIG00742774: hypothetical protein +FIG00742774 FIG00742775: hypothetical protein +FIG00742776 FIG00742777: hypothetical protein +FIG00742777 FIG00742779: hypothetical protein +FIG00742780 FIG00742782: hypothetical protein +FIG00742783 FIG00742784: hypothetical protein +FIG00742785 FIG00742787: hypothetical protein +FIG00742790 FIG00742792: hypothetical protein +FIG00742793 FIG00742796: hypothetical protein +FIG00742797 FIG00742798: hypothetical protein +FIG00742798 FIG00742800: hypothetical protein +FIG00742800 FIG00742801: hypothetical protein +FIG00742803 FIG00742804: hypothetical protein +FIG00742804 contains glycosyl transferase family 8 domain +FIG00742805 FIG00742807: hypothetical protein +FIG00742807 FIG00742808: hypothetical protein +FIG00742809 FIG00742810: hypothetical protein +FIG00742810 FIG00742813: hypothetical protein +FIG00742813 FIG00742814: hypothetical protein +FIG00742814 FIG00742815: hypothetical protein +FIG00742816 FIG00742817: hypothetical protein +FIG00742818 FIG00742820: hypothetical protein +FIG00742824 FIG00742825: hypothetical protein +FIG00742826 FIG00742827: hypothetical protein +FIG00742831 FIG00742833: hypothetical protein +FIG00742833 FIG00742834: hypothetical protein +FIG00742836 NUDIX family hydrolase +FIG00742843 FIG00742846: hypothetical protein +FIG00742846 FIG00742847: hypothetical protein +FIG00742847 FIG00742849: hypothetical protein +FIG00742854 negative regulator of proteolysis +FIG00742856 FIG00742857: hypothetical protein +FIG00742857 FIG00742859: hypothetical protein +FIG00742860 FIG00742864: hypothetical protein +FIG00742864 Pyridoxine 5'-phosphate oxidase V related favin-nucleotide-binding protein +FIG00742872 FIG00742875: hypothetical protein +FIG00742875 FIG00742876: hypothetical protein +FIG00742876 FIG00742877: hypothetical protein +FIG00742877 DNA polymerase( EC:2.7.7.7 ) +FIG00742879 FIG00742880: hypothetical protein +FIG00742881 FIG00742882: hypothetical protein +FIG00742882 FIG00742885: hypothetical protein +FIG00742886 FIG00742887: hypothetical protein +FIG00742887 FIG00742888: hypothetical protein +FIG00742888 FIG00742891: hypothetical protein +FIG00742891 FIG00742892: hypothetical protein +FIG00742896 FIG00742897: hypothetical protein +FIG00742898 FIG00742899: hypothetical protein +FIG00742899 FIG00742900: hypothetical protein +FIG00742905 FIG00742906: hypothetical protein +FIG00742906 FIG00742907: hypothetical protein +FIG00742910 FIG00742912: hypothetical protein +FIG00742913 FIG00742914: hypothetical protein +FIG00742914 FIG00742915: hypothetical protein +FIG00742915 RibT protein, riboflavin biosynthesis acetyltransferase (GNAT) family +FIG00742916 FIG00742918: hypothetical protein +FIG00742919 FIG00742920: hypothetical protein +FIG00742920 FIG00742925: hypothetical protein +FIG00742925 FIG00742928: hypothetical protein +FIG00742929 L-O-lysylphosphatidylglycerol synthase (EC 2.3.2.3) +FIG00742931 FIG00742932: hypothetical protein +FIG00742932 FIG00742935: hypothetical protein +FIG00742942 FIG00742943: hypothetical protein +FIG00742943 FIG00742944: hypothetical protein +FIG00742946 FIG00742949: hypothetical protein +FIG00742952 FIG00742953: hypothetical protein +FIG00742954 FIG00742955: hypothetical protein +FIG00742956 FIG00742957: hypothetical protein +FIG00742957 FIG00742958: hypothetical protein +FIG00742963 FIG00742964: hypothetical protein +FIG00742968 FIG00742969: hypothetical protein +FIG00742972 FIG00742974: hypothetical protein +FIG00742974 2-oxo-hept-3-ene-1,7-dioate hydratase; 2-oxo-hept-4-ene-1,7-dioate hydratase( EC:4.2.1.- ) +FIG00742975 FIG00742976: hypothetical protein +FIG00742983 FIG00742986: hypothetical protein +FIG00742988 putative PepQ +FIG00742989 FIG00742990: hypothetical protein +FIG00742991 phage shock protein C, PspC +FIG00742992 FIG00742993: hypothetical protein +FIG00743001 FIG00743002: hypothetical protein +FIG00743003 FIG00743005: hypothetical protein +FIG00743005 FIG00743007: hypothetical protein +FIG00743008 FIG00743009: hypothetical protein +FIG00743009 FIG00743010: hypothetical protein +FIG00743011 FIG00743012: hypothetical protein +FIG00743013 FIG00743014: hypothetical protein +FIG00743016 FIG00743019: hypothetical protein +FIG00743020 FIG00743021: hypothetical protein +FIG00743021 FIG00743025: hypothetical protein +FIG00743027 DNA-binding response regulator, OmpR family (Rec-wHTH domains) +FIG00743030 FIG00743032: hypothetical protein +FIG00743033 FIG00743034: hypothetical protein +FIG00743034 FIG00743035: hypothetical protein +FIG00743035 FIG00743037: hypothetical protein +FIG00743037 FIG00743038: hypothetical protein +FIG00743040 FIG00743041: hypothetical protein +FIG00743043 FIG00743046: hypothetical protein +FIG00743047 FIG00743048: hypothetical protein +FIG00743048 FIG00743049: hypothetical protein +FIG00743049 FIG00743050: hypothetical protein +FIG00743059 FIG00743060: hypothetical protein +FIG00743060 FIG00743062: hypothetical protein +FIG00743062 FIG00743063: hypothetical protein +FIG00743065 FIG00743066: hypothetical protein +FIG00743069 FIG00743072: hypothetical protein +FIG00743072 FIG00743076: hypothetical protein +FIG00743076 FIG00743079: hypothetical protein +FIG00743079 ORF-12 +FIG00743081 FIG00743082: hypothetical protein +FIG00743082 FIG00743083: hypothetical protein +FIG00743083 CsbD family protein +FIG00743089 FIG00743091: hypothetical protein +FIG00743091 FIG00743093: hypothetical protein +FIG00743093 FIG00743094: hypothetical protein +FIG00743096 FIG00743097: hypothetical protein +FIG00743097 FIG00743099: hypothetical protein +FIG00743099 FIG00743100: hypothetical protein +FIG00743100 FIG00743102: hypothetical protein +FIG00743102 FIG00743106: hypothetical protein +FIG00743107 FIG00743109: hypothetical protein +FIG00743110 FIG00743112: hypothetical protein +FIG00743112 ABC transporter, ATP-binding and permease protein +FIG00743121 FIG00743122: hypothetical protein +FIG00743122 FIG00743123: hypothetical protein +FIG00743125 FIG00743126: hypothetical protein +FIG00743126 FIG00743127: hypothetical protein +FIG00743127 alkaline phosphatase like protein +FIG00743128 FIG00743132: hypothetical protein +FIG00743132 FIG00743134: hypothetical protein +FIG00743135 FIG00743137: hypothetical protein +FIG00743139 Predicted holin-like toxin +FIG00743147 FIG00743148: hypothetical protein +FIG00743148 transport protein +FIG00743155 FIG00743157: hypothetical protein +FIG00743157 FIG00743158: hypothetical protein +FIG00743161 FIG00743162: hypothetical protein +FIG00743162 FIG00743163: hypothetical protein +FIG00743164 FIG00743165: hypothetical protein +FIG00743165 PTS system, cellobiose-specific IIC component +FIG00743167 FIG00743168: hypothetical protein +FIG00743173 FIG00743175: hypothetical protein +FIG00743176 FIG00743177: hypothetical protein +FIG00743177 FIG00743178: hypothetical protein +FIG00743180 FIG00743181: hypothetical protein +FIG00743181 FIG00743183: hypothetical protein +FIG00743183 FIG00743184: hypothetical protein +FIG00743184 Promiscuous sugar phosphatase YidA, haloacid dehalogenase-like phosphatase family +FIG00743192 PemK family protein +FIG00743193 FIG00743194: hypothetical protein +FIG00743194 FIG00743196: hypothetical protein +FIG00743197 FIG00743198: hypothetical protein +FIG00743199 FIG00743200: hypothetical protein +FIG00743200 FIG00743202: hypothetical protein +FIG00743202 FIG00743203: hypothetical protein +FIG00743210 regulatory protein, MerR +FIG00743215 Mannosyl-glycoprotein endo-beta-N-acetylglucosamidase +FIG00743217 FIG00743218: hypothetical protein +FIG00743218 FIG00743219: hypothetical protein +FIG00743220 FIG00744177: hypothetical protein +FIG00743224 acyltransferase (putative) +FIG00743225 FIG00743226: hypothetical protein +FIG00743233 FIG00743234: hypothetical protein +FIG00743234 Polysaccharide polymerase +FIG00743235 FIG00743236: hypothetical protein +FIG00743236 FIG00743237: hypothetical protein +FIG00743238 FIG00743239: hypothetical protein +FIG00743241 FIG00743242: hypothetical protein +FIG00743247 FIG00743248: hypothetical protein +FIG00743250 FIG00743252: hypothetical protein +FIG00743258 FIG00743260: hypothetical protein +FIG00743262 FIG00743265: hypothetical protein +FIG00743267 FIG00743269: hypothetical protein +FIG00743269 FIG00743270: hypothetical protein +FIG00743270 FIG00743271: hypothetical protein +FIG00743271 FIG00743273: hypothetical protein +FIG00743275 Camphor resistance CrcB protein +FIG00743276 FIG00743278: hypothetical protein +FIG00743278 FIG00743279: hypothetical protein +FIG00743281 FIG00743283: hypothetical protein +FIG00743283 FIG00743284: hypothetical protein +FIG00743291 FIG00743292: hypothetical protein +FIG00743292 FIG00743301: hypothetical protein +FIG00743302 FIG00743303: hypothetical protein +FIG00743304 FIG00743307: hypothetical protein +FIG00743310 FIG00743311: hypothetical protein +FIG00743311 Sortase related acyltransferase +FIG00743313 FIG00743314: hypothetical protein +FIG00743314 FIG00743316: hypothetical protein +FIG00743317 FIG00743318: hypothetical protein +FIG00743318 FIG00743319: hypothetical protein +FIG00743321 FIG00743322: hypothetical protein +FIG00743324 FIG00743325: hypothetical protein +FIG00743325 FIG00743326: hypothetical protein +FIG00743327 Orf2 protein +FIG00743329 serine-threonine protein phosphatase +FIG00743334 FIG00743336: hypothetical protein +FIG00743341 FIG00743345: hypothetical protein +FIG00743345 putative Mg2+/citrate transporter +FIG00743350 FIG00743351: hypothetical protein +FIG00743352 FIG00743353: hypothetical protein +FIG00743353 FIG00743354: hypothetical protein +FIG00743357 FIG00743358: hypothetical protein +FIG00743372 FIG00743376: hypothetical protein +FIG00743381 Di- and tricarboxylate transporter +FIG00743385 FIG00743387: hypothetical protein +FIG00743387 Glutathione reductase +FIG00743389 FIG00743390: hypothetical protein +FIG00743390 FIG00743391: hypothetical protein +FIG00743391 FIG00743394: hypothetical protein +FIG00743394 FIG00743395: hypothetical protein +FIG00743396 FIG00743397: hypothetical protein +FIG00743397 FIG00743398: hypothetical protein +FIG00743398 contains PAP2 superfamily domain +FIG00743402 FIG00743403: hypothetical protein +FIG00743407 FIG00743411: hypothetical protein +FIG00743411 FIG00743414: hypothetical protein +FIG00743414 FIG00743416: hypothetical protein +FIG00743416 FIG00743417: hypothetical protein +FIG00743418 Na+-H+ antiporter +FIG00743421 FIG00743423: hypothetical protein +FIG00743423 FIG00743424: hypothetical protein +FIG00743425 FIG00743426: hypothetical protein +FIG00743426 FIG00743430: hypothetical protein +FIG00743430 FIG00743432: hypothetical protein +FIG00743434 FIG00743435: hypothetical protein +FIG00743435 FIG00743436: hypothetical protein +FIG00743436 FIG00743437: hypothetical protein +FIG00743437 putative autolysin +FIG00743439 FIG00743440: hypothetical protein +FIG00743440 FIG00743441: hypothetical protein +FIG00743441 transmembrane protein Tmp5 +FIG00743444 Exonuclease +FIG00743445 FIG00743448: hypothetical protein +FIG00743448 FIG00743450: hypothetical protein +FIG00743450 FIG00743451: hypothetical protein +FIG00743453 FIG00743454: hypothetical protein +FIG00743454 FIG00743456: hypothetical protein +FIG00743456 FIG00743457: hypothetical protein +FIG00743457 FIG00743458: hypothetical protein +FIG00743462 FIG00743463: hypothetical protein +FIG00743465 FIG00743466: hypothetical protein +FIG00743466 FIG00743467: hypothetical protein +FIG00743473 FIG00743476: hypothetical protein +FIG00743477 FIG00743478: hypothetical protein +FIG00743479 FIG00743480: hypothetical protein +FIG00743481 transcriptional regulator, DeoR-family +FIG00743488 FIG00743490: hypothetical protein +FIG00743490 FIG00743492: hypothetical protein +FIG00743496 FIG00743498: hypothetical protein +FIG00743499 FIG00743502: hypothetical protein +FIG00743503 FIG00743504: hypothetical protein +FIG00743505 FIG00743506: hypothetical protein +FIG00743506 FIG00743507: hypothetical protein +FIG00743507 FIG00743509: hypothetical protein +FIG00743510 FIG00743511: hypothetical protein +FIG00743512 FIG00743513: hypothetical protein +FIG00743514 FIG00743515: hypothetical protein +FIG00743516 contains transcriptional regulator helix-turn-helix domain +FIG00743519 FIG00744186: hypothetical protein +FIG00743525 FIG00743526: hypothetical protein +FIG00743526 FIG00743531: hypothetical protein +FIG00743532 FIG00743533: hypothetical protein +FIG00743533 FIG00743534: hypothetical protein +FIG00743534 cation transport protein +FIG00743536 FIG00743537: hypothetical protein +FIG00743541 FIG00743542: hypothetical protein +FIG00743542 FIG00743544: hypothetical protein +FIG00743544 FIG00743545: hypothetical protein +FIG00743545 FIG00743546: hypothetical protein +FIG00743547 FIG00743548: hypothetical protein +FIG00743548 FIG00743549: hypothetical protein +FIG00743549 FIG00743550: hypothetical protein +FIG00743554 FIG00743555: hypothetical protein +FIG00743555 FIG00743556: hypothetical protein +FIG00743556 probable metal-dependant glycoprotease +FIG00743558 FIG00743560: hypothetical protein +FIG00743560 FIG00743563: hypothetical protein +FIG00743564 FIG00743565: hypothetical protein +FIG00743565 FIG00743567: hypothetical protein +FIG00743569 FIG00743571: hypothetical protein +FIG00743571 S-methylmethionine permease pseudogene +FIG00743574 FIG00743575: hypothetical protein +FIG00743576 FIG00743578: hypothetical protein +FIG00743579 DNA-binding response regulator, CitB family (Rec-wHTH domains) +FIG00743586 FIG00743588: hypothetical protein +FIG00743588 FIG00743589: hypothetical protein +FIG00743593 FIG00743594: hypothetical protein +FIG00743594 FIG00743595: hypothetical protein +FIG00743599 FIG00743601: hypothetical protein +FIG00743601 FIG00743602: hypothetical protein +FIG00743602 FIG00743604: hypothetical protein +FIG00743605 FIG00743607: hypothetical protein +FIG00743607 FIG00743608: hypothetical protein +FIG00743608 FIG00743610: hypothetical protein +FIG00743611 FIG00743612: hypothetical protein +FIG00743612 Bacteriocin prepeptide or inducing factor for bacteriocin synthesis +FIG00743616 FIG00743617: hypothetical protein +FIG00743617 membrane-bound protease, CAAX family +FIG00743620 FIG00743621: hypothetical protein +FIG00743621 FIG00743622: hypothetical protein +FIG00743623 FIG00743624: hypothetical protein +FIG00743624 FIG00743625: hypothetical protein +FIG00743628 FIG00743630: hypothetical protein +FIG00743632 FIG00743633: hypothetical protein +FIG00743638 FIG00743639: hypothetical protein +FIG00743639 FIG00743640: hypothetical protein +FIG00743643 FIG00743644: hypothetical protein +FIG00743645 FIG00743647: hypothetical protein +FIG00743647 FIG00743648: hypothetical protein +FIG00743649 FIG00743652: hypothetical protein +FIG00743652 FIG00743653: hypothetical protein +FIG00743653 FIG00743654: hypothetical protein +FIG00743654 FIG00743655: hypothetical protein +FIG00743656 FIG00743657: hypothetical protein +FIG00743657 Predicted metal-dependent membrane protease +FIG00743667 FIG00743668: hypothetical protein +FIG00743668 FIG00743671: hypothetical protein +FIG00743671 FIG00743672: hypothetical protein +FIG00743672 FIG00743673: hypothetical protein +FIG00743673 FIG00743674: hypothetical protein +FIG00743674 FIG00743676: hypothetical protein +FIG00743678 FIG00743679: hypothetical protein +FIG00743679 FIG00743680: hypothetical protein +FIG00743680 FIG00743681: hypothetical protein +FIG00743681 FIG00743683: hypothetical protein +FIG00743684 FIG00743687: hypothetical protein +FIG00743696 FIG00743697: hypothetical protein +FIG00743697 FIG00743698: hypothetical protein +FIG00743699 FIG00743700: hypothetical protein +FIG00743702 FIG00743703: hypothetical protein +FIG00743713 FIG00743715: hypothetical protein +FIG00743715 FIG00743716: hypothetical protein +FIG00743716 acetyltransferase (putative) +FIG00743720 FIG00743722: hypothetical protein +FIG00743727 Phage transcriptional regulator +FIG00743728 FIG00743730: hypothetical protein +FIG00743735 FIG00743736: hypothetical protein +FIG00743736 FIG00743738: hypothetical protein +FIG00743738 putative replication initiator protein +FIG00743741 FIG00743744: hypothetical protein +FIG00743744 FIG00743746: hypothetical protein +FIG00743746 FIG00743747: hypothetical protein +FIG00743747 FIG00743748: hypothetical protein +FIG00743749 FIG00743751: hypothetical protein +FIG00743751 FIG00743752: hypothetical protein +FIG00743753 FIG00743754: hypothetical protein +FIG00743755 FIG00743758: hypothetical protein +FIG00743759 FIG00743761: hypothetical protein +FIG00743765 FIG00743766: hypothetical protein +FIG00743768 FIG00743769: hypothetical protein +FIG00743769 FIG00743770: hypothetical protein +FIG00743770 FIG00743771: hypothetical protein +FIG00743772 FIG00743773: hypothetical protein +FIG00743773 multi-drug-type permease +FIG00743774 FIG00743776: hypothetical protein +FIG00743777 FIG00743778: hypothetical protein +FIG00743782 Arylesterase (EC 3.1.1.2) +FIG00743786 Phosphoglycerate mutase (Putative) (EC 5.4.2.1) +FIG00743791 FIG00743792: hypothetical protein +FIG00743795 Small conserved membrane protein +FIG00743796 FIG00743797: hypothetical protein +FIG00743797 FIG00743798: hypothetical protein +FIG00743798 FIG00743799: hypothetical protein +FIG00743805 Periplasmic binding protein/LacI transcriptional regulator +FIG00743809 FIG00743810: hypothetical protein +FIG00743810 FIG00743812: hypothetical protein +FIG00743817 FIG00743818: hypothetical protein +FIG00743818 Phosphotransferase system, mannose/fructose/N-acetylgalactosamine-specific component IID, with ABC-type ATPase domain +FIG00743824 FIG00743825: hypothetical protein +FIG00743825 FIG00743828: hypothetical protein +FIG00743828 putative phage minor head protein +FIG00743829 FIG00743830: hypothetical protein +FIG00743830 FIG00743832: hypothetical protein +FIG00743844 Uncharacterized phage-associated protein +FIG00743848 PTS system, galactosamine-specific IIC component (EC 2.7.1.69) +FIG00743850 FIG00743851: hypothetical protein +FIG00743851 FIG00743852: hypothetical protein +FIG00743852 FIG00743855: hypothetical protein +FIG00743855 FIG00743857: hypothetical protein +FIG00743857 FIG00743858: hypothetical protein +FIG00743859 FIG00743861: hypothetical protein +FIG00743862 contains methionine synthase, vitamin-B12 independent domain +FIG00743864 FIG00743865: hypothetical protein +FIG00743865 FIG00743868: hypothetical protein +FIG00743869 FIG00743870: hypothetical protein +FIG00743870 Prebacteriocin +FIG00743878 FIG00743879: hypothetical protein +FIG00743882 FIG00743883: hypothetical protein +FIG00743883 FIG00743884: hypothetical protein +FIG00743885 FIG00743887: hypothetical protein +FIG00743887 FIG00743888: hypothetical protein +FIG00743895 FIG00743901: hypothetical protein +FIG00743901 FIG00743902: hypothetical protein +FIG00743904 FIG00743905: hypothetical protein +FIG00743905 FIG00743906: hypothetical protein +FIG00743907 FIG00743909: hypothetical protein +FIG00743913 FIG00743918: hypothetical protein +FIG00743918 FIG00743921: hypothetical protein +FIG00743924 FIG00743925: hypothetical protein +FIG00743928 FIG00743929: hypothetical protein +FIG00743930 FIG00743932: hypothetical protein +FIG00743933 FIG00743934: hypothetical protein +FIG00743940 Peptidase M23B:Mannosyl-glycoprotein endo-beta-N-acetylglucosamidase +FIG00743943 FIG00743946: hypothetical protein +FIG00743946 Transcriptional regulator, DeoR family +FIG00743947 FIG00743949: hypothetical protein +FIG00743950 Imidazolonepropionase related amidohydrolase +FIG00743952 FIG00743953: hypothetical protein +FIG00743953 FIG00743956: hypothetical protein +FIG00743956 FIG00743957: hypothetical protein +FIG00743958 Tellurite resistance protein related permease +FIG00743960 FIG00743961: hypothetical protein +FIG00743961 FIG00743964: hypothetical protein +FIG00743964 FIG00743965: hypothetical protein +FIG00743969 nisin resistance protein (putative) +FIG00743976 FIG00743977: hypothetical protein +FIG00743977 FIG00743978: hypothetical protein +FIG00743978 integrase/recombinase, fragment (putative) +FIG00743979 FIG00743981: hypothetical protein +FIG00743981 FIG00743982: hypothetical protein +FIG00743982 FIG00743983: hypothetical protein +FIG00743984 FIG00743985: hypothetical protein +FIG00743989 FIG00743991: hypothetical protein +FIG00743994 FIG00743995: hypothetical protein +FIG00743995 FIG00743996: hypothetical protein +FIG00743996 FIG00743997: hypothetical protein +FIG00743997 FIG00743998: hypothetical protein +FIG00744001 FIG00744002: hypothetical protein +FIG00744002 FIG00744003: hypothetical protein +FIG00744006 FIG00744008: hypothetical protein +FIG00744008 FIG00744011: hypothetical protein +FIG00744011 FIG00744012: hypothetical protein +FIG00744012 PTS system, galactosamine-specific IIA component (EC 2.7.1.69) +FIG00744017 FIG00744019: hypothetical protein +FIG00744019 FIG00742793: hypothetical protein +FIG00744021 FIG00744022: hypothetical protein +FIG00744024 FIG00744025: hypothetical protein +FIG00744025 FIG00744026: hypothetical protein +FIG00744029 FIG00744032: hypothetical protein +FIG00744032 contains haloacid dehalogenase-like domain +FIG00744035 putative amino acid ABC transporter, permease protein +FIG00744037 FIG00744038: hypothetical protein +FIG00744038 FIG00744040: hypothetical protein +FIG00744043 extracellular protein, N-terminal fragment +FIG00744046 Phosphotransferase system galacitol-specific IIA domain (Ntr-type) +FIG00744047 FIG00744048: hypothetical protein +FIG00744049 FIG00744050: hypothetical protein +FIG00744050 FIG00744052: hypothetical protein +FIG00744053 FIG00744054: hypothetical protein +FIG00744062 FIG00744063: hypothetical protein +FIG00744065 FIG00744066: hypothetical protein +FIG00744066 FIG00744068: hypothetical protein +FIG00744068 FIG00744072: hypothetical protein +FIG00744076 FIG00744077: hypothetical protein +FIG00744077 FIG00744078: hypothetical protein +FIG00744078 FIG00744079: hypothetical protein +FIG00744084 putative apo-citrate lyase( EC:2.7.7.- ) +FIG00744093 Bacteriocin ABC-transporter, auxillary protein +FIG00744098 FIG00744099: hypothetical protein +FIG00744099 major tail protein, phi13 family +FIG00744103 FIG00744104: hypothetical protein +FIG00744104 FIG00744107: hypothetical protein +FIG00744108 FIG00744109: hypothetical protein +FIG00744109 FIG00744110: hypothetical protein +FIG00744114 FIG00744116: hypothetical protein +FIG00744124 FIG00744125: hypothetical protein +FIG00744128 FIG00744131: hypothetical protein +FIG00744131 FIG00744132: hypothetical protein +FIG00744132 FIG00744133: hypothetical protein +FIG00744134 FIG00744135: hypothetical protein +FIG00744141 FIG00744143: hypothetical protein +FIG00744143 Phage Mu protein F like protein +FIG00744145 FIG00744146: hypothetical protein +FIG00744148 galactoside O-acetyltransferase +FIG00744157 FIG00744158: hypothetical protein +FIG00744158 Propanediol utilization polyhedral body protein PduJ +FIG00744159 FIG00744162: hypothetical protein +FIG00744165 FIG00744166: hypothetical protein +FIG00744166 FIG00744170: hypothetical protein +FIG00744170 FIG00744171: hypothetical protein +FIG00744171 FIG00744172: hypothetical protein +FIG00744172 FIG00744173: hypothetical protein +FIG00744181 FIG00744182: hypothetical protein +FIG00744182 lincomycin-resistance protein +FIG00744183 Acetyltransferases, putative( EC:2.3.1.128 ) +FIG00744186 FIG00744188: hypothetical protein +FIG00744188 FIG00744190: hypothetical protein +FIG00744192 Orf 14.9-like protein +FIG00744193 protein-disulfide isomerase +FIG00744195 ABC transporter membrane-spanning permease - glutamine transport +FIG00744196 FIG00744197: hypothetical protein +FIG00744197 FIG00744198: hypothetical protein +FIG00744198 FIG00744199: hypothetical protein +FIG00744199 FIG00744201: hypothetical protein +FIG00744201 FIG00744203: hypothetical protein +FIG00744204 FIG00744205: hypothetical protein +FIG00744207 FIG00744210: hypothetical protein +FIG00744210 FIG00744215: hypothetical protein +FIG00744219 FIG00744223: hypothetical protein +FIG00744223 FIG00744225: hypothetical protein +FIG00744225 FIG00744226: hypothetical protein +FIG00744231 FIG00744233: hypothetical protein +FIG00744233 FIG00744234: hypothetical protein +FIG00744234 FIG00744235: hypothetical protein +FIG00744236 FIG00744240: hypothetical protein +FIG00744240 FIG00744242: hypothetical protein +FIG00744243 FIG00744246: hypothetical protein +FIG00744251 putative transcriptional regulator phage-related +FIG00744252 FIG00744255: hypothetical protein +FIG00744255 FIG00744256: hypothetical protein +FIG00744260 putative alpha-beta superfamily hydrolase +FIG00744269 FIG00744271: hypothetical protein +FIG00744274 FIG00744275: hypothetical protein +FIG00744275 FIG00744276: hypothetical protein +FIG00744276 FIG00744277: hypothetical protein +FIG00744279 FIG00744281: hypothetical protein +FIG00744281 FIG00744283: hypothetical protein +FIG00744283 FIG00744287: hypothetical protein +FIG00744287 FIG00744290: hypothetical protein +FIG00744290 FIG00744291: hypothetical protein +FIG00744297 Arsenate reductase and related proteins, glutaredoxin family +FIG00744301 FIG00744302: hypothetical protein +FIG00744303 FIG00744305: hypothetical protein +FIG00744310 lipase/esterase +FIG00744311 FIG00744316: hypothetical protein +FIG00744316 FIG00744317: hypothetical protein +FIG00744317 FIG00744318: hypothetical protein +FIG00744325 FIG00744328: hypothetical protein +FIG00744328 FIG00744332: hypothetical protein +FIG00744335 FIG00744337: hypothetical protein +FIG00744337 Bacteriocin ABC-transporter, putative component +FIG00744341 FIG00744342: hypothetical protein +FIG00744342 FIG00744344: hypothetical protein +FIG00744344 FIG00744346: hypothetical protein +FIG00744346 FIG00744349: hypothetical protein +FIG00744350 FIG00744353: hypothetical protein +FIG00744362 FIG00744363: hypothetical protein +FIG00744367 FIG00744368: hypothetical protein +FIG00744368 P-type proton motive membrane ATPase-like protein +FIG00744372 FIG00744373: hypothetical protein +FIG00744373 EpsIIG, Putative glycosyltransferase +FIG00744392 FIG00744394: hypothetical protein +FIG00744394 FIG00744395: hypothetical protein +FIG00744397 FIG00744398: hypothetical protein +FIG00744398 FIG00744400: hypothetical protein +FIG00744402 FIG00744403: hypothetical protein +FIG00744407 FIG00744409: hypothetical protein +FIG00744411 FIG00744412: hypothetical protein +FIG00744412 FIG00744413: hypothetical protein +FIG00744413 FIG00744414: hypothetical protein +FIG00744414 FIG00744417: hypothetical protein +FIG00744418 FIG00744419: hypothetical protein +FIG00744419 transcription regulator of multidrug-efflux transporter +FIG00744422 FIG00744423: hypothetical protein +FIG00744424 FIG00744425: hypothetical protein +FIG00744427 FIG00744428: hypothetical protein +FIG00744429 FIG00744434: hypothetical protein +FIG00744437 FIG00744440: hypothetical protein +FIG00744442 FIG00744444: hypothetical protein +FIG00744444 FIG00744445: hypothetical protein +FIG00744449 FIG00744451: hypothetical protein +FIG00744453 FIG00744454: hypothetical protein +FIG00744454 FIG00744455: hypothetical protein +FIG00744455 FIG00744457: hypothetical protein +FIG00744457 Esterase/lipase-like protein +FIG00744464 Predicted oxidoreductase; Myosin-crossreactive antigen ortholog +FIG00744466 FIG00744467: hypothetical protein +FIG00744472 FIG00744476: hypothetical protein +FIG00744477 Putative antimicrobial peptide ABC exporter, membrane-spanning/permease subunit +FIG00744479 PTS system, mannose/fructose/sorbose family, IIB component +FIG00744481 FIG00744482: hypothetical protein +FIG00744484 fhu operon transcription regulator +FIG00744491 FIG00744500: hypothetical protein +FIG00744500 FIG00744503: hypothetical protein +FIG00744504 ATPase, P-type (transporting), HAD superfamily, subfamily IC +FIG00744506 putative methionine synthase +FIG00744507 Aminoglycoside 3'-phosphotransferase (EC 2.7.1.95) +FIG00744508 X-Pro dipeptidase (EC 3.4.13.9) +FIG00744509 FIG00744510: hypothetical protein +FIG00744513 ThiJ/PfpI +FIG00744517 oxidoreductase (putative) +FIG00744521 FIG00744522: hypothetical protein +FIG00744523 FIG00744525: hypothetical protein +FIG00744527 FIG00744528: hypothetical protein +FIG00744532 FIG00744533: hypothetical protein +FIG00744535 ABC transporter, ATP-binding protein +FIG00744537 contains DUF161 family domain +FIG00744541 Acetoacetate decarboxylase( EC:4.1.1.4 ) +FIG00744542 Haloacid dehalogenase/epoxide hydrolase family( EC:3.1.3.18 ) +FIG00744543 FIG00744545: hypothetical protein +FIG00744545 FIG00744546: hypothetical protein +FIG00744550 FIG00744551: hypothetical protein +FIG00744551 FIG00744552: hypothetical protein +FIG00744552 FIG00744553: hypothetical protein +FIG00744555 Conjugated bile salt hydrolase related amidase +FIG00744558 FIG00744561: hypothetical protein +FIG00744561 FIG00744562: hypothetical protein +FIG00744562 L-2-hydroxyisocaproate dehydrogenase +FIG00744563 FIG00744564: hypothetical protein +FIG00744565 contains glycosyl transferase family 2 region +FIG00744566 FIG00744568: hypothetical protein +FIG00744570 FIG00744571: hypothetical protein +FIG00744571 FIG00744572: hypothetical protein +FIG00744576 FIG00744577: hypothetical protein +FIG00744586 Aspartate racemase( EC:5.1.1.13 ) +FIG00744589 Predicted Zn-dependent protease +FIG00744590 FIG00744591: hypothetical protein +FIG00744594 FIG00744595: hypothetical protein +FIG00744595 FIG00744597: hypothetical protein +FIG00744597 lipase +FIG00744600 FIG00744602: hypothetical protein +FIG00744602 FIG00744604: hypothetical protein +FIG00744604 FIG00744606: hypothetical protein +FIG00744608 FIG00744610: hypothetical protein +FIG00744613 FIG00744614: hypothetical protein +FIG00744615 FIG00744621: hypothetical protein +FIG00744625 FIG00744627: hypothetical protein +FIG00744627 FIG00744628: hypothetical protein +FIG00744628 FIG00744629: hypothetical protein +FIG00744631 FIG00744634: hypothetical protein +FIG00744641 FIG00744642: hypothetical protein +FIG00744643 FIG00744644: hypothetical protein +FIG00744644 short-chain dehydrogenase/oxidoreductase +FIG00744646 FIG00744647: hypothetical protein +FIG00744647 FIG00744648: hypothetical protein +FIG00744648 FIG00744649: hypothetical protein +FIG00744649 FIG00744650: hypothetical protein +FIG00744651 FIG00744653: hypothetical protein +FIG00744653 FIG00744654: hypothetical protein +FIG00744654 Predicted permease, cadmium resistance protein +FIG00744663 FIG00744666: hypothetical protein +FIG00744666 FIG00744668: hypothetical protein +FIG00744670 FIG01116939: hypothetical protein +FIG00744671 FIG00744673: hypothetical protein +FIG00744674 FIG00744675: hypothetical protein +FIG00744675 FIG00749239: hypothetical protein +FIG00744676 FIG00744680: hypothetical protein +FIG00744680 FIG00744681: hypothetical protein +FIG00744681 FIG00744682: hypothetical protein +FIG00744682 FIG00744684: hypothetical protein +FIG00744685 FIG00744686: hypothetical protein +FIG00744686 Transcriptional antiterminator and PTS system component IIA +FIG00744689 multidrug transport protein, major facilitator superfamily +FIG00744694 FIG00744695: hypothetical protein +FIG00744703 FIG00744705: hypothetical protein +FIG00744705 LPXTG-motif cell wall anchor domain +FIG00744708 contains nitroreductase domain +FIG00744723 FIG00744724: hypothetical protein +FIG00744729 FIG00744731: hypothetical protein +FIG00744739 FIG00744740: hypothetical protein +FIG00744742 FIG00744745: hypothetical protein +FIG00744746 FIG00744747: hypothetical protein +FIG00744749 FIG00744750: hypothetical protein +FIG00744755 FIG00744756: hypothetical protein +FIG00744766 Putative hydrolase of the HAD superfamily +FIG00744772 FIG00744773: hypothetical protein +FIG00744773 FIG00744774: hypothetical protein +FIG00744775 FIG00744776: hypothetical protein +FIG00744779 FIG00744781: hypothetical protein +FIG00744782 FIG00744783: hypothetical protein +FIG00744783 contains ATPase involved in DNA replication initiation domain +FIG00744791 FIG00744794: hypothetical protein +FIG00744794 FIG00744797: hypothetical protein +FIG00744799 FIG00744800: hypothetical protein +FIG00744803 FIG00744804: hypothetical protein +FIG00744805 FIG00744807: hypothetical protein +FIG00744809 FIG00744810: hypothetical protein +FIG00744810 lysin +FIG00744820 FIG00744821: hypothetical protein +FIG00744821 FIG00744823: hypothetical protein +FIG00744823 FIG00744827: hypothetical protein +FIG00744828 FIG00744829: hypothetical protein +FIG00744829 FIG00744831: hypothetical protein +FIG00744831 putative DNA-damage-inducible protein J +FIG00744832 FIG00744833: hypothetical protein +FIG00744839 FIG00744840: hypothetical protein +FIG00744840 FIG00744841: hypothetical protein +FIG00744841 FIG00744842: hypothetical protein +FIG00744845 FIG00744846: hypothetical protein +FIG00744846 FIG00744847: hypothetical protein +FIG00744847 FIG00744849: hypothetical protein +FIG00744849 FIG00744851: hypothetical protein +FIG00744854 FIG00744855: hypothetical protein +FIG00744855 FIG00744856: hypothetical protein +FIG00744856 FIG00744857: hypothetical protein +FIG00744859 FIG00744860: hypothetical protein +FIG00744861 FIG00744862: hypothetical protein +FIG00744869 FIG00744871: hypothetical protein +FIG00744871 FIG00744872: hypothetical protein +FIG00744872 FIG00744873: hypothetical protein +FIG00744873 FIG00744874: hypothetical protein +FIG00744883 FIG00744884: hypothetical protein +FIG00744884 Myosin-crossreactive antigen +FIG00744885 FIG00744886: hypothetical protein +FIG00744887 FIG00744888: hypothetical protein +FIG00744888 FIG00744889: hypothetical protein +FIG00744889 FIG00744891: hypothetical protein +FIG00744895 FIG00744896: hypothetical protein +FIG00744896 FIG00744897: hypothetical protein +FIG00744898 FIG00744899: hypothetical protein +FIG00744899 FIG00744901: hypothetical protein +FIG00744902 FIG00744905: hypothetical protein +FIG00744905 Cadmium-translocating P-type ATPase +FIG00744908 FIG00744910: hypothetical protein +FIG00744910 FIG00744912: hypothetical protein +FIG00744918 FIG00744919: hypothetical protein +FIG00744919 FIG00744920: hypothetical protein +FIG00744920 FIG00744921: hypothetical protein +FIG00744921 FIG00744922: hypothetical protein +FIG00744922 FIG00744925: hypothetical protein +FIG00744931 Phage tail assembly +FIG00744935 FIG00744936: hypothetical protein +FIG00744936 FIG00744940: hypothetical protein +FIG00744942 FIG00744944: hypothetical protein +FIG00744945 FIG00744946: hypothetical protein +FIG00744949 Aminoglycoside N3'-acetyltransferase +FIG00744950 FIG00744952: hypothetical protein +FIG00744952 FIG00744954: hypothetical protein +FIG00744955 FIG00744956: hypothetical protein +FIG00744956 Rec (receiver) domain signal transduction protein +FIG00744957 FIG00744959: hypothetical protein +FIG00744959 FIG00744960: hypothetical protein +FIG00744963 FIG00744965: hypothetical protein +FIG00744966 FIG00744967: hypothetical protein +FIG00744967 FIG00744969: hypothetical protein +FIG00744973 phosphoenolpyruvate-dependent sugar phosphotransferase system EIIAB, probable mannose specific +FIG00744975 FIG00744976: hypothetical protein +FIG00744976 Three-component quorum-sensing regulatory system, sensor histidine kinase +FIG00744978 FIG00744981: hypothetical protein +FIG00744981 FIG00744982: hypothetical protein +FIG00744984 FIG00744985: hypothetical protein +FIG00744988 FIG00744990: hypothetical protein +FIG00744997 FIG00744999: hypothetical protein +FIG00744999 FIG00745000: hypothetical protein +FIG00745004 FIG00773110: hypothetical protein +FIG00745005 FIG00745007: hypothetical protein +FIG00745009 FIG00745011: hypothetical protein +FIG00745011 FIG00745012: hypothetical protein +FIG00745018 FIG00745021: hypothetical protein +FIG00745024 FIG00745025: hypothetical protein +FIG00745033 FIG00745034: hypothetical protein +FIG00745038 FIG00745040: hypothetical protein +FIG00745040 FIG00745042: hypothetical protein +FIG00745045 FIG00745046: hypothetical protein +FIG00745046 FIG00745047: hypothetical protein +FIG00745047 FIG00745048: hypothetical protein +FIG00745048 FIG00745049: hypothetical protein +FIG00745053 FIG00745054: hypothetical protein +FIG00745058 FIG00745059: hypothetical protein +FIG00745061 Predicted dinucleotide-binding enzyme +FIG00745062 FIG00745063: hypothetical protein +FIG00745063 FIG00745064: hypothetical protein +FIG00745066 FIG00745068: hypothetical protein +FIG00745068 CAAX amino terminal protease family protein +FIG00745071 FIG00745072: hypothetical protein +FIG00745072 FIG00745073: hypothetical protein +FIG00745073 FIG00745074: hypothetical protein +FIG00745077 FIG00745079: hypothetical protein +FIG00745079 FIG00745080: hypothetical protein +FIG00745081 FIG00745083: hypothetical protein +FIG00745083 FIG00745084: hypothetical protein +FIG00745087 FIG00745091: hypothetical protein +FIG00745091 FIG00745092: hypothetical protein +FIG00745094 FIG00745097: hypothetical protein +FIG00745105 FIG00745106: hypothetical protein +FIG00745106 FIG00745107: hypothetical protein +FIG00745107 FIG00745109: hypothetical protein +FIG00745114 FIG00745117: hypothetical protein +FIG00745122 FIG00745123: hypothetical protein +FIG00745123 FIG00745125: hypothetical protein +FIG00745125 FIG00745127: hypothetical protein +FIG00745127 FIG00745129: hypothetical protein +FIG00745129 FIG00745130: hypothetical protein +FIG00745131 FIG00745135: hypothetical protein +FIG00745139 FIG00745143: hypothetical protein +FIG00745143 FIG00745144: hypothetical protein +FIG00745145 FIG00745146: hypothetical protein +FIG00745148 FIG00745154: hypothetical protein +FIG00745155 FIG00745156: hypothetical protein +FIG00745156 putative transcriptional regulator, XRE family +FIG00745157 FIG00745158: hypothetical protein +FIG00745158 Putative cadmium resistance transporter +FIG00745160 FIG00745161: hypothetical protein +FIG00745161 putative fibronectin domain +FIG00745162 FIG00745163: hypothetical protein +FIG00745163 FIG00745165: hypothetical protein +FIG00745165 FIG00745166: hypothetical protein +FIG00745166 Putative glucose uptake permease +FIG00745167 FIG00745168: hypothetical protein +FIG00745170 FIG00745172: hypothetical protein +FIG00745172 FIG00745175: hypothetical protein +FIG00745175 FIG00745176: hypothetical protein +FIG00745176 FIG00745177: hypothetical protein +FIG00745177 FIG00745179: hypothetical protein +FIG00745180 FIG00745183: hypothetical protein +FIG00745183 FIG00745184: hypothetical protein +FIG00745187 FIG00745188: hypothetical protein +FIG00745189 FIG00745190: hypothetical protein +FIG00745190 FIG00745194: hypothetical protein +FIG00745194 FIG00745195: hypothetical protein +FIG00745195 FIG00745197: hypothetical protein +FIG00745197 FIG00745198: hypothetical protein +FIG00745198 FIG00745200: hypothetical protein +FIG00745202 FIG00745204: hypothetical protein +FIG00745205 FIG00745206: hypothetical protein +FIG00745206 FIG00745207: hypothetical protein +FIG00745211 FIG00745212: hypothetical protein +FIG00745212 FIG00745213: hypothetical protein +FIG00745217 Rad protein +FIG00745219 FIG00745221: hypothetical protein +FIG00745227 FIG00745228: hypothetical protein +FIG00745228 quinone oxidoreductase CC3759 +FIG00745229 FIG00745230: hypothetical protein +FIG00745237 FIG00745240: hypothetical protein +FIG00745243 FIG00745244: hypothetical protein +FIG00745246 FIG00745247: hypothetical protein +FIG00745247 FIG00745248: hypothetical protein +FIG00745248 FIG00745253: hypothetical protein +FIG00745253 FIG00745254: hypothetical protein +FIG00745254 FIG00745255: hypothetical protein +FIG00745255 FIG00745256: hypothetical protein +FIG00745257 Aldo/keto reductase of diketogulonate reductase family +FIG00745258 FIG00745261: hypothetical protein +FIG00745262 FIG00745266: hypothetical protein +FIG00745268 FIG00745270: hypothetical protein +FIG00745270 FIG00745275: hypothetical protein +FIG00745275 FIG00745276: hypothetical protein +FIG00745278 FIG00745280: hypothetical protein +FIG00745284 FIG00745286: hypothetical protein +FIG00745286 RpoE, DNA-directed RNA polymerase specialized sigma subunit, sigma24-like +FIG00745288 FIG00745289: hypothetical protein +FIG00745301 FIG00745302: hypothetical protein +FIG00745302 FIG00745303: hypothetical protein +FIG00745305 cell filamentation protein Fic +FIG00745306 putative phage DEAD box family helicase +FIG00745308 FIG00745310: hypothetical protein +FIG00745312 putative aggregation promoting protein +FIG00745313 FIG00745314: hypothetical protein +FIG00745314 FIG00745317: hypothetical protein +FIG00745318 FIG00745320: hypothetical protein +FIG00745320 FIG00745321: hypothetical protein +FIG00745322 FIG00745323: hypothetical protein +FIG00745327 FIG00745329: hypothetical protein +FIG00745329 FIG00745331: hypothetical protein +FIG00745334 FIG00745336: hypothetical protein +FIG00745336 FIG00745337: hypothetical protein +FIG00745337 putative sugar hydrolase +FIG00745341 FIG00745344: hypothetical protein +FIG00745344 FIG00745348: hypothetical protein +FIG00745348 phosphoenolpyruvate-dependent sugar phosphotransferase system EIIBC, probable arbutin specific +FIG00745351 FIG00745353: hypothetical protein +FIG00745353 FIG00745356: hypothetical protein +FIG00745356 ABC transporter ATPase component +FIG00745362 FIG00745363: hypothetical protein +FIG00745363 FIG00745364: hypothetical protein +FIG00745364 FIG00745365: hypothetical protein +FIG00745370 FIG00745371: hypothetical protein +FIG00745377 FIG00745379: hypothetical protein +FIG00745379 FIG00745383: hypothetical protein +FIG00745383 FIG00745384: hypothetical protein +FIG00745384 FIG00745386: hypothetical protein +FIG00745389 FIG00745391: hypothetical protein +FIG00745397 amino acid transport protein +FIG00745399 FIG00745400: hypothetical protein +FIG00745400 Lipase/esterase +FIG00745402 diaphanous-like protein +FIG00745403 FIG00745405: hypothetical protein +FIG00745412 FIG00745413: hypothetical protein +FIG00745413 FIG00745414: hypothetical protein +FIG00745416 Lysin +FIG00745418 FIG00745420: hypothetical protein +FIG00745425 FIG00745428: hypothetical protein +FIG00745428 FIG00745429: hypothetical protein +FIG00745429 FIG00745430: hypothetical protein +FIG00745430 FIG00745431: hypothetical protein +FIG00745431 FIG00745433: hypothetical protein +FIG00745433 FIG00745434: hypothetical protein +FIG00745434 FIG00745435: hypothetical protein +FIG00745437 FIG00745438: hypothetical protein +FIG00745438 FIG00745439: hypothetical protein +FIG00745440 FIG00745441: hypothetical protein +FIG00745443 ammonium transporter family protein +FIG00745445 FIG00745448: hypothetical protein +FIG00745448 FIG00745449: hypothetical protein +FIG00745450 FIG00745452: hypothetical protein +FIG00745452 FIG00745454: hypothetical protein +FIG00745454 FIG00745455: hypothetical protein +FIG00745460 FIG00745465: hypothetical protein +FIG00745465 FIG00745466: hypothetical protein +FIG00745466 FIG00745468: hypothetical protein +FIG00745471 FIG00745472: hypothetical protein +FIG00745472 FIG00745473: hypothetical protein +FIG00745473 FIG00745474: hypothetical protein +FIG00745480 FIG00745481: hypothetical protein +FIG00745481 FIG00745482: hypothetical protein +FIG00745485 FIG00745488: hypothetical protein +FIG00745488 FIG00745489: hypothetical protein +FIG00745490 predicted oxidoreductase +FIG00745491 FIG00745492: hypothetical protein +FIG00745495 FIG00745498: hypothetical protein +FIG00745501 FIG00745505: hypothetical protein +FIG00745505 FIG00745507: hypothetical protein +FIG00745513 FIG00745514: hypothetical protein +FIG00745516 FIG00745520: hypothetical protein +FIG00745521 Fucose 4-O-acetylase and related acetyltransferases +FIG00745524 FIG00745528: hypothetical protein +FIG00745533 FIG00745534: hypothetical protein +FIG00745534 FIG00745535: hypothetical protein +FIG00745539 YrhM +FIG00745540 Protein disulfide isomerase (S-S rearrangase) (EC 5.3.4.1) +FIG00745546 FIG00745550: hypothetical protein +FIG00745550 FIG00745551: hypothetical protein +FIG00745551 FIG00745553: hypothetical protein +FIG00745553 FIG00745554: hypothetical protein +FIG00745554 FIG00745556: hypothetical protein +FIG00745560 FIG00745562: hypothetical protein +FIG00745564 amino acid ABC transporter, amino acid-binding protein +FIG00745570 FIG00745571: hypothetical protein +FIG00745579 FIG00745580: hypothetical protein +FIG00745580 FIG00745581: hypothetical protein +FIG00745581 FIG00745582: hypothetical protein +FIG00745583 FIG00745584: hypothetical protein +FIG00745584 FIG00745585: hypothetical protein +FIG00745587 FIG00745588: hypothetical protein +FIG00745588 lipoprotein precursor (putative) +FIG00745594 FIG00745595: hypothetical protein +FIG00745595 FIG00745597: hypothetical protein +FIG00745597 FIG00745599: hypothetical protein +FIG00745599 Alpha-glucosidase (EC 3.2.1.20) +FIG00745602 FIG00745603: hypothetical protein +FIG00745603 FIG00745605: hypothetical protein +FIG00745610 FIG00745611: hypothetical protein +FIG00745614 multidrug resistance ABC transporter +FIG00745618 FIG00745619: hypothetical protein +FIG00745619 FIG00745621: hypothetical protein +FIG00745621 Hydratase/decarboxylase +FIG00745632 FIG00745633: hypothetical protein +FIG00745635 FIG00745636: hypothetical protein +FIG00745636 FIG00745638: hypothetical protein +FIG00745638 FIG00745640: hypothetical protein +FIG00745640 FIG00745641: hypothetical protein +FIG00745641 FIG00745643: hypothetical protein +FIG00745643 FIG00745644: hypothetical protein +FIG00745644 FIG00745645: hypothetical protein +FIG00745645 FIG00745647: hypothetical protein +FIG00745650 FIG00745651: hypothetical protein +FIG00745651 FIG00745652: hypothetical protein +FIG00745652 FIG00745654: hypothetical protein +FIG00745654 FIG00745655: hypothetical protein +FIG00745655 FIG00745657: hypothetical protein +FIG00745657 FIG00745658: hypothetical protein +FIG00745661 Three-component quorum-sensing regulatory system, response regulator +FIG00745663 FIG00745665: hypothetical protein +FIG00745669 FIG00745670: hypothetical protein +FIG00745670 FIG00745671: hypothetical protein +FIG00745671 FIG00745674: hypothetical protein +FIG00745674 FIG00745677: hypothetical protein +FIG00745677 FIG00745678: hypothetical protein +FIG00745684 FIG00745685: hypothetical protein +FIG00745685 FIG00745687: hypothetical protein +FIG00745687 FIG00745688: hypothetical protein +FIG00745694 Ribose 5-phosphate isomerase RpiB +FIG00745702 FIG00745703: hypothetical protein +FIG00745703 FIG00745705: hypothetical protein +FIG00745706 FIG00745707: hypothetical protein +FIG00745709 FIG00745710: hypothetical protein +FIG00745710 PRD/PTS system IIA 2 domain protein +FIG00745712 FIG00745713: hypothetical protein +FIG00745715 FIG00745716: hypothetical protein +FIG00745717 FIG00745719: hypothetical protein +FIG00745719 FIG00745720: hypothetical protein +FIG00745720 FIG00745725: hypothetical protein +FIG00745727 possible helicase +FIG00745728 FIG00745729: hypothetical protein +FIG00745736 FIG00745737: hypothetical protein +FIG00745741 FIG00745743: hypothetical protein +FIG00745744 contains bacterial regulatory merR domain +FIG00745746 FIG00745747: hypothetical protein +FIG00745747 FIG00745750: hypothetical protein +FIG00745750 FIG00745751: hypothetical protein +FIG00745751 FIG00745753: hypothetical protein +FIG00745756 FIG00745757: hypothetical protein +FIG00745759 FIG00745760: hypothetical protein +FIG00745760 FIG00745761: hypothetical protein +FIG00745764 FIG00745767: hypothetical protein +FIG00745767 FIG00745770: hypothetical protein +FIG00745771 FIG00745772: hypothetical protein +FIG00745775 transcriptional regulator, HxlR family +FIG00745780 FIG00745782: hypothetical protein +FIG00745782 FIG00745783: hypothetical protein +FIG00745783 Signal transduction diguanylate cyclase +FIG00745789 FIG00745790: hypothetical protein +FIG00745792 FIG00745794: hypothetical protein +FIG00745794 FIG00745795: hypothetical protein +FIG00745795 FIG00745796: hypothetical protein +FIG00745796 FIG00745797: hypothetical protein +FIG00745797 FIG00745800: hypothetical protein +FIG00745800 FIG00745802: hypothetical protein +FIG00745805 hypothetical protein +FIG00745809 FIG00745810: hypothetical protein +FIG00745810 FIG00745812: hypothetical protein +FIG00745815 FIG00745816: hypothetical protein +FIG00745817 FIG00745818: hypothetical protein +FIG00745819 polyferredoxin +FIG00745821 Lyzozyme M1 (1,4-beta-N-acetylmuramidase) +FIG00745823 FIG00745824: hypothetical protein +FIG00745824 FIG00745825: hypothetical protein +FIG00745828 FIG00745830: hypothetical protein +FIG00745831 FIG00745832: hypothetical protein +FIG00745839 FIG00745840: hypothetical protein +FIG00745840 FIG00745841: hypothetical protein +FIG00745841 FIG00745843: hypothetical protein +FIG00745843 Amino acid transporter +FIG00745845 FIG00745847: hypothetical protein +FIG00745850 FIG00745852: hypothetical protein +FIG00745854 FIG00745855: hypothetical protein +FIG00745855 FIG00745856: hypothetical protein +FIG00745856 FIG00745857: hypothetical protein +FIG00745857 FIG00745858: hypothetical protein +FIG00745863 FIG00745864: hypothetical protein +FIG00745864 FIG00745865: hypothetical protein +FIG00745865 FIG00745869: hypothetical protein +FIG00745869 FIG00745870: hypothetical protein +FIG00745872 corA-family cationic transporter +FIG00745878 FIG00745880: hypothetical protein +FIG00745887 FIG00745888: hypothetical protein +FIG00745891 type 1 capsular polysaccharide biosynthesis protein( EC:2.4.1.- ) +FIG00745902 FIG00745903: hypothetical protein +FIG00745905 FIG00745906: hypothetical protein +FIG00745906 FIG00745907: hypothetical protein +FIG00745912 FIG00745914: hypothetical protein +FIG00745918 FIG00745919: hypothetical protein +FIG00745919 FIG00745920: hypothetical protein +FIG00745921 FIG00745924: hypothetical protein +FIG00745924 FIG00745926: hypothetical protein +FIG00745926 FIG00745927: hypothetical protein +FIG00745928 N-acetylmuramidase( EC:3.5.1.28 ) +FIG00745932 FIG00745935: hypothetical protein +FIG00745935 FIG00745936: hypothetical protein +FIG00745940 FIG00745942: hypothetical protein +FIG00745942 FIG00745943: hypothetical protein +FIG00745948 FIG00745949: hypothetical protein +FIG00745953 FIG00745954: hypothetical protein +FIG00745957 bacteriocin helveticin J +FIG00745958 FIG00745960: hypothetical protein +FIG00745961 lipoprotein precursor +FIG00745962 FIG00745963: hypothetical protein +FIG00745969 FIG00745970: hypothetical protein +FIG00745970 FIG00745971: hypothetical protein +FIG00745974 Putative O-unit flippase +FIG00745976 FIG00745978: hypothetical protein +FIG00745980 FIG00745981: hypothetical protein +FIG00745982 FIG00745986: hypothetical protein +FIG00745987 Membrane proteins related to metalloendopeptidase-like +FIG00745991 FIG00745993: hypothetical protein +FIG00745993 FIG00745994: hypothetical protein +FIG00745994 lysozyme, putative +FIG00745997 FIG00745999: hypothetical protein +FIG00745999 small terminase subunit +FIG00746001 FIG00746003: hypothetical protein +FIG00746003 FIG00746004: hypothetical protein +FIG00746005 FIG00746006: hypothetical protein +FIG00746006 FIG00746007: hypothetical protein +FIG00746011 FIG00746012: hypothetical protein +FIG00746012 hypothetical protein +FIG00746016 FIG00746019: hypothetical protein +FIG00746019 FIG00746020: hypothetical protein +FIG00746020 FIG00746021: hypothetical protein +FIG00746021 FIG00746022: hypothetical protein +FIG00746032 ABC transporter ATPase protein +FIG00746037 FIG00746038: hypothetical protein +FIG00746047 Predicted multitransmembrane protein +FIG00746051 FIG00746053: hypothetical protein +FIG00746061 FIG00746062: hypothetical protein +FIG00746066 positive transcriptional regulator MutR family +FIG00746073 putative integrase-recombinase +FIG00746078 FIG00746081: hypothetical protein +FIG00746081 PspC +FIG00746084 FIG00746089: hypothetical protein +FIG00746090 sugar transport protein +FIG00746095 FIG00746096: hypothetical protein +FIG00746096 FIG00746097: hypothetical protein +FIG00746098 FIG00746099: hypothetical protein +FIG00746102 FIG00746103: hypothetical protein +FIG00746103 FIG00746104: hypothetical protein +FIG00746104 type 1 DNA topoisomerase-like protein +FIG00746112 FIG00746113: hypothetical protein +FIG00746113 FIG00746114: hypothetical protein +FIG00746119 FIG00746120: hypothetical protein +FIG00746120 FIG00746124: hypothetical protein +FIG00746125 FIG00746126: hypothetical protein +FIG00746126 FIG00746129: hypothetical protein +FIG00746129 transport protein (putative) +FIG00746132 FIG00746133: hypothetical protein +FIG00746133 putative aluminum resistance protein +FIG00746134 acetylesterase +FIG00746140 FIG00746141: hypothetical protein +FIG00746141 Saccharopine dehydrogenase related protein +FIG00746146 FIG00746147: hypothetical protein +FIG00746149 FIG00746150: hypothetical protein +FIG00746150 peptidase M10A and M12B, matrixin and adamalysin +FIG00746153 FIG00746154: hypothetical protein +FIG00746158 FIG00746160: hypothetical protein +FIG00746160 FIG00746162: hypothetical protein +FIG00746166 FIG00746167: hypothetical protein +FIG00746173 FIG00746175: hypothetical protein +FIG00746181 FIG00746182: hypothetical protein +FIG00746186 FIG00746187: hypothetical protein +FIG00746188 FIG00746189: hypothetical protein +FIG00746189 FIG00746192: hypothetical protein +FIG00746195 FIG00746197: hypothetical protein +FIG00746197 FIG00746198: hypothetical protein +FIG00746200 FIG00746202: hypothetical protein +FIG00746213 FIG00746214: hypothetical protein +FIG00746216 HTH-type transcriptional regulator glvR +FIG00746218 prophage Lp2 protein 40 +FIG00746220 FIG00746222: hypothetical protein +FIG00746222 FIG00746224: hypothetical protein +FIG00746225 FIG00746226: hypothetical protein +FIG00746226 FIG00746227: hypothetical protein +FIG00746227 FIG00746228: hypothetical protein +FIG00746228 FIG00746230: hypothetical protein +FIG00746230 FIG00746231: hypothetical protein +FIG00746231 FIG00746232: hypothetical protein +FIG00746234 bacteriocin production-related histidine kinase +FIG00746235 FIG00746240: hypothetical protein +FIG00746243 FIG00746245: hypothetical protein +FIG00746245 FIG00746247: hypothetical protein +FIG00746258 FIG00746259: hypothetical protein +FIG00746259 protein TrsF +FIG00746262 FIG00746263: hypothetical protein +FIG00746265 prophage Lp1 protein 45 +FIG00746266 FIG00746267: hypothetical protein +FIG00746273 Predicted dehydrogenase related protein +FIG00746280 FIG00746281: hypothetical protein +FIG00746281 FIG00746284: hypothetical protein +FIG00746294 contains potassium channel domain +FIG00746295 FMN-dependent NADH-azoreductase 2 (EC 1.7.-.-) (FMN-dependent NADH-azo compound oxidoreductase 2) (Azo-dye reductase 2) +FIG00746296 FIG00746298: hypothetical protein +FIG00746298 FIG00746299: hypothetical protein +FIG00746299 FIG00746301: hypothetical protein +FIG00746301 FIG00746302: hypothetical protein +FIG00746302 FIG00746306: hypothetical protein +FIG00746306 FIG00746307: hypothetical protein +FIG00746307 FIG00746308: hypothetical protein +FIG00746311 FIG00746312: hypothetical protein +FIG00746316 FIG00746317: hypothetical protein +FIG00746322 FIG00746323: hypothetical protein +FIG00746324 FIG00746325: hypothetical protein +FIG00746325 FIG00746327: hypothetical protein +FIG00746328 FIG00746332: hypothetical protein +FIG00746333 FIG00746334: hypothetical protein +FIG00746335 FIG00746338: hypothetical protein +FIG00746338 FIG00746340: hypothetical protein +FIG00746340 FIG00746341: hypothetical protein +FIG00746348 FIG00746350: hypothetical protein +FIG00746355 FIG00746359: hypothetical protein +FIG00746360 FIG00746361: hypothetical protein +FIG00746366 FIG00746367: hypothetical protein +FIG00746367 FIG00746368: hypothetical protein +FIG00746370 FIG00746371: hypothetical protein +FIG00746372 FIG00746375: hypothetical protein +FIG00746375 FIG00746376: hypothetical protein +FIG00746376 FIG00746380: hypothetical protein +FIG00746392 FIG00746394: hypothetical protein +FIG00746395 FIG00746396: hypothetical protein +FIG00746396 FIG00746398: hypothetical protein +FIG00746400 FIG00746401: hypothetical protein +FIG00746402 FIG00746403: hypothetical protein +FIG00746403 FIG00746404: hypothetical protein +FIG00746406 FIG00746407: hypothetical protein +FIG00746407 FIG00746410: hypothetical protein +FIG00746411 FIG00746416: hypothetical protein +FIG00746426 FIG00746427: hypothetical protein +FIG00746432 FIG00746435: hypothetical protein +FIG00746435 FIG00746436: hypothetical protein +FIG00746436 FIG00746437: hypothetical protein +FIG00746439 FIG00746440: hypothetical protein +FIG00746440 FIG00746441: hypothetical protein +FIG00746443 NUDIX hydrolase +FIG00746445 FIG00746447: hypothetical protein +FIG00746447 FIG00746449: hypothetical protein +FIG00746454 FIG00746455: hypothetical protein +FIG00746455 phosphinothricin N-acetyltransferase( EC:2.3.1.- ) +FIG00746456 FIG00746459: hypothetical protein +FIG00746460 FIG00746461: hypothetical protein +FIG00746464 FIG00746469: hypothetical protein +FIG00746476 FIG00746478: hypothetical protein +FIG00746478 FIG00746481: hypothetical protein +FIG00746482 P-nitrobenzoate reductase +FIG00746483 FIG00746484: hypothetical protein +FIG00746484 integral membrane protein plnV, membrane-bound protease CAAX family +FIG00746485 FIG00746488: hypothetical protein +FIG00746489 FIG00746490: hypothetical protein +FIG00746494 Uncharacterized integral membrane protein +FIG00746495 FIG00746496: hypothetical protein +FIG00746496 FIG00746501: hypothetical protein +FIG00746505 FIG00746506: hypothetical protein +FIG00746506 FIG00746507: hypothetical protein +FIG00746512 FIG00746513: hypothetical protein +FIG00746513 FIG00746514: hypothetical protein +FIG00746516 FIG00746518: hypothetical protein +FIG00746518 FIG00746519: hypothetical protein +FIG00746523 Cytochrome b5 +FIG00746524 FIG00746526: hypothetical protein +FIG00746526 FIG00746527: hypothetical protein +FIG00746528 FIG00746529: hypothetical protein +FIG00746529 FIG00746531: hypothetical protein +FIG00746536 FIG00746537: hypothetical protein +FIG00746537 FIG00746538: hypothetical protein +FIG00746539 FIG00746543: hypothetical protein +FIG00746543 FIG00746545: hypothetical protein +FIG00746546 FIG00746547: hypothetical protein +FIG00746552 FIG00746553: hypothetical protein +FIG00746558 FIG00746559: hypothetical protein +FIG00746559 FIG00746560: hypothetical protein +FIG00746560 FIG00746562: hypothetical protein +FIG00746562 FIG00746563: hypothetical protein +FIG00746563 FIG00746567: hypothetical protein +FIG00746569 contains aldo/keto reductase domain +FIG00746571 polysaccharide biosynthesis protein CpsM +FIG00746572 FIG00746573: hypothetical protein +FIG00746573 FIG00746574: hypothetical protein +FIG00746574 L-O-lysylphosphatidylglycerol synthase (EC 2.3.2.3) +FIG00746575 FIG00746577: hypothetical protein +FIG00746581 FIG00746582: hypothetical protein +FIG00746582 FIG00746585: hypothetical protein +FIG00746590 FIG00746593: hypothetical protein +FIG00746603 FIG00746604: hypothetical protein +FIG00746606 FIG00746607: hypothetical protein +FIG00746607 FIG00746610: hypothetical protein +FIG00746610 FIG00746611: hypothetical protein +FIG00746618 FIG00746619: hypothetical protein +FIG00746620 FIG00746621: hypothetical protein +FIG00746621 FIG00746622: hypothetical protein +FIG00746622 hydrolase, HAD superfamily, Cof family +FIG00746626 FIG00746627: hypothetical protein +FIG00746630 FIG00746631: hypothetical protein +FIG00746631 Prophage maintenance system killer protein +FIG00746634 FIG00746641: hypothetical protein +FIG00746641 FIG00746643: hypothetical protein +FIG00746643 FIG00746644: hypothetical protein +FIG00746644 FIG00746645: hypothetical protein +FIG00746657 FIG00746659: hypothetical protein +FIG00746659 triphosphoribosyl-dephospho-CoA synthetase +FIG00746662 Protein of unknown function UPF0150 +FIG00746665 Phosphatase +FIG00746668 FIG00746669: hypothetical protein +FIG00746669 FIG00746670: hypothetical protein +FIG00746670 FIG00746672: hypothetical protein +FIG00746672 FIG00746675: hypothetical protein +FIG00746676 FIG00746678: hypothetical protein +FIG00746683 FIG00746684: hypothetical protein +FIG00746684 FIG00746685: hypothetical protein +FIG00746685 FIG00746686: hypothetical protein +FIG00746694 FIG00746695: hypothetical protein +FIG00746701 FIG00746703: hypothetical protein +FIG00746705 Phage putative head morphogenesis protein, SPP1 gp7 +FIG00746718 FIG00746720: hypothetical protein +FIG00746722 FIG00746724: hypothetical protein +FIG00746724 FIG00746725: hypothetical protein +FIG00746730 FIG00746732: hypothetical protein +FIG00746732 FIG00746734: hypothetical protein +FIG00746735 FIG00746736: hypothetical protein +FIG00746737 FIG00746738: hypothetical protein +FIG00746739 FIG00746740: hypothetical protein +FIG00746740 FIG00746741: hypothetical protein +FIG00746742 FIG00746743: hypothetical protein +FIG00746745 FIG00746746: hypothetical protein +FIG00746746 FIG00746747: hypothetical protein +FIG00746751 FIG00746752: hypothetical protein +FIG00746756 FIG00746758: hypothetical protein +FIG00746758 FIG00746760: hypothetical protein +FIG00746763 FIG00746764: hypothetical protein +FIG00746764 FIG00746765: hypothetical protein +FIG00746765 FIG00746766: hypothetical protein +FIG00746770 FIG00746771: hypothetical protein +FIG00746771 FIG00746772: hypothetical protein +FIG00746772 FIG00746776: hypothetical protein +FIG00746776 FIG00746777: hypothetical protein +FIG00746795 FIG00746798: hypothetical protein +FIG00746798 FIG00746802: hypothetical protein +FIG00746809 FIG00746810: hypothetical protein +FIG00746815 putative lactocepin S-layer protein( EC:3.4.21.96 ) +FIG00746818 FIG00746819: hypothetical protein +FIG00746820 FIG00746821: hypothetical protein +FIG00746821 FIG00746822: hypothetical protein +FIG00746825 FIG00746833: hypothetical protein +FIG00746833 FIG00746834: hypothetical protein +FIG00746834 FIG00746835: hypothetical protein +FIG00746836 FIG00746837: hypothetical protein +FIG00746841 FIG00746842: hypothetical protein +FIG00746842 Possible 5-nitroimidazole antibiotic resistance +FIG00746844 dipeptidase, truncated +FIG00746848 FIG00746850: hypothetical protein +FIG00746850 Aryl-alcohol dehydrogenase related enzyme +FIG00746851 FIG00746852: hypothetical protein +FIG00746852 FIG00746854: hypothetical protein +FIG00746858 FIG00746859: hypothetical protein +FIG00746859 FIG00746862: hypothetical protein +FIG00746865 FIG00746868: hypothetical protein +FIG00746872 FIG00746873: hypothetical protein +FIG00746877 FIG00746879: hypothetical protein +FIG00746879 FIG00746881: hypothetical protein +FIG00746881 FIG00746882: hypothetical protein +FIG00746882 FIG00746883: hypothetical protein +FIG00746883 FIG00746884: hypothetical protein +FIG00746891 FIG00746892: hypothetical protein +FIG00746896 FIG00746897: hypothetical protein +FIG00746905 FIG00746906: hypothetical protein +FIG00746906 FIG00749442: hypothetical protein +FIG00746907 FIG00746908: hypothetical protein +FIG00746908 FIG00746909: hypothetical protein +FIG00746914 FIG00746915: hypothetical protein +FIG00746916 FIG00746917: hypothetical protein +FIG00746917 FIG00746919: hypothetical protein +FIG00746921 FIG00746926: hypothetical protein +FIG00746927 FIG00746928: hypothetical protein +FIG00746928 FIG00746929: hypothetical protein +FIG00746929 FIG00746930: hypothetical protein +FIG00746931 FIG00746932: hypothetical protein +FIG00746933 FIG00746935: hypothetical protein +FIG00746936 FIG00746938: hypothetical protein +FIG00746941 FIG00746942: hypothetical protein +FIG00746942 FIG00746944: hypothetical protein +FIG00746944 FIG00746946: hypothetical protein +FIG00746948 FIG00746951: hypothetical protein +FIG00746954 FIG00746955: hypothetical protein +FIG00746955 FIG00746957: hypothetical protein +FIG00746960 FIG00746961: hypothetical protein +FIG00746962 FIG00746964: hypothetical protein +FIG00746964 FIG00746965: hypothetical protein +FIG00746965 FIG00746966: hypothetical protein +FIG00746972 FIG00746973: hypothetical protein +FIG00746975 NemA protein +FIG00746979 FIG00746980: hypothetical protein +FIG00746985 FIG00746986: hypothetical protein +FIG00746986 FIG00746988: hypothetical protein +FIG00746988 FIG00746992: hypothetical protein +FIG00746992 FIG00746996: hypothetical protein +FIG00746999 FIG00747000: hypothetical protein +FIG00747000 FIG00747001: hypothetical protein +FIG00747003 FIG00747004: hypothetical protein +FIG00747007 Putative pyridine nucleotide-disulphide oxidoreductase +FIG00747011 FIG00747012: hypothetical protein +FIG00747013 FIG00747014: hypothetical protein +FIG00747016 FIG00747018: hypothetical protein +FIG00747018 FIG00747020: hypothetical protein +FIG00747022 FIG00747023: hypothetical protein +FIG00747024 FIG00747025: hypothetical protein +FIG00747028 protein of unknown function DUF302 +FIG00747031 FIG00747032: hypothetical protein +FIG00747032 FIG00747033: hypothetical protein +FIG00747033 oxidoreductase( EC:1.1.1.- ) +FIG00747035 FIG00747042: hypothetical protein +FIG00747045 FIG00747047: hypothetical protein +FIG00747047 FIG00747049: hypothetical protein +FIG00747049 FIG00747050: hypothetical protein +FIG00747050 FIG00747051: hypothetical protein +FIG00747053 FIG00747054: hypothetical protein +FIG00747059 FIG00747062: hypothetical protein +FIG00747063 FIG00747064: hypothetical protein +FIG00747069 FIG00747071: hypothetical protein +FIG00747071 periplasmic fumarate reductase, FccA (EC 1.3.99.1) +FIG00747075 FIG00747076: hypothetical protein +FIG00747079 FIG00747084: hypothetical protein +FIG00747084 FIG00747085: hypothetical protein +FIG00747085 FIG00747086: hypothetical protein +FIG00747086 dentin sialophosphoprotein +FIG00747090 FIG00747091: hypothetical protein +FIG00747092 prophage Lp1 protein 48 +FIG00747095 FIG00747097: hypothetical protein +FIG00747097 FIG00747099: hypothetical protein +FIG00747099 FIG00747103: hypothetical protein +FIG00747103 FIG00747106: hypothetical protein +FIG00747108 FIG00747111: hypothetical protein +FIG00747115 FIG00747117: hypothetical protein +FIG00747119 FIG00747122: hypothetical protein +FIG00747123 putative temperature-sensitive replication protein +FIG00747129 FIG00747130: hypothetical protein +FIG00747131 Bacteriophage head-tail adaptor +FIG00747132 FIG00747133: hypothetical protein +FIG00747133 FIG00747134: hypothetical protein +FIG00747136 FIG00747138: hypothetical protein +FIG00747146 FIG00747150: hypothetical protein +FIG00747153 FIG00747155: hypothetical protein +FIG00747156 FIG00747158: hypothetical protein +FIG00747162 FIG00747163: hypothetical protein +FIG00747164 FIG00747165: hypothetical protein +FIG00747170 FIG00747172: hypothetical protein +FIG00747174 FIG00747177: hypothetical protein +FIG00747177 FIG00747180: hypothetical protein +FIG00747180 FIG00747181: hypothetical protein +FIG00747181 FIG00747182: hypothetical protein +FIG00747182 FIG00747183: hypothetical protein +FIG00747183 VanZ family protein +FIG00747185 FIG00747186: hypothetical protein +FIG00747186 dipeptidase +FIG00747188 Galactose mutarotase related enzyme +FIG00747189 FIG00747190: hypothetical protein +FIG00747191 FIG00747192: hypothetical protein +FIG00747196 FIG00747197: hypothetical protein +FIG00747200 FIG00747202: hypothetical protein +FIG00747208 FIG00747210: hypothetical protein +FIG00747210 FIG00747214: hypothetical protein +FIG00747216 FIG00747217: hypothetical protein +FIG00747217 FIG00747218: hypothetical protein +FIG00747218 FIG00747220: hypothetical protein +FIG00747221 FIG00747222: hypothetical protein +FIG00747225 FIG00747226: hypothetical protein +FIG00747226 Endoglucanase Y +FIG00747230 FIG00747231: hypothetical protein +FIG00747231 FIG00747232: hypothetical protein +FIG00747232 drug efflux ABC transporter, ATP-binding/permease protein +FIG00747238 FIG00747239: hypothetical protein +FIG00747243 FIG00747245: hypothetical protein +FIG00747246 FIG00747248: hypothetical protein +FIG00747248 FIG00747249: hypothetical protein +FIG00747250 FIG00747251: hypothetical protein +FIG00747251 FIG00747252: hypothetical protein +FIG00747252 FIG00747253: hypothetical protein +FIG00747253 taurine transport system permease protein tauC +FIG00747256 FIG00747257: hypothetical protein +FIG00747257 FIG00747262: hypothetical protein +FIG00747281 FIG00747286: hypothetical protein +FIG00747289 FIG00747293: hypothetical protein +FIG00747293 FIG00747294: hypothetical protein +FIG00747297 Uncharacterized 11.8 kDa protein in hlv 5'region precursor (ORF2) +FIG00747304 FIG00747305: hypothetical protein +FIG00747310 FIG00747311: hypothetical protein +FIG00747312 FIG00747317: hypothetical protein +FIG00747317 FIG00747318: hypothetical protein +FIG00747326 Phosphoenolpyruvate-dependent sugar phosphotransferase system, EIIA 2 +FIG00747330 FIG00747331: hypothetical protein +FIG00747331 FIG00747338: hypothetical protein +FIG00747338 FIG00747339: hypothetical protein +FIG00747339 FIG00747340: hypothetical protein +FIG00747340 FIG00747341: hypothetical protein +FIG00747344 FIG00747345: hypothetical protein +FIG00747345 Magnesium and cobalt transport protein CorA +FIG00747349 FIG00747352: hypothetical protein +FIG00747360 FIG00747361: hypothetical protein +FIG00747365 FIG00747366: hypothetical protein +FIG00747370 FIG00747373: hypothetical protein +FIG00747373 FIG00747375: hypothetical protein +FIG00747375 FIG00747378: hypothetical protein +FIG00747378 FIG00747379: hypothetical protein +FIG00747379 Sensory transduction protein kinase( EC:2.7.3.- ) +FIG00747380 FIG00747381: hypothetical protein +FIG00747381 FIG00747382: hypothetical protein +FIG00747382 FIG00747383: hypothetical protein +FIG00747386 FIG00747387: hypothetical protein +FIG00747396 FIG00747397: hypothetical protein +FIG00747397 hypothetical protein +FIG00747400 FIG00747402: hypothetical protein +FIG00747408 type IIS restriction enzyme +FIG00747413 FIG00747415: hypothetical protein +FIG00747415 FIG00747417: hypothetical protein +FIG00747419 FIG00743641: hypothetical protein +FIG00747420 FIG00747422: hypothetical protein +FIG00747422 FIG00747423: hypothetical protein +FIG00747423 FIG00747428: hypothetical protein +FIG00747429 putative DNA-invertase +FIG00747433 FIG00747435: hypothetical protein +FIG00747435 FIG00747436: hypothetical protein +FIG00747436 FIG00747437: hypothetical protein +FIG00747443 FIG00747444: hypothetical protein +FIG00747444 FIG00747446: hypothetical protein +FIG00747446 FIG00747447: hypothetical protein +FIG00747447 UpsR +FIG00747450 FIG00747452: hypothetical protein +FIG00747453 FIG00747458: hypothetical protein +FIG00747462 FIG00747465: hypothetical protein +FIG00747466 FIG00747470: hypothetical protein +FIG00747470 FIG00747471: hypothetical protein +FIG00747476 prophage Lp2 protein 42 +FIG00747478 FIG00747480: hypothetical protein +FIG00747480 FIG01165809: hypothetical protein +FIG00747483 FIG00747485: hypothetical protein +FIG00747490 FIG00747492: hypothetical protein +FIG00747492 PTS system, maltose-specific IIC component / PTS system, maltose-specific IIB component (EC 2.7.1.69) +FIG00747493 FIG00747494: hypothetical protein +FIG00747495 multidrug transport protein +FIG00747500 FIG00747501: hypothetical protein +FIG00747513 FIG00747514: hypothetical protein +FIG00747524 FIG00747526: hypothetical protein +FIG00747527 FIG00747528: hypothetical protein +FIG00747529 FIG00747531: hypothetical protein +FIG00747531 FIG00747533: hypothetical protein +FIG00747542 phosphoenolpyruvate-dependent sugar phosphotransferase system EIIB, probable sorbose specific +FIG00747543 FIG00747544: hypothetical protein +FIG00747544 Phage related protein +FIG00747549 FIG00747553: hypothetical protein +FIG00747554 FIG00747557: hypothetical protein +FIG00747562 FIG00747566: hypothetical protein +FIG00747566 penicillin-binding protein, transpeptidase +FIG00747567 FIG00747568: hypothetical protein +FIG00747568 ATPase, AAA family protein +FIG00747570 FIG00747572: hypothetical protein +FIG00747577 FIG00747578: hypothetical protein +FIG00747582 FIG00747583: hypothetical protein +FIG00747583 FIG00747585: hypothetical protein +FIG00747590 FIG00747592: hypothetical protein +FIG00747592 FIG00747593: hypothetical protein +FIG00747595 FIG00747598: hypothetical protein +FIG00747598 prophage Lp3 protein 20 +FIG00747601 FIG00747603: hypothetical protein +FIG00747603 FIG00747604: hypothetical protein +FIG00747608 FIG00747612: hypothetical protein +FIG00747615 FIG00747617: hypothetical protein +FIG00747620 extracellular protein, gamma-D-glutamate-meso-diaminopimelate muropeptidase (putative) +FIG00747622 FIG00747623: hypothetical protein +FIG00747623 FIG00747626: hypothetical protein +FIG00747628 bacteriocin precursor peptide PlnK (putative) +FIG00747632 FIG00747633: hypothetical protein +FIG00747633 FIG00747634: hypothetical protein +FIG00747634 FIG00747635: hypothetical protein +FIG00747635 FIG00747637: hypothetical protein +FIG00747637 FIG00747638: hypothetical protein +FIG00747638 FIG00747639: hypothetical protein +FIG00747640 FIG00747642: hypothetical protein +FIG00747648 FIG00747650: hypothetical protein +FIG00747651 FIG00747652: hypothetical protein +FIG00747652 ABC transporter ATP binding and permease protein +FIG00747655 FIG00747657: hypothetical protein +FIG00747662 COG0637: Predicted phosphatase/phosphohexomutase +FIG00747663 FIG00747664: hypothetical protein +FIG00747664 FIG00747667: hypothetical protein +FIG00747670 FIG00747671: hypothetical protein +FIG00747673 FIG00747674: hypothetical protein +FIG00747674 transcription regulator levR (putative) +FIG00747675 FIG00747677: hypothetical protein +FIG00747682 FIG00747683: hypothetical protein +FIG00747683 FIG00747686: hypothetical protein +FIG00747689 FIG00747691: hypothetical protein +FIG00747691 FIG00747693: hypothetical protein +FIG00747694 FIG00747697: hypothetical protein +FIG00747697 FIG00747699: hypothetical protein +FIG00747699 FIG00747700: hypothetical protein +FIG00747702 FIG00747704: hypothetical protein +FIG00747710 FIG00747712: hypothetical protein +FIG00747712 FIG00747714: hypothetical protein +FIG00747715 FIG00747716: hypothetical protein +FIG00747724 FIG00747725: hypothetical protein +FIG00747731 conserved hypothetical protein; probable esterase +FIG00747734 FIG00747735: hypothetical protein +FIG00747735 FIG00747736: hypothetical protein +FIG00747736 FIG00747738: hypothetical protein +FIG00747738 FIG00747740: hypothetical protein +FIG00747742 FIG00747743: hypothetical protein +FIG00747743 FIG00747744: hypothetical protein +FIG00747754 FIG00747757: hypothetical protein +FIG00747758 FIG00747759: hypothetical protein +FIG00747760 prophage Lp1 protein 43 +FIG00747761 FIG00747762: hypothetical protein +FIG00747762 FIG00747764: hypothetical protein +FIG00747766 putative beta-glucanase precursor( EC:3.2.1.- ) +FIG00747774 FIG00747776: hypothetical protein +FIG00747778 FIG00747779: hypothetical protein +FIG00747779 acetyl esterase family enzyme +FIG00747780 FIG00747781: hypothetical protein +FIG00747781 protein TrsB +FIG00747786 ORF018 +FIG00747789 FIG00747791: hypothetical protein +FIG00747796 FIG00747797: hypothetical protein +FIG00747805 FIG00747806: hypothetical protein +FIG00747807 FIG00747808: hypothetical protein +FIG00747815 FIG00747816: hypothetical protein +FIG00747816 Nucleotidyltransferase/DNA polymerase for DNA repair +FIG00747818 FIG00747820: hypothetical protein +FIG00747820 Propanediol utilization protein PduM +FIG00747821 FIG00747823: hypothetical protein +FIG00747825 Predicted signal transduction protein with a C-terminal HATPase domain +FIG00747826 FIG00747828: hypothetical protein +FIG00747828 secreted protein-like +FIG00747831 plantaricin biosynthesis protein PlnX (putative) +FIG00747832 FIG00747833: hypothetical protein +FIG00747833 FIG00747836: hypothetical protein +FIG00747840 FIG00747841: hypothetical protein +FIG00747852 FIG00747853: hypothetical protein +FIG00747854 FIG00747855: hypothetical protein +FIG00747859 FIG00747860: hypothetical protein +FIG00747863 FIG00747865: hypothetical protein +FIG00747865 FIG00747866: hypothetical protein +FIG00747870 FIG00747871: hypothetical protein +FIG00747876 FIG00747882: hypothetical protein +FIG00747882 FIG00747883: hypothetical protein +FIG00747889 FIG00747891: hypothetical protein +FIG00747892 Unchracterized conserved protein, similar to IcaC of Staphylococcus; YHJR B.subtilis family +FIG00747894 FIG00747895: hypothetical protein +FIG00747900 FIG00747904: hypothetical protein +FIG00747906 FIG00747908: hypothetical protein +FIG00747911 FIG00747913: hypothetical protein +FIG00747913 FIG00747916: hypothetical protein +FIG00747917 FIG00747918: hypothetical protein +FIG00747919 FIG00747921: hypothetical protein +FIG00747923 FIG00747924: hypothetical protein +FIG00747930 FIG00747934: hypothetical protein +FIG00747944 FIG00747945: hypothetical protein +FIG00747947 FIG00747948: hypothetical protein +FIG00747948 FIG00747949: hypothetical protein +FIG00747954 FIG00747956: hypothetical protein +FIG00747958 FIG00747959: hypothetical protein +FIG00747959 FIG00747960: hypothetical protein +FIG00747960 FIG00747962: hypothetical protein +FIG00747966 FIG00747967: hypothetical protein +FIG00747967 FIG00747969: hypothetical protein +FIG00747969 FIG00747972: hypothetical protein +FIG00747978 FIG00747979: hypothetical protein +FIG00747979 FIG00747981: hypothetical protein +FIG00747983 FIG00747984: hypothetical protein +FIG00747985 putative tail component +FIG00747987 FIG00747988: hypothetical protein +FIG00747988 FIG00747992: hypothetical protein +FIG00747994 FIG00747995: hypothetical protein +FIG00747996 FIG00748001: hypothetical protein +FIG00748001 Protein of unknown function DUF1275 +FIG00748010 7,8-dihydro-8-oxoguanine-triphosphatase (putative) +FIG00748011 Predicted pyrophosphatase +FIG00748015 FIG00748016: hypothetical protein +FIG00748016 FIG00748017: hypothetical protein +FIG00748018 FIG00748020: hypothetical protein +FIG00748020 FIG00748021: hypothetical protein +FIG00748021 FIG00748022: hypothetical protein +FIG00748023 FIG00748025: hypothetical protein +FIG00748025 FIG00748026: hypothetical protein +FIG00748026 FIG00748027: hypothetical protein +FIG00748027 FIG00748028: hypothetical protein +FIG00748028 FIG00748029: hypothetical protein +FIG00748036 PTS system, mannose-specific IIC component( EC:2.7.1.69 ) +FIG00748045 FIG00748046: hypothetical protein +FIG00748055 FIG00906203: hypothetical protein +FIG00748060 FIG00748062: hypothetical protein +FIG00748065 4-carboxymuconolactone decarboxylase (EC 4.1.1.44) +FIG00748075 alpha-L-rhamnosidase (putative)( EC:3.2.1.40 ) +FIG00748077 FIG00748079: hypothetical protein +FIG00748081 Lipopolysaccharide synthesis sugar transferase +FIG00748084 FIG00748088: hypothetical protein +FIG00748090 FIG00748091: hypothetical protein +FIG00748091 oxidoreductase (putative)( EC:1.- ) +FIG00748093 FIG00748094: hypothetical protein +FIG00748094 FIG00748095: hypothetical protein +FIG00748099 FIG00748105: hypothetical protein +FIG00748106 FIG00748107: hypothetical protein +FIG00748107 contains helicase conserved C-terminal domain +FIG00748108 FIG00748109: hypothetical protein +FIG00748109 FIG00748112: hypothetical protein +FIG00748118 FIG00748120: hypothetical protein +FIG00748122 Chloramphenicol O-acetyltransferase +FIG00748127 FIG00748128: hypothetical protein +FIG00748128 FIG00748131: hypothetical protein +FIG00748133 FIG00748134: hypothetical protein +FIG00748137 FIG00748140: hypothetical protein +FIG00748140 FIG00748141: hypothetical protein +FIG00748141 FIG00748142: hypothetical protein +FIG00748143 FIG00748144: hypothetical protein +FIG00748145 FIG00748148: hypothetical protein +FIG00748148 FIG00748149: hypothetical protein +FIG00748149 holin +FIG00748150 FIG00748152: hypothetical protein +FIG00748153 FIG00748154: hypothetical protein +FIG00748154 FIG00748155: hypothetical protein +FIG00748158 FIG00748159: hypothetical protein +FIG00748159 FIG00748161: hypothetical protein +FIG00748163 FIG00748164: hypothetical protein +FIG00748164 FIG00748165: hypothetical protein +FIG00748166 FIG00748167: hypothetical protein +FIG00748167 FIG00748168: hypothetical protein +FIG00748174 FIG00748175: hypothetical protein +FIG00748175 FIG00748176: hypothetical protein +FIG00748176 FIG00748177: hypothetical protein +FIG00748177 FIG00748178: hypothetical protein +FIG00748178 FIG00748179: hypothetical protein +FIG00748180 FIG00748181: hypothetical protein +FIG00748183 FIG00748184: hypothetical protein +FIG00748190 FIG00748193: hypothetical protein +FIG00748197 Sugar diacid utilization regulator +FIG00748200 FIG00748201: hypothetical protein +FIG00748202 Cation-transporting ATPase (EC 3.6.3.6) +FIG00748206 FIG00748207: hypothetical protein +FIG00748218 FIG00748221: hypothetical protein +FIG00748221 FIG00748223: hypothetical protein +FIG00748223 FIG00748224: hypothetical protein +FIG00748229 FIG00748231: hypothetical protein +FIG00748238 FIG00748239: hypothetical protein +FIG00748239 major facilitator superfamily permease +FIG00748241 minor capsid protein +FIG00748252 putative PTS system, IIA component +FIG00748261 extracellular zinc metalloproteinase (putative)( EC:3.4.24.- ) +FIG00748262 FIG00748263: hypothetical protein +FIG00748263 FIG00748264: hypothetical protein +FIG00748264 FIG00748267: hypothetical protein +FIG00748269 FIG00748271: hypothetical protein +FIG00748274 FIG00748275: hypothetical protein +FIG00748275 FIG00748277: hypothetical protein +FIG00748279 prophage Lp1 protein 20 +FIG00748280 FIG00748281: hypothetical protein +FIG00748281 PTS system, IIb component +FIG00748283 FIG00748284: hypothetical protein +FIG00748288 FIG00748290: hypothetical protein +FIG00748292 FIG00748293: hypothetical protein +FIG00748300 FIG00748304: hypothetical protein +FIG00748309 FIG00748310: hypothetical protein +FIG00748310 FIG00748311: hypothetical protein +FIG00748314 FIG00748315: hypothetical protein +FIG00748318 FIG00748319: hypothetical protein +FIG00748319 FIG00748322: hypothetical protein +FIG00748324 bacteriocin precursor peptide PlnE (putative) +FIG00748325 FIG00748333: hypothetical protein +FIG00748333 FIG00748334: hypothetical protein +FIG00748334 Protein of unknown function DUF1306 +FIG00748345 Uncharacterized protein in hlv 5'region (ORF1) (Fragment) +FIG00748346 HigA protein (antitoxin to HigB) +FIG00748352 FIG00748356: hypothetical protein +FIG00748356 FIG00748357: hypothetical protein +FIG00748357 FIG00748358: hypothetical protein +FIG00748358 FIG00748359: hypothetical protein +FIG00748362 FIG00748363: hypothetical protein +FIG00748374 Sugar specific permease +FIG00748376 FIG00748377: hypothetical protein +FIG00748379 FIG00748380: hypothetical protein +FIG00748387 methyltransferase (putative) +FIG00748392 FIG00748393: hypothetical protein +FIG00748393 FIG00748394: hypothetical protein +FIG00748407 FIG00748409: hypothetical protein +FIG00748409 FIG00748412: hypothetical protein +FIG00748415 FIG00748416: hypothetical protein +FIG00748416 FIG00748417: hypothetical protein +FIG00748419 FIG00748420: hypothetical protein +FIG00748421 FIG00748422: hypothetical protein +FIG00748422 FIG00748425: hypothetical protein +FIG00748431 putative plasmid partition protein +FIG00748444 nodulin / glutamate-ammonia ligase-like protein +FIG00748449 FIG00748452: hypothetical protein +FIG00748453 FIG00748454: hypothetical protein +FIG00748460 FIG00748463: hypothetical protein +FIG00748465 FIG00748466: hypothetical protein +FIG00748467 FIG00748469: hypothetical protein +FIG00748470 FIG00748471: hypothetical protein +FIG00748471 FIG00748472: hypothetical protein +FIG00748472 HAD-superfamily hydrolase subfamily IA, variant 3:HAD-superfamily hydrolase, subfamily IA, variant 1 +FIG00748473 FIG00748476: hypothetical protein +FIG00748482 FIG00748483: hypothetical protein +FIG00748484 FIG00748485: hypothetical protein +FIG00748485 FIG00748486: hypothetical protein +FIG00748486 FIG00748487: hypothetical protein +FIG00748502 putative site-specific recombinase +FIG00748506 FIG00748507: hypothetical protein +FIG00748507 FIG00748508: hypothetical protein +FIG00748512 FIG00748513: hypothetical protein +FIG00748513 FIG00748514: hypothetical protein +FIG00748518 immunity protein PlnL +FIG00748519 FIG00748520: hypothetical protein +FIG00748525 FIG00748528: hypothetical protein +FIG00748528 FIG00748531: hypothetical protein +FIG00748531 FIG00748532: hypothetical protein +FIG00748534 FIG00748535: hypothetical protein +FIG00748535 Uncharacterized ABC transporter, permease component +FIG00748538 FIG00748539: hypothetical protein +FIG00748539 FIG00748542: hypothetical protein +FIG00748542 prophage Lp1 protein 40 +FIG00748548 FIG00748550: hypothetical protein +FIG00748550 FIG00748552: hypothetical protein +FIG00748557 acetoin reductase( EC:1.1.1.5 ) +FIG00748558 FIG00748560: hypothetical protein +FIG00748560 FIG00748562: hypothetical protein +FIG00748563 FIG00748565: hypothetical protein +FIG00748572 FIG00748575: hypothetical protein +FIG00748575 FIG00748576: hypothetical protein +FIG00748576 FIG00748579: hypothetical protein +FIG00748579 FIG00748580: hypothetical protein +FIG00748580 FIG00748581: hypothetical protein +FIG00748583 possible ABC transporter, ATP binding component +FIG00748586 FIG00748587: hypothetical protein +FIG00748587 FIG00748588: hypothetical protein +FIG00748588 FIG00748590: hypothetical protein +FIG00748599 FIG00748600: hypothetical protein +FIG00748600 FIG00748601: hypothetical protein +FIG00748605 FIG00748606: hypothetical protein +FIG00748606 FIG00748608: hypothetical protein +FIG00748612 FIG00748613: hypothetical protein +FIG00748613 FIG00748616: hypothetical protein +FIG00748616 FIG00748618: hypothetical protein +FIG00748620 2-hydroxyhepta-2,4-diene-1,7-dioateisomerase / 5-carboxymethyl-2-oxo-hex-3-ene-1,7-dioatedecarboxylase (putative)( EC:5.3.3.-,EC:4.1.1.- ) +FIG00748621 COG2274: ABC-type bacteriocin/lantibiotic exporters, contain an N-terminal double-glycine peptidase domain +FIG00748622 FIG00748623: hypothetical protein +FIG00748624 FIG00748625: hypothetical protein +FIG00748625 FIG00748628: hypothetical protein +FIG00748628 FIG00748629: hypothetical protein +FIG00748629 FIG00748630: hypothetical protein +FIG00748634 PrtP precursor +FIG00748638 Mono-ADP-ribosyltransferase C3 precursor; CF-7 family +FIG00748640 Xylose isomerase domain protein TIM barrel +FIG00748661 FIG00748664: hypothetical protein +FIG00748667 FIG00748669: hypothetical protein +FIG00748669 FIG00748670: hypothetical protein +FIG00748675 FIG00748677: hypothetical protein +FIG00748677 FIG00748679: hypothetical protein +FIG00748681 FIG00748682: hypothetical protein +FIG00748682 FIG00748687: hypothetical protein +FIG00748687 FIG00748689: hypothetical protein +FIG00748689 FIG00748694: hypothetical protein +FIG00748694 FIG00748695: hypothetical protein +FIG00748695 FIG00748696: hypothetical protein +FIG00748698 Putative multidrug ABC exporter, ATP-binding and membrane-spanning/permease subunit +FIG00748699 FIG00748700: hypothetical protein +FIG00748700 AraC-like transcriptional regulator (HTH and ligand binding domain) +FIG00748701 FIG00748705: hypothetical protein +FIG00748706 Putative transcriptional regulator, TetR family +FIG00748711 FIG00748712: hypothetical protein +FIG00748717 FIG00748719: hypothetical protein +FIG00748720 FIG00748723: hypothetical protein +FIG00748723 FIG00748724: hypothetical protein +FIG00748727 FIG00748730: hypothetical protein +FIG00748730 FIG00748731: hypothetical protein +FIG00748731 FIG00748733: hypothetical protein +FIG00748733 FIG00748734: hypothetical protein +FIG00748738 Xre-like reg +FIG00748739 FIG00748740: hypothetical protein +FIG00748752 contains glycosyl transferase group 2 domain +FIG00748755 FIG00748756: hypothetical protein +FIG00748756 FIG00748758: hypothetical protein +FIG00748758 Carbohydrate transport domain / Chorismate mutase I (EC 5.4.99.5) +FIG00748759 FIG00748760: hypothetical protein +FIG00748760 FIG00748761: hypothetical protein +FIG00748765 FIG00748766: hypothetical protein +FIG00748766 FIG00748767: hypothetical protein +FIG00748770 Snf2 family protein +FIG00748778 FIG00748779: hypothetical protein +FIG00748783 FIG00748785: hypothetical protein +FIG00748793 FIG00748794: hypothetical protein +FIG00748794 FIG00748795: hypothetical protein +FIG00748798 Arsenate reductase related protein, glutaredoxin family +FIG00748804 FIG00748805: hypothetical protein +FIG00748808 relaxase Mob DEI +FIG00748809 GTP cyclohydrolase II (EC 3.5.4.25) fragment +FIG00748811 FIG00748813: hypothetical protein +FIG00748819 FIG00748820: hypothetical protein +FIG00748820 FIG00748823: hypothetical protein +FIG00748825 FIG00748828: hypothetical protein +FIG00748834 FIG00748835: hypothetical protein +FIG00748835 FIG00748836: hypothetical protein +FIG00748836 adenylyl transferase (putative) +FIG00748837 FIG00748839: hypothetical protein +FIG00748839 Predicted esterase +FIG00748841 FIG00748843: hypothetical protein +FIG00748857 FIG00748860: hypothetical protein +FIG00748867 FIG00748868: hypothetical protein +FIG00748868 FIG00748869: hypothetical protein +FIG00748870 FIG00748873: hypothetical protein +FIG00748873 FIG00748876: hypothetical protein +FIG00748883 FIG00748884: hypothetical protein +FIG00748884 FIG00748885: hypothetical protein +FIG00748885 FIG00748888: hypothetical protein +FIG00748888 FIG00748889: hypothetical protein +FIG00748891 FIG00748893: hypothetical protein +FIG00748902 FIG00748903: hypothetical protein +FIG00748906 FIG00748910: hypothetical protein +FIG00748910 FIG00748913: hypothetical protein +FIG00748913 FIG00748914: hypothetical protein +FIG00748914 Sigma-70 factor family protein +FIG00748928 FIG00748929: hypothetical protein +FIG00748929 FIG00748931: hypothetical protein +FIG00748931 FIG00748933: hypothetical protein +FIG00748936 FIG00748937: hypothetical protein +FIG00748938 FIG00748941: hypothetical protein +FIG00748941 FIG00748944: hypothetical protein +FIG00748944 FIG00748947: hypothetical protein +FIG00748947 FIG00748948: hypothetical protein +FIG00748948 FIG00748949: hypothetical protein +FIG00748949 FIG00748951: hypothetical protein +FIG00748954 FIG00748956: hypothetical protein +FIG00748956 FIG00748957: hypothetical protein +FIG00748957 branched-chain amino acid transport protein +FIG00748961 FIG00748962: hypothetical protein +FIG00748962 FIG00748964: hypothetical protein +FIG00748964 FIG00748966: hypothetical protein +FIG00748967 FIG00748969: hypothetical protein +FIG00748969 FIG00748970: hypothetical protein +FIG00748972 Tec protein +FIG00748975 FIG00748976: hypothetical protein +FIG00748981 Orf76 +FIG00748990 FIG00748991: hypothetical protein +FIG00748991 FIG00748993: hypothetical protein +FIG00748996 Penicillin-binding protein, transpeptidase +FIG00748997 FIG00748998: hypothetical protein +FIG00749004 FIG00749005: hypothetical protein +FIG00749005 FIG00749009: hypothetical protein +FIG00749010 FIG00749011: hypothetical protein +FIG00749011 FIG00749012: hypothetical protein +FIG00749012 FIG00749014: hypothetical protein +FIG00749014 FIG00749015: hypothetical protein +FIG00749020 FIG00749021: hypothetical protein +FIG00749021 FIG00749023: hypothetical protein +FIG00749023 FIG00749026: hypothetical protein +FIG00749026 FIG00749027: hypothetical protein +FIG00749027 FIG00749030: hypothetical protein +FIG00749045 FIG00749049: hypothetical protein +FIG00749051 Choloylglycine hydrolase( EC:3.5.1.24 ) +FIG00749052 FIG00749053: hypothetical protein +FIG00749053 FIG00749054: hypothetical protein +FIG00749056 FIG00749057: hypothetical protein +FIG00749058 Unchracterized domain and predicted acyltransferase +FIG00749065 FIG00749068: hypothetical protein +FIG00749068 FIG00749071: hypothetical protein +FIG00749072 FIG00749073: hypothetical protein +FIG00749073 FIG00749075: hypothetical protein +FIG00749075 FIG00749076: hypothetical protein +FIG00749076 FIG00749077: hypothetical protein +FIG00749077 FIG00749078: hypothetical protein +FIG00749078 FIG00749080: hypothetical protein +FIG00749080 FIG00749082: hypothetical protein +FIG00749084 FIG00749086: hypothetical protein +FIG00749093 FIG00749094: hypothetical protein +FIG00749094 FIG00749095: hypothetical protein +FIG00749103 FIG00749104: hypothetical protein +FIG00749107 FIG00749108: hypothetical protein +FIG00749108 FIG00749109: hypothetical protein +FIG00749113 FIG00749116: hypothetical protein +FIG00749118 Orf96 +FIG00749120 FIG00749124: hypothetical protein +FIG00749124 putative arginase( EC:3.5.3.1 ) +FIG00749126 FIG00749128: hypothetical protein +FIG00749128 FIG00749130: hypothetical protein +FIG00749130 FIG00749131: hypothetical protein +FIG00749131 FIG00749134: hypothetical protein +FIG00749134 FIG00749137: hypothetical protein +FIG00749137 FIG00749138: hypothetical protein +FIG00749139 FIG00749141: hypothetical protein +FIG00749141 FIG00749143: hypothetical protein +FIG00749164 FIG00749166: hypothetical protein +FIG00749170 bile salt hydrolase +FIG00749173 FIG00749174: hypothetical protein +FIG00749174 cell surface hydrolase, membrane-bound (putative) +FIG00749175 FIG00749177: hypothetical protein +FIG00749177 FIG00749178: hypothetical protein +FIG00749178 FIG00749183: hypothetical protein +FIG00749186 FIG00749187: hypothetical protein +FIG00749195 FIG00749197: hypothetical protein +FIG00749204 FIG00749207: hypothetical protein +FIG00749208 FIG00749209: hypothetical protein +FIG00749209 FIG00749210: hypothetical protein +FIG00749210 FIG00749211: hypothetical protein +FIG00749231 FIG00749233: hypothetical protein +FIG00749237 transctiptional regulator, TetR family +FIG00749239 Lj965 prophage repressor +FIG00749244 Binding-protein-dependent transport systems inner membrane component +FIG00749245 FIG00749246: hypothetical protein +FIG00749246 FIG00749250: hypothetical protein +FIG00749250 FIG00749256: hypothetical protein +FIG00749259 FIG00749260: hypothetical protein +FIG00749260 FIG00749261: hypothetical protein +FIG00749261 FIG00749262: hypothetical protein +FIG00749267 prophage pi1 protein 32 +FIG00749269 FIG00749270: hypothetical protein +FIG00749286 FIG00749287: hypothetical protein +FIG00749287 FIG00749291: hypothetical protein +FIG00749291 Lj965 prophage holin +FIG00749293 FIG00749294: hypothetical protein +FIG00749295 FIG00749296: hypothetical protein +FIG00749296 FIG00749297: hypothetical protein +FIG00749302 C-di-GMP-specific phosphodiesterase +FIG00749303 FIG00749304: hypothetical protein +FIG00749307 FIG00749310: hypothetical protein +FIG00749314 FIG00749315: hypothetical protein +FIG00749322 FIG00749323: hypothetical protein +FIG00749323 FIG00749327: hypothetical protein +FIG00749328 FIG00749329: hypothetical protein +FIG00749329 FIG00749331: hypothetical protein +FIG00749333 FIG00749334: hypothetical protein +FIG00749334 FIG00749336: hypothetical protein +FIG00749337 FIG00749338: hypothetical protein +FIG00749342 FIG00749344: hypothetical protein +FIG00749349 FIG00749350: hypothetical protein +FIG00749350 FIG00749351: hypothetical protein +FIG00749352 FIG00749353: hypothetical protein +FIG00749353 FIG00749354: hypothetical protein +FIG00749367 FIG00749369: hypothetical protein +FIG00749370 prophage Lp3 protein 8, helicase +FIG00749371 FIG00749372: hypothetical protein +FIG00749373 FIG00749374: hypothetical protein +FIG00749374 FIG00749379: hypothetical protein +FIG00749383 FIG00749384: hypothetical protein +FIG00749384 FIG00749385: hypothetical protein +FIG00749385 FIG00749386: hypothetical protein +FIG00749386 FIG00749387: hypothetical protein +FIG00749394 FIG00749395: hypothetical protein +FIG00749396 FIG00749397: hypothetical protein +FIG00749397 FIG00749399: hypothetical protein +FIG00749399 FIG00749401: hypothetical protein +FIG00749401 prophage Lp1 protein 47 +FIG00749403 FIG00749404: hypothetical protein +FIG00749404 NAD(P)H dehydrogenase (quinone):NADPH-dependent FMN reductase +FIG00749412 FIG00749416: hypothetical protein +FIG00749428 FIG00749429: hypothetical protein +FIG00749435 Glycosyltransferase( EC:2.4.1.- ) +FIG00749436 FIG00749440: hypothetical protein +FIG00749442 FIG00749445: hypothetical protein +FIG00749445 FIG00749446: hypothetical protein +FIG00749452 endopeptidase O +FIG00749453 FIG00749454: hypothetical protein +FIG00749454 FIG00749456: hypothetical protein +FIG00749456 FIG00749459: hypothetical protein +FIG00749460 FIG00749461: hypothetical protein +FIG00749466 FIG00749467: hypothetical protein +FIG00749468 FIG00749471: hypothetical protein +FIG00749471 FIG00749472: hypothetical protein +FIG00749472 FIG00749473: hypothetical protein +FIG00749479 FIG00749480: hypothetical protein +FIG00749491 FIG00749494: hypothetical protein +FIG00749495 FIG00749497: hypothetical protein +FIG00749503 oxidoreductase( EC:1.- ) +FIG00749511 FIG00749516: hypothetical protein +FIG00749517 FIG00749519: hypothetical protein +FIG00749519 FIG00749520: hypothetical protein +FIG00749520 FIG00749522: hypothetical protein +FIG00749522 amino acid permease-associated region +FIG00749539 FIG00749541: hypothetical protein +FIG00749542 FIG00749543: hypothetical protein +FIG00749545 FIG00749547: hypothetical protein +FIG00749555 FIG00749556: hypothetical protein +FIG00749558 FIG00749560: hypothetical protein +FIG00749560 FIG00749561: hypothetical protein +FIG00749561 FIG00749562: hypothetical protein +FIG00749566 FIG00749567: hypothetical protein +FIG00749567 N-acetylglucosamine/galactosamine PTS, EIIA( EC:2.7.1.69 ) +FIG00749570 FIG00749571: hypothetical protein +FIG00749571 FIG00749572: hypothetical protein +FIG00749578 FIG00749579: hypothetical protein +FIG00749585 FIG00749589: hypothetical protein +FIG00749591 FIG00749592: hypothetical protein +FIG00749593 FIG00749594: hypothetical protein +FIG00749595 FIG00749597: hypothetical protein +FIG00749597 FIG00749599: hypothetical protein +FIG00749599 FIG00749600: hypothetical protein +FIG00749603 PTS, EIIB +FIG00749605 FIG00629163: hypothetical protein +FIG00749608 FIG00749609: hypothetical protein +FIG00749609 FIG00749610: hypothetical protein +FIG00749611 FIG00749614: hypothetical protein +FIG00749619 LepB +FIG00749625 FIG00749626: hypothetical protein +FIG00749629 hydrolase (putative) +FIG00749630 FIG00749631: hypothetical protein +FIG00749634 FIG00749635: hypothetical protein +FIG00749635 FIG00749636: hypothetical protein +FIG00749636 FIG00749637: hypothetical protein +FIG00749638 FIG00749639: hypothetical protein +FIG00749639 FIG00749640: hypothetical protein +FIG00749641 FIG00749642: hypothetical protein +FIG00749644 FIG00749645: hypothetical protein +FIG00749652 FIG00749653: hypothetical protein +FIG00749653 FIG00749657: hypothetical protein +FIG00749662 FIG00749666: hypothetical protein +FIG00749666 Oligopeptide-binding protein oppA +FIG00749674 FIG00749675: hypothetical protein +FIG00749675 FIG00749676: hypothetical protein +FIG00749682 FIG00749683: hypothetical protein +FIG00749683 FIG00749684: hypothetical protein +FIG00749684 FIG00749687: hypothetical protein +FIG00749688 FIG00749689: hypothetical protein +FIG00749689 FIG00749691: hypothetical protein +FIG00749691 FIG00749692: hypothetical protein +FIG00749700 FIG00749702: hypothetical protein +FIG00749702 FIG00749705: hypothetical protein +FIG00749709 FIG00749711: hypothetical protein +FIG00749711 FIG00749712: hypothetical protein +FIG00749715 Putative thioredoxin-like protein +FIG00749716 FIG00749717: hypothetical protein +FIG00749721 FIG00749722: hypothetical protein +FIG00749726 FIG00749728: hypothetical protein +FIG00749730 Diadenosine tetraphosphatase related serine/threonine protein phosphatase +FIG00749731 prophage pi3 protein 39 +FIG00749732 FIG00749733: hypothetical protein +FIG00749733 FIG00749735: hypothetical protein +FIG00749735 FIG00749737: hypothetical protein +FIG00749737 FIG00749738: hypothetical protein +FIG00749747 FIG00749748: hypothetical protein +FIG00749748 FIG00749752: hypothetical protein +FIG00749756 FIG00749758: hypothetical protein +FIG00749758 FIG00749760: hypothetical protein +FIG00749762 diacylglycerol kinase catalytic domain protein +FIG00749765 Glycosyltransferase related enzyme +FIG00749767 FIG00749768: hypothetical protein +FIG00749769 FIG00749770: hypothetical protein +FIG00749770 FIG00749773: hypothetical protein +FIG00749774 FIG00749776: hypothetical protein +FIG00749779 FIG00749784: hypothetical protein +FIG00749784 p-nitrobenzoate reductase +FIG00749790 FIG00749791: hypothetical protein +FIG00749791 FIG00749795: hypothetical protein +FIG00749796 FIG00749797: hypothetical protein +FIG00749797 FIG00749798: hypothetical protein +FIG00749810 FIG00749812: hypothetical protein +FIG00749825 Transcription regulator, Crp family +FIG00749834 FIG00749835: hypothetical protein +FIG00749835 FIG00749836: hypothetical protein +FIG00749837 FIG00749838: hypothetical protein +FIG00749845 FIG00749847: hypothetical protein +FIG00749850 FIG00749852: hypothetical protein +FIG00749852 hypothetical protein +FIG00749865 FIG00749868: hypothetical protein +FIG00749868 FIG00749869: hypothetical protein +FIG00749869 FIG00749870: hypothetical protein +FIG00749872 FIG00749873: hypothetical protein +FIG00749877 FIG00749881: hypothetical protein +FIG00749893 Thiamin biosynthesis lipoprotein ApbE +FIG00749894 FIG00749895: hypothetical protein +FIG00749903 Na+/H+ antiporter-like protein +FIG00749904 FIG00749905: hypothetical protein +FIG00749916 FIG00749917: hypothetical protein +FIG00749917 FIG00749918: hypothetical protein +FIG00749922 FIG00749923: hypothetical protein +FIG00749923 FIG00749924: hypothetical protein +FIG00749927 FIG00749930: hypothetical protein +FIG00749930 FIG00749931: hypothetical protein +FIG00749931 FIG00749932: hypothetical protein +FIG00749941 FIG00749944: hypothetical protein +FIG00749946 YibE/F-like +FIG00749958 FIG00749959: hypothetical protein +FIG00749960 FIG00749961: hypothetical protein +FIG00749962 FIG00749963: hypothetical protein +FIG00749963 replication protein B +FIG00749964 FIG00749966: hypothetical protein +FIG00749975 FIG00749976: hypothetical protein +FIG00749985 FIG00749986: hypothetical protein +FIG00749986 FIG00749990: hypothetical protein +FIG00749990 FIG00749991: hypothetical protein +FIG00750003 FIG00750004: hypothetical protein +FIG00750004 FIG00750005: hypothetical protein +FIG00750005 FIG00750007: hypothetical protein +FIG00750007 neutral endopeptidase +FIG00750010 FIG00750014: hypothetical protein +FIG00750016 FIG00750017: hypothetical protein +FIG00750017 FIG00750027: hypothetical protein +FIG00750027 FIG00750032: hypothetical protein +FIG00750032 FIG00750033: hypothetical protein +FIG00750033 FIG00750034: hypothetical protein +FIG00750043 FIG00750048: hypothetical protein +FIG00750049 FIG00750050: hypothetical protein +FIG00750050 Orf43 +FIG00750058 FIG00750060: hypothetical protein +FIG00750060 FIG00750061: hypothetical protein +FIG00750061 FIG00750064: hypothetical protein +FIG00750069 FIG00751743: hypothetical protein +FIG00750070 FIG00750071: hypothetical protein +FIG00750074 FIG00750075: hypothetical protein +FIG00750075 FIG00750078: hypothetical protein +FIG00750081 FIG01165383: hypothetical protein +FIG00750082 FIG00750083: hypothetical protein +FIG00750085 Cro-like phage transcriptional repressor protein +FIG00750091 FIG00750093: hypothetical protein +FIG00750093 FIG00750094: hypothetical protein +FIG00750095 Mannitol-1-phosphate 5-dehydrogenase( EC:1.1.1.17 ) +FIG00750098 FIG00750099: hypothetical protein +FIG00750101 FIG00750105: hypothetical protein +FIG00750105 FIG00750106: hypothetical protein +FIG00750107 FIG00750113: hypothetical protein +FIG00750114 FIG00750119: hypothetical protein +FIG00750128 FIG00750130: hypothetical protein +FIG00750130 FIG00750134: hypothetical protein +FIG00750140 FIG00750141: hypothetical protein +FIG00750150 FIG00750151: hypothetical protein +FIG00750153 FIG00750154: hypothetical protein +FIG00750154 ABC-type uncharacterized transport system, ATPase component +FIG00750156 FIG00750160: hypothetical protein +FIG00750160 FIG00750161: hypothetical protein +FIG00750164 FIG00750168: hypothetical protein +FIG00750174 Flavodoxin/nitric oxide synthase +FIG00750182 FIG00750185: hypothetical protein +FIG00750188 FIG00750191: hypothetical protein +FIG00750195 prophage Lp1 protein 17 +FIG00750201 FIG00750202: hypothetical protein +FIG00750202 FIG00750204: hypothetical protein +FIG00750205 FIG00750206: hypothetical protein +FIG00750206 Glycosyltransferase involved in cell wall biogenesis-like +FIG00750209 FIG00750211: hypothetical protein +FIG00750211 FIG00750212: hypothetical protein +FIG00750212 FIG00750214: hypothetical protein +FIG00750216 FIG00750218: hypothetical protein +FIG00750226 FIG00750228: hypothetical protein +FIG00750229 cellulose 1,4-beta-cellobiosidase +FIG00750236 FIG00750237: hypothetical protein +FIG00750261 FIG00750262: hypothetical protein +FIG00750264 Phosphoglycerate mutase family +FIG00750265 FIG00750266: hypothetical protein +FIG00750267 FIG00750268: hypothetical protein +FIG00750268 FIG00750272: hypothetical protein +FIG00750272 FIG00750275: hypothetical protein +FIG00750275 integral membrane protein PlnW, membrane-bound protease CAAX family +FIG00750279 reductase-dehydrogenase( EC:1.1.1.- ) +FIG00750283 FIG00750285: hypothetical protein +FIG00750287 serine/threonine protein kinase and beta-lactam (PASTA) domains +FIG00750294 FIG00750296: hypothetical protein +FIG00750304 FIG00750306: hypothetical protein +FIG00750318 FIG00750320: hypothetical protein +FIG00750326 FIG00750328: hypothetical protein +FIG00750328 FIG00750331: hypothetical protein +FIG00750331 FIG00750332: hypothetical protein +FIG00750335 FIG00750338: hypothetical protein +FIG00750338 FIG00750341: hypothetical protein +FIG00750346 3-oxoacyl-(acyl carrier protein) reductase-like protein +FIG00750349 FIG00750350: hypothetical protein +FIG00750350 FIG00750351: hypothetical protein +FIG00750351 FIG00750352: hypothetical protein +FIG00750359 FIG00750364: hypothetical protein +FIG00750364 FIG00750365: hypothetical protein +FIG00750365 FIG00750367: hypothetical protein +FIG00750367 uroporphyrinogen-III synthase +FIG00750369 integrase, fragment +FIG00750376 FIG00750377: hypothetical protein +FIG00750378 FIG00750381: hypothetical protein +FIG00750381 FIG00753961: hypothetical protein +FIG00750382 FIG00750385: hypothetical protein +FIG00750390 FIG00750392: hypothetical protein +FIG00750401 FIG00750403: hypothetical protein +FIG00750403 FIG00750410: hypothetical protein +FIG00750410 FIG00750412: hypothetical protein +FIG00750433 FIG00750434: hypothetical protein +FIG00750434 FIG00750436: hypothetical protein +FIG00750437 FIG00750438: hypothetical protein +FIG00750438 FIG00750439: hypothetical protein +FIG00750444 FIG00750446: hypothetical protein +FIG00750447 FIG00750448: hypothetical protein +FIG00750450 FIG00750451: hypothetical protein +FIG00750453 FIG00750454: hypothetical protein +FIG00750454 FIG00750458: hypothetical protein +FIG00750458 Putative melibiose:Na(+) transport protein +FIG00750459 FIG00750460: hypothetical protein +FIG00750463 FIG00750464: hypothetical protein +FIG00750464 FIG00750467: hypothetical protein +FIG00750467 FIG00750468: hypothetical protein +FIG00750471 FIG00750472: hypothetical protein +FIG00750476 FIG00750477: hypothetical protein +FIG00750477 D-alanyl-D-alanine dipeptidase( EC:3.4.13.- ) +FIG00750480 ABC transporter permease component +FIG00750487 FIG00750489: hypothetical protein +FIG00750490 FIG00750491: hypothetical protein +FIG00750502 FIG00750504: hypothetical protein +FIG00750506 FIG00750508: hypothetical protein +FIG00750508 FIG00750509: hypothetical protein +FIG00750514 beta-glucosides PTS, EIIABC( EC:2.7.1.69 ) +FIG00750517 FIG00750519: hypothetical protein +FIG00750520 FIG00750521: hypothetical protein +FIG00750522 contains predicted nucleoside-diphosphate-sugar epimerase domain +FIG00750533 FIG00750534: hypothetical protein +FIG00750534 FIG00750536: hypothetical protein +FIG00750536 FIG00750537: hypothetical protein +FIG00750551 FIG00750554: hypothetical protein +FIG00750554 FIG00750555: hypothetical protein +FIG00750555 Dimeric dUTPase (EC 3.6.1.23) +FIG00750559 FIG00750561: hypothetical protein +FIG00750561 FIG00750564: hypothetical protein +FIG00750564 FIG00750565: hypothetical protein +FIG00750565 CRISPR-associated protein, Cse1 family +FIG00750566 FIG00750569: hypothetical protein +FIG00750569 FIG00750572: hypothetical protein +FIG00750572 FIG00750574: hypothetical protein +FIG00750578 FIG00750580: hypothetical protein +FIG00750580 FIG00750582: hypothetical protein +FIG00750583 FIG00750585: hypothetical protein +FIG00750591 FIG00750596: hypothetical protein +FIG00750600 FIG00750601: hypothetical protein +FIG00750601 FIG00750602: hypothetical protein +FIG00750602 contains glutamine amidotransferase class-I domain +FIG00750603 FIG00750608: hypothetical protein +FIG00750610 putative enterolysin A +FIG00750611 FIG00750612: hypothetical protein +FIG00750612 acetoacetate decarboxylase (putative) +FIG00750617 FIG00750619: hypothetical protein +FIG00750622 FIG00750623: hypothetical protein +FIG00750623 FIG00750624: hypothetical protein +FIG00750630 FIG00750631: hypothetical protein +FIG00750637 FIG00750638: hypothetical protein +FIG00750638 FIG00750639: hypothetical protein +FIG00750640 FIG00750642: hypothetical protein +FIG00750642 putative serine-specific protein kinase +FIG00750645 FIG00750646: hypothetical protein +FIG00750647 FIG00750648: hypothetical protein +FIG00750651 FIG00750652: hypothetical protein +FIG00750652 Hypothetical cell surface protein precursor +FIG00750666 FIG00750667: hypothetical protein +FIG00750672 FIG00750675: hypothetical protein +FIG00750681 FIG00750682: hypothetical protein +FIG00750683 FIG00750685: hypothetical protein +FIG00750685 hypothetical protein, nickel resistance determinant +FIG00750687 FIG00750688: hypothetical protein +FIG00750699 FIG00750702: hypothetical protein +FIG00750702 FIG00750704: hypothetical protein +FIG00750707 metal-dependent hydrolase (putative) +FIG00750711 FIG00750714: hypothetical protein +FIG00750714 FIG00750718: hypothetical protein +FIG00750723 FIG00750724: hypothetical protein +FIG00750724 FIG00750726: hypothetical protein +FIG00750727 FIG00750729: hypothetical protein +FIG00750729 FIG00750730: hypothetical protein +FIG00750730 prophage Lp1 protein 46 +FIG00750737 FIG00750739: hypothetical protein +FIG00750742 Lactacin F two-component system inducer peptide +FIG00750746 FIG00750750: hypothetical protein +FIG00750750 FIG00750754: hypothetical protein +FIG00750754 FIG00750757: hypothetical protein +FIG00750757 FIG00750760: hypothetical protein +FIG00750760 FIG00750761: hypothetical protein +FIG00750764 Conserved membrane protein, GtcA family +FIG00750766 FIG00750767: hypothetical protein +FIG00750770 FIG00750772: hypothetical protein +FIG00750772 H+-transporting ATPase, plasma membrane-type +FIG00750773 FIG00750780: hypothetical protein +FIG00750780 FIG00750781: hypothetical protein +FIG00750781 Glucose-1-phosphate adenylyltransferase (EC 2.7.7.27) (ADP-glucose synthase) (ADP-glucose pyrophosphorylase) (ADPGlc PPase) +FIG00750788 FIG00750789: hypothetical protein +FIG00750790 FIG00750795: hypothetical protein +FIG00750796 FIG00750797: hypothetical protein +FIG00750798 FIG00750800: hypothetical protein +FIG00750801 FIG00750802: hypothetical protein +FIG00750802 FIG00750803: hypothetical protein +FIG00750814 FIG00750815: hypothetical protein +FIG00750823 FIG00750825: hypothetical protein +FIG00750841 FIG00750844: hypothetical protein +FIG00750845 FIG00750846: hypothetical protein +FIG00750847 FIG00750848: hypothetical protein +FIG00750848 FIG00750849: hypothetical protein +FIG00750850 FIG00750852: hypothetical protein +FIG00750868 FIG00750871: hypothetical protein +FIG00750871 2-haloacid dehalogenase (putative) +FIG00750872 FIG00750873: hypothetical protein +FIG00750873 FIG00750874: hypothetical protein +FIG00750874 conserved hypothetical protein, Cof family, truncated +FIG00750878 FIG00750880: hypothetical protein +FIG00750880 L-O-lysylphosphatidylglycerol synthase (EC 2.3.2.3) +FIG00750886 transcriptional regulator (TetR/AcrR family) +FIG00750887 FIG00750888: hypothetical protein +FIG00750890 FIG00750891: hypothetical protein +FIG00750891 prophage DNA packaging protein NU1 +FIG00750899 FIG00750900: hypothetical protein +FIG00750904 FIG00750905: hypothetical protein +FIG00750910 FIG00750912: hypothetical protein +FIG00750913 FIG00750914: hypothetical protein +FIG00750915 FIG00750919: hypothetical protein +FIG00750921 Multidrug resistance protein 12 (P-glycoprotein 14) +FIG00750925 FIG00750926: hypothetical protein +FIG00750926 cell surface protein precursor (putative) +FIG00750927 FIG00750928: hypothetical protein +FIG00750930 FIG00750931: hypothetical protein +FIG00750937 FIG00750939: hypothetical protein +FIG00750939 FIG00750940: hypothetical protein +FIG00750940 Glutamine ABC transporter substrate-binding protein +FIG00750946 protein of unknown function UPF0074 +FIG00750948 FIG00750950: hypothetical protein +FIG00750952 FIG00750956: hypothetical protein +FIG00750956 FIG00750957: hypothetical protein +FIG00750959 FIG00750962: hypothetical protein +FIG00750962 FIG00750963: hypothetical protein +FIG00750965 FIG00750966: hypothetical protein +FIG00750968 FIG00750969: hypothetical protein +FIG00750969 FIG00750970: hypothetical protein +FIG00750976 FIG00750978: hypothetical protein +FIG00750985 FIG00750986: hypothetical protein +FIG00750992 DNA or RNA helicase of superfamily II +FIG00750993 FIG00750994: hypothetical protein +FIG00750996 FIG00750997: hypothetical protein +FIG00750997 FIG00751001: hypothetical protein +FIG00751004 Plasmid maintenance system killer protein +FIG00751007 FIG00751008: hypothetical protein +FIG00751008 conjugation protein +FIG00751010 Predicted Rossmann fold nucleotide-binding protein +FIG00751016 FIG00751017: hypothetical protein +FIG00751022 FIG00751025: hypothetical protein +FIG00751025 FIG00751026: hypothetical protein +FIG00751038 FIG00751039: hypothetical protein +FIG00751041 FIG00751042: hypothetical protein +FIG00751042 FIG00751043: hypothetical protein +FIG00751045 sugar kinase -putative transcriptional regulator +FIG00751047 FIG00751048: hypothetical protein +FIG00751052 FIG00751053: hypothetical protein +FIG00751054 aryl-alcohol dehydrogenase( EC:1.1.1.90 ) +FIG00751064 FIG00751066: hypothetical protein +FIG00751066 FIG00751067: hypothetical protein +FIG00751069 FIG00751070: hypothetical protein +FIG00751070 FIG00751071: hypothetical protein +FIG00751071 FIG00751072: hypothetical protein +FIG00751074 FIG00751075: hypothetical protein +FIG00751078 FIG00751087: hypothetical protein +FIG00751087 FIG00751088: hypothetical protein +FIG00751088 FIG00751089: hypothetical protein +FIG00751094 PTS system, IId component +FIG00751103 FIG00751104: hypothetical protein +FIG00751107 FIG00751108: hypothetical protein +FIG00751108 FIG00751109: hypothetical protein +FIG00751112 FIG00751117: hypothetical protein +FIG00751122 FIG00751124: hypothetical protein +FIG00751127 FIG00751128: hypothetical protein +FIG00751128 FIG00751131: hypothetical protein +FIG00751142 FIG00751148: hypothetical protein +FIG00751152 FIG00751154: hypothetical protein +FIG00751159 FIG00751160: hypothetical protein +FIG00751160 FIG00751161: hypothetical protein +FIG00751161 Tyrosine recombinase xerC +FIG00751165 FIG00751167: hypothetical protein +FIG00751167 FIG00751168: hypothetical protein +FIG00751168 FIG00751170: hypothetical protein +FIG00751170 FIG00751173: hypothetical protein +FIG00751177 FIG00751178: hypothetical protein +FIG00751179 FIG00751184: hypothetical protein +FIG00751184 FIG00751185: hypothetical protein +FIG00751186 FIG00751187: hypothetical protein +FIG00751199 FIG00751200: hypothetical protein +FIG00751200 FIG00751202: hypothetical protein +FIG00751206 FIG00751207: hypothetical protein +FIG00751213 FIG00751214: hypothetical protein +FIG00751217 FIG00751218: hypothetical protein +FIG00751220 FIG00751222: hypothetical protein +FIG00751227 FIG00751229: hypothetical protein +FIG00751239 FIG01116301: hypothetical protein +FIG00751246 FIG00751247: hypothetical protein +FIG00751247 FIG00751248: hypothetical protein +FIG00751248 FIG00751249: hypothetical protein +FIG00751250 FIG00751251: hypothetical protein +FIG00751260 Peptidase M10A and M12B, matrixin and adamalysin +FIG00751262 FIG00751263: hypothetical protein +FIG00751263 FIG00751264: hypothetical protein +FIG00751276 FIG00751277: hypothetical protein +FIG00751277 FIG00751280: hypothetical protein +FIG00751280 FIG00751281: hypothetical protein +FIG00751285 FIG00751289: hypothetical protein +FIG00751294 FIG00751296: hypothetical protein +FIG00751296 FIG00751297: hypothetical protein +FIG00751297 conserved hypothetical protein, Cof family +FIG00751299 FIG00751301: hypothetical protein +FIG00751301 FIG00751302: hypothetical protein +FIG00751302 FIG00751303: hypothetical protein +FIG00751303 FIG00751306: hypothetical protein +FIG00751307 Prophage Lp2 protein 4 +FIG00751313 FIG00751314: hypothetical protein +FIG00751318 FIG00751319: hypothetical protein +FIG00751319 FIG00751320: hypothetical protein +FIG00751334 FIG00751335: hypothetical protein +FIG00751335 FIG00751338: hypothetical protein +FIG00751343 FIG00751344: hypothetical protein +FIG00751344 FIG00751345: hypothetical protein +FIG00751350 FIG00751351: hypothetical protein +FIG00751351 2-oxo-hepta-3-ene-1,7-dioate hydratase +FIG00751358 FIG00751360: hypothetical protein +FIG00751361 FIG00751362: hypothetical protein +FIG00751362 FIG00751369: hypothetical protein +FIG00751369 FIG00751373: hypothetical protein +FIG00751376 FIG00751377: hypothetical protein +FIG00751379 FIG00751381: hypothetical protein +FIG00751384 FIG00751385: hypothetical protein +FIG00751385 FIG00751386: hypothetical protein +FIG00751386 FIG00751393: hypothetical protein +FIG00751393 FIG00751395: hypothetical protein +FIG00751404 Serine/threonine exchanger SteT +FIG00751409 FIG00751412: hypothetical protein +FIG00751412 FIG00751417: hypothetical protein +FIG00751424 FIG00751425: hypothetical protein +FIG00751428 FIG00751429: hypothetical protein +FIG00751429 FIG00751432: hypothetical protein +FIG00751434 FIG00751435: hypothetical protein +FIG00751435 FIG00751437: hypothetical protein +FIG00751439 FIG00751441: hypothetical protein +FIG00751446 FIG00751449: hypothetical protein +FIG00751451 FIG00751453: hypothetical protein +FIG00751453 4-methyl-5(B-hydroxyethyl)-thiazole monophosphate biosynthesis enzyme +FIG00751461 FIG00751462: hypothetical protein +FIG00751462 gtrA family protein +FIG00751476 Bacteriocin ABC-transporter, ATP-binding and permease component +FIG00751477 FIG00751479: hypothetical protein +FIG00751482 FIG00751483: hypothetical protein +FIG00751491 FIG00751493: hypothetical protein +FIG00751494 CRISPR-associated protein, SAG0897 family +FIG00751502 FIG00751505: hypothetical protein +FIG00751508 sodium/sulfate symport protein (putative) +FIG00751509 FIG00751510: hypothetical protein +FIG00751514 FIG00751516: hypothetical protein +FIG00751523 FIG00751524: hypothetical protein +FIG00751528 DNA-damage-inducible gene +FIG00751532 FIG00751533: hypothetical protein +FIG00751535 FIG00751538: hypothetical protein +FIG00751538 FIG00751540: hypothetical protein +FIG00751540 FIG00751544: hypothetical protein +FIG00751544 FIG00751545: hypothetical protein +FIG00751545 FIG00751546: hypothetical protein +FIG00751548 FIG00751549: hypothetical protein +FIG00751554 FIG00751556: hypothetical protein +FIG00751560 FIG00751563: hypothetical protein +FIG00751563 Diadenosine tetraphosphate (Ap4A) hydrolase related HIT family hydrolase +FIG00751567 FIG00751568: hypothetical protein +FIG00751572 FIG00751575: hypothetical protein +FIG00751583 FIG00751586: hypothetical protein +FIG00751586 integral membrane protein (putative) +FIG00751592 FIG00751593: hypothetical protein +FIG00751596 FIG00751599: hypothetical protein +FIG00751599 FIG00751601: hypothetical protein +FIG00751601 FIG00751602: hypothetical protein +FIG00751603 FIG00751604: hypothetical protein +FIG00751613 FIG00751614: hypothetical protein +FIG00751614 FIG00751615: hypothetical protein +FIG00751615 FIG00751618: hypothetical protein +FIG00751626 FIG00751630: hypothetical protein +FIG00751630 FIG00751631: hypothetical protein +FIG00751637 FIG00751638: hypothetical protein +FIG00751638 FIG00751639: hypothetical protein +FIG00751639 FIG00751640: hypothetical protein +FIG00751640 FIG00751643: hypothetical protein +FIG00751646 FIG00751647: hypothetical protein +FIG00751647 Penicillin V acylase related amidase +FIG00751650 FIG00751658: hypothetical protein +FIG00751658 Alpha/beta hydrolase fold-3 domain protein +FIG00751667 FIG00751668: hypothetical protein +FIG00751670 protein TrsD +FIG00751681 FIG00751683: hypothetical protein +FIG00751683 FIG00751684: hypothetical protein +FIG00751687 FIG00751689: hypothetical protein +FIG00751689 FIG00751694: hypothetical protein +FIG00751697 FIG00751701: hypothetical protein +FIG00751702 FIG00751703: hypothetical protein +FIG00751703 FIG00751704: hypothetical protein +FIG00751725 FIG00751726: hypothetical protein +FIG00751726 FIG00751727: hypothetical protein +FIG00751734 FIG00751735: hypothetical protein +FIG00751735 FIG00751736: hypothetical protein +FIG00751736 FIG00751737: hypothetical protein +FIG00751738 beta-1,3-glucanase precursor +FIG00751749 FIG00751752: hypothetical protein +FIG00751754 FIG00751755: hypothetical protein +FIG00751760 orf97 +FIG00751764 FIG00751765: hypothetical protein +FIG00751765 FIG00751769: hypothetical protein +FIG00751770 FIG00751771: hypothetical protein +FIG00751781 FIG00751783: hypothetical protein +FIG00751784 FIG00751786: hypothetical protein +FIG00751786 FIG00751788: hypothetical protein +FIG00751789 FIG00751791: hypothetical protein +FIG00751791 FIG00751792: hypothetical protein +FIG00751796 FIG00751798: hypothetical protein +FIG00751798 Short-chain dehydrogenase/oxidoreductase +FIG00751810 FIG00751814: hypothetical protein +FIG00751815 FIG00751816: hypothetical protein +FIG00751823 FIG00751824: hypothetical protein +FIG00751825 FIG00751826: hypothetical protein +FIG00751826 FIG00751827: hypothetical protein +FIG00751827 FIG00751828: hypothetical protein +FIG00751829 FIG00751831: hypothetical protein +FIG00751834 FIG00751836: hypothetical protein +FIG00751837 FIG00751838: hypothetical protein +FIG00751840 FIG00751841: hypothetical protein +FIG00751844 FIG00751846: hypothetical protein +FIG00751848 Adhesion exoprotein +FIG00751850 FIG00751857: hypothetical protein +FIG00751857 N-acetylglucosaminyltransferase +FIG00751858 FIG00751860: hypothetical protein +FIG00751860 FIG00751862: hypothetical protein +FIG00751862 ABC-type amino acid transport system, permease and periplasmic component +FIG00751874 FIG00751876: hypothetical protein +FIG00751878 FIG00751880: hypothetical protein +FIG00751884 FIG00751886: hypothetical protein +FIG00751887 FIG00751889: hypothetical protein +FIG00751893 NADH nitroreductase +FIG00751896 FIG00751900: hypothetical protein +FIG00751908 FIG00751909: hypothetical protein +FIG00751909 FIG00751910: hypothetical protein +FIG00751910 histone H1 +FIG00751912 FIG00751913: hypothetical protein +FIG00751915 FIG00751916: hypothetical protein +FIG00751916 FIG00751924: hypothetical protein +FIG00751925 Lactate dehydrogenase related 2-hydroxyacid dehydrogenase +FIG00751933 Proline/glycine betaine ABC-type transport system, permease component +FIG00751934 DNA-binding response regulator, OmpR family +FIG00751942 AraC-type DNA-binding protein +FIG00751947 FIG00751948: hypothetical protein +FIG00751952 FIG00751954: hypothetical protein +FIG00751985 FIG00751986: hypothetical protein +FIG00751986 galacturonosyl transferase +FIG00752006 FIG00752009: hypothetical protein +FIG00752009 FIG00752011: hypothetical protein +FIG00752011 FIG00752012: hypothetical protein +FIG00752012 FIG00752013: hypothetical protein +FIG00752014 FIG00752016: hypothetical protein +FIG00752017 FIG00752018: hypothetical protein +FIG00752020 FIG00752025: hypothetical protein +FIG00752025 FIG00752027: hypothetical protein +FIG00752027 FIG00752030: hypothetical protein +FIG00752030 FIG00752037: hypothetical protein +FIG00752040 FIG00752041: hypothetical protein +FIG00752048 FIG00752052: hypothetical protein +FIG00752060 FIG00752061: hypothetical protein +FIG00752061 FIG00752069: hypothetical protein +FIG00752071 FIG00752075: hypothetical protein +FIG00752082 FIG00752084: hypothetical protein +FIG00752093 FIG00752096: hypothetical protein +FIG00752099 FIG00752100: hypothetical protein +FIG00752102 glucose PTS, EIIA( EC:2.7.1.69 ) +FIG00752110 FIG00752111: hypothetical protein +FIG00752111 FIG00752112: hypothetical protein +FIG00752112 FIG00752114: hypothetical protein +FIG00752118 FIG00752121: hypothetical protein +FIG00752121 FIG00752122: hypothetical protein +FIG00752131 FIG00752132: hypothetical protein +FIG00752133 FIG00752134: hypothetical protein +FIG00752134 FIG00752135: hypothetical protein +FIG00752139 lactose transport regulator +FIG00752140 FIG00752141: hypothetical protein +FIG00752141 FIG00752142: hypothetical protein +FIG00752144 FIG00752147: hypothetical protein +FIG00752160 FIG00752161: hypothetical protein +FIG00752162 FIG00752164: hypothetical protein +FIG00752164 FIG00752165: hypothetical protein +FIG00752176 FIG00752177: hypothetical protein +FIG00752179 FIG00752180: hypothetical protein +FIG00752180 protein containing diguanylate cyclase/phosphodiesterase domain 2 (EAL) +FIG00752185 FIG00752187: hypothetical protein +FIG00752187 FIG00752190: hypothetical protein +FIG00752192 FIG00752194: hypothetical protein +FIG00752200 FIG00752201: hypothetical protein +FIG00752206 FIG00752207: hypothetical protein +FIG00752222 FIG00752224: hypothetical protein +FIG00752230 FIG00752231: hypothetical protein +FIG00752232 FIG00752237: hypothetical protein +FIG00752237 FIG00752240: hypothetical protein +FIG00752241 Phage anti-repressor protein +FIG00752243 FIG00752245: hypothetical protein +FIG00752246 FIG00752248: hypothetical protein +FIG00752248 FIG00752250: hypothetical protein +FIG00752258 FIG00752261: hypothetical protein +FIG00752261 putative endonuclease-exonuclease-phosphatase family protein +FIG00752267 FIG00752269: hypothetical protein +FIG00752270 intercellular adhesion protein +FIG00752280 FIG00752282: hypothetical protein +FIG00752283 FIG00752284: hypothetical protein +FIG00752295 FIG00752296: hypothetical protein +FIG00752306 FIG00752307: hypothetical protein +FIG00752307 FIG00752308: hypothetical protein +FIG00752316 FIG00752318: hypothetical protein +FIG00752320 FIG00752321: hypothetical protein +FIG00752329 FIG00752330: hypothetical protein +FIG00752332 FIG00752347: hypothetical protein +FIG00752348 FIG00752349: hypothetical protein +FIG00752349 FIG00752350: hypothetical protein +FIG00752350 FIG00752351: hypothetical protein +FIG00752355 FIG00752356: hypothetical protein +FIG00752362 FIG00752363: hypothetical protein +FIG00752366 FIG00752372: hypothetical protein +FIG00752372 FIG00752375: hypothetical protein +FIG00752377 FIG00752383: hypothetical protein +FIG00752386 FIG00752387: hypothetical protein +FIG00752388 FIG00752389: hypothetical protein +FIG00752389 FIG00752392: hypothetical protein +FIG00752409 FIG00752414: hypothetical protein +FIG00752414 FIG00752417: hypothetical protein +FIG00752421 FIG00752425: hypothetical protein +FIG00752425 FIG00752428: hypothetical protein +FIG00752429 FIG00752432: hypothetical protein +FIG00752434 FIG00752436: hypothetical protein +FIG00752444 FIG00752445: hypothetical protein +FIG00752462 FIG00752466: hypothetical protein +FIG00752470 FIG00752472: hypothetical protein +FIG00752485 FIG00752487: hypothetical protein +FIG00752487 FIG00752488: hypothetical protein +FIG00752488 FIG00752489: hypothetical protein +FIG00752494 FIG00752495: hypothetical protein +FIG00752495 FIG00752497: hypothetical protein +FIG00752506 FIG00752508: hypothetical protein +FIG00752511 FIG00752512: hypothetical protein +FIG00752513 FIG00752514: hypothetical protein +FIG00752514 FIG00752517: hypothetical protein +FIG00752523 FIG00752524: hypothetical protein +FIG00752525 FMN-binding protein +FIG00752532 FIG00752535: hypothetical protein +FIG00752539 FIG00752542: hypothetical protein +FIG00752542 FIG00752548: hypothetical protein +FIG00752557 FIG00752562: hypothetical protein +FIG00752562 FIG00752563: hypothetical protein +FIG00752580 NTP pyrophosphohydrolase( EC:3.6.1.- ) +FIG00752583 FIG00752586: hypothetical protein +FIG00752586 FIG00752587: hypothetical protein +FIG00752591 FIG00752593: hypothetical protein +FIG00752593 FIG00752596: hypothetical protein +FIG00752597 Phage endolysin +FIG00752604 putative lipoprotein A-antigen precursor +FIG00752606 FIG00752608: hypothetical protein +FIG00752609 FIG00752614: hypothetical protein +FIG00752621 FIG00752622: hypothetical protein +FIG00752622 protein of unknown function DUF915, hydrolase family protein +FIG00752628 FIG00752629: hypothetical protein +FIG00752629 FIG00752630: hypothetical protein +FIG00752634 FIG00752635: hypothetical protein +FIG00752635 FIG00752639: hypothetical protein +FIG00752644 FIG00752645: hypothetical protein +FIG00752648 Helicase-like:Type III restriction enzyme, res subunit:DEAD/DEAH box helicase-like +FIG00752654 FIG00752658: hypothetical protein +FIG00752676 FIG00752677: hypothetical protein +FIG00752677 FIG00752678: hypothetical protein +FIG00752678 FIG00752680: hypothetical protein +FIG00752680 FIG00752681: hypothetical protein +FIG00752681 FIG00752687: hypothetical protein +FIG00752692 glutamine amidotransferase of anthranilate synthase or para-aminobenzoate synthase( EC:4.1.3.27 ) +FIG00752694 FIG00752700: hypothetical protein +FIG00752700 FIG00752701: hypothetical protein +FIG00752704 FIG00752706: hypothetical protein +FIG00752706 FIG00752707: hypothetical protein +FIG00752718 FIG00752719: hypothetical protein +FIG00752724 FIG00752725: hypothetical protein +FIG00752726 FIG00752731: hypothetical protein +FIG00752734 FIG00752735: hypothetical protein +FIG00752741 FIG00752743: hypothetical protein +FIG00752743 lyzozyme M1, 1,4-beta-N-acetylmuramidase +FIG00752759 FIG00752761: hypothetical protein +FIG00752765 FIG00752766: hypothetical protein +FIG00752771 FIG00752773: hypothetical protein +FIG00752775 FIG00752778: hypothetical protein +FIG00752778 FIG00752779: hypothetical protein +FIG00752779 FIG00752785: hypothetical protein +FIG00752806 FIG00752807: hypothetical protein +FIG00752812 FIG00752816: hypothetical protein +FIG00752820 FIG00752821: hypothetical protein +FIG00752822 FIG00752823: hypothetical protein +FIG00752826 FIG00752829: hypothetical protein +FIG00752834 FIG00752836: hypothetical protein +FIG00752836 FIG00752837: hypothetical protein +FIG00752837 FIG00752840: hypothetical protein +FIG00752840 FIG00752841: hypothetical protein +FIG00752841 FIG00752844: hypothetical protein +FIG00752844 FIG00752849: hypothetical protein +FIG00752849 FIG00752852: hypothetical protein +FIG00752854 FIG00752856: hypothetical protein +FIG00752861 FIG00752863: hypothetical protein +FIG00752866 FIG00752867: hypothetical protein +FIG00752867 FIG00752869: hypothetical protein +FIG00752872 FIG00752875: hypothetical protein +FIG00752880 FIG00752881: hypothetical protein +FIG00752883 chromosome segregation helicase (putative) +FIG00752893 FIG00752894: hypothetical protein +FIG00752896 FIG00752897: hypothetical protein +FIG00752897 FIG00752900: hypothetical protein +FIG00752904 PTS system, IIc component +FIG00752916 FIG00752917: hypothetical protein +FIG00752917 FIG00752919: hypothetical protein +FIG00752919 FIG00752923: hypothetical protein +FIG00752923 FIG00752925: hypothetical protein +FIG00752925 FIG00752929: hypothetical protein +FIG00752932 FIG00752933: hypothetical protein +FIG00752935 FIG00752938: hypothetical protein +FIG00752941 FIG00752943: hypothetical protein +FIG00752959 FIG00752961: hypothetical protein +FIG00752961 FIG00752962: hypothetical protein +FIG00752965 hypothetical protein, lipoprotein +FIG00752968 Transcriptional regulator (LysR family) +FIG00752970 FIG00752971: hypothetical protein +FIG00752971 FIG00752976: hypothetical protein +FIG00752976 FIG00752978: hypothetical protein +FIG00752978 FIG00752979: hypothetical protein +FIG00752984 FIG00752987: hypothetical protein +FIG00752987 FIG00752989: hypothetical protein +FIG00752989 FIG00752990: hypothetical protein +FIG00752990 FIG00752991: hypothetical protein +FIG00752991 FIG00752992: hypothetical protein +FIG00753007 FIG00753008: hypothetical protein +FIG00753012 FIG00753014: hypothetical protein +FIG00753014 FIG00753019: hypothetical protein +FIG00753029 Protein of unknown function DUF915, hydrolase-like +FIG00753032 Phosphoglycerate mutase family +FIG00753039 FIG00753043: hypothetical protein +FIG00753043 FIG00753047: hypothetical protein +FIG00753056 FIG00753059: hypothetical protein +FIG00753069 FIG00753071: hypothetical protein +FIG00753083 FIG00753085: hypothetical protein +FIG00753094 FIG00753096: hypothetical protein +FIG00753096 FIG00753097: hypothetical protein +FIG00753103 FIG00753104: hypothetical protein +FIG00753128 FIG00753130: hypothetical protein +FIG00753131 FIG00753132: hypothetical protein +FIG00753133 FIG00753135: hypothetical protein +FIG00753147 histidine protein kinase; sensor protein( EC:2.7.3.- ) +FIG00753148 FIG00753149: hypothetical protein +FIG00753149 FIG00753151: hypothetical protein +FIG00753155 FIG00753157: hypothetical protein +FIG00753157 FIG00753159: hypothetical protein +FIG00753174 FIG00753176: hypothetical protein +FIG00753176 putative mucus binding protein +FIG00753177 FIG00753178: hypothetical protein +FIG00753182 FIG00753183: hypothetical protein +FIG00753183 FIG00753185: hypothetical protein +FIG00753189 FIG00753191: hypothetical protein +FIG00753197 FIG00753200: hypothetical protein +FIG00753206 FIG00753207: hypothetical protein +FIG00753213 FIG00753216: hypothetical protein +FIG00753218 FIG00753219: hypothetical protein +FIG00753223 FIG00753224: hypothetical protein +FIG00753233 FIG00753242: hypothetical protein +FIG00753242 FIG00753243: hypothetical protein +FIG00753251 FIG00753252: hypothetical protein +FIG00753252 FIG00753255: hypothetical protein +FIG00753255 FIG00753257: hypothetical protein +FIG00753261 FIG00753262: hypothetical protein +FIG00753262 protein TrsJ +FIG00753273 alcohol dehydrogenase( EC:1.1.1.1 ) +FIG00753274 bacteriocin precursor peptide PlnJ (putative) +FIG00753279 FIG00753284: hypothetical protein +FIG00753284 FIG00753285: hypothetical protein +FIG00753285 prophage Lp4 protein 12 +FIG00753292 FIG00753293: hypothetical protein +FIG00753297 FIG00753298: hypothetical protein +FIG00753298 FIG00753303: hypothetical protein +FIG00753303 FIG00753304: hypothetical protein +FIG00753305 FIG00753306: hypothetical protein +FIG00753306 FIG00753307: hypothetical protein +FIG00753307 FIG00753312: hypothetical protein +FIG00753316 FIG00753317: hypothetical protein +FIG00753317 FIG00753319: hypothetical protein +FIG00753324 FIG00753327: hypothetical protein +FIG00753328 FIG00753329: hypothetical protein +FIG00753339 FIG00753340: hypothetical protein +FIG00753341 FIG00753343: hypothetical protein +FIG00753351 FIG00753354: hypothetical protein +FIG00753356 Three-component quorum-sensing regulatory system, inducing peptide for bacteriocin biosynthesis +FIG00753357 Galactofuranosyltransferase( EC:2.4.1.- ) +FIG00753359 FIG00753365: hypothetical protein +FIG00753368 FIG00753369: hypothetical protein +FIG00753369 FIG00753374: hypothetical protein +FIG00753381 FIG00753382: hypothetical protein +FIG00753382 FIG00753387: hypothetical protein +FIG00753387 FIG00753388: hypothetical protein +FIG00753391 transcription regulator (putative) +FIG00753397 FIG00753398: hypothetical protein +FIG00753407 FIG00753408: hypothetical protein +FIG00753420 Carbonate dehydratase( EC:4.2.1.1 ) +FIG00753424 FIG00753425: hypothetical protein +FIG00753432 FIG00753433: hypothetical protein +FIG00753442 FIG00753443: hypothetical protein +FIG00753451 FIG00753459: hypothetical protein +FIG00753459 FIG00753462: hypothetical protein +FIG00753462 FIG00753464: hypothetical protein +FIG00753473 FIG00753474: hypothetical protein +FIG00753474 FIG00753476: hypothetical protein +FIG00753476 FIG00753478: hypothetical protein +FIG00753487 prophage Lp1 protein 19 +FIG00753495 x-prolyl-dipeptidyl aminopeptidase +FIG00753499 2O-beta-hydroxysteroid dehydrogenase( EC:1.1.1.53 ) +FIG00753505 FIG00753506: hypothetical protein +FIG00753507 FIG00753508: hypothetical protein +FIG00753508 FIG00753512: hypothetical protein +FIG00753513 FIG00753514: hypothetical protein +FIG00753515 FIG00753520: hypothetical protein +FIG00753522 FIG00753523: hypothetical protein +FIG00753523 FIG00753524: hypothetical protein +FIG00753525 FIG00753531: hypothetical protein +FIG00753534 FIG00753535: hypothetical protein +FIG00753537 Hypothetical protein, ErfK family +FIG00753550 FIG00753552: hypothetical protein +FIG00753562 S-layer protein precursor +FIG00753566 FIG00753567: hypothetical protein +FIG00753576 Carbonic anhydrase +FIG00753577 FIG00753580: hypothetical protein +FIG00753580 FIG00753582: hypothetical protein +FIG00753582 iron(III) dicitrate ABC transporter (ATP-binding protein) +FIG00753586 FIG00753588: hypothetical protein +FIG00753603 FIG00753608: hypothetical protein +FIG00753618 FIG00753619: hypothetical protein +FIG00753647 FIG00753649: hypothetical protein +FIG00753653 FIG00753655: hypothetical protein +FIG00753655 FIG00753657: hypothetical protein +FIG00753657 FIG00753658: hypothetical protein +FIG00753664 FIG00753666: hypothetical protein +FIG00753666 FIG00753669: hypothetical protein +FIG00753669 FIG00753671: hypothetical protein +FIG00753684 FIG00753685: hypothetical protein +FIG00753695 FIG00753698: hypothetical protein +FIG00753698 FIG00753701: hypothetical protein +FIG00753710 FIG00753712: hypothetical protein +FIG00753723 FIG00753725: hypothetical protein +FIG00753725 muramidase( EC:3.2.1.17 ) +FIG00753733 FIG00753734: hypothetical protein +FIG00753741 FIG00753743: hypothetical protein +FIG00753746 FIG00753748: hypothetical protein +FIG00753759 FIG00753765: hypothetical protein +FIG00753765 FIG00753767: hypothetical protein +FIG00753767 FIG00753770: hypothetical protein +FIG00753770 FIG00753771: hypothetical protein +FIG00753774 FIG00753779: hypothetical protein +FIG00753779 FIG00753781: hypothetical protein +FIG00753782 FIG00753784: hypothetical protein +FIG00753784 FIG00753785: hypothetical protein +FIG00753789 FIG00753790: hypothetical protein +FIG00753794 FIG00753798: hypothetical protein +FIG00753808 FIG00753813: hypothetical protein +FIG00753813 FIG00753815: hypothetical protein +FIG00753815 FIG00753819: hypothetical protein +FIG00753819 FIG00753821: hypothetical protein +FIG00753840 FIG00753841: hypothetical protein +FIG00753862 FIG00753867: hypothetical protein +FIG00753868 FIG00753869: hypothetical protein +FIG00753869 NADH-dependent oxidoreductase +FIG00753876 glycosyltransferase (putative) +FIG00753878 FIG00753879: hypothetical protein +FIG00753881 FIG00753882: hypothetical protein +FIG00753882 FIG00753883: hypothetical protein +FIG00753889 FIG00753890: hypothetical protein +FIG00753891 FIG00753894: hypothetical protein +FIG00753907 sensor histidine kinase (homolog to ciaH Spn), truncated +FIG00753917 ppGpp-regulated growth inhibitor +FIG00753923 FIG00753926: hypothetical protein +FIG00753942 FIG00753943: hypothetical protein +FIG00753945 putative ABC transporter ATP-binding and permease component +FIG00753980 FIG00753986: hypothetical protein +FIG00753986 FIG00753988: hypothetical protein +FIG00753988 FIG00753989: hypothetical protein +FIG00754000 FIG00754011: hypothetical protein +FIG00754011 FIG00754012: hypothetical protein +FIG00754012 protein containing diguanylate cyclase/phosphodiesterase domain 1 (GGDEF) +FIG00754020 FIG00754023: hypothetical protein +FIG00754023 FIG00754025: hypothetical protein +FIG00754028 D-aminopeptidase (EC 3.4.11.19) +FIG00754030 FIG00754031: hypothetical protein +FIG00754040 FIG00754043: hypothetical protein +FIG00754043 FIG00754047: hypothetical protein +FIG00754051 FIG00754053: hypothetical protein +FIG00754062 FIG00754063: hypothetical protein +FIG00754063 FIG00754064: hypothetical protein +FIG00754079 HesB/YadR/YfhF +FIG00754087 FIG00754088: hypothetical protein +FIG00754090 Multidrug transport protein +FIG00754092 FIG00754096: hypothetical protein +FIG00754115 Viral enhancing factor +FIG00754127 Trk system potassium uptake protein trkA +FIG00754132 phosphoenolpyruvate-dependent sugar phosphotransferase system EIIC, probable galactitol specific +FIG00754141 FIG00754145: hypothetical protein +FIG00754147 FIG00754149: hypothetical protein +FIG00754149 FIG00754152: hypothetical protein +FIG00754158 FIG00754159: hypothetical protein +FIG00754161 magnesium transporter CorA +FIG00754164 FIG00754168: hypothetical protein +FIG00754168 FIG00754174: hypothetical protein +FIG00754182 FIG00754183: hypothetical protein +FIG00754183 Short chain dehydrogenase dehydrogenases +FIG00754188 FIG00754190: hypothetical protein +FIG00754192 FIG00754195: hypothetical protein +FIG00754198 FIG00754199: hypothetical protein +FIG00754199 FIG00754201: hypothetical protein +FIG00754203 Amino acid ABC transporter, substrate binding protein +FIG00754208 FIG00754209: hypothetical protein +FIG00754221 FIG00754600: hypothetical protein +FIG00754224 FIG00754227: hypothetical protein +FIG00754227 PTS system, Lactose specific IIB subunit subfamily +FIG00754242 FIG00754243: hypothetical protein +FIG00754243 FIG00754245: hypothetical protein +FIG00754247 FIG00754250: hypothetical protein +FIG00754250 pts system, sucrose-specific iibc component +FIG00754257 FIG00754261: hypothetical protein +FIG00754272 purine transport regulator +FIG00754282 FIG00754287: hypothetical protein +FIG00754288 6 Protein of unknown function, without similarity to other proteins +FIG00754295 FIG00754296: hypothetical protein +FIG00754298 FIG00754301: hypothetical protein +FIG00754301 FIG00754305: hypothetical protein +FIG00754306 FIG00754309: hypothetical protein +FIG00754312 FIG00754313: hypothetical protein +FIG00754320 FIG00754321: hypothetical protein +FIG00754321 FIG00754324: hypothetical protein +FIG00754326 Putative metalloproteinase +FIG00754327 FIG00754332: hypothetical protein +FIG00754334 FIG00754337: hypothetical protein +FIG00754337 FIG00754339: hypothetical protein +FIG00754342 FIG00754347: hypothetical protein +FIG00754347 FIG00754358: hypothetical protein +FIG00754380 FIG00754381: hypothetical protein +FIG00754384 FIG00754386: hypothetical protein +FIG00754396 FIG00754398: hypothetical protein +FIG00754399 FIG00754400: hypothetical protein +FIG00754400 FIG00754402: hypothetical protein +FIG00754418 ADP-ribose pyrophosphatase (putative)( EC:3.6.1.13 ) +FIG00754425 nitroreductase family +FIG00754441 halo peroxidase +FIG00754447 FIG00754449: hypothetical protein +FIG00754452 FIG00744219: hypothetical protein +FIG00754455 FIG00754460: hypothetical protein +FIG00754480 FIG00754483: hypothetical protein +FIG00754483 FIG00754485: hypothetical protein +FIG00754492 FIG00754493: hypothetical protein +FIG00754493 FIG00754495: hypothetical protein +FIG00754525 FIG00754530: hypothetical protein +FIG00754531 FIG00754532: hypothetical protein +FIG00754534 FIG00754536: hypothetical protein +FIG00754536 FIG00754542: hypothetical protein +FIG00754559 FIG00754567: hypothetical protein +FIG00754568 FIG00754583: hypothetical protein +FIG00754596 FIG00754597: hypothetical protein +FIG00754597 FIG00754598: hypothetical protein +FIG00754603 FIG00754604: hypothetical protein +FIG00754609 FIG00754614: hypothetical protein +FIG00754615 FIG00754617: hypothetical protein +FIG00754632 hypothetical replication protein +FIG00754634 FIG00754637: hypothetical protein +FIG00754640 FIG00754641: hypothetical protein +FIG00754652 FIG00754654: hypothetical protein +FIG00754665 FIG00754669: hypothetical protein +FIG00754674 FIG00754680: hypothetical protein +FIG00754690 FIG00754691: hypothetical protein +FIG00754695 NTP pyrophosphohydrolase (putative)( EC:3.6.1.- ) +FIG00754705 FIG00754708: hypothetical protein +FIG00754708 FIG00754712: hypothetical protein +FIG00754762 phage tape measure protein +FIG00754767 FIG00754768: hypothetical protein +FIG00754768 FIG00754769: hypothetical protein +FIG00754774 FIG00754778: hypothetical protein +FIG00754785 FIG00754789: hypothetical protein +FIG00754789 FIG00754795: hypothetical protein +FIG00754797 TyrA protein +FIG00754813 FIG00754814: hypothetical protein +FIG00754818 FIG00754819: hypothetical protein +FIG00754844 FIG00754851: hypothetical protein +FIG00754852 FIG00754860: hypothetical protein +FIG00754864 FIG00754868: hypothetical protein +FIG00754878 prophage Lp3 protein 24 +FIG00754895 FIG00754899: hypothetical protein +FIG00754904 FIG00754908: hypothetical protein +FIG00754933 FIG00754934: hypothetical protein +FIG00754942 FIG00754943: hypothetical protein +FIG00754943 FIG00754946: hypothetical protein +FIG00754946 FIG00754947: hypothetical protein +FIG00754963 prophage Lp2 protein 17 +FIG00754969 FIG00754979: hypothetical protein +FIG00754990 contains sodium/hydrogen exchanger family domain +FIG00755010 FIG00755011: hypothetical protein +FIG00755024 FIG00755026: hypothetical protein +FIG00755031 FIG00755032: hypothetical protein +FIG00755032 FIG00755034: hypothetical protein +FIG00755034 FIG00755036: hypothetical protein +FIG00755036 FIG00755037: hypothetical protein +FIG00755037 FIG00755038: hypothetical protein +FIG00755038 FIG00755040: hypothetical protein +FIG00755040 FIG00755041: hypothetical protein +FIG00755045 FIG00755046: hypothetical protein +FIG00755046 Mg(2+) transport ATPase protein C +FIG00755052 FIG00755053: hypothetical protein +FIG00755053 FIG00755054: hypothetical protein +FIG00755054 FIG00755055: hypothetical protein +FIG00755058 FIG00755059: hypothetical protein +FIG00755059 FIG00755063: hypothetical protein +FIG00755064 FIG00755065: hypothetical protein +FIG00755067 FIG00755071: hypothetical protein +FIG00755071 FIG00755075: hypothetical protein +FIG00755077 FIG00755079: hypothetical protein +FIG00755079 FIG00755080: hypothetical protein +FIG00755080 FIG00755081: hypothetical protein +FIG00755081 Cystathionine beta-lyase (EC 4.4.1.8) +FIG00755083 FIG00755085: hypothetical protein +FIG00755086 FIG00755088: hypothetical protein +FIG00755089 FIG00755090: hypothetical protein +FIG00755090 FIG00755092: hypothetical protein +FIG00755092 FIG00755093: hypothetical protein +FIG00755095 FIG00755096: hypothetical protein +FIG00755098 FIG00755099: hypothetical protein +FIG00755100 FIG00755101: hypothetical protein +FIG00755105 FIG00755110: hypothetical protein +FIG00755110 FIG00755112: hypothetical protein +FIG00755112 FIG00755123: hypothetical protein +FIG00755124 FIG00755125: hypothetical protein +FIG00755130 FIG00755131: hypothetical protein +FIG00755133 FIG00755139: hypothetical protein +FIG00755139 Dithiol-disulfide isomerase +FIG00755140 FIG00755141: hypothetical protein +FIG00755148 FIG00755150: hypothetical protein +FIG00755150 FIG00755152: hypothetical protein +FIG00755152 FIG00755154: hypothetical protein +FIG00755158 FIG00755159: hypothetical protein +FIG00755161 FIG00755162: hypothetical protein +FIG00755166 ABC transporter, ATP-binding/permease protein, MDR family +FIG00755174 FIG00755177: hypothetical protein +FIG00755178 FIG00755179: hypothetical protein +FIG00755180 FIG00755181: hypothetical protein +FIG00755181 FIG00755183: hypothetical protein +FIG00755183 FIG00755184: hypothetical protein +FIG00755187 FIG00755191: hypothetical protein +FIG00755195 FIG00755199: hypothetical protein +FIG00755200 FIG00755201: hypothetical protein +FIG00755206 FIG00755208: hypothetical protein +FIG00755208 Prophage pi3 protein 58 +FIG00755209 FIG00755210: hypothetical protein +FIG00755210 FIG00755211: hypothetical protein +FIG00755211 FIG00755213: hypothetical protein +FIG00755213 FIG00755214: hypothetical protein +FIG00755214 FIG00755215: hypothetical protein +FIG00755215 FIG00755217: hypothetical protein +FIG00755217 FIG00755220: hypothetical protein +FIG00755222 FIG00755224: hypothetical protein +FIG00755224 FIG00755225: hypothetical protein +FIG00755226 FIG00755227: hypothetical protein +FIG00755227 FIG00755228: hypothetical protein +FIG00755229 FIG00755232: hypothetical protein +FIG00755232 FIG00755233: hypothetical protein +FIG00755233 FIG00755234: hypothetical protein +FIG00755236 FIG00755237: hypothetical protein +FIG00755237 FIG00755238: hypothetical protein +FIG00755239 FIG00755240: hypothetical protein +FIG00755240 FIG00755241: hypothetical protein +FIG00755241 FIG00755244: hypothetical protein +FIG00755244 FIG00755245: hypothetical protein +FIG00755245 Cell wall surface anchor family protein +FIG00755257 Cell surface hydrolase, membrane-bound (putative) +FIG00755258 FIG00755262: hypothetical protein +FIG00755268 FIG00755270: hypothetical protein +FIG00755270 FIG00755271: hypothetical protein +FIG00755271 Protein export element (Fragment) +FIG00755277 FIG00755280: hypothetical protein +FIG00755280 FIG00755282: hypothetical protein +FIG00755282 prophage ps1 protein 16 +FIG00755284 FIG00755285: hypothetical protein +FIG00755285 FIG00755287: hypothetical protein +FIG00755287 FIG00755288: hypothetical protein +FIG00755289 FIG00755291: hypothetical protein +FIG00755295 FIG00755296: hypothetical protein +FIG00755300 FIG00755304: hypothetical protein +FIG00755304 FIG00755305: hypothetical protein +FIG00755305 FIG00755306: hypothetical protein +FIG00755306 FIG00755312: hypothetical protein +FIG00755312 FIG00755313: hypothetical protein +FIG00755313 FIG00755315: hypothetical protein +FIG00755315 Prenylated rab acceptor 1 related protein +FIG00755316 FIG00755317: hypothetical protein +FIG00755318 FIG00755322: hypothetical protein +FIG00755331 FIG00755336: hypothetical protein +FIG00755336 FIG00755337: hypothetical protein +FIG00755339 FIG00755340: hypothetical protein +FIG00755343 FIG01120689: hypothetical protein +FIG00755346 FIG00755348: hypothetical protein +FIG00755348 FIG00755349: hypothetical protein +FIG00755350 FIG00755352: hypothetical protein +FIG00755352 O-methyltransferase family protein [C1] +FIG00755354 FIG00755355: hypothetical protein +FIG00755355 FIG00755356: hypothetical protein +FIG00755356 FIG00755359: hypothetical protein +FIG00755363 FIG00755366: hypothetical protein +FIG00755368 FIG00755373: hypothetical protein +FIG00755374 FIG00755379: hypothetical protein +FIG00755384 FIG00755385: hypothetical protein +FIG00755386 FIG00755387: hypothetical protein +FIG00755388 FIG00755390: hypothetical protein +FIG00755395 FIG00755396: hypothetical protein +FIG00755396 FIG00755397: hypothetical protein +FIG00755397 FIG00755398: hypothetical protein +FIG00755398 FIG00755399: hypothetical protein +FIG00755399 FIG00755400: hypothetical protein +FIG00755400 FIG00755403: hypothetical protein +FIG00755403 FIG00755405: hypothetical protein +FIG00755406 FIG00755408: hypothetical protein +FIG00755409 FIG00755411: hypothetical protein +FIG00755423 FIG00755428: hypothetical protein +FIG00755428 FIG00755430: hypothetical protein +FIG00755430 FIG00755434: hypothetical protein +FIG00755434 FIG00755435: hypothetical protein +FIG00755435 FIG00755436: hypothetical protein +FIG00755436 FIG00755438: hypothetical protein +FIG00755442 FIG00755447: hypothetical protein +FIG00755451 FIG00755452: hypothetical protein +FIG00755452 FIG00755454: hypothetical protein +FIG00755455 FIG00755459: hypothetical protein +FIG00755459 FIG00755461: hypothetical protein +FIG00755461 FIG00755462: hypothetical protein +FIG00755462 FIG00755469: hypothetical protein +FIG00755469 FIG00755472: hypothetical protein +FIG00755472 FIG00755473: hypothetical protein +FIG00755477 FIG00755478: hypothetical protein +FIG00755478 FIG00755482: hypothetical protein +FIG00755483 FIG00755486: hypothetical protein +FIG00755486 FIG00755487: hypothetical protein +FIG00755491 prophage pi2 protein 08 +FIG00755495 FIG00755496: hypothetical protein +FIG00755496 FIG00755497: hypothetical protein +FIG00755497 putative mutator protein +FIG00755507 positive regulator +FIG00755509 FIG00755513: hypothetical protein +FIG00755520 DNA polymerase III, epsilon chain +FIG00755524 FIG00755525: hypothetical protein +FIG00755529 FIG00755530: hypothetical protein +FIG00755530 Prophage pi2 protein 03 +FIG00755532 FIG00755533: hypothetical protein +FIG00755533 FIG00755535: hypothetical protein +FIG00755538 similarity to PlnI and PlnP of Lactobacillus plantarum +FIG00755539 FIG00755540: hypothetical protein +FIG00755540 FIG00755541: hypothetical protein +FIG00755543 MurM +FIG00755544 FIG00755545: hypothetical protein +FIG00755545 FIG00755546: hypothetical protein +FIG00755547 FIG00755549: hypothetical protein +FIG00755549 FIG00755551: hypothetical protein +FIG00755552 FIG00755554: hypothetical protein +FIG00755554 FIG00755557: hypothetical protein +FIG00755569 FIG00755572: hypothetical protein +FIG00755572 FIG00755573: hypothetical protein +FIG00755576 FIG00755577: hypothetical protein +FIG00755582 transcriptional regulator, Rgg family +FIG00755583 FIG00755590: hypothetical protein +FIG00755590 FIG00755592: hypothetical protein +FIG00755592 FIG00755593: hypothetical protein +FIG00755593 FIG00755595: hypothetical protein +FIG00755596 DNA topoisomerase, phage-associated +FIG00755599 FIG00755602: hypothetical protein +FIG00755602 FIG00755603: hypothetical protein +FIG00755605 FIG00755607: hypothetical protein +FIG00755627 FIG00755630: hypothetical protein +FIG00755630 FIG00755635: hypothetical protein +FIG00755635 FIG00755640: hypothetical protein +FIG00755645 FIG00755652: hypothetical protein +FIG00755652 FIG00755655: hypothetical protein +FIG00755655 FIG00755661: hypothetical protein +FIG00755661 FIG00755663: hypothetical protein +FIG00755667 FIG00755668: hypothetical protein +FIG00755669 FIG00755671: hypothetical protein +FIG00755677 FIG00755678: hypothetical protein +FIG00755679 FIG00755680: hypothetical protein +FIG00755680 Bactoprenol glucosyl transferase (EC 2.4.1.-); Glycosyltransferase, group 2 family protein +FIG00755686 FIG00755687: hypothetical protein +FIG00755687 FIG00755688: hypothetical protein +FIG00755688 FIG00755689: hypothetical protein +FIG00755689 FIG00755690: hypothetical protein +FIG00755693 FIG00755694: hypothetical protein +FIG00755699 FIG00755700: hypothetical protein +FIG00755700 FIG00755702: hypothetical protein +FIG00755702 FIG00755703: hypothetical protein +FIG00755703 FIG00755704: hypothetical protein +FIG00755704 FIG00755705: hypothetical protein +FIG00755705 FIG00755706: hypothetical protein +FIG00755706 FIG00755707: hypothetical protein +FIG00755707 FIG00755708: hypothetical protein +FIG00755708 FIG00755709: hypothetical protein +FIG00755711 FIG00755715: hypothetical protein +FIG00755717 FIG00755718: hypothetical protein +FIG00755721 FIG00755722: hypothetical protein +FIG00755722 FIG00755725: hypothetical protein +FIG00755727 FIG00755728: hypothetical protein +FIG00755734 competence factor +FIG00755737 FIG00755738: hypothetical protein +FIG00755740 FIG00755751: hypothetical protein +FIG00755753 FIG00755754: hypothetical protein +FIG00755758 FIG00755759: hypothetical protein +FIG00755759 FIG00755761: hypothetical protein +FIG00755761 FIG00755762: hypothetical protein +FIG00755762 FIG00755765: hypothetical protein +FIG00755765 FIG00755768: hypothetical protein +FIG00755768 FIG00755769: hypothetical protein +FIG00755770 ABC transporter permease and substrate binding protein +FIG00755771 FIG00755772: hypothetical protein +FIG00755773 FIG00755774: hypothetical protein +FIG00755779 FIG00755780: hypothetical protein +FIG00755780 putative bacteriophage bIL310 repressor +FIG00755784 FIG00755786: hypothetical protein +FIG00755787 FIG00755788: hypothetical protein +FIG00755788 Glycosyltransferase, family 11 +FIG00755790 FIG00755791: hypothetical protein +FIG00755791 FIG00755792: hypothetical protein +FIG00755792 Small integral membrane protein +FIG00755794 FIG00755797: hypothetical protein +FIG00755797 FIG00755798: hypothetical protein +FIG00755800 immunogenic secreted protein precursor homolog +FIG00755801 FIG00755804: hypothetical protein +FIG00755804 FIG00755805: hypothetical protein +FIG00755806 FIG00755812: hypothetical protein +FIG00755814 FIG00755819: hypothetical protein +FIG00755820 FIG00755821: hypothetical protein +FIG00755821 Cryptic haloacid dehalogenase 1 (EC 3.8.1.2) +FIG00755834 FIG00755838: hypothetical protein +FIG00755838 tyrosine phosphatase +FIG00755849 FIG00773788: hypothetical protein +FIG00755855 FIG00755858: hypothetical protein +FIG00755858 FIG00755859: hypothetical protein +FIG00755859 FIG00755860: hypothetical protein +FIG00755860 possible surface protein +FIG00755863 FIG00755864: hypothetical protein +FIG00755865 FIG00755870: hypothetical protein +FIG00755874 FIG00755875: hypothetical protein +FIG00755875 FIG00755878: hypothetical protein +FIG00755878 FIG00755882: hypothetical protein +FIG00755884 DNA replication protein, phage-associated +FIG00755887 FIG00755890: hypothetical protein +FIG00755895 FIG00755899: hypothetical protein +FIG00755899 FIG00755903: hypothetical protein +FIG00755903 FIG00755907: hypothetical protein +FIG00755910 FIG00755911: hypothetical protein +FIG00755911 FIG00755914: hypothetical protein +FIG00755914 FIG00755915: hypothetical protein +FIG00755915 FIG00755916: hypothetical protein +FIG00755917 FIG00755919: hypothetical protein +FIG00755923 FIG00755924: hypothetical protein +FIG00755924 FIG00755925: hypothetical protein +FIG00755925 FIG00755927: hypothetical protein +FIG00755928 FIG00755931: hypothetical protein +FIG00755931 FIG00755938: hypothetical protein +FIG00755938 FIG00755939: hypothetical protein +FIG00755939 FIG00755941: hypothetical protein +FIG00755946 FIG00755954: hypothetical protein +FIG00755956 prophage pi3 protein 01 +FIG00755964 FIG00755965: hypothetical protein +FIG00755968 FIG00755970: hypothetical protein +FIG00755970 Cell surface protein precursor +FIG00755973 FIG00755978: hypothetical protein +FIG00755978 FIG00755979: hypothetical protein +FIG00755981 FIG00755982: hypothetical protein +FIG00755982 FIG00755986: hypothetical protein +FIG00755986 FIG00755988: hypothetical protein +FIG00755988 FIG00755991: hypothetical protein +FIG00755991 Cysteine ABC transporter, permease protein +FIG00755993 FIG00755994: hypothetical protein +FIG00755994 FIG00755998: hypothetical protein +FIG00755998 FIG00755999: hypothetical protein +FIG00756003 FIG00756004: hypothetical protein +FIG00756008 FIG00756009: hypothetical protein +FIG00756009 FIG00756019: hypothetical protein +FIG00756019 FIG00756020: hypothetical protein +FIG00756021 FIG00756023: hypothetical protein +FIG00756023 FIG00756030: hypothetical protein +FIG00756035 FIG00756036: hypothetical protein +FIG00756036 FIG00756038: hypothetical protein +FIG00756038 FIG00756040: hypothetical protein +FIG00756047 FIG00756052: hypothetical protein +FIG00756052 FIG00756056: hypothetical protein +FIG00756056 SAM-dependent methyltransferase, evidenced by COGnitor +FIG00756062 FIG00756064: hypothetical protein +FIG00756064 FIG00756065: hypothetical protein +FIG00756066 FIG00756067: hypothetical protein +FIG00756067 FIG00756068: hypothetical protein +FIG00756068 Immunity repressor +FIG00756074 repressor +FIG00756079 FIG00756080: hypothetical protein +FIG00756080 FIG00756082: hypothetical protein +FIG00756082 FIG00756084: hypothetical protein +FIG00756084 FIG00756086: hypothetical protein +FIG00756086 FIG00756088: hypothetical protein +FIG00756089 FIG00756092: hypothetical protein +FIG00756095 FIG00756096: hypothetical protein +FIG00756096 FIG00756097: hypothetical protein +FIG00756098 FIG00756100: hypothetical protein +FIG00756100 FIG00756103: hypothetical protein +FIG00756103 FIG00756105: hypothetical protein +FIG00756107 FIG00756108: hypothetical protein +FIG00756112 prophage ps3 protein 09 +FIG00756122 Uncharacterized protein CA_C3712 +FIG00756124 COG0503: Adenine/guanine phosphoribosyltransferases and related PRPP-binding proteins +FIG00756126 FIG00756129: hypothetical protein +FIG00756129 FIG00756130: hypothetical protein +FIG00756132 FIG00756133: hypothetical protein +FIG00756133 FIG00756134: hypothetical protein +FIG00756134 FIG00756139: hypothetical protein +FIG00756146 FIG00756147: hypothetical protein +FIG00756150 FIG00756151: hypothetical protein +FIG00756151 FIG00756152: hypothetical protein +FIG00756153 FIG00756154: hypothetical protein +FIG00756154 FIG00756156: hypothetical protein +FIG00756156 prophage ps3 protein 12 +FIG00756158 FIG00756160: hypothetical protein +FIG00756160 FIG00756161: hypothetical protein +FIG00756161 FIG00756162: hypothetical protein +FIG00756162 FIG00756167: hypothetical protein +FIG00756167 FIG00756168: hypothetical protein +FIG00756184 FIG00756185: hypothetical protein +FIG00756185 FIG00756186: hypothetical protein +FIG00756186 FIG00756187: hypothetical protein +FIG00756187 FIG00756189: hypothetical protein +FIG00756192 FIG00756196: hypothetical protein +FIG00756196 FIG00756199: hypothetical protein +FIG00756199 FIG00756202: hypothetical protein +FIG00756205 FIG00756206: hypothetical protein +FIG00756206 transcriptional regulator +FIG00756208 FIG00756210: hypothetical protein +FIG00756210 FIG00756213: hypothetical protein +FIG00756213 putative deoxyribonuclease +FIG00756215 FIG00756216: hypothetical protein +FIG00756220 FIG00756221: hypothetical protein +FIG00756221 FIG00756222: hypothetical protein +FIG00756223 hypothetical protein +FIG00756224 FIG00756225: hypothetical protein +FIG00756228 FIG00756230: hypothetical protein +FIG00756230 FIG00756232: hypothetical protein +FIG00756233 FIG00756237: hypothetical protein +FIG00756237 FIG00756240: hypothetical protein +FIG00756246 FIG00756247: hypothetical protein +FIG00756248 FIG00756249: hypothetical protein +FIG00756249 FIG00756250: hypothetical protein +FIG00756250 FIG00756253: hypothetical protein +FIG00756253 FIG00756255: hypothetical protein +FIG00756255 FIG00756261: hypothetical protein +FIG00756262 orf11 +FIG00756264 FIG00756265: hypothetical protein +FIG00756280 aerobic energy metabolism +FIG00756294 FIG00756296: hypothetical protein +FIG00756296 HTH-type dhaKLM operon transcriptional activator dhaS +FIG00756300 FIG00756301: hypothetical protein +FIG00756301 FIG00756305: hypothetical protein +FIG00756310 FIG00756311: hypothetical protein +FIG00756311 Phage scaffold protein +FIG00756316 cro-like repressor +FIG00756320 FIG00756322: hypothetical protein +FIG00756322 FIG00756326: hypothetical protein +FIG00756326 FMN-dependent NADH-azoreductase 1 (EC 1.7.-.-) (FMN-dependent NADH-azo compound oxidoreductase 1) (Azo-dye reductase 1) +FIG00756328 FIG00756332: hypothetical protein +FIG00756332 FIG00756333: hypothetical protein +FIG00756333 FIG00756341: hypothetical protein +FIG00756341 cI-like repressor +FIG00756348 Phage integrase: site-specific recombinase +FIG00756362 FIG00756365: hypothetical protein +FIG00756365 FIG00756368: hypothetical protein +FIG00756368 Cystine transport ATP-binding protein +FIG00756369 FIG00756373: hypothetical protein +FIG00756377 FIG00756380: hypothetical protein +FIG00756385 prophage ps3 protein 11 +FIG00756386 no similarity +FIG00756390 FIG00756392: hypothetical protein +FIG00756410 FIG00756411: hypothetical protein +FIG00756411 FIG00756412: hypothetical protein +FIG00756417 FIG00756419: hypothetical protein +FIG00756430 FIG00756431: hypothetical protein +FIG00756435 FIG00756436: hypothetical protein +FIG00756437 FIG00756442: hypothetical protein +FIG00756443 FIG00756444: hypothetical protein +FIG00756445 FIG00756446: hypothetical protein +FIG00756448 FIG00756453: hypothetical protein +FIG00756464 FIG00756468: hypothetical protein +FIG00756468 FIG00756470: hypothetical protein +FIG00756470 FIG00756474: hypothetical protein +FIG00756478 FIG00756484: hypothetical protein +FIG00756484 FIG00756488: hypothetical protein +FIG00756493 FIG00756494: hypothetical protein +FIG00756494 FIG00756495: hypothetical protein +FIG00756495 FIG00756503: hypothetical protein +FIG00756509 FIG00756513: hypothetical protein +FIG00756514 FIG00756517: hypothetical protein +FIG00756517 Uncharacterized threonine-rich protein C1742.01 precursor +FIG00756518 exopolysaccharide biosynthesis protein +FIG00756528 FIG00756529: hypothetical protein +FIG00756536 FIG00756541: hypothetical protein +FIG00756541 putative ribosomal protein, YsxB-like +FIG00756545 ORF3 +FIG00756553 Hypothetical protein SP1558 +FIG00756559 prophage ps1 protein 15 +FIG00756563 FIG00756567: hypothetical protein +FIG00756569 FIG00756570: hypothetical protein +FIG00756573 FIG00756575: hypothetical protein +FIG00756576 FIG00756580: hypothetical protein +FIG00756585 FIG00756586: hypothetical protein +FIG00756587 FIG00756591: hypothetical protein +FIG00756600 FIG00756602: hypothetical protein +FIG00756605 FIG00756606: hypothetical protein +FIG00756623 FIG00756629: hypothetical protein +FIG00756632 FIG00756633: hypothetical protein +FIG00756656 Radical SAM superfamily enzyme +FIG00756663 FIG00756664: hypothetical protein +FIG00756664 FIG00756667: hypothetical protein +FIG00756672 FIG00756674: hypothetical protein +FIG00756674 ABC transporter, permease protein +FIG00756675 FIG00756677: hypothetical protein +FIG00756677 FIG00756678: hypothetical protein +FIG00756680 FIG00756684: hypothetical protein +FIG00756687 FIG00756689: hypothetical protein +FIG00756689 FIG00756691: hypothetical protein +FIG00756696 FIG00756698: hypothetical protein +FIG00756703 FIG00756704: hypothetical protein +FIG00756712 FIG00756714: hypothetical protein +FIG00756714 FIG00756717: hypothetical protein +FIG00756717 FIG00756719: hypothetical protein +FIG00756734 FIG00756735: hypothetical protein +FIG00756736 FIG00756739: hypothetical protein +FIG00756742 FIG00756743: hypothetical protein +FIG00756753 FIG00756754: hypothetical protein +FIG00756756 FIG00756758: hypothetical protein +FIG00756774 Phage head-tail joining protein +FIG00756794 FIG00773410: hypothetical protein +FIG00756796 FIG00756797: hypothetical protein +FIG00756804 FIG013452: putative tellurium resistance protein +FIG00756826 hypothetical protein +FIG00756835 ABC transporter ATP binding protein +FIG00756846 FIG00756847: hypothetical protein +FIG00756847 FIG00756849: hypothetical protein +FIG00756853 FIG00756858: hypothetical protein +FIG00756862 Phage DNA-binding protein +FIG00756914 LtrE +FIG00756915 FIG00756917: hypothetical protein +FIG00756917 FIG00756927: hypothetical protein +FIG00756930 FIG00756940: hypothetical protein +FIG00756940 liver stage antigen 3 +FIG00756943 FIG00756950: hypothetical protein +FIG00756950 prophage ps2 protein 09 +FIG00756954 FIG00756960: hypothetical protein +FIG00756974 Prophage pi3 protein 42 +FIG00756990 FIG00756991: hypothetical protein +FIG00757002 hypothetical protein +FIG00757022 FIG00757023: hypothetical protein +FIG00757024 FIG00757025: hypothetical protein +FIG00757043 FIG00757045: hypothetical protein +FIG00757052 putative Tn5276 excisionase +FIG00757056 FIG00757057: hypothetical protein +FIG00757082 FIG00757086: hypothetical protein +FIG00757095 FIG00757096: hypothetical protein +FIG00757726 FIG00757739: hypothetical protein +FIG00757837 FIG00757839: hypothetical protein +FIG00757840 FIG00757842: hypothetical protein +FIG00757842 FIG00757843: hypothetical protein +FIG00757843 Ras-related GTP-binding protein, putative +FIG00757845 FIG00757846: hypothetical protein +FIG00757846 FIG00757847: hypothetical protein +FIG00757847 FIG00757849: hypothetical protein +FIG00757849 FIG00757850: hypothetical protein +FIG00757855 FIG00757856: hypothetical protein +FIG00757856 FIG00757858: hypothetical protein +FIG00757858 FIG00757860: hypothetical protein +FIG00757860 FIG00757861: hypothetical protein +FIG00757861 FIG00757862: hypothetical protein +FIG00757862 FIG00757863: hypothetical protein +FIG00757863 FIG00757864: hypothetical protein +FIG00757864 FIG00757867: hypothetical protein +FIG00757867 FIG00757868: hypothetical protein +FIG00757868 FIG00757869: hypothetical protein +FIG00757869 FIG00757872: hypothetical protein +FIG00757872 FIG00757873: hypothetical protein +FIG00757873 FIG00757874: hypothetical protein +FIG00757874 FIG00757875: hypothetical protein +FIG00757875 FIG00757877: hypothetical protein +FIG00757877 FIG00757881: hypothetical protein +FIG00757881 hypothetical periplasmic or secreted lipoprotein +FIG00757882 FIG00757883: hypothetical protein +FIG00757883 FIG00757884: hypothetical protein +FIG00757884 SdeD +FIG00757886 FIG00757887: hypothetical protein +FIG00757887 FIG00757888: hypothetical protein +FIG00757888 FIG00757889: hypothetical protein +FIG00757889 Protein traD +FIG00757892 FIG00757894: hypothetical protein +FIG00757895 FIG00757896: hypothetical protein +FIG00757896 FIG00757900: hypothetical protein +FIG00757900 Chorismate--pyruvate lyase (EC 4.1.3.40) +FIG00757902 FIG00757904: hypothetical protein +FIG00757904 FIG00757905: hypothetical protein +FIG00757905 FIG00757906: hypothetical protein +FIG00757906 FIG00757907: hypothetical protein +FIG00757907 FIG00757908: hypothetical protein +FIG00757908 FIG00757910: hypothetical protein +FIG00757910 FIG00757911: hypothetical protein +FIG00757911 FIG00757912: hypothetical protein +FIG00757912 FIG00757913: hypothetical protein +FIG00757913 FIG00757914: hypothetical protein +FIG00757914 FIG00757916: hypothetical protein +FIG00757917 FIG00757918: hypothetical protein +FIG00757918 FIG00757919: hypothetical protein +FIG00757922 FIG00757923: hypothetical protein +FIG00757923 FIG00757927: hypothetical protein +FIG00757927 FIG00757928: hypothetical protein +FIG00757928 FIG00757929: hypothetical protein +FIG00757929 FIG00757933: hypothetical protein +FIG00757934 Twin-arginine translocation protein TatB +FIG00757935 FIG00757939: hypothetical protein +FIG00757939 FIG00757941: hypothetical protein +FIG00757941 FIG00757943: hypothetical protein +FIG00757944 FIG00757946: hypothetical protein +FIG00757946 FIG00757948: hypothetical protein +FIG00757948 FIG00757950: hypothetical protein +FIG00757950 FIG00757953: hypothetical protein +FIG00757955 FIG00757956: hypothetical protein +FIG00757958 FIG00757959: hypothetical protein +FIG00757959 FIG00757960: hypothetical protein +FIG00757960 FIG00757961: hypothetical protein +FIG00757961 FIG00757962: hypothetical protein +FIG00757962 FIG00757964: hypothetical protein +FIG00757964 FIG00757965: hypothetical protein +FIG00757965 Sulfate transporter (EC 4.2.1.1) +FIG00757968 FIG00757969: hypothetical protein +FIG00757969 FIG00757970: hypothetical protein +FIG00757970 FIG00757974: hypothetical protein +FIG00757975 Putative tail fiber protein +FIG00757976 FIG00757977: hypothetical protein +FIG00757977 FIG00757978: hypothetical protein +FIG00757981 FIG00757982: hypothetical protein +FIG00757982 FIG00757983: hypothetical protein +FIG00757983 FIG00757985: hypothetical protein +FIG00757985 FIG00757986: hypothetical protein +FIG00757986 FIG00757987: hypothetical protein +FIG00757987 FIG00757988: hypothetical protein +FIG00757988 FIG00757989: hypothetical protein +FIG00757989 FIG00757990: hypothetical protein +FIG00757991 FIG00757993: hypothetical protein +FIG00757993 FIG00757996: hypothetical protein +FIG00757996 FIG00757997: hypothetical protein +FIG00757997 FIG00757998: hypothetical protein +FIG00757998 FIG00758000: hypothetical protein +FIG00758000 FIG00758002: hypothetical protein +FIG00758002 FIG00758005: hypothetical protein +FIG00758008 FIG00758010: hypothetical protein +FIG00758010 ProQ-like, activator of ProP osmoprotectant transporter +FIG00758012 FIG00758013: hypothetical protein +FIG00758013 FIG00758014: hypothetical protein +FIG00758014 FIG00758016: hypothetical protein +FIG00758017 FIG00758018: hypothetical protein +FIG00758018 FIG00758020: hypothetical protein +FIG00758020 FIG00758021: hypothetical protein +FIG00758021 FIG00758022: hypothetical protein +FIG00758022 FIG00758023: hypothetical protein +FIG00758023 FIG00758024: hypothetical protein +FIG00758024 FIG00758027: hypothetical protein +FIG00758027 FIG00758029: hypothetical protein +FIG00758029 FIG00758032: hypothetical protein +FIG00758032 FIG00758033: hypothetical protein +FIG00758033 FIG00758034: hypothetical protein +FIG00758034 FIG00758035: hypothetical protein +FIG00758037 FIG00758038: hypothetical protein +FIG00758039 FIG00758041: hypothetical protein +FIG00758041 FIG00758042: hypothetical protein +FIG00758042 FIG00758043: hypothetical protein +FIG00758045 FIG00758046: hypothetical protein +FIG00758046 FIG00758048: hypothetical protein +FIG00758048 FIG00758050: hypothetical protein +FIG00758050 FIG00758051: hypothetical protein +FIG00758051 FIG00758053: hypothetical protein +FIG00758053 FIG00758054: hypothetical protein +FIG00758054 FIG00758055: hypothetical protein +FIG00758055 FIG00758056: hypothetical protein +FIG00758056 FIG00758058: hypothetical protein +FIG00758058 FIG00758059: hypothetical protein +FIG00758059 FIG00758063: hypothetical protein +FIG00758063 FIG00758064: hypothetical protein +FIG00758064 FIG00758066: hypothetical protein +FIG00758068 FIG00758069: hypothetical protein +FIG00758069 FIG00758070: hypothetical protein +FIG00758070 Tryptophan/tyrosine permease +FIG00758072 FIG00758073: hypothetical protein +FIG00758073 FIG00758074: hypothetical protein +FIG00758074 FIG00758076: hypothetical protein +FIG00758076 FIG00758077: hypothetical protein +FIG00758077 FIG00758078: hypothetical protein +FIG00758078 SdbA protein, putative substrate of the Dot/Icm system +FIG00758079 FIG00758081: hypothetical protein +FIG00758081 FIG00758083: hypothetical protein +FIG00758083 FIG00758086: hypothetical protein +FIG00758087 FIG00758088: hypothetical protein +FIG00758088 FIG00758091: hypothetical protein +FIG00758091 FIG00758092: hypothetical protein +FIG00758092 FIG00758094: hypothetical protein +FIG00758094 FIG00758095: hypothetical protein +FIG00758095 FIG00758097: hypothetical protein +FIG00758097 FIG00758098: hypothetical protein +FIG00758098 Tryptophan rich sensory protein TspO +FIG00758099 FIG00758101: hypothetical protein +FIG00758101 Sugar symporter +FIG00758102 FIG00758103: hypothetical protein +FIG00758103 FIG00758104: hypothetical protein +FIG00758104 FIG00758105: hypothetical protein +FIG00758105 FIG00758106: hypothetical protein +FIG00758106 FIG00758107: hypothetical protein +FIG00758107 FIG00758108: hypothetical protein +FIG00758108 FIG00758111: hypothetical protein +FIG00758117 FIG00758119: hypothetical protein +FIG00758119 FIG00758120: hypothetical protein +FIG00758120 FIG00758121: hypothetical protein +FIG00758121 FIG00758123: hypothetical protein +FIG00758124 FIG00758127: hypothetical protein +FIG00758127 FIG00758128: hypothetical protein +FIG00758129 FIG00758130: hypothetical protein +FIG00758130 FIG00758131: hypothetical protein +FIG00758132 FIG00758134: hypothetical protein +FIG00758134 FIG00758135: hypothetical protein +FIG00758135 FIG00758136: hypothetical protein +FIG00758136 FIG00758137: hypothetical protein +FIG00758137 FIG00758139: hypothetical protein +FIG00758139 FIG00758142: hypothetical protein +FIG00758142 FIG00759447: hypothetical protein +FIG00758145 FIG00758147: hypothetical protein +FIG00758147 FIG00758148: hypothetical protein +FIG00758149 FIG00758150: hypothetical protein +FIG00758150 FIG00758152: hypothetical protein +FIG00758154 FIG00758155: hypothetical protein +FIG00758155 FIG00758156: hypothetical protein +FIG00758156 FIG00758158: hypothetical protein +FIG00758158 FIG00758159: hypothetical protein +FIG00758159 FIG00758160: hypothetical protein +FIG00758160 FIG00758161: hypothetical protein +FIG00758163 FIG00758165: hypothetical protein +FIG00758165 FIG00758168: hypothetical protein +FIG00758168 FIG00758171: hypothetical protein +FIG00758171 FIG00758173: hypothetical protein +FIG00758175 FIG00758177: hypothetical protein +FIG00758177 FIG00758180: hypothetical protein +FIG00758180 FIG00758181: hypothetical protein +FIG00758181 FIG00758182: hypothetical protein +FIG00758182 FIG00758184: hypothetical protein +FIG00758184 FIG00758186: hypothetical protein +FIG00758187 FIG00758189: hypothetical protein +FIG00758189 FIG00758190: hypothetical protein +FIG00758190 FIG00758192: hypothetical protein +FIG00758192 FIG00758193: hypothetical protein +FIG00758193 FIG00758194: hypothetical protein +FIG00758194 FIG00758197: hypothetical protein +FIG00758197 FIG00758200: hypothetical protein +FIG00758200 FIG00758202: hypothetical protein +FIG00758202 FIG00758203: hypothetical protein +FIG00758203 FIG00758205: hypothetical protein +FIG00758205 FIG00758206: hypothetical protein +FIG00758206 FIG00758207: hypothetical protein +FIG00758211 FIG00758212: hypothetical protein +FIG00758212 FIG00758213: hypothetical protein +FIG00758213 FIG00758214: hypothetical protein +FIG00758214 FIG00758215: hypothetical protein +FIG00758215 FIG00758216: hypothetical protein +FIG00758216 FIG00758219: hypothetical protein +FIG00758221 FIG00758222: hypothetical protein +FIG00758222 ATP-dependent nuclease subunit A +FIG00758224 FIG00758227: hypothetical protein +FIG00758229 FIG00758230: hypothetical protein +FIG00758238 FIG00758239: hypothetical protein +FIG00758239 FIG00758241: hypothetical protein +FIG00758241 FIG00758242: hypothetical protein +FIG00758242 FIG00758243: hypothetical protein +FIG00758243 FIG00758245: hypothetical protein +FIG00758245 FIG00758246: hypothetical protein +FIG00758246 FIG00758247: hypothetical protein +FIG00758248 FIG00758249: hypothetical protein +FIG00758249 FIG00758250: hypothetical protein +FIG00758250 FIG00758251: hypothetical protein +FIG00758251 FIG00758254: hypothetical protein +FIG00758254 FIG00758256: hypothetical protein +FIG00758256 FIG00758257: hypothetical protein +FIG00758257 FIG00758258: hypothetical protein +FIG00758258 FIG00758260: hypothetical protein +FIG00758260 FIG00758262: hypothetical protein +FIG00758262 FIG00758263: hypothetical protein +FIG00758263 FIG00758264: hypothetical protein +FIG00758264 FIG00758266: hypothetical protein +FIG00758266 FIG00758267: hypothetical protein +FIG00758267 FIG00758268: hypothetical protein +FIG00758268 FIG00758269: hypothetical protein +FIG00758269 FIG00758271: hypothetical protein +FIG00758271 FIG00758273: hypothetical protein +FIG00758273 FIG00758275: hypothetical protein +FIG00758275 FIG00758276: hypothetical protein +FIG00758276 FIG00758277: hypothetical protein +FIG00758277 Substrate of the Dot/Icm system +FIG00758278 Phytanoyl-CoA dioxygenase domain containing 1 +FIG00758279 FIG00758282: hypothetical protein +FIG00758282 FIG00758283: hypothetical protein +FIG00758283 FIG00758284: hypothetical protein +FIG00758284 FIG00758285: hypothetical protein +FIG00758285 FIG00758287: hypothetical protein +FIG00758288 FIG00758289: hypothetical protein +FIG00758289 FIG00758290: hypothetical protein +FIG00758290 Flagellar biosynthesis/type III secretory pathway chaperone +FIG00758292 FIG00758293: hypothetical protein +FIG00758294 FIG00758295: hypothetical protein +FIG00758295 FIG00758297: hypothetical protein +FIG00758297 FIG00758298: hypothetical protein +FIG00758298 FIG00758301: hypothetical protein +FIG00758303 hypothetical protein +FIG00758304 FIG00758306: hypothetical protein +FIG00758306 FIG00758307: hypothetical protein +FIG00758309 FIG00758310: hypothetical protein +FIG00758311 FIG00758312: hypothetical protein +FIG00758312 FIG00758313: hypothetical protein +FIG00758313 FIG00758315: hypothetical protein +FIG00758315 FIG00758316: hypothetical protein +FIG00758316 Putative prophage CP4-6 integrase +FIG00758318 FIG00758320: hypothetical protein +FIG00758320 FIG00758322: hypothetical protein +FIG00758322 FIG00758323: hypothetical protein +FIG00758323 FIG00758324: hypothetical protein +FIG00758324 FIG00758325: hypothetical protein +FIG00758325 FIG00758327: hypothetical protein +FIG00758327 FIG00758329: hypothetical protein +FIG00758329 FIG00758332: hypothetical protein +FIG00758332 FIG00758335: hypothetical protein +FIG00758335 FIG00758336: hypothetical protein +FIG00758336 FIG00758337: hypothetical protein +FIG00758337 FIG00758339: hypothetical protein +FIG00758339 FIG00758340: hypothetical protein +FIG00758340 FIG00758342: hypothetical protein +FIG00758342 FIG00758343: hypothetical protein +FIG00758343 FIG00758348: hypothetical protein +FIG00758349 FIG00758350: hypothetical protein +FIG00758354 FIG00758355: hypothetical protein +FIG00758357 FIG00758358: hypothetical protein +FIG00758358 FIG00758359: hypothetical protein +FIG00758359 FIG00758360: hypothetical protein +FIG00758360 FIG00758361: hypothetical protein +FIG00758361 FIG00758362: hypothetical protein +FIG00758362 MFS multidrug efflux pump, outer membrane protein +FIG00758363 FIG00758364: hypothetical protein +FIG00758364 FIG00758369: hypothetical protein +FIG00758369 FIG00758370: hypothetical protein +FIG00758371 FIG00758372: hypothetical protein +FIG00758372 Ankyrin repeat family protein +FIG00758373 Outer membrane protein MIP precursor (Macrophage infectivity potentiator) (Peptidyl-prolyl cis-trans isomerase) (EC 5.2.1.8) +FIG00758375 FIG00758376: hypothetical protein +FIG00758376 FIG00758377: hypothetical protein +FIG00758377 FIG00758378: hypothetical protein +FIG00758378 FIG00758379: hypothetical protein +FIG00758379 FIG00758381: hypothetical protein +FIG00758381 FIG00758382: hypothetical protein +FIG00758382 FIG00758383: hypothetical protein +FIG00758383 FIG00758384: hypothetical protein +FIG00758384 major outer membrane protein +FIG00758390 FIG00758391: hypothetical protein +FIG00758391 FIG00761080: hypothetical protein +FIG00758392 FIG00758393: hypothetical protein +FIG00758393 FIG00758394: hypothetical protein +FIG00758394 LysR-family transcriptional activator +FIG00758395 FIG00758396: hypothetical protein +FIG00758399 FIG00758400: hypothetical protein +FIG00758400 FIG00758401: hypothetical protein +FIG00758401 FIG00758402: hypothetical protein +FIG00758402 FIG00758404: hypothetical protein +FIG00758406 FIG00758409: hypothetical protein +FIG00758409 FIG00758412: hypothetical protein +FIG00758412 FIG00758413: hypothetical protein +FIG00758413 FIG00758414: hypothetical protein +FIG00758414 FIG00758417: hypothetical protein +FIG00758422 FIG00758424: hypothetical protein +FIG00758424 FIG00758425: hypothetical protein +FIG00758425 FIG00758426: hypothetical protein +FIG00758426 FIG00758427: hypothetical protein +FIG00758427 FIG00758429: hypothetical protein +FIG00758429 FIG00758430: hypothetical protein +FIG00758430 FIG00758431: hypothetical protein +FIG00758432 FIG00758433: hypothetical protein +FIG00758433 FIG00758434: hypothetical protein +FIG00758434 FIG00758436: hypothetical protein +FIG00758437 FIG00758439: hypothetical protein +FIG00758439 FIG00758441: hypothetical protein +FIG00758441 FIG00758443: hypothetical protein +FIG00758443 FIG00758446: hypothetical protein +FIG00758447 FIG00758448: hypothetical protein +FIG00758448 FIG00758449: hypothetical protein +FIG00758450 FIG00758451: hypothetical protein +FIG00758451 FIG00758452: hypothetical protein +FIG00758452 FIG00758454: hypothetical protein +FIG00758454 FIG00758455: hypothetical protein +FIG00758455 FIG00758456: hypothetical protein +FIG00758456 FIG00758458: hypothetical protein +FIG00758458 FIG00758460: hypothetical protein +FIG00758460 FIG00758462: hypothetical protein +FIG00758462 FIG00758464: hypothetical protein +FIG00758464 FIG00758465: hypothetical protein +FIG00758465 FIG00758466: hypothetical protein +FIG00758469 FIG00758471: hypothetical protein +FIG00758471 FIG00758474: hypothetical protein +FIG00758474 FIG00758475: hypothetical protein +FIG00758475 FIG00758476: hypothetical protein +FIG00758479 FIG00758482: hypothetical protein +FIG00758482 FIG00758484: hypothetical protein +FIG00758484 FIG00758485: hypothetical protein +FIG00758486 FIG00758487: hypothetical protein +FIG00758487 FIG00758488: hypothetical protein +FIG00758488 FIG00758489: hypothetical protein +FIG00758489 FIG00758490: hypothetical protein +FIG00758490 FIG00758494: hypothetical protein +FIG00758494 FIG00758495: hypothetical protein +FIG00758495 FIG00758496: hypothetical protein +FIG00758496 FIG00758497: hypothetical protein +FIG00758500 FIG00758501: hypothetical protein +FIG00758501 FIG00758502: hypothetical protein +FIG00758502 FIG00758503: hypothetical protein +FIG00758507 FIG00758509: hypothetical protein +FIG00758509 FIG00758510: hypothetical protein +FIG00758510 FIG00758511: hypothetical protein +FIG00758512 FIG00758517: hypothetical protein +FIG00758517 FIG00758518: hypothetical protein +FIG00758518 FIG00758519: hypothetical protein +FIG00758519 FIG00758520: hypothetical protein +FIG00758520 FIG00758521: hypothetical protein +FIG00758521 FIG00758527: hypothetical protein +FIG00758527 FIG00758528: hypothetical protein +FIG00758528 FIG00758533: hypothetical protein +FIG00758533 FIG00758536: hypothetical protein +FIG00758537 FIG00758540: hypothetical protein +FIG00758540 FIG00758541: hypothetical protein +FIG00758541 FIG00758544: hypothetical protein +FIG00758549 FIG00758550: hypothetical protein +FIG00758550 FIG00758551: hypothetical protein +FIG00758551 FIG00758552: hypothetical protein +FIG00758553 FIG00758554: hypothetical protein +FIG00758558 FIG00758561: hypothetical protein +FIG00758561 FIG00758562: hypothetical protein +FIG00758562 FIG00758563: hypothetical protein +FIG00758563 FIG00758565: hypothetical protein +FIG00758565 FIG00758568: hypothetical protein +FIG00758568 FIG00758569: hypothetical protein +FIG00758569 FIG00758570: hypothetical protein +FIG00758570 FIG00758571: hypothetical protein +FIG00758571 IucD protein +FIG00758572 FIG00758573: hypothetical protein +FIG00758576 FIG00758578: hypothetical protein +FIG00758578 FIG00758579: hypothetical protein +FIG00758579 FIG00758581: hypothetical protein +FIG00758581 FIG00758582: hypothetical protein +FIG00758585 FIG00758588: hypothetical protein +FIG00758588 FIG00758589: hypothetical protein +FIG00758589 FIG00758593: hypothetical protein +FIG00758596 FIG00758599: hypothetical protein +FIG00758599 FIG00758600: hypothetical protein +FIG00758600 FIG00758601: hypothetical protein +FIG00758601 FIG00758602: hypothetical protein +FIG00758602 FIG00758604: hypothetical protein +FIG00758604 FIG00758606: hypothetical protein +FIG00758606 FIG00758607: hypothetical protein +FIG00758607 FIG00758609: hypothetical protein +FIG00758609 FIG00758611: hypothetical protein +FIG00758611 FIG00758612: hypothetical protein +FIG00758612 FIG00758615: hypothetical protein +FIG00758617 FIG00758618: hypothetical protein +FIG00758618 FIG00758619: hypothetical protein +FIG00758619 FIG00758621: hypothetical protein +FIG00758621 FIG00758622: hypothetical protein +FIG00758624 FIG00758626: hypothetical protein +FIG00758626 FIG00758627: hypothetical protein +FIG00758627 FIG00758628: hypothetical protein +FIG00758628 FIG00758629: hypothetical protein +FIG00758629 FIG00758630: hypothetical protein +FIG00758630 Alr2710 protein +FIG00758634 FIG00758635: hypothetical protein +FIG00758636 FIG00758637: hypothetical protein +FIG00758637 FIG00758638: hypothetical protein +FIG00758638 MFS multidrug efflux pump, A subunit +FIG00758641 FIG00758642: hypothetical protein +FIG00758643 FIG00758647: hypothetical protein +FIG00758648 FIG00758649: hypothetical protein +FIG00758649 FIG00758650: hypothetical protein +FIG00758650 FIG00758651: hypothetical protein +FIG00758651 FIG00758652: hypothetical protein +FIG00758652 FIG00758653: hypothetical protein +FIG00758653 FIG00758655: hypothetical protein +FIG00758655 FIG00758658: hypothetical protein +FIG00758658 FIG00758659: hypothetical protein +FIG00758660 FIG00758661: hypothetical protein +FIG00758662 FIG00758663: hypothetical protein +FIG00758663 FIG00758666: hypothetical protein +FIG00758666 FIG00758667: hypothetical protein +FIG00758667 FIG00758668: hypothetical protein +FIG00758668 Acid sphingomyelinase-like phosphodiesterase +FIG00758669 FIG00758670: hypothetical protein +FIG00758670 FIG00758672: hypothetical protein +FIG00758672 FIG00758673: hypothetical protein +FIG00758674 FIG00758675: hypothetical protein +FIG00758675 FIG00758678: hypothetical protein +FIG00758678 FIG00758683: hypothetical protein +FIG00758683 FIG00758684: hypothetical protein +FIG00758684 FIG00758685: hypothetical protein +FIG00758685 FIG00758689: hypothetical protein +FIG00758689 FIG00758690: hypothetical protein +FIG00758690 FIG00758692: hypothetical protein +FIG00758692 FIG00758694: hypothetical protein +FIG00758696 FIG00758698: hypothetical protein +FIG00758699 FIG00758700: hypothetical protein +FIG00758700 Prolidase +FIG00758705 FIG00758706: hypothetical protein +FIG00758711 FIG00758712: hypothetical protein +FIG00758712 FIG00758715: hypothetical protein +FIG00758715 FIG00758719: hypothetical protein +FIG00758719 FIG00758720: hypothetical protein +FIG00758723 FIG00758727: hypothetical protein +FIG00758727 FIG00758728: hypothetical protein +FIG00758728 FIG00758729: hypothetical protein +FIG00758729 FIG00758732: hypothetical protein +FIG00758732 FIG00758734: hypothetical protein +FIG00758734 FIG00758735: hypothetical protein +FIG00758735 FIG00758736: hypothetical protein +FIG00758736 FIG00758738: hypothetical protein +FIG00758738 NAD(P)HX epimerase +FIG00758739 FIG00758740: hypothetical protein +FIG00758740 FIG00758742: hypothetical protein +FIG00758742 FIG00758743: hypothetical protein +FIG00758743 FIG00758745: hypothetical protein +FIG00758745 FIG00758746: hypothetical protein +FIG00758746 FIG00758747: hypothetical protein +FIG00758747 FIG00758752: hypothetical protein +FIG00758752 FIG00758753: hypothetical protein +FIG00758753 FIG00758756: hypothetical protein +FIG00758756 FIG00758757: hypothetical protein +FIG00758757 FIG00758758: hypothetical protein +FIG00758758 FIG00758760: hypothetical protein +FIG00758760 FIG00758761: hypothetical protein +FIG00758761 FIG00758763: hypothetical protein +FIG00758763 FIG00758767: hypothetical protein +FIG00758767 FIG00758768: hypothetical protein +FIG00758768 FIG00758769: hypothetical protein +FIG00758769 FIG00758770: hypothetical protein +FIG00758771 FIG00758773: hypothetical protein +FIG00758773 FIG00758774: hypothetical protein +FIG00758774 FIG00758776: hypothetical protein +FIG00758776 FIG00758777: hypothetical protein +FIG00758777 Periplasmic septal ring factor with murein hydrolase activity EnvC/YibP +FIG00758779 FIG00758780: hypothetical protein +FIG00758780 FIG00758785: hypothetical protein +FIG00758785 FIG00758786: hypothetical protein +FIG00758786 FIG00758787: hypothetical protein +FIG00758787 FIG00758789: hypothetical protein +FIG00758791 FIG00758794: hypothetical protein +FIG00758794 FIG00758795: hypothetical protein +FIG00758795 FIG00758798: hypothetical protein +FIG00758801 FIG00758802: hypothetical protein +FIG00758802 FIG00758803: hypothetical protein +FIG00758803 FIG00758804: hypothetical protein +FIG00758804 FIG00758805: hypothetical protein +FIG00758805 FIG00758806: hypothetical protein +FIG00758806 FIG00758809: hypothetical protein +FIG00758809 FIG00758812: hypothetical protein +FIG00758812 FIG00758816: hypothetical protein +FIG00758816 FIG00758817: hypothetical protein +FIG00758817 FIG00758819: hypothetical protein +FIG00758819 FIG00758820: hypothetical protein +FIG00758820 FIG00758821: hypothetical protein +FIG00758821 FIG00758822: hypothetical protein +FIG00758823 FIG00758824: hypothetical protein +FIG00758824 FIG00758825: hypothetical protein +FIG00758825 FIG00758826: hypothetical protein +FIG00758826 FIG00758829: hypothetical protein +FIG00758829 FIG00758830: hypothetical protein +FIG00758830 FIG00758834: hypothetical protein +FIG00758834 FIG00758835: hypothetical protein +FIG00758835 FIG00758838: hypothetical protein +FIG00758838 FIG00758839: hypothetical protein +FIG00758839 FIG00758840: hypothetical protein +FIG00758840 FIG00758841: hypothetical protein +FIG00758842 FIG00758845: hypothetical protein +FIG00758845 FIG00758846: hypothetical protein +FIG00758846 FIG00758849: hypothetical protein +FIG00758849 FIG00758851: hypothetical protein +FIG00758851 FIG00758853: hypothetical protein +FIG00758853 FIG00758857: hypothetical protein +FIG00758857 FIG00758858: hypothetical protein +FIG00758858 FIG00758859: hypothetical protein +FIG00758859 FIG00758860: hypothetical protein +FIG00758861 FIG00758862: hypothetical protein +FIG00758865 FIG00758866: hypothetical protein +FIG00758868 FIG00758869: hypothetical protein +FIG00758874 FIG00758875: hypothetical protein +FIG00758875 FIG00758876: hypothetical protein +FIG00758876 FIG00758877: hypothetical protein +FIG00758877 FIG00758880: hypothetical protein +FIG00758880 FIG00758882: hypothetical protein +FIG00758882 FIG00758887: hypothetical protein +FIG00758887 FIG00758888: hypothetical protein +FIG00758888 FIG00758889: hypothetical protein +FIG00758889 FIG00758890: hypothetical protein +FIG00758895 FIG00758896: hypothetical protein +FIG00758896 FIG00758897: hypothetical protein +FIG00758898 FIG00758899: hypothetical protein +FIG00758899 FIG00758902: hypothetical protein +FIG00758904 FIG00758905: hypothetical protein +FIG00758905 FIG00758906: hypothetical protein +FIG00758906 FIG00758907: hypothetical protein +FIG00758907 FIG00758908: hypothetical protein +FIG00758908 FIG00758909: hypothetical protein +FIG00758909 FIG00758912: hypothetical protein +FIG00758912 FIG00758913: hypothetical protein +FIG00758913 FIG00758916: hypothetical protein +FIG00758916 FIG00758918: hypothetical protein +FIG00758918 FIG00758919: hypothetical protein +FIG00758919 FIG00758920: hypothetical protein +FIG00758921 SidA +FIG00758924 FIG00758926: hypothetical protein +FIG00758926 FIG00758929: hypothetical protein +FIG00758929 FIG00758931: hypothetical protein +FIG00758931 FIG00758932: hypothetical protein +FIG00758932 FIG00758933: hypothetical protein +FIG00758933 FIG00758934: hypothetical protein +FIG00758934 FIG00758935: hypothetical protein +FIG00758935 FIG00758936: hypothetical protein +FIG00758936 FIG00758937: hypothetical protein +FIG00758937 FIG00758938: hypothetical protein +FIG00758938 FIG00758940: hypothetical protein +FIG00758941 FIG00758942: hypothetical protein +FIG00758942 FIG00758943: hypothetical protein +FIG00758943 FIG00758944: hypothetical protein +FIG00758947 FIG00758949: hypothetical protein +FIG00758949 FIG00758950: hypothetical protein +FIG00758950 FIG00758951: hypothetical protein +FIG00758952 FIG00758954: hypothetical protein +FIG00758955 FIG00758956: hypothetical protein +FIG00758956 Transcriptional regulator LuxR +FIG00758957 FIG00758960: hypothetical protein +FIG00758960 FIG00758962: hypothetical protein +FIG00758962 FIG00758965: hypothetical protein +FIG00758966 FIG00758967: hypothetical protein +FIG00758967 FIG00758968: hypothetical protein +FIG00758968 FIG00758969: hypothetical protein +FIG00758969 FIG00758971: hypothetical protein +FIG00758973 FIG00758975: hypothetical protein +FIG00758975 FIG00758977: hypothetical protein +FIG00758977 FIG00758979: hypothetical protein +FIG00758979 FIG00758981: hypothetical protein +FIG00758983 FIG00758984: hypothetical protein +FIG00758984 FIG00758985: hypothetical protein +FIG00758985 FIG00758986: hypothetical protein +FIG00758986 FIG00758987: hypothetical protein +FIG00758994 FIG00758995: hypothetical protein +FIG00758999 FIG00759001: hypothetical protein +FIG00759001 FIG00759002: hypothetical protein +FIG00759002 FIG00759003: hypothetical protein +FIG00759003 FIG00759004: hypothetical protein +FIG00759005 FIG00759006: hypothetical protein +FIG00759006 FIG00759008: hypothetical protein +FIG00759008 FIG00759009: hypothetical protein +FIG00759009 FIG00759012: hypothetical protein +FIG00759012 FIG00759014: hypothetical protein +FIG00759014 FIG00759016: hypothetical protein +FIG00759016 FIG00759018: hypothetical protein +FIG00759018 FIG00759019: hypothetical protein +FIG00759019 FIG00759021: hypothetical protein +FIG00759023 FIG00759024: hypothetical protein +FIG00759027 Chemiosmotic efflux system C protein A +FIG00759028 FIG00759029: hypothetical protein +FIG00759030 FIG00759032: hypothetical protein +FIG00759034 FIG00759035: hypothetical protein +FIG00759035 FIG00759039: hypothetical protein +FIG00759039 FIG00759040: hypothetical protein +FIG00759040 FIG00759043: hypothetical protein +FIG00759043 FIG00759044: hypothetical protein +FIG00759044 FIG00759045: hypothetical protein +FIG00759045 FIG00759047: hypothetical protein +FIG00759048 FIG00759050: hypothetical protein +FIG00759050 FIG00759051: hypothetical protein +FIG00759052 FIG00759053: hypothetical protein +FIG00759060 FIG00759062: hypothetical protein +FIG00759062 FIG00759063: hypothetical protein +FIG00759065 FIG00759066: hypothetical protein +FIG00759066 IncP-type oriT binding protein TraJ +FIG00759068 FIG00759069: hypothetical protein +FIG00759069 FIG00759070: hypothetical protein +FIG00759070 FIG00759071: hypothetical protein +FIG00759071 FIG00759073: hypothetical protein +FIG00759073 FIG00759076: hypothetical protein +FIG00759076 FIG00759077: hypothetical protein +FIG00759077 FIG00759079: hypothetical protein +FIG00759079 FIG00759080: hypothetical protein +FIG00759080 FIG00759081: hypothetical protein +FIG00759083 FIG00759085: hypothetical protein +FIG00759085 FIG00759086: hypothetical protein +FIG00759094 FIG00759096: hypothetical protein +FIG00759096 FIG00759099: hypothetical protein +FIG00759099 FIG00759102: hypothetical protein +FIG00759105 FIG00759107: hypothetical protein +FIG00759107 LssZ protein +FIG00759111 FIG00759112: hypothetical protein +FIG00759112 FIG00759115: hypothetical protein +FIG00759115 FIG00759116: hypothetical protein +FIG00759116 FIG00759117: hypothetical protein +FIG00759117 FIG00759119: hypothetical protein +FIG00759119 FIG00759120: hypothetical protein +FIG00759120 FIG00759121: hypothetical protein +FIG00759121 FIG00759122: hypothetical protein +FIG00759122 FIG00759123: hypothetical protein +FIG00759124 FIG00759127: hypothetical protein +FIG00759127 FIG00759128: hypothetical protein +FIG00759129 FIG00759130: hypothetical protein +FIG00759130 FIG00759131: hypothetical protein +FIG00759133 FIG00759134: hypothetical protein +FIG00759141 FIG00759142: hypothetical protein +FIG00759145 FIG00759146: hypothetical protein +FIG00759147 FIG00759148: hypothetical protein +FIG00759148 FIG00759151: hypothetical protein +FIG00759155 FIG00759159: hypothetical protein +FIG00759159 FIG00759165: hypothetical protein +FIG00759165 FIG00759166: hypothetical protein +FIG00759167 FIG00759169: hypothetical protein +FIG00759169 ABC transporter ATP-binding protein Uup, erythromycin resistance +FIG00759175 FIG00759176: hypothetical protein +FIG00759176 FIG00759178: hypothetical protein +FIG00759178 FIG00759179: hypothetical protein +FIG00759179 FIG00759180: hypothetical protein +FIG00759180 FIG00759181: hypothetical protein +FIG00759181 Amine oxidase, flavin containing +FIG00759182 FIG00759183: hypothetical protein +FIG00759191 FIG00759192: hypothetical protein +FIG00759192 FIG00759193: hypothetical protein +FIG00759195 FIG00759196: hypothetical protein +FIG00759196 FIG00759198: hypothetical protein +FIG00759198 FIG00759200: hypothetical protein +FIG00759200 FIG00759201: hypothetical protein +FIG00759201 FIG00759203: hypothetical protein +FIG00759203 FIG00759204: hypothetical protein +FIG00759204 FIG00759205: hypothetical protein +FIG00759206 FIG00759207: hypothetical protein +FIG00759210 FIG00759214: hypothetical protein +FIG00759216 FIG00759220: hypothetical protein +FIG00759220 FIG00759221: hypothetical protein +FIG00759222 FIG00759224: hypothetical protein +FIG00759224 FIG00759225: hypothetical protein +FIG00759226 FIG00759227: hypothetical protein +FIG00759234 FIG00759238: hypothetical protein +FIG00759239 FIG00759242: hypothetical protein +FIG00759242 FIG00759244: hypothetical protein +FIG00759244 FIG00759246: hypothetical protein +FIG00759246 FIG00759247: hypothetical protein +FIG00759247 FIG00759249: hypothetical protein +FIG00759249 FIG00759250: hypothetical protein +FIG00759251 TraK +FIG00759252 FIG00759253: hypothetical protein +FIG00759253 FIG00759254: hypothetical protein +FIG00759254 FIG00759261: hypothetical protein +FIG00759261 FIG00759262: hypothetical protein +FIG00759262 FIG00759263: hypothetical protein +FIG00759263 FIG00759264: hypothetical protein +FIG00759267 FIG00759268: hypothetical protein +FIG00759268 FIG00759271: hypothetical protein +FIG00759273 FIG00759275: hypothetical protein +FIG00759275 FIG00759276: hypothetical protein +FIG00759276 FIG00759277: hypothetical protein +FIG00759277 FIG00759278: hypothetical protein +FIG00759278 FIG00759279: hypothetical protein +FIG00759279 FIG00759283: hypothetical protein +FIG00759283 FIG00759285: hypothetical protein +FIG00759285 FIG00759286: hypothetical protein +FIG00759286 FIG00759287: hypothetical protein +FIG00759287 FIG00759288: hypothetical protein +FIG00759288 FIG00759290: hypothetical protein +FIG00759290 FIG00759294: hypothetical protein +FIG00759294 FIG00759295: hypothetical protein +FIG00759295 FIG00759298: hypothetical protein +FIG00759298 FIG00759302: hypothetical protein +FIG00759304 FIG00759305: hypothetical protein +FIG00759305 FIG00759306: hypothetical protein +FIG00759306 FIG00759307: hypothetical protein +FIG00759307 FIG00759309: hypothetical protein +FIG00759309 FIG00759312: hypothetical protein +FIG00759312 FIG00759313: hypothetical protein +FIG00759313 FIG00759316: hypothetical protein +FIG00759317 FIG00759318: hypothetical protein +FIG00759320 FIG00759321: hypothetical protein +FIG00759321 FIG00759322: hypothetical protein +FIG00759322 FIG00759326: hypothetical protein +FIG00759326 FIG00759327: hypothetical protein +FIG00759327 FIG00759329: hypothetical protein +FIG00759329 FIG00759330: hypothetical protein +FIG00759331 FIG00759332: hypothetical protein +FIG00759332 FIG00759333: hypothetical protein +FIG00759334 FIG00759336: hypothetical protein +FIG00759336 FIG00759339: hypothetical protein +FIG00759342 FIG00759343: hypothetical protein +FIG00759346 FIG00759348: hypothetical protein +FIG00759348 FIG00759350: hypothetical protein +FIG00759350 FIG00759351: hypothetical protein +FIG00759351 FIG00759352: hypothetical protein +FIG00759352 FIG00759354: hypothetical protein +FIG00759354 FIG00759355: hypothetical protein +FIG00759355 FIG00759356: hypothetical protein +FIG00759356 FIG00759357: hypothetical protein +FIG00759357 FIG00759361: hypothetical protein +FIG00759363 FIG00759364: hypothetical protein +FIG00759364 FIG00759366: hypothetical protein +FIG00759366 FIG00759367: hypothetical protein +FIG00759367 FIG00759376: hypothetical protein +FIG00759376 FIG00759379: hypothetical protein +FIG00759379 FIG00759385: hypothetical protein +FIG00759385 FIG00759388: hypothetical protein +FIG00759388 FIG00759389: hypothetical protein +FIG00759389 FIG00759390: hypothetical protein +FIG00759390 FIG00759391: hypothetical protein +FIG00759392 FIG00759393: hypothetical protein +FIG00759393 FIG00759396: hypothetical protein +FIG00759396 FIG00759401: hypothetical protein +FIG00759401 FIG00759402: hypothetical protein +FIG00759402 FIG00759403: hypothetical protein +FIG00759403 FIG00759405: hypothetical protein +FIG00759408 FIG00759409: hypothetical protein +FIG00759411 FIG00759412: hypothetical protein +FIG00759412 FIG00759413: hypothetical protein +FIG00759413 FIG00759416: hypothetical protein +FIG00759417 FIG00759419: hypothetical protein +FIG00759419 FIG00759421: hypothetical protein +FIG00759421 FIG00759423: hypothetical protein +FIG00759423 FIG00759424: hypothetical protein +FIG00759424 FIG00759426: hypothetical protein +FIG00759426 FIG00759427: hypothetical protein +FIG00759427 FIG00759428: hypothetical protein +FIG00759432 FIG00759433: hypothetical protein +FIG00759433 FIG00759434: hypothetical protein +FIG00759434 FIG00759440: hypothetical protein +FIG00759444 FIG00759446: hypothetical protein +FIG00759447 FIG00759448: hypothetical protein +FIG00759448 FIG00759451: hypothetical protein +FIG00759452 FIG00759454: hypothetical protein +FIG00759454 FIG00759455: hypothetical protein +FIG00759455 FIG00759457: hypothetical protein +FIG00759462 FIG00759464: hypothetical protein +FIG00759467 FIG00759468: hypothetical protein +FIG00759469 FIG00759472: hypothetical protein +FIG00759472 FIG00759477: hypothetical protein +FIG00759479 FIG00759482: hypothetical protein +FIG00759482 FIG00759483: hypothetical protein +FIG00759485 FIG00759487: hypothetical protein +FIG00759487 FIG00759489: hypothetical protein +FIG00759489 FIG00759490: hypothetical protein +FIG00759490 FIG00759491: hypothetical protein +FIG00759491 FIG00759492: hypothetical protein +FIG00759503 FIG00759506: hypothetical protein +FIG00759506 FIG00759507: hypothetical protein +FIG00759507 FIG00759508: hypothetical protein +FIG00759508 FIG00759510: hypothetical protein +FIG00759510 FIG00759511: hypothetical protein +FIG00759511 FIG00759512: hypothetical protein +FIG00759512 FIG00759514: hypothetical protein +FIG00759514 FIG00759515: hypothetical protein +FIG00759515 FIG00759517: hypothetical protein +FIG00759519 Transporting ATPase +FIG00759520 FIG00759521: hypothetical protein +FIG00759521 FIG00759522: hypothetical protein +FIG00759522 Legionella vir region protein +FIG00759523 FIG00759524: hypothetical protein +FIG00759524 FIG00759525: hypothetical protein +FIG00759525 FIG00759527: hypothetical protein +FIG00759527 FIG00759528: hypothetical protein +FIG00759528 FIG00759530: hypothetical protein +FIG00759532 FIG00759533: hypothetical protein +FIG00759533 FIG00759539: hypothetical protein +FIG00759539 FIG00759542: hypothetical protein +FIG00759542 FIG00759544: hypothetical protein +FIG00759546 FIG00759547: hypothetical protein +FIG00759547 FIG00759549: hypothetical protein +FIG00759549 FIG00759552: hypothetical protein +FIG00759552 FIG00759553: hypothetical protein +FIG00759554 FIG00759559: hypothetical protein +FIG00759559 FIG00759561: hypothetical protein +FIG00759561 FIG00759562: hypothetical protein +FIG00759564 FIG00759565: hypothetical protein +FIG00759570 FIG00759571: hypothetical protein +FIG00759572 FIG00759579: hypothetical protein +FIG00759579 FIG00759584: hypothetical protein +FIG00759584 FIG00759585: hypothetical protein +FIG00759585 FIG00759591: hypothetical protein +FIG00759591 FIG00759593: hypothetical protein +FIG00759593 FIG00759597: hypothetical protein +FIG00759597 FIG00759598: hypothetical protein +FIG00759598 FIG00759599: hypothetical protein +FIG00759599 FIG00759601: hypothetical protein +FIG00759601 FIG00759603: hypothetical protein +FIG00759603 FIG00759604: hypothetical protein +FIG00759605 FIG00759607: hypothetical protein +FIG00759607 FIG00759608: hypothetical protein +FIG00759613 FIG00759616: hypothetical protein +FIG00759616 FIG00759617: hypothetical protein +FIG00759617 FIG00759622: hypothetical protein +FIG00759638 FIG00759640: hypothetical protein +FIG00759640 FIG00759641: hypothetical protein +FIG00759641 FIG00759643: hypothetical protein +FIG00759643 FIG00759645: hypothetical protein +FIG00759646 IncP-type DNA transfer protein TraL +FIG00759647 FIG00759650: hypothetical protein +FIG00759650 FIG00759651: hypothetical protein +FIG00759654 FIG00759657: hypothetical protein +FIG00759657 FIG00759658: hypothetical protein +FIG00759665 FIG00759670: hypothetical protein +FIG00759670 FIG00759671: hypothetical protein +FIG00759675 FIG00759678: hypothetical protein +FIG00759678 Glutamate synthetase +FIG00759681 FIG00759682: hypothetical protein +FIG00759682 FIG00759683: hypothetical protein +FIG00759683 FIG00759690: hypothetical protein +FIG00759693 FIG00759694: hypothetical protein +FIG00759694 FIG00759695: hypothetical protein +FIG00759698 FIG00759699: hypothetical protein +FIG00759699 FIG00759706: hypothetical protein +FIG00759706 FIG00759708: hypothetical protein +FIG00759710 FIG00759711: hypothetical protein +FIG00759722 FIG00759724: hypothetical protein +FIG00759724 FIG00759725: hypothetical protein +FIG00759726 FIG00759728: hypothetical protein +FIG00759728 FIG00759735: hypothetical protein +FIG00759735 FIG00759737: hypothetical protein +FIG00759745 FIG00759748: hypothetical protein +FIG00759748 Gll2498 protein +FIG00759749 FIG00759750: hypothetical protein +FIG00759750 FIG00759756: hypothetical protein +FIG00759756 FIG00759760: hypothetical protein +FIG00759760 FIG00759761: hypothetical protein +FIG00759763 FIG00759765: hypothetical protein +FIG00759765 FIG00759769: hypothetical protein +FIG00759769 FIG00759771: hypothetical protein +FIG00759771 FIG00759772: hypothetical protein +FIG00759772 FIG00759777: hypothetical protein +FIG00759780 FIG00759783: hypothetical protein +FIG00759783 FIG00759786: hypothetical protein +FIG00759786 FIG00759787: hypothetical protein +FIG00759792 FIG00759796: hypothetical protein +FIG00759796 FIG00759799: hypothetical protein +FIG00759799 FIG00759800: hypothetical protein +FIG00759800 FIG00759801: hypothetical protein +FIG00759801 FIG00759803: hypothetical protein +FIG00759803 heat shock hsp20 +FIG00759808 FIG00759811: hypothetical protein +FIG00759811 FIG00759813: hypothetical protein +FIG00759813 FIG00759817: hypothetical protein +FIG00759817 FIG00759818: hypothetical protein +FIG00759818 Interaptin +FIG00759821 FIG00759822: hypothetical protein +FIG00759825 FIG00759827: hypothetical protein +FIG00759831 FIG00759833: hypothetical protein +FIG00759833 FIG00759836: hypothetical protein +FIG00759836 FIG00759838: hypothetical protein +FIG00759839 FIG00759840: hypothetical protein +FIG00759840 FIG00759841: hypothetical protein +FIG00759841 FIG00759845: hypothetical protein +FIG00759846 FIG00759847: hypothetical protein +FIG00759847 FIG00759848: hypothetical protein +FIG00759854 RelB/StbD replicon stabilization protein (antitoxin to RelE/StbE) +FIG00759855 FIG00759858: hypothetical protein +FIG00759858 FIG00759859: hypothetical protein +FIG00759860 FIG00759861: hypothetical protein +FIG00759861 FIG00759863: hypothetical protein +FIG00759873 FIG00759875: hypothetical protein +FIG00759878 FIG00759880: hypothetical protein +FIG00759880 FIG00759882: hypothetical protein +FIG00759883 FIG00759885: hypothetical protein +FIG00759885 FIG00759890: hypothetical protein +FIG00759892 FIG00759893: hypothetical protein +FIG00759903 FIG00759904: hypothetical protein +FIG00759904 FIG00759906: hypothetical protein +FIG00759914 FIG00759916: hypothetical protein +FIG00759920 FIG00759921: hypothetical protein +FIG00759921 FIG00759923: hypothetical protein +FIG00759923 FIG00759925: hypothetical protein +FIG00759925 FIG00759931: hypothetical protein +FIG00759931 FIG00759932: hypothetical protein +FIG00759932 FIG00759933: hypothetical protein +FIG00759933 FIG00759934: hypothetical protein +FIG00759934 FIG00759938: hypothetical protein +FIG00759945 FIG00759948: hypothetical protein +FIG00759948 FIG00759949: hypothetical protein +FIG00759949 FIG00759953: hypothetical protein +FIG00759953 FIG00759955: hypothetical protein +FIG00759955 FIG00759956: hypothetical protein +FIG00759956 FIG00759958: hypothetical protein +FIG00759960 FIG00759963: hypothetical protein +FIG00759970 FIG00759974: hypothetical protein +FIG00759974 FIG00759977: hypothetical protein +FIG00759977 FIG00759983: hypothetical protein +FIG00759983 FIG00759989: hypothetical protein +FIG00759989 FIG00759991: hypothetical protein +FIG00759993 FIG00759994: hypothetical protein +FIG00759994 FIG00759996: hypothetical protein +FIG00759996 FIG00759998: hypothetical protein +FIG00759999 FIG00760002: hypothetical protein +FIG00760002 FIG00760004: hypothetical protein +FIG00760004 FIG00760008: hypothetical protein +FIG00760015 FIG00760019: hypothetical protein +FIG00760020 FIG00760026: hypothetical protein +FIG00760026 FIG00760027: hypothetical protein +FIG00760027 FIG00760037: hypothetical protein +FIG00760038 FIG00760039: hypothetical protein +FIG00760039 FIG00760040: hypothetical protein +FIG00760040 FIG00760041: hypothetical protein +FIG00760042 FIG00760044: hypothetical protein +FIG00760044 hypothetical protein +FIG00760047 FIG00760050: hypothetical protein +FIG00760050 FIG00760052: hypothetical protein +FIG00760054 FIG00760056: hypothetical protein +FIG00760057 FIG00760061: hypothetical protein +FIG00760072 FIG00760075: hypothetical protein +FIG00760075 FIG00760076: hypothetical protein +FIG00760079 FIG00760082: hypothetical protein +FIG00760082 FIG00760083: hypothetical protein +FIG00760083 FIG00760084: hypothetical protein +FIG00760084 FIG00760085: hypothetical protein +FIG00760086 FIG00760090: hypothetical protein +FIG00760092 FIG00760093: hypothetical protein +FIG00760093 FIG00760096: hypothetical protein +FIG00760096 FIG00760098: hypothetical protein +FIG00760098 FIG00760099: hypothetical protein +FIG00760099 FIG00760100: hypothetical protein +FIG00760100 FIG00760107: hypothetical protein +FIG00760107 FIG00760108: hypothetical protein +FIG00760108 FIG00760110: hypothetical protein +FIG00760110 FIG00760111: hypothetical protein +FIG00760117 FIG00760120: hypothetical protein +FIG00760120 FIG00760121: hypothetical protein +FIG00760121 FIG00760125: hypothetical protein +FIG00760125 FIG00760127: hypothetical protein +FIG00760142 FIG00760143: hypothetical protein +FIG00760143 GTP cyclohydrolase II homolog +FIG00760157 FIG00760160: hypothetical protein +FIG00760160 FIG00760162: hypothetical protein +FIG00760166 FIG00760167: hypothetical protein +FIG00760167 FIG00760169: hypothetical protein +FIG00760169 FIG00760174: hypothetical protein +FIG00760174 FIG00760175: hypothetical protein +FIG00760175 FIG00760177: hypothetical protein +FIG00760177 FIG00760178: hypothetical protein +FIG00760178 FIG00760180: hypothetical protein +FIG00760182 FIG00760189: hypothetical protein +FIG00760190 FIG00760191: hypothetical protein +FIG00760191 FIG00760192: hypothetical protein +FIG00760194 FIG00760195: hypothetical protein +FIG00760199 FIG00760205: hypothetical protein +FIG00760205 FIG00760206: hypothetical protein +FIG00760206 FIG00760207: hypothetical protein +FIG00760207 FIG00760208: hypothetical protein +FIG00760209 FIG00760211: hypothetical protein +FIG00760220 FIG00760222: hypothetical protein +FIG00760222 FIG00760223: hypothetical protein +FIG00760236 FIG00760237: hypothetical protein +FIG00760238 FIG00760245: hypothetical protein +FIG00760246 FIG00760250: hypothetical protein +FIG00760257 FIG00760258: hypothetical protein +FIG00760261 FIG00760262: hypothetical protein +FIG00760270 FIG00760276: hypothetical protein +FIG00760276 FIG00760280: hypothetical protein +FIG00760280 FIG00760281: hypothetical protein +FIG00760283 FIG00760284: hypothetical protein +FIG00760284 FIG00760286: hypothetical protein +FIG00760286 FIG00760289: hypothetical protein +FIG00760294 FIG00760296: hypothetical protein +FIG00760296 FIG00760297: hypothetical protein +FIG00760297 FIG00760300: hypothetical protein +FIG00760305 FIG00760306: hypothetical protein +FIG00760306 FIG00760308: hypothetical protein +FIG00760318 FIG00760322: hypothetical protein +FIG00760324 FIG00760326: hypothetical protein +FIG00760326 FIG00760330: hypothetical protein +FIG00760330 FIG00760331: hypothetical protein +FIG00760333 FIG00760336: hypothetical protein +FIG00760336 FIG00760340: hypothetical protein +FIG00760344 FIG00760347: hypothetical protein +FIG00760351 FIG00760355: hypothetical protein +FIG00760355 FIG00760356: hypothetical protein +FIG00760365 FIG00760368: hypothetical protein +FIG00760379 FIG00760383: hypothetical protein +FIG00760383 FIG00760385: hypothetical protein +FIG00760385 FIG00760386: hypothetical protein +FIG00760386 FIG00760388: hypothetical protein +FIG00760390 FIG00760391: hypothetical protein +FIG00760397 FIG00760400: hypothetical protein +FIG00760403 FIG00760406: hypothetical protein +FIG00760407 FIG00760410: hypothetical protein +FIG00760410 FIG00760411: hypothetical protein +FIG00760411 FIG00760413: hypothetical protein +FIG00760413 FIG00760416: hypothetical protein +FIG00760416 FIG00760417: hypothetical protein +FIG00760418 FIG00760422: hypothetical protein +FIG00760422 FIG00760425: hypothetical protein +FIG00760425 FIG00760427: hypothetical protein +FIG00760431 FIG00760432: hypothetical protein +FIG00760433 FIG00760434: hypothetical protein +FIG00760436 FIG00760439: hypothetical protein +FIG00760439 FIG00760440: hypothetical protein +FIG00760440 IncP-type DNA transfer coupling protein TraG +FIG00760442 FIG00760443: hypothetical protein +FIG00760443 FIG00760446: hypothetical protein +FIG00760454 FIG00760458: hypothetical protein +FIG00760458 FIG00760459: hypothetical protein +FIG00760464 FIG00760466: hypothetical protein +FIG00760467 FIG00760469: hypothetical protein +FIG00760469 FIG00760473: hypothetical protein +FIG00760477 FIG00760478: hypothetical protein +FIG00760483 FIG00760484: hypothetical protein +FIG00760492 FIG00760497: hypothetical protein +FIG00760501 FIG00760502: hypothetical protein +FIG00760502 FIG00760506: hypothetical protein +FIG00760519 FIG00760524: hypothetical protein +FIG00760524 FIG00760526: hypothetical protein +FIG00760528 FIG00760529: hypothetical protein +FIG00760530 FIG00760532: hypothetical protein +FIG00760532 FIG00760543: hypothetical protein +FIG00760546 FIG00760547: hypothetical protein +FIG00760547 FIG00760548: hypothetical protein +FIG00760548 Drug resistance transporter, Bcr/CflA +FIG00760560 FIG00760569: hypothetical protein +FIG00760570 nuclear receptor coactivator 6 interacting protein +FIG00760571 FIG00760574: hypothetical protein +FIG00760575 FIG00760577: hypothetical protein +FIG00760577 stress-responsive transcriptional regulator +FIG00760584 FIG00760587: hypothetical protein +FIG00760589 FIG00760591: hypothetical protein +FIG00760594 FIG00760595: hypothetical protein +FIG00760607 FIG00760613: hypothetical protein +FIG00760613 FIG00760617: hypothetical protein +FIG00760618 Small-molecule methyltransferase IraA +FIG00760630 FIG00760635: hypothetical protein +FIG00760635 FIG00760639: hypothetical protein +FIG00760651 FIG00760652: hypothetical protein +FIG00760654 FIG00760655: hypothetical protein +FIG00760661 FIG00760669: hypothetical protein +FIG00760673 FIG00760674: hypothetical protein +FIG00760674 FIG00760675: hypothetical protein +FIG00760683 FIG00760685: hypothetical protein +FIG00760685 FIG00760686: hypothetical protein +FIG00760686 FIG00760689: hypothetical protein +FIG00760697 FIG00760698: hypothetical protein +FIG00760698 FIG00760701: hypothetical protein +FIG00760701 FIG00760702: hypothetical protein +FIG00760702 FIG00760703: hypothetical protein +FIG00760703 FIG00760707: hypothetical protein +FIG00760714 FIG00760715: hypothetical protein +FIG00760716 FIG00760718: hypothetical protein +FIG00760722 FIG00760724: hypothetical protein +FIG00760725 FIG00760726: hypothetical protein +FIG00760726 FIG00760728: hypothetical protein +FIG00760728 FIG00760734: hypothetical protein +FIG00760734 FIG00760735: hypothetical protein +FIG00760737 FIG00760741: hypothetical protein +FIG00760743 FIG00760744: hypothetical protein +FIG00760744 FIG00760749: hypothetical protein +FIG00760749 FIG00760750: hypothetical protein +FIG00760751 IncP-type DNA transfer maturation peptidase TraF +FIG00760752 FIG00760753: hypothetical protein +FIG00760758 FIG00760761: hypothetical protein +FIG00760761 FIG00760762: hypothetical protein +FIG00760762 FIG00760763: hypothetical protein +FIG00760763 IncP-type DNA transfer protein TraM +FIG00760780 FIG00760783: hypothetical protein +FIG00760783 FIG00760786: hypothetical protein +FIG00760793 FIG00760795: hypothetical protein +FIG00760798 FIG00760799: hypothetical protein +FIG00760799 FIG00760800: hypothetical protein +FIG00760800 FIG00760803: hypothetical protein +FIG00760814 FIG00760816: hypothetical protein +FIG00760816 FIG00760825: hypothetical protein +FIG00760825 Periplasmic, osmotically inducible protein Y-like +FIG00760828 Bll0215 protein +FIG00760834 FIG00760835: hypothetical protein +FIG00760835 FIG00760844: hypothetical protein +FIG00760850 FIG00760854: hypothetical protein +FIG00760868 FIG00760877: hypothetical protein +FIG00760877 FIG00760887: hypothetical protein +FIG00760899 FIG00760904: hypothetical protein +FIG00760904 FIG00760905: hypothetical protein +FIG00760906 FIG00760909: hypothetical protein +FIG00760909 ATP-dependent RNA helicase A +FIG00760912 FIG00760913: hypothetical protein +FIG00760927 FIG00760931: hypothetical protein +FIG00760940 FIG00760941: hypothetical protein +FIG00760941 FIG00760946: hypothetical protein +FIG00760946 FIG00760950: hypothetical protein +FIG00760950 FIG00760951: hypothetical protein +FIG00760951 FIG00760952: hypothetical protein +FIG00760952 FIG00760954: hypothetical protein +FIG00760954 FIG00760958: hypothetical protein +FIG00760960 FIG00760963: hypothetical protein +FIG00760970 FIG00760976: hypothetical protein +FIG00760976 FIG00760978: hypothetical protein +FIG00760992 FIG00760997: hypothetical protein +FIG00761001 FIG00761007: hypothetical protein +FIG00761016 FIG00761034: hypothetical protein +FIG00761039 FIG00761040: hypothetical protein +FIG00761047 FIG00761049: hypothetical protein +FIG00761053 FIG00761054: hypothetical protein +FIG00761055 FIG00761060: hypothetical protein +FIG00761063 FIG00761065: hypothetical protein +FIG00761073 FIG00761074: hypothetical protein +FIG00761086 FIG00761094: hypothetical protein +FIG00761099 FIG00761103: hypothetical protein +FIG00761116 FIG00761117: hypothetical protein +FIG00761117 FIG00761123: hypothetical protein +FIG00761141 FIG00761142: hypothetical protein +FIG00761142 FIG00761154: hypothetical protein +FIG00761184 FIG00761187: hypothetical protein +FIG00761195 FIG00761199: hypothetical protein +FIG00761216 FIG00761220: hypothetical protein +FIG00761272 RelE/StbE replicon stabilization toxin +FIG00761304 FIG00761309: hypothetical protein +FIG00761337 FIG00761339: hypothetical protein +FIG00761342 FIG00761343: hypothetical protein +FIG00761343 FIG00761345: hypothetical protein +FIG00761347 FIG00761351: hypothetical protein +FIG00761358 FIG00761366: hypothetical protein +FIG00761376 FIG00761382: hypothetical protein +FIG00761382 FIG00761384: hypothetical protein +FIG00761401 FIG00761423: hypothetical protein +FIG00761545 FIG00761547: hypothetical protein +FIG00761549 FIG00761558: hypothetical protein +FIG00761558 FIG00761562: hypothetical protein +FIG00761568 FIG00761570: hypothetical protein +FIG00761571 FIG00761579: hypothetical protein +FIG00761592 FIG00761593: hypothetical protein +FIG00761593 Alr0203 protein +FIG00761596 FIG00761598: hypothetical protein +FIG00761602 FIG00761612: hypothetical protein +FIG00761612 FIG00761614: hypothetical protein +FIG00761616 FIG00761617: hypothetical protein +FIG00761672 FIG00761676: hypothetical protein +FIG00761681 FIG00761684: hypothetical protein +FIG00761735 Trehalase (EC 3.2.1.28); Cytoplasmic trehalase (EC 3.2.1.28) +FIG00761767 FIG00761768: hypothetical protein +FIG00761799 FIG00761799: membrane protein +FIG00761809 Probable serine/threonine-protein kinase pknK (EC 2.7.11.1) +FIG00761891 FIG00761895: hypothetical protein +FIG00761952 FIG00761954: hypothetical protein +FIG00761997 FIG00762000: hypothetical protein +FIG00762043 FIG00762047: hypothetical protein +FIG00762047 Phage major capsid +FIG00762055 Probable phage-related protein +FIG00762115 Lipopolysaccharide modification acyltransferase +FIG00762207 FIG00762208: hypothetical protein +FIG00762247 FIG00762251: hypothetical protein +FIG00762330 FIG00762332: hypothetical protein +FIG00762340 FIG00762341: hypothetical protein +FIG00762457 RNA polymerase, sigma-70 factor, ECF subfamily +FIG00762472 FIG00762474: hypothetical protein +FIG00762480 FIG00762484: hypothetical protein +FIG00762497 FIG00762498: hypothetical protein +FIG00762498 FIG00762500: hypothetical protein +FIG00762500 putative glycine-rich RNA binding protein +FIG00762502 FIG00762503: hypothetical protein +FIG00762508 FIG00762509: hypothetical protein +FIG00762509 FIG00762511: hypothetical protein +FIG00762511 FIG00762514: hypothetical protein +FIG00762518 Cholesterol oxidase precursor +FIG00762520 Carboxy-terminal processing protease precursor +FIG00762521 FIG00762522: hypothetical protein +FIG00762522 FIG00762525: hypothetical protein +FIG00762525 FIG00762527: hypothetical protein +FIG00762527 FIG00762528: hypothetical protein +FIG00762530 FIG00762532: hypothetical protein +FIG00762532 FIG00762533: hypothetical protein +FIG00762533 FIG00762535: hypothetical protein +FIG00762535 FIG00762537: hypothetical protein +FIG00762537 FIG00762538: hypothetical protein +FIG00762539 FIG00762540: hypothetical protein +FIG00762540 FIG00762542: hypothetical protein +FIG00762542 Heme exporter protein A (TC3.A.1.107.1) +FIG00762544 FIG00762547: hypothetical protein +FIG00762547 putative sugar transport protein +FIG00762550 FIG00762551: hypothetical protein +FIG00762551 FIG00762554: hypothetical protein +FIG00762555 FIG00762557: hypothetical protein +FIG00762558 FIG00762559: hypothetical protein +FIG00762559 FIG00762560: hypothetical protein +FIG00762560 transcriptional regulator (AraC family) +FIG00762563 FIG00762566: hypothetical protein +FIG00762566 FIG00762569: hypothetical protein +FIG00762569 FIG00762573: hypothetical protein +FIG00762573 FIG00762574: hypothetical protein +FIG00762578 FIG00762581: hypothetical protein +FIG00762583 FIG00762584: hypothetical protein +FIG00762584 FIG00762585: hypothetical protein +FIG00762587 FIG00762588: hypothetical protein +FIG00762598 FIG00762601: hypothetical protein +FIG00762601 FIG00762602: hypothetical protein +FIG00762603 phage-related integrase/recombinase +FIG00762604 FIG00762606: hypothetical protein +FIG00762606 FIG00762607: hypothetical protein +FIG00762607 FIG00762608: hypothetical protein +FIG00762609 confirmed by proteomics +FIG00762610 FIG00762613: hypothetical protein +FIG00762621 FIG00762622: hypothetical protein +FIG00762622 heat shock protein,HtrA1 +FIG00762626 FIG00762628: hypothetical protein +FIG00762628 Oxidoreductase FAD-binding family protein +FIG00762629 FIG00762631: hypothetical protein +FIG00762631 FIG00762635: hypothetical protein +FIG00762635 FIG00762636: hypothetical protein +FIG00762636 FIG00762639: hypothetical protein +FIG00762639 FIG00762641: hypothetical protein +FIG00762641 FIG00762642: hypothetical protein +FIG00762642 FIG00762646: hypothetical protein +FIG00762649 FIG00762650: hypothetical protein +FIG00762650 FIG00762653: hypothetical protein +FIG00762653 FIG00762655: hypothetical protein +FIG00762655 FIG00762656: hypothetical protein +FIG00762656 FIG00762657: hypothetical protein +FIG00762657 FIG00762658: hypothetical protein +FIG00762659 FIG00762661: hypothetical protein +FIG00762661 FIG00762662: hypothetical protein +FIG00762662 FIG00762664: hypothetical protein +FIG00762665 FIG00762667: hypothetical protein +FIG00762667 FIG00762672: hypothetical protein +FIG00762675 FIG00762676: hypothetical protein +FIG00762676 FIG00762677: hypothetical protein +FIG00762677 FIG00762678: hypothetical protein +FIG00762678 aspartate aminotransferase +FIG00762680 methylamine utilization ferredoxin-type protein +FIG00762682 ATPase of AAA class +FIG00762683 FIG00762684: hypothetical protein +FIG00762684 FIG00762685: hypothetical protein +FIG00762685 ARM repeat superfamily protein +FIG00762687 transmembrane outer membrane protein L1 +FIG00762691 FIG00762692: hypothetical protein +FIG00762693 FIG00762696: hypothetical protein +FIG00762700 benzene 1,2-dioxygenase Rieske iron-sulfur component +FIG00762703 DNA repair protein +FIG00762707 FIG00762708: hypothetical protein +FIG00762710 FIG00762713: hypothetical protein +FIG00762716 FIG00762717: hypothetical protein +FIG00762717 FIG00762722: hypothetical protein +FIG00762724 FIG00762725: hypothetical protein +FIG00762725 FIG00762727: hypothetical protein +FIG00762728 MotA/TolQ/ExbB proton channel family +FIG00762733 FIG00762734: hypothetical protein +FIG00762734 FIG00762740: hypothetical protein +FIG00762742 FIG00762743: hypothetical protein +FIG00762743 FIG00762745: hypothetical protein +FIG00762745 FIG00762746: hypothetical protein +FIG00762746 internal repeat sequences detected +FIG00762747 FIG00762749: hypothetical protein +FIG00762752 FIG00762753: hypothetical protein +FIG00762753 leucine-rich-repeat containing protein +FIG00762757 FIG00762758: hypothetical protein +FIG00762758 FIG00762759: hypothetical protein +FIG00762762 FIG00762765: hypothetical protein +FIG00762766 FIG00762769: hypothetical protein +FIG00762769 periplasmic trypsin-like serine protease +FIG00762771 FIG00762772: hypothetical protein +FIG00762772 FIG00762777: hypothetical protein +FIG00762777 FIG00762781: hypothetical protein +FIG00762790 FIG00762791: hypothetical protein +FIG00762791 FIG00762794: hypothetical protein +FIG00762794 FIG00762796: hypothetical protein +FIG00762798 signal peptide peptidase sppA( EC:3.4.21.- ) +FIG00762799 Leucine-rich repeat containing protein +FIG00762804 FIG00762805: hypothetical protein +FIG00762805 FIG00762806: hypothetical protein +FIG00762806 FIG00762807: hypothetical protein +FIG00762807 FIG00762808: hypothetical protein +FIG00762809 FIG00762810: hypothetical protein +FIG00762814 FIG00762815: hypothetical protein +FIG00762816 FIG00762817: hypothetical protein +FIG00762817 FIG00762820: hypothetical protein +FIG00762822 hypothetical protein +FIG00762824 FIG00762826: hypothetical protein +FIG00762826 FIG00762828: hypothetical protein +FIG00762828 FIG00762833: hypothetical protein +FIG00762833 FIG00762834: hypothetical protein +FIG00762834 FIG00762835: hypothetical protein +FIG00762835 FIG00762836: hypothetical protein +FIG00762836 FIG00762839: hypothetical protein +FIG00762839 FIG00762841: hypothetical protein +FIG00762841 FIG00762842: hypothetical protein +FIG00762845 LipL45-like protein +FIG00762847 cyclic nucleotide binding protein +FIG00762850 FIG00762852: hypothetical protein +FIG00762853 FIG00762854: hypothetical protein +FIG00762854 FIG00762855: hypothetical protein +FIG00762858 FIG00762859: hypothetical protein +FIG00762861 FIG00762862: hypothetical protein +FIG00762868 FIG00762873: hypothetical protein +FIG00762873 FIG00762874: hypothetical protein +FIG00762874 FIG00762875: hypothetical protein +FIG00762875 FIG00762879: hypothetical protein +FIG00762883 probable acetyltransferase +FIG00762889 FIG00762890: hypothetical protein +FIG00762890 FIG00762892: hypothetical protein +FIG00762892 FIG00762893: hypothetical protein +FIG00762893 Heat shock protein HSP33 +FIG00762902 FIG00762903: hypothetical protein +FIG00762903 FIG00762904: hypothetical protein +FIG00762909 FIG00762912: hypothetical protein +FIG00762912 FIG00762913: hypothetical protein +FIG00762913 FIG00762914: hypothetical protein +FIG00762914 FIG00762915: hypothetical protein +FIG00762919 FIG00762922: hypothetical protein +FIG00762925 FIG00762926: hypothetical protein +FIG00762937 Oxidoreductase ucpA (EC 1.-.-.-) +FIG00762940 FIG00762942: hypothetical protein +FIG00762942 FIG00762944: hypothetical protein +FIG00762944 FIG00762945: hypothetical protein +FIG00762951 ABC transporter, ABC-2 subfamily +FIG00762954 FIG00762956: hypothetical protein +FIG00762956 regulator of chromosome condensation +FIG00762963 hemolysin hemolytic protein hlpA +FIG00762965 FIG00762966: hypothetical protein +FIG00762966 FIG00762968: hypothetical protein +FIG00762968 FIG00762969: hypothetical protein +FIG00762969 HNH endonuclease family +FIG00762970 FIG00762972: hypothetical protein +FIG00762975 FIG00762978: hypothetical protein +FIG00762978 FIG00762979: hypothetical protein +FIG00762979 FIG00762983: hypothetical protein +FIG00762983 FIG00762984: hypothetical protein +FIG00762984 FIG00762991: hypothetical protein +FIG00762991 FIG00762994: hypothetical protein +FIG00762994 FIG00762995: hypothetical protein +FIG00762998 FIG00762999: hypothetical protein +FIG00762999 FIG00763004: hypothetical protein +FIG00763004 FIG00763008: hypothetical protein +FIG00763008 FIG00763009: hypothetical protein +FIG00763010 FIG00763012: hypothetical protein +FIG00763012 FIG00763013: hypothetical protein +FIG00763013 2-nitropropane dioxygenase +FIG00763014 FIG00763015: hypothetical protein +FIG00763015 FIG00763018: hypothetical protein +FIG00763019 FIG00763022: hypothetical protein +FIG00763022 FIG00763026: hypothetical protein +FIG00763026 Probable RNA polymerase ECF-type sigma factor +FIG00763029 FIG00763032: hypothetical protein +FIG00763032 Probable 15 kDa heat shock protein +FIG00763033 FIG00763036: hypothetical protein +FIG00763039 FIG00763043: hypothetical protein +FIG00763043 FIG00763045: hypothetical protein +FIG00763045 FIG00763048: hypothetical protein +FIG00763049 Surface exposed lipoprotein +FIG00763050 phage Gp37Gp68 +FIG00763052 FIG00763053: hypothetical protein +FIG00763053 FIG00763054: hypothetical protein +FIG00763054 FIG00763055: hypothetical protein +FIG00763055 FIG00763059: hypothetical protein +FIG00763060 FIG00763061: hypothetical protein +FIG00763061 FIG00763062: hypothetical protein +FIG00763062 FIG00763064: hypothetical protein +FIG00763064 FIG00763065: hypothetical protein +FIG00763065 FIG00763067: hypothetical protein +FIG00763067 FIG00763068: hypothetical protein +FIG00763070 FIG00763072: hypothetical protein +FIG00763072 FIG00763078: hypothetical protein +FIG00763078 Potassium uptake protein KtrB +FIG00763079 FIG00763080: hypothetical protein +FIG00763080 putative acyl-CoA dehydrogenase-like protein +FIG00763086 FIG00763088: hypothetical protein +FIG00763088 FIG00763089: hypothetical protein +FIG00763089 FIG00763092: hypothetical protein +FIG00763092 FIG00763101: hypothetical protein +FIG00763101 FIG00763102: hypothetical protein +FIG00763102 FIG00763103: hypothetical protein +FIG00763103 serine protease DO +FIG00763109 FIG00763110: hypothetical protein +FIG00763110 FIG00763111: hypothetical protein +FIG00763113 FIG00763118: hypothetical protein +FIG00763124 FIG00763126: hypothetical protein +FIG00763126 FIG00763127: hypothetical protein +FIG00763127 FIG00763128: hypothetical protein +FIG00763128 FIG00763130: hypothetical protein +FIG00763130 FIG00763132: hypothetical protein +FIG00763132 FIG00763133: hypothetical protein +FIG00763133 FIG00763136: hypothetical protein +FIG00763136 FIG00763140: hypothetical protein +FIG00763140 FIG00763141: hypothetical protein +FIG00763141 RidA/YER057c/UK114 superfamily, group 1 +FIG00763146 acetylglutamate kinase-like protein +FIG00763149 FIG00763150: hypothetical protein +FIG00763150 FIG00763151: hypothetical protein +FIG00763151 FIG00763154: hypothetical protein +FIG00763154 FIG00763156: hypothetical protein +FIG00763156 FIG00763158: hypothetical protein +FIG00763158 FIG00763159: hypothetical protein +FIG00763162 cytoplasmic membrane protein +FIG00763165 FIG00763166: hypothetical protein +FIG00763166 FIG00763169: hypothetical protein +FIG00763171 FIG00763172: hypothetical protein +FIG00763172 FIG00763175: hypothetical protein +FIG00763175 FIG00763176: hypothetical protein +FIG00763176 FIG00763178: hypothetical protein +FIG00763178 inositol monophosphatase family +FIG00763181 methyltransferase DNA modification enzyme +FIG00763182 FIG00763184: hypothetical protein +FIG00763184 FIG00763185: hypothetical protein +FIG00763185 ABC-type multidrug transport system, ATP-binding protein YadG +FIG00763190 acyltransferase +FIG00763192 FIG00763195: hypothetical protein +FIG00763195 FIG00763196: hypothetical protein +FIG00763196 multidrug-efflux transporter +FIG00763198 FIG00763201: hypothetical protein +FIG00763201 FIG00763203: hypothetical protein +FIG00763208 FIG00763211: hypothetical protein +FIG00763211 FIG00763212: hypothetical protein +FIG00763212 acyl-CoA dehydrogenase +FIG00763213 FIG00763215: hypothetical protein +FIG00763215 FIG00763216: hypothetical protein +FIG00763216 FIG00763221: hypothetical protein +FIG00763221 FIG00763226: hypothetical protein +FIG00763227 FIG00763228: hypothetical protein +FIG00763228 FIG00763229: hypothetical protein +FIG00763231 Probable peptide transporter permease +FIG00763240 ABC transporter, atp-binding protein +FIG00763245 FIG00763248: hypothetical protein +FIG00763248 FIG00763251: hypothetical protein +FIG00763251 FIG00763252: hypothetical protein +FIG00763252 FIG00763253: hypothetical protein +FIG00763254 FIG00763255: hypothetical protein +FIG00763255 FIG00763261: hypothetical protein +FIG00763261 DNA replication protein DnaC +FIG00763262 FIG00763267: hypothetical protein +FIG00763267 FIG00763271: hypothetical protein +FIG00763271 FIG00763273: hypothetical protein +FIG00763273 FIG00763277: hypothetical protein +FIG00763277 FIG00763280: hypothetical protein +FIG00763280 FIG00763281: hypothetical protein +FIG00763281 FIG00763287: hypothetical protein +FIG00763287 FIG00763289: hypothetical protein +FIG00763289 FIG00763291: hypothetical protein +FIG00763291 FIG00763294: hypothetical protein +FIG00763294 FIG00763297: hypothetical protein +FIG00763297 FIG00763298: hypothetical protein +FIG00763299 FIG00763300: hypothetical protein +FIG00763300 FIG00763302: hypothetical protein +FIG00763302 FIG00763303: hypothetical protein +FIG00763303 FIG00763304: hypothetical protein +FIG00763306 FIG00763309: hypothetical protein +FIG00763309 FIG00763312: hypothetical protein +FIG00763316 protein phosphatase +FIG00763319 FIG00763320: hypothetical protein +FIG00763322 FIG00763323: hypothetical protein +FIG00763323 FIG00763324: hypothetical protein +FIG00763324 FIG00763325: hypothetical protein +FIG00763325 FIG00763327: hypothetical protein +FIG00763327 FIG00763328: hypothetical protein +FIG00763328 FIG00763329: hypothetical protein +FIG00763329 FIG00763332: hypothetical protein +FIG00763332 FIG00763333: hypothetical protein +FIG00763333 FIG00763335: hypothetical protein +FIG00763335 FIG00763338: hypothetical protein +FIG00763338 FIG00763341: hypothetical protein +FIG00763341 FIG00763344: hypothetical protein +FIG00763344 FIG00769019: hypothetical protein +FIG00763346 NHL repeat protein +FIG00763349 FIG00763353: hypothetical protein +FIG00763353 FIG00763359: hypothetical protein +FIG00763361 FIG00763362: hypothetical protein +FIG00763365 FIG00763366: hypothetical protein +FIG00763366 FIG00763367: hypothetical protein +FIG00763369 FIG00763374: hypothetical protein +FIG00763374 FIG00763375: hypothetical protein +FIG00763376 FIG00763378: hypothetical protein +FIG00763378 FIG00763380: hypothetical protein +FIG00763381 FIG00763382: hypothetical protein +FIG00763382 dihydrolipoamide acetyltransferase +FIG00763383 FIG00763384: hypothetical protein +FIG00763384 FIG00763385: hypothetical protein +FIG00763385 putative methyl-accepting chemotaxis transmembrane protein +FIG00763388 FIG00763389: hypothetical protein +FIG00763389 FIG00763392: hypothetical protein +FIG00763392 conserved hypothetical protein with MORN repeat +FIG00763393 FIG00763395: hypothetical protein +FIG00763403 FIG00763404: hypothetical protein +FIG00763405 FIG00763406: hypothetical protein +FIG00763406 FIG00763407: hypothetical protein +FIG00763407 FIG00763409: hypothetical protein +FIG00763412 FIG00763418: hypothetical protein +FIG00763419 FIG00763421: hypothetical protein +FIG00763422 FIG00763423: hypothetical protein +FIG00763430 FIG00763433: hypothetical protein +FIG00763433 Molecular chaperones dnaJ +FIG00763435 FIG00763436: hypothetical protein +FIG00763436 FIG00763438: hypothetical protein +FIG00763438 L-lactate dehydrogenase +FIG00763440 receptor tyrosine kinase +FIG00763443 FIG00763444: hypothetical protein +FIG00763447 FIG00763448: hypothetical protein +FIG00763448 FIG00763449: hypothetical protein +FIG00763453 UDP-glucose 4-epimerase (EC 5.1.3.2) +FIG00763455 parA family protein +FIG00763456 rhodanese-like thiosulfate sulfurtransferase +FIG00763457 FIG00763462: hypothetical protein +FIG00763462 FIG00763463: hypothetical protein +FIG00763465 FIG00763466: hypothetical protein +FIG00763466 short-chain dehydrogenase +FIG00763467 FIG00763470: hypothetical protein +FIG00763470 FIG00763472: hypothetical protein +FIG00763472 alpha/beta hydrolase +FIG00763474 FIG00763475: hypothetical protein +FIG00763475 FIG00763476: hypothetical protein +FIG00763476 TolR protein +FIG00763482 FIG00763491: hypothetical protein +FIG00763491 3-oxoacyl-[acyl-carrier protein] reductase +FIG00763495 FIG00763496: hypothetical protein +FIG00763496 FIG00763499: hypothetical protein +FIG00763499 FIG00763504: hypothetical protein +FIG00763504 FIG00763505: hypothetical protein +FIG00763505 FIG00763507: hypothetical protein +FIG00763508 FIG00763509: hypothetical protein +FIG00763509 FIG00763510: hypothetical protein +FIG00763513 FIG00763515: hypothetical protein +FIG00763515 FIG00763517: hypothetical protein +FIG00763517 FIG00763518: hypothetical protein +FIG00763518 FIG00763520: hypothetical protein +FIG00763520 FIG00763521: hypothetical protein +FIG00763521 FIG00763526: hypothetical protein +FIG00763526 histidine kinase sensor protein +FIG00763529 putative oligopeptide transport ATP-binding protein +FIG00763530 FIG00763532: hypothetical protein +FIG00763532 FIG00763533: hypothetical protein +FIG00763534 FIG00763535: hypothetical protein +FIG00763535 FIG00763539: hypothetical protein +FIG00763539 FIG00763541: hypothetical protein +FIG00763544 FIG00763545: hypothetical protein +FIG00763546 FIG00763548: hypothetical protein +FIG00763548 FIG00763550: hypothetical protein +FIG00763551 MCE-family protein Mce1B +FIG00763561 FIG00763563: hypothetical protein +FIG00763563 FIG00763565: hypothetical protein +FIG00763565 FIG00763566: hypothetical protein +FIG00763570 FIG00763573: hypothetical protein +FIG00763573 two-component response regulator transcriptional regulator protein +FIG00763581 Daunorubicin resistance ABC transporter, permease protein yadH +FIG00763582 FIG00763583: hypothetical protein +FIG00763583 glycosyl transferase family protein +FIG00763587 FIG00763588: hypothetical protein +FIG00763588 FIG00763591: hypothetical protein +FIG00763591 FIG00763592: hypothetical protein +FIG00763594 FIG00763595: hypothetical protein +FIG00763595 FIG00763596: hypothetical protein +FIG00763596 FIG00763601: hypothetical protein +FIG00763605 FIG00763606: hypothetical protein +FIG00763606 FIG00763608: hypothetical protein +FIG00763608 FIG00763609: hypothetical protein +FIG00763609 FIG00763610: hypothetical protein +FIG00763610 FIG00763615: hypothetical protein +FIG00763615 FIG00763617: hypothetical protein +FIG00763617 FIG00763618: hypothetical protein +FIG00763618 FlgG +FIG00763621 FIG00763622: hypothetical protein +FIG00763622 FIG00763624: hypothetical protein +FIG00763624 oxidoreductase family +FIG00763633 FIG00763636: hypothetical protein +FIG00763636 FIG00763641: hypothetical protein +FIG00763641 Nuclease S1 (EC 3.1.30.1) +FIG00763642 FIG00763644: hypothetical protein +FIG00763644 FIG00763646: hypothetical protein +FIG00763646 FIG00763653: hypothetical protein +FIG00763657 FIG00763661: hypothetical protein +FIG00763661 Predicted DNA repair exonuclease +FIG00763664 FIG00763665: hypothetical protein +FIG00763665 FIG00763666: hypothetical protein +FIG00763666 FIG00763667: hypothetical protein +FIG00763668 FIG00763669: hypothetical protein +FIG00763669 FIG00763670: hypothetical protein +FIG00763670 FIG00763673: hypothetical protein +FIG00763674 FIG00765749: hypothetical protein +FIG00763675 FIG00763676: hypothetical protein +FIG00763676 FIG00763680: hypothetical protein +FIG00763680 FIG00763681: hypothetical protein +FIG00763681 FIG00763682: hypothetical protein +FIG00763682 FIG00763683: hypothetical protein +FIG00763684 FIG00763685: hypothetical protein +FIG00763685 polysaccharide exporter +FIG00763686 FIG00763687: hypothetical protein +FIG00763687 FIG00763695: hypothetical protein +FIG00763695 FIG00763697: hypothetical protein +FIG00763697 3-oxoacyl-[acyl-carrier protein] reductase paralog (EC 1.1.1.100) +FIG00763700 FIG00763701: hypothetical protein +FIG00763701 FIG00763702: hypothetical protein +FIG00763704 FIG00763707: hypothetical protein +FIG00763711 FIG00763715: hypothetical protein +FIG00763715 FIG00763718: hypothetical protein +FIG00763718 FIG00763720: hypothetical protein +FIG00763720 FIG00763721: hypothetical protein +FIG00763721 FIG00763722: hypothetical protein +FIG00763722 NAD(P)-dependent steroid dehydrogenase +FIG00763723 FIG00763724: hypothetical protein +FIG00763724 FIG00762880: hypothetical protein +FIG00763725 FIG00763726: hypothetical protein +FIG00763726 FIG00763728: hypothetical protein +FIG00763728 FIG00763729: hypothetical protein +FIG00763729 glcG protein, putative +FIG00763732 FIG00763733: hypothetical protein +FIG00763734 FIG00763736: hypothetical protein +FIG00763736 FIG00763738: hypothetical protein +FIG00763745 FIG00763746: hypothetical protein +FIG00763746 FIG00763747: hypothetical protein +FIG00763752 FIG00763753: hypothetical protein +FIG00763755 Putative acyl-CoA thioester hydrolase +FIG00763763 FIG00763764: hypothetical protein +FIG00763764 FIG00763765: hypothetical protein +FIG00763765 FIG00763766: hypothetical protein +FIG00763768 fatty acid transport protein +FIG00763772 FIG00763774: hypothetical protein +FIG00763774 D-alanyl-D-alanine carboxypeptidase +FIG00763780 FIG00763781: hypothetical protein +FIG00763781 Ribosomal protein S27e +FIG00763786 FIG00763787: hypothetical protein +FIG00763787 FIG00763788: hypothetical protein +FIG00763788 FIG00763789: hypothetical protein +FIG00763789 FIG00763790: hypothetical protein +FIG00763790 FIG00763791: hypothetical protein +FIG00763791 FIG00763792: hypothetical protein +FIG00763792 Di-haem cytochrome c peroxidase family protein +FIG00763793 FIG00763796: hypothetical protein +FIG00763798 FIG00763800: hypothetical protein +FIG00763804 FIG00763807: hypothetical protein +FIG00763807 hydrogenase subunit +FIG00763810 ankyrin like protein +FIG00763812 FIG00763814: hypothetical protein +FIG00763815 FIG00763817: hypothetical protein +FIG00763817 FIG00763818: hypothetical protein +FIG00763818 FIG00763819: hypothetical protein +FIG00763819 FIG00763821: hypothetical protein +FIG00763821 Probable peptidyl-prolyl cis-trans isomerase A +FIG00763822 FIG00763824: hypothetical protein +FIG00763824 FIG00763827: hypothetical protein +FIG00763829 FIG00763830: hypothetical protein +FIG00763830 FIG00763831: hypothetical protein +FIG00763831 FIG00763832: hypothetical protein +FIG00763834 FIG00763835: hypothetical protein +FIG00763835 hydrogenase-4 component B +FIG00763836 Bifunctional glycosyltransferase/sugar pyrophosphorylase +FIG00763839 FIG00763841: hypothetical protein +FIG00763841 C-5 sterol desaturase +FIG00763850 FIG00763852: hypothetical protein +FIG00763852 FIG00763854: hypothetical protein +FIG00763854 FIG00763856: hypothetical protein +FIG00763856 FIG00763857: hypothetical protein +FIG00763858 FIG00763859: hypothetical protein +FIG00763861 FIG00763864: hypothetical protein +FIG00763864 FIG00763865: hypothetical protein +FIG00763865 FIG00763866: hypothetical protein +FIG00763866 FIG00763867: hypothetical protein +FIG00763867 aerotaxis sensor receptor, flavoprotein +FIG00763873 putative 4-hydroxybenzoate transporter transmembrane protein +FIG00763874 FIG00763875: hypothetical protein +FIG00763875 FIG00763880: hypothetical protein +FIG00763880 FIG00763881: hypothetical protein +FIG00763881 FIG00763883: hypothetical protein +FIG00763885 FIG00763887: hypothetical protein +FIG00763887 FIG00763889: hypothetical protein +FIG00763889 FIG00763891: hypothetical protein +FIG00763891 FIG00763893: hypothetical protein +FIG00763893 FIG00763894: hypothetical protein +FIG00763894 phosphocarrier protein hpr +FIG00763896 ATP-dependent protease-like La +FIG00763899 FIG00763902: hypothetical protein +FIG00763908 ribonuclease BN rbn +FIG00763910 membrane peptidase +FIG00763927 FIG00763928: hypothetical protein +FIG00763928 FIG00763934: hypothetical protein +FIG00763934 FIG00763935: hypothetical protein +FIG00763935 FIG00763936: hypothetical protein +FIG00763937 FIG00763938: hypothetical protein +FIG00763939 GMC oxidoreductase +FIG00763942 FIG00763943: hypothetical protein +FIG00763943 FIG00763944: hypothetical protein +FIG00763945 FIG00763946: hypothetical protein +FIG00763949 FIG00763950: hypothetical protein +FIG00763950 FIG00763955: hypothetical protein +FIG00763957 FIG00763960: hypothetical protein +FIG00763960 FIG00763961: hypothetical protein +FIG00763961 FIG00763964: hypothetical protein +FIG00763964 FIG00763965: hypothetical protein +FIG00763965 FIG00763966: hypothetical protein +FIG00763966 FIG00763969: hypothetical protein +FIG00763969 FIG00763976: hypothetical protein +FIG00763976 glutamine amidotransferase +FIG00763977 FIG00763980: hypothetical protein +FIG00763981 FIG00763985: hypothetical protein +FIG00763985 FIG00763987: hypothetical protein +FIG00763989 FIG00763994: hypothetical protein +FIG00763994 FIG00763995: hypothetical protein +FIG00763995 FIG00763997: hypothetical protein +FIG00763997 FIG00763999: hypothetical protein +FIG00763999 FIG00764000: hypothetical protein +FIG00764000 FIG00764006: hypothetical protein +FIG00764006 FIG00764007: hypothetical protein +FIG00764010 FIG00764011: hypothetical protein +FIG00764011 FIG00764013: hypothetical protein +FIG00764013 FIG00764014: hypothetical protein +FIG00764014 FIG00764016: hypothetical protein +FIG00764016 FIG00764021: hypothetical protein +FIG00764021 Conserved hypothetical lipoprotein +FIG00764022 FIG00764024: hypothetical protein +FIG00764028 FIG00764030: hypothetical protein +FIG00764033 FIG00764035: hypothetical protein +FIG00764036 FIG00764037: hypothetical protein +FIG00764037 serine protease; identified by sequence similarity; putative; ORF located using Blastx/Glimmer +FIG00764045 dolichyl-phosphate-mannose-protein mannosyltransferase-family protein +FIG00764046 FIG00764049: hypothetical protein +FIG00764049 FIG00764051: hypothetical protein +FIG00764053 FIG00764055: hypothetical protein +FIG00764057 FIG00764058: hypothetical protein +FIG00764058 FIG00764062: hypothetical protein +FIG00764062 FIG00764065: hypothetical protein +FIG00764065 histone deacetylase +FIG00764067 sigma factor regulatory protein +FIG00764070 FIG00764075: hypothetical protein +FIG00764075 FIG00764076: hypothetical protein +FIG00764077 FIG00764083: hypothetical protein +FIG00764083 FIG00764087: hypothetical protein +FIG00764087 FIG00764088: hypothetical protein +FIG00764091 FIG00764092: hypothetical protein +FIG00764092 FIG00764094: hypothetical protein +FIG00764094 FIG00764095: hypothetical protein +FIG00764095 FIG00764096: hypothetical protein +FIG00764096 FIG00764098: hypothetical protein +FIG00764098 FIG00764100: hypothetical protein +FIG00764106 FIG00764108: hypothetical protein +FIG00764108 FIG00764110: hypothetical protein +FIG00764110 FIG00764114: hypothetical protein +FIG00764116 FIG00764117: hypothetical protein +FIG00764117 FIG00764118: hypothetical protein +FIG00764118 FIG00764122: hypothetical protein +FIG00764124 FIG00764127: hypothetical protein +FIG00764130 FIG00764135: hypothetical protein +FIG00764135 FIG00764138: hypothetical protein +FIG00764139 FIG00764143: hypothetical protein +FIG00764143 FIG00764144: hypothetical protein +FIG00764146 FIG00764147: hypothetical protein +FIG00764147 FIG00764150: hypothetical protein +FIG00764156 heavy metal efflux pump +FIG00764158 FIG00764162: hypothetical protein +FIG00764162 FIG00764165: hypothetical protein +FIG00764165 FIG00764168: hypothetical protein +FIG00764170 FIG00764171: hypothetical protein +FIG00764179 dipeptide/oligopeptide/nickel transport systems, permease components +FIG00764183 FIG00766616: hypothetical protein +FIG00764185 FIG00764186: hypothetical protein +FIG00764186 FIG00764188: hypothetical protein +FIG00764195 FIG00764196: hypothetical protein +FIG00764196 integrin homolog +FIG00764200 hypothetical protein +FIG00764202 FIG00764203: hypothetical protein +FIG00764203 FIG00767760: hypothetical protein +FIG00764204 ACT family protein +FIG00764205 drug:Na+ antiporter of the multi antimicrobial extrusion family +FIG00764210 FIG00764211: hypothetical protein +FIG00764211 FIG00764212: hypothetical protein +FIG00764212 FIG00764213: hypothetical protein +FIG00764213 FIG00764216: hypothetical protein +FIG00764221 FIG00764222: hypothetical protein +FIG00764222 FIG00764224: hypothetical protein +FIG00764224 outer membrane protein, porin superfamily +FIG00764227 FIG00764229: hypothetical protein +FIG00764229 FIG00764230: hypothetical protein +FIG00764238 FIG00764239: hypothetical protein +FIG00764239 FIG00764240: hypothetical protein +FIG00764241 FIG00764243: hypothetical protein +FIG00764243 FIG00764244: hypothetical protein +FIG00764244 FIG00764251: hypothetical protein +FIG00764251 FIG00764252: hypothetical protein +FIG00764252 FIG00764253: hypothetical protein +FIG00764253 FIG00764255: hypothetical protein +FIG00764255 3-demethylubiquinone-9 3-methyltransferase-like protein +FIG00764261 FIG00764263: hypothetical protein +FIG00764263 putative haloacid dehalogenase-like hydrolase +FIG00764264 FIG00764267: hypothetical protein +FIG00764267 FIG00764270: hypothetical protein +FIG00764270 Flagellar biosynthesis protein FliR / Flagellar biosynthesis protein FlhB +FIG00764272 FIG00764274: hypothetical protein +FIG00764274 FIG00764277: hypothetical protein +FIG00764277 FIG00764278: hypothetical protein +FIG00764278 FIG00764279: hypothetical protein +FIG00764279 Cytochrome c biogenesis factor +FIG00764281 FIG056361: hypothetical protein implicated in coenzyme B12 biosynthesis +FIG00764283 FIG00764284: hypothetical protein +FIG00764284 FIG00764285: hypothetical protein +FIG00764285 FIG00764291: hypothetical protein +FIG00764291 FIG00764304: hypothetical protein +FIG00764304 Type III leader peptidase family protein +FIG00764313 ChoD +FIG00764314 FIG00764315: hypothetical protein +FIG00764315 FIG00764316: hypothetical protein +FIG00764316 FIG00767675: hypothetical protein +FIG00764317 FIG00764323: hypothetical protein +FIG00764323 FIG00764326: hypothetical protein +FIG00764326 transcriptional coactivator +FIG00764327 dihydrofolate reductase +FIG00764335 FIG00764336: hypothetical protein +FIG00764336 sigma 54 activator +FIG00764339 FIG00764341: hypothetical protein +FIG00764341 PBS lyase HEAT-like repeat containing protein +FIG00764343 FIG00764345: hypothetical protein +FIG00764345 FIG00764354: hypothetical protein +FIG00764357 FIG00764359: hypothetical protein +FIG00764367 penicillin G acylase precursor +FIG00764371 FIG00764373: hypothetical protein +FIG00764373 FIG00764374: hypothetical protein +FIG00764374 FIG00764381: hypothetical protein +FIG00764381 FIG00764383: hypothetical protein +FIG00764383 FIG00764384: hypothetical protein +FIG00764384 divalent anion Na+ symporter +FIG00764388 FIG00764389: hypothetical protein +FIG00764389 FIG00764391: hypothetical protein +FIG00764391 FIG00764393: hypothetical protein +FIG00764393 FIG00764394: hypothetical protein +FIG00764394 FIG00764397: hypothetical protein +FIG00764398 FIG00764399: hypothetical protein +FIG00764399 Bacteriophage protein gp37 +FIG00764415 FIG00764417: hypothetical protein +FIG00764417 FIG00764418: hypothetical protein +FIG00764418 FIG00764419: hypothetical protein +FIG00764425 FIG00764431: hypothetical protein +FIG00764432 FIG00764435: hypothetical protein +FIG00764435 FIG00764438: hypothetical protein +FIG00764438 FIG00764439: hypothetical protein +FIG00764439 FIG00764441: hypothetical protein +FIG00764441 FIG00764443: hypothetical protein +FIG00764445 FIG00764446: hypothetical protein +FIG00764447 FIG00764452: hypothetical protein +FIG00764452 FIG00764456: hypothetical protein +FIG00764460 probable anti-sigma factor antagonist +FIG00764461 FIG00764462: hypothetical protein +FIG00764466 FIG00764470: hypothetical protein +FIG00764470 FIG00764471: hypothetical protein +FIG00764474 FIG00764482: hypothetical protein +FIG00764482 FIG00764483: hypothetical protein +FIG00764483 FIG00764484: hypothetical protein +FIG00764486 probable CDP-alcohol phosphatidyltransferase +FIG00764488 TPR repeat containing protein +FIG00764490 FIG00764496: hypothetical protein +FIG00764496 peptide methionine sulfoxide reductase 2 +FIG00764499 FIG00764506: hypothetical protein +FIG00764510 FIG00764511: hypothetical protein +FIG00764511 FIG00764513: hypothetical protein +FIG00764513 sugar transferase +FIG00764514 FIG00764515: hypothetical protein +FIG00764515 FIG00764516: hypothetical protein +FIG00764519 FIG00764522: hypothetical protein +FIG00764522 FIG00764523: hypothetical protein +FIG00764523 FIG00764525: hypothetical protein +FIG00764529 FIG00764530: hypothetical protein +FIG00764530 FIG00764531: hypothetical protein +FIG00764531 DNA binding protein +FIG00764532 FIG00764534: hypothetical protein +FIG00764536 FIG00764539: hypothetical protein +FIG00764546 FIG00764548: hypothetical protein +FIG00764548 FIG00764549: hypothetical protein +FIG00764550 FIG00764556: hypothetical protein +FIG00764556 hypothetical protein +FIG00764564 hydrolase +FIG00764570 FIG00764571: hypothetical protein +FIG00764573 FIG00764575: hypothetical protein +FIG00764575 lipopolysaccharide biosynthesis glycosyltransferase +FIG00764577 FIG00764580: hypothetical protein +FIG00764584 FIG00764585: hypothetical protein +FIG00764585 FIG00764586: hypothetical protein +FIG00764586 FIG057251: Fe-S oxidoreductase +FIG00764592 FIG00764593: hypothetical protein +FIG00764593 FIG00764594: hypothetical protein +FIG00764594 FIG00764595: hypothetical protein +FIG00764597 probable phosphoesterase +FIG00764598 FIG00764599: hypothetical protein +FIG00764602 hypothetical protein +FIG00764603 Translation elongation and release factor +FIG00764609 FIG00764611: hypothetical protein +FIG00764611 FIG00764613: hypothetical protein +FIG00764613 FIG00764616: hypothetical protein +FIG00764616 putative acidic periplasmic protein +FIG00764618 FIG00764619: hypothetical protein +FIG00764620 Strictosidine synthase precursor +FIG00764623 putative flavin-containing monooxygenase +FIG00764624 FIG00764625: hypothetical protein +FIG00764628 FIG00764630: hypothetical protein +FIG00764640 FIG00764641: hypothetical protein +FIG00764641 FIG00764642: hypothetical protein +FIG00764642 Putative Na(+)/H(+) exchanger +FIG00764651 FIG00764653: hypothetical protein +FIG00764653 FIG00764655: hypothetical protein +FIG00764655 FIG00764656: hypothetical protein +FIG00764656 FIG00764657: hypothetical protein +FIG00764657 FIG00764658: hypothetical protein +FIG00764667 FIG00764668: hypothetical protein +FIG00764668 FIG00764669: hypothetical protein +FIG00764669 FIG00764671: hypothetical protein +FIG00764671 FIG00764673: hypothetical protein +FIG00764673 FIG00764675: hypothetical protein +FIG00764675 probable Zinc-binding dehydrogenases +FIG00764676 FIG00764677: hypothetical protein +FIG00764677 FIG00764678: hypothetical protein +FIG00764678 FIG00764679: hypothetical protein +FIG00764686 FIG00764688: hypothetical protein +FIG00764696 FIG00764702: hypothetical protein +FIG00764706 FIG00764708: hypothetical protein +FIG00764711 outer membrane protein OmpA family +FIG00764712 FIG00764713: hypothetical protein +FIG00764713 FIG00764714: hypothetical protein +FIG00764717 FIG00764718: hypothetical protein +FIG00764718 FIG00764720: hypothetical protein +FIG00764720 FIG00764721: hypothetical protein +FIG00764722 unknown protein +FIG00764724 Nitrogen regulatory IIA protein +FIG00764729 Glucose inhibited division protein gidB +FIG00764734 FIG00764735: hypothetical protein +FIG00764735 FIG00764739: hypothetical protein +FIG00764739 FIG00764740: hypothetical protein +FIG00764744 alpha-methylacyl-CoA racemase +FIG00764745 FIG00764746: hypothetical protein +FIG00764747 FIG00764748: hypothetical protein +FIG00764748 Hsa protein +FIG00764755 FIG00764758: hypothetical protein +FIG00764758 FIG00764759: hypothetical protein +FIG00764759 FIG00764760: hypothetical protein +FIG00764765 membrane associated metalloendopeptidase +FIG00764766 FIG00764768: hypothetical protein +FIG00764772 FIG00764773: hypothetical protein +FIG00764773 Rhodanese domain protein / Ankyrin +FIG00764775 FIG00764777: hypothetical protein +FIG00764777 FIG00764788: hypothetical protein +FIG00764788 FIG00764789: hypothetical protein +FIG00764790 Nucleotidyltransferase associated with HEPN-containing protein +FIG00764791 Peptidase family M48 +FIG00764794 FIG00764795: hypothetical protein +FIG00764801 FIG00764802: hypothetical protein +FIG00764803 FIG00764806: hypothetical protein +FIG00764807 FIG00764809: hypothetical protein +FIG00764809 FIG00764812: hypothetical protein +FIG00764812 FIG00764813: hypothetical protein +FIG00764813 FIG00764814: hypothetical protein +FIG00764814 FIG00764815: hypothetical protein +FIG00764816 FIG00764822: hypothetical protein +FIG00764823 FIG00764826: hypothetical protein +FIG00764826 FIG00764827: hypothetical protein +FIG00764829 FIG00764834: hypothetical protein +FIG00764841 FIG00764843: hypothetical protein +FIG00764844 FIG00764845: hypothetical protein +FIG00764845 cytochrome c-type biogenesis precursor +FIG00764847 FIG00764848: hypothetical protein +FIG00764848 FIG00764850: hypothetical protein +FIG00764850 FIG00764851: hypothetical protein +FIG00764851 FIG00764853: hypothetical protein +FIG00764853 FIG00764854: hypothetical protein +FIG00764857 putative phospholipid synthase +FIG00764861 FIG00764862: hypothetical protein +FIG00764862 phage DNA-binding-like protein (gam) +FIG00764873 FIG00764876: hypothetical protein +FIG00764876 FIG00764877: hypothetical protein +FIG00764878 FIG00764880: hypothetical protein +FIG00764880 FIG00764882: hypothetical protein +FIG00764883 FIG00764886: hypothetical protein +FIG00764886 FIG00764891: hypothetical protein +FIG00764891 FIG00764894: hypothetical protein +FIG00764898 FIG00764899: hypothetical protein +FIG00764900 FIG00764901: hypothetical protein +FIG00764901 FIG00764905: hypothetical protein +FIG00764905 probable carbon-nitrogen hydrolase +FIG00764911 FIG00764912: hypothetical protein +FIG00764912 FIG00764913: hypothetical protein +FIG00764913 FIG00764916: hypothetical protein +FIG00764917 FIG00764918: hypothetical protein +FIG00764918 FIG00764922: hypothetical protein +FIG00764922 FIG00764925: hypothetical protein +FIG00764925 FIG00764930: hypothetical protein +FIG00764930 FIG00764934: hypothetical protein +FIG00764934 FIG00764936: hypothetical protein +FIG00764936 FIG00764942: hypothetical protein +FIG00764945 FIG00764947: hypothetical protein +FIG00764950 spore coat polysaccharide biosynthesis protein spsF-like protein +FIG00764953 FIG00764957: hypothetical protein +FIG00764957 FIG00764958: hypothetical protein +FIG00764958 FIG00764959: hypothetical protein +FIG00764961 FIG00764963: hypothetical protein +FIG00764963 FIG00764965: hypothetical protein +FIG00764965 FIG00764966: hypothetical protein +FIG00764971 FIG00764974: hypothetical protein +FIG00764976 FIG00764977: hypothetical protein +FIG00764980 FIG00764982: hypothetical protein +FIG00764985 Pyridine nucleotide-disulphide oxidoreductase +FIG00764990 FIG00764991: hypothetical protein +FIG00765004 FIG00765005: hypothetical protein +FIG00765005 FIG00765006: hypothetical protein +FIG00765007 FIG00765008: hypothetical protein +FIG00765009 FIG00765012: hypothetical protein +FIG00765012 FIG00765015: hypothetical protein +FIG00765017 methyl-accepting chemotaxis transducer transmembrane protein +FIG00765020 anti-sigma F factor antagonist, putative +FIG00765024 FIG00765026: hypothetical protein +FIG00765027 FIG00765028: hypothetical protein +FIG00765028 FIG00765029: hypothetical protein +FIG00765029 FIG00765034: hypothetical protein +FIG00765034 putative O-methyl transferase +FIG00765041 FIG00765043: hypothetical protein +FIG00765044 FIG00765046: hypothetical protein +FIG00765046 FIG00765047: hypothetical protein +FIG00765047 FIG00765050: hypothetical protein +FIG00765050 FIG00765051: hypothetical protein +FIG00765051 FIG00765054: hypothetical protein +FIG00765054 FIG00765058: hypothetical protein +FIG00765058 FIG00765060: hypothetical protein +FIG00765060 FIG00765061: hypothetical protein +FIG00765063 FIG00765065: hypothetical protein +FIG00765065 FIG00765066: hypothetical protein +FIG00765069 FIG00765076: hypothetical protein +FIG00765079 Putative UDP-glucose 4-epimerase +FIG00765082 FIG00765087: hypothetical protein +FIG00765087 FIG00765089: hypothetical protein +FIG00765090 Hydrolase of unknown specificity RsbQ, part of a novel [RsbQ - PAS domain] bacterial sensing module +FIG00765093 FIG00765094: hypothetical protein +FIG00765094 peptidyl-prolyl cis-trans isomerase +FIG00765096 beta-ketoacyl synthase +FIG00765099 FIG00765101: hypothetical protein +FIG00765101 FIG00765104: hypothetical protein +FIG00765104 FIG00765105: hypothetical protein +FIG00765109 FIG00765110: hypothetical protein +FIG00765110 FIG00765112: hypothetical protein +FIG00765112 FIG00765113: hypothetical protein +FIG00765113 FIG00765118: hypothetical protein +FIG00765118 FIG00765120: hypothetical protein +FIG00765121 FIG00765124: hypothetical protein +FIG00765129 FIG00765133: hypothetical protein +FIG00765133 FIG00765134: hypothetical protein +FIG00765134 FIG00765139: hypothetical protein +FIG00765139 hypothetical protein +FIG00765143 FIG00765146: hypothetical protein +FIG00765146 FIG00765147: hypothetical protein +FIG00765148 FIG00765152: hypothetical protein +FIG00765152 FIG00765156: hypothetical protein +FIG00765156 FIG00765157: hypothetical protein +FIG00765157 FIG00765162: hypothetical protein +FIG00765162 FIG00765164: hypothetical protein +FIG00765167 hypothetical protein +FIG00765171 sodium:alanine symporter family/phosphatidylserine decarboxylase +FIG00765174 FIG00765178: hypothetical protein +FIG00765178 FIG00765179: hypothetical protein +FIG00765179 FIG00765181: hypothetical protein +FIG00765182 FIG00765184: hypothetical protein +FIG00765184 FIG00765185: hypothetical protein +FIG00765185 FIG00765187: hypothetical protein +FIG00765187 ParB family protein +FIG00765195 FIG00765196: hypothetical protein +FIG00765196 FIG00765200: hypothetical protein +FIG00765200 FIG00765201: hypothetical protein +FIG00765205 FIG00765208: hypothetical protein +FIG00765208 FIG00765209: hypothetical protein +FIG00765213 FIG00765214: hypothetical protein +FIG00765228 FIG00765232: hypothetical protein +FIG00765233 FIG00765235: hypothetical protein +FIG00765235 FIG00765238: hypothetical protein +FIG00765238 FIG00765239: hypothetical protein +FIG00765241 FIG00765243: hypothetical protein +FIG00765245 FIG00765246: hypothetical protein +FIG00765246 FIG00765248: hypothetical protein +FIG00765255 FIG00765256: hypothetical protein +FIG00765262 CAAX protease +FIG00765263 ExbD/TolR biopolymer transport protein +FIG00765265 FIG00765278: hypothetical protein +FIG00765278 FIG00765280: hypothetical protein +FIG00765280 FIG00765284: hypothetical protein +FIG00765284 FIG00765286: hypothetical protein +FIG00765286 FIG00765289: hypothetical protein +FIG00765290 putative bacterioferritin-associated ferredoxin protein +FIG00765292 FIG00765298: hypothetical protein +FIG00765310 FIG00765311: hypothetical protein +FIG00765317 FIG00765318: hypothetical protein +FIG00765323 FIG00765325: hypothetical protein +FIG00765329 styrene monooxygenase component 1-like protein +FIG00765333 FIG00765334: hypothetical protein +FIG00765334 FIG00765336: hypothetical protein +FIG00765336 FIG00765337: hypothetical protein +FIG00765337 FIG00765338: hypothetical protein +FIG00765338 FIG00765340: hypothetical protein +FIG00765340 FIG00765342: hypothetical protein +FIG00765342 FIG00765343: hypothetical protein +FIG00765343 FIG00765344: hypothetical protein +FIG00765344 FIG00765348: hypothetical protein +FIG00765348 FIG00765350: hypothetical protein +FIG00765352 FIG00765353: hypothetical protein +FIG00765353 GAF domain protein +FIG00765359 FIG00765360: hypothetical protein +FIG00765360 FIG00765362: hypothetical protein +FIG00765362 FIG00765364: hypothetical protein +FIG00765364 FIG00765366: hypothetical protein +FIG00765366 phosphoserine phosphatase +FIG00765367 FIG00765369: hypothetical protein +FIG00765369 FIG00765370: hypothetical protein +FIG00765370 FIG00765371: hypothetical protein +FIG00765371 FIG00765372: hypothetical protein +FIG00765372 FIG00765374: hypothetical protein +FIG00765374 FIG00765378: hypothetical protein +FIG00765380 FIG00765381: hypothetical protein +FIG00765382 FIG00765384: hypothetical protein +FIG00765384 FIG00765385: hypothetical protein +FIG00765385 putative ABC transporter, ATP-binding protein +FIG00765389 FIG00765397: hypothetical protein +FIG00765401 FIG00765405: hypothetical protein +FIG00765409 FIG00765410: hypothetical protein +FIG00765410 FIG00765411: hypothetical protein +FIG00765412 Ankyrin repeat proteins +FIG00765414 FIG00765416: hypothetical protein +FIG00765416 FIG00765417: hypothetical protein +FIG00765417 FIG00765419: hypothetical protein +FIG00765425 FIG00765430: hypothetical protein +FIG00765430 FIG00765431: hypothetical protein +FIG00765432 FIG00765437: hypothetical protein +FIG00765437 FIG00765438: hypothetical protein +FIG00765443 cystine-binding periplasmic protein precursor +FIG00765445 FIG00765447: hypothetical protein +FIG00765449 FIG00765453: hypothetical protein +FIG00765453 FIG00765457: hypothetical protein +FIG00765458 FIG00765460: hypothetical protein +FIG00765461 FIG00765462: hypothetical protein +FIG00765462 FIG00765463: hypothetical protein +FIG00765463 FIG00765464: hypothetical protein +FIG00765464 cytochrome c-type biogenesis protein +FIG00765467 FIG00765471: hypothetical protein +FIG00765471 FIG00765472: hypothetical protein +FIG00765472 oligo-1,6-glucosidase +FIG00765479 FIG00765480: hypothetical protein +FIG00765480 FIG00765482: hypothetical protein +FIG00765482 FIG00765486: hypothetical protein +FIG00765486 putative hydroxyacid aldolase protein +FIG00765488 FIG00765491: hypothetical protein +FIG00765491 FIG00765493: hypothetical protein +FIG00765493 FIG00765497: hypothetical protein +FIG00765497 FIG00765499: hypothetical protein +FIG00765506 FIG00765507: hypothetical protein +FIG00765507 putative acyltransferase +FIG00765508 transcriptional regulator, copG family +FIG00765514 outer membrane lipoprotein lipL41 +FIG00765518 FIG00765519: hypothetical protein +FIG00765521 FIG00765523: hypothetical protein +FIG00765523 FIG00765529: hypothetical protein +FIG00765529 FIG00765531: hypothetical protein +FIG00765533 COG1872 +FIG00765534 FIG00765535: hypothetical protein +FIG00765535 FIG00765537: hypothetical protein +FIG00765537 polysaccharide biosynthesis export protein +FIG00765540 FIG00765541: hypothetical protein +FIG00765541 FIG00765543: hypothetical protein +FIG00765544 FIG00765545: hypothetical protein +FIG00765547 COG0385 sodium-dependent transporter +FIG00765550 FIG00765551: hypothetical protein +FIG00765551 FIG00765552: hypothetical protein +FIG00765552 FIG00765558: hypothetical protein +FIG00765558 FIG00765560: hypothetical protein +FIG00765560 class I heat shock protein (HSP20) +FIG00765565 FIG00765567: hypothetical protein +FIG00765568 FIG00765569: hypothetical protein +FIG00765578 hypothetical zinc protease +FIG00765583 outer membrane protein OmpA +FIG00765585 FIG00765591: hypothetical protein +FIG00765592 FIG00765597: hypothetical protein +FIG00765597 flagellar filament sheath protein +FIG00765599 FIG00765604: hypothetical protein +FIG00765606 FIG00765608: hypothetical protein +FIG00765612 FIG00765617: hypothetical protein +FIG00765622 FIG00765623: hypothetical protein +FIG00765623 FIG00765625: hypothetical protein +FIG00765629 FIG00765630: hypothetical protein +FIG00765630 FIG00765631: hypothetical protein +FIG00765631 FIG00765632: hypothetical protein +FIG00765633 FIG00765634: hypothetical protein +FIG00765634 FIG00765635: hypothetical protein +FIG00765635 FIG00765644: hypothetical protein +FIG00765647 FIG00765648: hypothetical protein +FIG00765648 FIG00765651: hypothetical protein +FIG00765651 FIG00765652: hypothetical protein +FIG00765657 FIG00765660: hypothetical protein +FIG00765660 FIG00765663: hypothetical protein +FIG00765663 FIG00765666: hypothetical protein +FIG00765666 FIG00765667: hypothetical protein +FIG00765670 FIG00765673: hypothetical protein +FIG00765673 HtrA1-like protein +FIG00765678 pseudouridylate synthase, 23S RNA-specific +FIG00765679 FIG00765681: hypothetical protein +FIG00765681 FIG00765685: hypothetical protein +FIG00765685 FIG00765688: hypothetical protein +FIG00765688 FIG00765694: hypothetical protein +FIG00765694 FIG00765700: hypothetical protein +FIG00765710 FIG00765713: hypothetical protein +FIG00765713 Hydrogenase-4 component F +FIG00765716 FIG00765722: hypothetical protein +FIG00765722 FIG00765732: hypothetical protein +FIG00765732 Fimh-like protein +FIG00765736 FIG00765737: hypothetical protein +FIG00765739 FIG00765741: hypothetical protein +FIG00765741 FIG00765742: hypothetical protein +FIG00765742 FIG00765743: hypothetical protein +FIG00765743 FIG00765745: hypothetical protein +FIG00765747 FIG00765748: hypothetical protein +FIG00765751 FIG00765753: hypothetical protein +FIG00765754 FIG00765755: hypothetical protein +FIG00765755 FIG00765757: hypothetical protein +FIG00765757 FIG00765759: hypothetical protein +FIG00765759 FIG00765760: hypothetical protein +FIG00765760 FIG00765762: hypothetical protein +FIG00765762 FIG00765767: hypothetical protein +FIG00765779 FIG00765780: hypothetical protein +FIG00765780 FIG00765781: hypothetical protein +FIG00765783 FIG00765784: hypothetical protein +FIG00765787 FIG00765789: hypothetical protein +FIG00765789 FIG00765795: hypothetical protein +FIG00765797 FIG00765800: hypothetical protein +FIG00765804 FIG00765806: hypothetical protein +FIG00765806 FIG00765809: hypothetical protein +FIG00765809 FIG00765816: hypothetical protein +FIG00765816 FIG00765817: hypothetical protein +FIG00765819 FIG00765821: hypothetical protein +FIG00765825 FIG00765826: hypothetical protein +FIG00765826 FIG00765827: hypothetical protein +FIG00765827 FIG00765828: hypothetical protein +FIG00765828 FIG00765832: hypothetical protein +FIG00765832 FIG00765836: hypothetical protein +FIG00765838 FIG00765839: hypothetical protein +FIG00765843 FIG00765844: hypothetical protein +FIG00765844 FIG00765848: hypothetical protein +FIG00765848 FIG00765855: hypothetical protein +FIG00765855 FIG00765856: hypothetical protein +FIG00765857 FIG00769731: hypothetical protein +FIG00765867 FIG00765872: hypothetical protein +FIG00765872 FIG00765873: hypothetical protein +FIG00765878 FIG00763732: hypothetical protein +FIG00765879 FIG00765880: hypothetical protein +FIG00765880 FIG00765881: hypothetical protein +FIG00765881 FIG00765970: hypothetical protein +FIG00765884 FIG00765885: hypothetical protein +FIG00765886 FIG00765890: hypothetical protein +FIG00765892 FIG00765893: hypothetical protein +FIG00765893 FIG00765895: hypothetical protein +FIG00765901 FIG00765902: hypothetical protein +FIG00765906 FIG00765908: hypothetical protein +FIG00765908 FIG00765909: hypothetical protein +FIG00765912 FIG00765913: hypothetical protein +FIG00765913 FIG00765919: hypothetical protein +FIG00765919 FIG00765921: hypothetical protein +FIG00765921 FIG00765923: hypothetical protein +FIG00765926 FIG00765928: hypothetical protein +FIG00765928 FIG00765929: hypothetical protein +FIG00765929 FIG00765930: hypothetical protein +FIG00765936 FIG00765937: hypothetical protein +FIG00765937 FIG00765944: hypothetical protein +FIG00765944 FIG00765945: hypothetical protein +FIG00765945 FIG00765948: hypothetical protein +FIG00765948 FIG00765949: hypothetical protein +FIG00765949 FIG00765951: hypothetical protein +FIG00765952 FIG00765954: hypothetical protein +FIG00765954 FIG00765955: hypothetical protein +FIG00765955 FIG00765958: hypothetical protein +FIG00765958 cation:proton antiporter +FIG00765959 FIG00765963: hypothetical protein +FIG00765970 acriflavin resistance +FIG00765974 FIG00765975: hypothetical protein +FIG00765975 FIG00765976: hypothetical protein +FIG00765976 FIG00765977: hypothetical protein +FIG00765981 FIG00765982: hypothetical protein +FIG00765985 FIG00765989: hypothetical protein +FIG00765989 Lyzozyme M1 (1,4-beta-N-acetylmuramidase) (EC 3.2.1.17) +FIG00765992 FIG00765994: hypothetical protein +FIG00765995 FIG00765997: hypothetical protein +FIG00765997 FIG00765998: hypothetical protein +FIG00766000 FIG00766001: hypothetical protein +FIG00766001 FIG00766005: hypothetical protein +FIG00766005 FIG00766008: hypothetical protein +FIG00766011 FIG00766013: hypothetical protein +FIG00766013 membrane-bound lytic murein transglycosylase A precursor +FIG00766023 FIG00766024: hypothetical protein +FIG00766029 FIG00766030: hypothetical protein +FIG00766031 FIG00766034: hypothetical protein +FIG00766035 FIG00766036: hypothetical protein +FIG00766036 FIG00766037: hypothetical protein +FIG00766037 sterol biosynthesis methyltransferase related protein-like protein +FIG00766038 FIG00766039: hypothetical protein +FIG00766040 FIG00766042: hypothetical protein +FIG00766042 FIG00766043: hypothetical protein +FIG00766043 Na(+) dependent transporter,Sodium Bile acid symporter family +FIG00766045 FIG00766049: hypothetical protein +FIG00766054 FIG00766056: hypothetical protein +FIG00766070 FIG00766075: hypothetical protein +FIG00766075 FIG00766077: hypothetical protein +FIG00766077 FIG00766081: hypothetical protein +FIG00766081 FIG00766084: hypothetical protein +FIG00766084 FIG00766085: hypothetical protein +FIG00766085 FIG00766089: hypothetical protein +FIG00766089 FIG00766091: hypothetical protein +FIG00766093 FIG00766094: hypothetical protein +FIG00766097 FIG00766100: hypothetical protein +FIG00766100 FIG00766103: hypothetical protein +FIG00766103 FIG00766107: hypothetical protein +FIG00766115 FIG00766116: hypothetical protein +FIG00766120 FIG00766122: hypothetical protein +FIG00766122 FIG00766127: hypothetical protein +FIG00766128 FIG00766129: hypothetical protein +FIG00766129 FIG00766136: hypothetical protein +FIG00766136 FIG00766137: hypothetical protein +FIG00766145 intercellular adhesion protein C +FIG00766150 FIG00766152: hypothetical protein +FIG00766152 Signal transduction protein +FIG00766154 FIG00766155: hypothetical protein +FIG00766158 histidine kinase response regulator hybrid protein +FIG00766163 FIG00766165: hypothetical protein +FIG00766165 FIG00766167: hypothetical protein +FIG00766174 FIG00766178: hypothetical protein +FIG00766180 probable ferredoxin +FIG00766183 FIG00766189: hypothetical protein +FIG00766189 FIG00766193: hypothetical protein +FIG00766193 FIG00766194: hypothetical protein +FIG00766196 FIG00766205: hypothetical protein +FIG00766213 FIG00766217: hypothetical protein +FIG00766217 identified by sequence similarity; putative; ORF located using Blastx/Glimmer +FIG00766219 nonspecific acid phosphatase precursor +FIG00766220 carboxypeptidase T +FIG00766221 Zn-ribbon-containing, possibly RNA-binding protein and truncated derivatives +FIG00766223 FIG00766224: hypothetical protein +FIG00766226 FIG00766228: hypothetical protein +FIG00766235 phage-related-like protein +FIG00766240 FIG00766241: hypothetical protein +FIG00766241 FIG00766252: hypothetical protein +FIG00766253 FIG00766254: hypothetical protein +FIG00766254 FIG00766255: hypothetical protein +FIG00766256 FIG00766257: hypothetical protein +FIG00766257 FIG00766258: hypothetical protein +FIG00766263 FIG00769263: hypothetical protein +FIG00766264 FIG00766268: hypothetical protein +FIG00766268 FIG00766269: hypothetical protein +FIG00766272 FIG00766276: hypothetical protein +FIG00766276 FIG00766284: hypothetical protein +FIG00766284 integral membrane rhomboid family serine protease MJ0610.1 +FIG00766295 FIG00766296: hypothetical protein +FIG00766296 FIG00766297: hypothetical protein +FIG00766297 FIG00766298: hypothetical protein +FIG00766301 FIG00769677: hypothetical protein +FIG00766302 FIG00766304: hypothetical protein +FIG00766308 FIG00766314: hypothetical protein +FIG00766314 FIG00766320: hypothetical protein +FIG00766323 FIG00766326: hypothetical protein +FIG00766326 FIG00766327: hypothetical protein +FIG00766330 FIG00766331: hypothetical protein +FIG00766331 FIG00766334: hypothetical protein +FIG00766334 FIG00766338: hypothetical protein +FIG00766338 FIG00766343: hypothetical protein +FIG00766343 heme exporter protein B +FIG00766350 FIG00766356: hypothetical protein +FIG00766356 FIG00766357: hypothetical protein +FIG00766357 FIG00766359: hypothetical protein +FIG00766359 FIG00766363: hypothetical protein +FIG00766363 possible transmembrane-transport protein +FIG00766371 FIG00766377: hypothetical protein +FIG00766385 FIG00766387: hypothetical protein +FIG00766387 FIG00766388: hypothetical protein +FIG00766393 FIG00766397: hypothetical protein +FIG00766397 anti-sigma factor antagonist +FIG00766398 FIG00766401: hypothetical protein +FIG00766401 FIG00766403: hypothetical protein +FIG00766403 FIG00766407: hypothetical protein +FIG00766407 flavin-containing monooxygenase +FIG00766408 FIG00766409: hypothetical protein +FIG00766409 FIG00766410: hypothetical protein +FIG00766410 FIG00766414: hypothetical protein +FIG00766417 FIG00766419: hypothetical protein +FIG00766419 Sodium:neurotransmitter symporter family +FIG00766425 sugar-phosphate nucleotidyl transferase +FIG00766438 FIG00766442: hypothetical protein +FIG00766442 FIG00766446: hypothetical protein +FIG00766446 FIG00766447: hypothetical protein +FIG00766447 FIG00766448: hypothetical protein +FIG00766448 FIG00766449: hypothetical protein +FIG00766458 FIG00766459: hypothetical protein +FIG00766459 FIG00766461: hypothetical protein +FIG00766461 FIG00766465: hypothetical protein +FIG00766465 FIG00766466: hypothetical protein +FIG00766466 flagellar biosynthetic transmembrane protein +FIG00766469 FIG00766474: hypothetical protein +FIG00766474 FIG00766477: hypothetical protein +FIG00766477 FIG00766481: hypothetical protein +FIG00766484 FIG00766486: hypothetical protein +FIG00766496 FIG00766510: hypothetical protein +FIG00766517 FIG00766520: hypothetical protein +FIG00766521 Cobalt-zinc-cadmium resistance protein CZCA +FIG00766529 FIG00766533: hypothetical protein +FIG00766533 FIG00766535: hypothetical protein +FIG00766535 FIG00766537: hypothetical protein +FIG00766542 FIG00766543: hypothetical protein +FIG00766543 FIG00766546: hypothetical protein +FIG00766553 FIG00766556: hypothetical protein +FIG00766556 FIG00766557: hypothetical protein +FIG00766558 FIG00766562: hypothetical protein +FIG00766564 FIG00766566: hypothetical protein +FIG00766568 FIG00766578: hypothetical protein +FIG00766578 FIG00766579: hypothetical protein +FIG00766579 FIG00766582: hypothetical protein +FIG00766587 FIG00766588: hypothetical protein +FIG00766588 FIG00766604: hypothetical protein +FIG00766604 FIG00766608: hypothetical protein +FIG00766608 FIG00766610: hypothetical protein +FIG00766610 FIG00766611: hypothetical protein +FIG00766613 FIG00766614: hypothetical protein +FIG00766616 FIG00766619: hypothetical protein +FIG00766619 FIG00766621: hypothetical protein +FIG00766626 Putative signal peptide peptidase sppA +FIG00766630 FIG00766631: hypothetical protein +FIG00766631 FIG00766633: hypothetical protein +FIG00766633 molybdate metabolism regulator +FIG00766636 Predicted hydrolases or acyltransferases, alpha/beta hydrolase superfamily +FIG00766639 FIG00766643: hypothetical protein +FIG00766643 FIG00766644: hypothetical protein +FIG00766644 FIG00766645: hypothetical protein +FIG00766645 FIG00766658: hypothetical protein +FIG00766659 small conductance mechanosensitive ion channel +FIG00766660 FIG00766665: hypothetical protein +FIG00766665 FIG00766666: hypothetical protein +FIG00766666 FIG00766669: hypothetical protein +FIG00766675 FIG00766679: hypothetical protein +FIG00766679 FIG00766684: hypothetical protein +FIG00766684 FIG00766689: hypothetical protein +FIG00766691 D-3-phosphoglycerate dehydrogenase +FIG00766697 FIG00766698: hypothetical protein +FIG00766698 sterol desaturase-related protein +FIG00766700 FIG00766704: hypothetical protein +FIG00766705 FIG00766706: hypothetical protein +FIG00766706 FIG00766710: hypothetical protein +FIG00766710 FIG00766712: hypothetical protein +FIG00766715 FIG00766716: hypothetical protein +FIG00766719 FIG00766733: hypothetical protein +FIG00766733 peptidoglycan associated cytoplasmic membrane protein +FIG00766738 FIG00766743: hypothetical protein +FIG00766743 FIG00766751: hypothetical protein +FIG00766751 Cysteine protease +FIG00766752 FIG00766766: hypothetical protein +FIG00766767 FIG00766768: hypothetical protein +FIG00766772 FIG00766773: hypothetical protein +FIG00766773 FIG00766779: hypothetical protein +FIG00766779 ferredoxin family +FIG00766783 FIG00766787: hypothetical protein +FIG00766794 FIG00766795: hypothetical protein +FIG00766796 hydrogenase-4 component E +FIG00766801 FIG00766805: hypothetical protein +FIG00766806 putative metallohydrolase +FIG00766808 FIG00766809: hypothetical protein +FIG00766809 FIG00766810: hypothetical protein +FIG00766810 FIG00766815: hypothetical protein +FIG00766815 FIG00766816: hypothetical protein +FIG00766816 hypothetical protein +FIG00766817 FIG00766822: hypothetical protein +FIG00766822 FIG00766823: hypothetical protein +FIG00766823 FIG00766826: hypothetical protein +FIG00766830 FIG00766831: hypothetical protein +FIG00766831 FIG00766832: hypothetical protein +FIG00766832 FIG00766833: hypothetical protein +FIG00766841 FIG00766842: hypothetical protein +FIG00766842 FIG00766844: hypothetical protein +FIG00766844 FIG00766846: hypothetical protein +FIG00766846 FIG00766847: hypothetical protein +FIG00766849 FIG00766850: hypothetical protein +FIG00766851 FIG00766852: hypothetical protein +FIG00766852 coproporphyrinogen III oxidase +FIG00766859 FIG00766861: hypothetical protein +FIG00766865 FIG00766866: hypothetical protein +FIG00766867 probable glutamine amidotransferase +FIG00766872 FIG00766880: hypothetical protein +FIG00766880 FIG00766883: hypothetical protein +FIG00766883 FIG00766884: hypothetical protein +FIG00766884 FIG00766887: hypothetical protein +FIG00766893 Lipid-A-disaccharide synthetase(lpxB) like protein +FIG00766902 FIG00766906: hypothetical protein +FIG00766909 FIG00766910: hypothetical protein +FIG00766913 FIG00766916: hypothetical protein +FIG00766916 FIG00766920: hypothetical protein +FIG00766925 FIG00766929: hypothetical protein +FIG00766929 FIG00766930: hypothetical protein +FIG00766930 FIG00766934: hypothetical protein +FIG00766935 FIG00766938: hypothetical protein +FIG00766938 FIG00766939: hypothetical protein +FIG00766939 FIG00766942: hypothetical protein +FIG00766944 unknown protein confirmed by proteomics +FIG00766945 FIG00766948: hypothetical protein +FIG00766950 FIG00766955: hypothetical protein +FIG00766965 FIG00766968: hypothetical protein +FIG00766968 FIG00766969: hypothetical protein +FIG00766969 FIG00766970: hypothetical protein +FIG00766976 FIG00766978: hypothetical protein +FIG00766978 FIG00766982: hypothetical protein +FIG00766991 FIG00766993: hypothetical protein +FIG00766993 FIG00766994: hypothetical protein +FIG00766994 FIG00766998: hypothetical protein +FIG00767002 FIG00767004: hypothetical protein +FIG00767004 FIG00767006: hypothetical protein +FIG00767009 FIG00767013: hypothetical protein +FIG00767015 probable DegT/DnrJ/EryC2/StrS family protein +FIG00767016 FIG00767017: hypothetical protein +FIG00767019 FIG00767023: hypothetical protein +FIG00767023 FIG00767024: hypothetical protein +FIG00767024 FIG00767025: hypothetical protein +FIG00767026 FIG00767029: hypothetical protein +FIG00767029 FIG00767031: hypothetical protein +FIG00767031 FIG00767032: hypothetical protein +FIG00767035 FIG00767036: hypothetical protein +FIG00767036 FIG00767037: hypothetical protein +FIG00767040 FIG00767041: hypothetical protein +FIG00767041 FIG00767046: hypothetical protein +FIG00767047 FIG00767048: hypothetical protein +FIG00767052 FIG00767055: hypothetical protein +FIG00767055 fruiting body developmental protein +FIG00767057 FIG00767059: hypothetical protein +FIG00767059 FIG00767061: hypothetical protein +FIG00767061 cGMP-specific phosphodiesterase +FIG00767062 processing proteinase +FIG00767066 FIG00767068: hypothetical protein +FIG00767071 FIG00767072: hypothetical protein +FIG00767072 FIG00767080: hypothetical protein +FIG00767080 FIG00767085: hypothetical protein +FIG00767085 FIG00767086: hypothetical protein +FIG00767088 lysine arginine ornithine transport system kinase +FIG00767093 putative Protein export membrane protein SecD/SecF +FIG00767094 FIG00767097: hypothetical protein +FIG00767097 hypothetical protein +FIG00767100 FIG00767101: hypothetical protein +FIG00767103 FIG00767110: hypothetical protein +FIG00767110 FIG00767111: hypothetical protein +FIG00767111 FIG00767112: hypothetical protein +FIG00767129 FIG00767131: hypothetical protein +FIG00767131 FIG00767136: hypothetical protein +FIG00767136 FIG00767138: hypothetical protein +FIG00767138 FIG00767141: hypothetical protein +FIG00767141 FIG00767142: hypothetical protein +FIG00767142 FIG00767156: hypothetical protein +FIG00767162 FIG00767164: hypothetical protein +FIG00767166 FIG00767167: hypothetical protein +FIG00767167 FIG00767168: hypothetical protein +FIG00767199 FIG00767205: hypothetical protein +FIG00767205 FIG00767206: hypothetical protein +FIG00767208 FIG00767210: hypothetical protein +FIG00767211 FIG00767213: hypothetical protein +FIG00767223 FIG00767224: hypothetical protein +FIG00767224 FIG00767229: hypothetical protein +FIG00767229 FIG00767232: hypothetical protein +FIG00767232 FIG00767234: hypothetical protein +FIG00767235 FIG00767236: hypothetical protein +FIG00767236 FIG00767241: hypothetical protein +FIG00767242 FIG00767243: hypothetical protein +FIG00767243 FIG00767246: hypothetical protein +FIG00767246 FIG00767248: hypothetical protein +FIG00767249 FIG00767253: hypothetical protein +FIG00767253 FIG00767255: hypothetical protein +FIG00767256 FIG00767259: hypothetical protein +FIG00767261 FIG00767268: hypothetical protein +FIG00767273 FIG00767280: hypothetical protein +FIG00767280 FIG00767289: hypothetical protein +FIG00767289 FIG00767292: hypothetical protein +FIG00767292 FIG00767293: hypothetical protein +FIG00767294 FIG00767295: hypothetical protein +FIG00767295 FIG00767296: hypothetical protein +FIG00767297 FIG00767301: hypothetical protein +FIG00767301 FIG00767303: hypothetical protein +FIG00767305 FIG00767311: hypothetical protein +FIG00767311 FIG00767314: hypothetical protein +FIG00767318 FIG00767319: hypothetical protein +FIG00767319 Metallo-beta-lactamase superfamily protein +FIG00767325 FIG00767326: hypothetical protein +FIG00767327 FIG00767332: hypothetical protein +FIG00767332 FIG00767335: hypothetical protein +FIG00767335 FIG00767336: hypothetical protein +FIG00767350 FIG00767351: hypothetical protein +FIG00767351 UDP-glucose lipid carrier transferase +FIG00767360 FIG00767363: hypothetical protein +FIG00767363 FIG00767364: hypothetical protein +FIG00767364 FIG00767365: hypothetical protein +FIG00767387 FIG00767392: hypothetical protein +FIG00767392 FIG00767397: hypothetical protein +FIG00767397 FIG00767399: hypothetical protein +FIG00767399 FIG00767405: hypothetical protein +FIG00767405 FIG00767406: hypothetical protein +FIG00767418 FIG00767420: hypothetical protein +FIG00767420 FIG00767422: hypothetical protein +FIG00767422 FIG00767423: hypothetical protein +FIG00767423 Aldo/keto reductase family protein +FIG00767424 FIG00767425: hypothetical protein +FIG00767425 probable carbamoyl transferase +FIG00767430 FIG00767432: hypothetical protein +FIG00767436 FIG00767437: hypothetical protein +FIG00767437 FIG00767447: hypothetical protein +FIG00767455 FIG00767459: hypothetical protein +FIG00767460 FIG00767463: hypothetical protein +FIG00767468 FIG00767471: hypothetical protein +FIG00767473 FIG00767474: hypothetical protein +FIG00767474 FIG00767480: hypothetical protein +FIG00767481 FIG00767483: hypothetical protein +FIG00767483 FIG00767484: hypothetical protein +FIG00767489 FIG00767490: hypothetical protein +FIG00767492 Ferredoxin--NADP reductase +FIG00767498 FIG00767500: hypothetical protein +FIG00767500 FIG00767501: hypothetical protein +FIG00767505 aspartate aminotransferase a +FIG00767506 FIG00767507: hypothetical protein +FIG00767507 FIG00767508: hypothetical protein +FIG00767523 FIG00767526: hypothetical protein +FIG00767526 putative LRR repeat family protein +FIG00767527 Sphingomyelinase C precursor (EC 3.1.4.12) +FIG00767528 FIG00767531: hypothetical protein +FIG00767531 Acetoacetyl-CoA synthetase (EC 6.2.1.16) +FIG00767535 FIG00767538: hypothetical protein +FIG00767538 FIG00767549: hypothetical protein +FIG00767549 FIG00767550: hypothetical protein +FIG00767551 FIG00763254: hypothetical protein +FIG00767552 FIG00767554: hypothetical protein +FIG00767574 probable phospholipase/Carboxylesterase family protein +FIG00767575 FIG00767577: hypothetical protein +FIG00767581 FIG00767582: hypothetical protein +FIG00767590 FIG00767595: hypothetical protein +FIG00767595 FIG00767603: hypothetical protein +FIG00767603 SET family protein +FIG00767605 FIG00767607: hypothetical protein +FIG00767607 FIG00767613: hypothetical protein +FIG00767613 FIG00767614: hypothetical protein +FIG00767614 FIG00767619: hypothetical protein +FIG00767619 FIG00767620: hypothetical protein +FIG00767640 FIG00767642: hypothetical protein +FIG00767642 FIG00767643: hypothetical protein +FIG00767653 FIG00767659: hypothetical protein +FIG00767661 methylamine utilization protein +FIG00767667 Phospholipase D family protein +FIG00767672 FIG00767674: hypothetical protein +FIG00767687 FIG00767691: hypothetical protein +FIG00767691 FIG00767692: hypothetical protein +FIG00767692 FIG00767693: hypothetical protein +FIG00767693 FIG00767694: hypothetical protein +FIG00767697 SMF protein +FIG00767699 FIG00767711: hypothetical protein +FIG00767711 sphingomyelinase C precursor +FIG00767712 FIG00767717: hypothetical protein +FIG00767724 FIG00767725: hypothetical protein +FIG00767730 FIG00767731: hypothetical protein +FIG00767731 FIG00767732: hypothetical protein +FIG00767734 FIG00767735: hypothetical protein +FIG00767745 surface antigen +FIG00767747 FIG00767748: hypothetical protein +FIG00767748 FIG00767749: hypothetical protein +FIG00767767 FIG00767772: hypothetical protein +FIG00767772 FIG00767777: hypothetical protein +FIG00767785 FIG00767800: hypothetical protein +FIG00767800 FIG00767803: hypothetical protein +FIG00767816 outermembrane protein +FIG00767823 phosphate transport system protein +FIG00767827 FIG00767829: hypothetical protein +FIG00767829 FIG00767835: hypothetical protein +FIG00767838 FIG00767839: hypothetical protein +FIG00767839 FIG00767852: hypothetical protein +FIG00767855 FIG00767856: hypothetical protein +FIG00767857 FIG00767858: hypothetical protein +FIG00767858 FIG00767862: hypothetical protein +FIG00767862 FIG00767866: hypothetical protein +FIG00767866 glutaconate CoA transferase-like protein +FIG00767867 FIG00767877: hypothetical protein +FIG00767877 3-oxoacyl-(acyl carrier protein) reductase +FIG00767897 phosphoglycerate mutase-related protein +FIG00767906 FIG00767909: hypothetical protein +FIG00767911 FIG00767913: hypothetical protein +FIG00767917 FIG00767920: hypothetical protein +FIG00767924 FIG00767932: hypothetical protein +FIG00767932 FIG00767936: hypothetical protein +FIG00767936 FIG00767937: hypothetical protein +FIG00767937 FIG00767938: hypothetical protein +FIG00767942 FIG00767944: hypothetical protein +FIG00767944 FIG00767947: hypothetical protein +FIG00767959 FIG00767960: hypothetical protein +FIG00767965 aminopeptidase N +FIG00767972 FIG00767973: hypothetical protein +FIG00767975 FIG00767977: hypothetical protein +FIG00767980 prolipoprotein diacylglycerol transferase +FIG00767981 FIG00767982: hypothetical protein +FIG00767987 FIG00767989: hypothetical protein +FIG00767989 FIG00767994: hypothetical protein +FIG00767994 FIG00767995: hypothetical protein +FIG00767995 O-antigen export system ATP-binding protein rfbB +FIG00768004 FIG00768005: hypothetical protein +FIG00768012 S-layer-like protein +FIG00768013 FIG00768014: hypothetical protein +FIG00768017 FIG00768019: hypothetical protein +FIG00768034 FIG00768042: hypothetical protein +FIG00768044 FIG00768051: hypothetical protein +FIG00768052 rfaL +FIG00768060 FIG00762699: hypothetical protein +FIG00768073 FIG00768074: hypothetical protein +FIG00768074 FIG00768075: hypothetical protein +FIG00768075 Methylase +FIG00768082 Stage II sporulation protein E (EC 3.1.3.16) +FIG00768086 FIG00768091: hypothetical protein +FIG00768091 FIG00768093: hypothetical protein +FIG00768093 FIG00768094: hypothetical protein +FIG00768094 FIG017431: Sigma factor-like phosphatase with CBS pair domains +FIG00768097 FIG00768103: hypothetical protein +FIG00768103 FIG00768104: hypothetical protein +FIG00768104 FIG00768105: hypothetical protein +FIG00768128 FIG00768142: hypothetical protein +FIG00768149 FIG00768152: hypothetical protein +FIG00768152 FIG00768156: hypothetical protein +FIG00768156 FIG00768161: hypothetical protein +FIG00768161 FIG00768162: hypothetical protein +FIG00768162 thiol-disulfide interchange like protein +FIG00768163 FIG00768166: hypothetical protein +FIG00768166 FIG00768170: hypothetical protein +FIG00768170 FIG00768181: hypothetical protein +FIG00768190 FIG00768192: hypothetical protein +FIG00768198 FIG00768199: hypothetical protein +FIG00768199 FIG00768200: hypothetical protein +FIG00768200 FIG00768203: hypothetical protein +FIG00768203 FIG00768208: hypothetical protein +FIG00768221 FIG00768223: hypothetical protein +FIG00768225 FIG00768231: hypothetical protein +FIG00768241 FIG00768242: hypothetical protein +FIG00768242 surface protein Lk90-like protein +FIG00768250 FIG00768259: hypothetical protein +FIG00768259 FIG00768262: hypothetical protein +FIG00768262 FIG00768270: hypothetical protein +FIG00768270 FIG00768276: hypothetical protein +FIG00768289 Glycerol kinase +FIG00768291 cell division inhibitor +FIG00768292 FIG00768294: hypothetical protein +FIG00768303 FIG00768306: hypothetical protein +FIG00768306 hemerythrin-related protein +FIG00768311 FIG00768312: hypothetical protein +FIG00768314 FIG00768315: hypothetical protein +FIG00768316 FIG00768317: hypothetical protein +FIG00768317 FIG00768319: hypothetical protein +FIG00768323 FIG00768324: hypothetical protein +FIG00768328 FIG00768331: hypothetical protein +FIG00768331 FIG00768335: hypothetical protein +FIG00768341 FIG00768342: hypothetical protein +FIG00768344 FIG00768348: hypothetical protein +FIG00768349 FIG00768350: hypothetical protein +FIG00768353 FIG00768368: hypothetical protein +FIG00768368 FIG00768373: hypothetical protein +FIG00768373 FIG00768376: hypothetical protein +FIG00768376 Ig-like repeat domain protein 3 +FIG00768378 FIG00768379: hypothetical protein +FIG00768381 FIG00768385: hypothetical protein +FIG00768385 FIG00768388: hypothetical protein +FIG00768388 FIG00768393: hypothetical protein +FIG00768393 FIG00768394: hypothetical protein +FIG00768400 FIG00768402: hypothetical protein +FIG00768411 FIG00768414: hypothetical protein +FIG00768414 FIG00768415: hypothetical protein +FIG00768415 FIG00768417: hypothetical protein +FIG00768417 2-dehydropantoate 2-reductase +FIG00768433 putative malonyl-CoA transacylase +FIG00768437 FIG00768442: hypothetical protein +FIG00768442 FIG00768447: hypothetical protein +FIG00768447 FIG00768448: hypothetical protein +FIG00768448 FIG00768449: hypothetical protein +FIG00768488 FIG00768494: hypothetical protein +FIG00768494 FIG00768501: hypothetical protein +FIG00768513 FIG00768514: hypothetical protein +FIG00768522 FIG00768529: hypothetical protein +FIG00768529 FIG00768530: hypothetical protein +FIG00768530 FIG00768533: hypothetical protein +FIG00768539 Putative 1-aminocyclopropane-1-carboxylate deaminase (EC 3.5.99.7) +FIG00768546 FIG00768549: hypothetical protein +FIG00768569 FIG00768577: hypothetical protein +FIG00768577 FIG00768578: hypothetical protein +FIG00768578 FIG00768584: hypothetical protein +FIG00768585 FIG00768591: hypothetical protein +FIG00768591 FIG00768597: hypothetical protein +FIG00768597 FIG00768598: hypothetical protein +FIG00768598 FIG00768603: hypothetical protein +FIG00768607 FIG00768610: hypothetical protein +FIG00768610 FIG00768611: hypothetical protein +FIG00768618 FIG00072947: hypothetical protein +FIG00768621 FIG00768624: hypothetical protein +FIG00768624 FIG00768629: hypothetical protein +FIG00768629 fatty acid desaturase +FIG00768645 FIG00768647: hypothetical protein +FIG00768648 membrane metalloendopeptidase +FIG00768649 putative acetyl CoA acetyltransferase +FIG00768654 FIG00768655: hypothetical protein +FIG00768655 FIG00768656: hypothetical protein +FIG00768673 FIG00768674: hypothetical protein +FIG00768676 FIG00768677: hypothetical protein +FIG00768696 FIG00768699: hypothetical protein +FIG00768700 FIG00768701: hypothetical protein +FIG00768712 FIG00768714: hypothetical protein +FIG00768714 FIG00768715: hypothetical protein +FIG00768719 probable DegT/DnrJ/EryC4/StrS family protein +FIG00768725 acriflavine resistance protein homolog +FIG00768727 FIG00768729: hypothetical protein +FIG00768741 DNA polymerase III gamma and tau subunits +FIG00768743 FIG00768749: hypothetical protein +FIG00768759 FIG00768766: hypothetical protein +FIG00768786 FIG00768789: hypothetical protein +FIG00768804 FIG00768808: hypothetical protein +FIG00768808 FIG00768812: hypothetical protein +FIG00768813 FIG00768821: hypothetical protein +FIG00768821 FIG00768826: hypothetical protein +FIG00768837 FIG00768840: hypothetical protein +FIG00768847 FIG00768848: hypothetical protein +FIG00768848 FIG00768849: hypothetical protein +FIG00768853 FIG00768855: hypothetical protein +FIG00768855 FIG00768858: hypothetical protein +FIG00768863 FIG00768864: hypothetical protein +FIG00768864 FIG00768867: hypothetical protein +FIG00768867 thioredoxin-like protein +FIG00768873 FIG00768874: hypothetical protein +FIG00768880 FIG00768881: hypothetical protein +FIG00768887 citrate lyase, beta subunit +FIG00768889 FIG00768890: hypothetical protein +FIG00768890 FIG00768891: hypothetical protein +FIG00768891 FIG00768892: hypothetical protein +FIG00768892 FIG00768894: hypothetical protein +FIG00768895 FIG00768896: hypothetical protein +FIG00768927 FIG00768928: hypothetical protein +FIG00768937 FIG00768939: hypothetical protein +FIG00768939 FIG00768940: hypothetical protein +FIG00768948 RNA polymerase sigma subunit +FIG00768967 FIG00768968: hypothetical protein +FIG00768990 FIG00768992: hypothetical protein +FIG00768992 FIG00768994: hypothetical protein +FIG00769019 FIG00769023: hypothetical protein +FIG00769027 FIG00769028: hypothetical protein +FIG00769033 FIG00769038: hypothetical protein +FIG00769038 Putative AraC-type Regulator +FIG00769040 FIG00769041: hypothetical protein +FIG00769041 FIG00769048: hypothetical protein +FIG00769048 FIG00769049: hypothetical protein +FIG00769049 FIG00769050: hypothetical protein +FIG00769050 alkylglycerone-phosphate synthase +FIG00769096 FIG00769106: hypothetical protein +FIG00769106 FIG00769108: hypothetical protein +FIG00769108 FIG00769118: hypothetical protein +FIG00769120 FIG00769121: hypothetical protein +FIG00769133 hypothetical protein +FIG00769135 FIG00769136: hypothetical protein +FIG00769136 FIG00769143: hypothetical protein +FIG00769164 FIG00769167: hypothetical protein +FIG00769174 Sensory transduction histidine kinase +FIG00769196 phenazine biosynthesis-like protein +FIG00769213 FIG00769221: hypothetical protein +FIG00769221 FIG00769234: hypothetical protein +FIG00769234 FIG00769235: hypothetical protein +FIG00769237 FIG00769238: hypothetical protein +FIG00769242 FIG00769244: hypothetical protein +FIG00769244 FIG00769249: hypothetical protein +FIG00769252 FIG00769253: hypothetical protein +FIG00769255 FIG00769259: hypothetical protein +FIG00769281 FIG00769283: hypothetical protein +FIG00769288 FIG00769292: hypothetical protein +FIG00769299 FIG00769300: hypothetical protein +FIG00769324 FIG00769325: hypothetical protein +FIG00769332 FIG00769338: hypothetical protein +FIG00769338 Tat (twin-arginine translocation) pathway signal sequence domain protein +FIG00769339 FIG00769347: hypothetical protein +FIG00769347 FIG00769349: hypothetical protein +FIG00769353 FIG00769354: hypothetical protein +FIG00769359 FIG00769360: hypothetical protein +FIG00769365 FIG00769369: hypothetical protein +FIG00769373 Phage ribonuclease H +FIG00769396 PII uridylyl- transferase; Uridylyl removing enzyme; UTase +FIG00769405 FIG00769406: hypothetical protein +FIG00769410 FIG00769417: hypothetical protein +FIG00769417 FIG00769420: hypothetical protein +FIG00769424 ComFC-like protein +FIG00769430 FIG00769431: hypothetical protein +FIG00769431 FIG00769432: hypothetical protein +FIG00769450 FIG00769456: hypothetical protein +FIG00769456 FIG00769460: hypothetical protein +FIG00769468 FIG00769472: hypothetical protein +FIG00769472 FIG00769475: hypothetical protein +FIG00769475 sterol desaturase family protein +FIG00769480 FIG00769482: hypothetical protein +FIG00769487 FIG00769492: hypothetical protein +FIG00769492 copper-transport ATP-binding protein NosF +FIG00769510 FIG00769511: hypothetical protein +FIG00769511 FIG00769512: hypothetical protein +FIG00769513 FIG00769520: hypothetical protein +FIG00769529 FIG00769530: hypothetical protein +FIG00769535 acriflavine resistance +FIG00769540 FIG00769541: hypothetical protein +FIG00769542 FIG00769546: hypothetical protein +FIG00769546 FIG00769550: hypothetical protein +FIG00769550 FIG00769556: hypothetical protein +FIG00769556 FIG00769557: hypothetical protein +FIG00769567 FIG00769568: hypothetical protein +FIG00769568 FIG00769589: hypothetical protein +FIG00769589 FIG00769590: hypothetical protein +FIG00769618 FIG00769622: hypothetical protein +FIG00769622 FIG00769623: hypothetical protein +FIG00769623 FIG00769627: hypothetical protein +FIG00769630 FIG00769631: hypothetical protein +FIG00769645 FIG00769649: hypothetical protein +FIG00769649 FIG00769650: hypothetical protein +FIG00769650 FIG00769654: hypothetical protein +FIG00769654 FIG00769658: hypothetical protein +FIG00769659 FIG00769660: hypothetical protein +FIG00769670 putative FAD-dependent dehydrogenase +FIG00769675 FIG00769676: hypothetical protein +FIG00769710 FIG00769711: hypothetical protein +FIG00769731 FIG00769732: hypothetical protein +FIG00769734 FIG00769746: hypothetical protein +FIG00769774 probable TonB-dependent receptor +FIG00769779 FIG00769780: hypothetical protein +FIG00769821 FIG00769822: hypothetical protein +FIG00769822 FIG00769824: hypothetical protein +FIG00769832 FIG00769834: hypothetical protein +FIG00769859 FIG00769860: hypothetical protein +FIG00769865 FIG00769867: hypothetical protein +FIG00769867 FIG00769868: hypothetical protein +FIG00769946 FIG00769947: hypothetical protein +FIG00769958 FIG00769968: hypothetical protein +FIG00770008 FIG00770016: hypothetical protein +FIG00770018 FIG00770019: hypothetical protein +FIG00770033 FIG00770038: hypothetical protein +FIG00770058 Rhodanese/cdc25 fold +FIG00770139 FIG00770143: hypothetical protein +FIG00770229 Transcriptional regulator, LacI family protein +FIG00770252 LemA precursor +FIG00770281 FIG00770282: hypothetical protein +FIG00770309 FIG00770315: hypothetical protein +FIG00770315 FIG00770320: hypothetical protein +FIG00770341 putative HNS-like transcription regulator protein +FIG00770380 FIG00770383: hypothetical protein +FIG00770404 FIG00770405: hypothetical protein +FIG00770407 FIG01003829: hypothetical protein +FIG00770423 D-xylose transport ATP-binding protein xylG +FIG00770491 FIG00770495: hypothetical protein +FIG00770573 Universal stress family protein +FIG00770676 putative poly-gamma-glutamate biosynthesis enzyme +FIG00770705 Xylose isomerase-like +FIG00770732 FIG00770738: hypothetical protein +FIG00770872 FIG00770873: hypothetical protein +FIG00770875 FIG00770878: hypothetical protein +FIG00770887 Acetyltransferase, isoleucine patch superfamily +FIG00770907 LysR type regulator +FIG00770914 NIPSNAP domain containing protein +FIG00770999 Permease of ABC sugar transporter +FIG00771072 Peptidase M52, hydrogen uptake protein +FIG00771096 FIG00771097: hypothetical protein +FIG00771184 FIG00771185: hypothetical protein +FIG00771346 FIG00771358: hypothetical protein +FIG00771361 FIG00771363: hypothetical protein +FIG00771401 DUF1854 domain-containing protein +FIG00771406 Probable RNA methyltransferase PA1839 +FIG00771412 FIG00771417: hypothetical protein +FIG00771429 FIG00771430: hypothetical protein +FIG00771472 FIG00771477: hypothetical protein +FIG00771520 Putrescine ABC transporter putrescine-binding protein PotF (TC 3.A.1.11.2) +FIG00771532 Protein yhbN precursor +FIG00771553 FIG00771554: hypothetical protein +FIG00771554 FIG00771556: hypothetical protein +FIG00771556 FIG00771561: hypothetical protein +FIG00771561 FIG00771562: hypothetical protein +FIG00771562 FIG00771568: hypothetical protein +FIG00771568 FIG00771569: hypothetical protein +FIG00771574 FIG00771576: hypothetical protein +FIG00771583 FIG00771584: hypothetical protein +FIG00771584 FIG00771587: hypothetical protein +FIG00771590 FIG00771592: hypothetical protein +FIG00771593 FIG00771594: hypothetical protein +FIG00771594 FIG00771595: hypothetical protein +FIG00771595 FIG00771597: hypothetical protein +FIG00771598 FIG00771599: hypothetical protein +FIG00771599 FIG00771600: hypothetical protein +FIG00771600 FIG00771601: hypothetical protein +FIG00771601 FIG00771603: hypothetical protein +FIG00771604 FIG00771609: hypothetical protein +FIG00771609 FIG00771615: hypothetical protein +FIG00771615 FIG00771620: hypothetical protein +FIG00771620 FIG00771622: hypothetical protein +FIG00771627 FIG00771629: hypothetical protein +FIG00771638 FIG00771643: hypothetical protein +FIG00771643 FIG00771650: hypothetical protein +FIG00771650 FIG00771652: hypothetical protein +FIG00771653 FIG00771654: hypothetical protein +FIG00771659 FIG00771662: hypothetical protein +FIG00771662 FIG00771663: hypothetical protein +FIG00771670 FIG00771671: hypothetical protein +FIG00771672 FIG00771675: hypothetical protein +FIG00771678 FIG00771679: hypothetical protein +FIG00771679 FIG00771680: hypothetical protein +FIG00771689 FIG00771691: hypothetical protein +FIG00771710 FIG00771713: hypothetical protein +FIG00771713 FIG00771714: hypothetical protein +FIG00771715 FIG00771718: hypothetical protein +FIG00771718 FIG00771719: hypothetical protein +FIG00771725 FIG00771736: hypothetical protein +FIG00771740 FIG00771742: hypothetical protein +FIG00771748 FIG00771749: hypothetical protein +FIG00771749 RelB/StbD replicon stabilization protein (antitoxin to RelE/StbE) +FIG00771752 Uncharacterized conserved protein, YCII family +FIG00771760 FIG00771761: hypothetical protein +FIG00771761 FIG00771766: hypothetical protein +FIG00771782 FIG00771785: hypothetical protein +FIG00771785 FIG00771789: hypothetical protein +FIG00771791 FIG00771796: hypothetical protein +FIG00771803 FIG00771805: hypothetical protein +FIG00771808 FIG00771809: hypothetical protein +FIG00771809 FIG00771812: hypothetical protein +FIG00771813 FIG00771815: hypothetical protein +FIG00771819 FIG00771820: hypothetical protein +FIG00771823 FIG00771826: hypothetical protein +FIG00771826 FIG00771827: hypothetical protein +FIG00771827 FIG00771839: hypothetical protein +FIG00771839 FIG00771843: hypothetical protein +FIG00771845 FIG00771847: hypothetical protein +FIG00771849 FIG00771850: hypothetical protein +FIG00771850 FIG00771851: hypothetical protein +FIG00771851 FIG00771855: hypothetical protein +FIG00771855 FIG00771856: hypothetical protein +FIG00771856 FIG00771858: hypothetical protein +FIG00771864 FIG00771868: hypothetical protein +FIG00771872 FIG00771876: hypothetical protein +FIG00771887 Ferrochelatase( EC:1.- ) +FIG00771888 FIG00771890: hypothetical protein +FIG00771895 Putative ATP-binding protein +FIG00771903 Amino-acid ABC transporter ATP-binding protein +FIG00771906 FIG00771908: hypothetical protein +FIG00771908 FIG00771909: hypothetical protein +FIG00771912 FIG00771913: hypothetical protein +FIG00771920 FIG00771922: hypothetical protein +FIG00771925 FIG00771928: hypothetical protein +FIG00771941 FIG00771943: hypothetical protein +FIG00771948 FIG00771953: hypothetical protein +FIG00771954 FIG00771958: hypothetical protein +FIG00771970 FIG00771972: hypothetical protein +FIG00771972 FIG00771973: hypothetical protein +FIG00771973 FIG00771974: hypothetical protein +FIG00771975 FIG00771976: hypothetical protein +FIG00771988 FIG00771989: hypothetical protein +FIG00771989 FIG00771991: hypothetical protein +FIG00771991 FIG00771996: hypothetical protein +FIG00771996 FIG00771998: hypothetical protein +FIG00772005 FIG00772007: hypothetical protein +FIG00772009 putative patatin-like phospholipase +FIG00772013 FIG00772017: hypothetical protein +FIG00772019 FIG00772024: hypothetical protein +FIG00772024 FIG00772025: hypothetical protein +FIG00772026 FIG00772030: hypothetical protein +FIG00772030 FIG00772031: hypothetical protein +FIG00772040 FIG00772041: hypothetical protein +FIG00772041 FIG00772043: hypothetical protein +FIG00772045 FIG00772046: hypothetical protein +FIG00772047 FIG00772049: hypothetical protein +FIG00772049 FIG00772051: hypothetical protein +FIG00772058 FIG00772060: hypothetical protein +FIG00772060 FIG00772064: hypothetical protein +FIG00772064 FIG00772066: hypothetical protein +FIG00772066 FIG00772070: hypothetical protein +FIG00772073 cobalt ABC transporter ATP-binding protein +FIG00772084 FIG00772085: hypothetical protein +FIG00772085 FIG00772086: hypothetical protein +FIG00772087 FIG00772093: hypothetical protein +FIG00772093 FIG00772095: hypothetical protein +FIG00772100 FIG00772101: hypothetical protein +FIG00772105 FIG00772107: hypothetical protein +FIG00772107 FIG00772110: hypothetical protein +FIG00772119 FIG00772122: hypothetical protein +FIG00772122 FIG00772126: hypothetical protein +FIG00772126 FIG00772128: hypothetical protein +FIG00772133 FIG00772135: hypothetical protein +FIG00772139 FIG00772144: hypothetical protein +FIG00772144 FIG00772158: hypothetical protein +FIG00772158 FIG00772159: hypothetical protein +FIG00772159 FIG00772161: hypothetical protein +FIG00772162 Bis(5'-nucleosyl)-tetraphosphatase (asymmetrical)( EC:3.6.1.17 ) +FIG00772164 FIG00772165: hypothetical protein +FIG00772165 FIG00772169: hypothetical protein +FIG00772170 FIG00772171: hypothetical protein +FIG00772171 amino acid ABC transporter permease protein +FIG00772172 FIG00772173: hypothetical protein +FIG00772176 FIG00772179: hypothetical protein +FIG00772179 FIG00772184: hypothetical protein +FIG00772195 FIG00772198: hypothetical protein +FIG00772202 FIG00772205: hypothetical protein +FIG00772208 FIG00772210: hypothetical protein +FIG00772221 FIG00772222: hypothetical protein +FIG00772249 FIG00772254: hypothetical protein +FIG00772256 FIG00772260: hypothetical protein +FIG00772260 FIG00772266: hypothetical protein +FIG00772271 FIG00772273: hypothetical protein +FIG00772273 FIG00772276: hypothetical protein +FIG00772276 PTS system, IIA component( EC:2.7.1.69 ) +FIG00772279 FIG00772280: hypothetical protein +FIG00772290 FIG00772292: hypothetical protein +FIG00772292 FIG00772294: hypothetical protein +FIG00772294 FIG00772295: hypothetical protein +FIG00772302 FIG00772310: hypothetical protein +FIG00772314 GrpE protein HSP-70 cofactor +FIG00772321 FIG00772322: hypothetical protein +FIG00772328 FIG00772330: hypothetical protein +FIG00772330 FIG00772340: hypothetical protein +FIG00772340 FIG00772343: hypothetical protein +FIG00772343 FIG00772344: hypothetical protein +FIG00772344 FUSOBACTERIUM OUTER MEMBRANE PROTEIN FAMILY +FIG00772350 FIG00772351: hypothetical protein +FIG00772351 FIG00772356: hypothetical protein +FIG00772369 FIG00772372: hypothetical protein +FIG00772379 FIG00772381: hypothetical protein +FIG00772402 FIG00772403: hypothetical protein +FIG00772403 FIG00772407: hypothetical protein +FIG00772411 FIG00772415: hypothetical protein +FIG00772415 FIG00772420: hypothetical protein +FIG00772420 FIG00772425: hypothetical protein +FIG00772440 FIG00772442: hypothetical protein +FIG00772456 FIG00772457: hypothetical protein +FIG00772457 FIG00772458: hypothetical protein +FIG00772489 FIG00772496: hypothetical protein +FIG00772496 FIG00772497: hypothetical protein +FIG00772497 FIG00772498: hypothetical protein +FIG00772507 FIG00772508: hypothetical protein +FIG00772508 FIG00772509: hypothetical protein +FIG00772510 FIG00772512: hypothetical protein +FIG00772512 FIG00772516: hypothetical protein +FIG00772541 FIG00772543: hypothetical protein +FIG00772549 FIG00772550: hypothetical protein +FIG00772550 FIG00772553: hypothetical protein +FIG00772553 putative capsular polysaccharide synthesis protein +FIG00772567 FIG00772571: hypothetical protein +FIG00772574 FIG00772577: hypothetical protein +FIG00772578 FIG00772579: hypothetical protein +FIG00772579 FIG00772581: hypothetical protein +FIG00772581 FIG00772583: hypothetical protein +FIG00772583 FIG00772589: hypothetical protein +FIG00772598 FIG00772601: hypothetical protein +FIG00772601 FIG00772603: hypothetical protein +FIG00772607 FIG00772609: hypothetical protein +FIG00772612 FIG00772617: hypothetical protein +FIG00772623 FIG00772624: hypothetical protein +FIG00772624 FIG00772626: hypothetical protein +FIG00772627 FIG00772628: hypothetical protein +FIG00772631 FIG00772632: hypothetical protein +FIG00772632 FIG00772633: hypothetical protein +FIG00772633 FIG00772635: hypothetical protein +FIG00772635 FIG00772645: hypothetical protein +FIG00772645 FIG00772646: hypothetical protein +FIG00772649 FIG00772655: hypothetical protein +FIG00772655 lemA family protein +FIG00772659 FIG00772661: hypothetical protein +FIG00772661 FIG00772664: hypothetical protein +FIG00772664 FIG00772665: hypothetical protein +FIG00772669 FIG00772670: hypothetical protein +FIG00772676 FIG00772677: hypothetical protein +FIG00772677 FIG00772678: hypothetical protein +FIG00772683 FIG00772684: hypothetical protein +FIG00772684 FIG00772691: hypothetical protein +FIG00772700 FIG00772704: hypothetical protein +FIG00772716 FIG00772719: hypothetical protein +FIG00772735 heat shock factor (HSF)-type DNA-binding domain-containing protein +FIG00772736 Ethanolamine utilization polyhedral-body-like protein EutM +FIG00772740 FIG00772742: hypothetical protein +FIG00772742 DNASE I HOMOLOGOUS PROTEIN DHP2 PRECURSOR( EC:3.1.21.- ) +FIG00772743 FIG00772745: hypothetical protein +FIG00772752 FIG00772755: hypothetical protein +FIG00772785 FIG00772788: hypothetical protein +FIG00772796 unknown next to FUPA32 +FIG00772799 FIG00772801: hypothetical protein +FIG00772804 FIG00772812: hypothetical protein +FIG00772836 Protein clustered with ethanolamine utilization +FIG00772860 FIG00772867: hypothetical protein +FIG00772873 FIG00772874: hypothetical protein +FIG00772903 FIG00772904: hypothetical protein +FIG00772907 FIG00772908: hypothetical protein +FIG00772938 FIG00772942: hypothetical protein +FIG00772943 hypothetical hemolysin +FIG00772966 FIG00772967: hypothetical protein +FIG00772967 FIG00772968: hypothetical protein +FIG00772968 FIG00772970: hypothetical protein +FIG00772973 FIG00772974: hypothetical protein +FIG00772975 FIG00772976: hypothetical protein +FIG00772984 FIG00772986: hypothetical protein +FIG00772986 FIG00772987: hypothetical protein +FIG00772990 FIG00772991: hypothetical protein +FIG00772994 FIG00772995: hypothetical protein +FIG00772995 FIG00772996: hypothetical protein +FIG00772996 FIG00772997: hypothetical protein +FIG00773004 FIG00773006: hypothetical protein +FIG00773006 FIG00773009: hypothetical protein +FIG00773014 FIG00773016: hypothetical protein +FIG00773017 FIG00773019: hypothetical protein +FIG00773020 FIG00773021: hypothetical protein +FIG00773021 FIG00773022: hypothetical protein +FIG00773027 FIG00773029: hypothetical protein +FIG00773032 FIG00773034: hypothetical protein +FIG00773034 FIG00773035: hypothetical protein +FIG00773035 FIG00773036: hypothetical protein +FIG00773038 FIG00773039: hypothetical protein +FIG00773047 FIG00773048: hypothetical protein +FIG00773053 FIG00773054: hypothetical protein +FIG00773058 FIG00773059: hypothetical protein +FIG00773060 FIG00773061: hypothetical protein +FIG00773063 FIG00773064: hypothetical protein +FIG00773068 FIG00773070: hypothetical protein +FIG00773073 Predicted SAM-dependent methyltransferase +FIG00773074 FIG00773075: hypothetical protein +FIG00773079 FIG00773080: hypothetical protein +FIG00773081 FIG00773083: hypothetical protein +FIG00773085 FIG00773086: hypothetical protein +FIG00773088 FIG00773089: hypothetical protein +FIG00773089 FIG00773091: hypothetical protein +FIG00773091 FIG00773093: hypothetical protein +FIG00773096 FIG00773097: hypothetical protein +FIG00773097 FIG00773100: hypothetical protein +FIG00773102 FIG00773104: hypothetical protein +FIG00773107 FIG01115255: hypothetical protein +FIG00773114 FIG00773115: hypothetical protein +FIG00773115 FIG00773116: hypothetical protein +FIG00773116 FIG00773120: hypothetical protein +FIG00773125 FIG00773127: hypothetical protein +FIG00773129 FIG00773130: hypothetical protein +FIG00773130 FIG00773131: hypothetical protein +FIG00773131 FIG00773134: hypothetical protein +FIG00773136 FIG00773139: hypothetical protein +FIG00773141 FIG00773142: hypothetical protein +FIG00773149 FIG00773151: hypothetical protein +FIG00773158 FIG00773160: hypothetical protein +FIG00773164 FIG00773167: hypothetical protein +FIG00773169 Aryl-alcohol dehydrogenase family enzyme +FIG00773175 FIG00773176: hypothetical protein +FIG00773176 FIG00773177: hypothetical protein +FIG00773177 FIG00773178: hypothetical protein +FIG00773178 FIG00773179: hypothetical protein +FIG00773184 FIG00773185: hypothetical protein +FIG00773185 Fucose 4-O-acetylase related acetyltransferase +FIG00773189 FIG00773191: hypothetical protein +FIG00773191 FIG00773193: hypothetical protein +FIG00773193 FIG00773194: hypothetical protein +FIG00773195 FIG00773196: hypothetical protein +FIG00773196 Glycoside-Pentoside-Hexuronide (GPH):Cation symporter family protein +FIG00773199 FIG00773200: hypothetical protein +FIG00773200 FIG00773204: hypothetical protein +FIG00773204 tRNA-dependent lipid II-Ala--L-serine ligase +FIG00773211 FIG00773212: hypothetical protein +FIG00773215 FIG00773216: hypothetical protein +FIG00773219 FIG00773220: hypothetical protein +FIG00773220 FIG00773221: hypothetical protein +FIG00773221 FIG00773222: hypothetical protein +FIG00773229 FIG00773230: hypothetical protein +FIG00773232 255aa long hypothetical tropinesterase +FIG00773241 amino acid ABC transporter (permease) +FIG00773244 FIG00773245: hypothetical protein +FIG00773246 ABC-type transport system for multi-copper enzyme maturation, permease component +FIG00773250 FIG00773251: hypothetical protein +FIG00773251 FIG00773253: hypothetical protein +FIG00773259 FIG00773260: hypothetical protein +FIG00773261 FIG00773262: hypothetical protein +FIG00773262 FIG00773263: hypothetical protein +FIG00773263 FIG00773264: hypothetical protein +FIG00773264 FIG00773265: hypothetical protein +FIG00773267 Nicotinamide mononucleotide transporter +FIG00773274 FIG00773275: hypothetical protein +FIG00773275 FIG00773277: hypothetical protein +FIG00773280 FIG00773283: hypothetical protein +FIG00773283 ArdA protein +FIG00773284 FIG00773286: hypothetical protein +FIG00773288 conjugal transfer protein, interruption-C +FIG00773290 FIG00773291: hypothetical protein +FIG00773292 FIG00773293: hypothetical protein +FIG00773296 FIG00773299: hypothetical protein +FIG00773299 FIG00773300: hypothetical protein +FIG00773302 FIG00773304: hypothetical protein +FIG00773307 FIG00773308: hypothetical protein +FIG00773309 Predicted membrane protein, putative toxin regulator +FIG00773314 FIG00773315: hypothetical protein +FIG00773316 FIG00773317: hypothetical protein +FIG00773317 FIG00773318: hypothetical protein +FIG00773319 FIG00773321: hypothetical protein +FIG00773321 Membrane-associated serine protease +FIG00773323 FIG00773325: hypothetical protein +FIG00773326 FIG00773328: hypothetical protein +FIG00773329 FIG00773330: hypothetical protein +FIG00773330 FIG00773332: hypothetical protein +FIG00773332 FIG00773333: hypothetical protein +FIG00773334 FIG00773335: hypothetical protein +FIG00773335 FIG00773336: hypothetical protein +FIG00773336 FIG00773337: hypothetical protein +FIG00773343 FIG00773344: hypothetical protein +FIG00773345 FIG00773349: hypothetical protein +FIG00773352 FIG00773353: hypothetical protein +FIG00773354 FIG00773356: hypothetical protein +FIG00773356 Aromatic compounds catabolism protein +FIG00773358 FIG00773359: hypothetical protein +FIG00773359 FIG00773360: hypothetical protein +FIG00773362 Diacylglycerol kinase family protein +FIG00773363 FIG00773365: hypothetical protein +FIG00773368 FIG01118726: hypothetical protein +FIG00773371 FIG00773372: hypothetical protein +FIG00773373 FIG00773374: hypothetical protein +FIG00773374 FIG00773375: hypothetical protein +FIG00773375 FIG00773376: hypothetical protein +FIG00773376 FIG00773377: hypothetical protein +FIG00773381 FIG00773382: hypothetical protein +FIG00773382 Protein of unknown function (DUF1456) +FIG00773384 FIG00773385: hypothetical protein +FIG00773389 FIG00773390: hypothetical protein +FIG00773391 FIG00773392: hypothetical protein +FIG00773392 FIG00773393: hypothetical protein +FIG00773395 FIG00773396: hypothetical protein +FIG00773396 FIG00773401: hypothetical protein +FIG00773401 L-O-lysylphosphatidylglycerol synthase (EC 2.3.2.3) +FIG00773402 FIG00773403: hypothetical protein +FIG00773411 alpha/beta hydrolase superfamily protein +FIG00773416 FIG00773419: hypothetical protein +FIG00773420 FIG01115927: hypothetical protein +FIG00773424 LysM domain +FIG00773426 FIG00773428: hypothetical protein +FIG00773429 putative secreted metallopeptidase +FIG00773430 FIG00773433: hypothetical protein +FIG00773434 FIG00773438: hypothetical protein +FIG00773441 FIG00773444: hypothetical protein +FIG00773444 FIG00773445: hypothetical protein +FIG00773448 FIG00773452: hypothetical protein +FIG00773464 FIG00773470: hypothetical protein +FIG00773470 FIG00773474: hypothetical protein +FIG00773479 Predicted phosphoesterase or phosphohydrolase +FIG00773487 FIG00773489: hypothetical protein +FIG00773499 ComX +FIG00773503 FIG00773504: hypothetical protein +FIG00773513 FIG00773514: hypothetical protein +FIG00773514 FIG00773515: hypothetical protein +FIG00773519 FIG00773521: hypothetical protein +FIG00773521 FIG00773523: hypothetical protein +FIG00773523 FIG00773524: hypothetical protein +FIG00773526 FIG00773527: hypothetical protein +FIG00773533 FIG00773534: hypothetical protein +FIG00773534 FIG00773535: hypothetical protein +FIG00773539 FIG00773543: hypothetical protein +FIG00773546 FIG00773547: hypothetical protein +FIG00773547 FIG00773548: hypothetical protein +FIG00773548 FIG00773551: hypothetical protein +FIG00773562 FIG00773565: hypothetical protein +FIG00773572 FIG00773573: hypothetical protein +FIG00773573 FIG00773574: hypothetical protein +FIG00773577 FIG00773578: hypothetical protein +FIG00773582 FIG00773584: hypothetical protein +FIG00773584 FIG00773585: hypothetical protein +FIG00773585 FIG00773586: hypothetical protein +FIG00773608 FIG00773610: hypothetical protein +FIG00773613 FIG00773614: hypothetical protein +FIG00773614 FIG01116645: hypothetical protein +FIG00773617 FIG00773618: hypothetical protein +FIG00773618 FIG00773619: hypothetical protein +FIG00773619 FIG00773620: hypothetical protein +FIG00773620 FIG00773621: hypothetical protein +FIG00773628 FIG00773629: hypothetical protein +FIG00773630 FIG00773631: hypothetical protein +FIG00773635 FIG00773636: hypothetical protein +FIG00773638 FIG00773641: hypothetical protein +FIG00773642 FIG00773645: hypothetical protein +FIG00773649 FIG00773650: hypothetical protein +FIG00773650 FIG00773652: hypothetical protein +FIG00773653 ABC-type metal ion transport system, periplasmic component/surface adhesin +FIG00773665 FIG00773666: hypothetical protein +FIG00773672 FIG00773679: hypothetical protein +FIG00773679 FIG00773681: hypothetical protein +FIG00773682 FIG00773683: hypothetical protein +FIG00773691 FIG00773692: hypothetical protein +FIG00773695 FIG00773697: hypothetical protein +FIG00773697 FIG00773698: hypothetical protein +FIG00773718 FIG00773723: hypothetical protein +FIG00773723 FIG00773725: hypothetical protein +FIG00773725 FIG00773727: hypothetical protein +FIG00773727 FIG00773728: hypothetical protein +FIG00773728 FIG00773729: hypothetical protein +FIG00773729 FIG00773733: hypothetical protein +FIG00773746 FIG00773749: hypothetical protein +FIG00773750 FIG00773753: hypothetical protein +FIG00773756 FIG00773757: hypothetical protein +FIG00773757 Lactoylglutathione lyase related lyase +FIG00773766 FIG00773769: hypothetical protein +FIG00773774 FIG00773777: hypothetical protein +FIG00773777 FIG00773778: hypothetical protein +FIG00773779 FIG00773781: hypothetical protein +FIG00773781 FIG00773783: hypothetical protein +FIG00773783 FIG00773784: hypothetical protein +FIG00773784 FIG00773785: hypothetical protein +FIG00773790 FIG00773791: hypothetical protein +FIG00773794 FIG00773795: hypothetical protein +FIG00773795 Helix-turn-helix XRE-family like protein +FIG00773799 FIG00773027: hypothetical protein +FIG00773815 FIG00773817: hypothetical protein +FIG00773824 membrane protein +FIG00773831 FIG00773832: hypothetical protein +FIG00773832 two-component sensor histidine kinase-like protein +FIG00773838 FIG00773840: hypothetical protein +FIG00773856 FIG00773857: hypothetical protein +FIG00773858 FIG00773860: hypothetical protein +FIG00773860 FIG00773861: hypothetical protein +FIG00773864 FIG00773866: hypothetical protein +FIG00773866 FIG00773867: hypothetical protein +FIG00773867 FIG00773871: hypothetical protein +FIG00773875 FIG00773877: hypothetical protein +FIG00773885 FIG00773892: hypothetical protein +FIG00773901 FIG00773903: hypothetical protein +FIG00773903 FIG00773906: hypothetical protein +FIG00773908 FIG00773911: hypothetical protein +FIG00773915 FIG00773917: hypothetical protein +FIG00773928 FIG00773931: hypothetical protein +FIG00773955 FIG00773957: hypothetical protein +FIG00773957 FIG00773959: hypothetical protein +FIG00773968 FIG00773969: hypothetical protein +FIG00773969 FIG00773970: hypothetical protein +FIG00773976 FIG00773977: hypothetical protein +FIG00773977 transcription regulator of beta-galactosidase gene +FIG00773986 FIG00773990: hypothetical protein +FIG00774019 FIG00774020: hypothetical protein +FIG00774021 FIG00774022: hypothetical protein +FIG00774022 FIG00774023: hypothetical protein +FIG00774023 FIG00774025: hypothetical protein +FIG00774028 TPR domain protein +FIG00774029 FIG00774030: hypothetical protein +FIG00774030 FIG00774031: hypothetical protein +FIG00774031 FIG00774033: hypothetical protein +FIG00774033 FIG00774034: hypothetical protein +FIG00774034 FIG00774036: hypothetical protein +FIG00774036 FIG00774037: hypothetical protein +FIG00774037 FIG00774039: hypothetical protein +FIG00774039 FIG00774040: hypothetical protein +FIG00774040 FIG00774041: hypothetical protein +FIG00774041 FIG00774042: hypothetical protein +FIG00774042 FIG00774044: hypothetical protein +FIG00774044 FIG00774045: hypothetical protein +FIG00774045 FIG00774048: hypothetical protein +FIG00774048 FIG00774050: hypothetical protein +FIG00774050 FIG00774052: hypothetical protein +FIG00774052 Tetratricopeptide repeat (TPR) family protein +FIG00774053 FIG00774055: hypothetical protein +FIG00774055 FIG00774057: hypothetical protein +FIG00774060 FIG00774061: hypothetical protein +FIG00774061 FIG00774062: hypothetical protein +FIG00774062 Similar to terminase small subunit, yqaS homolog +FIG00774063 FIG00774066: hypothetical protein +FIG00774066 FIG00774067: hypothetical protein +FIG00774067 FIG00774068: hypothetical protein +FIG00774069 FIG00774070: hypothetical protein +FIG00774070 FIG00774071: hypothetical protein +FIG00774071 FIG00774072: hypothetical protein +FIG00774072 FIG00774074: hypothetical protein +FIG00774074 FIG042801: CBS domain containing protein +FIG00774075 FIG00774078: hypothetical protein +FIG00774079 FIG00774080: hypothetical protein +FIG00774081 FIG00774082: hypothetical protein +FIG00774082 FIG00774083: hypothetical protein +FIG00774083 FIG00774084: hypothetical protein +FIG00774084 FIG00774085: hypothetical protein +FIG00774085 FIG00774086: hypothetical protein +FIG00774087 FIG00774088: hypothetical protein +FIG00774088 FIG00774089: hypothetical protein +FIG00774089 FIG00774090: hypothetical protein +FIG00774090 FIG00774091: hypothetical protein +FIG00774091 FIG00774092: hypothetical protein +FIG00774092 FIG00774093: hypothetical protein +FIG00774093 FIG00774094: hypothetical protein +FIG00774094 FIG00774095: hypothetical protein +FIG00774097 FIG00774098: hypothetical protein +FIG00774098 FIG00774099: hypothetical protein +FIG00774099 FIG00774100: hypothetical protein +FIG00774100 FIG00774101: hypothetical protein +FIG00774101 FIG00774104: hypothetical protein +FIG00774104 FIG00774105: hypothetical protein +FIG00774105 FIG00774106: hypothetical protein +FIG00774106 FIG00774107: hypothetical protein +FIG00774107 FIG00774108: hypothetical protein +FIG00774109 FIG00774110: hypothetical protein +FIG00774110 FIG00774111: hypothetical protein +FIG00774111 FIG00774112: hypothetical protein +FIG00774112 FIG00774113: hypothetical protein +FIG00774113 FIG00774115: hypothetical protein +FIG00774115 FIG00774116: hypothetical protein +FIG00774117 FIG00774118: hypothetical protein +FIG00774118 FIG00774119: hypothetical protein +FIG00774119 FIG00774121: hypothetical protein +FIG00774121 FIG00774122: hypothetical protein +FIG00774122 FIG00774123: hypothetical protein +FIG00774123 FIG00774125: hypothetical protein +FIG00774128 FIG00774129: hypothetical protein +FIG00774129 FIG00774130: hypothetical protein +FIG00774130 FIG00774131: hypothetical protein +FIG00774132 similar to Antigen D +FIG00774134 FIG00774136: hypothetical protein +FIG00774136 FIG00774137: hypothetical protein +FIG00774138 FIG00774139: hypothetical protein +FIG00774139 FIG00774140: hypothetical protein +FIG00774140 FIG00774141: hypothetical protein +FIG00774141 FIG00774145: hypothetical protein +FIG00774145 FIG00774146: hypothetical protein +FIG00774146 FIG00774150: hypothetical protein +FIG00774151 FIG00774152: hypothetical protein +FIG00774152 FIG00774153: hypothetical protein +FIG00774153 FIG00774154: hypothetical protein +FIG00774154 FIG00774155: hypothetical protein +FIG00774155 FIG00774156: hypothetical protein +FIG00774156 FIG00774157: hypothetical protein +FIG00774157 FIG00774158: hypothetical protein +FIG00774160 FIG00774161: hypothetical protein +FIG00774161 FIG00774162: hypothetical protein +FIG00774162 FIG00774163: hypothetical protein +FIG00774163 FIG00774164: hypothetical protein +FIG00774164 FIG00774165: hypothetical protein +FIG00774165 FIG00774166: hypothetical protein +FIG00774166 FIG00774167: hypothetical protein +FIG00774168 FIG00774170: hypothetical protein +FIG00774170 FIG00774172: hypothetical protein +FIG00774172 FIG00774173: hypothetical protein +FIG00774173 FIG00774174: hypothetical protein +FIG00774174 FIG00774175: hypothetical protein +FIG00774176 FIG00774179: hypothetical protein +FIG00774179 FIG00774180: hypothetical protein +FIG00774180 FIG00774181: hypothetical protein +FIG00774181 FIG00774182: hypothetical protein +FIG00774183 FIG00774184: hypothetical protein +FIG00774184 FIG00774185: hypothetical protein +FIG00774185 FIG00774187: hypothetical protein +FIG00774187 FIG00774188: hypothetical protein +FIG00774189 FIG00774192: hypothetical protein +FIG00774192 FIG00774193: hypothetical protein +FIG00774193 FIG00774196: hypothetical protein +FIG00774196 FIG00774197: hypothetical protein +FIG00774197 FIG00774198: hypothetical protein +FIG00774198 FIG00774199: hypothetical protein +FIG00774200 FIG00774201: hypothetical protein +FIG00774201 FIG00774203: hypothetical protein +FIG00774203 FIG00774204: hypothetical protein +FIG00774204 FIG00774205: hypothetical protein +FIG00774209 FIG00774211: hypothetical protein +FIG00774211 FIG00774214: hypothetical protein +FIG00774214 FIG00774215: hypothetical protein +FIG00774215 FIG00774216: hypothetical protein +FIG00774216 FIG00774217: hypothetical protein +FIG00774217 FIG00774218: hypothetical protein +FIG00774218 FIG00775037: hypothetical protein +FIG00774219 FIG00774220: hypothetical protein +FIG00774220 FIG00774221: hypothetical protein +FIG00774222 FIG00774224: hypothetical protein +FIG00774224 FIG00774226: hypothetical protein +FIG00774226 FIG00774227: hypothetical protein +FIG00774227 FIG00774231: hypothetical protein +FIG00774231 FIG00774232: hypothetical protein +FIG00774232 FIG00774234: hypothetical protein +FIG00774234 FIG00774235: hypothetical protein +FIG00774235 FIG00774236: hypothetical protein +FIG00774236 FIG00774237: hypothetical protein +FIG00774237 FIG00774238: hypothetical protein +FIG00774238 FIG00774239: hypothetical protein +FIG00774239 FIG00774240: hypothetical protein +FIG00774242 FIG00774243: hypothetical protein +FIG00774243 FIG00774243: hypothetical protein YlaN +FIG00774245 FIG00774247: hypothetical protein +FIG00774247 FIG00774249: hypothetical protein +FIG00774249 FIG00774250: hypothetical protein +FIG00774250 FIG00774251: hypothetical protein +FIG00774251 FIG00774252: hypothetical protein +FIG00774252 FIG00774253: hypothetical protein +FIG00774253 FIG00774255: hypothetical protein +FIG00774255 FIG00774257: hypothetical protein +FIG00774257 FIG00774260: hypothetical protein +FIG00774260 FIG00774261: hypothetical protein +FIG00774261 FIG00774262: hypothetical protein +FIG00774262 FIG00774263: hypothetical protein +FIG00774263 FIG00774264: hypothetical protein +FIG00774264 FIG00774265: hypothetical protein +FIG00774265 FIG00774267: hypothetical protein +FIG00774267 FIG00774268: hypothetical protein +FIG00774268 FIG00774270: hypothetical protein +FIG00774270 FIG00774271: hypothetical protein +FIG00774271 FIG00774272: hypothetical protein +FIG00774272 FIG00774274: hypothetical protein +FIG00774274 FIG00774276: hypothetical protein +FIG00774276 FIG01228237: hypothetical protein +FIG00774277 FIG00774278: hypothetical protein +FIG00774278 FIG00774280: hypothetical protein +FIG00774280 FIG00774281: hypothetical protein +FIG00774281 FIG00774282: hypothetical protein +FIG00774282 FIG00774284: hypothetical protein +FIG00774284 FIG00774285: hypothetical protein +FIG00774286 FIG00774287: hypothetical protein +FIG00774287 FIG00774289: hypothetical protein +FIG00774289 FIG00774290: hypothetical protein +FIG00774290 FIG00774292: hypothetical protein +FIG00774292 FIG00774294: hypothetical protein +FIG00774294 FIG00774296: hypothetical protein +FIG00774297 FIG00774298: hypothetical protein +FIG00774298 ABC transporter membrane-spanning permease - glutamine transport +FIG00774299 FIG00774300: hypothetical protein +FIG00774300 FIG00774302: hypothetical protein +FIG00774302 FIG00774303: hypothetical protein +FIG00774303 FIG00774304: hypothetical protein +FIG00774304 FIG00774309: hypothetical protein +FIG00774309 FIG00774310: hypothetical protein +FIG00774310 FIG00774311: hypothetical protein +FIG00774311 FIG00774312: hypothetical protein +FIG00774313 FIG00774315: hypothetical protein +FIG00774315 FIG00774316: hypothetical protein +FIG00774316 FIG00774317: hypothetical protein +FIG00774317 FIG00774318: hypothetical protein +FIG00774318 FIG00774319: hypothetical protein +FIG00774319 hypothetical protein +FIG00774320 FIG00774322: hypothetical protein +FIG00774322 FIG00774323: hypothetical protein +FIG00774323 FIG00774324: hypothetical protein +FIG00774324 FIG00774325: hypothetical protein +FIG00774326 FIG00774327: hypothetical protein +FIG00774327 FIG00774329: hypothetical protein +FIG00774329 FIG00774330: hypothetical protein +FIG00774330 FIG00774331: hypothetical protein +FIG00774331 FIG00774332: hypothetical protein +FIG00774332 FIG00774333: hypothetical protein +FIG00774334 FIG00774335: hypothetical protein +FIG00774335 FIG00774336: hypothetical protein +FIG00774337 FIG00774338: hypothetical protein +FIG00774338 FIG00774340: hypothetical protein +FIG00774340 FIG00774343: hypothetical protein +FIG00774343 FIG00774344: hypothetical protein +FIG00774347 Aluminum resistance protein +FIG00774349 FIG00774350: hypothetical protein +FIG00774350 FIG00774351: hypothetical protein +FIG00774351 FIG00774353: hypothetical protein +FIG00774353 FIG00774354: hypothetical protein +FIG00774355 FIG00774356: hypothetical protein +FIG00774356 FIG00774358: hypothetical protein +FIG00774358 FIG00774361: hypothetical protein +FIG00774361 FIG00774362: hypothetical protein +FIG00774362 FIG00774364: hypothetical protein +FIG00774364 FIG00774365: hypothetical protein +FIG00774365 FIG00774366: hypothetical protein +FIG00774367 FIG00774369: hypothetical protein +FIG00774369 FIG00774370: hypothetical protein +FIG00774370 FIG00774371: hypothetical protein +FIG00774373 FIG00774374: hypothetical protein +FIG00774374 FIG00774375: hypothetical protein +FIG00774377 FIG00774379: hypothetical protein +FIG00774379 FIG00774380: hypothetical protein +FIG00774380 Bile acid 7-alpha dehydratase BaiE (EC 4.2.1.106) +FIG00774381 FIG00774383: hypothetical protein +FIG00774383 FIG00774386: hypothetical protein +FIG00774386 FIG00774388: hypothetical protein +FIG00774388 FIG00774389: hypothetical protein +FIG00774389 FIG00774390: hypothetical protein +FIG00774392 FIG00774393: hypothetical protein +FIG00774393 FIG00774394: hypothetical protein +FIG00774394 FIG00774397: hypothetical protein +FIG00774397 Prophage Lp1 protein 1, integrase +FIG00774398 FIG00774399: hypothetical protein +FIG00774399 FIG00774400: hypothetical protein +FIG00774400 FIG00774402: hypothetical protein +FIG00774403 FIG00774405: hypothetical protein +FIG00774405 FIG00774406: hypothetical protein +FIG00774406 FIG00774407: hypothetical protein +FIG00774407 FIG00774408: hypothetical protein +FIG00774408 FIG00774409: hypothetical protein +FIG00774410 FIG00774411: hypothetical protein +FIG00774412 FIG00774413: hypothetical protein +FIG00774413 FIG00774415: hypothetical protein +FIG00774415 FIG00774416: hypothetical protein +FIG00774416 FIG00774418: hypothetical protein +FIG00774418 FIG00774419: hypothetical protein +FIG00774424 FIG00774426: hypothetical protein +FIG00774426 FIG00774428: hypothetical protein +FIG00774428 FIG00774429: hypothetical protein +FIG00774429 FIG00774432: hypothetical protein +FIG00774432 FIG00774433: hypothetical protein +FIG00774433 FIG00774434: hypothetical protein +FIG00774434 FIG00774435: hypothetical protein +FIG00774437 hypothetical protein +FIG00774438 FIG00774440: hypothetical protein +FIG00774441 FIG00774444: hypothetical protein +FIG00774444 FIG00774445: hypothetical protein +FIG00774445 FIG00774446: hypothetical protein +FIG00774446 FIG00774447: hypothetical protein +FIG00774447 FIG00774449: hypothetical protein +FIG00774450 FIG00774451: hypothetical protein +FIG00774451 FIG00774452: hypothetical protein +FIG00774454 FIG00774455: hypothetical protein +FIG00774455 FIG00774456: hypothetical protein +FIG00774456 FIG00774463: hypothetical protein +FIG00774463 FIG00774464: hypothetical protein +FIG00774464 FIG00774465: hypothetical protein +FIG00774465 FIG00774466: hypothetical protein +FIG00774466 FIG00774468: hypothetical protein +FIG00774468 FIG00774469: hypothetical protein +FIG00774469 FIG00774471: hypothetical protein +FIG00774474 FIG00774475: hypothetical protein +FIG00774475 FIG00774476: hypothetical protein +FIG00774476 FIG00774477: hypothetical protein +FIG00774477 FIG00774478: hypothetical protein +FIG00774478 FIG00774480: hypothetical protein +FIG00774481 FIG00774482: hypothetical protein +FIG00774486 FIG00774487: hypothetical protein +FIG00774487 FIG00774488: hypothetical protein +FIG00774488 FIG00774489: hypothetical protein +FIG00774489 FIG00774490: hypothetical protein +FIG00774492 FIG00774495: hypothetical protein +FIG00774495 FIG00774496: hypothetical protein +FIG00774496 FIG00774500: hypothetical protein +FIG00774500 FIG00774503: hypothetical protein +FIG00774503 FIG00774504: hypothetical protein +FIG00774504 FIG00774507: hypothetical protein +FIG00774509 FIG00774511: hypothetical protein +FIG00774511 FIG00774512: hypothetical protein +FIG00774512 FIG00774513: hypothetical protein +FIG00774513 FIG00774514: hypothetical protein +FIG00774514 FIG00774515: hypothetical protein +FIG00774515 FIG00774516: hypothetical protein +FIG00774516 FIG00774517: hypothetical protein +FIG00774517 FIG00774518: hypothetical protein +FIG00774518 FIG00774519: hypothetical protein +FIG00774519 FIG00774520: hypothetical protein +FIG00774520 FIG00774521: hypothetical protein +FIG00774522 FIG00774523: hypothetical protein +FIG00774523 FIG00774524: hypothetical protein +FIG00774524 FIG00774525: hypothetical protein +FIG00774525 FIG00774528: hypothetical protein +FIG00774528 FIG00774529: hypothetical protein +FIG00774529 FIG00774531: hypothetical protein +FIG00774531 FIG00774533: hypothetical protein +FIG00774533 FIG00774534: hypothetical protein +FIG00774534 Potassium uptake protein, integral membrane component, KtrD +FIG00774536 FIG00774538: hypothetical protein +FIG00774538 FIG00774540: hypothetical protein +FIG00774542 FIG00774543: hypothetical protein +FIG00774546 FIG00774549: hypothetical protein +FIG00774549 FIG007350: hypothetical protein co-occurring with bile hydrolase +FIG00774550 FIG00774551: hypothetical protein +FIG00774551 hypothetical protein +FIG00774552 FIG00774553: hypothetical protein +FIG00774553 FIG00774554: hypothetical protein +FIG00774555 FIG00774559: hypothetical protein +FIG00774559 FIG00774560: hypothetical protein +FIG00774560 FIG00774562: hypothetical protein +FIG00774562 FIG00774563: hypothetical protein +FIG00774563 FIG00774565: hypothetical protein +FIG00774565 FIG00774566: hypothetical protein +FIG00774566 FIG00774569: hypothetical protein +FIG00774569 FIG00774571: hypothetical protein +FIG00774571 FIG00774573: hypothetical protein +FIG00774576 FIG00774578: hypothetical protein +FIG00774580 FIG00774581: hypothetical protein +FIG00774581 FIG00774582: hypothetical protein +FIG00774582 aminoglycoside phosphotransferase family protein +FIG00774590 FIG00774592: hypothetical protein +FIG00774592 FIG00774594: hypothetical protein +FIG00774594 FIG00774597: hypothetical protein +FIG00774597 FIG00774599: hypothetical protein +FIG00774600 FIG00774601: hypothetical protein +FIG00774601 FIG00774602: hypothetical protein +FIG00774602 PTS system, IIB component (EC 2.7.1.69) / PTS system, IIC component (EC 2.7.1.69) +FIG00774604 FIG00774605: hypothetical protein +FIG00774605 FIG00774607: hypothetical protein +FIG00774607 Amino acid ABC transporter, amino acid-binding protein +FIG00774610 FIG00774615: hypothetical protein +FIG00774615 FIG00774616: hypothetical protein +FIG00774617 FIG00774618: hypothetical protein +FIG00774618 FIG00774619: hypothetical protein +FIG00774619 FIG00774621: hypothetical protein +FIG00774621 FIG00774622: hypothetical protein +FIG00774622 FIG00774623: hypothetical protein +FIG00774623 FIG00774624: hypothetical protein +FIG00774624 FIG00774625: hypothetical protein +FIG00774625 FIG00774626: hypothetical protein +FIG00774626 FIG00774627: hypothetical protein +FIG00774635 FIG00774636: hypothetical protein +FIG00774636 FIG00774637: hypothetical protein +FIG00774637 FIG00774638: hypothetical protein +FIG00774638 FIG00774639: hypothetical protein +FIG00774639 FIG00774640: hypothetical protein +FIG00774640 FIG00774641: hypothetical protein +FIG00774642 FIG00774643: hypothetical protein +FIG00774645 FIG00774646: hypothetical protein +FIG00774646 FIG00774648: hypothetical protein +FIG00774649 FIG00774650: hypothetical protein +FIG00774650 FIG00774651: hypothetical protein +FIG00774651 FIG00774656: hypothetical protein +FIG00774656 FIG00774658: hypothetical protein +FIG00774658 FIG00774659: hypothetical protein +FIG00774659 FIG00774661: hypothetical protein +FIG00774661 FIG00774662: hypothetical protein +FIG00774662 FIG00774663: hypothetical protein +FIG00774663 FIG00774666: hypothetical protein +FIG00774666 FIG00774668: hypothetical protein +FIG00774668 FIG00774672: hypothetical protein +FIG00774672 FIG00774673: hypothetical protein +FIG00774674 FIG00774675: hypothetical protein +FIG00774675 FIG00774676: hypothetical protein +FIG00774676 FIG00774678: hypothetical protein +FIG00774678 FIG00774680: hypothetical protein +FIG00774684 FIG00774685: hypothetical protein +FIG00774685 FIG00774686: hypothetical protein +FIG00774686 FIG00774687: hypothetical protein +FIG00774689 FIG00774691: hypothetical protein +FIG00774692 FIG00774695: hypothetical protein +FIG00774695 FIG00774697: hypothetical protein +FIG00774697 FIG00774698: hypothetical protein +FIG00774698 FIG00774699: hypothetical protein +FIG00774700 FIG00774701: hypothetical protein +FIG00774702 FIG00774703: hypothetical protein +FIG00774703 FIG00774705: hypothetical protein +FIG00774705 FIG00774706: hypothetical protein +FIG00774706 FIG00774708: hypothetical protein +FIG00774708 FIG00774709: hypothetical protein +FIG00774709 FIG00774711: hypothetical protein +FIG00774717 FIG00774719: hypothetical protein +FIG00774719 FIG00774720: hypothetical protein +FIG00774720 FIG00774721: hypothetical protein +FIG00774721 FIG00774722: hypothetical protein +FIG00774723 FIG00774724: hypothetical protein +FIG00774724 prophage LambdaBa01, positive control factor Xpf, putative +FIG00774726 FIG00774727: hypothetical protein +FIG00774727 FIG00774728: hypothetical protein +FIG00774728 FIG00774729: hypothetical protein +FIG00774729 FIG00774730: hypothetical protein +FIG00774730 FIG00774732: hypothetical protein +FIG00774732 FIG00774733: hypothetical protein +FIG00774734 FIG00774737: hypothetical protein +FIG00774737 FIG00774738: hypothetical protein +FIG00774738 FIG00774739: hypothetical protein +FIG00774743 FIG00774744: hypothetical protein +FIG00774744 FIG00774745: hypothetical protein +FIG00774745 FIG00774746: hypothetical protein +FIG00774746 FIG00774748: hypothetical protein +FIG00774748 FIG00774749: hypothetical protein +FIG00774749 Putative peptidoglycan bound protein (LPXTG motif) Lmo0160 homolog +FIG00774750 FIG00774752: hypothetical protein +FIG00774754 FIG00774755: hypothetical protein +FIG00774755 FIG00774758: hypothetical protein +FIG00774762 FIG00774763: hypothetical protein +FIG00774763 FIG00774764: hypothetical protein +FIG00774766 DNA primase/helicase, phage-associated +FIG00774767 FIG00774770: hypothetical protein +FIG00774770 FIG00774771: hypothetical protein +FIG00774771 FIG00774772: hypothetical protein +FIG00774775 FIG00774776: hypothetical protein +FIG00774776 FIG00774777: hypothetical protein +FIG00774779 FIG00774780: hypothetical protein +FIG00774780 FIG00774781: hypothetical protein +FIG00774781 FIG00774782: hypothetical protein +FIG00774782 FIG00774783: hypothetical protein +FIG00774783 FIG00774784: hypothetical protein +FIG00774784 FIG00774785: hypothetical protein +FIG00774786 FIG00774790: hypothetical protein +FIG00774790 FIG00774792: hypothetical protein +FIG00774792 FIG00774793: hypothetical protein +FIG00774794 FIG00774796: hypothetical protein +FIG00774796 FIG00774797: hypothetical protein +FIG00774797 FIG00774798: hypothetical protein +FIG00774800 FIG00774801: hypothetical protein +FIG00774801 FIG00774802: hypothetical protein +FIG00774802 FIG00774803: hypothetical protein +FIG00774803 FIG00774804: hypothetical protein +FIG00774804 FIG00774805: hypothetical protein +FIG00774805 FIG00774806: hypothetical protein +FIG00774807 FIG00774809: hypothetical protein +FIG00774811 FIG00774812: hypothetical protein +FIG00774812 FIG00774814: hypothetical protein +FIG00774815 FIG01227614: hypothetical protein +FIG00774823 Conservative hypothetical protein probably involved in hydantoin, pyrimidine utilization +FIG00774824 FIG00774825: hypothetical protein +FIG00774825 FIG00774826: hypothetical protein +FIG00774826 FIG00774827: hypothetical protein +FIG00774827 FIG00774828: hypothetical protein +FIG00774828 FIG00774829: hypothetical protein +FIG00774829 FIG00774830: hypothetical protein +FIG00774830 FIG00774832: hypothetical protein +FIG00774832 FIG00774834: hypothetical protein +FIG00774834 FIG00774835: hypothetical protein +FIG00774835 FIG00774837: hypothetical protein +FIG00774837 FIG00774840: hypothetical protein +FIG00774840 FIG00774842: hypothetical protein +FIG00774843 FIG00774844: hypothetical protein +FIG00774844 FIG00774847: hypothetical protein +FIG00774847 FIG00774848: hypothetical protein +FIG00774849 FIG00774850: hypothetical protein +FIG00774850 FIG00774856: hypothetical protein +FIG00774856 FIG00774857: hypothetical protein +FIG00774857 FIG00774858: hypothetical protein +FIG00774859 FIG00774862: hypothetical protein +FIG00774863 FIG00774864: hypothetical protein +FIG00774864 FIG00774865: hypothetical protein +FIG00774865 FIG00774866: hypothetical protein +FIG00774870 FIG00774878: hypothetical protein +FIG00774882 FIG00774885: hypothetical protein +FIG00774885 FIG00774886: hypothetical protein +FIG00774886 FIG00774888: hypothetical protein +FIG00774888 FIG00774889: hypothetical protein +FIG00774889 FIG00774890: hypothetical protein +FIG00774890 Transcriptional regulator, repressor of the glutamine synthetase, MerR family +FIG00774891 FIG00774894: hypothetical protein +FIG00774894 FIG00774895: hypothetical protein +FIG00774895 FIG00774897: hypothetical protein +FIG00774897 FIG019766: hypothetical protein co-occurring with bile hydrolase +FIG00774898 FIG00774899: hypothetical protein +FIG00774899 FIG00774903: hypothetical protein +FIG00774903 FIG00774904: hypothetical protein +FIG00774904 FIG00774908: hypothetical protein +FIG00774908 FIG00774911: hypothetical protein +FIG00774911 FIG00774912: hypothetical protein +FIG00774912 FIG00774914: hypothetical protein +FIG00774920 FIG00774921: hypothetical protein +FIG00774921 FIG00774922: hypothetical protein +FIG00774925 FIG00774927: hypothetical protein +FIG00774927 FIG00774928: hypothetical protein +FIG00774928 FIG00774929: hypothetical protein +FIG00774934 FIG00774935: hypothetical protein +FIG00774935 FIG00774936: hypothetical protein +FIG00774936 FIG00774937: hypothetical protein +FIG00774937 FIG00774940: hypothetical protein +FIG00774942 Lmo1671 protein +FIG00774948 FIG00774949: hypothetical protein +FIG00774949 FIG00774950: hypothetical protein +FIG00774950 FIG00774951: hypothetical protein +FIG00774955 FIG00774959: hypothetical protein +FIG00774959 FIG00774960: hypothetical protein +FIG00774963 FIG00774965: hypothetical protein +FIG00774965 FIG00774967: hypothetical protein +FIG00774967 FIG00774968: hypothetical protein +FIG00774970 FIG00774972: hypothetical protein +FIG00774974 FIG00774977: hypothetical protein +FIG00774980 FIG00774981: hypothetical protein +FIG00774981 FIG00774984: hypothetical protein +FIG00774984 FIG00774986: hypothetical protein +FIG00774986 FIG00774988: hypothetical protein +FIG00774988 FIG00774989: hypothetical protein +FIG00774989 FIG00774991: hypothetical protein +FIG00774991 FIG00774993: hypothetical protein +FIG00774993 FIG00774996: hypothetical protein +FIG00774997 FIG00774998: hypothetical protein +FIG00774998 FIG00774999: hypothetical protein +FIG00774999 FIG00775001: hypothetical protein +FIG00775003 Gp31 protein +FIG00775005 FIG00775008: hypothetical protein +FIG00775008 FIG00775010: hypothetical protein +FIG00775010 FIG00775013: hypothetical protein +FIG00775015 FIG00775016: hypothetical protein +FIG00775016 FIG00775017: hypothetical protein +FIG00775017 FIG00775018: hypothetical protein +FIG00775020 FIG00775022: hypothetical protein +FIG00775025 FIG00775026: hypothetical protein +FIG00775026 FIG00775029: hypothetical protein +FIG00775032 FIG00775033: hypothetical protein +FIG00775033 FIG00775034: hypothetical protein +FIG00775034 FIG00775035: hypothetical protein +FIG00775041 FIG00775048: hypothetical protein +FIG00775048 FIG00775051: hypothetical protein +FIG00775051 FIG00775054: hypothetical protein +FIG00775055 FIG00775057: hypothetical protein +FIG00775060 FIG00775064: hypothetical protein +FIG00775064 FIG00775065: hypothetical protein +FIG00775065 FIG00775066: hypothetical protein +FIG00775069 FIG00775072: hypothetical protein +FIG00775072 FIG00775073: hypothetical protein +FIG00775073 FIG00775074: hypothetical protein +FIG00775074 FIG00775077: hypothetical protein +FIG00775077 FIG00775078: hypothetical protein +FIG00775079 FIG00775080: hypothetical protein +FIG00775080 FIG00775084: hypothetical protein +FIG00775085 FIG00775087: hypothetical protein +FIG00775089 hypothetical protein +FIG00775093 FIG00775095: hypothetical protein +FIG00775097 FIG00775099: hypothetical protein +FIG00775099 FIG00775101: hypothetical protein +FIG00775101 FIG00775102: hypothetical protein +FIG00775102 FIG00775105: hypothetical protein +FIG00775105 FIG00775106: hypothetical protein +FIG00775106 FIG00775107: hypothetical protein +FIG00775107 FIG00775108: hypothetical protein +FIG00775108 FIG00775109: hypothetical protein +FIG00775111 FIG00775112: hypothetical protein +FIG00775113 FIG00775116: hypothetical protein +FIG00775116 FIG00775121: hypothetical protein +FIG00775121 FIG00775122: hypothetical protein +FIG00775122 FIG00775125: hypothetical protein +FIG00775125 FIG00775127: hypothetical protein +FIG00775127 FIG00775131: hypothetical protein +FIG00775133 FIG00775136: hypothetical protein +FIG00775140 FIG00775141: hypothetical protein +FIG00775142 FIG00775143: hypothetical protein +FIG00775151 FIG00775152: hypothetical protein +FIG00775154 hypothetical protein +FIG00775157 FIG00775160: hypothetical protein +FIG00775166 FIG00775172: hypothetical protein +FIG00775172 FIG00775174: hypothetical protein +FIG00775175 FIG00775176: hypothetical protein +FIG00775176 FIG00775178: hypothetical protein +FIG00775178 DNA-dependent ATPase, putative +FIG00775181 FIG00775182: hypothetical protein +FIG00775182 FIG00775185: hypothetical protein +FIG00775185 FIG00775187: hypothetical protein +FIG00775187 FIG00775193: hypothetical protein +FIG00775193 Protein gp32 [Listeria phage 2389] +FIG00775194 FIG00775196: hypothetical protein +FIG00775196 FIG00775202: hypothetical protein +FIG00775202 FIG00775203: hypothetical protein +FIG00775203 FIG00775204: hypothetical protein +FIG00775204 FIG00775205: hypothetical protein +FIG00775205 FIG00775207: hypothetical protein +FIG00775208 FIG00775209: hypothetical protein +FIG00775209 FIG00775210: hypothetical protein +FIG00775210 FIG00775212: hypothetical protein +FIG00775212 FIG00775213: hypothetical protein +FIG00775213 FIG00775214: hypothetical protein +FIG00775214 FIG00775215: hypothetical protein +FIG00775215 FIG00775218: hypothetical protein +FIG00775218 FIG00775219: hypothetical protein +FIG00775219 FIG00775220: hypothetical protein +FIG00775220 FIG00775222: hypothetical protein +FIG00775225 FIG00775226: hypothetical protein +FIG00775226 FIG00775228: hypothetical protein +FIG00775233 FIG00775234: hypothetical protein +FIG00775236 FIG00775237: hypothetical protein +FIG00775237 FIG00775239: hypothetical protein +FIG00775242 FIG00775247: hypothetical protein +FIG00775247 FIG00775248: hypothetical protein +FIG00775249 hypothetical protein +FIG00775259 FIG00775260: hypothetical protein +FIG00775263 FIG00775266: hypothetical protein +FIG00775266 FIG00775267: hypothetical protein +FIG00775267 FIG00775268: hypothetical protein +FIG00775268 hypothetical protein +FIG00775270 FIG00775271: hypothetical protein +FIG00775273 FIG00775274: hypothetical protein +FIG00775274 FIG00775278: hypothetical protein +FIG00775289 FIG00775290: hypothetical protein +FIG00775290 FIG00775291: hypothetical protein +FIG00775291 FIG00775292: hypothetical protein +FIG00775292 FIG00775295: hypothetical protein +FIG00775299 FIG00775302: hypothetical protein +FIG00775302 FIG00775304: hypothetical protein +FIG00775304 FIG00775306: hypothetical protein +FIG00775306 FIG00775309: hypothetical protein +FIG00775311 FIG00775314: hypothetical protein +FIG00775314 FIG00775315: hypothetical protein +FIG00775315 FIG00775316: hypothetical protein +FIG00775320 FIG00775322: hypothetical protein +FIG00775322 FIG00775325: hypothetical protein +FIG00775325 FIG00775328: hypothetical protein +FIG00775328 hypothetical protein +FIG00775329 FIG00775330: hypothetical protein +FIG00775330 FIG00775331: hypothetical protein +FIG00775331 FIG00775333: hypothetical protein +FIG00775333 FIG00775334: hypothetical protein +FIG00775338 FIG00775341: hypothetical protein +FIG00775341 FIG00775346: hypothetical protein +FIG00775354 FIG00775356: hypothetical protein +FIG00775356 FIG00775358: hypothetical protein +FIG00775358 Septation ring formation regulator EzrA +FIG00775359 FIG00775360: hypothetical protein +FIG00775360 FIG00775361: hypothetical protein +FIG00775361 FIG00775362: hypothetical protein +FIG00775362 FIG00775363: hypothetical protein +FIG00775369 TPA: TPA_exp: hypothetical protein NT01LM0494 +FIG00775370 FIG00775371: hypothetical protein +FIG00775373 FIG00775375: hypothetical protein +FIG00775381 FIG00775383: hypothetical protein +FIG00775383 FIG00775387: hypothetical protein +FIG00775390 FIG00775392: hypothetical protein +FIG00775392 FIG00775393: hypothetical protein +FIG00775393 FIG00775394: hypothetical protein +FIG00775394 FIG00775399: hypothetical protein +FIG00775399 FIG036446: hypothetical protein +FIG00775408 sugar ABC transport system, permease protein +FIG00775411 FIG00775412: hypothetical protein +FIG00775412 FIG00775413: hypothetical protein +FIG00775420 FIG01231397: hypothetical protein +FIG00775422 Lin1768 protein +FIG00775423 FIG00775424: hypothetical protein +FIG00775433 FIG00775436: hypothetical protein +FIG00775441 FIG00775444: hypothetical protein +FIG00775448 FIG00775449: hypothetical protein +FIG00775455 FIG00775456: hypothetical protein +FIG00775456 FIG00775457: hypothetical protein +FIG00775460 FIG00775461: hypothetical protein +FIG00775461 FIG00775463: hypothetical protein +FIG00775468 FIG00775474: hypothetical protein +FIG00775481 FIG00775482: hypothetical protein +FIG00775489 FIG00775494: hypothetical protein +FIG00775504 FIG00775505: hypothetical protein +FIG00775508 FIG00775511: hypothetical protein +FIG00775511 FIG00775513: hypothetical protein +FIG00775519 FIG00775521: hypothetical protein +FIG00775523 FIG00775524: hypothetical protein +FIG00775525 FIG00775527: hypothetical protein +FIG00775527 FIG00775528: hypothetical protein +FIG00775528 FIG00775532: hypothetical protein +FIG00775536 FIG00775540: hypothetical protein +FIG00775544 Holin, phage phi LC3 family +FIG00775545 FIG00775546: hypothetical protein +FIG00775549 phage minor structural protein, N-terminal region domain protein +FIG00775551 FIG00775553: hypothetical protein +FIG00775554 FIG00775555: hypothetical protein +FIG00775555 FIG00775557: hypothetical protein +FIG00775563 FIG00775564: hypothetical protein +FIG00775567 FIG00775573: hypothetical protein +FIG00775573 FIG00775574: hypothetical protein +FIG00775585 FIG00775593: hypothetical protein +FIG00775594 FIG00775597: hypothetical protein +FIG00775598 Lin1238 protein +FIG00775600 FIG00775603: hypothetical protein +FIG00775611 FIG00775613: hypothetical protein +FIG00775616 FIG00775618: hypothetical protein +FIG00775618 FIG00775619: hypothetical protein +FIG00775619 FIG00775620: hypothetical protein +FIG00775625 FIG00775635: hypothetical protein +FIG00775637 FIG00775639: hypothetical protein +FIG00775648 hypothetical protein +FIG00775649 FIG00775650: hypothetical protein +FIG00775651 FIG00775656: hypothetical protein +FIG00775657 FIG00775658: hypothetical protein +FIG00775662 FIG00775663: hypothetical protein +FIG00775668 FIG00775669: hypothetical protein +FIG00775669 FIG00775670: hypothetical protein +FIG00775671 FIG00775678: hypothetical protein +FIG00775678 FIG00775679: hypothetical protein +FIG00775679 FIG00775680: hypothetical protein +FIG00775703 FIG00775710: hypothetical protein +FIG00775710 FIG00775711: hypothetical protein +FIG00775719 FIG00775722: hypothetical protein +FIG00775727 FIG00775728: hypothetical protein +FIG00775729 FIG00775651: hypothetical protein +FIG00775730 FIG00775731: hypothetical protein +FIG00775735 FIG00775736: hypothetical protein +FIG00775738 FIG00775742: hypothetical protein +FIG00775742 FIG00775743: hypothetical protein +FIG00775743 hypothetical protein +FIG00775751 FIG00775752: hypothetical protein +FIG00775753 FIG00775758: hypothetical protein +FIG00775764 FIG00775767: hypothetical protein +FIG00775767 FIG00775770: hypothetical protein +FIG00775772 FIG00775775: hypothetical protein +FIG00775775 FIG00775776: hypothetical protein +FIG00775788 FIG00775790: hypothetical protein +FIG00775800 FIG00775801: hypothetical protein +FIG00775814 hypothetical protein +FIG00775821 FIG00775830: hypothetical protein +FIG00775833 FIG00775834: hypothetical protein +FIG00775835 FIG00775836: hypothetical protein +FIG00775836 FIG00775837: hypothetical protein +FIG00775840 FIG00775849: hypothetical protein +FIG00775849 hypothetical protein +FIG00775855 FIG00775856: hypothetical protein +FIG00775857 FIG00775859: hypothetical protein +FIG00775859 hypothetical protein +FIG00775865 FIG00775866: hypothetical protein +FIG00775877 FIG00775880: hypothetical protein +FIG00775885 hypothetical protein +FIG00775891 FIG00775896: hypothetical protein +FIG00775896 FIG00775897: hypothetical protein +FIG00775897 FIG00775917: hypothetical protein +FIG00775924 FIG00775927: hypothetical protein +FIG00775927 FIG00775928: hypothetical protein +FIG00775937 FIG00775940: hypothetical protein +FIG00775949 Lin2383 protein +FIG00775956 FIG00775957: hypothetical protein +FIG00775957 FIG00775959: hypothetical protein +FIG00775959 FIG00775960: hypothetical protein +FIG00775966 FIG00775972: hypothetical protein +FIG00775980 FIG00775987: hypothetical protein +FIG00775988 FIG00775993: hypothetical protein +FIG00775998 FIG00775999: hypothetical protein +FIG00776000 FIG00776004: hypothetical protein +FIG00776004 FIG00776007: hypothetical protein +FIG00776007 FIG00776009: hypothetical protein +FIG00776019 FIG00776020: hypothetical protein +FIG00776020 FIG00776024: hypothetical protein +FIG00776027 FIG00776029: hypothetical protein +FIG00776039 FIG00776040: hypothetical protein +FIG00776040 FIG00776043: hypothetical protein +FIG00776058 FIG00776061: hypothetical protein +FIG00776063 FIG00776066: hypothetical protein +FIG00776084 FIG00776087: hypothetical protein +FIG00776087 FIG00776090: hypothetical protein +FIG00776090 FIG00776091: hypothetical protein +FIG00776094 FIG00776104: hypothetical protein +FIG00776104 FIG00776108: hypothetical protein +FIG00776115 FIG00776116: hypothetical protein +FIG00776116 FIG00776119: hypothetical protein +FIG00776138 FIG00776139: hypothetical protein +FIG00776162 hypothetical protein +FIG00776167 FIG00776168: hypothetical protein +FIG00776183 FIG00776187: hypothetical protein +FIG00776193 FIG00776198: hypothetical protein +FIG00776203 FIG00776206: hypothetical protein +FIG00776207 FIG00776209: hypothetical protein +FIG00776214 FIG00776219: hypothetical protein +FIG00776260 FIG00776263: hypothetical protein +FIG00776307 hypothetical protein +FIG00776312 FIG00776313: hypothetical protein +FIG00776335 FIG00776338: hypothetical protein +FIG00776343 FIG00776352: hypothetical protein +FIG00776361 FIG00776372: hypothetical protein +FIG00776375 D-glutamyl-L-m-Dpm peptidase P45; Peptidoglycan lytic protein P45 +FIG00776391 FIG00776397: hypothetical protein +FIG00776412 FIG00776421: hypothetical protein +FIG00776426 Protein gp63 [Bacteriophage A118] +FIG00776427 FIG00776428: hypothetical protein +FIG00776441 FIG00776451: hypothetical protein +FIG00776453 FIG00776455: hypothetical protein +FIG00776457 FIG00776461: hypothetical protein +FIG00776526 FIG00776527: hypothetical protein +FIG00776534 CPN protein +FIG00776542 FIG00776553: hypothetical protein +FIG00776589 COGs COG2343 +FIG00776622 FIG00776626: hypothetical protein +FIG00776635 FIG00917791: hypothetical protein +FIG00776639 DNA primase domain protein +FIG00776644 FIG00776648: hypothetical protein +FIG00776734 FIG00993026: hypothetical protein +FIG00776762 FIG00992944: hypothetical protein +FIG00776793 Probable amino-acid binding protein for ABC transporter system +FIG00776874 FIG00776878: hypothetical protein +FIG00776904 FIG00993253: hypothetical protein +FIG00776949 Aminomethyl transferase family protein +FIG00776977 FIG01073677: hypothetical protein +FIG00776982 FIG00776997: hypothetical protein +FIG00776997 FIG00992753: hypothetical protein +FIG00777097 FIG00777098: hypothetical protein +FIG00777098 FIG00777107: hypothetical protein +FIG00777120 Bll2366 protein +FIG00777130 FIG00777134: hypothetical protein +FIG00777143 FIG00992365: hypothetical protein +FIG00777164 FIG00777194: hypothetical protein +FIG00777255 FIG00777257: hypothetical protein +FIG00777257 FIG00777264: hypothetical protein +FIG00777264 FIG00777270: hypothetical protein +FIG00777542 putative cytochrome b +FIG00777643 COGs COG2378 +FIG00777683 Anti-sigma-factor antagonist +FIG00777729 Rubredoxin-type Fe(Cys)4 protein +FIG00777958 Methyl-accepting chemotaxis sensory transducer +FIG00778097 CiaB PROTEIN +FIG00778231 FIG00778235: hypothetical protein +FIG00778275 Sporulation domain protein precursor +FIG00778283 cytochrome b561 +FIG00778312 FIG00778314: hypothetical protein +FIG00778356 FIG00778362: hypothetical protein +FIG00778398 Magnetosome protein MamP, serine protease +FIG00778473 Type IV pilus assembly PilZ +FIG00778542 Anion transporter +FIG00778682 UPF0422 protein CBU_0937 precursor +FIG00778729 Membrane-fusion protein-like +FIG00778850 Adenine-specific DNA methylase containing a Zn-ribbon +FIG00778928 Resolvase, N-terminal domain +FIG00779024 FIG00779029: hypothetical protein +FIG00779034 conserved hypothetical protein, potential methyltransferase +FIG00779100 FIG00779102: hypothetical protein +FIG00779102 FIG00779104: hypothetical protein +FIG00779114 FIG00779116: hypothetical protein +FIG00779121 FIG00779123: hypothetical protein +FIG00779126 FIG00779127: hypothetical protein +FIG00779128 Bll0505 protein +FIG00779132 FIG00779133: hypothetical protein +FIG00779145 FIG00779148: hypothetical protein +FIG00779165 FIG00779168: hypothetical protein +FIG00779182 Magnetosome protein MamC +FIG00779189 FIG00779190: hypothetical protein +FIG00779190 FIG00779191: hypothetical protein +FIG00779191 FIG00779197: hypothetical protein +FIG00779204 FIG00779206: hypothetical protein +FIG00779208 FIG00779209: hypothetical protein +FIG00779209 FIG00779211: hypothetical protein +FIG00779214 FIG00779215: hypothetical protein +FIG00779225 FIG01012879: hypothetical protein +FIG00779230 FIG00779234: hypothetical protein +FIG00779234 Penicillin acylase II precursor (EC 3.5.1.11) +FIG00779237 blr7855; hypothetical protein +FIG00779240 FIG00779241: hypothetical protein +FIG00779243 Magnetosome protein MamX +FIG00779244 FIG00779245: hypothetical protein +FIG00779262 FIG01122965: hypothetical protein +FIG00779282 FIG00779285: hypothetical protein +FIG00779287 FIG00779288: hypothetical protein +FIG00779289 FIG00779291: hypothetical protein +FIG00779303 FIG00779304: hypothetical protein +FIG00779307 FIG00779309: hypothetical protein +FIG00779330 FIG00779336: hypothetical protein +FIG00779338 Mll4708 protein +FIG00779382 bll4252; putative hydrolase +FIG00779395 NAD(+)--dinitrogen-reductase ADP-D-ribosyltransferase (EC 2.4.2.37) +FIG00779400 Uncharacterized protein containing LysM domain +FIG00779449 blr2286; hypothetical protein +FIG00779452 FIG00779453: hypothetical protein +FIG00779460 FIG00779463: hypothetical protein +FIG00779476 FIG00779477: hypothetical protein +FIG00779481 FIG00779485: hypothetical protein +FIG00779487 FIG00779491: hypothetical protein +FIG00779523 FIG00779524: hypothetical protein +FIG00779549 FIG00779551: hypothetical protein +FIG00779561 FIG00779564: hypothetical protein +FIG00779565 COG1714: Predicted membrane protein/domain +FIG00779567 Magnetosome protein MamY +FIG00779629 Magnetosome protein MamJ +FIG00779631 FIG00779632: hypothetical protein +FIG00779636 FIG00779637: hypothetical protein +FIG00779653 FIG00779654: hypothetical protein +FIG00779667 FIG00779673: hypothetical protein +FIG00779690 FIG00779692: hypothetical protein +FIG00779714 FIG00779715: hypothetical protein +FIG00779747 FIG00779748: hypothetical protein +FIG00779771 FIG00779773: hypothetical protein +FIG00779783 FIG00779785: hypothetical protein +FIG00779789 FIG00779790: hypothetical protein +FIG00779812 FIG00779816: hypothetical protein +FIG00779848 FIG00779849: hypothetical protein +FIG00779855 FIG00779858: hypothetical protein +FIG00779858 FIG00779860: hypothetical protein +FIG00779863 FIG00779866: hypothetical protein +FIG00779876 FIG00779879: hypothetical protein +FIG00779922 Hydrogenase transcriptional regulatory protein HoxA +FIG00779956 FIG00779958: hypothetical protein +FIG00779959 FIG00779962: hypothetical protein +FIG00779983 FIG00779984: hypothetical protein +FIG00779995 FIG00779997: hypothetical protein +FIG00780013 FIG00780014: hypothetical protein +FIG00780050 FIG00780052: hypothetical protein +FIG00780069 FIG00780073: hypothetical protein +FIG00780075 FIG00780076: hypothetical protein +FIG00780081 molybdopterin biosynthesis protein +FIG00780085 blr6126; hypothetical protein +FIG00780090 FIG00780092: hypothetical protein +FIG00780096 FIG00780099: hypothetical protein +FIG00780111 FIG00780112: hypothetical protein +FIG00780112 FIG00780113: hypothetical protein +FIG00780125 FIG00780130: hypothetical protein +FIG00780158 FIG00780160: hypothetical protein +FIG00780164 Magnetosome protein MamF +FIG00780226 FIG00780227: hypothetical protein +FIG00780260 FIG00780262: hypothetical protein +FIG00780328 bll3966; hypothetical protein +FIG00780364 FIG00780368: hypothetical protein +FIG00780398 putative outer membrane secretion protein +FIG00780408 FIG00780409: hypothetical protein +FIG00780409 bll1341; hypothetical protein +FIG00780423 Phage portal protein, lambda +FIG00780484 FIG00780487: hypothetical protein +FIG00780491 FIG00780493: hypothetical protein +FIG00780494 FIG00780501: hypothetical protein +FIG00780555 FIG00780560: hypothetical protein +FIG00780610 FIG00780612: hypothetical protein +FIG00780634 bll5864; hypothetical protein +FIG00780651 FIG00992437: hypothetical protein +FIG00780677 Similar to E. coli HemY protein +FIG00780687 FIG00780690: hypothetical protein +FIG00780690 homospermidine synthase +FIG00780698 COG0006: Xaa-Pro aminopeptidase +FIG00780700 FIG00780701: hypothetical protein +FIG00780704 FIG00780705: hypothetical protein +FIG00780715 FIG00780717: hypothetical protein +FIG00780717 blr5428; hypothetical protein +FIG00780720 FIG00780721: hypothetical protein +FIG00780745 FIG00780748: hypothetical protein +FIG00780770 FIG00780772: hypothetical protein +FIG00780773 Phytochrome associated response regulator +FIG00780806 Possible membrane protein +FIG00780818 FIG00780819: hypothetical protein +FIG00780879 FIG00780881: hypothetical protein +FIG00780881 FIG00780884: hypothetical protein +FIG00780884 Plasmid stability-like protein +FIG00780889 FIG00780891: hypothetical protein +FIG00780891 FIG00780893: hypothetical protein +FIG00780941 FIG00780945: hypothetical protein +FIG00780945 3-oxoacyl-[acyl-carrier-protein] synthase III (EC 2.3.1.41) +FIG00780957 FIG00780967: hypothetical protein +FIG00780982 Phage integrase +FIG00780993 FIG00780994: hypothetical protein +FIG00780994 putative TDP-D-fucosamine acetyltransferase +FIG00781015 FIG00781016: hypothetical protein +FIG00781021 FIG00781023: hypothetical protein +FIG00781023 Transcriptional regulator, LacI family +FIG00781026 FIG00781027: hypothetical protein +FIG00781095 FIG00781096: hypothetical protein +FIG00781096 serotype-specific antigen 1 precursor +FIG00781097 FIG00781100: hypothetical protein +FIG00781134 FIG00781135: hypothetical protein +FIG00781155 FIG00781158: hypothetical protein +FIG00781175 FIG00781179: hypothetical protein +FIG00781196 FIG00781197: hypothetical protein +FIG00781197 FIG00781204: hypothetical protein +FIG00781210 FIG00781211: hypothetical protein +FIG00781235 ABC-type transport protein Uup +FIG00781251 FIG00781254: hypothetical protein +FIG00781273 FIG00781274: hypothetical protein +FIG00781279 FIG00781282: hypothetical protein +FIG00781282 FIG00781286: hypothetical protein +FIG00781301 Mu-like prophage FluMu protein gp16 +FIG00781305 FIG00781306: hypothetical protein +FIG00781310 FIG00781316: hypothetical protein +FIG00781316 FIG00781317: hypothetical protein +FIG00781348 FAD flavoprotein oxidase +FIG00781352 FIG00781353: hypothetical protein +FIG00781353 FIG00781357: hypothetical protein +FIG00781363 COG1309: Transcriptional regulator +FIG00781385 FIG00781389: hypothetical protein +FIG00781399 possible DNA transformation protein +FIG00781412 ATPase domain protein +FIG00781451 FIG00698670: hypothetical protein +FIG00781470 FIG00781475: hypothetical protein +FIG00781478 TfpB protein +FIG00781488 FIG00781495: hypothetical protein +FIG00781527 FIG00781530: hypothetical protein +FIG00781544 FIG00781545: hypothetical protein +FIG00781555 phosphatidylglycerophosphatase B( EC:3.1.3.27 ) +FIG00781557 FIG00781559: hypothetical protein +FIG00781559 FIG00781562: hypothetical protein +FIG00781571 COG4942: Membrane-bound metallopeptidase +FIG00781592 FIG00781594: hypothetical protein +FIG00781597 FIG00781604: hypothetical protein +FIG00781604 Tfp pilus assembly protein, pilus retraction ATPase PilT +FIG00781630 FIG00781631: hypothetical protein +FIG00781636 FIG00781638: hypothetical protein +FIG00781659 FIG00781661: hypothetical protein +FIG00781662 COG0644: Dehydrogenases (flavoproteins) +FIG00781682 transcriptional regulator MtrA +FIG00781718 competence protein ComEA helix-hairpin-helix repeat protein +FIG00781729 COG0668: Small-conductance mechanosensitive channel +FIG00781731 FIG00781736: hypothetical protein +FIG00781742 FIG00781743: hypothetical protein +FIG00781743 FIG00781744: hypothetical protein +FIG00781744 FIG00781751: hypothetical protein +FIG00781755 PilL +FIG00781768 CI repressor +FIG00781812 FIG00781814: hypothetical protein +FIG00781819 FIG00781823: hypothetical protein +FIG00781841 Lipopolysaccharide core biosynthesis glycosyltransferase WadA +FIG00781864 Ribose ABC transporter, periplasmic ribose-binding protein +FIG00781890 FIG00781892: hypothetical protein +FIG00781935 FIG00781936: hypothetical protein +FIG00781936 FIG00781937: hypothetical protein +FIG00781941 Transcriptional regulator of aromatic amino acids metabolism +FIG00781957 FIG00781958: hypothetical protein +FIG00781970 FIG00781974: hypothetical protein +FIG00781987 FIG00781988: hypothetical protein +FIG00782003 FIG00641787: hypothetical protein +FIG00782004 FIG00782005: hypothetical protein +FIG00782024 FIG00782031: hypothetical protein +FIG00782058 FIG00782063: hypothetical protein +FIG00782072 Possible exported protein +FIG00782074 conserved hypothetical protein HI0073 +FIG00782078 Putative sulfatase +FIG00782080 FIG00782093: hypothetical protein +FIG00782098 Probable NADH-dependent flavin oxidoreductase yqiG (EC 1.-.-.-) +FIG00782125 FIG00782129: hypothetical protein +FIG00782134 branched-chain amino acid ABC transporter, periplasmic branched-chain amino acid-binding protein, putative +FIG00782150 hemin-binding periplasmic protein +FIG00782152 FIG00848677: hypothetical protein +FIG00782157 FIG00782162: hypothetical protein +FIG00782162 FIG00782164: hypothetical protein +FIG00782166 FIG00782168: hypothetical protein +FIG00782174 FIG00782194: hypothetical protein +FIG00782195 FIG00782199: hypothetical protein +FIG00782209 FIG00782210: hypothetical protein +FIG00782210 FIG00782214: hypothetical protein +FIG00782247 probable exported protein STY4558 +FIG00782254 ModF +FIG00782260 FIG00782264: hypothetical protein +FIG00782264 FIG00782265: hypothetical protein +FIG00782265 FIG00782269: hypothetical protein +FIG00782269 FIG00782270: hypothetical protein +FIG00782288 Ribose/xylose/arabinose/galactoside ABC-type transport systems, periplasmic sugar binding protein +FIG00782300 FIG00782302: hypothetical protein +FIG00782317 Type II secretory pathway, component PulJ +FIG00782338 possible SirA response regulator +FIG00782350 ABC-type amino acid transport system, permease component +FIG00782352 COG0443: Molecular chaperone +FIG00782358 FIG00782361: hypothetical protein +FIG00782367 FIG00782373: hypothetical protein +FIG00782386 FIG00782388: hypothetical protein +FIG00782388 FIG00782392: hypothetical protein +FIG00782398 Domain of unknown function DUF1537 +FIG00782410 FIG00782411: hypothetical protein +FIG00782416 FIG00782427: hypothetical protein +FIG00782441 FIG00782448: hypothetical protein +FIG00782493 FIG00782494: hypothetical protein +FIG00782497 FIG00782512: hypothetical protein +FIG00782564 FIG00782581: hypothetical protein +FIG00782586 DsrE-related protein +FIG00782587 FIG00782603: hypothetical protein +FIG00782635 similar to gammaN-crystallin +FIG00782654 InterPro IPR001279 COGs COG2015 +FIG00782656 Kazal-type serine protease inhibitor domain +FIG00782696 FIG00782697: hypothetical protein +FIG00782745 FIG00782746: hypothetical protein +FIG00782746 FIG00782751: hypothetical protein +FIG00782857 FIG00782862: hypothetical protein +FIG00782969 peptidase M20/M25/M40 family protein +FIG00783139 FIG00783140: hypothetical protein +FIG00783154 FIG00783155: hypothetical protein +FIG00783172 FIG00783175: hypothetical protein +FIG00783231 Bona fide RidA/YjgF/TdcF/RutC subgroup +FIG00783259 FIG00783260: hypothetical protein +FIG00783265 peptidase S58, DmpA +FIG00783266 FIG00783267: hypothetical protein +FIG00783301 transglutaminase-like enzyme +FIG00783309 FIG00783312: hypothetical protein +FIG00783354 FIG00880183: hypothetical protein +FIG00783377 FIG00783378: hypothetical protein +FIG00783425 FIG00783430: hypothetical protein +FIG00783440 FIG00783444: hypothetical protein +FIG00783450 FIG00783451: hypothetical protein +FIG00783453 interphotoreceptor retinoid-binding protein +FIG00783482 FIG00783483: hypothetical protein +FIG00783497 Error-prone repair protein ImuA +FIG00783502 Gene Transfer Agent associated protein CC2787 +FIG00783539 FIG00783540: hypothetical protein +FIG00783580 FIG00783581: hypothetical protein +FIG00783599 FIG00783600: hypothetical protein +FIG00783716 InterPro IPR000305 COGs COG2827 +FIG00783754 FIG00783755: hypothetical protein +FIG00783802 FIG00783804: hypothetical protein +FIG00783849 FIG00783850: hypothetical protein +FIG00783894 FIG00783897: hypothetical protein +FIG00783914 FIG00783915: hypothetical protein +FIG00783916 FIG00783917: hypothetical protein +FIG00783917 FIG00783918: hypothetical protein +FIG00783918 FIG00783923: hypothetical protein +FIG00783926 FIG00783929: hypothetical protein +FIG00783929 FIG00783930: hypothetical protein +FIG00783930 FIG00783931: hypothetical protein +FIG00783934 FIG00783935: hypothetical protein +FIG00783936 FIG00783937: hypothetical protein +FIG00783937 FIG00783939: hypothetical protein +FIG00783941 FIG00783944: hypothetical protein +FIG00783944 Serine-threonine protein kinase (EC 2.7.1.-) +FIG00783945 FIG00783947: hypothetical protein +FIG00783950 FIG00783951: hypothetical protein +FIG00783951 FIG00783952: hypothetical protein +FIG00783952 FIG00783954: hypothetical protein +FIG00783957 FIG00783958: hypothetical protein +FIG00783961 UPF0057 membrane protein PA0567 +FIG00783964 FIG00783965: hypothetical protein +FIG00783965 FIG00783966: hypothetical protein +FIG00783966 FIG00783967: hypothetical protein +FIG00783969 FIG00783975: hypothetical protein +FIG00783977 FIG00783979: hypothetical protein +FIG00783979 FIG00783981: hypothetical protein +FIG00783982 FIG00783983: hypothetical protein +FIG00783984 FIG00783986: hypothetical protein +FIG00783986 FIG00783988: hypothetical protein +FIG00783992 FIG00783994: hypothetical protein +FIG00783995 FIG00783996: hypothetical protein +FIG00783997 FIG00783998: hypothetical protein +FIG00784002 FIG00784003: hypothetical protein +FIG00784007 FIG00784008: hypothetical protein +FIG00784009 FIG00784010: hypothetical protein +FIG00784012 FIG00784013: hypothetical protein +FIG00784014 FIG00784016: hypothetical protein +FIG00784019 FIG00784021: hypothetical protein +FIG00784021 FIG00784023: hypothetical protein +FIG00784024 FIG00784026: hypothetical protein +FIG00784026 FIG00784028: hypothetical protein +FIG00784029 FIG00784030: hypothetical protein +FIG00784030 FIG00784031: hypothetical protein +FIG00784031 FIG00784032: hypothetical protein +FIG00784032 FIG00784036: hypothetical protein +FIG00784036 FIG00784037: hypothetical protein +FIG00784037 FIG00784039: hypothetical protein +FIG00784039 FIG00784040: hypothetical protein +FIG00784040 FIG00784041: hypothetical protein +FIG00784041 FIG00784042: hypothetical protein +FIG00784046 FIG00784047: hypothetical protein +FIG00784047 FIG00784048: hypothetical protein +FIG00784048 FIG00784049: hypothetical protein +FIG00784049 FIG00784051: hypothetical protein +FIG00784051 FIG00784053: hypothetical protein +FIG00784064 FIG00784065: hypothetical protein +FIG00784065 FIG00784066: hypothetical protein +FIG00784067 FIG00784069: hypothetical protein +FIG00784072 FIG00784074: hypothetical protein +FIG00784074 FIG00784075: hypothetical protein +FIG00784082 FIG00784084: hypothetical protein +FIG00784085 FIG00784087: hypothetical protein +FIG00784092 FIG00784094: hypothetical protein +FIG00784094 FIG00784095: hypothetical protein +FIG00784095 FIG00784098: hypothetical protein +FIG00784099 FIG00784100: hypothetical protein +FIG00784101 FIG00784102: hypothetical protein +FIG00784102 FIG00784104: hypothetical protein +FIG00784110 FIG00784112: hypothetical protein +FIG00784120 protein of unknown function (DUF1439) +FIG00784121 protein of unknown function DUF442 +FIG00784125 FIG00784127: hypothetical protein +FIG00784127 FIG00784129: hypothetical protein +FIG00784129 FIG00784131: hypothetical protein +FIG00784138 FIG00784142: hypothetical protein +FIG00784142 FIG00784144: hypothetical protein +FIG00784151 FIG00784152: hypothetical protein +FIG00784163 FIG00784164: hypothetical protein +FIG00784170 FIG00784171: hypothetical protein +FIG00784177 integral membrane sensor hybrid histidine kinase +FIG00784178 FIG00784179: hypothetical protein +FIG00784189 FIG00784192: hypothetical protein +FIG00784192 FIG00784193: hypothetical protein +FIG00784193 FIG00784194: hypothetical protein +FIG00784197 FIG00784198: hypothetical protein +FIG00784204 FIG00784207: hypothetical protein +FIG00784207 FIG00784210: hypothetical protein +FIG00784218 protein of unknown function DUF503 +FIG00784220 Sigma-70 factor +FIG00784221 FIG00784222: hypothetical protein +FIG00784223 FIG00784227: hypothetical protein +FIG00784227 FIG00784230: hypothetical protein +FIG00784232 FIG00784233: hypothetical protein +FIG00784238 FIG00784240: hypothetical protein +FIG00784241 FIG00784245: hypothetical protein +FIG00784245 FIG00784246: hypothetical protein +FIG00784246 FIG00784247: hypothetical protein +FIG00784247 FIG00784248: hypothetical protein +FIG00784248 FIG00784249: hypothetical protein +FIG00784256 FIG00784257: hypothetical protein +FIG00784257 FIG00784260: hypothetical protein +FIG00784261 FIG00784262: hypothetical protein +FIG00784262 FIG00784264: hypothetical protein +FIG00784265 FIG00784268: hypothetical protein +FIG00784269 FIG00784270: hypothetical protein +FIG00784272 FIG00784274: hypothetical protein +FIG00784282 FIG00784284: hypothetical protein +FIG00784284 FIG00784285: hypothetical protein +FIG00784288 DotD protein +FIG00784291 FIG00784295: hypothetical protein +FIG00784295 FIG00784296: hypothetical protein +FIG00784304 FIG00784305: hypothetical protein +FIG00784305 FIG00784306: hypothetical protein +FIG00784307 FIG00784309: hypothetical protein +FIG00784310 FIG00784311: hypothetical protein +FIG00784311 FIG00784312: hypothetical protein +FIG00784312 FIG00784315: hypothetical protein +FIG00784315 FIG00784319: hypothetical protein +FIG00784319 FIG00784321: hypothetical protein +FIG00784321 FIG00784324: hypothetical protein +FIG00784326 FIG00784327: hypothetical protein +FIG00784328 FIG00784332: hypothetical protein +FIG00784332 FIG00784334: hypothetical protein +FIG00784338 FIG00784340: hypothetical protein +FIG00784342 FIG00784343: hypothetical protein +FIG00784345 FIG00784346: hypothetical protein +FIG00784346 FIG00784347: hypothetical protein +FIG00784347 FIG00784348: hypothetical protein +FIG00784357 FIG00784359: hypothetical protein +FIG00784359 FIG00784361: hypothetical protein +FIG00784363 FIG00784366: hypothetical protein +FIG00784369 FIG00784370: hypothetical protein +FIG00784370 FIG00784372: hypothetical protein +FIG00784378 FIG00784379: hypothetical protein +FIG00784396 FIG00784397: hypothetical protein +FIG00784397 FIG00784399: hypothetical protein +FIG00784399 FIG00784400: hypothetical protein +FIG00784403 FIG00784405: hypothetical protein +FIG00784405 FIG00784407: hypothetical protein +FIG00784412 ATPase (PilT family) +FIG00784413 FIG00784415: hypothetical protein +FIG00784419 FIG00784420: hypothetical protein +FIG00784428 FIG00784429: hypothetical protein +FIG00784437 FIG00784442: hypothetical protein +FIG00784446 putative dehydrogenase domain of multifunctional non-ribosomal peptide synthetases and related enzyme +FIG00784448 FIG00784450: hypothetical protein +FIG00784450 FIG00784454: hypothetical protein +FIG00784455 FIG00784457: hypothetical protein +FIG00784459 putative DNA helicase +FIG00784465 FIG00784466: hypothetical protein +FIG00784467 Putative diguanylate phosphodiesterase (EAL domain) +FIG00784470 FIG00784471: hypothetical protein +FIG00784471 FIG00784472: hypothetical protein +FIG00784475 FIG00784478: hypothetical protein +FIG00784478 FIG00784479: hypothetical protein +FIG00784479 FIG00784482: hypothetical protein +FIG00784484 FIG00784489: hypothetical protein +FIG00784490 FIG00784491: hypothetical protein +FIG00784501 FIG00784502: hypothetical protein +FIG00784510 FIG00784511: hypothetical protein +FIG00784514 FIG00784516: hypothetical protein +FIG00784516 Membrane-fusion protein +FIG00784524 FIG00784525: hypothetical protein +FIG00784531 FIG00784532: hypothetical protein +FIG00784532 FIG00784533: hypothetical protein +FIG00784536 Glutathione S-transferase( EC:2.5.1.18 ) +FIG00784538 FIG00784539: hypothetical protein +FIG00784543 FIG00784545: hypothetical protein +FIG00784545 FIG00784546: hypothetical protein +FIG00784546 FIG00784548: hypothetical protein +FIG00784549 FIG00784550: hypothetical protein +FIG00784552 FIG00784553: hypothetical protein +FIG00784553 FIG00784554: hypothetical protein +FIG00784559 zinc-binding protein +FIG00784561 FIG00784562: hypothetical protein +FIG00784565 FIG00784566: hypothetical protein +FIG00784566 FIG00784567: hypothetical protein +FIG00784574 FIG00784576: hypothetical protein +FIG00784576 FIG00784578: hypothetical protein +FIG00784578 FIG00784579: hypothetical protein +FIG00784587 FIG00784588: hypothetical protein +FIG00784591 FIG00784592: hypothetical protein +FIG00784592 FIG00784595: hypothetical protein +FIG00784598 biopolymer transport protein +FIG00784599 FIG00784605: hypothetical protein +FIG00784605 FIG00784606: hypothetical protein +FIG00784613 FIG00784616: hypothetical protein +FIG00784627 FIG00784628: hypothetical protein +FIG00784632 FIG00784633: hypothetical protein +FIG00784633 FIG00784635: hypothetical protein +FIG00784635 FIG00784636: hypothetical protein +FIG00784637 FIG00784639: hypothetical protein +FIG00784646 FIG00784648: hypothetical protein +FIG00784649 Putative transcriptional activator ChrR +FIG00784650 FIG00784652: hypothetical protein +FIG00784654 FIG00784655: hypothetical protein +FIG00784657 FIG00784658: hypothetical protein +FIG00784666 FIG00799023: hypothetical protein +FIG00784668 FIG00784670: hypothetical protein +FIG00784692 FIG00784693: hypothetical protein +FIG00784706 Sll1095 protein +FIG00784707 FIG00784708: hypothetical protein +FIG00784708 Putative integrase/recombinase HI1572 +FIG00784709 FIG00784710: hypothetical protein +FIG00784718 Endoglucanase N252 (EC 3.2.1.4) +FIG00784722 FIG00784724: hypothetical protein +FIG00784724 FIG00784729: hypothetical protein +FIG00784733 FIG00784736: hypothetical protein +FIG00784736 putative transglycosylase protein +FIG00784739 Putative transporting ATPase +FIG00784743 FIG00784745: hypothetical protein +FIG00784747 FIG00784749: hypothetical protein +FIG00784749 FIG00784750: hypothetical protein +FIG00784758 FIG00784759: hypothetical protein +FIG00784766 predicted phosphohydrolase +FIG00784783 FIG00784785: hypothetical protein +FIG00784791 FIG00784792: hypothetical protein +FIG00784792 FIG00784793: hypothetical protein +FIG00784795 FIG00784797: hypothetical protein +FIG00784800 FIG00784802: hypothetical protein +FIG00784810 FIG00784811: hypothetical protein +FIG00784811 FIG00784812: hypothetical protein +FIG00784816 FIG00784820: hypothetical protein +FIG00784820 Pirin-like protein CC_3178 +FIG00784826 FIG00784827: hypothetical protein +FIG00784827 FIG00784831: hypothetical protein +FIG00784831 FIG00784832: hypothetical protein +FIG00784832 FIG00784835: hypothetical protein +FIG00784842 FIG00784845: hypothetical protein +FIG00784846 FIG00784849: hypothetical protein +FIG00784849 UPF0104 membrane protein AF_2231 +FIG00784851 FIG00784852: hypothetical protein +FIG00784856 FIG00784862: hypothetical protein +FIG00784863 FIG00784870: hypothetical protein +FIG00784874 FIG00784875: hypothetical protein +FIG00784890 FIG00784891: hypothetical protein +FIG00784892 FIG00784893: hypothetical protein +FIG00784894 FIG00784896: hypothetical protein +FIG00784902 FIG00784903: hypothetical protein +FIG00784911 FIG00784913: hypothetical protein +FIG00784915 FIG00784916: hypothetical protein +FIG00784916 FIG00784918: hypothetical protein +FIG00784929 FIG00784933: hypothetical protein +FIG00784938 FIG00784939: hypothetical protein +FIG00784943 FIG00784944: hypothetical protein +FIG00784949 FIG00784952: hypothetical protein +FIG00784954 FIG00784956: hypothetical protein +FIG00784958 sigma-24 (FecI-like) +FIG00784962 FIG00784963: hypothetical protein +FIG00784963 uncharacterized conserved coiled coil protein +FIG00784965 FIG00784966: hypothetical protein +FIG00784966 FIG00784967: hypothetical protein +FIG00784973 ferric siderophore transport system,innermembrane protein E +FIG00784976 FIG00784981: hypothetical protein +FIG00784981 FIG00784982: hypothetical protein +FIG00784986 FIG00784987: hypothetical protein +FIG00784994 FIG00784995: hypothetical protein +FIG00784997 FIG00785000: hypothetical protein +FIG00785000 FIG00785001: hypothetical protein +FIG00785002 Helix-turn-helix protein, CopG +FIG00785007 FIG00785009: hypothetical protein +FIG00785011 FIG00785012: hypothetical protein +FIG00785012 FIG00785014: hypothetical protein +FIG00785014 FIG00785016: hypothetical protein +FIG00785017 FIG00785019: hypothetical protein +FIG00785019 FIG00785022: hypothetical protein +FIG00785022 FIG00785025: hypothetical protein +FIG00785025 FIG00785026: hypothetical protein +FIG00785026 FIG00785029: hypothetical protein +FIG00785030 FIG00785031: hypothetical protein +FIG00785037 FIG00785038: hypothetical protein +FIG00785043 FIG00785044: hypothetical protein +FIG00785046 FIG00785047: hypothetical protein +FIG00785055 FIG00785059: hypothetical protein +FIG00785068 FIG00785075: hypothetical protein +FIG00785079 FIG00785081: hypothetical protein +FIG00785088 FIG00785089: hypothetical protein +FIG00785089 FIG00785090: hypothetical protein +FIG00785090 FIG00785091: hypothetical protein +FIG00785116 FIG00785119: hypothetical protein +FIG00785120 FIG00785121: hypothetical protein +FIG00785127 FIG00785128: hypothetical protein +FIG00785128 FIG00785129: hypothetical protein +FIG00785129 FIG00785130: hypothetical protein +FIG00785134 FIG00785135: hypothetical protein +FIG00785138 FIG00785140: hypothetical protein +FIG00785140 FIG00785144: hypothetical protein +FIG00785150 FIG00785151: hypothetical protein +FIG00785151 FIG00785152: hypothetical protein +FIG00785152 FIG00785157: hypothetical protein +FIG00785158 FIG00785159: hypothetical protein +FIG00785159 FIG00785170: hypothetical protein +FIG00785170 FIG00785176: hypothetical protein +FIG00785176 FIG00785178: hypothetical protein +FIG00785182 Putative sodium/bile acid symporter family protein +FIG00785183 FIG00785185: hypothetical protein +FIG00785185 FIG00785186: hypothetical protein +FIG00785188 FIG00785192: hypothetical protein +FIG00785195 Heat shock hsp20 (Alpha crystallin) proteins family +FIG00785197 FIG00785198: hypothetical protein +FIG00785199 FIG00785200: hypothetical protein +FIG00785211 FIG00785212: hypothetical protein +FIG00785216 Lipase 1 precursor (EC 3.1.1.3) (Triacylglycerol lipase) +FIG00785220 FIG00785222: hypothetical protein +FIG00785223 FIG00785224: hypothetical protein +FIG00785224 FIG00785230: hypothetical protein +FIG00785232 FIG00785235: hypothetical protein +FIG00785239 FIG00785242: hypothetical protein +FIG00785243 FIG00785244: hypothetical protein +FIG00785244 FIG00785245: hypothetical protein +FIG00785255 IcmL protein +FIG00785259 FIG00785260: hypothetical protein +FIG00785260 FIG00785261: hypothetical protein +FIG00785283 FIG00785284: hypothetical protein +FIG00785284 FIG00785287: hypothetical protein +FIG00785290 FIG00785291: hypothetical protein +FIG00785292 FIG00785293: hypothetical protein +FIG00785295 probable sigma-70 factor, ECF subfamily protein +FIG00785309 FIG00785312: hypothetical protein +FIG00785313 FIG00785315: hypothetical protein +FIG00785315 FIG00785317: hypothetical protein +FIG00785317 FIG00785318: hypothetical protein +FIG00785318 FIG00785319: hypothetical protein +FIG00785321 FIG00785322: hypothetical protein +FIG00785322 FIG00785323: hypothetical protein +FIG00785323 FIG00785325: hypothetical protein +FIG00785325 FIG00785329: hypothetical protein +FIG00785329 FIG00785332: hypothetical protein +FIG00785361 FIG00785362: hypothetical protein +FIG00785368 FIG00785369: hypothetical protein +FIG00785372 FIG00785374: hypothetical protein +FIG00785396 FIG00785397: hypothetical protein +FIG00785397 FIG00785398: hypothetical protein +FIG00785403 Predicted hydrolase of the alpha/beta-hydrolase fold +FIG00785411 Nonmuscle myosin heavy chain +FIG00785412 FIG00785417: hypothetical protein +FIG00785421 FIG00785424: hypothetical protein +FIG00785427 FIG00785429: hypothetical protein +FIG00785436 FIG00785439: hypothetical protein +FIG00785447 FIG00785448: hypothetical protein +FIG00785448 FIG00785450: hypothetical protein +FIG00785463 FIG00785464: hypothetical protein +FIG00785464 Phenylacetic acid degradation protein PaaN, ring-opening aldehyde dehydrogenase (EC 1.2.1.3) +FIG00785475 Tripartite ATP-independent periplasmic +FIG00785479 FIG00785482: hypothetical protein +FIG00785502 FIG00785506: hypothetical protein +FIG00785512 FIG00785513: hypothetical protein +FIG00785513 FIG00785514: hypothetical protein +FIG00785523 FIG00785524: hypothetical protein +FIG00785528 FIG00785529: hypothetical protein +FIG00785533 FIG00785534: hypothetical protein +FIG00785541 FIG00785543: hypothetical protein +FIG00785543 FIG00785546: hypothetical protein +FIG00785550 FIG00785551: hypothetical protein +FIG00785562 FIG00785566: hypothetical protein +FIG00785591 FIG00785597: hypothetical protein +FIG00785597 methyltransferase-related protein +FIG00785639 similar to putative threonine efflux protein +FIG00785643 FIG00785650: hypothetical protein +FIG00785653 FIG00785654: hypothetical protein +FIG00785654 Darcynin homolog +FIG00785668 Extracellular solute-binding protein, family 3 precursor +FIG00785687 FIG00785693: hypothetical protein +FIG00785693 FIG00785694: hypothetical protein +FIG00785715 FIG00785717: hypothetical protein +FIG00785724 lysine exporter protein LysE/YggA +FIG00785757 FIG00785760: hypothetical protein +FIG00785760 FIG00785764: hypothetical protein +FIG00785769 FIG00785770: hypothetical protein +FIG00785785 FIG00785788: hypothetical protein +FIG00785801 FIG00785805: hypothetical protein +FIG00785811 FIG00785812: hypothetical protein +FIG00785830 COG3380: Amine oxidase, flavin-containing +FIG00785838 FIG00785839: hypothetical protein +FIG00785842 FIG00785843: hypothetical protein +FIG00785843 FIG00785844: hypothetical protein +FIG00785854 FIG00785860: hypothetical protein +FIG00785875 FIG00785877: hypothetical protein +FIG00785882 FIG00785883: hypothetical protein +FIG00785893 sodium-dependent transporter, NSS family protein +FIG00785907 FIG00785908: hypothetical protein +FIG00785962 Two-component system sensor protein Z5692 +FIG00785970 FIG00785972: hypothetical protein +FIG00785983 FIG00785984: hypothetical protein +FIG00786016 FIG00786019: hypothetical protein +FIG00786027 FIG00786030: hypothetical protein +FIG00786032 Cytoplasmic beta-glucosidase (EC 3.2.1.21) +FIG00786046 FIG01001988: hypothetical protein +FIG00786054 FIG00786055: hypothetical protein +FIG00786059 FIG00786063: hypothetical protein +FIG00786079 FIG00786082: hypothetical protein +FIG00786092 FIG004853: possible toxin to DivIC +FIG00786117 FIG00786119: hypothetical protein +FIG00786120 FIG00786121: hypothetical protein +FIG00786122 FIG00786123: hypothetical protein +FIG00786134 FIG00786137: hypothetical protein +FIG00786137 transcriptional regulator, IclR family/regucalcin +FIG00786149 protein of unknown function DUF446 +FIG00786156 FIG00786159: hypothetical protein +FIG00786159 FIG00786161: hypothetical protein +FIG00786161 FIG00786162: hypothetical protein +FIG00786162 Peptide ABC transporter, permease component +FIG00786186 FIG00786189: hypothetical protein +FIG00786192 FIG00786198: hypothetical protein +FIG00786198 FIG00786199: hypothetical protein +FIG00786237 FIG00786242: hypothetical protein +FIG00786252 FIG00786254: hypothetical protein +FIG00786273 FIG00786274: hypothetical protein +FIG00786276 FIG00786278: hypothetical protein +FIG00786301 FIG00786303: hypothetical protein +FIG00786305 FIG00786307: hypothetical protein +FIG00786307 FIG00786308: hypothetical protein +FIG00786313 FIG00786315: hypothetical protein +FIG00786322 FIG00786328: hypothetical protein +FIG00786336 Protein yfjF +FIG00786341 FIG00786345: hypothetical protein +FIG00786348 FIG00786352: hypothetical protein +FIG00786353 FIG00786354: hypothetical protein +FIG00786354 FIG00786362: hypothetical protein +FIG00786384 FIG00786385: hypothetical protein +FIG00786394 FIG00786395: hypothetical protein +FIG00786395 FIG00786397: hypothetical protein +FIG00786397 FIG00786399: hypothetical protein +FIG00786399 FIG00786400: hypothetical protein +FIG00786402 FIG00786405: hypothetical protein +FIG00786408 FIG00786409: hypothetical protein +FIG00786409 FIG00786415: hypothetical protein +FIG00786421 FIG00786422: hypothetical protein +FIG00786422 FIG00786423: hypothetical protein +FIG00786434 FIG00786435: hypothetical protein +FIG00786439 FIG00786440: hypothetical protein +FIG00786456 FIG00786457: hypothetical protein +FIG00786464 FIG00786468: hypothetical protein +FIG00786492 Peptidase, U7 family +FIG00786493 FIG00786494: hypothetical protein +FIG00786499 FIG00786500: hypothetical protein +FIG00786503 FIG00786504: hypothetical protein +FIG00786511 FIG00786515: hypothetical protein +FIG00786515 FIG00786520: hypothetical protein +FIG00786612 FIG00786616: hypothetical protein +FIG00786629 FIG00786630: hypothetical protein +FIG00786630 FIG00786631: hypothetical protein +FIG00786636 FIG00786640: hypothetical protein +FIG00786651 FIG00786653: hypothetical protein +FIG00786653 FIG00786659: hypothetical protein +FIG00786659 FIG00786662: hypothetical protein +FIG00786702 FIG00786704: hypothetical protein +FIG00786707 FIG00786711: hypothetical protein +FIG00786716 FIG00786717: hypothetical protein +FIG00786725 FIG00786727: hypothetical protein +FIG00786734 WD40 repeat protein +FIG00786748 Possible bacteriophage protein +FIG00786755 FIG00786757: hypothetical protein +FIG00786774 Probable repressor transcription regulator protein +FIG00786779 FIG00786782: hypothetical protein +FIG00786783 phosphorylase family family +FIG00786790 FIG00786794: hypothetical protein +FIG00786806 FIG00786808: hypothetical protein +FIG00786826 FIG00786828: hypothetical protein +FIG00786828 FIG00786829: hypothetical protein +FIG00786829 FIG00786834: hypothetical protein +FIG00786841 FIG00786843: hypothetical protein +FIG00786871 FIG00786873: hypothetical protein +FIG00786875 FIG00786878: hypothetical protein +FIG00786892 3-oxoacyl-(Acyl-carrier-protein) synthase III (EC 2.3.1.41) +FIG00786894 FIG00786896: hypothetical protein +FIG00786905 FIG00786906: hypothetical protein +FIG00786908 FIG00786915: hypothetical protein +FIG00786918 FIG00786919: hypothetical protein +FIG00786981 FIG00786982: hypothetical protein +FIG00786991 FIG00786997: hypothetical protein +FIG00787032 FIG00787033: hypothetical protein +FIG00787050 FIG00787051: hypothetical protein +FIG00787063 FIG00787065: hypothetical protein +FIG00787068 Class II aldolase/adducin, N-terminal +FIG00787071 FIG00787077: hypothetical protein +FIG00787104 FIG00787105: hypothetical protein +FIG00787105 DNA-binding response regulator OmpR +FIG00787119 FIG00787124: hypothetical protein +FIG00787151 FIG00787152: hypothetical protein +FIG00787154 Aldose 1-epimerase-related protein +FIG00787193 FIG00787195: hypothetical protein +FIG00787204 FIG00787208: hypothetical protein +FIG00787210 FIG00787218: hypothetical protein +FIG00787224 Diverse 7TM receptor, extracellular region 2 +FIG00787283 Type I secretion system, outer membrane component LapE +FIG00787295 FIG00787296: hypothetical protein +FIG00787304 FIG00787305: hypothetical protein +FIG00787305 FIG00787306: hypothetical protein +FIG00787307 FIG00787310: hypothetical protein +FIG00787310 FIG00787313: hypothetical protein +FIG00787325 FIG00787326: hypothetical protein +FIG00787390 FIG00787391: hypothetical protein +FIG00787403 FIG00787405: hypothetical protein +FIG00787405 FIG00787413: hypothetical protein +FIG00787440 two component sensor kinase [EC:2.7.3.-] +FIG00787469 FIG00787474: hypothetical protein +FIG00787508 FIG00787509: hypothetical protein +FIG00787512 FIG00787521: hypothetical protein +FIG00787540 FIG00787544: hypothetical protein +FIG00787567 FIG00787569: hypothetical protein +FIG00787622 Reductase homolog +FIG00787650 FIG00787658: hypothetical protein +FIG00787658 FIG00787662: hypothetical protein +FIG00787662 FIG00787674: hypothetical protein +FIG00787703 FIG00787711: hypothetical protein +FIG00787711 FIG00787715: hypothetical protein +FIG00787715 FIG00787721: hypothetical protein +FIG00787732 FIG00787749: hypothetical protein +FIG00787749 FIG00787781: hypothetical protein +FIG00787781 FIG00787782: hypothetical protein +FIG00787786 FIG00787789: hypothetical protein +FIG00787789 soj protein +FIG00787802 FIG00787804: hypothetical protein +FIG00787804 putative malate dehydrogenase +FIG00787808 integral membrane protein TerC family +FIG00787815 TPR repeat:Bacterial transcriptional activator domain:Tetratricopeptide TPR_4 +FIG00787824 FIG00787826: hypothetical protein +FIG00787826 FIG00787835: hypothetical protein +FIG00787835 FIG00787837: hypothetical protein +FIG00787837 FIG00787846: hypothetical protein +FIG00787861 COG1609: Transcriptional regulators +FIG00787870 FIG00787873: hypothetical protein +FIG00787873 FIG00787877: hypothetical protein +FIG00787877 FIG00787884: hypothetical protein +FIG00787896 FIG00787900: hypothetical protein +FIG00787900 FIG00787904: hypothetical protein +FIG00787904 FIG00787913: hypothetical protein +FIG00787924 FIG00787933: hypothetical protein +FIG00787933 FIG00787939: hypothetical protein +FIG00787939 rieske iron-sulfur protein +FIG00787941 FIG00787952: hypothetical protein +FIG00787952 FIG00787956: hypothetical protein +FIG00787956 FIG00787957: hypothetical protein +FIG00787957 FIG00787959: hypothetical protein +FIG00787959 sodium ABC transporter, permease protein NatB +FIG00787966 FIG00787968: hypothetical protein +FIG00787968 FIG00787972: hypothetical protein +FIG00787972 FIG00787978: hypothetical protein +FIG00787978 FIG00787983: hypothetical protein +FIG00787983 twitching motility protein +FIG00787984 FIG00787985: hypothetical protein +FIG00787985 FIG00787990: hypothetical protein +FIG00787995 FIG00788006: hypothetical protein +FIG00788006 FIG00788018: hypothetical protein +FIG00788018 FIG00788021: hypothetical protein +FIG00788026 FIG00788033: hypothetical protein +FIG00788040 FIG00788043: hypothetical protein +FIG00788051 FIG00788058: hypothetical protein +FIG00788061 FIG00788069: hypothetical protein +FIG00788069 ribose ABC transporter, periplasmic binding protein +FIG00788078 probable cytochrome +FIG00788080 type B carboxylesterase +FIG00788082 FIG00788084: hypothetical protein +FIG00788095 copper resistance protein, putative +FIG00788100 FIG00788103: hypothetical protein +FIG00788103 FIG00788123: hypothetical protein +FIG00788123 Chlorite dismutase +FIG00788128 FIG00788129: hypothetical protein +FIG00788129 FIG00788135: hypothetical protein +FIG00788141 FIG00788147: hypothetical protein +FIG00788147 FIG00788160: hypothetical protein +FIG00788160 Single-stranded exonuclease associated with Rad50/Mre11 complex +FIG00788168 FIG00788187: hypothetical protein +FIG00788187 FIG00788197: hypothetical protein +FIG00788201 FIG00788204: hypothetical protein +FIG00788204 FIG00788207: hypothetical protein +FIG00788208 FIG00788213: hypothetical protein +FIG00788213 FIG00788231: hypothetical protein +FIG00788231 FIG00788233: hypothetical protein +FIG00788233 FIG00788235: hypothetical protein +FIG00788235 FIG00788238: hypothetical protein +FIG00788239 FIG00788250: hypothetical protein +FIG00788250 FIG00788255: hypothetical protein +FIG00788255 S-layer protein-related protein +FIG00788262 FIG00788265: hypothetical protein +FIG00788280 FIG00788281: hypothetical protein +FIG00788300 FIG00788303: hypothetical protein +FIG00788303 FIG00788308: hypothetical protein +FIG00788321 FIG00788322: hypothetical protein +FIG00788322 FIG00788325: hypothetical protein +FIG00788325 FIG00788328: hypothetical protein +FIG00788331 FIG00788341: hypothetical protein +FIG00788343 FIG00788346: hypothetical protein +FIG00788346 FIG00788358: hypothetical protein +FIG00788371 FIG00788384: hypothetical protein +FIG00788385 FIG00788386: hypothetical protein +FIG00788386 FIG00788401: hypothetical protein +FIG00788401 FIG00788405: hypothetical protein +FIG00788407 FIG00788424: hypothetical protein +FIG00788424 FIG00788430: hypothetical protein +FIG00788438 FIG00788441: hypothetical protein +FIG00788469 FIG00788478: hypothetical protein +FIG00788478 FIG00788479: hypothetical protein +FIG00788480 FIG00788491: hypothetical protein +FIG00788521 FIG00788536: hypothetical protein +FIG00788536 FIG00788537: hypothetical protein +FIG00788537 FIG00788538: hypothetical protein +FIG00788538 FIG00788541: hypothetical protein +FIG00788541 FIG00788542: hypothetical protein +FIG00788542 FIG00788547: hypothetical protein +FIG00788550 FIG00788551: hypothetical protein +FIG00788551 FIG00788552: hypothetical protein +FIG00788552 FIG00788557: hypothetical protein +FIG00788558 FIG00788566: hypothetical protein +FIG00788566 FIG00788568: hypothetical protein +FIG00788571 FIG00788576: hypothetical protein +FIG00788576 Dolichyl-phosphate mannose synthase related protein +FIG00788584 FIG00788586: hypothetical protein +FIG00788586 FIG00788588: hypothetical protein +FIG00788602 FIG00788604: hypothetical protein +FIG00788604 FIG00788613: hypothetical protein +FIG00788615 FIG00788636: hypothetical protein +FIG00788640 FIG00788647: hypothetical protein +FIG00788650 FIG00788652: hypothetical protein +FIG00788657 FIG00788661: hypothetical protein +FIG00788671 FIG00788685: hypothetical protein +FIG00788702 FIG00788703: hypothetical protein +FIG00788703 FIG00788704: hypothetical protein +FIG00788704 FIG00788713: hypothetical protein +FIG00788715 FIG00788719: hypothetical protein +FIG00788719 diguanylate cyclase/phosphodiesterase domain 1 (GGDEF) +FIG00788726 FIG00788741: hypothetical protein +FIG00788741 FIG00788743: hypothetical protein +FIG00788743 FIG00788746: hypothetical protein +FIG00788746 FIG00788748: hypothetical protein +FIG00788752 FIG00788754: hypothetical protein +FIG00788754 FIG00788758: hypothetical protein +FIG00788758 FIG00788761: hypothetical protein +FIG00788761 FIG00788763: hypothetical protein +FIG00788763 FIG00788785: hypothetical protein +FIG00788785 FIG00788795: hypothetical protein +FIG00788795 FIG00788796: hypothetical protein +FIG00788796 FIG00788804: hypothetical protein +FIG00788810 FIG00788819: hypothetical protein +FIG00788835 FIG00788843: hypothetical protein +FIG00788843 FIG00788844: hypothetical protein +FIG00788844 FIG00788845: hypothetical protein +FIG00788845 FIG00788858: hypothetical protein +FIG00788858 FIG00788862: hypothetical protein +FIG00788862 FIG00788866: hypothetical protein +FIG00788866 FIG00788868: hypothetical protein +FIG00788869 FIG00788870: hypothetical protein +FIG00788870 FIG00788876: hypothetical protein +FIG00788876 FIG00788883: hypothetical protein +FIG00788883 minor tail protein +FIG00788885 protein of unknown function DUF1211 +FIG00788886 FIG00788891: hypothetical protein +FIG00788891 FIG00788893: hypothetical protein +FIG00788893 FIG00788894: hypothetical protein +FIG00788894 FIG00788898: hypothetical protein +FIG00788898 FIG00788908: hypothetical protein +FIG00788915 FIG00788917: hypothetical protein +FIG00788917 FIG00788925: hypothetical protein +FIG00788925 FIG00788940: hypothetical protein +FIG00788971 FIG00788978: hypothetical protein +FIG00788978 FIG00788979: hypothetical protein +FIG00788979 FIG00788993: hypothetical protein +FIG00788993 FIG00788995: hypothetical protein +FIG00788996 FIG00789000: hypothetical protein +FIG00789000 FIG00789006: hypothetical protein +FIG00789006 FIG00789022: hypothetical protein +FIG00789022 FIG00789024: hypothetical protein +FIG00789024 FIG00789036: hypothetical protein +FIG00789038 FIG00789047: hypothetical protein +FIG00789048 FIG00789064: hypothetical protein +FIG00789078 FIG00789082: hypothetical protein +FIG00789082 FIG00789084: hypothetical protein +FIG00789094 FIG00789095: hypothetical protein +FIG00789095 FIG00789100: hypothetical protein +FIG00789100 FIG00789108: hypothetical protein +FIG00789109 putative glycosyl hydrolase (putative secreted protein) +FIG00789121 FIG00789123: hypothetical protein +FIG00789123 FIG00789128: hypothetical protein +FIG00789128 FIG00789133: hypothetical protein +FIG00789133 FIG00789134: hypothetical protein +FIG00789134 FIG00789135: hypothetical protein +FIG00789135 FIG00789147: hypothetical protein +FIG00789147 FIG00789149: hypothetical protein +FIG00789149 Possible gluconolactonase +FIG00789150 FIG00789154: hypothetical protein +FIG00789154 FIG00789157: hypothetical protein +FIG00789157 FIG00789172: hypothetical protein +FIG00789172 FIG00789178: hypothetical protein +FIG00789178 FIG00789180: hypothetical protein +FIG00789180 FIG00789205: hypothetical protein +FIG00789205 FIG00789206: hypothetical protein +FIG00789206 FIG00789211: hypothetical protein +FIG00789211 FIG00789223: hypothetical protein +FIG00789229 FIG00789233: hypothetical protein +FIG00789234 FIG00789236: hypothetical protein +FIG00789245 FIG00789254: hypothetical protein +FIG00789254 FIG00789255: hypothetical protein +FIG00789255 FIG00789260: hypothetical protein +FIG00789264 FIG00789275: hypothetical protein +FIG00789279 FIG00789295: hypothetical protein +FIG00789295 FIG00789307: hypothetical protein +FIG00789307 FIG00789322: hypothetical protein +FIG00789322 FIG00789327: hypothetical protein +FIG00789327 FIG00789337: hypothetical protein +FIG00789337 FIG00789342: hypothetical protein +FIG00789342 FIG00789352: hypothetical protein +FIG00789355 FIG00789356: hypothetical protein +FIG00789356 FIG00789368: hypothetical protein +FIG00789368 FIG00789370: hypothetical protein +FIG00789370 FIG00789372: hypothetical protein +FIG00789375 FIG00789379: hypothetical protein +FIG00789379 FIG00789385: hypothetical protein +FIG00789413 FIG00789422: hypothetical protein +FIG00789422 FIG00789425: hypothetical protein +FIG00789425 FIG00789431: hypothetical protein +FIG00789431 FIG00789442: hypothetical protein +FIG00789442 Aminoglycoside N(6')-acetyltransferase type 1 (EC 2.3.1.82) (AAC(6')) +FIG00789444 FIG00789450: hypothetical protein +FIG00789450 Phage essential recombination function protein, Erf +FIG00789473 FIG00789481: hypothetical protein +FIG00789490 FIG00789497: hypothetical protein +FIG00789510 FIG00789511: hypothetical protein +FIG00789521 competence protein/comEA-related protein +FIG00789538 FIG00789539: hypothetical protein +FIG00789539 FIG00789542: hypothetical protein +FIG00789542 FIG00789552: hypothetical protein +FIG00789567 FIG00789570: hypothetical protein +FIG00789570 FIG00789582: hypothetical protein +FIG00789582 FIG00789586: hypothetical protein +FIG00789586 FIG00789589: hypothetical protein +FIG00789589 FIG00789592: hypothetical protein +FIG00789592 FIG00789598: hypothetical protein +FIG00789627 FIG00789629: hypothetical protein +FIG00789629 FIG00789635: hypothetical protein +FIG00789635 FIG00789638: hypothetical protein +FIG00789638 ferric enterobactin esterase-related protein +FIG00789654 FIG00789671: hypothetical protein +FIG00789671 ABC transporter ATP-binding protein (CycB) +FIG00789674 FIG00789675: hypothetical protein +FIG00789675 FIG00789677: hypothetical protein +FIG00789696 FIG00789697: hypothetical protein +FIG00789702 FIG00789706: hypothetical protein +FIG00789706 FIG00789710: hypothetical protein +FIG00789710 FIG00789722: hypothetical protein +FIG00789725 FIG00789729: hypothetical protein +FIG00789729 FIG00789747: hypothetical protein +FIG00789752 FIG00789753: hypothetical protein +FIG00789758 FIG00789759: hypothetical protein +FIG00789759 FIG00789760: hypothetical protein +FIG00789760 FIG00789770: hypothetical protein +FIG00789770 FIG00789776: hypothetical protein +FIG00789776 FIG00789782: hypothetical protein +FIG00789782 FIG00789789: hypothetical protein +FIG00789798 FIG00789809: hypothetical protein +FIG00789809 FIG00789813: hypothetical protein +FIG00789813 FIG00789815: hypothetical protein +FIG00789815 FIG00789819: hypothetical protein +FIG00789819 FIG00789830: hypothetical protein +FIG00789848 FIG00789853: hypothetical protein +FIG00789853 FIG00789871: hypothetical protein +FIG00789871 FIG00789878: hypothetical protein +FIG00789890 FIG00789891: hypothetical protein +FIG00789891 FIG00789900: hypothetical protein +FIG00789900 probable virD4 gene +FIG00789904 FIG00789905: hypothetical protein +FIG00789913 FIG00789914: hypothetical protein +FIG00789914 FIG00789917: hypothetical protein +FIG00789917 FIG00789925: hypothetical protein +FIG00789939 FIG00789949: hypothetical protein +FIG00789949 FIG00789951: hypothetical protein +FIG00789951 FIG00789966: hypothetical protein +FIG00789966 FIG00789973: hypothetical protein +FIG00789973 FIG00789978: hypothetical protein +FIG00789978 FIG00789980: hypothetical protein +FIG00789980 FIG00789981: hypothetical protein +FIG00789981 Multidrug-efflux transporter +FIG00789989 FIG00789990: hypothetical protein +FIG00789994 FIG00789996: hypothetical protein +FIG00789996 FIG00790000: hypothetical protein +FIG00790001 FIG00790011: hypothetical protein +FIG00790011 FIG00790019: hypothetical protein +FIG00790032 FIG00790040: hypothetical protein +FIG00790055 FIG00790059: hypothetical protein +FIG00790059 FIG00790073: hypothetical protein +FIG00790073 FIG00790074: hypothetical protein +FIG00790079 two-component system response regulator TcsR5 +FIG00790090 FIG00790091: hypothetical protein +FIG00790092 FIG00790093: hypothetical protein +FIG00790093 FIG00790118: hypothetical protein +FIG00790132 FIG00790141: hypothetical protein +FIG00790141 FIG00790142: hypothetical protein +FIG00790142 FIG00790144: hypothetical protein +FIG00790168 FIG00790170: hypothetical protein +FIG00790176 FIG00790189: hypothetical protein +FIG00790189 FIG00790206: hypothetical protein +FIG00790206 FIG00790208: hypothetical protein +FIG00790208 FIG00790222: hypothetical protein +FIG00790222 FIG00790235: hypothetical protein +FIG00790235 MazG nucleotide pyrophosphohydrolase +FIG00790239 FIG00790247: hypothetical protein +FIG00790247 FIG00790264: hypothetical protein +FIG00790264 putative acetamidase/Formamidase +FIG00790296 FIG00790300: hypothetical protein +FIG00790300 FIG00790308: hypothetical protein +FIG00790308 FIG00790313: hypothetical protein +FIG00790313 FIG00790318: hypothetical protein +FIG00790318 FIG00790324: hypothetical protein +FIG00790344 FIG00790364: hypothetical protein +FIG00790364 FIG00790366: hypothetical protein +FIG00790366 FIG00790369: hypothetical protein +FIG00790369 Superfamily I DNA and RNA helicases-like protein +FIG00790372 FIG00790377: hypothetical protein +FIG00790377 FIG00790383: hypothetical protein +FIG00790390 protoglobin +FIG00790401 FIG00790403: hypothetical protein +FIG00790403 FIG00790411: hypothetical protein +FIG00790411 FIG00790426: hypothetical protein +FIG00790427 FIG00790443: hypothetical protein +FIG00790463 FIG00790479: hypothetical protein +FIG00790479 FIG00790481: hypothetical protein +FIG00790481 FIG00790482: hypothetical protein +FIG00790482 putative fructose 1,6-bisphosphate aldolase( EC:4.1.2.13 ) +FIG00790529 FIG00790538: hypothetical protein +FIG00790538 FIG00790553: hypothetical protein +FIG00790565 FIG00790578: hypothetical protein +FIG00790599 FIG00790602: hypothetical protein +FIG00790625 FIG00790627: hypothetical protein +FIG00790627 FIG00790632: hypothetical protein +FIG00790633 FIG00790639: hypothetical protein +FIG00790639 FIG00790643: hypothetical protein +FIG00790650 FIG00790652: hypothetical protein +FIG00790652 branched-chain amino acid transport protein AzlC +FIG00790663 FIG00790673: hypothetical protein +FIG00790673 FIG00790691: hypothetical protein +FIG00790691 FIG00790709: hypothetical protein +FIG00790709 iron ABC transporter, periplasmic substrate-binding protein +FIG00790727 FIG00790729: hypothetical protein +FIG00790744 FIG00790756: hypothetical protein +FIG00790756 FIG00790774: hypothetical protein +FIG00790774 rod shape-determining protein MreD +FIG00790777 FIG00790787: hypothetical protein +FIG00790787 FIG00790788: hypothetical protein +FIG00790788 FIG00790790: hypothetical protein +FIG00790790 FIG00790810: hypothetical protein +FIG00790816 FIG00790817: hypothetical protein +FIG00790838 FIG00790846: hypothetical protein +FIG00790846 FIG00790875: hypothetical protein +FIG00790879 putative bleomycin resistance protein +FIG00790881 FIG00790899: hypothetical protein +FIG00790899 FIG00790906: hypothetical protein +FIG00790924 FIG00790925: hypothetical protein +FIG00790925 FIG00790933: hypothetical protein +FIG00790933 FIG00790957: hypothetical protein +FIG00790980 FIG00790981: hypothetical protein +FIG00790981 FIG00790985: hypothetical protein +FIG00790985 FIG00790988: hypothetical protein +FIG00790988 FIG00790994: hypothetical protein +FIG00791002 FIG00791015: hypothetical protein +FIG00791015 FIG00791018: hypothetical protein +FIG00791018 FIG00791019: hypothetical protein +FIG00791027 FIG00791046: hypothetical protein +FIG00791046 FIG00791059: hypothetical protein +FIG00791061 FIG00791062: hypothetical protein +FIG00791062 FIG00791075: hypothetical protein +FIG00791086 tRNA 5-methylaminomethyl-2-thiouridine synthase TusA +FIG00791088 FIG00791101: hypothetical protein +FIG00791132 FIG00791137: hypothetical protein +FIG00791137 FIG00791141: hypothetical protein +FIG00791192 FIG00791200: hypothetical protein +FIG00791200 FIG00791205: hypothetical protein +FIG00791205 FIG00791210: hypothetical protein +FIG00791215 FIG00791216: hypothetical protein +FIG00791216 FIG00791218: hypothetical protein +FIG00791218 FIG00791219: hypothetical protein +FIG00791219 FIG00791223: hypothetical protein +FIG00791379 FIG00791385: hypothetical protein +FIG00791425 FIG00791463: hypothetical protein +FIG00791468 Prolipoprotein diacylglyceryl transferase and tran +FIG00791521 unknown transmembrane protein +FIG00791568 FIG00791569: hypothetical protein +FIG00791569 FIG00791570: hypothetical protein +FIG00791576 FIG00791578: hypothetical protein +FIG00791589 FIG00791590: hypothetical protein +FIG00791597 FIG00791600: hypothetical protein +FIG00791603 FIG00791604: hypothetical protein +FIG00791606 FIG00791607: hypothetical protein +FIG00791607 FIG00791608: hypothetical protein +FIG00791611 FIG00791612: hypothetical protein +FIG00791612 FIG00791613: hypothetical protein +FIG00791616 FIG00791618: hypothetical protein +FIG00791620 FIG00791621: hypothetical protein +FIG00791621 FIG00791623: hypothetical protein +FIG00791624 FIG00791625: hypothetical protein +FIG00791628 FIG00791629: hypothetical protein +FIG00791631 EXOPOLYSACCHARIDE PRODUCTION REPRESSOR ExoX protein +FIG00791633 FIG00791636: hypothetical protein +FIG00791636 FIG00791637: hypothetical protein +FIG00791637 FIG00450046: hypothetical protein +FIG00791638 glutamyl endopeptidase (EC 3.4.21.19) +FIG00791640 FIG00791645: hypothetical protein +FIG00791648 FIG00791649: hypothetical protein +FIG00791650 FIG00791651: hypothetical protein +FIG00791654 FIG00791655: hypothetical protein +FIG00791655 hypothetical protein, putative transmembrane protein +FIG00791659 FIG00791660: hypothetical protein +FIG00791660 FIG00791661: hypothetical protein +FIG00791662 FIG00791664: hypothetical protein +FIG00791666 FIG00791667: hypothetical protein +FIG00791667 FIG00791668: hypothetical protein +FIG00791669 FIG00791670: hypothetical protein +FIG00791670 FIG00791671: hypothetical protein +FIG00791671 protein of unknown function DUF1236 +FIG00791677 FIG00791678: hypothetical protein +FIG00791682 FIG00791683: hypothetical protein +FIG00791683 FIG00791685: hypothetical protein +FIG00791685 FIG00791689: hypothetical protein +FIG00791690 FIG00791693: hypothetical protein +FIG00791696 FIG00791697: hypothetical protein +FIG00791698 Maleylacetoacetate isomerase (EC 5.2.1.2) / Glutathione S-transferase +FIG00791703 FIG00791704: hypothetical protein +FIG00791704 FIG00791707: hypothetical protein +FIG00791707 FIG00791709: hypothetical protein +FIG00791709 FIG00791710: hypothetical protein +FIG00791714 FIG00791715: hypothetical protein +FIG00791715 FIG00791716: hypothetical protein +FIG00791716 FIG00791718: hypothetical protein +FIG00791718 FIG00791721: hypothetical protein +FIG00791722 FIG00791725: hypothetical protein +FIG00791725 FIG00791726: hypothetical protein +FIG00791726 FIG00791727: hypothetical protein +FIG00791730 FIG00791738: hypothetical protein +FIG00791738 FIG00791741: hypothetical protein +FIG00791745 FIG00791746: hypothetical protein +FIG00791749 Exopolysaccharide production protein ExoF precursor +FIG00791754 FIG00791755: hypothetical protein +FIG00791759 FIG00791762: hypothetical protein +FIG00791766 FIG00791767: hypothetical protein +FIG00791769 Nucleoside ABC transporter, permease protein 2 +FIG00791771 FIG00791773: hypothetical protein +FIG00791773 FIG00791774: hypothetical protein +FIG00791774 FIG00791776: hypothetical protein +FIG00791777 FIG00791779: hypothetical protein +FIG00791795 DNA gyrase, subunit B +FIG00791803 FIG00791808: hypothetical protein +FIG00791815 ribonuclease II +FIG00791819 FIG00791820: hypothetical protein +FIG00791832 contains similarity to auxin-binding protein +FIG00791835 FIG00791836: hypothetical protein +FIG00791841 FIG00791843: hypothetical protein +FIG00791847 FIG00450081: hypothetical protein +FIG00791848 proline dipeptidase +FIG00791853 FIG00791857: hypothetical protein +FIG00791858 FIG00791859: hypothetical protein +FIG00791866 FIG00791867: hypothetical protein +FIG00791868 FIG00791869: hypothetical protein +FIG00791874 FIG00791875: hypothetical protein +FIG00791875 FIG00791876: hypothetical protein +FIG00791876 FIG00791877: hypothetical protein +FIG00791880 Nuclease +FIG00791885 FIG00791887: hypothetical protein +FIG00791887 FIG00791888: hypothetical protein +FIG00791893 FIG00791894: hypothetical protein +FIG00791901 FIG00791903: hypothetical protein +FIG00791903 Type I restriction-modification system methyltransferase subunit +FIG00791904 Magnesium and cobalt transport protein CorA +FIG00791906 FIG00791911: hypothetical protein +FIG00791911 FIG00791913: hypothetical protein +FIG00791913 FIG00791914: hypothetical protein +FIG00791914 FIG00791917: hypothetical protein +FIG00791918 FIG00791919: hypothetical protein +FIG00791919 FIG00791921: hypothetical protein +FIG00791921 Magnesium and cobalt transport protein CorA +FIG00791924 FIG00791925: hypothetical protein +FIG00791925 FIG00791926: hypothetical protein +FIG00791926 FIG01027706: hypothetical protein +FIG00791928 FIG00791929: hypothetical protein +FIG00791929 FIG00791930: hypothetical protein +FIG00791934 FIG00791936: hypothetical protein +FIG00791938 FIG00791939: hypothetical protein +FIG00791940 Putative diaminopropionate ammonia-lyase +FIG00791942 FIG00791945: hypothetical protein +FIG00791949 FIG00791952: hypothetical protein +FIG00791954 FIG00791956: hypothetical protein +FIG00791958 Conserved hypothetical protein, gene in Ubiquinol-cytochrome C chaperone locus +FIG00791960 FIG00791963: hypothetical protein +FIG00791963 FIG00791964: hypothetical protein +FIG00791977 FIG00791978: hypothetical protein +FIG00791978 FIG00791979: hypothetical protein +FIG00791981 FIG00791982: hypothetical protein +FIG00791982 FIG00791983: hypothetical protein +FIG00791983 FIG00791984: hypothetical protein +FIG00791985 FIG00791989: hypothetical protein +FIG00791990 FIG00791991: hypothetical protein +FIG00791991 FIG00791992: hypothetical protein +FIG00791992 FIG00791995: hypothetical protein +FIG00792001 FIG00792002: hypothetical protein +FIG00792002 FIG00792003: hypothetical protein +FIG00792004 FIG00792006: hypothetical protein +FIG00792010 FIG00792012: hypothetical protein +FIG00792012 FIG00792016: hypothetical protein +FIG00792016 FIG00792017: hypothetical protein +FIG00792019 FIG00792020: hypothetical protein +FIG00792021 FIG00792022: hypothetical protein +FIG00792036 FIG00792037: hypothetical protein +FIG00792039 FIG00792041: hypothetical protein +FIG00792046 FIG00792049: hypothetical protein +FIG00792052 FIG00792053: hypothetical protein +FIG00792056 FIG00792057: hypothetical protein +FIG00792058 FIG00792059: hypothetical protein +FIG00792061 FIG00792063: hypothetical protein +FIG00792065 FIG00792067: hypothetical protein +FIG00792069 osmotically inducible protein C, putative ATP/GTP binding protein +FIG00792071 FIG00792072: hypothetical protein +FIG00792072 FIG00792073: hypothetical protein +FIG00792077 probable membrane transport protein +FIG00792081 FIG00792084: hypothetical protein +FIG00792095 FIG00792097: hypothetical protein +FIG00792100 FIG00792104: hypothetical protein +FIG00792104 FIG00792107: hypothetical protein +FIG00792108 Competence lipoprotein comL precursor +FIG00792109 FIG00792111: hypothetical protein +FIG00792114 FIG00792115: hypothetical protein +FIG00792115 FIG00792116: hypothetical protein +FIG00792123 FIG00792124: hypothetical protein +FIG00792125 FIG00792126: hypothetical protein +FIG00792127 FIG00792128: hypothetical protein +FIG00792129 FIG00792132: hypothetical protein +FIG00792136 dimethylaniline monooxygenase +FIG00792137 FIG00792138: hypothetical protein +FIG00792142 FIG00792143: hypothetical protein +FIG00792144 FIG00792145: hypothetical protein +FIG00792146 transcriptional regulator (leucine-responsive) +FIG00792150 FIG00792151: hypothetical protein +FIG00792156 FIG00792158: hypothetical protein +FIG00792159 FIG00792160: hypothetical protein +FIG00792169 FIG00792170: hypothetical protein +FIG00792170 FIG00792171: hypothetical protein +FIG00792174 FIG00792175: hypothetical protein +FIG00792175 FIG00792177: hypothetical protein +FIG00792177 FIG00792179: hypothetical protein +FIG00792180 FIG00792187: hypothetical protein +FIG00792189 FIG00792190: hypothetical protein +FIG00792190 FIG00792191: hypothetical protein +FIG00792191 FIG00792192: hypothetical protein +FIG00792194 FIG00792195: hypothetical protein +FIG00792195 FIG00792200: hypothetical protein +FIG00792200 Pectin degradation protein +FIG00792202 FIG00792204: hypothetical protein +FIG00792208 Polyketide synthase modules and related proteins +FIG00792209 FIG00792215: hypothetical protein +FIG00792219 FIG00792220: hypothetical protein +FIG00792224 FIG00792227: hypothetical protein +FIG00792232 FIG00792236: hypothetical protein +FIG00792236 COG0697: Permeases of the drug/metabolite transporter (DMT) superfamily +FIG00792238 FIG00792239: hypothetical protein +FIG00792242 FIG00792246: hypothetical protein +FIG00792254 FIG00792255: hypothetical protein +FIG00792255 FIG00792256: hypothetical protein +FIG00792257 FIG00792259: hypothetical protein +FIG00792260 FIG00792264: hypothetical protein +FIG00792265 muconate lactonizing enzyme +FIG00792269 FIG00792272: hypothetical protein +FIG00792272 FIG00792273: hypothetical protein +FIG00792273 FIG00792274: hypothetical protein +FIG00792274 FIG00792275: hypothetical protein +FIG00792276 FIG00792279: hypothetical protein +FIG00792282 Bona fide RidA/YjgF/TdcF/RutC subgroup +FIG00792283 FIG00792284: hypothetical protein +FIG00792284 FIG00792286: hypothetical protein +FIG00792290 FIG00792291: hypothetical protein +FIG00792295 FIG00792299: hypothetical protein +FIG00792299 FIG00792300: hypothetical protein +FIG00792303 probable fatty acid hydroxylase +FIG00792304 FIG00792305: hypothetical protein +FIG00792310 FIG00792312: hypothetical protein +FIG00792312 Amine oxidase [flavin-containing] (EC 1.4.3.4) +FIG00792319 FIG00792320: hypothetical protein +FIG00792323 FIG00792324: hypothetical protein +FIG00792331 probable hydrocarbon oxygenase MocD +FIG00792332 FIG00792335: hypothetical protein +FIG00792338 FIG00792339: hypothetical protein +FIG00792346 FIG00792347: hypothetical protein +FIG00792350 FIG00792351: hypothetical protein +FIG00792351 similar to mannose-6-phosphate isomerase/mannose-1-phosphate guanylyl transferase( EC:2.7.7.13,EC:5.3.1.8 ) +FIG00792354 FIG00792355: hypothetical protein +FIG00792363 putative glutathione S-transferase +FIG00792364 FIG00792369: hypothetical protein +FIG00792370 FIG00792372: hypothetical protein +FIG00792373 FIG00792378: hypothetical protein +FIG00792378 FIG00792382: hypothetical protein +FIG00792382 FIG00792384: hypothetical protein +FIG00792388 mutator MutT protein +FIG00792389 FIG00792390: hypothetical protein +FIG00792392 FIG00792395: hypothetical protein +FIG00792395 FIG00792397: hypothetical protein +FIG00792399 oxido-reductase, and dehydratase mocA +FIG00792407 FIG00792409: hypothetical protein +FIG00792409 FIG00792410: hypothetical protein +FIG00792417 FIG00792419: hypothetical protein +FIG00792420 FIG00792421: hypothetical protein +FIG00792428 FIG00792429: hypothetical protein +FIG00792432 FIG00792434: hypothetical protein +FIG00792434 FIG00792436: hypothetical protein +FIG00792436 FIG00792437: hypothetical protein +FIG00792437 FIG00792438: hypothetical protein +FIG00792441 macrolide glycosyltransferase-like +FIG00792443 opine/polyamine ABC transporter, periplasmic substrate-binding protein +FIG00792452 FIG00792453: hypothetical protein +FIG00792458 FIG00792459: hypothetical protein +FIG00792461 FIG00792464: hypothetical protein +FIG00792467 arginase (EC 3.5.3.1) +FIG00792478 FIG00792479: hypothetical protein +FIG00792479 FIG00792482: hypothetical protein +FIG00792483 FIG00792485: hypothetical protein +FIG00792485 FIG00792486: hypothetical protein +FIG00792486 FIG00792487: hypothetical protein +FIG00792487 FIG00792492: hypothetical protein +FIG00792493 FIG00792494: hypothetical protein +FIG00792494 FIG00792496: hypothetical protein +FIG00792496 FIG00792499: hypothetical protein +FIG00792499 FIG00792500: hypothetical protein +FIG00792501 FIG00792502: hypothetical protein +FIG00792503 FIG00792504: hypothetical protein +FIG00792507 FIG00792508: hypothetical protein +FIG00792511 FIG00792514: hypothetical protein +FIG00792514 FIG00792515: hypothetical protein +FIG00792518 FIG00792519: hypothetical protein +FIG00792522 phage terminase, large subunit, putative +FIG00792523 multidrug-efflux transporter-like +FIG00792525 FIG00792526: hypothetical protein +FIG00792527 FIG00792528: hypothetical protein +FIG00792531 FIG00792533: hypothetical protein +FIG00792533 ribose ABC transporter +FIG00792543 FIG00792544: hypothetical protein +FIG00792551 CELL PROCESSES; Transport of small molecules; carbohydrates, organic acids, alcohols +FIG00792552 Probably methylase/helicase +FIG00792553 proteinase (kallikrein, trypsin III, kallikrein-like serine protease) +FIG00792555 FIG00450785: hypothetical protein +FIG00792556 FIG00792558: hypothetical protein +FIG00792560 FIG00792561: hypothetical protein +FIG00792561 FIG00792562: hypothetical protein +FIG00792565 FIG00792566: hypothetical protein +FIG00792567 FIG00451037: hypothetical protein +FIG00792574 FIG00792577: hypothetical protein +FIG00792579 FIG00792581: hypothetical protein +FIG00792582 FIG00792584: hypothetical protein +FIG00792589 FIG00792590: hypothetical protein +FIG00792591 FIG00792592: hypothetical protein +FIG00792592 FIG00792593: hypothetical protein +FIG00792593 FIG00792595: hypothetical protein +FIG00792595 FIG00792596: hypothetical protein +FIG00792596 FIG00792597: hypothetical protein +FIG00792597 FIG00792598: hypothetical protein +FIG00792599 FIG00792600: hypothetical protein +FIG00792602 FIG00792603: hypothetical protein +FIG00792603 FIG00792604: hypothetical protein +FIG00792606 putative integral membrane transporter protein +FIG00792610 FIG00792612: hypothetical protein +FIG00792612 FIG00792613: hypothetical protein +FIG00792621 FIG00792627: hypothetical protein +FIG00792629 FIG00792630: hypothetical protein +FIG00792630 transcriptional activator protein ampR +FIG00792640 FIG00792641: hypothetical protein +FIG00792647 FIG00792648: hypothetical protein +FIG00792649 FIG00792650: hypothetical protein +FIG00792653 FIG00792654: hypothetical protein +FIG00792654 FIG00792655: hypothetical protein +FIG00792655 FIG00792656: hypothetical protein +FIG00792656 FIG00792659: hypothetical protein +FIG00792659 COG0500: SAM-dependent methyltransferases +FIG00792660 FIG00792661: hypothetical protein +FIG00792664 phosphinotricin acetyltransferase +FIG00792669 Mlr4106 protein +FIG00792673 FIG00792675: hypothetical protein +FIG00792676 FIG00792680: hypothetical protein +FIG00792680 FIG00792682: hypothetical protein +FIG00792686 FIG00792687: hypothetical protein +FIG00792691 FIG00792692: hypothetical protein +FIG00792695 FIG00792697: hypothetical protein +FIG00792706 FIG00792707: hypothetical protein +FIG00792707 FIG00792709: hypothetical protein +FIG00792711 Dipeptide transport system permease protein dppB +FIG00792714 FIG00792715: hypothetical protein +FIG00792719 FIG00792722: hypothetical protein +FIG00792737 FIG00792739: hypothetical protein +FIG00792739 FIG00792740: hypothetical protein +FIG00792755 FIG00792758: hypothetical protein +FIG00792758 FIG00792761: hypothetical protein +FIG00792781 COG0728: Uncharacterized membrane protein, putative virulence factor +FIG00792783 FIG00792786: hypothetical protein +FIG00792786 FIG00792787: hypothetical protein +FIG00792787 FIG00792789: hypothetical protein +FIG00792793 FIG00792795: hypothetical protein +FIG00792795 FIG00792796: hypothetical protein +FIG00792805 FIG00792806: hypothetical protein +FIG00792806 FIG00792807: hypothetical protein +FIG00792809 FIG00792810: hypothetical protein +FIG00792815 FIG00792818: hypothetical protein +FIG00792822 FIG00985384: hypothetical protein +FIG00792823 weak similarity to chloramphenicol phosphotransferase +FIG00792833 FIG00792834: hypothetical protein +FIG00792862 FIG00792864: hypothetical protein +FIG00792864 TRANSCRIPTIONAL REGULATORY PROTEIN HYDG +FIG00792869 FIG00792870: hypothetical protein +FIG00792870 FIG00792875: hypothetical protein +FIG00792879 Hydrolase (EC 3.8.1.2) +FIG00792881 homoserine kinase +FIG00792882 FIG00792884: hypothetical protein +FIG00792892 FIG00792893: hypothetical protein +FIG00792898 FIG00792899: hypothetical protein +FIG00792900 FIG00792904: hypothetical protein +FIG00792908 FIG00792909: hypothetical protein +FIG00792913 aminomethyl transferase family protein +FIG00792919 FIG00792920: hypothetical protein +FIG00792925 FIG00792933: hypothetical protein +FIG00792941 ABC-type sugar transport system periplasmic component-like protein +FIG00792949 3-oxoacyl-[acyl-carrier protein] reductase (EC 1.1.1.100), inferred for ABFAE pathway +FIG00792957 FIG00792958: hypothetical protein +FIG00792959 FIG00792960: hypothetical protein +FIG00792960 FIG00792961: hypothetical protein +FIG00792968 FIG00792971: hypothetical protein +FIG00792971 FIG00792973: hypothetical protein +FIG00792977 FIG00792978: hypothetical protein +FIG00792982 FIG00792984: hypothetical protein +FIG00792988 FIG00792989: hypothetical protein +FIG00792989 FIG00792992: hypothetical protein +FIG00792993 FIG00792994: hypothetical protein +FIG00792996 FIG00793000: hypothetical protein +FIG00793000 FIG00793001: hypothetical protein +FIG00793004 FIG00793005: hypothetical protein +FIG00793005 FIG00793007: hypothetical protein +FIG00793009 FIG00793010: hypothetical protein +FIG00793011 FIG00793012: hypothetical protein +FIG00793012 FIG00793013: hypothetical protein +FIG00793015 FIG00793016: hypothetical protein +FIG00793016 Arylmalonate decarboxylase (EC 4.1.1.76) +FIG00793020 FIG00793021: hypothetical protein +FIG00793021 FIG00793022: hypothetical protein +FIG00793023 FIG00793024: hypothetical protein +FIG00793025 FIG00793026: hypothetical protein +FIG00793026 ABC-transport system ATP binding protein +FIG00793028 FIG00793031: hypothetical protein +FIG00793036 FIG00793037: hypothetical protein +FIG00793045 FIG00793048: hypothetical protein +FIG00793049 f125 +FIG00793054 FIG00793056: hypothetical protein +FIG00793056 FIG00793058: hypothetical protein +FIG00793058 FIG00793059: hypothetical protein +FIG00793061 FIG00793062: hypothetical protein +FIG00793064 FIG00793069: hypothetical protein +FIG00793071 FIG00793074: hypothetical protein +FIG00793089 FIG00793090: hypothetical protein +FIG00793091 FIG00793092: hypothetical protein +FIG00793092 aromatic-L-amino-acid decarboxylase +FIG00793097 FIG00793098: hypothetical protein +FIG00793098 FIG00793103: hypothetical protein +FIG00793103 FIG00793105: hypothetical protein +FIG00793105 FIG00793108: hypothetical protein +FIG00793108 FIG00793110: hypothetical protein +FIG00793110 FIG00793111: hypothetical protein +FIG00793111 FIG00793113: hypothetical protein +FIG00793113 methyl transferase-like protein +FIG00793120 macrocin-O-methyltransferase +FIG00793121 FIG00793124: hypothetical protein +FIG00793125 FIG00793127: hypothetical protein +FIG00793127 FIG00793128: hypothetical protein +FIG00793128 FIG00450539: hypothetical protein +FIG00793131 FIG00793132: hypothetical protein +FIG00793132 FIG00793136: hypothetical protein +FIG00793144 NodF +FIG00793145 FIG00793148: hypothetical protein +FIG00793154 FIG00793156: hypothetical protein +FIG00793156 FIG00793158: hypothetical protein +FIG00793163 FIG00793164: hypothetical protein +FIG00793173 Oligopeptide ABC transporter, periplasmic oligopeptide-binding protein +FIG00793180 FIG00793182: hypothetical protein +FIG00793182 FIG00793184: hypothetical protein +FIG00793186 Putative TetR-family transcriptional regulator +FIG00793192 FIG00793193: hypothetical protein +FIG00793193 FIG00793194: hypothetical protein +FIG00793198 FIG00793200: hypothetical protein +FIG00793200 probable phage repressor protein C +FIG00793206 FIG00793207: hypothetical protein +FIG00793211 FIG00793212: hypothetical protein +FIG00793215 23S ribosomal RNA methyltransferase +FIG00793220 Glutamine transport system permease protein glnP (TC 3.A.1.3.2) +FIG00793221 FIG00793225: hypothetical protein +FIG00793226 FIG00793227: hypothetical protein +FIG00793229 FIG00793230: hypothetical protein +FIG00793232 FIG00793234: hypothetical protein +FIG00793234 FIG00793235: hypothetical protein +FIG00793235 FIG00793236: hypothetical protein +FIG00793236 FIG00793237: hypothetical protein +FIG00793237 FIG00793240: hypothetical protein +FIG00793243 probable RNA polymerase sigma factor +FIG00793245 POLYSACCHARIDE DEACETYLASE +FIG00793249 FIG00793251: hypothetical protein +FIG00793251 FIG00793252: hypothetical protein +FIG00793254 blr2149; hypothetical protein +FIG00793261 FIG00793262: hypothetical protein +FIG00793265 FIG00793266: hypothetical protein +FIG00793266 FIG00793267: hypothetical protein +FIG00793269 FIG00793270: hypothetical protein +FIG00793270 FIG00793273: hypothetical protein +FIG00793273 FIG00793278: hypothetical protein +FIG00793280 FIG00450156: hypothetical protein +FIG00793281 FIG00793283: hypothetical protein +FIG00793287 FIG00793289: hypothetical protein +FIG00793291 FIG00793293: hypothetical protein +FIG00793293 Mlr9176 protein +FIG00793295 FIG00793296: hypothetical protein +FIG00793296 FIG00793297: hypothetical protein +FIG00793305 FIG00793310: hypothetical protein +FIG00793310 Glutamine ABC transporter, ATP-binding protein GlnQ +FIG00793311 FIG00793313: hypothetical protein +FIG00793320 FIG00793325: hypothetical protein +FIG00793330 FIG00793331: hypothetical protein +FIG00793331 FIG00793332: hypothetical protein +FIG00793333 FIG00793337: hypothetical protein +FIG00793341 two-component sensor/response regulator hybrid +FIG00793342 FIG00793346: hypothetical protein +FIG00793347 (U87316) orf4; putative +FIG00793354 FIG00793358: hypothetical protein +FIG00793360 FIG00451007: hypothetical protein +FIG00793369 FIG00793371: hypothetical protein +FIG00793372 FIG00793373: hypothetical protein +FIG00793373 FIG00793374: hypothetical protein +FIG00793374 transcriptional activator (glycine cleavage system transcription activator(GcvA)) +FIG00793377 FIG00793380: hypothetical protein +FIG00793381 FIG00793383: hypothetical protein +FIG00793383 FIG00793384: hypothetical protein +FIG00793388 chloromuconate cycloisomerase +FIG00793392 two-component transcriptional regulator +FIG00793394 FIG00793396: hypothetical protein +FIG00793396 FIG00793398: hypothetical protein +FIG00793411 lipopolysaccharide core biosynthesis protein lpsA +FIG00793418 FIG00793420: hypothetical protein +FIG00793422 ABC transporter,binding protein +FIG00793424 FIG00793426: hypothetical protein +FIG00793429 FIG00793431: hypothetical protein +FIG00793431 FIG00793433: hypothetical protein +FIG00793434 NADH oxidoreductase +FIG00793435 FIG00793437: hypothetical protein +FIG00793437 FIG00793438: hypothetical protein +FIG00793438 FIG00793439: hypothetical protein +FIG00793441 FIG00793442: hypothetical protein +FIG00793442 FIG00793443: hypothetical protein +FIG00793447 FIG00793449: hypothetical protein +FIG00793450 FIG00793453: hypothetical protein +FIG00793453 FIG00793454: hypothetical protein +FIG00793457 FIG00793458: hypothetical protein +FIG00793458 FIG00793459: hypothetical protein +FIG00793461 FIG00793462: hypothetical protein +FIG00793463 FIG00793468: hypothetical protein +FIG00793475 permease protein of dipeptide ABC transporter +FIG00793476 FIG00793478: hypothetical protein +FIG00793482 FIG00793483: hypothetical protein +FIG00793485 FIG00793488: hypothetical protein +FIG00793495 FIG00793497: hypothetical protein +FIG00793499 FIG00793500: hypothetical protein +FIG00793501 FIG00793502: hypothetical protein +FIG00793502 probable multidrug efflux protein +FIG00793505 FIG00793506: hypothetical protein +FIG00793511 YceI +FIG00793512 FIG00793514: hypothetical protein +FIG00793518 FIG00793519: hypothetical protein +FIG00793519 PROBABLE UDP-N-ACETYL-D-MANNOSAMINURONIC ACID TRANSFERASE +FIG00793521 weak similarity to phospholipase +FIG00793524 FIG00793525: hypothetical protein +FIG00793525 FIG00793527: hypothetical protein +FIG00793527 FIG00793528: hypothetical protein +FIG00793528 Mll5001 protein +FIG00793529 FIG00793531: hypothetical protein +FIG00793531 FIG00793532: hypothetical protein +FIG00793532 FIG00793535: hypothetical protein +FIG00793540 FIG00793543: hypothetical protein +FIG00793544 FIG00793546: hypothetical protein +FIG00793547 FIG00793550: hypothetical protein +FIG00793562 FIG00450254: hypothetical protein +FIG00793574 FIG00793576: hypothetical protein +FIG00793579 FIG00793580: hypothetical protein +FIG00793580 FIG00793582: hypothetical protein +FIG00793582 FIG00793584: hypothetical protein +FIG00793591 FIG00793592: hypothetical protein +FIG00793593 FIG00793594: hypothetical protein +FIG00793594 FIG00793598: hypothetical protein +FIG00793602 FIG00793607: hypothetical protein +FIG00793607 FIG00793610: hypothetical protein +FIG00793610 FIG00793612: hypothetical protein +FIG00793612 Bll0057 protein +FIG00793614 FIG00793615: hypothetical protein +FIG00793619 FIG00793620: hypothetical protein +FIG00793620 FIG00793622: hypothetical protein +FIG00793622 FIG00793623: hypothetical protein +FIG00793623 FIG00793624: hypothetical protein +FIG00793624 FIG00793629: hypothetical protein +FIG00793632 Extensin-like +FIG00793633 FIG00793635: hypothetical protein +FIG00793636 FIG00793638: hypothetical protein +FIG00793648 FIG00793649: hypothetical protein +FIG00793660 FIG00793661: hypothetical protein +FIG00793661 FIG00793662: hypothetical protein +FIG00793662 FIG00793665: hypothetical protein +FIG00793665 FIG00793666: hypothetical protein +FIG00793668 FIG00793671: hypothetical protein +FIG00793671 FIG00793673: hypothetical protein +FIG00793673 FIG00793678: hypothetical protein +FIG00793678 metalloprotease transporter +FIG00793684 FIG00793685: hypothetical protein +FIG00793699 FIG00793700: hypothetical protein +FIG00793700 FIG00450271: hypothetical protein +FIG00793704 FIG00793705: hypothetical protein +FIG00793710 FIG00793711: hypothetical protein +FIG00793711 FIG00793712: hypothetical protein +FIG00793712 FIG00793713: hypothetical protein +FIG00793716 FIG00793717: hypothetical protein +FIG00793720 CONSERVED HYPOTHETICAL SIGNAL PEPTIDE PROTEIN +FIG00793721 FIG00793725: hypothetical protein +FIG00793725 FIG00793727: hypothetical protein +FIG00793728 FIG00793730: hypothetical protein +FIG00793731 FIG00793732: hypothetical protein +FIG00793732 FIG00793735: hypothetical protein +FIG00793736 FIG00793737: hypothetical protein +FIG00793740 FIG00793741: hypothetical protein +FIG00793746 aldo/keto reductase homolog +FIG00793752 FIG00793753: hypothetical protein +FIG00793753 FIG00793754: hypothetical protein +FIG00793754 periplasmic ATP/GTP-binding protein +FIG00793763 FIG00793764: hypothetical protein +FIG00793765 FIG00793768: hypothetical protein +FIG00793775 FIG00793776: hypothetical protein +FIG00793776 putative ammonia monooxygenase +FIG00793779 FIG00793781: hypothetical protein +FIG00793781 FIG00793782: hypothetical protein +FIG00793788 FIG00793789: hypothetical protein +FIG00793802 FIG00793803: hypothetical protein +FIG00793803 FIG00793804: hypothetical protein +FIG00793804 FIG00793806: hypothetical protein +FIG00793806 FIG00793807: hypothetical protein +FIG00793807 FIG00793808: hypothetical protein +FIG00793808 TPR repeat, SEL1 subfamily +FIG00793815 FIG00793820: hypothetical protein +FIG00793829 putative transmembrane efflux protei +FIG00793830 FIG00793831: hypothetical protein +FIG00793838 FIG00793839: hypothetical protein +FIG00793839 Mlr0938 protein +FIG00793840 FIG00793841: hypothetical protein +FIG00793857 FIG00793859: hypothetical protein +FIG00793861 FIG00793862: hypothetical protein +FIG00793869 FIG00793870: hypothetical protein +FIG00793870 FIG00793873: hypothetical protein +FIG00793873 FIG00793876: hypothetical protein +FIG00793881 FIG00793882: hypothetical protein +FIG00793890 similar to transcription negative regulator ChrR +FIG00793891 FIG00793892: hypothetical protein +FIG00793898 FIG00793900: hypothetical protein +FIG00793900 FIG00793904: hypothetical protein +FIG00793904 FIG00793906: hypothetical protein +FIG00793907 FIG00793908: hypothetical protein +FIG00793908 FIG00793909: hypothetical protein +FIG00793911 FIG00793912: hypothetical protein +FIG00793913 FIG00793914: hypothetical protein +FIG00793914 FIG00793915: hypothetical protein +FIG00793916 FIG00793917: hypothetical protein +FIG00793921 FIG00793922: hypothetical protein +FIG00793924 FIG00793926: hypothetical protein +FIG00793926 FIG00793927: hypothetical protein +FIG00793927 FIG00793928: hypothetical protein +FIG00793931 usg protein - Caulobacter crescentus +FIG00793932 FIG00793933: hypothetical protein +FIG00793939 FIG00793942: hypothetical protein +FIG00793942 FIG00793943: hypothetical protein +FIG00793943 FIG00793944: hypothetical protein +FIG00793945 FIG00793946: hypothetical protein +FIG00793949 FIG00793952: hypothetical protein +FIG00793956 FIG00793957: hypothetical protein +FIG00793957 TWO COMPONENT RESPONSE REGULATOR +FIG00793958 FIG00793962: hypothetical protein +FIG00793962 FIG00793963: hypothetical protein +FIG00793971 FIG00793973: hypothetical protein +FIG00793977 probable RND efflux membrane fusion protein precursor +FIG00793979 FIG00793980: hypothetical protein +FIG00793995 FIG00793996: hypothetical protein +FIG00793997 FIG00793998: hypothetical protein +FIG00794002 FIG00794003: hypothetical protein +FIG00794009 PilA-like protein +FIG00794012 FIG00794014: hypothetical protein +FIG00794014 FIG00794015: hypothetical protein +FIG00794015 FIG00794016: hypothetical protein +FIG00794016 FIG00794019: hypothetical protein +FIG00794019 tRNA uridine 5-carboxymethylaminomethyl modification enzyme gid +FIG00794024 FIG00794025: hypothetical protein +FIG00794028 FIG00794029: hypothetical protein +FIG00794029 FIG00794030: hypothetical protein +FIG00794031 FIG00794032: hypothetical protein +FIG00794032 COG1872 +FIG00794052 ExsE protein(ABC transporter, ATP-binding protein) +FIG00794054 FIG00794056: hypothetical protein +FIG00794056 FIG00794059: hypothetical protein +FIG00794059 FIG00794060: hypothetical protein +FIG00794063 FIG00794064: hypothetical protein +FIG00794069 Glycosyl Hydrolase, Cellulase, Family +FIG00794073 FIG00794074: hypothetical protein +FIG00794075 FIG00794077: hypothetical protein +FIG00794077 FIG00794078: hypothetical protein +FIG00794079 FIG00794080: hypothetical protein +FIG00794082 FIG00794083: hypothetical protein +FIG00794083 binding protein component precursor of ABC ribose transporter +FIG00794091 FIG00794094: hypothetical protein +FIG00794094 FIG00794096: hypothetical protein +FIG00794096 FIG00794097: hypothetical protein +FIG00794097 FIG00794098: hypothetical protein +FIG00794104 FIG00794107: hypothetical protein +FIG00794111 FIG00794118: hypothetical protein +FIG00794140 FIG00794141: hypothetical protein +FIG00794142 FIG00794143: hypothetical protein +FIG00794146 FIG00878931: hypothetical protein +FIG00794147 FIG00794149: hypothetical protein +FIG00794164 FIG00794167: hypothetical protein +FIG00794167 FIG00794171: hypothetical protein +FIG00794171 FIG00794172: hypothetical protein +FIG00794175 FIG00794177: hypothetical protein +FIG00794177 Pyridoxamine-pyruvate aminotransferase (EC 2.6.1.30) +FIG00794189 response sensor protein +FIG00794193 FIG00794195: hypothetical protein +FIG00794198 spermidine/putrescine ABC transporter, permease protein +FIG00794202 FIG00794203: hypothetical protein +FIG00794206 contains similarity to D-alanine:D-lactate ligase +FIG00794209 FIG00794210: hypothetical protein +FIG00794214 FIG00794218: hypothetical protein +FIG00794218 FIG00794220: hypothetical protein +FIG00794223 hypothetical protein +FIG00794226 cytochrome c556 +FIG00794229 FIG00794231: hypothetical protein +FIG00794233 FIG00794234: hypothetical protein +FIG00794250 FIG00794251: hypothetical protein +FIG00794252 FIG00794253: hypothetical protein +FIG00794253 FIG00794255: hypothetical protein +FIG00794258 FIG00794260: hypothetical protein +FIG00794260 4-hydroxybenzoyl-CoA reductase, alpha subunit (EC 1.3.99.20) +FIG00794264 FIG00794266: hypothetical protein +FIG00794268 FIG00794277: hypothetical protein +FIG00794277 FIG00794278: hypothetical protein +FIG00794278 regulatory protein, VirG protein +FIG00794288 FIG00794289: hypothetical protein +FIG00794291 FIG00794293: hypothetical protein +FIG00794293 FIG00794294: hypothetical protein +FIG00794302 FIG00794303: hypothetical protein +FIG00794303 FIG00794307: hypothetical protein +FIG00794308 FIG00794309: hypothetical protein +FIG00794309 FIG00794311: hypothetical protein +FIG00794312 Small molecule metabolism; Degradation; amino acids +FIG00794316 FIG00794317: hypothetical protein +FIG00794320 FIG00794322: hypothetical protein +FIG00794328 FIG00794332: hypothetical protein +FIG00794334 protein of unknown function DUF606 +FIG00794337 FIG00794340: hypothetical protein +FIG00794340 FIG00450516: Zinc-finger domain protein +FIG00794341 FIG00794342: hypothetical protein +FIG00794365 FIG00794366: hypothetical protein +FIG00794367 FIG00794372: hypothetical protein +FIG00794372 FIG00794373: hypothetical protein +FIG00794376 FIG00794377: hypothetical protein +FIG00794379 FIG00794380: hypothetical protein +FIG00794384 FIG00794386: hypothetical protein +FIG00794386 FIG00794387: hypothetical protein +FIG00794388 FIG00794390: hypothetical protein +FIG00794393 FIG00794396: hypothetical protein +FIG00794398 FIG00794401: hypothetical protein +FIG00794402 FIG00794405: hypothetical protein +FIG00794405 FIG00794408: hypothetical protein +FIG00794417 4-pyridoxic acid dehydrogenase / 3-hydroxybutyryl-CoA dehydrogenase (EC 1.1.1.157) +FIG00794418 FIG00794421: hypothetical protein +FIG00794425 FIG00451006: hypothetical protein +FIG00794430 transglycosylase +FIG00794431 FIG00794433: hypothetical protein +FIG00794435 ABC transporter, periplasmic spermidine putrescine-binding protein potD (TC_3.A.1.11.1) +FIG00794438 FIG00794439: hypothetical protein +FIG00794439 FIG00794443: hypothetical protein +FIG00794451 FIG00794455: hypothetical protein +FIG00794455 FIG00794456: hypothetical protein +FIG00794456 FIG00794458: hypothetical protein +FIG00794459 FIG00794460: hypothetical protein +FIG00794461 Chaperone required for the assembly of the mitochondrial F1-ATPase +FIG00794465 FIG00794466: hypothetical protein +FIG00794467 FIG00794468: hypothetical protein +FIG00794468 FIG00794473: hypothetical protein +FIG00794475 FIG00794478: hypothetical protein +FIG00794480 FIG00794481: hypothetical protein +FIG00794494 Homospermidine synthase (EC 2.5.1.44) +FIG00794498 spermidine/putrescine ABC transporter, periplasmic spermidine/putrescine-binding protein +FIG00794501 FIG00794505: hypothetical protein +FIG00794505 FIG00794509: hypothetical protein +FIG00794509 FIG00794510: hypothetical protein +FIG00794515 FIG00794518: hypothetical protein +FIG00794523 FIG00794525: hypothetical protein +FIG00794525 FIG00794528: hypothetical protein +FIG00794529 FIG00794532: hypothetical protein +FIG00794534 FIG00794537: hypothetical protein +FIG00794537 ALPHA-GLUCOSIDES TRANSPORT ATP-BINDING PROTEIN AGLK +FIG00794538 FIG00794540: hypothetical protein +FIG00794541 FIG00794542: hypothetical protein +FIG00794542 FIG00794543: hypothetical protein +FIG00794543 FIG00794544: hypothetical protein +FIG00794544 FIG00794545: hypothetical protein +FIG00794547 streptomycin phosphotransferase +FIG00794550 FIG00794551: hypothetical protein +FIG00794551 FIG00794552: hypothetical protein +FIG00794573 FIG00794576: hypothetical protein +FIG00794589 cellulase +FIG00794607 FIG00794609: hypothetical protein +FIG00794612 FIG00794613: hypothetical protein +FIG00794620 FIG00794622: hypothetical protein +FIG00794635 FIG00794638: hypothetical protein +FIG00794638 FIG00794639: hypothetical protein +FIG00794641 FIG00794642: hypothetical protein +FIG00794642 FIG00794643: hypothetical protein +FIG00794645 FIG00794646: hypothetical protein +FIG00794651 FIG00794652: hypothetical protein +FIG00794660 FIG00794662: hypothetical protein +FIG00794665 FIG00794666: hypothetical protein +FIG00794666 FIG00794667: hypothetical protein +FIG00794671 FIG00794672: hypothetical protein +FIG00794672 FIG00794673: hypothetical protein +FIG00794680 FIG00794681: hypothetical protein +FIG00794693 FIG00794694: hypothetical protein +FIG00794696 FIG00794697: hypothetical protein +FIG00794699 FIG00794701: hypothetical protein +FIG00794701 FIG00794702: hypothetical protein +FIG00794706 permease protein of amino acid ABC transporter +FIG00794712 FIG038675: hypothetical protein +FIG00794715 FIG00794721: hypothetical protein +FIG00794723 FIG00794726: hypothetical protein +FIG00794726 FIG00794727: hypothetical protein +FIG00794732 FIG00794735: hypothetical protein +FIG00794739 FIG00794741: hypothetical protein +FIG00794746 FIG00794750: hypothetical protein +FIG00794750 FIG00794751: hypothetical protein +FIG00794752 protein of unknown function DUF1625 +FIG00794765 Tagatose 1,6-bisphosphate aldolase (EC 4.1.2.40) +FIG00794770 FIG00794772: hypothetical protein +FIG00794778 FIG00794780: hypothetical protein +FIG00794780 FIG00794782: hypothetical protein +FIG00794785 ABC transporter (substrate-binding protein) +FIG00794788 FIG00794791: hypothetical protein +FIG00794791 FIG00794792: hypothetical protein +FIG00794792 FIG00794793: hypothetical protein +FIG00794798 arylamine N-acetyltransferase (EC 2.3.1.5) +FIG00794799 CYTOCHROME P450 +FIG00794804 ribose binding protein of ABC transporter +FIG00794811 FIG00794812: hypothetical protein +FIG00794814 FIG00794815: hypothetical protein +FIG00794819 FIG00794821: hypothetical protein +FIG00794823 FIG00794826: hypothetical protein +FIG00794835 FIG00794836: hypothetical protein +FIG00794836 FIG00794837: hypothetical protein +FIG00794837 FIG00794838: hypothetical protein +FIG00794838 COG1355, Predicted dioxygenase / COG2078: Uncharacterized ACR +FIG00794842 FIG00794845: hypothetical protein +FIG00794845 FIG00794846: hypothetical protein +FIG00794846 FIG00794847: hypothetical protein +FIG00794851 FIG00794852: hypothetical protein +FIG00794857 FIG00794859: hypothetical protein +FIG00794868 short chain dehydrogenase/reductase +FIG00794872 FIG00794874: hypothetical protein +FIG00794876 FIG00794878: hypothetical protein +FIG00794878 FIG00794880: hypothetical protein +FIG00794880 FIG00794881: hypothetical protein +FIG00794886 FIG00794888: hypothetical protein +FIG00794894 FIG00794895: hypothetical protein +FIG00794904 FIG00794907: hypothetical protein +FIG00794913 FIG00794914: hypothetical protein +FIG00794916 FIG00794921: hypothetical protein +FIG00794923 FIG00794925: hypothetical protein +FIG00794928 FIG00794930: hypothetical protein +FIG00794933 FIG00794942: hypothetical protein +FIG00794942 transcriptional regulator, nolR protein +FIG00794950 FIG00794951: hypothetical protein +FIG00794954 FIG00794955: hypothetical protein +FIG00794955 ABC sugar transport ATP binding protein +FIG00794956 FIG00794960: hypothetical protein +FIG00794967 Oxidoreductase ucpA +FIG00794968 FIG00794973: hypothetical protein +FIG00794983 FIG00794985: hypothetical protein +FIG00794985 FIG00794992: hypothetical protein +FIG00794998 FIG00794999: hypothetical protein +FIG00795006 succinoglycan biosynthesis transport protein +FIG00795016 FIG00795017: hypothetical protein +FIG00795021 probable FAD-dependent monooxygenase +FIG00795026 FIG00795028: hypothetical protein +FIG00795028 FIG00795031: hypothetical protein +FIG00795031 2-(acetamidomethylene)succinate hydrolase (EC 3.5.1.29) +FIG00795035 sugar ABC transporter, periplasmic binding protein +FIG00795048 Major facilitator transporter +FIG00795049 FIG00795050: hypothetical protein +FIG00795052 FIG00795053: hypothetical protein +FIG00795054 FIG00795055: hypothetical protein +FIG00795061 FIG00795064: hypothetical protein +FIG00795067 FIG00795070: hypothetical protein +FIG00795077 peptidase inhibitor, Kazal family +FIG00795084 FIG00795086: hypothetical protein +FIG00795089 FIG00795090: hypothetical protein +FIG00795107 FIG00795108: hypothetical protein +FIG00795108 probable binding protein component of amino acid ABC transporter +FIG00795115 probable reductase +FIG00795117 ABC transporter protein, ATP binding component +FIG00795118 FIG00795123: hypothetical protein +FIG00795123 FIG00795124: hypothetical protein +FIG00795124 FIG00795126: hypothetical protein +FIG00795126 FIG00795132: hypothetical protein +FIG00795132 FIG00795133: hypothetical protein +FIG00795135 FIG00795136: hypothetical protein +FIG00795138 FIG00795141: hypothetical protein +FIG00795142 FIG00795145: hypothetical protein +FIG00795145 FIG00795146: hypothetical protein +FIG00795146 FIG00795149: hypothetical protein +FIG00795149 FIG00795150: hypothetical protein +FIG00795173 FIG00795176: hypothetical protein +FIG00795176 FIG00795177: hypothetical protein +FIG00795177 probable RNA polymerase sigma subunit +FIG00795181 probable secreted solute-binding protein +FIG00795188 probable mdcF malonate transporter +FIG00795190 FIG00795193: hypothetical protein +FIG00795194 glutamine-binding protein, glutamine ABC transporter +FIG00795219 FIG00795220: hypothetical protein +FIG00795222 resembles Y4DW of Rhizobium sp. +FIG00795225 FIG00795227: hypothetical protein +FIG00795242 FIG00795244: hypothetical protein +FIG00795246 FIG00795252: hypothetical protein +FIG00795252 FIG00795254: hypothetical protein +FIG00795254 FIG00795255: hypothetical protein +FIG00795258 FIG00795259: hypothetical protein +FIG00795262 FIG00795263: hypothetical protein +FIG00795279 FIG00795283: hypothetical protein +FIG00795287 FIG00795288: hypothetical protein +FIG00795289 FIG00795291: hypothetical protein +FIG00795295 FIG00795296: hypothetical protein +FIG00795304 Probable ABC transporter periplasmic-binding protein y4mI precursor +FIG00795309 FIG00795310: hypothetical protein +FIG00795325 FIG00795326: hypothetical protein +FIG00795347 FIG00795348: hypothetical protein +FIG00795358 FIG00795359: hypothetical protein +FIG00795359 FIG00795362: hypothetical protein +FIG00795365 FIG00795368: hypothetical protein +FIG00795368 endo-1,3-1,4-beta-glycanase +FIG00795371 Uncharacterized protein MJ0989 +FIG00795374 Uncharacterized protein MJ1360 +FIG00795376 Uncharacterized protein MJ0903 +FIG00795377 Complete genome; segment 3/5 +FIG00795378 Uncharacterized protein MJ0546 +FIG00795379 Uncharacterized protein MJ1470 +FIG00795388 Uncharacterized protein MJ0764 +FIG00795390 Protein similar to polyadenylation specificity factor, MJ0162 type +FIG00795395 Uncharacterized protein MJ0497 +FIG00795396 Uncharacterized protein MJ0954 precursor +FIG00795399 Ammonia transporter +FIG00795405 Predicted ATP-dependent carboligase related to biotin carboxylase +FIG00795413 Deoxycytidine triphosphate deaminase (EC 3.5.4.30) (dUMP-forming) +FIG00795415 Uncharacterized protein MTH_1195 +FIG00795426 Uncharacterized protein MJ0575 +FIG00795429 Biotin synthase-related protein in some methanogens +FIG00795432 Uncharacterized protein MJ0916 +FIG00795434 Uncharacterized protein MJ0596 +FIG00795439 Uncharacterized protein MJ0531 +FIG00795441 Uncharacterized protein MJ0966 +FIG00795444 Uncharacterized protein MJ0482 +FIG00795450 Biosynthetic Aromatic amino acid aminotransferase beta (EC 2.6.1.57) @ LL-diaminopimelate aminotransferase (EC 2.6.1.83), methanococcal +FIG00795453 Uncharacterized protein MJ1032 +FIG00795454 H(2)-dependent methylenetetrahydromethanopterin dehydrogenase related protein +FIG00795456 UPF0132 membrane protein MJ1527 +FIG00795457 UPF0118 membrane protein MJ1177 +FIG00795458 UPF0280 protein MA_1715 +FIG00795460 Transcriptional regulator, LysR Family Member +FIG00795461 UPF0333 protein MMP0903 +FIG00795466 Uncharacterized protein MJ1106 +FIG00795468 Uncharacterized protein MJ1079 +FIG00795471 UPF0104 membrane protein MTH_1261 +FIG00795477 Uncharacterized protein MJ1506 +FIG00795485 Uncharacterized protein MJ0290 +FIG00795502 UPF0305 protein MJ0646 +FIG00795503 polyprenyl synthetase +FIG00795507 Uncharacterized protein AF_2307 +FIG00795509 Protein-N(5)-glutamine methyltransferase PrmC, methylates polypeptide chain release factors RF1 and RF2 +FIG00795510 Metallo-phosphoesterase:Serine/threonine- specific protein phosphatase +FIG00795515 UPF0127 protein MJ1496 +FIG00795516 OB-fold nucleic acid binding domain protein +FIG00795526 Uncharacterized protein MJ0773 precursor +FIG00795528 Uncharacterized protein MJ0759 +FIG00795532 predicted ATPase, AAA superfamily +FIG00795535 Predicted NTPase +FIG00795540 Uncharacterized glycosyltransferase MM_1636 (EC 2.-.-.-) +FIG00795541 Uncharacterized protein MMP0618 +FIG00795542 Nucleotide binding protein, PINc +FIG00795545 Uncharacterized protein MJ1554 precursor +FIG00795546 Iron transport Periplasmic binding protein precursor +FIG00795547 Formylmethanofuran dehydrogenase (molybdenum) subunit C (EC 1.2.99.5) / Formylmethanofuran dehydrogenase (molybdenum) subunit D (EC 1.2.99.5) +FIG00795552 Uncharacterized protein MJ1579 +FIG00795553 Putative ammonium transporter MJ1343 +FIG00795555 Uncharacterized protein MJ0919 +FIG00795557 UPF0148 protein PH0795 +FIG00795560 Uncharacterized protein MJ1361 +FIG00795562 UPF0235 protein MJ0618 +FIG00795565 Uncharacterized protein MJ0995 +FIG00795570 Uncharacterized protein MJ1341 +FIG00795572 Uncharacterized Fe-S oxidoreductase MJ0550 +FIG00795576 Probable amino-acid ABC transporter precursor +FIG00795580 Uncharacterized membrane protein MJ0091 +FIG00795585 Uncharacterized protein MJ0661 +FIG00795592 Daunorubicin resistance ATP-binding protein +FIG00795593 Carbamoyltransferase +FIG00795596 Uncharacterized protein MJ0366 +FIG00795597 Latent nuclear antigen +FIG00795600 Uncharacterized protein MJ1086 +FIG00795607 NMD protein affecting ribosome stability and mRNA decay +FIG00795610 Uncharacterized protein MJ1590 +FIG00795616 UPF0147 protein PYRAB16980 +FIG00795617 S-layer protein precursor (Surface layer protein) (Cell surface glycoprotein) (Fragment) +FIG00795622 conserved hypothetical archaeal protein +FIG00795631 Uncharacterized protein MJ0905 +FIG00795633 UPF0248 protein MMP0286 +FIG00795645 Uncharacterized protein MJ1580 +FIG00795650 Protein of unknown function DUF99 +FIG00795656 Putative HTH-type transcriptional regulatory protein PF1851 +FIG00795659 Uncharacterized protein MJ0804 +FIG00795662 Uncharacterized protein MJ1082 +FIG00795664 Uncharacterized protein MJ0614 +FIG00795671 Uncharacterized protein MJ1162 +FIG00795674 Hydrogenase expression/formation protein related +FIG00795677 UPF0333 protein MMP1685 +FIG00795683 TilS-like 3 +FIG00795689 Uncharacterized protein MJ0538 +FIG00795695 UPF0218 protein MJ0395 +FIG00795696 Iron(III) dicitrate transport ATP-binding protein +FIG00795701 UPF0058 protein MJ1132 +FIG00795704 Uncharacterized protein MJ0706 +FIG00795706 Regulatory protein CysB +FIG00795709 Glycosyl transferase, family 2 (EC 2.4.1.83) +FIG00795714 Uncharacterized protein MJ0505 +FIG00795717 Uncharacterized protein MJ0597 +FIG00795734 UPF0216 protein MTH_949 +FIG00795735 Nitroreductase family +FIG00795740 Uncharacterized protein MJ0859 +FIG00795741 Uncharacterized protein MJ0409 +FIG00795742 UPF0333 protein MJ0835.1 +FIG00795747 Predicted phosphoesterase MJ0623 +FIG00795749 Uncharacterized protein MJ0753 precursor +FIG00795752 Uncharacterized protein MJ0416 +FIG00795753 Uncharacterized protein MJ1467 +FIG00795760 Flavoprotein MJ0732 +FIG00795761 Uncharacterized protein MJ0639 +FIG00795766 Putative membrane protein MJ1562 +FIG00795770 Uncharacterized protein MJ1017 +FIG00795771 Methanol dehydrogenase regulatory protein +FIG00795775 Polyferredoxin MJ0934 +FIG00795778 KH domain-containing protein MJ1533 +FIG00795782 Uncharacterized protein MJ1189 +FIG00795787 Nitrogenase related protein +FIG00795788 Fmn-binding protein +FIG00795790 Uncharacterized protein MJ0755 precursor +FIG00795794 Uncharacterized protein MJ1561 +FIG00795799 Methylcobalamin methyltransferase MMP0834 +FIG00795807 Uncharacterized protein MJ0491 +FIG00795818 Uncharacterized HTH-type transcriptional regulator MJ0586 +FIG00795829 Uncharacterized protein MJ1114 +FIG00795834 hypothetical protein MJ0594a +FIG00795836 Uncharacterized protein MJ0282 +FIG00795841 Uncharacterized protein MJ0308 +FIG00795849 S layer protein precursor +FIG00795857 Uncharacterized protein MJ0415 +FIG00795864 Methyltransferase corrinoid protein MMP0829 +FIG00795865 Uncharacterized protein MJ0388 +FIG00795888 FIG041141: CBS domain protein +FIG00795904 O-linked N-acetylglucosamine transferase +FIG00795912 Cell division cycle protein 48 homolog +FIG00795918 FIG040948: CBS domain protein +FIG00795925 hypothetical protein (multi-domain) +FIG00795934 alpha/beta superfamily +FIG00795948 flavoredoxin Flr +FIG00795967 Soluble P-type ATPase-like phosphatase (EC 3.6.3.-) +FIG00795968 Homocysteine desulfhydrase (EC 4.4.1.2) +FIG00795979 aldehyde ferredoxin oxidoreductase +FIG00795981 Chaperone protein +FIG00795992 Protein-disulfide reductase +FIG00796010 Iron(III) dicitrate transport system permease protein +FIG00796014 Signal-transducing histidine kinase +FIG00796017 PQQ enzyme repeat domain protein +FIG00796026 Beta-ketoacyl synthase/thiolase +FIG00796033 Methyltransferase corrinoid activation protein MA0150 +FIG00796051 Nitrogenase-related protein +FIG00796057 Exopolyphosphatase-related proteins +FIG00796073 FIG038974: CBS domain protein +FIG00796089 Cell surface glycoprotein +FIG00796091 Molybdopterin biosynthesis MoeA protein +FIG00796132 LysM protein +FIG00796151 glycosyltransferase (group I) +FIG00796152 Conserved transmembrane protein +FIG00796171 transporter, RND superfamily +FIG00796198 membrane-associated protein +FIG00796210 Cacineurin superfamily phosphoesterase +FIG00796225 Serine/threonine protein phosphatase BSU1 (EC 3.1.3.16) +FIG00796251 MutT protein +FIG00796258 MoxR-related protein +FIG00796260 Prefoldin beta subunit +FIG00796302 ATP-dependent DNA ligase, homolog of eukaryotic ligase III +FIG00796310 Hydrogenase expression/formation protein +FIG00796329 O-GlcNAc transferase, p110 subunit +FIG00796334 Mg/Co/Ni transporter MgtE +FIG00796340 phosphinothricin acetyltransferase +FIG00796348 surface layer protein B +FIG00796360 metallo-beta-lactamase +FIG00796372 Periplasmic serine proteases +FIG00796379 Molybdopterin-guanine dinucleotide biosynthesis protein +FIG00796385 Acetolactate synthase small subunit +FIG00796403 Sodium/calcium exchanger protein +FIG00796417 phosphate regulatory protein homolog +FIG00796463 Replication factor-A protein 1 +FIG00796505 Ribosomal protein S6 +FIG00796513 tRNA synthetase domain +FIG00796522 Uncharacterized protein MJ0480 +FIG00796524 Methyltransferase corrinoid activation protein MA4380 +FIG00796528 Peptide chain release factor paralog +FIG00796613 Beta-phosphoglucomutase (EC 5.4.2.6) +FIG00796617 Orotate phosphoribosyltransferase related protein +FIG00796618 LL-diaminopimelate aminotransferase (EC 2.6.1.83), methanococcal +FIG00796645 Zn-ribbon containing protein +FIG00796652 Oligosaccharyl transferase +FIG00796662 Mov34 family protein +FIG00796679 Periplasmic component of the Tol biopolymer transport system-like protein precursor +FIG00796681 multidrug ABC transporter, permease protein +FIG00796687 Mannose-6-phosphate isomerase, bifunctional enzyme +FIG00796722 Iron-sulfur flavoprotein MJ0731 +FIG00796727 Phycocyanin alpha phycocyanobilin lyase +FIG00796729 Signal recognition particle SEC65 subunit +FIG00796742 Fe-S oxidoreductase; Homology to heterodisulfide reductase 2 iron-sulfur subunit +FIG00796745 Cell surface lipoprotein +FIG00796777 WD-domain containing protein +FIG00796799 cytochrome oxidase subunit I homolog +FIG00796811 GMP synthase [glutamine-hydrolyzing] +FIG00796897 FIG00796900: hypothetical protein +FIG00797059 Protein of unknown function DUF1597 +FIG00797231 Integration host factor alpha/beta +FIG00798031 FIG00798038: hypothetical protein +FIG00798536 FIG00798538: hypothetical protein +FIG00798538 FIG00798541: hypothetical protein +FIG00798564 FIG00798565: hypothetical protein +FIG00798600 FIG00798604: hypothetical protein +FIG00798630 FIG00798637: hypothetical protein +FIG00798637 Phosphoribosylformimino-5-aminoimidazole carboxamide ribotide isomerase related protein +FIG00798665 FIG00798673: hypothetical protein +FIG00798683 FIG00798684: hypothetical protein +FIG00798713 FIG00798715: hypothetical protein +FIG00798717 FIG00798719: hypothetical protein +FIG00798750 FIG00798753: hypothetical protein +FIG00798795 Sensory/regulatory protein rpfC (EC 2.7.13.3) +FIG00798823 FIG00798825: hypothetical protein +FIG00798833 TPR domain/SEC-C motif domain protein +FIG00798851 FIG00798852: hypothetical protein +FIG00798852 FIG00798854: hypothetical protein +FIG00798855 FIG00798856: hypothetical protein +FIG00798870 FIG00798873: hypothetical protein +FIG00798876 FIG00798878: hypothetical protein +FIG00798897 FIG00798899: hypothetical protein +FIG00798899 Probable carboxylesterase +FIG00798928 FIG00798930: hypothetical protein +FIG00798963 FIG00798967: hypothetical protein +FIG00798967 Type II secretion pathway protein D homolog +FIG00798986 Tetratricopeptide TPR_2 +FIG00799011 FIG00799016: hypothetical protein +FIG00799020 FIG00799022: hypothetical protein +FIG00799046 FIG00799047: hypothetical protein +FIG00799047 Glutamate synthase domain 2 +FIG00799053 Asr1714 protein +FIG00799057 FIG00799059: hypothetical protein +FIG00799082 FIG00799083: hypothetical protein +FIG00799083 FIG00856772: hypothetical protein +FIG00799111 Methanol dehydrogenase regulatory protein MoxR +FIG00799168 FIG00799173: hypothetical protein +FIG00799181 FIG00799183: hypothetical protein +FIG00799196 FIG00799203: hypothetical protein +FIG00799203 FIG00799209: hypothetical protein +FIG00799267 FIG00799269: hypothetical protein +FIG00799272 FIG00799274: hypothetical protein +FIG00799293 FIG00799296: hypothetical protein +FIG00799306 duf556 family protein +FIG00799320 FIG00799324: hypothetical protein +FIG00799325 FIG00799326: hypothetical protein +FIG00799330 FIG00799332: hypothetical protein +FIG00799367 FIG00799368: hypothetical protein +FIG00799369 FIG00799371: hypothetical protein +FIG00799372 FIG00799373: hypothetical protein +FIG00799373 FIG00799375: hypothetical protein +FIG00799375 FIG00799377: hypothetical protein +FIG00799377 FIG00799378: hypothetical protein +FIG00799378 FIG00799381: hypothetical protein +FIG00799383 FIG00799384: hypothetical protein +FIG00799384 FIG00799385: hypothetical protein +FIG00799390 FIG00799391: hypothetical protein +FIG00799395 Mlr6145 protein +FIG00799401 FIG00799403: hypothetical protein +FIG00799403 COG3546: Mn-containing catalase +FIG00799405 FIG00799406: hypothetical protein +FIG00799407 FIG00799408: hypothetical protein +FIG00799408 FIG00799410: hypothetical protein +FIG00799412 FIG00799413: hypothetical protein +FIG00799416 FIG00799417: hypothetical protein +FIG00799417 FIG00799418: hypothetical protein +FIG00799418 FIG00799419: hypothetical protein +FIG00799422 FIG00799423: hypothetical protein +FIG00799423 FIG00799427: hypothetical protein +FIG00799427 FIG00799428: hypothetical protein +FIG00799429 FIG00799430: hypothetical protein +FIG00799430 FIG00799431: hypothetical protein +FIG00799431 FIG00799432: hypothetical protein +FIG00799432 FIG00799433: hypothetical protein +FIG00799433 UPF0098 protein PH1269 +FIG00799434 FIG00799435: hypothetical protein +FIG00799436 FIG00799437: hypothetical protein +FIG00799437 FIG00799438: hypothetical protein +FIG00799441 Bll4961 protein +FIG00799442 FIG00799443: hypothetical protein +FIG00799443 FIG00799444: hypothetical protein +FIG00799444 FIG00799445: hypothetical protein +FIG00799446 FIG00799447: hypothetical protein +FIG00799452 FIG00799453: hypothetical protein +FIG00799453 COG3861: Uncharacterized protein conserved in bacteria +FIG00799454 Predicted outer membrane protein +FIG00799455 FIG00799456: hypothetical protein +FIG00799458 FIG00799459: hypothetical protein +FIG00799459 COG3313: Predicted Fe-S protein +FIG00799463 FIG00799464: hypothetical protein +FIG00799464 FIG00799465: hypothetical protein +FIG00799465 contains Pfam profile: PF00561 alpha/beta hydrolase fold / expressed protein +FIG00799468 FIG00799469: hypothetical protein +FIG00799472 FIG00799473: hypothetical protein +FIG00799476 Magnesium and cobalt transport protein CorA +FIG00799477 FIG00799478: hypothetical protein +FIG00799478 FIG00799479: hypothetical protein +FIG00799479 FIG00799483: hypothetical protein +FIG00799487 FIG00799488: hypothetical protein +FIG00799491 FIG00799492: hypothetical protein +FIG00799494 COG2259: Predicted membrane protein +FIG00799497 FIG00799498: hypothetical protein +FIG00799498 FIG00799500: hypothetical protein +FIG00799501 FIG00799503: hypothetical protein +FIG00799503 FIG00799504: hypothetical protein +FIG00799506 Phage protein gp25 +FIG00799507 FIG00799508: hypothetical protein +FIG00799509 FIG00799510: hypothetical protein +FIG00799512 FIG00799513: hypothetical protein +FIG00799513 Glycine betaine-binding protein +FIG00799516 FIG00799519: hypothetical protein +FIG00799525 FIG00799526: hypothetical protein +FIG00799526 FIG00799527: hypothetical protein +FIG00799527 FIG00799528: hypothetical protein +FIG00799528 FIG00799529: hypothetical protein +FIG00799531 FIG00799534: hypothetical protein +FIG00799534 FIG00799535: hypothetical protein +FIG00799536 FIG00799538: hypothetical protein +FIG00799538 FIG00799539: hypothetical protein +FIG00799539 Bll5514 protein +FIG00799542 FIG00799543: hypothetical protein +FIG00799545 FIG00799546: hypothetical protein +FIG00799546 Mll5590 protein +FIG00799547 Carboxylate-amine ligase bll3764 (EC 6.3.-.-) +FIG00799549 Mll3440 protein +FIG00799551 FIG00799552: hypothetical protein +FIG00799552 FIG00799554: hypothetical protein +FIG00799554 FIG00799555: hypothetical protein +FIG00799555 putative teichoic acid biosynthesis, UDP-N-acetyl-D-mannosaminuronic acid transferase protein +FIG00799558 cupin 2 domain-containing protein +FIG00799562 FIG00799563: hypothetical protein +FIG00799564 COG4178: ABC-type uncharacterized transport system, permease and ATPase components +FIG00799565 FIG00799566: hypothetical protein +FIG00799566 FIG00799567: hypothetical protein +FIG00799567 FIG00799568: hypothetical protein +FIG00799568 FIG00799569: hypothetical protein +FIG00799569 FIG00799570: hypothetical protein +FIG00799570 FIG00799571: hypothetical protein +FIG00799573 FIG00799576: hypothetical protein +FIG00799576 Msl0146 protein +FIG00799578 FIG00799580: hypothetical protein +FIG00799580 FIG00799581: hypothetical protein +FIG00799581 FIG00799583: hypothetical protein +FIG00799583 FIG00799584: hypothetical protein +FIG00799588 FIG00799590: hypothetical protein +FIG00799590 FIG00799591: hypothetical protein +FIG00799591 FIG00799592: hypothetical protein +FIG00799592 FIG00799593: hypothetical protein +FIG00799593 FIG00799596: hypothetical protein +FIG00799596 FIG00799597: hypothetical protein +FIG00799602 FIG00799603: hypothetical protein +FIG00799603 FIG00799604: hypothetical protein +FIG00799604 FIG00799605: hypothetical protein +FIG00799605 FIG00799606: hypothetical protein +FIG00799606 FIG00799607: hypothetical protein +FIG00799610 blr0851; hypothetical protein +FIG00799611 Uncharacterized protein conserved in cyanobacteria +FIG00799612 FIG00799613: hypothetical protein +FIG00799613 FIG00799615: hypothetical protein +FIG00799615 FIG00799617: hypothetical protein +FIG00799618 FIG00799619: hypothetical protein +FIG00799619 FIG00799620: hypothetical protein +FIG00799620 FIG00799621: hypothetical protein +FIG00799634 FIG00799637: hypothetical protein +FIG00799639 FIG00799640: hypothetical protein +FIG00799642 FIG00799643: hypothetical protein +FIG00799643 FIG00799644: hypothetical protein +FIG00799644 FIG00799646: hypothetical protein +FIG00799646 Partition protein +FIG00799649 FIG00799650: hypothetical protein +FIG00799650 FIG00799651: hypothetical protein +FIG00799651 FIG00799654: hypothetical protein +FIG00799654 FIG00799655: hypothetical protein +FIG00799655 FIG00799656: hypothetical protein +FIG00799656 Circadian oscillation regulator KaiC homolog +FIG00799659 FIG00799661: hypothetical protein +FIG00799662 FIG00799663: hypothetical protein +FIG00799665 FIG00799666: hypothetical protein +FIG00799668 Bsl0728 protein +FIG00799669 COG1525: Micrococcal nuclease (thermonuclease) homologs +FIG00799672 Metacaspase +FIG00799673 Bll6196 protein +FIG00799674 FIG00799675: hypothetical protein +FIG00799675 FIG00799676: hypothetical protein +FIG00799676 FIG00799677: hypothetical protein +FIG00799677 FIG00799678: hypothetical protein +FIG00799680 FIG00799682: hypothetical protein +FIG00799682 FIG00799683: hypothetical protein +FIG00799683 FIG00799687: hypothetical protein +FIG00799691 FIG00799692: hypothetical protein +FIG00799693 FIG00799694: hypothetical protein +FIG00799694 FIG00799695: hypothetical protein +FIG00799695 FIG00799698: hypothetical protein +FIG00799698 FIG00799699: hypothetical protein +FIG00799702 FIG00799703: hypothetical protein +FIG00799704 FIG00799706: hypothetical protein +FIG00799706 FIG00799707: hypothetical protein +FIG00799710 FIG00799711: hypothetical protein +FIG00799711 Bll7395 protein +FIG00799715 FIG00799717: hypothetical protein +FIG00799717 FIG00799718: hypothetical protein +FIG00799718 FIG00799720: hypothetical protein +FIG00799720 FIG00799721: hypothetical protein +FIG00799721 FIG00799722: hypothetical protein +FIG00799722 NrtR-regulated hypothetical NrtY, PpnK-type ATP-NAD kinase domain +FIG00799727 FIG00799729: hypothetical protein +FIG00799730 FIG00799733: hypothetical protein +FIG00799733 FIG00799735: hypothetical protein +FIG00799735 FIG00799738: hypothetical protein +FIG00799738 FIG00799739: hypothetical protein +FIG00799741 FIG00799742: hypothetical protein +FIG00799743 COG3143: Chemotaxis protein +FIG00799744 FIG00799745: hypothetical protein +FIG00799745 FIG00799746: hypothetical protein +FIG00799747 FIG00799748: hypothetical protein +FIG00799752 FIG00799753: hypothetical protein +FIG00799754 FIG00799755: hypothetical protein +FIG00799755 FIG00799757: hypothetical protein +FIG00799757 FIG00799759: hypothetical protein +FIG00799764 MxaL protein +FIG00799766 FIG00799767: hypothetical protein +FIG00799767 FIG00799768: hypothetical protein +FIG00799771 FIG00799772: hypothetical protein +FIG00799778 FIG00799779: hypothetical protein +FIG00799779 FIG00799780: hypothetical protein +FIG00799781 FIG00799783: hypothetical protein +FIG00799786 putative transcriptional regulator, AbrB family +FIG00799788 Transporter, MFS superfamily +FIG00799789 FIG00799791: hypothetical protein +FIG00799791 FIG00799792: hypothetical protein +FIG00799798 FIG00799800: hypothetical protein +FIG00799801 FIG00799802: hypothetical protein +FIG00799805 A4orf02 protein +FIG00799810 FIG00799811: hypothetical protein +FIG00799811 FIG00799813: hypothetical protein +FIG00799813 FIG00799814: hypothetical protein +FIG00799814 FIG00799817: hypothetical protein +FIG00799818 FIG00799821: hypothetical protein +FIG00799828 FIG00799829: hypothetical protein +FIG00799829 FIG00799832: hypothetical protein +FIG00799832 FIG00799833: hypothetical protein +FIG00799833 FIG00799835: hypothetical protein +FIG00799835 FIG00799836: hypothetical protein +FIG00799838 FIG00799839: hypothetical protein +FIG00799840 FIG00799841: hypothetical protein +FIG00799841 FIG00799842: hypothetical protein +FIG00799843 FIG00799844: hypothetical protein +FIG00799844 FIG00799845: hypothetical protein +FIG00799845 COG5470: Uncharacterized conserved protein +FIG00799849 FIG00799851: hypothetical protein +FIG00799851 FIG00799853: hypothetical protein +FIG00799854 FIG00799855: hypothetical protein +FIG00799855 Polar amino acid uptake family ABC transporter, periplasmic substrate- binding protein +FIG00799858 FIG00799859: hypothetical protein +FIG00799862 FIG00799864: hypothetical protein +FIG00799864 FIG00799865: hypothetical protein +FIG00799865 COG0324: tRNA delta(2)-isopentenylpyrophosphate transferase +FIG00799870 FIG00799871: hypothetical protein +FIG00799876 FIG00799877: hypothetical protein +FIG00799877 FIG00799878: hypothetical protein +FIG00799879 FIG00799880: hypothetical protein +FIG00799880 FIG00799881: hypothetical protein +FIG00799883 FIG00799884: hypothetical protein +FIG00799887 FIG00799888: hypothetical protein +FIG00799890 FIG00799893: hypothetical protein +FIG00799894 FIG00799895: hypothetical protein +FIG00799895 FIG00799896: hypothetical protein +FIG00799898 FIG00799899: hypothetical protein +FIG00799900 FIG00799901: hypothetical protein +FIG00799901 FIG00799903: hypothetical protein +FIG00799904 Bll1555 protein +FIG00799905 FIG00799906: hypothetical protein +FIG00799911 Mlr4134 protein +FIG00799915 FIG00799916: hypothetical protein +FIG00799920 FIG00799921: hypothetical protein +FIG00799921 FIG00799922: hypothetical protein +FIG00799932 FIG00799933: hypothetical protein +FIG00799934 FIG00799935: hypothetical protein +FIG00799935 FIG00799936: hypothetical protein +FIG00799937 FIG00799938: hypothetical protein +FIG00799938 FIG00799939: hypothetical protein +FIG00799939 FIG00799941: hypothetical protein +FIG00799941 FIG00799942: hypothetical protein +FIG00799947 FIG00799948: hypothetical protein +FIG00799949 FIG00799950: hypothetical protein +FIG00799951 FIG00799952: hypothetical protein +FIG00799952 FIG00799953: hypothetical protein +FIG00799953 4-aminobutyrate aminotransferase and related aminotransferases +FIG00799957 Bsr7757 protein +FIG00799958 Phosphoribosylformylglycinamidine (FGAM) synthase, synthetase domain +FIG00799961 FIG00799962: hypothetical protein +FIG00799965 FIG00799966: hypothetical protein +FIG00799966 FIG00799968: hypothetical protein +FIG00799968 FIG00799969: hypothetical protein +FIG00799972 FIG00799973: hypothetical protein +FIG00799973 FIG00799974: hypothetical protein +FIG00799974 FIG00799976: hypothetical protein +FIG00799978 FIG00799979: hypothetical protein +FIG00799979 Possible serine protease, htrA-like +FIG00799980 FIG00799982: hypothetical protein +FIG00799982 FIG00799983: hypothetical protein +FIG00799987 UV DNA damage endonuclease (EC 3.-.-.-) (UV-endonuclease) (UVED) +FIG00799989 FIG00799990: hypothetical protein +FIG00799991 FIG00799993: hypothetical protein +FIG00799995 FIG00799996: hypothetical protein +FIG00799999 FIG00800002: hypothetical protein +FIG00800004 FIG00800005: hypothetical protein +FIG00800008 FIG00800009: hypothetical protein +FIG00800010 FIG00800011: hypothetical protein +FIG00800014 FIG00800016: hypothetical protein +FIG00800016 FIG00800017: hypothetical protein +FIG00800019 FIG00800021: hypothetical protein +FIG00800021 COG1937: Uncharacterized protein conserved in bacteria +FIG00800026 FIG00800027: hypothetical protein +FIG00800027 FIG00800028: hypothetical protein +FIG00800029 FIG00800030: hypothetical protein +FIG00800030 ABC-transporter periplasmic binding protein, unknown substrate +FIG00800033 FIG00800034: hypothetical protein +FIG00800034 FIG00800035: hypothetical protein +FIG00800035 FIG00800036: hypothetical protein +FIG00800036 FIG00800037: hypothetical protein +FIG00800037 FIG00800038: hypothetical protein +FIG00800041 FIG00800044: hypothetical protein +FIG00800044 FIG00800047: hypothetical protein +FIG00800048 FIG00800049: hypothetical protein +FIG00800049 FIG00800052: hypothetical protein +FIG00800052 FIG00800053: hypothetical protein +FIG00800053 FIG00800054: hypothetical protein +FIG00800057 FIG00800058: hypothetical protein +FIG00800058 FIG00800059: hypothetical protein +FIG00800062 FIG00800063: hypothetical protein +FIG00800063 FIG00800064: hypothetical protein +FIG00800064 UPF0391 membrane protein RPA3505 +FIG00800065 FIG00800068: hypothetical protein +FIG00800068 FIG00800070: hypothetical protein +FIG00800071 FIG00800072: hypothetical protein +FIG00800072 TRANSCRIPTIONAL REGULATOR, AlgH +FIG00800078 FIG00800079: hypothetical protein +FIG00800079 Bll6615 protein +FIG00800090 FIG00800091: hypothetical protein +FIG00800091 FIG00800092: hypothetical protein +FIG00800098 COG0104: Adenylosuccinate synthase +FIG00800099 COG0784: FOG: CheY-like receiver +FIG00800102 FIG00800103: hypothetical protein +FIG00800103 F47B8.5 +FIG00800104 FIG00800105: hypothetical protein +FIG00800105 FIG00800106: hypothetical protein +FIG00800106 FIG00800107: hypothetical protein +FIG00800107 Mlr5338 protein +FIG00800109 FIG00800111: hypothetical protein +FIG00800111 FIG00800112: hypothetical protein +FIG00800113 FIG00800114: hypothetical protein +FIG00800116 FIG00800117: hypothetical protein +FIG00800118 FIG00800121: hypothetical protein +FIG00800121 FIG00800122: hypothetical protein +FIG00800123 Predicted protein tyrosine phosphatase +FIG00800129 Cof-like hydrolase family protein +FIG00800131 UPF0337 protein blr1496 +FIG00800135 FIG00800138: hypothetical protein +FIG00800138 FIG00800139: hypothetical protein +FIG00800139 FIG00800140: hypothetical protein +FIG00800140 FIG00800141: hypothetical protein +FIG00800144 FIG00800145: hypothetical protein +FIG00800149 FIG00800150: hypothetical protein +FIG00800150 FIG00800151: hypothetical protein +FIG00800151 FIG00800152: hypothetical protein +FIG00800152 Glucose-fructose oxidoreductase (EC 1.1.99.28) +FIG00800153 FIG00800154: hypothetical protein +FIG00800155 Pyrroloquinoline-quinone synthase (EC 1.3.3.11) / Coenzyme PQQ synthesis protein D +FIG00800158 FIG00800160: hypothetical protein +FIG00800160 FIG00800161: hypothetical protein +FIG00800162 FIG00800164: hypothetical protein +FIG00800166 FIG00800167: hypothetical protein +FIG00800172 FIG00800173: hypothetical protein +FIG00800177 FIG00800178: hypothetical protein +FIG00800178 blr0461; probable ABC transporter permease protein +FIG00800181 FIG00800183: hypothetical protein +FIG00800183 FIG00800184: hypothetical protein +FIG00800184 FIG00800187: hypothetical protein +FIG00800190 FIG00800192: hypothetical protein +FIG00800192 FIG00800193: hypothetical protein +FIG00800193 FIG00800194: hypothetical protein +FIG00800195 FIG00800197: hypothetical protein +FIG00800201 FIG00800202: hypothetical protein +FIG00800202 FIG00800203: hypothetical protein +FIG00800206 outer membrane protein Omp31 precursor +FIG00800207 NADH-flavin oxidoreductase/NADH oxidase (EC 1.6.99.1) +FIG00800208 FIG00800209: hypothetical protein +FIG00800211 FIG00800212: hypothetical protein +FIG00800212 FIG00800214: hypothetical protein +FIG00800216 FIG00800217: hypothetical protein +FIG00800217 FIG00800218: hypothetical protein +FIG00800219 FIG00800221: hypothetical protein +FIG00800221 FIG00800222: hypothetical protein +FIG00800222 FIG00800223: hypothetical protein +FIG00800226 FIG00800227: hypothetical protein +FIG00800228 FIG00800229: hypothetical protein +FIG00800229 Possible FlbE protein +FIG00800232 FIG00800233: hypothetical protein +FIG00800234 FIG00800236: hypothetical protein +FIG00800236 FIG00800239: hypothetical protein +FIG00800240 FIG00800241: hypothetical protein +FIG00800243 FIG00800246: hypothetical protein +FIG00800246 FIG00800247: hypothetical protein +FIG00800248 Phenylacetic acid degradation-related protein +FIG00800250 FIG00800252: hypothetical protein +FIG00800252 probable sensory histidine kinase +FIG00800254 Class I triheme cytochrome c +FIG00800255 FIG00800256: hypothetical protein +FIG00800258 PucC protein +FIG00800259 FIG00800260: hypothetical protein +FIG00800261 FIG00800262: hypothetical protein +FIG00800262 FIG00800265: hypothetical protein +FIG00800265 FIG00800267: hypothetical protein +FIG00800267 FIG00800268: hypothetical protein +FIG00800268 FIG00800270: hypothetical protein +FIG00800270 FIG00800271: hypothetical protein +FIG00800271 FIG00800272: hypothetical protein +FIG00800272 FIG00800274: hypothetical protein +FIG00800274 FIG00800276: hypothetical protein +FIG00800276 FIG00800277: hypothetical protein +FIG00800277 FIG00800278: hypothetical protein +FIG00800278 FIG00800279: hypothetical protein +FIG00800280 FIG00800281: hypothetical protein +FIG00800283 FIG00800285: hypothetical protein +FIG00800285 FIG00800286: hypothetical protein +FIG00800286 FIG00800287: hypothetical protein +FIG00800287 FIG00800288: hypothetical protein +FIG00800288 FIG00800290: hypothetical protein +FIG00800293 FIG00800294: hypothetical protein +FIG00800294 FIG00800295: hypothetical protein +FIG00800299 FIG00800300: hypothetical protein +FIG00800300 FIG00800301: hypothetical protein +FIG00800301 FIG00800304: hypothetical protein +FIG00800304 FIG00800305: hypothetical protein +FIG00800305 FIG00800307: hypothetical protein +FIG00800307 FIG00800309: hypothetical protein +FIG00800310 Phosphatase yqaB (EC 3.1.3.-) +FIG00800311 FIG00800313: hypothetical protein +FIG00800319 FIG00800320: hypothetical protein +FIG00800321 FIG00800322: hypothetical protein +FIG00800322 COG1864: DNA/RNA endonuclease G, NUC1 +FIG00800323 FIG00800324: hypothetical protein +FIG00800329 FIG00800330: hypothetical protein +FIG00800332 FIG00800333: hypothetical protein +FIG00800335 FIG00800336: hypothetical protein +FIG00800336 FIG00800337: hypothetical protein +FIG00800337 FIG00800342: hypothetical protein +FIG00800344 FIG00800345: hypothetical protein +FIG00800345 FIG00800346: hypothetical protein +FIG00800346 FIG00800347: hypothetical protein +FIG00800347 FIG00800349: hypothetical protein +FIG00800349 Twin-arginine translocation signal domain protein +FIG00800350 FIG00800351: hypothetical protein +FIG00800351 FIG00800355: hypothetical protein +FIG00800355 FIG00800356: hypothetical protein +FIG00800357 FIG00800358: hypothetical protein +FIG00800358 Mll5741 protein +FIG00800359 FIG00800360: hypothetical protein +FIG00800364 orf1 +FIG00800367 FIG00800368: hypothetical protein +FIG00800370 FIG00800373: hypothetical protein +FIG00800374 FIG00800376: hypothetical protein +FIG00800376 FIG00800377: hypothetical protein +FIG00800378 FIG00800379: hypothetical protein +FIG00800380 FIG00800381: hypothetical protein +FIG00800381 FIG00800382: hypothetical protein +FIG00800384 FIG00800385: hypothetical protein +FIG00800386 FIG00800387: hypothetical protein +FIG00800387 FIG00800388: hypothetical protein +FIG00800393 FIG00800394: hypothetical protein +FIG00800394 FIG00800397: hypothetical protein +FIG00800399 FIG00800401: hypothetical protein +FIG00800403 FIG00800404: hypothetical protein +FIG00800404 FIG00800405: hypothetical protein +FIG00800405 Gluconolactonase +FIG00800406 FIG00800407: hypothetical protein +FIG00800408 N-terminal methylation precursor +FIG00800412 FIG00800413: hypothetical protein +FIG00800414 FIG00800415: hypothetical protein +FIG00800416 FIG00800417: hypothetical protein +FIG00800417 FIG00800418: hypothetical protein +FIG00800418 FIG00800420: hypothetical protein +FIG00800421 FIG00800422: hypothetical protein +FIG00800424 FIG00800425: hypothetical protein +FIG00800427 FIG00800428: hypothetical protein +FIG00800432 FIG00800433: hypothetical protein +FIG00800434 FIG00800435: hypothetical protein +FIG00800435 FIG00800436: hypothetical protein +FIG00800436 FIG00800437: hypothetical protein +FIG00800437 Two component system response regulator +FIG00800438 FIG00800440: hypothetical protein +FIG00800443 FIG00800444: hypothetical protein +FIG00800444 FIG00800445: hypothetical protein +FIG00800445 Mll0880 protein +FIG00800446 bsl7612; hypothetical protein +FIG00800448 FIG00800449: hypothetical protein +FIG00800449 FIG00800451: hypothetical protein +FIG00800451 FIG00800453: hypothetical protein +FIG00800453 FIG00800454: hypothetical protein +FIG00800455 FIG00800456: hypothetical protein +FIG00800457 FIG00800458: hypothetical protein +FIG00800458 FIG00800461: hypothetical protein +FIG00800465 FIG00800466: hypothetical protein +FIG00800467 FIG00800469: hypothetical protein +FIG00800469 FIG00800470: hypothetical protein +FIG00800470 Bsl4900 protein +FIG00800474 FIG00800475: hypothetical protein +FIG00800478 FIG00800480: hypothetical protein +FIG00800480 FIG00800481: hypothetical protein +FIG00800486 FIG00800487: hypothetical protein +FIG00800487 MxaC, protein involved in Ca2+ insertion into methanol dehydrogenase +FIG00800490 FIG00800492: hypothetical protein +FIG00800500 Patatin-like phospholipase domain +FIG00800501 FIG00800503: hypothetical protein +FIG00800503 FIG00800504: hypothetical protein +FIG00800504 FIG00800505: hypothetical protein +FIG00800505 FIG00800506: hypothetical protein +FIG00800506 FIG00800507: hypothetical protein +FIG00800507 FIG00800508: hypothetical protein +FIG00800508 putative sorbitol dehydrogenase( EC:1.1.1.14 ) +FIG00800509 FIG00800510: hypothetical protein +FIG00800510 FIG00800511: hypothetical protein +FIG00800514 FIG00800515: hypothetical protein +FIG00800524 FIG00800525: hypothetical protein +FIG00800526 Proline-rich protein +FIG00800531 FIG00800532: hypothetical protein +FIG00800537 (S)-2-haloacid dehalogenase I (EC 3.8.1.2) (2-haloalkanoic acid dehalogenase I) (L-2-haloacid dehalogenase I) (Halocarboxylic acid halidohydrolase I) (DEHCI) +FIG00800544 FIG00800546: hypothetical protein +FIG00800546 FIG00800547: hypothetical protein +FIG00800547 FIG00800548: hypothetical protein +FIG00800550 FIG00800551: hypothetical protein +FIG00800551 FIG00800553: hypothetical protein +FIG00800557 FIG00800559: hypothetical protein +FIG00800566 FIG00800567: hypothetical protein +FIG00800567 FIG00800569: hypothetical protein +FIG00800569 FIG00800571: hypothetical protein +FIG00800571 Short chain dehydrogenase family protein +FIG00800576 FIG00800577: hypothetical protein +FIG00800577 FIG00800578: hypothetical protein +FIG00800578 FIG00800579: hypothetical protein +FIG00800580 Aldo/keto reductase (EC 1.1.1.65) +FIG00800584 FIG00800585: hypothetical protein +FIG00800585 FIG00800586: hypothetical protein +FIG00800586 AT4g29590/T16L4_100 +FIG00800590 MxaA protein +FIG00800591 FIG00800592: hypothetical protein +FIG00800593 FIG00800594: hypothetical protein +FIG00800598 FIG00800599: hypothetical protein +FIG00800599 FIG00800600: hypothetical protein +FIG00800601 FIG00800602: hypothetical protein +FIG00800606 FIG00800609: hypothetical protein +FIG00800609 FIG00800611: hypothetical protein +FIG00800611 FIG00800612: hypothetical protein +FIG00800614 FIG00800615: hypothetical protein +FIG00800618 FIG00800623: hypothetical protein +FIG00800625 FIG00800626: hypothetical protein +FIG00800628 Bll6609 protein +FIG00800630 FIG00800632: hypothetical protein +FIG00800633 FIG00800634: hypothetical protein +FIG00800634 Bll1668 protein +FIG00800638 FIG00800639: hypothetical protein +FIG00800639 FIG00800641: hypothetical protein +FIG00800641 FIG00800642: hypothetical protein +FIG00800642 FIG00800644: hypothetical protein +FIG00800649 FIG00800651: hypothetical protein +FIG00800654 FIG00800656: hypothetical protein +FIG00800656 FIG00800658: hypothetical protein +FIG00800658 Biotin synthase-related enzyme +FIG00800661 FIG00800664: hypothetical protein +FIG00800668 FIG00800670: hypothetical protein +FIG00800671 FIG00800672: hypothetical protein +FIG00800674 FIG00800676: hypothetical protein +FIG00800676 FIG00800677: hypothetical protein +FIG00800678 FIG00800681: hypothetical protein +FIG00800684 FIG00800685: hypothetical protein +FIG00800686 FIG00800687: hypothetical protein +FIG00800687 FIG00800688: hypothetical protein +FIG00800688 FIG00800689: hypothetical protein +FIG00800689 FIG00800690: hypothetical protein +FIG00800690 FIG00800691: hypothetical protein +FIG00800691 FIG00800693: hypothetical protein +FIG00800697 FIG00800698: hypothetical protein +FIG00800698 FIG00800700: hypothetical protein +FIG00800703 FIG00800705: hypothetical protein +FIG00800705 conserved hypothetical protein +FIG00800706 FIG00800707: hypothetical protein +FIG00800708 FIG00800709: hypothetical protein +FIG00800709 FIG00800710: hypothetical protein +FIG00800718 signal transduction histidine kinase +FIG00800720 FIG00800721: hypothetical protein +FIG00800721 Mlr7652 protein +FIG00800726 FIG00800727: hypothetical protein +FIG00800728 FIG00800730: hypothetical protein +FIG00800730 FIG00800732: hypothetical protein +FIG00800732 FIG00800734: hypothetical protein +FIG00800738 FIG00800740: hypothetical protein +FIG00800742 FIG00800747: hypothetical protein +FIG00800750 ABC-transporter ATP-binding protein with unknown substrate +FIG00800753 FIG00800754: hypothetical protein +FIG00800754 COG3544: Uncharacterized protein conserved in bacteria +FIG00800758 FIG00800759: hypothetical protein +FIG00800763 FIG00800765: hypothetical protein +FIG00800765 FIG00800766: hypothetical protein +FIG00800766 FIG00800767: hypothetical protein +FIG00800776 superoxide dismutase SodM-like protein +FIG00800778 FIG00800779: hypothetical protein +FIG00800779 FIG00800780: hypothetical protein +FIG00800781 FIG00800782: hypothetical protein +FIG00800782 FIG00800783: hypothetical protein +FIG00800783 UDP-glucose:tetrahydrobiopterin glucosyltransferase [EC:2.4.1.-] +FIG00800785 FIG00800787: hypothetical protein +FIG00800787 FIG00800788: hypothetical protein +FIG00800788 hypothetical protein-putative transmembrane protein +FIG00800792 FIG00800793: hypothetical protein +FIG00800794 FIG00800795: hypothetical protein +FIG00800796 FIG00800798: hypothetical protein +FIG00800798 FIG00800799: hypothetical protein +FIG00800799 FIG00800801: hypothetical protein +FIG00800802 ABC-transporter permease protein +FIG00800806 FIG00800807: hypothetical protein +FIG00800807 FIG00800808: hypothetical protein +FIG00800808 Bll3794 protein +FIG00800812 FIG00800813: hypothetical protein +FIG00800813 FIG00800814: hypothetical protein +FIG00800814 FIG00800815: hypothetical protein +FIG00800815 FIG00800816: hypothetical protein +FIG00800817 FIG00800819: hypothetical protein +FIG00800819 FIG00800820: hypothetical protein +FIG00800822 FIG00800823: hypothetical protein +FIG00800823 FIG00800824: hypothetical protein +FIG00800824 FIG00800826: hypothetical protein +FIG00800827 FIG00800828: hypothetical protein +FIG00800830 FIG00800832: hypothetical protein +FIG00800833 FIG00800834: hypothetical protein +FIG00800834 FIG00800838: hypothetical protein +FIG00800838 FIG00800839: hypothetical protein +FIG00800839 FIG00800840: hypothetical protein +FIG00800840 FIG00800842: hypothetical protein +FIG00800842 FIG00800843: hypothetical protein +FIG00800852 FIG00800853: hypothetical protein +FIG00800858 FIG00800859: hypothetical protein +FIG00800864 COG3920: Signal transduction histidine kinase +FIG00800867 FIG00800868: hypothetical protein +FIG00800870 FIG00800871: hypothetical protein +FIG00800871 FIG00800872: hypothetical protein +FIG00800876 COG1178: ABC-type Fe3+ transport system, permease component +FIG00800877 FIG00800878: hypothetical protein +FIG00800881 FIG00800882: hypothetical protein +FIG00800882 InterPro IPR001478 COGs COG0265 +FIG00800883 FIG00800884: hypothetical protein +FIG00800885 FIG00800887: hypothetical protein +FIG00800887 FIG00800888: hypothetical protein +FIG00800888 FIG00800889: hypothetical protein +FIG00800889 Methyl-accepting chemotaxis receptor/sensory transducer with PAS domain +FIG00800890 FIG00800892: hypothetical protein +FIG00800892 FIG00800893: hypothetical protein +FIG00800901 pyoverdine ABC export system, permease/ATP-binding protein +FIG00800902 FIG00800903: hypothetical protein +FIG00800904 FIG00800905: hypothetical protein +FIG00800906 FIG00800907: hypothetical protein +FIG00800908 FIG00800909: hypothetical protein +FIG00800910 PAN domain protein +FIG00800914 FIG00800919: hypothetical protein +FIG00800920 FIG00800921: hypothetical protein +FIG00800921 FIG00800923: hypothetical protein +FIG00800926 FIG00800927: hypothetical protein +FIG00800927 FIG00800928: hypothetical protein +FIG00800928 FIG00800929: hypothetical protein +FIG00800929 FIG00800930: hypothetical protein +FIG00800930 COG3914: Predicted O-linked N-acetylglucosamine transferase, SPINDLY family +FIG00800933 FIG00800934: hypothetical protein +FIG00800935 FIG00800937: hypothetical protein +FIG00800941 Probable GTP binding protein +FIG00800952 conserved hypothetical protein; putative signal peptide; putative calcium-binding protein +FIG00800957 FIG00800958: hypothetical protein +FIG00800959 FIG00800962: hypothetical protein +FIG00800962 FIG00800963: hypothetical protein +FIG00800970 FIG00800974: hypothetical protein +FIG00800974 FIG00800976: hypothetical protein +FIG00800977 FIG00800978: hypothetical protein +FIG00800979 COG3055: Uncharacterized protein conserved in bacteria +FIG00800987 FIG00800988: hypothetical protein +FIG00800988 Glucose--fructose oxidoreductase precursor (EC 1.1.99.28) (GFOR) +FIG00800992 FIG00800993: hypothetical protein +FIG00800997 Bll0561 protein +FIG00801000 FIG00801003: hypothetical protein +FIG00801003 FIG00801004: hypothetical protein +FIG00801005 FIG00801007: hypothetical protein +FIG00801007 FIG00801008: hypothetical protein +FIG00801010 Aminobenzoyl-glutamate utilization protein +FIG00801011 FIG00801014: hypothetical protein +FIG00801014 FIG00801016: hypothetical protein +FIG00801019 FIG00801020: hypothetical protein +FIG00801020 Capsular polysaccharide biosynthesis +FIG00801022 FIG00801023: hypothetical protein +FIG00801023 FIG00801024: hypothetical protein +FIG00801025 FIG00801026: hypothetical protein +FIG00801028 Formylmethanofuran dehydrogenase subunit C (EC 1.2.99.5) +FIG00801034 FIG00801035: hypothetical protein +FIG00801035 FIG00801036: hypothetical protein +FIG00801036 FIG00801037: hypothetical protein +FIG00801040 FIG00801042: hypothetical protein +FIG00801042 FIG00801044: hypothetical protein +FIG00801045 FIG00801047: hypothetical protein +FIG00801054 FIG00801055: hypothetical protein +FIG00801060 COG0526: Thiol-disulfide isomerase and thioredoxins +FIG00801063 FIG00801064: hypothetical protein +FIG00801064 Phenylacetic acid degradation protein paaI +FIG00801071 FIG00801072: hypothetical protein +FIG00801072 FIG00801074: hypothetical protein +FIG00801074 FIG00801075: hypothetical protein +FIG00801075 FIG00801076: hypothetical protein +FIG00801076 FIG00801078: hypothetical protein +FIG00801078 FIG00801079: hypothetical protein +FIG00801079 FIG00801080: hypothetical protein +FIG00801081 FIG00801082: hypothetical protein +FIG00801082 FIG00801084: hypothetical protein +FIG00801084 FIG00801086: hypothetical protein +FIG00801087 FIG00801088: hypothetical protein +FIG00801089 FIG00801090: hypothetical protein +FIG00801090 FIG00801091: hypothetical protein +FIG00801092 FIG00801093: hypothetical protein +FIG00801094 FIG00801096: hypothetical protein +FIG00801096 FIG00801097: hypothetical protein +FIG00801097 FIG00801098: hypothetical protein +FIG00801098 FIG00801099: hypothetical protein +FIG00801099 glycosyl transferase, group 1/2 family protein +FIG00801100 FIG00801104: hypothetical protein +FIG00801104 FIG00801105: hypothetical protein +FIG00801105 FIG00801106: hypothetical protein +FIG00801106 FIG00801107: hypothetical protein +FIG00801107 FIG00801110: hypothetical protein +FIG00801110 Bll5635 protein +FIG00801118 FIG00801120: hypothetical protein +FIG00801120 FIG00801121: hypothetical protein +FIG00801124 FIG00801125: hypothetical protein +FIG00801125 FIG00801126: hypothetical protein +FIG00801126 FIG00801127: hypothetical protein +FIG00801127 FIG00801129: hypothetical protein +FIG00801129 FIG00801130: hypothetical protein +FIG00801135 FIG00801136: hypothetical protein +FIG00801136 FIG00801137: hypothetical protein +FIG00801144 FIG00801145: hypothetical protein +FIG00801145 FIG00801146: hypothetical protein +FIG00801156 FIG00801157: hypothetical protein +FIG00801159 putative C-methyltransferase +FIG00801160 FIG00801161: hypothetical protein +FIG00801161 FIG00801163: hypothetical protein +FIG00801163 FIG00801165: hypothetical protein +FIG00801168 FIG00801169: hypothetical protein +FIG00801169 FIG00801170: hypothetical protein +FIG00801171 FIG00801173: hypothetical protein +FIG00801173 FIG00801174: hypothetical protein +FIG00801174 FIG00801175: hypothetical protein +FIG00801175 FIG00801176: hypothetical protein +FIG00801178 FIG00801179: hypothetical protein +FIG00801181 FIG00801182: hypothetical protein +FIG00801184 FIG00801187: hypothetical protein +FIG00801187 FIG001196: Membrane protein YedZ +FIG00801189 FIG00801190: hypothetical protein +FIG00801190 FIG00801191: hypothetical protein +FIG00801191 FIG00801192: hypothetical protein +FIG00801193 FIG00801194: hypothetical protein +FIG00801194 FIG00801195: hypothetical protein +FIG00801195 FIG00801196: hypothetical protein +FIG00801196 Mlr1592 protein +FIG00801197 FIG00801199: hypothetical protein +FIG00801200 FIG00801201: hypothetical protein +FIG00801203 FIG00801206: hypothetical protein +FIG00801207 FIG00801208: hypothetical protein +FIG00801213 FIG00801214: hypothetical protein +FIG00801217 FIG00801218: hypothetical protein +FIG00801220 FIG00801223: hypothetical protein +FIG00801223 FIG00801224: hypothetical protein +FIG00801225 FIG00801226: hypothetical protein +FIG00801226 Stress responsive alpha-beta barrel domain protein Dabb +FIG00801229 FIG00801230: hypothetical protein +FIG00801234 FIG00801236: hypothetical protein +FIG00801236 FIG00801237: hypothetical protein +FIG00801237 FIG00801240: hypothetical protein +FIG00801241 FIG00801242: hypothetical protein +FIG00801242 FIG00801243: hypothetical protein +FIG00801245 FIG00801249: hypothetical protein +FIG00801249 Polar amino acid uptake family ABC transporter, permease protein +FIG00801252 FIG00801254: hypothetical protein +FIG00801254 FIG00801255: hypothetical protein +FIG00801258 COG0401: Uncharacterized homolog of Blt101 +FIG00801261 FIG00801262: hypothetical protein +FIG00801262 Arsenic efflux pump protein +FIG00801263 FIG00801264: hypothetical protein +FIG00801264 FIG00801266: hypothetical protein +FIG00801267 FIG00801268: hypothetical protein +FIG00801268 FIG00801269: hypothetical protein +FIG00801269 FIG00801271: hypothetical protein +FIG00801271 FIG00801274: hypothetical protein +FIG00801278 FIG00801279: hypothetical protein +FIG00801280 FIG00801282: hypothetical protein +FIG00801283 FIG00801284: hypothetical protein +FIG00801285 FIG00801286: hypothetical protein +FIG00801286 FIG00801290: hypothetical protein +FIG00801291 FIG00801292: hypothetical protein +FIG00801297 ABC transporter ATP-binding/permease protein +FIG00801302 FIG00801303: hypothetical protein +FIG00801303 FIG00801304: hypothetical protein +FIG00801308 FIG00801309: hypothetical protein +FIG00801309 FIG00801310: hypothetical protein +FIG00801310 FIG00801311: hypothetical protein +FIG00801311 FIG00801312: hypothetical protein +FIG00801312 FIG00801314: hypothetical protein +FIG00801317 FIG00801318: hypothetical protein +FIG00801318 FIG00801319: hypothetical protein +FIG00801322 FIG00801323: hypothetical protein +FIG00801325 FIG00801326: hypothetical protein +FIG00801326 FIG00801327: hypothetical protein +FIG00801328 FIG00801329: hypothetical protein +FIG00801329 FIG00801331: hypothetical protein +FIG00801333 FIG00801334: hypothetical protein +FIG00801334 FIG00801335: hypothetical protein +FIG00801336 FIG00801337: hypothetical protein +FIG00801343 FIG00801344: hypothetical protein +FIG00801346 FIG00801347: hypothetical protein +FIG00801349 FIG00801350: hypothetical protein +FIG00801350 FIG00801351: hypothetical protein +FIG00801352 FIG00801354: hypothetical protein +FIG00801356 FIG00801357: hypothetical protein +FIG00801359 FIG00801361: hypothetical protein +FIG00801361 FIG00801362: hypothetical protein +FIG00801362 FIG00801363: hypothetical protein +FIG00801364 FIG00801366: hypothetical protein +FIG00801366 FIG00801367: hypothetical protein +FIG00801367 FIG00801369: hypothetical protein +FIG00801371 FIG00801372: hypothetical protein +FIG00801376 ABC-type multidrug transport system, ATPase and permease components +FIG00801384 FIG00801385: hypothetical protein +FIG00801385 Periplasmic aromatic aldehyde oxidoreductase, iron-sulfur subunit YagT +FIG00801394 FIG00801395: hypothetical protein +FIG00801396 FIG00801398: hypothetical protein +FIG00801399 FIG00801400: hypothetical protein +FIG00801400 FIG00801403: hypothetical protein +FIG00801403 FIG00801404: hypothetical protein +FIG00801405 FIG00801406: hypothetical protein +FIG00801406 FIG00801407: hypothetical protein +FIG00801407 FIG00801411: hypothetical protein +FIG00801411 FIG00801412: hypothetical protein +FIG00801416 FIG00801417: hypothetical protein +FIG00801417 FIG00801418: hypothetical protein +FIG00801419 FIG00801420: hypothetical protein +FIG00801420 FIG00801421: hypothetical protein +FIG00801423 FIG00801425: hypothetical protein +FIG00801425 FIG00801427: hypothetical protein +FIG00801430 FIG00801432: hypothetical protein +FIG00801432 FIG00801433: hypothetical protein +FIG00801437 FIG00801439: hypothetical protein +FIG00801442 FIG00801444: hypothetical protein +FIG00801446 FIG00801447: hypothetical protein +FIG00801447 FIG00801449: hypothetical protein +FIG00801450 FIG00801452: hypothetical protein +FIG00801452 FIG00801453: hypothetical protein +FIG00801453 FIG00801454: hypothetical protein +FIG00801456 FIG00801457: hypothetical protein +FIG00801457 FIG00801458: hypothetical protein +FIG00801462 FIG00801463: hypothetical protein +FIG00801463 FIG00801464: hypothetical protein +FIG00801464 tRNA delta(2)-isopentenylpyrophosphate transferase +FIG00801466 FIG00801467: hypothetical protein +FIG00801467 FIG00801468: hypothetical protein +FIG00801471 FIG00801473: hypothetical protein +FIG00801473 FIG00801475: hypothetical protein +FIG00801477 FIG00801478: hypothetical protein +FIG00801478 FIG00801479: hypothetical protein +FIG00801479 FIG00801480: hypothetical protein +FIG00801483 FIG00801484: hypothetical protein +FIG00801486 Anthrachelin biosynthesis protein AsbB / Long-chain-fatty-acid--CoA ligase associated with anthrachelin biosynthesis +FIG00801487 FIG00801490: hypothetical protein +FIG00801491 FIG00801496: hypothetical protein +FIG00801496 FIG00801499: hypothetical protein +FIG00801499 FIG00801500: hypothetical protein +FIG00801501 FIG00801502: hypothetical protein +FIG00801502 FIG00801503: hypothetical protein +FIG00801503 FIG00801504: hypothetical protein +FIG00801504 FIG00801505: hypothetical protein +FIG00801507 FIG00801513: hypothetical protein +FIG00801513 Mlr5678 protein +FIG00801514 hypothetical metabolite transport protein +FIG00801516 FIG00801517: hypothetical protein +FIG00801519 FIG00801522: hypothetical protein +FIG00801529 FIG00801531: hypothetical protein +FIG00801531 FIG00801532: hypothetical protein +FIG00801532 FIG00801534: hypothetical protein +FIG00801534 FIG00801536: hypothetical protein +FIG00801536 FIG00801537: hypothetical protein +FIG00801539 FIG00801540: hypothetical protein +FIG00801540 FIG00801541: hypothetical protein +FIG00801541 FIG00801542: hypothetical protein +FIG00801544 FIG00801546: hypothetical protein +FIG00801546 FIG00801547: hypothetical protein +FIG00801557 Fosmidomycin resistance protein +FIG00801558 FIG00801559: hypothetical protein +FIG00801561 COG1942: Uncharacterized protein, 4-oxalocrotonate tautomerase homolog +FIG00801564 Hopanoid 2-methyltransferase +FIG00801565 FIG00801566: hypothetical protein +FIG00801566 FIG00801567: hypothetical protein +FIG00801567 MxaK protein +FIG00801569 Aldo/keto reductase precursor +FIG00801576 FIG00801577: hypothetical protein +FIG00801577 FIG00801578: hypothetical protein +FIG00801578 FIG00801579: hypothetical protein +FIG00801579 FIG00801581: hypothetical protein +FIG00801582 FIG00801583: hypothetical protein +FIG00801583 Large subunit of N,N-dimethylformamidase +FIG00801584 Mlr4665 protein +FIG00801585 FIG00801586: hypothetical protein +FIG00801586 FIG00801588: hypothetical protein +FIG00801593 FIG00801594: hypothetical protein +FIG00801595 FIG00801596: hypothetical protein +FIG00801596 FIG00801597: hypothetical protein +FIG00801597 Tsr2277 protein +FIG00801600 FIG00801603: hypothetical protein +FIG00801606 FIG00801608: hypothetical protein +FIG00801608 FIG00801610: hypothetical protein +FIG00801611 Bll3075 protein +FIG00801612 COG1872 +FIG00801615 FIG00801616: hypothetical protein +FIG00801617 FIG00801618: hypothetical protein +FIG00801618 transporter, MFS family +FIG00801620 FIG00801621: hypothetical protein +FIG00801621 putative branched-chain amino acid ABC transporter, periplasmic branched-chain amino acid binding protein +FIG00801629 FIG00801630: hypothetical protein +FIG00801630 FIG00801631: hypothetical protein +FIG00801631 FIG00801632: hypothetical protein +FIG00801632 FIG00801633: hypothetical protein +FIG00801634 FIG00801635: hypothetical protein +FIG00801635 FIG00801637: hypothetical protein +FIG00801637 FIG00801640: hypothetical protein +FIG00801640 FIG00801641: hypothetical protein +FIG00801642 FIG00801643: hypothetical protein +FIG00801647 FIG00801652: hypothetical protein +FIG00801652 blr1215; hypothetical protein +FIG00801653 FIG00801654: hypothetical protein +FIG00801654 FIG00801655: hypothetical protein +FIG00801657 FIG00801658: hypothetical protein +FIG00801658 FIG00801660: hypothetical protein +FIG00801666 FIG00801667: hypothetical protein +FIG00801668 FIG00801669: hypothetical protein +FIG00801669 FIG00801670: hypothetical protein +FIG00801670 FIG00801672: hypothetical protein +FIG00801672 FIG00801674: hypothetical protein +FIG00801677 FIG00801679: hypothetical protein +FIG00801680 FIG00801681: hypothetical protein +FIG00801684 FIG00801685: hypothetical protein +FIG00801691 FIG00801692: hypothetical protein +FIG00801692 FIG00801693: hypothetical protein +FIG00801705 FIG00801706: hypothetical protein +FIG00801709 FIG00801710: hypothetical protein +FIG00801710 Uncharacterized membrane-associated protein-like protein +FIG00801712 FIG00801713: hypothetical protein +FIG00801713 FIG00801714: hypothetical protein +FIG00801714 FIG00801715: hypothetical protein +FIG00801715 FIG00801717: hypothetical protein +FIG00801717 FIG00801718: hypothetical protein +FIG00801718 FIG00801720: hypothetical protein +FIG00801720 FIG00801721: hypothetical protein +FIG00801725 FIG00801727: hypothetical protein +FIG00801727 FIG00801728: hypothetical protein +FIG00801733 FIG00801734: hypothetical protein +FIG00801734 FIG00801736: hypothetical protein +FIG00801736 FIG00801737: hypothetical protein +FIG00801737 FIG00801738: hypothetical protein +FIG00801738 FIG00801740: hypothetical protein +FIG00801749 Retinol dehydrogenase 13 (EC 1.1.1.-) +FIG00801750 FIG00801751: hypothetical protein +FIG00801752 FIG00801754: hypothetical protein +FIG00801754 FIG00801759: hypothetical protein +FIG00801759 InterPro IPR000073:IPR000379:IPR003089 COGs COG0596 +FIG00801761 FIG00801762: hypothetical protein +FIG00801762 FIG00801763: hypothetical protein +FIG00801763 FIG00801765: hypothetical protein +FIG00801765 COG1126: ABC-type polar amino acid transport system, ATPase component +FIG00801767 Mlr7703 protein +FIG00801768 FIG00801771: hypothetical protein +FIG00801775 FIG00801776: hypothetical protein +FIG00801777 FIG00801778: hypothetical protein +FIG00801782 FIG00801784: hypothetical protein +FIG00801785 Bll6706 protein +FIG00801786 FIG00801787: hypothetical protein +FIG00801791 FIG00801793: hypothetical protein +FIG00801793 FIG00801794: hypothetical protein +FIG00801794 FIG00801795: hypothetical protein +FIG00801795 blr6582; hypothetical protein +FIG00801797 Tryptophan-rich sensory protein precursor +FIG00801798 FIG00801800: hypothetical protein +FIG00801800 FIG00801802: hypothetical protein +FIG00801805 FIG00801806: hypothetical protein +FIG00801806 FIG00801807: hypothetical protein +FIG00801808 FIG00801809: hypothetical protein +FIG00801812 Gll3051 protein +FIG00801818 FIG00801819: hypothetical protein +FIG00801819 FIG00801820: hypothetical protein +FIG00801823 FIG00801827: hypothetical protein +FIG00801830 FIG00801831: hypothetical protein +FIG00801831 FIG00801832: hypothetical protein +FIG00801832 FIG00801833: hypothetical protein +FIG00801839 FIG00801840: hypothetical protein +FIG00801840 FIG00801843: hypothetical protein +FIG00801843 FIG00801844: hypothetical protein +FIG00801845 FIG00801846: hypothetical protein +FIG00801855 FIG00801857: hypothetical protein +FIG00801859 FIG00801860: hypothetical protein +FIG00801860 FIG00801862: hypothetical protein +FIG00801865 FIG00801868: hypothetical protein +FIG00801868 FIG00801869: hypothetical protein +FIG00801869 aspartyl/asparaginyl beta-hydroxylase family protein +FIG00801873 FIG00801874: hypothetical protein +FIG00801875 FIG00801876: hypothetical protein +FIG00801876 homologue of Rhodobacter capsulatus gene transfer agent (GTA) orfg6 (21% idenity) +FIG00801877 FIG00801878: hypothetical protein +FIG00801878 FIG00801879: hypothetical protein +FIG00801879 FIG00801880: hypothetical protein +FIG00801885 FIG00801886: hypothetical protein +FIG00801886 FIG00801887: hypothetical protein +FIG00801892 FIG00801894: hypothetical protein +FIG00801894 FIG00801896: hypothetical protein +FIG00801896 Phage repressor +FIG00801897 FIG00801900: hypothetical protein +FIG00801900 FIG00801901: hypothetical protein +FIG00801903 FIG00801904: hypothetical protein +FIG00801907 FIG00801908: hypothetical protein +FIG00801908 FIG00801909: hypothetical protein +FIG00801909 FIG00801910: hypothetical protein +FIG00801910 FIG00801911: hypothetical protein +FIG00801912 O-methyltransferase I +FIG00801917 FIG00801918: hypothetical protein +FIG00801918 FIG00801919: hypothetical protein +FIG00801921 FIG00801922: hypothetical protein +FIG00801922 FIG00801923: hypothetical protein +FIG00801923 FIG00801924: hypothetical protein +FIG00801924 FIG00801926: hypothetical protein +FIG00801926 FIG00801927: hypothetical protein +FIG00801931 FIG00801932: hypothetical protein +FIG00801932 conserved hypothetical alanine and arginine rich protein +FIG00801934 FIG00801935: hypothetical protein +FIG00801936 FIG00801937: hypothetical protein +FIG00801938 FIG00801939: hypothetical protein +FIG00801942 Major facilitator superfamily (MFS) sugar transporter +FIG00801945 FIG00801946: hypothetical protein +FIG00801948 FIG00801949: hypothetical protein +FIG00801950 FIG00801951: hypothetical protein +FIG00801955 FIG00801956: hypothetical protein +FIG00801956 FIG00801957: hypothetical protein +FIG00801957 FIG00801960: hypothetical protein +FIG00801960 FIG00801962: hypothetical protein +FIG00801964 FIG00801965: hypothetical protein +FIG00801965 Hydrolase +FIG00801966 Coenzyme F420 dependent glucose-6-phosphate dehydrogenase (EC 1.1.99.-) +FIG00801967 FIG00801969: hypothetical protein +FIG00801973 FIG00801974: hypothetical protein +FIG00801979 Conserved hypothetical protein, gene in Ubiquinol-cytochrome C chaperone locus +FIG00801993 FIG00801994: hypothetical protein +FIG00801995 FIG00801996: hypothetical protein +FIG00801997 FIG00801999: hypothetical protein +FIG00801999 FIG00802001: hypothetical protein +FIG00802001 FIG00802004: hypothetical protein +FIG00802006 FIG00802008: hypothetical protein +FIG00802008 InterPro IPR001687 COGs COG1493 +FIG00802009 FIG00802010: hypothetical protein +FIG00802010 FIG00802011: hypothetical protein +FIG00802011 FIG00802014: hypothetical protein +FIG00802017 FIG00802018: hypothetical protein +FIG00802018 FIG00802020: hypothetical protein +FIG00802023 FIG00802025: hypothetical protein +FIG00802025 FIG00802026: hypothetical protein +FIG00802026 FIG00802027: hypothetical protein +FIG00802027 FIG00802028: hypothetical protein +FIG00802028 FIG00802029: hypothetical protein +FIG00802029 FIG00802030: hypothetical protein +FIG00802030 FIG00802031: hypothetical protein +FIG00802031 FIG00802032: hypothetical protein +FIG00802037 FIG00802038: hypothetical protein +FIG00802040 FIG00802041: hypothetical protein +FIG00802041 FIG00802043: hypothetical protein +FIG00802047 COG4423: Uncharacterized protein conserved in bacteria +FIG00802048 FIG00802049: hypothetical protein +FIG00802049 FIG00802050: hypothetical protein +FIG00802050 FIG00802052: hypothetical protein +FIG00802052 FIG00802054: hypothetical protein +FIG00802054 FIG00802055: hypothetical protein +FIG00802059 FIG00802061: hypothetical protein +FIG00802063 FIG00802064: hypothetical protein +FIG00802069 FIG00802071: hypothetical protein +FIG00802073 FIG00802074: hypothetical protein +FIG00802074 FIG00802076: hypothetical protein +FIG00802078 FIG00802079: hypothetical protein +FIG00802084 Glycine amidinotransferase, mitochondrial precursor (EC 2.1.4.1) (L-arginine:glycine amidinotransferase) (Transamidinase) (AT) +FIG00802086 FIG00802087: hypothetical protein +FIG00802087 FIG00802090: hypothetical protein +FIG00802091 FIG00802093: hypothetical protein +FIG00802093 FIG00802094: hypothetical protein +FIG00802094 FIG00802095: hypothetical protein +FIG00802098 FIG00802099: hypothetical protein +FIG00802099 FIG00802100: hypothetical protein +FIG00802101 FIG00802102: hypothetical protein +FIG00802102 FIG00802103: hypothetical protein +FIG00802103 FIG00802105: hypothetical protein +FIG00802113 FIG00802114: hypothetical protein +FIG00802114 FIG00802115: hypothetical protein +FIG00802119 FIG00802120: hypothetical protein +FIG00802120 FIG00802121: hypothetical protein +FIG00802124 FIG00802127: hypothetical protein +FIG00802131 FIG00802133: hypothetical protein +FIG00802134 FIG00802135: hypothetical protein +FIG00802138 FIG00802139: hypothetical protein +FIG00802139 FIG00802140: hypothetical protein +FIG00802144 FIG00802145: hypothetical protein +FIG00802145 UPF0243 zinc-binding protein bsr1260 +FIG00802148 FIG00802149: hypothetical protein +FIG00802155 Mlr7916 protein +FIG00802159 FIG00802160: hypothetical protein +FIG00802160 Probable ferredoxin +FIG00802161 FIG00802162: hypothetical protein +FIG00802166 Bll5481 protein +FIG00802167 FIG00802168: hypothetical protein +FIG00802168 COG0513: Superfamily II DNA and RNA helicases +FIG00802170 FIG00802171: hypothetical protein +FIG00802172 FIG00802174: hypothetical protein +FIG00802175 FIG00802177: hypothetical protein +FIG00802177 FIG00802178: hypothetical protein +FIG00802179 FIG00802180: hypothetical protein +FIG00802182 FIG00802183: hypothetical protein +FIG00802183 FIG00802185: hypothetical protein +FIG00802186 COG1012: NAD-dependent aldehyde dehydrogenases +FIG00802188 FIG00802190: hypothetical protein +FIG00802190 FIG00802191: hypothetical protein +FIG00802191 FIG00802193: hypothetical protein +FIG00802193 FIG00802194: hypothetical protein +FIG00802195 FIG00802196: hypothetical protein +FIG00802198 FIG00802200: hypothetical protein +FIG00802201 FIG00802203: hypothetical protein +FIG00802203 FIG00802204: hypothetical protein +FIG00802204 FIG00802205: hypothetical protein +FIG00802213 FIG00802214: hypothetical protein +FIG00802218 FIG00802219: hypothetical protein +FIG00802221 FIG00802222: hypothetical protein +FIG00802224 FIG00802226: hypothetical protein +FIG00802226 FIG00802228: hypothetical protein +FIG00802229 FIG00802231: hypothetical protein +FIG00802234 FIG00802235: hypothetical protein +FIG00802236 FIG00802237: hypothetical protein +FIG00802238 FIG00802239: hypothetical protein +FIG00802242 Putative Tartrate dehydratase beta subunit +FIG00802243 FIG00802246: hypothetical protein +FIG00802248 FIG00802249: hypothetical protein +FIG00802249 blr4684; hypothetical protein +FIG00802251 FIG00802253: hypothetical protein +FIG00802254 FIG00802257: hypothetical protein +FIG00802257 FIG00802258: hypothetical protein +FIG00802260 FIG00802263: hypothetical protein +FIG00802265 FIG00802266: hypothetical protein +FIG00802271 FIG00802272: hypothetical protein +FIG00802273 FIG00802275: hypothetical protein +FIG00802275 FIG00802276: hypothetical protein +FIG00802278 FIG00802279: hypothetical protein +FIG00802279 FIG00802281: hypothetical protein +FIG00802283 FIG00802284: hypothetical protein +FIG00802284 FIG00802285: hypothetical protein +FIG00802287 FIG00802289: hypothetical protein +FIG00802289 FIG00802291: hypothetical protein +FIG00802291 FIG00802293: hypothetical protein +FIG00802294 FIG00802295: hypothetical protein +FIG00802297 FIG00802298: hypothetical protein +FIG00802304 FIG00802305: hypothetical protein +FIG00802306 FIG00802307: hypothetical protein +FIG00802311 FIG00802315: hypothetical protein +FIG00802324 FIG00802325: hypothetical protein +FIG00802325 FIG00802326: hypothetical protein +FIG00802326 FIG00802328: hypothetical protein +FIG00802328 Methylamine utilization protein mauJ +FIG00802334 FIG00802335: hypothetical protein +FIG00802339 FIG00802341: hypothetical protein +FIG00802341 FIG00802343: hypothetical protein +FIG00802343 FIG00802344: hypothetical protein +FIG00802345 FIG00802346: hypothetical protein +FIG00802346 FIG00802347: hypothetical protein +FIG00802347 Mlr2298 protein +FIG00802349 FIG00802351: hypothetical protein +FIG00802354 FIG00802355: hypothetical protein +FIG00802355 FIG00802356: hypothetical protein +FIG00802363 FIG00802364: hypothetical protein +FIG00802366 FIG00802367: hypothetical protein +FIG00802370 FIG00802372: hypothetical protein +FIG00802378 FIG00802379: hypothetical protein +FIG00802382 FIG00802383: hypothetical protein +FIG00802384 FIG00802386: hypothetical protein +FIG00802386 probable phosphoprotein phosphatase +FIG00802387 FIG00802389: hypothetical protein +FIG00802389 FIG00802391: hypothetical protein +FIG00802391 peptidase, membrane zinc metallopeptidase, putative +FIG00802394 FIG00802395: hypothetical protein +FIG00802395 FIG00802397: hypothetical protein +FIG00802399 MxaD-like protein +FIG00802402 FIG00802405: hypothetical protein +FIG00802405 FIG00802406: hypothetical protein +FIG00802408 FIG00802409: hypothetical protein +FIG00802409 FIG00802414: hypothetical protein +FIG00802415 Acyl-CoA dehydrogenase (EC 1.3.8.7) +FIG00802416 FIG00802417: hypothetical protein +FIG00802417 FIG00802418: hypothetical protein +FIG00802418 FIG00802419: hypothetical protein +FIG00802420 FIG00802421: hypothetical protein +FIG00802422 FIG00802424: hypothetical protein +FIG00802424 FIG00802425: hypothetical protein +FIG00802425 FIG00802426: hypothetical protein +FIG00802433 FIG00802436: hypothetical protein +FIG00802443 COG3187: Heat shock protein +FIG00802445 Bll5542 protein +FIG00802448 FIG00802451: hypothetical protein +FIG00802452 FIG00802453: hypothetical protein +FIG00802454 FIG00802456: hypothetical protein +FIG00802458 FIG00802461: hypothetical protein +FIG00802461 FIG00802462: hypothetical protein +FIG00802462 COG1607: Acyl-CoA hydrolase +FIG00802463 FIG00802465: hypothetical protein +FIG00802466 FIG00802468: hypothetical protein +FIG00802469 FIG00802471: hypothetical protein +FIG00802471 FIG00802472: hypothetical protein +FIG00802472 FIG00802473: hypothetical protein +FIG00802473 FIG00802474: hypothetical protein +FIG00802474 FIG00802476: hypothetical protein +FIG00802479 FIG00802480: hypothetical protein +FIG00802494 FIG00802496: hypothetical protein +FIG00802496 Mll3878 protein +FIG00802498 FIG00802499: hypothetical protein +FIG00802499 FIG00802500: hypothetical protein +FIG00802500 FIG00802501: hypothetical protein +FIG00802501 FIG00802502: hypothetical protein +FIG00802505 FIG00802506: hypothetical protein +FIG00802507 UspA (universal stress protein) domain protein +FIG00802508 FIG00802509: hypothetical protein +FIG00802511 FIG00802512: hypothetical protein +FIG00802513 FIG00802514: hypothetical protein +FIG00802518 FIG00802519: hypothetical protein +FIG00802522 FIG00802525: hypothetical protein +FIG00802530 FIG00802531: hypothetical protein +FIG00802532 hypothetical protein +FIG00802534 FIG00802535: hypothetical protein +FIG00802535 FIG00802536: hypothetical protein +FIG00802536 FIG00802539: hypothetical protein +FIG00802543 FIG00802544: hypothetical protein +FIG00802550 FIG00802551: hypothetical protein +FIG00802553 bll4707; hypothetical protein +FIG00802554 FIG00802555: hypothetical protein +FIG00802555 FIG00802556: hypothetical protein +FIG00802557 FIG00802558: hypothetical protein +FIG00802558 FIG00802559: hypothetical protein +FIG00802564 FIG00802565: hypothetical protein +FIG00802570 FIG00802571: hypothetical protein +FIG00802575 FIG00802576: hypothetical protein +FIG00802577 FIG00802579: hypothetical protein +FIG00802583 FIG00802584: hypothetical protein +FIG00802584 FIG00802586: hypothetical protein +FIG00802586 FIG00802590: hypothetical protein +FIG00802590 FIG00802591: hypothetical protein +FIG00802594 NapD-like protein +FIG00802596 FIG00802597: hypothetical protein +FIG00802597 FIG00802600: hypothetical protein +FIG00802602 FIG00802604: hypothetical protein +FIG00802604 FIG00802605: hypothetical protein +FIG00802607 FIG00802608: hypothetical protein +FIG00802608 FIG00802609: hypothetical protein +FIG00802609 FIG00802610: hypothetical protein +FIG00802610 FIG00802611: hypothetical protein +FIG00802611 FIG00802613: hypothetical protein +FIG00802615 FIG00802616: hypothetical protein +FIG00802622 FIG00802623: hypothetical protein +FIG00802624 FIG00802625: hypothetical protein +FIG00802625 FIG00802628: hypothetical protein +FIG00802628 FIG00802629: hypothetical protein +FIG00802631 FIG00802632: hypothetical protein +FIG00802632 FIG00802633: hypothetical protein +FIG00802640 Protein often near L-alanine-DL-glutamate epimerase (cell wall recycling) +FIG00802645 Mll7632 protein +FIG00802647 FIG00802650: hypothetical protein +FIG00802651 FIG00802652: hypothetical protein +FIG00802652 Mlr3136 protein +FIG00802653 COG3553: Uncharacterized protein conserved in bacteria +FIG00802654 FIG00802655: hypothetical protein +FIG00802658 FIG00802660: hypothetical protein +FIG00802660 blr2501; hypothetical protein +FIG00802662 FIG00802663: hypothetical protein +FIG00802664 FIG00802665: hypothetical protein +FIG00802673 COG1985: Pyrimidine reductase, riboflavin biosynthesis +FIG00802693 COG0657: Esterase/lipase +FIG00802700 similar to Fe-S oxidoreductases +FIG00802702 FIG00802703: hypothetical protein +FIG00802708 FIG00802709: hypothetical protein +FIG00802711 FIG00802712: hypothetical protein +FIG00802715 FIG00802720: hypothetical protein +FIG00802722 FIG00802723: hypothetical protein +FIG00802723 FIG00802724: hypothetical protein +FIG00802727 FIG00802728: hypothetical protein +FIG00802728 FIG00802729: hypothetical protein +FIG00802733 FIG00802734: hypothetical protein +FIG00802738 FIG00802739: hypothetical protein +FIG00802741 FIG00802742: hypothetical protein +FIG00802742 FIG00802745: hypothetical protein +FIG00802745 FIG00802746: hypothetical protein +FIG00802746 COG2841: Uncharacterized protein conserved in bacteria +FIG00802751 FIG00802752: hypothetical protein +FIG00802754 FIG00802756: hypothetical protein +FIG00802756 FIG00802757: hypothetical protein +FIG00802757 COG5569: Uncharacterized conserved protein +FIG00802762 FIG00802764: hypothetical protein +FIG00802764 FIG00802766: hypothetical protein +FIG00802766 FIG00802767: hypothetical protein +FIG00802768 FIG00802770: hypothetical protein +FIG00802771 FIG00802772: hypothetical protein +FIG00802772 FIG00802773: hypothetical protein +FIG00802775 FIG00802776: hypothetical protein +FIG00802780 MxaH +FIG00802784 FIG00802785: hypothetical protein +FIG00802786 FIG00802787: hypothetical protein +FIG00802790 FIG00802791: hypothetical protein +FIG00802791 FIG00802792: hypothetical protein +FIG00802792 FIG00802795: hypothetical protein +FIG00802795 FIG00802798: hypothetical protein +FIG00802802 FIG00802804: hypothetical protein +FIG00802804 FIG00802805: hypothetical protein +FIG00802811 FIG00802812: hypothetical protein +FIG00802812 FIG00802814: hypothetical protein +FIG00802815 FIG00802817: hypothetical protein +FIG00802817 FIG00802818: hypothetical protein +FIG00802821 FIG00802822: hypothetical protein +FIG00802822 Predicted glutamine amidotransferase involved in pyridoxine biosynthesis +FIG00802828 FIG00802829: hypothetical protein +FIG00802834 Protein crcB homolog 3 +FIG00802841 FIG00802845: hypothetical protein +FIG00802846 probable bacteriophage protein +FIG00802847 Epstein-Barr nuclear antigen 1 (EBV nuclear antigen 1) (EBNA-1) +FIG00802849 FIG00802850: hypothetical protein +FIG00802850 HOMOSERINE/HOMOSERINE LACTONE EFFLUX PROTEIN +FIG00802869 FIG00802870: hypothetical protein +FIG00802876 FIG00802877: hypothetical protein +FIG00802879 FIG00802881: hypothetical protein +FIG00802881 FIG00802882: hypothetical protein +FIG00802886 FIG00802887: hypothetical protein +FIG00802887 Helicase domain protein +FIG00802890 FIG00802892: hypothetical protein +FIG00802892 FIG00802895: hypothetical protein +FIG00802896 FIG00802897: hypothetical protein +FIG00802897 FIG00802899: hypothetical protein +FIG00802902 FIG00802904: hypothetical protein +FIG00802910 FIG00802911: hypothetical protein +FIG00802913 FIG00802914: hypothetical protein +FIG00802914 FIG00802915: hypothetical protein +FIG00802915 COG1408: Predicted phosphohydrolases +FIG00802916 FIG00802917: hypothetical protein +FIG00802920 FIG00802921: hypothetical protein +FIG00802921 Bll5259 protein +FIG00802928 FIG00802929: hypothetical protein +FIG00802936 FIG00802937: hypothetical protein +FIG00802937 FIG00802938: hypothetical protein +FIG00802938 FIG00802939: hypothetical protein +FIG00802940 FIG00802941: hypothetical protein +FIG00802941 FIG00802942: hypothetical protein +FIG00802942 FIG00802944: hypothetical protein +FIG00802944 FIG00802945: hypothetical protein +FIG00802945 FIG00802948: hypothetical protein +FIG00802948 FIG00802950: hypothetical protein +FIG00802950 FIG00802954: hypothetical protein +FIG00802955 FIG00802956: hypothetical protein +FIG00802956 Bsr4462 protein +FIG00802959 FIG00802960: hypothetical protein +FIG00802960 FIG00802961: hypothetical protein +FIG00802962 FIG00802964: hypothetical protein +FIG00802964 COG3409: Putative peptidoglycan-binding domain-containing protein +FIG00802967 FIG00802971: hypothetical protein +FIG00802976 phage tail protein I +FIG00802977 FIG00802980: hypothetical protein +FIG00802982 FIG00802985: hypothetical protein +FIG00802986 FIG00802988: hypothetical protein +FIG00802990 COG3918: Predicted membrane protein +FIG00802995 FIG00802996: hypothetical protein +FIG00803002 FIG00803005: hypothetical protein +FIG00803008 FIG00803009: hypothetical protein +FIG00803010 MupW, putative +FIG00803011 FIG00803012: hypothetical protein +FIG00803014 FIG00803015: hypothetical protein +FIG00803015 NAD/NADP transhydrogenase alpha subunit +FIG00803016 FIG00803017: hypothetical protein +FIG00803018 FIG00803019: hypothetical protein +FIG00803021 FIG00803022: hypothetical protein +FIG00803025 FIG00803026: hypothetical protein +FIG00803026 FIG00803028: hypothetical protein +FIG00803029 FIG00803031: hypothetical protein +FIG00803034 FIG00803035: hypothetical protein +FIG00803037 FIG00803039: hypothetical protein +FIG00803042 Nitrilase (EC 3.5.5.7) +FIG00803044 FIG00803045: hypothetical protein +FIG00803046 COG1872 +FIG00803050 FIG00803052: hypothetical protein +FIG00803052 FIG00803055: hypothetical protein +FIG00803055 FIG00803056: hypothetical protein +FIG00803056 FIG00803058: hypothetical protein +FIG00803074 FIG00803075: hypothetical protein +FIG00803075 FIG00803078: hypothetical protein +FIG00803082 FIG00803084: hypothetical protein +FIG00803088 FIG00803089: hypothetical protein +FIG00803089 Gene Transfer Agent associated protein Pden_3078 +FIG00803090 FIG00803091: hypothetical protein +FIG00803093 FIG00803095: hypothetical protein +FIG00803096 FIG00803097: hypothetical protein +FIG00803105 COG0790: FOG: TPR repeat, SEL1 subfamily +FIG00803111 FIG00803112: hypothetical protein +FIG00803112 FIG00803114: hypothetical protein +FIG00803114 FIG00803119: hypothetical protein +FIG00803119 FIG00803121: hypothetical protein +FIG00803129 FIG00803130: hypothetical protein +FIG00803130 Phage-related transcriptional regulator +FIG00803134 COG3753: Uncharacterized protein conserved in bacteria +FIG00803135 FIG00803136: hypothetical protein +FIG00803137 FIG00803138: hypothetical protein +FIG00803138 FIG00803140: hypothetical protein +FIG00803140 FIG00803141: hypothetical protein +FIG00803144 FIG00803145: hypothetical protein +FIG00803147 FIG00803150: hypothetical protein +FIG00803152 FIG00803153: hypothetical protein +FIG00803153 FIG00803154: hypothetical protein +FIG00803154 FIG00803155: hypothetical protein +FIG00803156 Mlr1171 protein +FIG00803160 Poly-beta-hydroxybutyrate polymerase subunit PhaE (EC 2.3.1.-) +FIG00803166 bll7613; hypothetical protein +FIG00803167 InterPro IPR001687:IPR003439:IPR003593 COGs COG1133 +FIG00803172 FIG00803173: hypothetical protein +FIG00803177 FIG00803178: hypothetical protein +FIG00803186 FIG00803188: hypothetical protein +FIG00803198 FIG00803199: hypothetical protein +FIG00803199 FIG00803201: hypothetical protein +FIG00803201 FIG00803202: hypothetical protein +FIG00803209 FIG00803210: hypothetical protein +FIG00803216 FIG00803217: hypothetical protein +FIG00803217 FIG00803218: hypothetical protein +FIG00803226 FIG00803227: hypothetical protein +FIG00803230 FIG00803232: hypothetical protein +FIG00803232 FIG00803233: hypothetical protein +FIG00803250 FIG00803251: hypothetical protein +FIG00803261 FIG00803262: hypothetical protein +FIG00803265 FIG00803266: hypothetical protein +FIG00803266 FIG00803268: hypothetical protein +FIG00803268 FIG00803270: hypothetical protein +FIG00803274 FIG00803275: hypothetical protein +FIG00803277 FIG00803278: hypothetical protein +FIG00803279 FIG00803280: hypothetical protein +FIG00803283 FIG00803284: hypothetical protein +FIG00803286 FIG00803287: hypothetical protein +FIG00803287 FIG00803289: hypothetical protein +FIG00803291 FIG00803292: hypothetical protein +FIG00803293 FIG00803295: hypothetical protein +FIG00803296 FIG00803297: hypothetical protein +FIG00803299 FIG00803300: hypothetical protein +FIG00803300 FIG00803302: hypothetical protein +FIG00803302 FIG00803304: hypothetical protein +FIG00803304 FIG00803306: hypothetical protein +FIG00803312 FIG00803313: hypothetical protein +FIG00803313 FIG00803314: hypothetical protein +FIG00803319 FIG00803320: hypothetical protein +FIG00803324 FIG00803325: hypothetical protein +FIG00803325 FIG00803326: hypothetical protein +FIG00803331 FIG00803332: hypothetical protein +FIG00803332 bll1138; probable transcriptional regulator +FIG00803334 FIG00803336: hypothetical protein +FIG00803342 FIG00803343: hypothetical protein +FIG00803343 Bll2537 protein +FIG00803344 FIG00803346: hypothetical protein +FIG00803346 FIG00803347: hypothetical protein +FIG00803351 FIG00803353: hypothetical protein +FIG00803353 Hydroxyneurosporene methyltransferase (EC 2.1.1.210) +FIG00803354 FIG00803356: hypothetical protein +FIG00803356 FIG00803357: hypothetical protein +FIG00803359 FIG00803363: hypothetical protein +FIG00803364 FIG00803365: hypothetical protein +FIG00803365 FIG00803368: hypothetical protein +FIG00803372 phage-related contractile tail sheath protein +FIG00803373 FIG00803374: hypothetical protein +FIG00803378 sulfur oxidation V protein +FIG00803380 FIG00803381: hypothetical protein +FIG00803383 FIG00803384: hypothetical protein +FIG00803384 FIG00803386: hypothetical protein +FIG00803391 FIG00803395: hypothetical protein +FIG00803395 FIG00803396: hypothetical protein +FIG00803397 FIG00803399: hypothetical protein +FIG00803399 FIG00803400: hypothetical protein +FIG00803402 FIG00803403: hypothetical protein +FIG00803403 FIG00803404: hypothetical protein +FIG00803407 FIG00803408: hypothetical protein +FIG00803408 probable N-methylproline demethylase (stahydrine utilization protein stcD) +FIG00803410 Secretion protein HlyD precursor +FIG00803418 FIG00803419: hypothetical protein +FIG00803425 FIG00803428: hypothetical protein +FIG00803428 FIG00803429: hypothetical protein +FIG00803440 FIG00803442: hypothetical protein +FIG00803450 FIG00803451: hypothetical protein +FIG00803454 FIG00803456: hypothetical protein +FIG00803464 FIG00803465: hypothetical protein +FIG00803465 FIG00803466: hypothetical protein +FIG00803466 Putative transport system permease +FIG00803467 FIG00803468: hypothetical protein +FIG00803468 FIG00803471: hypothetical protein +FIG00803479 FIG00803480: hypothetical protein +FIG00803480 FIG00803481: hypothetical protein +FIG00803481 FIG00803482: hypothetical protein +FIG00803489 FIG00803490: hypothetical protein +FIG00803493 FIG00803497: hypothetical protein +FIG00803497 FIG00803498: hypothetical protein +FIG00803502 FIG00803503: hypothetical protein +FIG00803506 FIG00803510: hypothetical protein +FIG00803510 FIG00803511: hypothetical protein +FIG00803521 FIG00803526: hypothetical protein +FIG00803526 FIG00803528: hypothetical protein +FIG00803528 FIG00803530: hypothetical protein +FIG00803531 FIG00803533: hypothetical protein +FIG00803535 FIG00803537: hypothetical protein +FIG00803537 FIG00803540: hypothetical protein +FIG00803543 FIG00803544: hypothetical protein +FIG00803544 FIG00803547: hypothetical protein +FIG00803548 FIG00803549: hypothetical protein +FIG00803549 blr0743; hypothetical protein +FIG00803557 FIG00803559: hypothetical protein +FIG00803559 FIG00803561: hypothetical protein +FIG00803561 FIG00803563: hypothetical protein +FIG00803567 blr0328; hypothetical protein +FIG00803568 FIG00803570: hypothetical protein +FIG00803572 FIG00803573: hypothetical protein +FIG00803573 FIG00803575: hypothetical protein +FIG00803577 bll4196; putative methyl-accepting chemotaxis protein +FIG00803582 FIG00803583: hypothetical protein +FIG00803583 FIG00803584: hypothetical protein +FIG00803588 FIG00803592: hypothetical protein +FIG00803596 FIG00803597: hypothetical protein +FIG00803607 FIG00803608: hypothetical protein +FIG00803608 FIG00803610: hypothetical protein +FIG00803610 FIG00803611: hypothetical protein +FIG00803611 FIG00803612: hypothetical protein +FIG00803612 FIG00803613: hypothetical protein +FIG00803615 FIG00803616: hypothetical protein +FIG00803616 FIG00803618: hypothetical protein +FIG00803623 FIG00803625: hypothetical protein +FIG00803625 FIG00803629: hypothetical protein +FIG00803631 hdeA protein +FIG00803632 Bll2420 protein +FIG00803635 Predicted ICC-like phosphoesterases +FIG00803637 FIG00803638: hypothetical protein +FIG00803639 FIG00803640: hypothetical protein +FIG00803642 COG3685: Uncharacterized protein conserved in bacteria +FIG00803645 FIG00803646: hypothetical protein +FIG00803654 FIG00803656: hypothetical protein +FIG00803656 FIG00803657: hypothetical protein +FIG00803657 FIG00803658: hypothetical protein +FIG00803659 FIG00803661: hypothetical protein +FIG00803661 Two-component transcriptional regulator, LuxR family +FIG00803664 FIG00803665: hypothetical protein +FIG00803666 sensor histidine kinase with multiple PAS and a response regulator receiver domain +FIG00803668 FIG00803669: hypothetical protein +FIG00803670 FIG00803671: hypothetical protein +FIG00803671 FIG00803672: hypothetical protein +FIG00803674 FIG00803675: hypothetical protein +FIG00803675 Mll8471 protein +FIG00803681 FIG00803682: hypothetical protein +FIG00803682 UPF0391 membrane protein lpl2443 +FIG00803687 FIG00803688: hypothetical protein +FIG00803690 FIG00803691: hypothetical protein +FIG00803695 Transcriptional regulatory protein ompR +FIG00803697 FIG00803698: hypothetical protein +FIG00803705 FIG00803707: hypothetical protein +FIG00803711 FIG00803716: hypothetical protein +FIG00803719 FIG00803720: hypothetical protein +FIG00803724 FIG00803727: hypothetical protein +FIG00803737 FIG00803738: hypothetical protein +FIG00803738 UPF0331 protein MA_0101 +FIG00803744 FIG00803746: hypothetical protein +FIG00803746 FIG00803747: hypothetical protein +FIG00803749 FIG00803750: hypothetical protein +FIG00803757 hypothetical DNA-binding response regulator OmpR +FIG00803771 FIG00803772: hypothetical protein +FIG00803773 FIG00803776: hypothetical protein +FIG00803778 COG0311: Predicted glutamine amidotransferase involved in pyridoxine biosynthesis +FIG00803779 ABC-type proline/glycine betaine transport systems, permease component +FIG00803783 MucR family transcriptional regulator +FIG00803785 FIG00803786: hypothetical protein +FIG00803786 FIG00803787: hypothetical protein +FIG00803787 FIG00803790: hypothetical protein +FIG00803793 FIG00803795: hypothetical protein +FIG00803804 FIG00803805: hypothetical protein +FIG00803805 FIG00803806: hypothetical protein +FIG00803812 FIG00803813: hypothetical protein +FIG00803830 FIG00803832: hypothetical protein +FIG00803840 FIG00803841: hypothetical protein +FIG00803841 FIG00803842: hypothetical protein +FIG00803845 FIG00803846: hypothetical protein +FIG00803849 FIG00803850: hypothetical protein +FIG00803851 FIG00803852: hypothetical protein +FIG00803855 FIG00803858: hypothetical protein +FIG00803858 FIG00803859: hypothetical protein +FIG00803863 FIG00803864: hypothetical protein +FIG00803864 FIG00803867: hypothetical protein +FIG00803868 FIG00803871: hypothetical protein +FIG00803871 FIG00803873: hypothetical protein +FIG00803885 FIG00803886: hypothetical protein +FIG00803892 FIG00803893: hypothetical protein +FIG00803893 FIG00803897: hypothetical protein +FIG00803898 FIG00803899: hypothetical protein +FIG00803899 FIG00803900: hypothetical protein +FIG00803900 FIG00803901: hypothetical protein +FIG00803904 FIG00803905: hypothetical protein +FIG00803918 CDS_ID OB1141 +FIG00803923 FIG00803924: hypothetical protein +FIG00803924 FIG00803926: hypothetical protein +FIG00803932 FIG00803934: hypothetical protein +FIG00803935 FIG00803936: hypothetical protein +FIG00803939 FIG00803940: hypothetical protein +FIG00803940 FIG00803941: hypothetical protein +FIG00803943 FIG00803947: hypothetical protein +FIG00803949 FIG00803950: hypothetical protein +FIG00803950 FIG00803952: hypothetical protein +FIG00803953 FIG00803954: hypothetical protein +FIG00803954 FIG00803955: hypothetical protein +FIG00803955 FIG00803956: hypothetical protein +FIG00803959 FIG00803962: hypothetical protein +FIG00803962 FIG00803964: hypothetical protein +FIG00803970 FIG00803971: hypothetical protein +FIG00803979 FIG00803980: hypothetical protein +FIG00803980 FIG00803981: hypothetical protein +FIG00803985 FIG00803986: hypothetical protein +FIG00803994 FIG00803997: hypothetical protein +FIG00803997 FIG00803998: hypothetical protein +FIG00803999 FIG00804001: hypothetical protein +FIG00804004 FIG00804005: hypothetical protein +FIG00804008 FIG00804009: hypothetical protein +FIG00804013 FIG00804014: hypothetical protein +FIG00804021 FIG00804023: hypothetical protein +FIG00804029 FIG00804030: hypothetical protein +FIG00804031 FIG00804035: hypothetical protein +FIG00804037 FIG00804038: hypothetical protein +FIG00804040 FIG00804041: hypothetical protein +FIG00804041 Bll2215 protein +FIG00804050 FIG00804052: hypothetical protein +FIG00804052 FIG00804054: hypothetical protein +FIG00804056 FIG00804058: hypothetical protein +FIG00804058 FIG00804060: hypothetical protein +FIG00804063 FIG00804064: hypothetical protein +FIG00804064 FIG00804065: hypothetical protein +FIG00804068 FIG00804069: hypothetical protein +FIG00804069 FIG00804070: hypothetical protein +FIG00804070 FIG00804071: hypothetical protein +FIG00804074 FIG00804076: hypothetical protein +FIG00804078 FIG00804079: hypothetical protein +FIG00804079 FIG00804081: hypothetical protein +FIG00804083 FIG00804084: hypothetical protein +FIG00804086 putative bacteriophage tail protein +FIG00804087 FIG00804088: hypothetical protein +FIG00804088 FIG00804089: hypothetical protein +FIG00804090 FIG00804093: hypothetical protein +FIG00804099 FIG00804100: hypothetical protein +FIG00804105 FIG00804107: hypothetical protein +FIG00804107 FIG00804108: hypothetical protein +FIG00804114 FIG00804116: hypothetical protein +FIG00804116 FIG00804117: hypothetical protein +FIG00804127 FIG00804128: hypothetical protein +FIG00804132 FIG00804133: hypothetical protein +FIG00804133 FIG00804134: hypothetical protein +FIG00804139 FIG00804140: hypothetical protein +FIG00804146 putative transmembrane regulator +FIG00804147 Protein-L-isoaspartate O-methyltransferase (EC 2.1.1.77) +FIG00804150 FIG00804151: hypothetical protein +FIG00804165 FIG00804166: hypothetical protein +FIG00804170 FIG00804171: hypothetical protein +FIG00804177 FIG00804178: hypothetical protein +FIG00804178 FIG00804179: hypothetical protein +FIG00804179 FIG00804180: hypothetical protein +FIG00804181 Possible peptidase +FIG00804182 FIG00804184: hypothetical protein +FIG00804187 oxidoreductase, iron-sulphur binding subunit +FIG00804189 FIG00804192: hypothetical protein +FIG00804194 FIG00804195: hypothetical protein +FIG00804195 FIG00804196: hypothetical protein +FIG00804196 FIG00804197: hypothetical protein +FIG00804197 FIG00804198: hypothetical protein +FIG00804200 FIG00804201: hypothetical protein +FIG00804201 FIG00804202: hypothetical protein +FIG00804205 FIG00804209: hypothetical protein +FIG00804213 FIG00804215: hypothetical protein +FIG00804221 FIG00804223: hypothetical protein +FIG00804230 FIG00804234: hypothetical protein +FIG00804238 FIG00804244: hypothetical protein +FIG00804247 Mlr8009 protein +FIG00804248 FIG00804249: hypothetical protein +FIG00804250 Bll7240 protein +FIG00804253 FIG00804254: hypothetical protein +FIG00804256 FIG00804257: hypothetical protein +FIG00804257 FIG00804258: hypothetical protein +FIG00804258 FIG00804259: hypothetical protein +FIG00804270 FIG00804271: hypothetical protein +FIG00804273 FIG00804274: hypothetical protein +FIG00804274 COG2373: Large extracellular alpha-helical protein +FIG00804282 FIG00804283: hypothetical protein +FIG00804284 Gene Transfer Agent prohead protease +FIG00804285 FIG00804286: hypothetical protein +FIG00804288 FIG00804290: hypothetical protein +FIG00804293 DNA polymerase III epsilon subunit and related 3'-5' exonuclease +FIG00804294 FIG00804295: hypothetical protein +FIG00804300 FIG00804304: hypothetical protein +FIG00804304 FIG00804305: hypothetical protein +FIG00804309 FIG00804311: hypothetical protein +FIG00804317 FIG00804318: hypothetical protein +FIG00804324 FIG00804326: hypothetical protein +FIG00804326 FIG00804328: hypothetical protein +FIG00804336 FIG00804339: hypothetical protein +FIG00804339 FIG00804340: hypothetical protein +FIG00804341 unknown, with homologous in databases +FIG00804353 FIG00804354: hypothetical protein +FIG00804368 FIG00804369: hypothetical protein +FIG00804379 FIG00804380: hypothetical protein +FIG00804390 FIG00804392: hypothetical protein +FIG00804396 FIG00804400: hypothetical protein +FIG00804400 FIG00804402: hypothetical protein +FIG00804403 Bll6206 protein +FIG00804404 ABC Fe3+ siderophore transporter, periplasmic ligand binding protein +FIG00804414 FIG00804416: hypothetical protein +FIG00804422 FIG00804424: hypothetical protein +FIG00804424 FIG00804426: hypothetical protein +FIG00804430 FIG00804431: hypothetical protein +FIG00804432 FIG00804433: hypothetical protein +FIG00804437 FIG00804439: hypothetical protein +FIG00804444 FIG00804445: hypothetical protein +FIG00804449 FIG00804453: hypothetical protein +FIG00804453 FIG00804457: hypothetical protein +FIG00804457 FIG00804460: hypothetical protein +FIG00804465 FIG00804466: hypothetical protein +FIG00804471 FIG00804473: hypothetical protein +FIG00804480 Chaperone HdeA +FIG00804481 putative permease (PerM family) +FIG00804491 FIG00804492: hypothetical protein +FIG00804492 FIG00804494: hypothetical protein +FIG00804505 FIG00804506: hypothetical protein +FIG00804506 FIG00804508: hypothetical protein +FIG00804509 FIG00804510: hypothetical protein +FIG00804510 FIG00804511: hypothetical protein +FIG00804511 FIG00804513: hypothetical protein +FIG00804520 FIG00804521: hypothetical protein +FIG00804529 FIG00804532: hypothetical protein +FIG00804550 FIG00804551: hypothetical protein +FIG00804553 FIG00804554: hypothetical protein +FIG00804554 Mlr4739 protein +FIG00804559 FIG00804561: hypothetical protein +FIG00804566 FIG00804569: hypothetical protein +FIG00804569 FIG00804570: hypothetical protein +FIG00804574 Oligopeptide transport ATP-binding protein oppF +FIG00804581 FIG00804582: hypothetical protein +FIG00804582 FIG00804583: hypothetical protein +FIG00804589 FIG00804593: hypothetical protein +FIG00804595 FIG00804596: hypothetical protein +FIG00804598 FIG00804599: hypothetical protein +FIG00804608 blr2811; hypothetical protein +FIG00804616 FIG00804617: hypothetical protein +FIG00804617 FIG00804618: hypothetical protein +FIG00804627 y4jL gene in pNGR234a homolog +FIG00804632 FIG00804635: hypothetical protein +FIG00804635 FIG00804637: hypothetical protein +FIG00804637 FIG00804639: hypothetical protein +FIG00804657 FIG00804658: hypothetical protein +FIG00804667 FIG00804668: hypothetical protein +FIG00804683 FIG00804685: hypothetical protein +FIG00804687 FIG00804688: hypothetical protein +FIG00804699 transcriptional regulator, MucR family +FIG00804703 FIG00804704: hypothetical protein +FIG00804706 FIG00804707: hypothetical protein +FIG00804710 FIG00804713: hypothetical protein +FIG00804730 Exopolysaccharide synthesis protein exoD +FIG00804734 FIG00804735: hypothetical protein +FIG00804735 FIG00804736: hypothetical protein +FIG00804736 Probable pyocin R2_PP, tail fiber protein +FIG00804737 Succinate dehydrogenase hydrophobic anchor protein +FIG00804769 Aldehyde dehydrogenase +FIG00804789 FIG00804790: hypothetical protein +FIG00804790 FIG00804791: hypothetical protein +FIG00804795 FIG00804797: hypothetical protein +FIG00804797 FIG00804798: hypothetical protein +FIG00804803 FIG00804806: hypothetical protein +FIG00804809 FIG00804811: hypothetical protein +FIG00804811 FIG00804813: hypothetical protein +FIG00804813 FIG00804814: hypothetical protein +FIG00804827 FIG00804828: hypothetical protein +FIG00804830 FIG00804831: hypothetical protein +FIG00804833 FIG00804834: hypothetical protein +FIG00804842 FIG00804843: hypothetical protein +FIG00804866 ABC-type transporter, permease component: PAAT family +FIG00804870 FIG00804871: hypothetical protein +FIG00804874 FIG00804875: hypothetical protein +FIG00804875 FIG00804876: hypothetical protein +FIG00804876 FIG00804878: hypothetical protein +FIG00804900 FIG00804901: hypothetical protein +FIG00804902 FIG00804903: hypothetical protein +FIG00804912 FIG00804914: hypothetical protein +FIG00804943 selenoprotein W-related protein +FIG00804945 FIG00804947: hypothetical protein +FIG00804947 FIG00804949: hypothetical protein +FIG00804968 FIG00804970: hypothetical protein +FIG00804971 FIG00804974: hypothetical protein +FIG00804987 polar amino acid uptake family ABC transporter, periplasmic substrate-binding protein +FIG00805002 FIG00805004: hypothetical protein +FIG00805043 FIG00805044: hypothetical protein +FIG00805044 FIG00805045: hypothetical protein +FIG00805071 FIG00805073: hypothetical protein +FIG00805600 Endonuclease relaxase +FIG00805801 Thioredoxin domain +FIG00805810 FIG00805834: hypothetical protein +FIG00805835 FIG00805846: hypothetical protein +FIG00806176 conserved protein of unknown function; putative YcgN protein +FIG00806686 FIG00806694: hypothetical protein +FIG00806867 FIG00806871: hypothetical protein +FIG00806946 Aerobic-type carbon monoxide dehydrogenase, large subunit CoxL/CutL homologs +FIG00806948 FIG00792428: hypothetical protein +FIG00808153 Cytochrome c5530 family protein +FIG00808215 FIG00808222: hypothetical protein +FIG00808222 Putative aminopeptidase ( EC:3.4.11.- ) +FIG00808248 Polysaccharide transport protein +FIG00808290 FIG00808298: hypothetical protein +FIG00808314 Predicted carbamoyl transferase, NodU family +FIG00808333 FIG00808334: hypothetical protein +FIG00808372 FIG00808377: hypothetical protein +FIG00808404 FIG00808405: hypothetical protein +FIG00808471 Site-specific recombinases, DNA invertase Pin homologs +FIG00808532 FIG00808534: hypothetical protein +FIG00808609 FIG00808610: hypothetical protein +FIG00808625 Sll0069 protein +FIG00808747 MxaJ protein +FIG00808774 FIG00808777: hypothetical protein +FIG00808777 Flagellin protein flaG +FIG00808781 FIG00808782: hypothetical protein +FIG00808788 ATP-dependent RNA helicase, superfamily II +FIG00808790 FIG00808791: hypothetical protein +FIG00808795 Negative regulator of flagellin synthesis (partial) +FIG00808812 FIG00808813: hypothetical protein +FIG00808816 Sporulation related +FIG00808831 FIG00808832: hypothetical protein +FIG00808847 MxaA protein, putative +FIG00808864 FIG00808865: hypothetical protein +FIG00808865 FIG00808867: hypothetical protein +FIG00808875 FIG00808876: hypothetical protein +FIG00808883 MxaD protein, putative +FIG00808895 FIG00808896: hypothetical protein +FIG00808896 FIG00808900: hypothetical protein +FIG00808901 FIG00808902: hypothetical protein +FIG00808908 FIG00808910: hypothetical protein +FIG00808911 delta 1-pyrroline-5-carboxylate synthetase +FIG00808917 FIG00808919: hypothetical protein +FIG00808927 FIG00808928: hypothetical protein +FIG00808934 FIG00808935: hypothetical protein +FIG00808941 FIG00808942: hypothetical protein +FIG00808942 FIG00808944: hypothetical protein +FIG00808948 WD-40 repeat +FIG00808958 FIG00808959: hypothetical protein +FIG00808962 FIG00808964: hypothetical protein +FIG00808965 Triphosphoribosyl-dephospho-CoA synthetase +FIG00808966 FIG00808967: hypothetical protein +FIG00808976 SelT/selW/selH selenoprotein +FIG00808989 FIG00808990: hypothetical protein +FIG00808991 FIG00808993: hypothetical protein +FIG00808993 DNA polymerase III chi subunit, HolC +FIG00808998 FIG00809000: hypothetical protein +FIG00809008 FIG00809009: hypothetical protein +FIG00809015 FIG00809016: hypothetical protein +FIG00809021 MxaS, protein involved in methanol oxidation +FIG00809042 Fmu (Sun) /eukaryotic nucleolar NOL1/Nop2p; tRNA and rRNA cytosine-C5-methylases +FIG00809054 FIG00809057: hypothetical protein +FIG00809071 FIG00809072: hypothetical protein +FIG00809074 prolyl-tRNA synthetase( EC:6.1.1.15 ) +FIG00809079 FIG00809080: hypothetical protein +FIG00809087 FIG00809088: hypothetical protein +FIG00809088 FIG00809089: hypothetical protein +FIG00809089 FIG00809091: hypothetical protein +FIG00809100 MxaL protein, putative +FIG00809105 FIG00809106: hypothetical protein +FIG00809108 Thermostable hemolysin delta-VPH +FIG00809109 FIG00809112: hypothetical protein +FIG00809122 Type II secretion system protein E +FIG00809136 FIG00809137: hypothetical protein +FIG00809141 FIG00809142: hypothetical protein +FIG00809149 FIG00809150: hypothetical protein +FIG00809153 putative signal transduction protein with EFhand domain +FIG00809164 FIG00809165: hypothetical protein +FIG00809177 FIG00809179: hypothetical protein +FIG00809189 FIG00809190: hypothetical protein +FIG00809198 FIG00809199: hypothetical protein +FIG00809200 FIG00809201: hypothetical protein +FIG00809207 NolW-like protein +FIG00809249 putative LysM domain protein +FIG00809255 FIG00734281: hypothetical protein +FIG00809293 putative protein of unknown function (DUF1003) +FIG00809319 FIG00809320: hypothetical protein +FIG00809321 FIG00809322: hypothetical protein +FIG00809334 phospholipase/Carboxylesterase +FIG00809383 putative membrane protein, GtrA-like family +FIG00809473 FIG00809474: hypothetical protein +FIG00809488 two-component system histidine kinase ChrS +FIG00809490 FIG00809491: hypothetical protein +FIG00809528 FIG00809529: hypothetical protein +FIG00809598 FIG00809599: hypothetical protein +FIG00809668 FIG00809670: hypothetical protein +FIG00809683 FIG00809685: hypothetical protein +FIG00809689 COG2261: Predicted membrane protein +FIG00809713 FIG00809717: hypothetical protein +FIG00809740 FIG01029358: hypothetical protein +FIG00809795 FIG00734031: hypothetical protein +FIG00809818 FIG00733452: hypothetical protein +FIG00809840 FIG00809842: hypothetical protein +FIG00809877 FIG00734064: hypothetical protein +FIG00809902 FIG00809903: hypothetical protein +FIG00809953 FIG00809955: hypothetical protein +FIG00809964 FIG00809966: hypothetical protein +FIG00809979 FIG00809980: hypothetical protein +FIG00809980 acyl-CoA dehydrogenase-like protein +FIG00809981 FIG021574: Possible membrane protein related to de Novo purine biosynthesis +FIG00810003 FIG00733332: hypothetical protein +FIG00810015 FIG00810016: hypothetical protein +FIG00810016 FIG00810017: hypothetical protein +FIG00810078 FIG00733163: hypothetical protein +FIG00810081 FIG00810082: hypothetical protein +FIG00810082 FIG01029203: hypothetical protein +FIG00810100 FIG00810102: hypothetical protein +FIG00810116 protein of unknown function DUF552 +FIG00810310 DevC protein +FIG00810357 COG5499: Predicted transcription regulator containing HTH domain +FIG00810366 Gas vesicle structural protein +FIG00810442 Bacilysin biosynthesis protein BacB +FIG00810496 Nitrogen assimilation transcriptional activator NtcB +FIG00810527 UPF0150 protein Ta0767 +FIG00810843 FIG00810851: hypothetical protein +FIG00810858 Type II restriction enzyme AvaI (EC 3.1.21.4) +FIG00811237 Transcriptional regulator AbrB +FIG00811329 HicA protein +FIG00811740 Copper-translocating P-type ATPase +FIG00811783 FIG00811825: hypothetical protein +FIG00812007 Thioredoxin-related +FIG00812557 FIG00812600: hypothetical protein +FIG00812629 HlyD family of secretion proteins +FIG00812730 signal peptidase II( EC:3.4.23.36 ) +FIG00813193 FIG00813250: hypothetical protein +FIG00813343 FIG00813375: hypothetical protein +FIG00814094 FIG00814097: hypothetical protein +FIG00814098 FIG00814099: hypothetical protein +FIG00814099 FIG00814101: hypothetical protein +FIG00814102 FIG00814105: hypothetical protein +FIG00814106 FIG00814107: hypothetical protein +FIG00814110 FIG00814111: hypothetical protein +FIG00814111 FIG00814112: hypothetical protein +FIG00814113 Phenylacetic acid degradation protein PaaN2, ring-opening aldehyde dehydrogenase (EC 1.2.1.3) +FIG00814114 FIG00814115: hypothetical protein +FIG00814115 FIG00814116: hypothetical protein +FIG00814116 FIG00814117: hypothetical protein +FIG00814120 FIG00814122: hypothetical protein +FIG00814125 FIG00814127: hypothetical protein +FIG00814127 FIG00814128: hypothetical protein +FIG00814131 Gll3326 protein +FIG00814134 FIG00814136: hypothetical protein +FIG00814139 FIG00814141: hypothetical protein +FIG00814148 FIG00814149: hypothetical protein +FIG00814149 FIG00814150: hypothetical protein +FIG00814150 FIG01043255: hypothetical protein +FIG00814158 FIG00814159: hypothetical protein +FIG00814161 FIG00814162: hypothetical protein +FIG00814165 FIG00814166: hypothetical protein +FIG00814166 ORFX +FIG00814168 dienelactone hydrolase +FIG00814170 FIG00822982: hypothetical protein +FIG00814173 FIG00814174: hypothetical protein +FIG00814174 FIG00814175: hypothetical protein +FIG00814177 FIG00814179: hypothetical protein +FIG00814179 Probable dipeptidyl peptidase IV +FIG00814182 FIG00814183: hypothetical protein +FIG00814183 flavodoxin/nitric oxide synthase +FIG00814187 Proteinase +FIG00814188 FIG00814189: hypothetical protein +FIG00814189 FIG00814190: hypothetical protein +FIG00814190 FIG00814191: hypothetical protein +FIG00814191 FIG00814192: hypothetical protein +FIG00814192 FIG00814193: hypothetical protein +FIG00814193 FIG00814194: hypothetical protein +FIG00814194 FIG00814195: hypothetical protein +FIG00814195 FIG00814198: hypothetical protein +FIG00814198 FIG00814199: hypothetical protein +FIG00814200 FIG00814201: hypothetical protein +FIG00814201 FIG00814202: hypothetical protein +FIG00814203 FIG00814204: hypothetical protein +FIG00814204 FIG00814205: hypothetical protein +FIG00814207 FIG00814208: hypothetical protein +FIG00814208 xylitol oxidase( EC:1.1.3.41 ) +FIG00814210 FIG00814211: hypothetical protein +FIG00814211 FIG00814212: hypothetical protein +FIG00814212 FIG00814213: hypothetical protein +FIG00814213 FIG00814214: hypothetical protein +FIG00814214 FIG00814216: hypothetical protein +FIG00814216 FIG00814217: hypothetical protein +FIG00814218 FIG00814219: hypothetical protein +FIG00814224 FIG00814225: hypothetical protein +FIG00814225 FIG00814227: hypothetical protein +FIG00814227 FIG00814228: hypothetical protein +FIG00814230 DNA mismatch repair protein MutS, putative +FIG00814231 FIG00814232: hypothetical protein +FIG00814232 FIG00814234: hypothetical protein +FIG00814239 FIG00814240: hypothetical protein +FIG00814240 FIG00814241: hypothetical protein +FIG00814241 FIG00814242: hypothetical protein +FIG00814245 FIG00814246: hypothetical protein +FIG00814246 FIG00814248: hypothetical protein +FIG00814248 FIG00814249: hypothetical protein +FIG00814249 FIG00814250: hypothetical protein +FIG00814252 FIG00814253: hypothetical protein +FIG00814253 FIG00814254: hypothetical protein +FIG00814255 FIG00814256: hypothetical protein +FIG00814256 FIG01042983: hypothetical protein +FIG00814261 FIG00814262: hypothetical protein +FIG00814262 FIG00814264: hypothetical protein +FIG00814264 FIG00814267: hypothetical protein +FIG00814269 membrane protein, probable +FIG00814270 FIG00814271: hypothetical protein +FIG00814271 FIG00814272: hypothetical protein +FIG00814276 FIG00814277: hypothetical protein +FIG00814277 FIG00814278: hypothetical protein +FIG00814278 FIG00814279: hypothetical protein +FIG00814283 FIG00814284: hypothetical protein +FIG00814284 FIG01043863: hypothetical protein +FIG00814285 FIG00814286: hypothetical protein +FIG00814286 FIG00814287: hypothetical protein +FIG00814287 FIG00814288: hypothetical protein +FIG00814289 FIG00814290: hypothetical protein +FIG00814290 FIG00814291: hypothetical protein +FIG00814291 FIG00814295: hypothetical protein +FIG00814295 Protein cysZ homolog +FIG00814296 ABC branched-chain amino acid transporter substrate-binding protein +FIG00814298 FIG00814299: hypothetical protein +FIG00814299 FIG00814300: hypothetical protein +FIG00814301 putative MutT/nudix-family hydrolase +FIG00814302 FIG00814303: hypothetical protein +FIG00814303 FIG00814304: hypothetical protein +FIG00814304 FIG00814305: hypothetical protein +FIG00814307 FIG00814308: hypothetical protein +FIG00814309 FIG00814311: hypothetical protein +FIG00814312 FIG00814314: hypothetical protein +FIG00814315 FIG00814316: hypothetical protein +FIG00814316 FIG00814317: hypothetical protein +FIG00814318 FIG00814319: hypothetical protein +FIG00814319 putative protease +FIG00814321 FIG00814323: hypothetical protein +FIG00814325 FIG00814326: hypothetical protein +FIG00814326 FIG00814328: hypothetical protein +FIG00814328 FIG00814329: hypothetical protein +FIG00814330 FIG00814332: hypothetical protein +FIG00814336 UPF0152 protein Rv1847/MT1895 +FIG00814337 FIG00814338: hypothetical protein +FIG00814342 FIG00814343: hypothetical protein +FIG00814343 FIG00814344: hypothetical protein +FIG00814347 FIG00814348: hypothetical protein +FIG00814348 FIG00814349: hypothetical protein +FIG00814351 FIG00814353: hypothetical protein +FIG00814353 FIG00814355: hypothetical protein +FIG00814357 FIG00814359: hypothetical protein +FIG00814359 FIG00814361: hypothetical protein +FIG00814362 thioesterase-like protein +FIG00814363 FIG00814364: hypothetical protein +FIG00814364 FIG00814365: hypothetical protein +FIG00814367 FIG00814369: hypothetical protein +FIG00814369 FIG00814370: hypothetical protein +FIG00814370 FIG00814372: hypothetical protein +FIG00814372 nitrate reductase (NADH)( EC:1.7.1.1 ) +FIG00814373 FIG00814374: hypothetical protein +FIG00814375 FIG00814377: hypothetical protein +FIG00814377 FIG00814378: hypothetical protein +FIG00814378 FIG00814379: hypothetical protein +FIG00814379 Anti-sigma factor +FIG00814380 FIG00814381: hypothetical protein +FIG00814382 FIG00814384: hypothetical protein +FIG00814384 FIG00814385: hypothetical protein +FIG00814386 FIG00814387: hypothetical protein +FIG00814388 FIG00814389: hypothetical protein +FIG00814390 FIG00814391: hypothetical protein +FIG00814394 FIG00814396: hypothetical protein +FIG00814396 putative secreted protein +FIG00814397 FIG00814398: hypothetical protein +FIG00814398 FIG00814399: hypothetical protein +FIG00814399 FIG00814401: hypothetical protein +FIG00814401 FIG00814404: hypothetical protein +FIG00814407 FIG00814408: hypothetical protein +FIG00814408 FIG00814410: hypothetical protein +FIG00814412 FIG00814413: hypothetical protein +FIG00814420 FIG00814421: hypothetical protein +FIG00814421 FIG00814422: hypothetical protein +FIG00814422 FIG00814423: hypothetical protein +FIG00814426 FIG00814427: hypothetical protein +FIG00814427 FIG00814428: hypothetical protein +FIG00814433 FIG00814435: hypothetical protein +FIG00814437 FIG00814439: hypothetical protein +FIG00814443 FIG00814445: hypothetical protein +FIG00814445 FIG00814446: hypothetical protein +FIG00814446 FIG00814447: hypothetical protein +FIG00814451 FIG00814452: hypothetical protein +FIG00814452 FIG00814453: hypothetical protein +FIG00814454 FIG00814456: hypothetical protein +FIG00814457 FIG00814458: hypothetical protein +FIG00814458 FIG00814459: hypothetical protein +FIG00814459 FIG00814460: hypothetical protein +FIG00814464 FIG00814465: hypothetical protein +FIG00814465 putative large membrane protein +FIG00814468 FIG00814469: hypothetical protein +FIG00814469 FIG00814470: hypothetical protein +FIG00814471 FIG00814472: hypothetical protein +FIG00814472 FIG00814474: hypothetical protein +FIG00814474 FIG00814475: hypothetical protein +FIG00814480 FIG00814481: hypothetical protein +FIG00814482 FIG00814483: hypothetical protein +FIG00814484 FIG00814486: hypothetical protein +FIG00814486 FIG00814487: hypothetical protein +FIG00814487 FIG00814489: hypothetical protein +FIG00814489 FIG00814490: hypothetical protein +FIG00814490 FIG00814492: hypothetical protein +FIG00814492 FIG00814493: hypothetical protein +FIG00814493 FIG00814494: hypothetical protein +FIG00814494 FIG00814495: hypothetical protein +FIG00814495 FIG00814496: hypothetical protein +FIG00814496 FIG00814497: hypothetical protein +FIG00814497 FIG00814498: hypothetical protein +FIG00814499 putative NUDIX-like hydrolase (modular protein) +FIG00814500 FIG00814502: hypothetical protein +FIG00814502 FIG00814503: hypothetical protein +FIG00814503 FIG00814504: hypothetical protein +FIG00814504 FIG00814505: hypothetical protein +FIG00814505 FIG00814506: hypothetical protein +FIG00814508 FIG00814509: hypothetical protein +FIG00814514 FIG00814515: hypothetical protein +FIG00814515 FIG00814516: hypothetical protein +FIG00814516 FIG00814517: hypothetical protein +FIG00814520 FIG00814521: hypothetical protein +FIG00814521 FIG00814522: hypothetical protein +FIG00814523 FIG00814524: hypothetical protein +FIG00814525 FIG01043361: hypothetical protein +FIG00814526 FIG00814527: hypothetical protein +FIG00814527 FIG00814529: hypothetical protein +FIG00814530 FIG00814531: hypothetical protein +FIG00814531 FIG00814533: hypothetical protein +FIG00814533 FIG00814534: hypothetical protein +FIG00814535 FIG00814538: hypothetical protein +FIG00814538 FIG00814540: hypothetical protein +FIG00814540 FIG00814542: hypothetical protein +FIG00814542 FIG00994049: hypothetical protein +FIG00814544 FIG00814545: hypothetical protein +FIG00814545 FIG00814546: hypothetical protein +FIG00814547 FIG01044031: hypothetical protein +FIG00814548 FIG00814549: hypothetical protein +FIG00814552 FIG00814553: hypothetical protein +FIG00814553 FIG00814554: hypothetical protein +FIG00814555 FIG00814558: hypothetical protein +FIG00814558 FIG00814559: hypothetical protein +FIG00814569 FIG00814570: hypothetical protein +FIG00814572 FIG00814574: hypothetical protein +FIG00814574 FIG00814575: hypothetical protein +FIG00814578 FIG01134417: hypothetical protein +FIG00814579 FIG00814580: hypothetical protein +FIG00814581 MutT-like domain protein +FIG00814584 FIG00814586: hypothetical protein +FIG00814586 FIG00814587: hypothetical protein +FIG00814590 FIG00814592: hypothetical protein +FIG00814594 Phosphatase (partial)( EC:3.1.3.18 ) +FIG00814597 FIG00814600: hypothetical protein +FIG00814600 FIG00814602: hypothetical protein +FIG00814602 Serine/threonine-protein kinase RIO2 (EC 2.7.11.1) +FIG00814604 FIG00814606: hypothetical protein +FIG00814613 FIG00814615: hypothetical protein +FIG00814615 ORF encoded in ISPre3 +FIG00814616 FIG01042417: hypothetical protein +FIG00814618 FIG00814619: hypothetical protein +FIG00814620 FIG00814621: hypothetical protein +FIG00814623 FIG00814624: hypothetical protein +FIG00814625 ABC-2 +FIG00814627 FIG00814628: hypothetical protein +FIG00814628 FIG00814629: hypothetical protein +FIG00814633 FIG00814634: hypothetical protein +FIG00814634 FIG00814635: hypothetical protein +FIG00814635 spread protein +FIG00814637 FIG00814639: hypothetical protein +FIG00814639 ANTAR domain protein +FIG00814644 FIG00814645: hypothetical protein +FIG00814646 FIG00814647: hypothetical protein +FIG00814647 FIG00814648: hypothetical protein +FIG00814649 FIG00814651: hypothetical protein +FIG00814651 FIG00814652: hypothetical protein +FIG00814652 FIG00814653: hypothetical protein +FIG00814658 FIG00814659: hypothetical protein +FIG00814660 FIG00814661: hypothetical protein +FIG00814661 FIG00814663: hypothetical protein +FIG00814668 FIG00814669: hypothetical protein +FIG00814670 FIG00814671: hypothetical protein +FIG00814671 FIG00814672: hypothetical protein +FIG00814675 FIG00814676: hypothetical protein +FIG00814676 FIG00814677: hypothetical protein +FIG00814677 FIG00814678: hypothetical protein +FIG00814678 FIG00814679: hypothetical protein +FIG00814679 FIG00814680: hypothetical protein +FIG00814680 FIG00814681: hypothetical protein +FIG00814685 Putative ATP/GTP-binding protein, doubtful CDS +FIG00814687 FIG00814688: hypothetical protein +FIG00814690 FIG00814691: hypothetical protein +FIG00814691 FIG00814692: hypothetical protein +FIG00814692 putative serine protease +FIG00814695 FIG00814697: hypothetical protein +FIG00814699 FIG00814700: hypothetical protein +FIG00814703 FIG01310822: Short chain dehydrogenase +FIG00814709 FIG00814710: hypothetical protein +FIG00814710 FIG00814711: hypothetical protein +FIG00814711 FIG00814712: hypothetical protein +FIG00814713 FIG00814714: hypothetical protein +FIG00814714 FIG00814715: hypothetical protein +FIG00814715 FIG00814716: hypothetical protein +FIG00814716 FIG00814717: hypothetical protein +FIG00814717 Rhodanese domain protein / Ankyrin +FIG00814721 FIG00814722: hypothetical protein +FIG00814722 FIG00814723: hypothetical protein +FIG00814723 FIG00814724: hypothetical protein +FIG00814727 3-ketoacyl-(acyl-carrier-protein) reductase( EC:1.1.1.100 ) +FIG00814731 Vng1025h +FIG00814738 FIG00814739: hypothetical protein +FIG00814739 FIG00814740: hypothetical protein +FIG00814740 FIG00814741: hypothetical protein +FIG00814741 Chain E, Pro 18 Variant Of Turkey Ovomucoid Inhibitor Third Domain Complexed With Streptomyces Griseus Proteinase B At Ph 6.5 +FIG00814743 FIG00814744: hypothetical protein +FIG00814749 FIG00814751: hypothetical protein +FIG00814755 FIG00814756: hypothetical protein +FIG00814760 FIG00814761: hypothetical protein +FIG00814764 FIG00814765: hypothetical protein +FIG00814765 calcineurin-like phosphoesterase family protein +FIG00814768 FIG00814769: hypothetical protein +FIG00814770 FIG00814772: hypothetical protein +FIG00814774 FIG00814777: hypothetical protein +FIG00814777 FIG00814779: hypothetical protein +FIG00814780 FIG00814781: hypothetical protein +FIG00814781 FIG00814785: hypothetical protein +FIG00814786 Esterase/lipase/thioesterase family active site +FIG00814791 FIG00814793: hypothetical protein +FIG00814793 FIG00814794: hypothetical protein +FIG00814795 UPF0353 protein Mb1517 +FIG00814796 COGs COG2030 +FIG00814798 FIG00814800: hypothetical protein +FIG00814805 FIG00814808: hypothetical protein +FIG00814808 FIG00814809: hypothetical protein +FIG00814809 glucose 1-dehydrogenase +FIG00814812 FIG00814814: hypothetical protein +FIG00814814 FIG00814815: hypothetical protein +FIG00814817 FIG00814818: hypothetical protein +FIG00814818 FIG00814820: hypothetical protein +FIG00814820 FIG00814821: hypothetical protein +FIG00814821 FIG00814822: hypothetical protein +FIG00814822 FIG00814823: hypothetical protein +FIG00814823 FIG00814824: hypothetical protein +FIG00814826 FIG00814827: hypothetical protein +FIG00814827 FIG00814828: hypothetical protein +FIG00814828 FIG00814829: hypothetical protein +FIG00814829 FIG00814831: hypothetical protein +FIG00814831 FIG00814832: hypothetical protein +FIG00814832 FIG00814834: hypothetical protein +FIG00814834 FIG00814835: hypothetical protein +FIG00814835 FIG00814836: hypothetical protein +FIG00814836 FIG00814837: hypothetical protein +FIG00814839 FIG00814842: hypothetical protein +FIG00814842 FIG00814844: hypothetical protein +FIG00814846 FIG00814847: hypothetical protein +FIG00814847 Pyridoxamine 5'-phosphate oxidase +FIG00814848 FIG00814849: hypothetical protein +FIG00814849 FIG00814850: hypothetical protein +FIG00814850 Hypothetical protein, possibly related to signal transduction +FIG00814851 FIG00814852: hypothetical protein +FIG00814852 FIG00814853: hypothetical protein +FIG00814853 FIG00814855: hypothetical protein +FIG00814857 FIG00814858: hypothetical protein +FIG00814859 FIG00814860: hypothetical protein +FIG00814860 FIG00814862: hypothetical protein +FIG00814862 FIG00814863: hypothetical protein +FIG00814863 FIG00814864: hypothetical protein +FIG00814864 FIG00814868: hypothetical protein +FIG00814868 FIG00814869: hypothetical protein +FIG00814872 Mpt53 +FIG00814874 FIG00814876: hypothetical protein +FIG00814876 FIG00814877: hypothetical protein +FIG00814877 FIG00814878: hypothetical protein +FIG00814878 FIG00814879: hypothetical protein +FIG00814889 FIG00814890: hypothetical protein +FIG00814890 FIG00814891: hypothetical protein +FIG00814895 FIG00814896: hypothetical protein +FIG00814896 FIG00814898: hypothetical protein +FIG00814898 FIG00814899: hypothetical protein +FIG00814900 FIG00814901: hypothetical protein +FIG00814906 FIG00814907: hypothetical protein +FIG00814907 FIG00814908: hypothetical protein +FIG00814910 FIG00814912: hypothetical protein +FIG00814915 FIG00814916: hypothetical protein +FIG00814920 FIG00814922: hypothetical protein +FIG00814922 FIG00814923: hypothetical protein +FIG00814923 FIG00814924: hypothetical protein +FIG00814925 ABC-type polar amino acid transport system ATPase component +FIG00814926 FIG00814927: hypothetical protein +FIG00814927 multiple sugar ABC transport permease protein +FIG00814929 FIG00814930: hypothetical protein +FIG00814930 Uncharacterized 17.2 kDa protein in melC2-rnhH intergenic region (ORF3) +FIG00814934 FIG00814935: hypothetical protein +FIG00814935 FIG00814936: hypothetical protein +FIG00814936 FIG00814940: hypothetical protein +FIG00814940 glycoside hydrolase, family 26 +FIG00814941 FIG00814942: hypothetical protein +FIG00814943 FIG00814944: hypothetical protein +FIG00814944 FIG00814945: hypothetical protein +FIG00814946 FIG00814947: hypothetical protein +FIG00814949 FIG00814951: hypothetical protein +FIG00814957 FIG00814959: hypothetical protein +FIG00814960 FIG00814961: hypothetical protein +FIG00814961 FIG00814963: hypothetical protein +FIG00814963 FIG00814964: hypothetical protein +FIG00814964 FIG00814965: hypothetical protein +FIG00814965 FIG00814966: hypothetical protein +FIG00814966 FIG00814969: hypothetical protein +FIG00814971 FIG00814973: hypothetical protein +FIG00814973 FIG00814974: hypothetical protein +FIG00814974 FIG00814975: hypothetical protein +FIG00814975 FIG00814977: hypothetical protein +FIG00814977 FIG00814978: hypothetical protein +FIG00814980 FIG00814981: hypothetical protein +FIG00814983 Phosphodiesterase +FIG00814985 FIG00814986: hypothetical protein +FIG00814986 FIG00814987: hypothetical protein +FIG00814988 FIG00814989: hypothetical protein +FIG00814989 FIG00814990: hypothetical protein +FIG00814991 branched-chain amino acid ABC transporter permease protein +FIG00814996 FIG00814997: hypothetical protein +FIG00814998 FIG00814999: hypothetical protein +FIG00815001 FIG00815002: hypothetical protein +FIG00815005 FIG00815006: hypothetical protein +FIG00815006 FIG00815010: hypothetical protein +FIG00815011 FIG00815012: hypothetical protein +FIG00815012 FIG00815013: hypothetical protein +FIG00815015 FIG00815016: hypothetical protein +FIG00815019 Phospholipid/glycerol acyltransferase +FIG00815022 FIG00815025: hypothetical protein +FIG00815025 FIG00815026: hypothetical protein +FIG00815027 FIG01043364: hypothetical protein +FIG00815030 FIG00815031: hypothetical protein +FIG00815031 Phage shock protein A (IM30) , suppresses sigma54-dependent transcription +FIG00815033 FIG00815034: hypothetical protein +FIG00815034 FIG00815037: hypothetical protein +FIG00815037 FIG00815038: hypothetical protein +FIG00815038 FIG00815040: hypothetical protein +FIG00815040 secreted glycosyl hydrolase +FIG00815041 FIG00815042: hypothetical protein +FIG00815042 FIG00815043: hypothetical protein +FIG00815043 Myeloperoxidase, thyroid peroxidase, cyclooxygenase catalytic domain +FIG00815044 FIG00815047: hypothetical protein +FIG00815047 FIG00815048: hypothetical protein +FIG00815048 FIG00815050: hypothetical protein +FIG00815050 protein of unknown function DUF909 +FIG00815051 FIG00815052: hypothetical protein +FIG00815052 FIG00815053: hypothetical protein +FIG00815053 Alanine--glyoxylate aminotransferase 2 homolog 3, mitochondrial precursor (EC 2.6.1.44) (Beta-alanine-pyruvate aminotransferase 3) +FIG00815057 FIG00815058: hypothetical protein +FIG00815058 FIG00815061: hypothetical protein +FIG00815062 FIG00815063: hypothetical protein +FIG00815063 FIG00815064: hypothetical protein +FIG00815064 ATP-binding transport protein NatA +FIG00815066 FIG00815067: hypothetical protein +FIG00815067 FIG00815068: hypothetical protein +FIG00815073 sodium/hydrogen exchanger +FIG00815075 FIG00815077: hypothetical protein +FIG00815077 FIG00815079: hypothetical protein +FIG00815079 FIG00815081: hypothetical protein +FIG00815081 FIG00815083: hypothetical protein +FIG00815083 Chorismate mutase +FIG00815087 FIG00815089: hypothetical protein +FIG00815090 FIG00815091: hypothetical protein +FIG00815091 Potassium channel beta chain +FIG00815093 FIG00815094: hypothetical protein +FIG00815094 FIG00815096: hypothetical protein +FIG00815096 FIG00815097: hypothetical protein +FIG00815097 FIG00815098: hypothetical protein +FIG00815108 probable sulfite oxidase +FIG00815109 Putative glycosyl transferase (partial match)( EC:2.4.- ) +FIG00815111 FIG00815115: hypothetical protein +FIG00815115 FIG00815116: hypothetical protein +FIG00815116 FIG00815117: hypothetical protein +FIG00815117 FIG00815118: hypothetical protein +FIG00815118 FIG00815119: hypothetical protein +FIG00815119 FIG00815120: hypothetical protein +FIG00815120 FIG00815121: hypothetical protein +FIG00815121 FIG00815122: hypothetical protein +FIG00815122 FIG00815123: hypothetical protein +FIG00815123 FIG00815126: hypothetical protein +FIG00815129 FIG00815131: hypothetical protein +FIG00815131 FIG00815132: hypothetical protein +FIG00815132 FIG00815133: hypothetical protein +FIG00815135 FIG00815136: hypothetical protein +FIG00815136 FIG00815137: hypothetical protein +FIG00815140 FIG00815142: hypothetical protein +FIG00815143 FIG00815145: hypothetical protein +FIG00815145 FIG00815148: hypothetical protein +FIG00815148 FIG00815149: hypothetical protein +FIG00815149 FIG00815152: hypothetical protein +FIG00815152 FIG00815154: hypothetical protein +FIG00815154 FIG00815155: hypothetical protein +FIG00815155 FIG00815156: hypothetical protein +FIG00815157 FIG00815158: hypothetical protein +FIG00815161 FIG00815163: hypothetical protein +FIG00815165 FIG00815167: hypothetical protein +FIG00815169 FIG00815172: hypothetical protein +FIG00815172 FIG00815173: hypothetical protein +FIG00815175 FIG00815176: hypothetical protein +FIG00815178 ABC-transporter ATP binding protein +FIG00815181 FIG00815184: hypothetical protein +FIG00815184 FIG00815185: hypothetical protein +FIG00815185 FIG00815188: hypothetical protein +FIG00815189 FIG01043482: hypothetical protein +FIG00815191 FIG00815193: hypothetical protein +FIG00815194 FIG00815195: hypothetical protein +FIG00815196 FIG00815197: hypothetical protein +FIG00815199 FIG00815200: hypothetical protein +FIG00815200 FIG00815203: hypothetical protein +FIG00815203 FIG215594: Membrane spanning protein +FIG00815205 FIG00815206: hypothetical protein +FIG00815212 FIG00815213: hypothetical protein +FIG00815213 FIG00815214: hypothetical protein +FIG00815214 FIG00815216: hypothetical protein +FIG00815223 diguanylate cyclase/phosphodiesterase +FIG00815224 FIG00815225: hypothetical protein +FIG00815225 FIG00815226: hypothetical protein +FIG00815227 putative hydrolase/acyltransferase +FIG00815228 FIG00815229: hypothetical protein +FIG00815229 FIG00815230: hypothetical protein +FIG00815230 FIG00815231: hypothetical protein +FIG00815231 Protein of unknown function DUF661 +FIG00815233 FIG00815236: hypothetical protein +FIG00815236 putative PASTA domain protein +FIG00815237 FIG00815238: hypothetical protein +FIG00815238 FIG00815239: hypothetical protein +FIG00815241 FIG00815242: hypothetical protein +FIG00815242 FIG00815244: hypothetical protein +FIG00815244 FIG00815246: hypothetical protein +FIG00815246 FIG00815247: hypothetical protein +FIG00815249 FIG00815251: hypothetical protein +FIG00815252 peptidase M36, fungalysin +FIG00815253 FIG00815254: hypothetical protein +FIG00815255 Enoyl-CoA hydratase (EC 4.2.1.17) +FIG00815258 FIG00815260: hypothetical protein +FIG00815260 NADPH-dependent F420 reductase +FIG00815261 FIG00815262: hypothetical protein +FIG00815262 FIG00815263: hypothetical protein +FIG00815264 FIG00815265: hypothetical protein +FIG00815270 FIG00815271: hypothetical protein +FIG00815278 FIG00815279: hypothetical protein +FIG00815279 FIG00815280: hypothetical protein +FIG00815280 FIG00815282: hypothetical protein +FIG00815284 FIG00815285: hypothetical protein +FIG00815285 FIG00815286: hypothetical protein +FIG00815286 FIG00815287: hypothetical protein +FIG00815289 FIG00815290: hypothetical protein +FIG00815292 FIG00815293: hypothetical protein +FIG00815294 FIG00815295: hypothetical protein +FIG00815295 FIG00815296: hypothetical protein +FIG00815297 FIG00815299: hypothetical protein +FIG00815302 putative secreted solute binding protein +FIG00815305 FIG00815306: hypothetical protein +FIG00815306 FIG01043831: hypothetical protein +FIG00815307 FIG00815308: hypothetical protein +FIG00815308 FIG00815309: hypothetical protein +FIG00815309 FIG00815310: hypothetical protein +FIG00815310 FIG00815311: hypothetical protein +FIG00815312 putative Aminoglycoside adenylyltransferase +FIG00815315 FIG00815316: hypothetical protein +FIG00815316 AsnC-family transcriptional regulator SCO4493, in menaquinone synthesis cluster +FIG00815317 FIG00815318: hypothetical protein +FIG00815318 FIG01044559: hypothetical protein +FIG00815325 FIG00815326: hypothetical protein +FIG00815326 FIG00815327: hypothetical protein +FIG00815327 Lipase LipA precursor +FIG00815331 putative keto acyl reductase( EC:1.1.1.- ) +FIG00815332 FIG00815333: hypothetical protein +FIG00815334 FIG00815335: hypothetical protein +FIG00815336 FIG00815337: hypothetical protein +FIG00815337 alginate biosynthesis regulatory protein AlgR (lytT) +FIG00815338 FIG00815339: hypothetical protein +FIG00815339 FIG00815342: hypothetical protein +FIG00815343 FIG00815344: hypothetical protein +FIG00815346 FIG00815347: hypothetical protein +FIG00815347 FIG00815348: hypothetical protein +FIG00815350 FIG00815352: hypothetical protein +FIG00815354 FIG00815355: hypothetical protein +FIG00815356 FIG00815357: hypothetical protein +FIG00815359 FIG00815361: hypothetical protein +FIG00815362 FIG00815365: hypothetical protein +FIG00815368 FIG00815370: hypothetical protein +FIG00815370 FIG00815371: hypothetical protein +FIG00815372 L-proline glycine betaine binding ABC transporter protein proX (TC 3.A.1.12.1) +FIG00815379 ABC-type branched-chain amino acid transport systems ATPase component +FIG00815380 FIG00815381: hypothetical protein +FIG00815381 FIG00815382: hypothetical protein +FIG00815382 FIG00815383: hypothetical protein +FIG00815383 FIG00815388: hypothetical protein +FIG00815388 FIG00815389: hypothetical protein +FIG00815390 probable sugar ABC transporter, substrate-binding protein +FIG00815391 FIG00815392: hypothetical protein +FIG00815392 FIG00815393: hypothetical protein +FIG00815395 FIG00815396: hypothetical protein +FIG00815406 FIG00815408: hypothetical protein +FIG00815414 FIG00815415: hypothetical protein +FIG00815415 FIG00815417: hypothetical protein +FIG00815420 FIG00815421: hypothetical protein +FIG00815421 FIG00815422: hypothetical protein +FIG00815422 SGNH hydrolase family +FIG00815423 Dbv30 protein +FIG00815427 FIG00815429: hypothetical protein +FIG00815429 FIG00815433: hypothetical protein +FIG00815434 FIG00815435: hypothetical protein +FIG00815438 FIG00815440: hypothetical protein +FIG00815440 FIG00815442: hypothetical protein +FIG00815442 FIG00815443: hypothetical protein +FIG00815445 FIG00815446: hypothetical protein +FIG00815446 FIG01044228: hypothetical protein +FIG00815447 FIG00815449: hypothetical protein +FIG00815449 FIG00815450: hypothetical protein +FIG00815452 FIG00815453: hypothetical protein +FIG00815453 FIG00815455: hypothetical protein +FIG00815460 FIG00815464: hypothetical protein +FIG00815464 FIG01044457: hypothetical protein +FIG00815468 multi-component regulatory system-6 +FIG00815477 FIG00815481: hypothetical protein +FIG00815481 FIG00815482: hypothetical protein +FIG00815483 FIG00815485: hypothetical protein +FIG00815496 Mlr4229 protein +FIG00815498 FIG00815499: hypothetical protein +FIG00815500 putative MFS permease +FIG00815512 FIG00815515: hypothetical protein +FIG00815515 FIG00815516: hypothetical protein +FIG00815517 FIG00815518: hypothetical protein +FIG00815518 putative NADH dehydrogenase / NAD(P)H nitroreductase( EC:1.- ) +FIG00815523 FIG00815524: hypothetical protein +FIG00815529 FIG00815530: hypothetical protein +FIG00815530 FIG00815531: hypothetical protein +FIG00815531 FIG00815532: hypothetical protein +FIG00815533 FIG00815534: hypothetical protein +FIG00815536 FIG00815537: hypothetical protein +FIG00815539 FIG00815540: hypothetical protein +FIG00815543 FIG00815545: hypothetical protein +FIG00815548 FIG00815549: hypothetical protein +FIG00815549 FIG00815550: hypothetical protein +FIG00815550 FIG00815552: hypothetical protein +FIG00815552 FIG00815553: hypothetical protein +FIG00815559 FIG00815564: hypothetical protein +FIG00815564 FIG00815565: hypothetical protein +FIG00815568 FIG00815569: hypothetical protein +FIG00815574 FIG00815578: hypothetical protein +FIG00815578 FIG00815579: hypothetical protein +FIG00815582 FIG00815583: hypothetical protein +FIG00815584 FIG00815585: hypothetical protein +FIG00815586 FIG00815587: hypothetical protein +FIG00815587 FIG00815589: hypothetical protein +FIG00815589 FIG00815590: hypothetical protein +FIG00815591 FIG00815593: hypothetical protein +FIG00815593 FIG00815594: hypothetical protein +FIG00815594 FIG00815595: hypothetical protein +FIG00815595 FIG00815597: hypothetical protein +FIG00815598 FIG00815600: hypothetical protein +FIG00815602 FIG00815604: hypothetical protein +FIG00815604 FIG00815605: hypothetical protein +FIG00815605 FIG00815606: hypothetical protein +FIG00815612 FIG00815614: hypothetical protein +FIG00815615 FIG00815616: hypothetical protein +FIG00815617 FIG00815619: hypothetical protein +FIG00815620 Protein of unknown function DUF1206 +FIG00815628 FIG00815629: hypothetical protein +FIG00815633 FIG00815634: hypothetical protein +FIG00815634 FIG00815635: hypothetical protein +FIG00815635 FIG00815636: hypothetical protein +FIG00815636 FIG00815637: hypothetical protein +FIG00815637 FIG00815640: hypothetical protein +FIG00815640 FIG00815643: hypothetical protein +FIG00815643 FIG00815644: hypothetical protein +FIG00815644 FIG00815647: hypothetical protein +FIG00815647 RecB family exonuclease +FIG00815648 glutamate receptor, ionotropic, N-methyl D-asparate-associated protein 1 (glutamate binding) +FIG00815649 FIG00815650: hypothetical protein +FIG00815650 FIG00815652: hypothetical protein +FIG00815652 FIG00815653: hypothetical protein +FIG00815653 FIG00815655: hypothetical protein +FIG00815657 protein of unknown function DUF664 +FIG00815658 FIG00815659: hypothetical protein +FIG00815659 FIG00815660: hypothetical protein +FIG00815660 FIG00815661: hypothetical protein +FIG00815661 UPF0145 protein TV0671 +FIG00815662 FIG00815666: hypothetical protein +FIG00815669 FIG00815671: hypothetical protein +FIG00815671 FIG00815672: hypothetical protein +FIG00815672 FIG00815673: hypothetical protein +FIG00815673 FIG00815674: hypothetical protein +FIG00815674 FIG00815675: hypothetical protein +FIG00815675 FIG00815680: hypothetical protein +FIG00815682 FIG00815683: hypothetical protein +FIG00815683 ABC sugar transporter, permease component +FIG00815685 FIG00815686: hypothetical protein +FIG00815686 FIG00815691: hypothetical protein +FIG00815692 FIG00815694: hypothetical protein +FIG00815694 FIG00815695: hypothetical protein +FIG00815697 Uncharacterized protein Mb1452 +FIG00815699 FIG00815701: hypothetical protein +FIG00815701 FIG00815702: hypothetical protein +FIG00815702 FIG00815704: hypothetical protein +FIG00815705 FIG00815706: hypothetical protein +FIG00815709 FIG00815711: hypothetical protein +FIG00815711 FIG00815712: hypothetical protein +FIG00815712 Conserved protein, DUF885 +FIG00815714 Large Ala/Glu-rich protein +FIG00815719 FIG00815720: hypothetical protein +FIG00815722 Hypthetical protein +FIG00815729 FIG00815731: hypothetical protein +FIG00815731 Secreted subtilisin-like protease +FIG00815733 thymidylate kinase +FIG00815734 FIG00815736: hypothetical protein +FIG00815736 FIG00815737: hypothetical protein +FIG00815737 Serine protease 2 (EC 3.4.21.-) (SFase-2) +FIG00815740 FIG00815741: hypothetical protein +FIG00815742 FIG00815743: hypothetical protein +FIG00815743 FIG00815744: hypothetical protein +FIG00815744 FIG00815745: hypothetical protein +FIG00815747 probable transferase +FIG00815749 FIG00822893: hypothetical protein +FIG00815751 FIG00815752: hypothetical protein +FIG00815752 FIG00815753: hypothetical protein +FIG00815753 FIG00815754: hypothetical protein +FIG00815754 FIG00815755: hypothetical protein +FIG00815755 FIG00815757: hypothetical protein +FIG00815758 FIG00815760: hypothetical protein +FIG00815760 FIG00815762: hypothetical protein +FIG00815762 FIG00815763: hypothetical protein +FIG00815763 FIG00815767: hypothetical protein +FIG00815767 FIG00815768: hypothetical protein +FIG00815771 FIG00815772: hypothetical protein +FIG00815773 FIG00815774: hypothetical protein +FIG00815774 FIG00815775: hypothetical protein +FIG00815775 FIG00815776: hypothetical protein +FIG00815776 Nodulation protein noeA +FIG00815777 FIG00815779: hypothetical protein +FIG00815779 FIG00815781: hypothetical protein +FIG00815781 FIG00815783: hypothetical protein +FIG00815783 FIG00815784: hypothetical protein +FIG00815784 Uncharacterized protein Mb0922c +FIG00815787 AknD +FIG00815791 UPF0276 protein SCO6045 +FIG00815792 FIG00815793: hypothetical protein +FIG00815794 FIG00815795: hypothetical protein +FIG00815796 FIG00815799: hypothetical protein +FIG00815802 Sporulation control protein Spo0M +FIG00815805 FIG00815806: hypothetical protein +FIG00815806 FIG00815807: hypothetical protein +FIG00815808 FIG00815809: hypothetical protein +FIG00815809 FIG00815810: hypothetical protein +FIG00815811 FIG00815812: hypothetical protein +FIG00815812 FIG00815814: hypothetical protein +FIG00815814 FIG00815815: hypothetical protein +FIG00815818 FIG00815819: hypothetical protein +FIG00815820 FIG00815822: hypothetical protein +FIG00815822 FIG00815823: hypothetical protein +FIG00815824 FIG00815825: hypothetical protein +FIG00815825 FIG00815826: hypothetical protein +FIG00815826 FIG00815827: hypothetical protein +FIG00815827 FIG00815828: hypothetical protein +FIG00815828 PROBABLE CONSERVED TRANSMEMBRANE ALANINE AND LEUCINE RICH PROTEIN +FIG00815829 FIG00815830: hypothetical protein +FIG00815832 CDP-tyvelose epimerase (EC 5.1.3.-) (EC 4.2.1.46) +FIG00815833 FUPA24 P-type ATPase +FIG00815835 FIG00815837: hypothetical protein +FIG00815839 FIG00815840: hypothetical protein +FIG00815844 FIG00815847: hypothetical protein +FIG00815847 FIG00815848: hypothetical protein +FIG00815848 FIG00815849: hypothetical protein +FIG00815849 Pyridoxal-dependent decarboxylase +FIG00815853 FIG00815855: hypothetical protein +FIG00815855 FIG00815856: hypothetical protein +FIG00815856 FIG00815858: hypothetical protein +FIG00815858 FIG00815860: hypothetical protein +FIG00815861 FIG00815865: hypothetical protein +FIG00815865 FIG00815866: hypothetical protein +FIG00815868 magnesium or manganese-dependent protein phosphatase +FIG00815874 FIG00815875: hypothetical protein +FIG00815875 FIG00815876: hypothetical protein +FIG00815876 FIG00815877: hypothetical protein +FIG00815880 FIG00815881: hypothetical protein +FIG00815883 hypothetical protein +FIG00815890 FIG00815892: hypothetical protein +FIG00815892 FIG00815893: hypothetical protein +FIG00815893 FIG00815894: hypothetical protein +FIG00815895 FIG00815898: hypothetical protein +FIG00815898 FIG00815899: hypothetical protein +FIG00815902 FIG00815905: hypothetical protein +FIG00815905 FIG00815906: hypothetical protein +FIG00815906 FIG00815907: hypothetical protein +FIG00815907 FIG00815909: hypothetical protein +FIG00815909 FIG00815910: hypothetical protein +FIG00815910 FIG00815911: hypothetical protein +FIG00815911 FIG00815914: hypothetical protein +FIG00815914 FIG00815916: hypothetical protein +FIG00815916 FIG01043075: hypothetical protein +FIG00815917 FIG00864038: hypothetical protein +FIG00815918 alpha-glucuronidase( EC:3.2.1.139 ) +FIG00815921 Possible regulatory protein +FIG00815922 FIG00815923: hypothetical protein +FIG00815924 FIG00815925: hypothetical protein +FIG00815927 FIG00815928: hypothetical protein +FIG00815929 FIG00815930: hypothetical protein +FIG00815930 FIG00815931: hypothetical protein +FIG00815931 FIG00815932: hypothetical protein +FIG00815932 FIG00815933: hypothetical protein +FIG00815935 probable nikkomycin biosynthesis protein, carboxylase +FIG00815937 FIG00815939: hypothetical protein +FIG00815940 FIG00815941: hypothetical protein +FIG00815941 FIG00815944: hypothetical protein +FIG00815945 FIG00815946: hypothetical protein +FIG00815946 FIG00815949: hypothetical protein +FIG00815949 FIG00815950: hypothetical protein +FIG00815952 FIG00815953: hypothetical protein +FIG00815954 FIG00815957: hypothetical protein +FIG00815960 FIG00815961: hypothetical protein +FIG00815961 FIG00815963: hypothetical protein +FIG00815963 FIG00815964: hypothetical protein +FIG00815964 FIG00815966: hypothetical protein +FIG00815966 FIG00815967: hypothetical protein +FIG00815967 FIG00815968: hypothetical protein +FIG00815968 FIG00815969: hypothetical protein +FIG00815969 FIG00815971: hypothetical protein +FIG00815972 FIG00815973: hypothetical protein +FIG00815978 FIG00815979: hypothetical protein +FIG00815979 FIG00815980: hypothetical protein +FIG00815980 FIG00815981: hypothetical protein +FIG00815981 FIG00815982: hypothetical protein +FIG00815983 FIG00815984: hypothetical protein +FIG00815988 FIG00815990: hypothetical protein +FIG00815991 FIG00815993: hypothetical protein +FIG00815993 FIG00815994: hypothetical protein +FIG00815994 FIG00815995: hypothetical protein +FIG00815995 Uncharacterized protein PA2301 +FIG00815996 Geranylgeranyl/isoprenyl reductase +FIG00815997 FIG00815998: hypothetical protein +FIG00815999 FIG00816000: hypothetical protein +FIG00816006 FIG00816008: hypothetical protein +FIG00816009 FIG00816010: hypothetical protein +FIG00816012 FIG00816014: hypothetical protein +FIG00816015 FIG00816016: hypothetical protein +FIG00816016 FIG00816017: hypothetical protein +FIG00816019 FIG00816020: hypothetical protein +FIG00816020 FIG00816021: hypothetical protein +FIG00816024 IdsA +FIG00816025 FIG00816028: hypothetical protein +FIG00816029 FIG00816030: hypothetical protein +FIG00816034 FIG00816036: hypothetical protein +FIG00816036 Daunorubicin resistance ATP-binding protein DrrA +FIG00816037 FIG00816038: hypothetical protein +FIG00816038 Glycosyltransferase 28, C-terminal domain +FIG00816039 Aminopeptidase YpdF (MP-, MA-, MS-, AP-, NP- specific) +FIG00816040 FIG00816041: hypothetical protein +FIG00816042 FIG00816043: hypothetical protein +FIG00816045 FIG00816046: hypothetical protein +FIG00816046 FIG00816048: hypothetical protein +FIG00816048 FIG00816049: hypothetical protein +FIG00816049 FIG00816050: hypothetical protein +FIG00816050 FIG00816051: hypothetical protein +FIG00816051 FIG00816052: hypothetical protein +FIG00816052 FIG00816053: hypothetical protein +FIG00816053 FIG00816056: hypothetical protein +FIG00816056 FIG00816058: hypothetical protein +FIG00816058 FIG00816059: hypothetical protein +FIG00816059 Terpene synthase, metal-binding +FIG00816060 FIG00816061: hypothetical protein +FIG00816070 FIG00816071: hypothetical protein +FIG00816071 FIG00816072: hypothetical protein +FIG00816072 FIG00816073: hypothetical protein +FIG00816073 FIG00816075: hypothetical protein +FIG00816075 FIG00816076: hypothetical protein +FIG00816079 FIG00816080: hypothetical protein +FIG00816080 FIG00816081: hypothetical protein +FIG00816081 FIG00816082: hypothetical protein +FIG00816082 FIG00816083: hypothetical protein +FIG00816084 FIG00816086: hypothetical protein +FIG00816090 ATPase associated with various cellular activities, AAA_3 +FIG00816091 Probable two-component system transcriptional regulator +FIG00816093 FIG00816094: hypothetical protein +FIG00816094 FIG00816095: hypothetical protein +FIG00816099 FIG01043030: hypothetical protein +FIG00816100 FIG00816102: hypothetical protein +FIG00816104 Redoxin +FIG00816105 FIG00816106: hypothetical protein +FIG00816107 FIG00816108: hypothetical protein +FIG00816108 FIG00816110: hypothetical protein +FIG00816110 FIG00816111: hypothetical protein +FIG00816112 FIG00816113: hypothetical protein +FIG00816113 FIG00816114: hypothetical protein +FIG00816114 FIG00816115: hypothetical protein +FIG00816117 FIG00816119: hypothetical protein +FIG00816119 SpoOM family protein +FIG00816121 FIG00816124: hypothetical protein +FIG00816124 FIG00816125: hypothetical protein +FIG00816125 putative deacetylase sulfotransferase +FIG00816126 probable redoxin +FIG00816130 FIG00816132: hypothetical protein +FIG00816136 FIG00816137: hypothetical protein +FIG00816138 FIG00816139: hypothetical protein +FIG00816141 FIG00816143: hypothetical protein +FIG00816143 FIG00816144: hypothetical protein +FIG00816144 FIG00816145: hypothetical protein +FIG00816145 FIG00816146: hypothetical protein +FIG00816149 FIG00816150: hypothetical protein +FIG00816151 FIG00816152: hypothetical protein +FIG00816155 putative oligopeptide ABC transporter, substrate-binding lipoprotein +FIG00816156 FIG00816158: hypothetical protein +FIG00816158 FK506-binding protein (Peptidyl-prolyl cis-trans isomerase) (PPIase) (EC 5.2.1.8) (Rotamase) +FIG00816160 cytochrome c biogenesis protein, transmembrane region +FIG00816161 FIG00816162: hypothetical protein +FIG00816167 FIG00816168: hypothetical protein +FIG00816170 FIG00816171: hypothetical protein +FIG00816171 FIG00816173: hypothetical protein +FIG00816173 Nickel-dependent superoxide dismutase (EC 1.15.1.1) +FIG00816174 FIG00816176: hypothetical protein +FIG00816176 FIG00816177: hypothetical protein +FIG00816187 FIG00816189: hypothetical protein +FIG00816189 FIG00816191: hypothetical protein +FIG00816191 FIG00816192: hypothetical protein +FIG00816192 FIG00816193: hypothetical protein +FIG00816193 FIG00816195: hypothetical protein +FIG00816196 FIG01042430: hypothetical protein +FIG00816197 FIG00816198: hypothetical protein +FIG00816200 FIG00816202: hypothetical protein +FIG00816209 1,4-dihydroxy-2-naphthoate octaprenyltransferase +FIG00816210 FIG00816212: hypothetical protein +FIG00816212 PROBABLE MEMBRANE PROTEIN +FIG00816213 Uroporphyrinogen-III synthase (EC 4.2.1.75) / response regulator +FIG00816214 FIG00816215: hypothetical protein +FIG00816215 FIG00816216: hypothetical protein +FIG00816220 FIG00816221: hypothetical protein +FIG00816221 FIG00816225: hypothetical protein +FIG00816235 FIG00816236: hypothetical protein +FIG00816236 FIG00816238: hypothetical protein +FIG00816238 FIG00816239: hypothetical protein +FIG00816239 FIG00816240: hypothetical protein +FIG00816240 FIG00816241: hypothetical protein +FIG00816242 PROBABLE OXIDOREDUCTASE (EC 1.-.-.-) +FIG00816243 FIG00816244: hypothetical protein +FIG00816245 FIG00816249: hypothetical protein +FIG00816249 FIG00816250: hypothetical protein +FIG00816250 FIG00816251: hypothetical protein +FIG00816253 FIG00816255: hypothetical protein +FIG00816255 FIG00816256: hypothetical protein +FIG00816262 FIG00816263: hypothetical protein +FIG00816264 FIG00816266: hypothetical protein +FIG00816271 FIG00816272: hypothetical protein +FIG00816275 FIG00816276: hypothetical protein +FIG00816277 Inositol-phosphate phosphatase( EC:3.1.3.25 ) +FIG00816282 FIG00816283: hypothetical protein +FIG00816283 FIG00816284: hypothetical protein +FIG00816284 FIG00816285: hypothetical protein +FIG00816285 FIG00816287: hypothetical protein +FIG00816289 Cold-shock protein, DNA-binding +FIG00816291 FIG00816292: hypothetical protein +FIG00816298 putative lipoprotein peptidase lpqM( EC:3.4.11.- ) +FIG00816299 ATP-dependent protease HslVU (ClpYQ), ATPase subunit +FIG00816301 FIG00816303: hypothetical protein +FIG00816303 FIG00816304: hypothetical protein +FIG00816304 FIG00816306: hypothetical protein +FIG00816306 FIG00816307: hypothetical protein +FIG00816307 FIG00816308: hypothetical protein +FIG00816308 FIG00816309: hypothetical protein +FIG00816309 FIG00816311: hypothetical protein +FIG00816312 FIG00816313: hypothetical protein +FIG00816313 FIG00816314: hypothetical protein +FIG00816316 FIG00816317: hypothetical protein +FIG00816317 FIG00816318: hypothetical protein +FIG00816320 putative CoA transferase B subunit +FIG00816321 ROK family protein +FIG00816324 FIG00816325: hypothetical protein +FIG00816325 FIG00816327: hypothetical protein +FIG00816328 FIG00816329: hypothetical protein +FIG00816331 FIG00816333: hypothetical protein +FIG00816333 FIG00816334: hypothetical protein +FIG00816334 FIG00816335: hypothetical protein +FIG00816335 FIG00816336: hypothetical protein +FIG00816337 FIG00816339: hypothetical protein +FIG00816339 FIG00816341: hypothetical protein +FIG00816341 Uncharacterized protein SCO3347 +FIG00816342 FIG00816343: hypothetical protein +FIG00816343 FIG00816344: hypothetical protein +FIG00816345 putative metallo-beta-lactamase +FIG00816350 FIG00816352: hypothetical protein +FIG00816356 Probable RNA polymerase sigma-C factor +FIG00816357 FIG00816358: hypothetical protein +FIG00816358 FIG00816359: hypothetical protein +FIG00816359 FIG00816361: hypothetical protein +FIG00816361 FIG00816362: hypothetical protein +FIG00816362 FIG00924678: hypothetical protein +FIG00816363 FIG00816365: hypothetical protein +FIG00816365 anti-sigma-factor antagonist +FIG00816366 FIG00816367: hypothetical protein +FIG00816367 FIG00816369: hypothetical protein +FIG00816369 FIG00816371: hypothetical protein +FIG00816371 FIG00816373: hypothetical protein +FIG00816373 FIG00816376: hypothetical protein +FIG00816376 FIG00816377: hypothetical protein +FIG00816380 FIG00816381: hypothetical protein +FIG00816385 FIG00816387: hypothetical protein +FIG00816387 FIG00816390: hypothetical protein +FIG00816397 MutT domain containing protein +FIG00816399 FIG00816400: hypothetical protein +FIG00816400 FIG00816401: hypothetical protein +FIG00816401 FIG00816402: hypothetical protein +FIG00816402 FIG00816403: hypothetical protein +FIG00816405 FIG00816406: hypothetical protein +FIG00816407 FIG00816411: hypothetical protein +FIG00816411 FIG00816413: hypothetical protein +FIG00816420 FIG00816422: hypothetical protein +FIG00816422 Uncharacterized protein Rv3412/MT3521 +FIG00816423 FIG00816424: hypothetical protein +FIG00816424 hypothetical protein; putative Arylesterase-related +FIG00816425 putative arylsulfatase regulatory protein +FIG00816428 FIG00816429: hypothetical protein +FIG00816430 FIG00816433: hypothetical protein +FIG00816436 FIG00816437: hypothetical protein +FIG00816439 FIG00816441: hypothetical protein +FIG00816441 FIG00816442: hypothetical protein +FIG00816442 FIG00816444: hypothetical protein +FIG00816446 unknown hypothetical protein +FIG00816456 FIG00816457: hypothetical protein +FIG00816459 FIG00816460: hypothetical protein +FIG00816460 FIG00816461: hypothetical protein +FIG00816462 FIG00816463: hypothetical protein +FIG00816463 FIG00816464: hypothetical protein +FIG00816464 FIG00816465: hypothetical protein +FIG00816466 FIG00816467: hypothetical protein +FIG00816467 FIG00816468: hypothetical protein +FIG00816470 FIG00816471: hypothetical protein +FIG00816472 FIG00816473: hypothetical protein +FIG00816473 FIG00816474: hypothetical protein +FIG00816476 FIG00816477: hypothetical protein +FIG00816477 FIG00816479: hypothetical protein +FIG00816480 FIG00816481: hypothetical protein +FIG00816481 Signal peptidase +FIG00816482 FIG00816483: hypothetical protein +FIG00816484 FIG00816486: hypothetical protein +FIG00816486 FIG00816487: hypothetical protein +FIG00816487 putative competence-damage inducible protein +FIG00816489 FIG00816490: hypothetical protein +FIG00816494 FIG00816496: hypothetical protein +FIG00816496 FIG00816498: hypothetical protein +FIG00816498 FIG00816500: hypothetical protein +FIG00816500 FIG00816501: hypothetical protein +FIG00816502 FIG00816505: hypothetical protein +FIG00816505 FIG00816507: hypothetical protein +FIG00816507 POSSIBLE RNA METHYLTRANSFERASE (RNA METHYLASE) +FIG00816510 FIG00816511: hypothetical protein +FIG00816511 FIG00816512: hypothetical protein +FIG00816512 FIG00816513: hypothetical protein +FIG00816514 FIG00816515: hypothetical protein +FIG00816515 putative acyl carier protein +FIG00816517 FIG00816518: hypothetical protein +FIG00816519 COG family: RecA-superfamily ATPases implicated in signal transduction +FIG00816520 FIG00816521: hypothetical protein +FIG00816531 FIG00816532: hypothetical protein +FIG00816533 FIG00816534: hypothetical protein +FIG00816534 FIG00816537: hypothetical protein +FIG00816538 FIG01042605: hypothetical protein +FIG00816542 FIG00816543: hypothetical protein +FIG00816543 geranylgeranyl reductase +FIG00816545 FIG00816546: hypothetical protein +FIG00816550 FIG00816551: hypothetical protein +FIG00816551 FIG00816554: hypothetical protein +FIG00816554 FIG00816555: hypothetical protein +FIG00816555 Glutamate--cysteine ligase EgtA +FIG00816557 FIG00816558: hypothetical protein +FIG00816558 FIG01042773: hypothetical protein +FIG00816564 FIG00816567: hypothetical protein +FIG00816570 FIG00816571: hypothetical protein +FIG00816571 FIG00816572: hypothetical protein +FIG00816572 multi-domain regulatory protein +FIG00816576 FIG00816577: hypothetical protein +FIG00816577 FIG00816578: hypothetical protein +FIG00816579 FIG00816580: hypothetical protein +FIG00816580 protein of unknown function UPF0126 +FIG00816582 FIG00816583: hypothetical protein +FIG00816583 FIG00816586: hypothetical protein +FIG00816586 FIG00816589: hypothetical protein +FIG00816592 FIG00816593: hypothetical protein +FIG00816595 FIG00816597: hypothetical protein +FIG00816597 FIG00816598: hypothetical protein +FIG00816598 FIG01044853: hypothetical protein +FIG00816599 FIG01043082: hypothetical protein +FIG00816607 FIG00816609: hypothetical protein +FIG00816609 FIG00816610: hypothetical protein +FIG00816610 FIG00816611: hypothetical protein +FIG00816611 FIG00816612: hypothetical protein +FIG00816612 FIG00816614: hypothetical protein +FIG00816616 FIG00816617: hypothetical protein +FIG00816617 protein of unknown function DUF1275 +FIG00816621 FIG00816622: hypothetical protein +FIG00816622 FIG00816623: hypothetical protein +FIG00816623 FIG00816624: hypothetical protein +FIG00816625 FIG00816626: hypothetical protein +FIG00816626 FIG00816627: hypothetical protein +FIG00816627 C-7 ketoreductase +FIG00816629 ABC transporter, membrane spanning protein [sugar] +FIG00816631 FIG00816632: hypothetical protein +FIG00816632 FIG00816633: hypothetical protein +FIG00816634 FIG00816635: hypothetical protein +FIG00816642 putative ABC transport system, ATP-binding protein +FIG00816646 FIG00816648: hypothetical protein +FIG00816648 FIG00816652: hypothetical protein +FIG00816653 FIG00816654: hypothetical protein +FIG00816657 FIG00816658: hypothetical protein +FIG00816660 flavin-dependent reductase +FIG00816664 Putative regulator of sigma factor +FIG00816665 FIG00816666: hypothetical protein +FIG00816668 FIG00816670: hypothetical protein +FIG00816670 FIG00816673: hypothetical protein +FIG00816676 possible low temperature requirement protein A +FIG00816684 FIG00816687: hypothetical protein +FIG00816687 FIG00816688: hypothetical protein +FIG00816688 FIG00816689: hypothetical protein +FIG00816693 FIG00816694: hypothetical protein +FIG00816695 FIG00816696: hypothetical protein +FIG00816696 FIG00816697: hypothetical protein +FIG00816698 FIG00816699: hypothetical protein +FIG00816701 FIG00816702: hypothetical protein +FIG00816702 FIG00816704: hypothetical protein +FIG00816707 FIG00816708: hypothetical protein +FIG00816708 FIG00816709: hypothetical protein +FIG00816710 FIG00816711: hypothetical protein +FIG00816712 Sigma-70, region 4 type 2 +FIG00816714 B12 binding domain protein +FIG00816715 FIG00816716: hypothetical protein +FIG00816716 FIG00816718: hypothetical protein +FIG00816718 FIG00816719: hypothetical protein +FIG00816724 FIG00816725: hypothetical protein +FIG00816725 FIG00816726: hypothetical protein +FIG00816726 metal dependent phosphohydrolase( EC:2.7.6.5 ) +FIG00816727 FIG00816728: hypothetical protein +FIG00816730 Extracellular ribonuclease/nuclease fusion protein +FIG00816733 FIG00816735: hypothetical protein +FIG00816735 FIG00816736: hypothetical protein +FIG00816741 FIG00816742: hypothetical protein +FIG00816743 FIG00816744: hypothetical protein +FIG00816744 FIG00816746: hypothetical protein +FIG00816748 FIG00816749: hypothetical protein +FIG00816756 FIG00816757: hypothetical protein +FIG00816757 FIG00816758: hypothetical protein +FIG00816760 protein of unknown function DUF1486 +FIG00816761 Uncharacterized protein Cgl2769/cg3067 +FIG00816763 Possible pre-pilin peptidase +FIG00816764 FIG00816765: hypothetical protein +FIG00816765 FIG00816768: hypothetical protein +FIG00816771 Alpha/beta hydrolase fold( EC:1.11.1.10 ) +FIG00816772 FIG00816773: hypothetical protein +FIG00816774 FIG00816775: hypothetical protein +FIG00816777 FIG00816778: hypothetical protein +FIG00816782 FIG00816783: hypothetical protein +FIG00816783 FIG00816785: hypothetical protein +FIG00816785 FIG00816786: hypothetical protein +FIG00816786 Exoglucanase B precursor (EC 3.2.1.91) (Exocellobiohydrolase B) (1,4-beta-cellobiohydrolase B) (CBP120) +FIG00816787 FIG00816789: hypothetical protein +FIG00816791 FIG00816794: hypothetical protein +FIG00816801 FIG00816802: hypothetical protein +FIG00816811 FIG00816812: hypothetical protein +FIG00816812 FIG00816814: hypothetical protein +FIG00816814 FIG00816815: hypothetical protein +FIG00816816 FIG00816818: hypothetical protein +FIG00816819 OrfE protein +FIG00816822 FIG01121218: hypothetical protein +FIG00816823 FIG00816824: hypothetical protein +FIG00816824 FIG00816825: hypothetical protein +FIG00816826 FIG00816828: hypothetical protein +FIG00816829 FIG00816830: hypothetical protein +FIG00816830 FIG00816832: hypothetical protein +FIG00816832 FIG00816834: hypothetical protein +FIG00816834 FIG00816837: hypothetical protein +FIG00816839 COG2719: Uncharacterized conserved protein +FIG00816843 PROBABLE CONSERVED ATP-BINDING PROTEIN ABC TRANSPORTER +FIG00816844 FIG00816845: hypothetical protein +FIG00816845 FIG00816846: hypothetical protein +FIG00816847 FIG00816848: hypothetical protein +FIG00816854 FIG00816855: hypothetical protein +FIG00816855 FIG00816856: hypothetical protein +FIG00816856 FIG00816857: hypothetical protein +FIG00816857 FIG00816859: hypothetical protein +FIG00816860 FIG00816861: hypothetical protein +FIG00816861 FIG00816863: hypothetical protein +FIG00816863 FIG00816866: hypothetical protein +FIG00816868 FIG00816869: hypothetical protein +FIG00816870 FIG00816871: hypothetical protein +FIG00816872 FIG00816875: hypothetical protein +FIG00816875 FIG00816876: hypothetical protein +FIG00816884 Helix-hairpin-helix DNA-binding, class 1 +FIG00816885 FIG00816888: hypothetical protein +FIG00816897 FIG00816898: hypothetical protein +FIG00816898 UPF0301 protein YqgE +FIG00816899 FIG00816900: hypothetical protein +FIG00816900 FIG00816902: hypothetical protein +FIG00816902 cyclase +FIG00816905 FIG00816906: hypothetical protein +FIG00816906 amino acid adenylation domain +FIG00816910 FIG00816911: hypothetical protein +FIG00816911 FIG00816912: hypothetical protein +FIG00816914 FIG00816915: hypothetical protein +FIG00816915 FIG00816916: hypothetical protein +FIG00816916 FIG00816917: hypothetical protein +FIG00816917 FIG00816920: hypothetical protein +FIG00816923 FIG00816924: hypothetical protein +FIG00816924 transcriptional regulator (MerR-family) +FIG00816926 FIG00816927: hypothetical protein +FIG00816928 FIG01044297: hypothetical protein +FIG00816930 FIG00816931: hypothetical protein +FIG00816933 FIG01044309: hypothetical protein +FIG00816934 FIG00816935: hypothetical protein +FIG00816937 FIG00816939: hypothetical protein +FIG00816939 Duplicated ATPase component CbrU of energizing module of predicted cobalamin ECF transporter +FIG00816944 FIG00816945: hypothetical protein +FIG00816950 FIG00816952: hypothetical protein +FIG00816952 FIG00816954: hypothetical protein +FIG00816954 FIG00816956: hypothetical protein +FIG00816958 FIG00816959: hypothetical protein +FIG00816959 FIG00816960: hypothetical protein +FIG00816974 FIG00816976: hypothetical protein +FIG00816976 FIG00816981: hypothetical protein +FIG00816984 FIG00816985: hypothetical protein +FIG00816986 FIG00816987: hypothetical protein +FIG00816987 FIG00816988: hypothetical protein +FIG00816995 FIG00816998: hypothetical protein +FIG00817000 FIG00817001: hypothetical protein +FIG00817003 FIG00817004: hypothetical protein +FIG00817004 FIG00817005: hypothetical protein +FIG00817006 MoxR +FIG00817009 FIG00817011: hypothetical protein +FIG00817011 FIG00817012: hypothetical protein +FIG00817012 FIG00817013: hypothetical protein +FIG00817015 FIG00817017: hypothetical protein +FIG00817022 FIG00817024: hypothetical protein +FIG00817024 FIG00817025: hypothetical protein +FIG00817025 FIG00817026: hypothetical protein +FIG00817026 FIG00817027: hypothetical protein +FIG00817027 FIG00817028: hypothetical protein +FIG00817030 Phosphopantothenoylcysteine decarboxylase (EC 4.1.1.36) homolog +FIG00817031 FIG00817032: hypothetical protein +FIG00817033 FIG00817034: hypothetical protein +FIG00817039 FIG00817040: hypothetical protein +FIG00817040 FIG00817041: hypothetical protein +FIG00817041 Probable aldehyde dehydrogenase +FIG00817045 FIG00817047: hypothetical protein +FIG00817047 FIG00817048: hypothetical protein +FIG00817048 FIG00817050: hypothetical protein +FIG00817053 Anti-sigma F factor antagonist (spoIIAA-2); Anti-sigma B factor antagonist RsbV +FIG00817055 FIG00817057: hypothetical protein +FIG00817060 FIG00817061: hypothetical protein +FIG00817061 FIG00817062: hypothetical protein +FIG00817062 FIG00817063: hypothetical protein +FIG00817064 Probable DNA-binding protein +FIG00817066 FIG00817067: hypothetical protein +FIG00817068 A3(2) glycogen metabolism clusterI +FIG00817072 FIG00817074: hypothetical protein +FIG00817074 FIG00817076: hypothetical protein +FIG00817076 FIG00817077: hypothetical protein +FIG00817080 FIG01043245: hypothetical protein +FIG00817081 FIG00817082: hypothetical protein +FIG00817085 FIG00817086: hypothetical protein +FIG00817087 FIG00817088: hypothetical protein +FIG00817088 FIG00817089: hypothetical protein +FIG00817091 FIG00817092: hypothetical protein +FIG00817093 FIG00817094: hypothetical protein +FIG00817094 FIG00817095: hypothetical protein +FIG00817095 FIG00817096: hypothetical protein +FIG00817096 protein of unknown function DUF984 +FIG00817097 FIG00817099: hypothetical protein +FIG00817099 peptidyl-prolyl cis-trans isomerase, cyclophilin type +FIG00817100 FIG00817101: hypothetical protein +FIG00817101 FIG00817102: hypothetical protein +FIG00817106 FIG00817107: hypothetical protein +FIG00817110 FIG00817111: hypothetical protein +FIG00817112 FIG00817113: hypothetical protein +FIG00817113 FIG00817115: hypothetical protein +FIG00817115 FIG00817116: hypothetical protein +FIG00817116 FIG00817117: hypothetical protein +FIG00817119 sugar isomerase (SIS) +FIG00817123 FIG00817124: hypothetical protein +FIG00817124 FIG00817125: hypothetical protein +FIG00817126 FIG00817127: hypothetical protein +FIG00817127 FIG00817128: hypothetical protein +FIG00817128 FIG00817129: hypothetical protein +FIG00817130 FIG00817132: hypothetical protein +FIG00817132 FIG00817134: hypothetical protein +FIG00817134 FIG00817137: hypothetical protein +FIG00817137 FIG00817138: hypothetical protein +FIG00817139 FIG00817142: hypothetical protein +FIG00817142 carboxypeptidase B +FIG00817144 FIG00817145: hypothetical protein +FIG00817145 FIG00817146: hypothetical protein +FIG00817146 FIG00817147: hypothetical protein +FIG00817148 FIG00817150: hypothetical protein +FIG00817171 FIG00817172: hypothetical protein +FIG00817172 FIG00817174: hypothetical protein +FIG00817177 FIG00817178: hypothetical protein +FIG00817178 FIG00817179: hypothetical protein +FIG00817179 FIG00817180: hypothetical protein +FIG00817180 FIG00817182: hypothetical protein +FIG00817182 FIG00817187: hypothetical protein +FIG00817187 FIG00817188: hypothetical protein +FIG00817191 Cholesterol oxidase (EC 1.1.3.6) +FIG00817196 FIG00817197: hypothetical protein +FIG00817197 FIG00817198: hypothetical protein +FIG00817198 FIG00817199: hypothetical protein +FIG00817199 FIG00817201: hypothetical protein +FIG00817201 FIG00817202: hypothetical protein +FIG00817202 FIG00817204: hypothetical protein +FIG00817204 D-aminopeptidase (EC 3.4.11.19) +FIG00817205 FIG00817206: hypothetical protein +FIG00817206 FIG00817207: hypothetical protein +FIG00817214 FIG00817215: hypothetical protein +FIG00817215 FIG00817216: hypothetical protein +FIG00817219 FIG00817221: hypothetical protein +FIG00817221 FIG00817222: hypothetical protein +FIG00817226 FIG00817227: hypothetical protein +FIG00817227 FIG00817229: hypothetical protein +FIG00817230 FIG00817231: hypothetical protein +FIG00817231 FIG00817233: hypothetical protein +FIG00817235 putative ferredoxin +FIG00817239 FIG00817241: hypothetical protein +FIG00817246 FIG00817249: hypothetical protein +FIG00817249 FIG00817251: hypothetical protein +FIG00817251 FIG00817252: hypothetical protein +FIG00817254 PROBABLE CONSERVED LIPOPROTEIN LPPS +FIG00817255 FIG00817257: hypothetical protein +FIG00817258 possible ABC transporter permease +FIG00817259 FIG00817260: hypothetical protein +FIG00817260 FIG00817261: hypothetical protein +FIG00817261 FIG00817262: hypothetical protein +FIG00817262 FIG00817263: hypothetical protein +FIG00817263 FIG00817264: hypothetical protein +FIG00817264 FIG00817267: hypothetical protein +FIG00817269 FIG00817270: hypothetical protein +FIG00817271 FIG00817273: hypothetical protein +FIG00817274 FIG00817276: hypothetical protein +FIG00817276 FIG00817277: hypothetical protein +FIG00817277 FIG00817278: hypothetical protein +FIG00817279 FIG00817280: hypothetical protein +FIG00817280 FIG00817281: hypothetical protein +FIG00817281 FIG00817282: hypothetical protein +FIG00817288 FIG00817289: hypothetical protein +FIG00817289 FIG00817290: hypothetical protein +FIG00817290 FIG00817294: hypothetical protein +FIG00817294 FIG00817295: hypothetical protein +FIG00817297 FIG00817298: hypothetical protein +FIG00817298 FIG00817299: hypothetical protein +FIG00817299 FIG00817301: hypothetical protein +FIG00817302 FIG00817303: hypothetical protein +FIG00817308 FIG00817309: hypothetical protein +FIG00817309 FIG00817311: hypothetical protein +FIG00817311 FIG00817312: hypothetical protein +FIG00817312 FIG00817313: hypothetical protein +FIG00817318 FIG00817319: hypothetical protein +FIG00817321 Ion transport protein +FIG00817322 FIG00817324: hypothetical protein +FIG00817326 FIG00817327: hypothetical protein +FIG00817327 FIG00817329: hypothetical protein +FIG00817330 FIG00817331: hypothetical protein +FIG00817331 FIG00817332: hypothetical protein +FIG00817332 FIG00817334: hypothetical protein +FIG00817341 FIG00817342: hypothetical protein +FIG00817342 FIG00817344: hypothetical protein +FIG00817345 FIG00817346: hypothetical protein +FIG00817349 FIG00817350: hypothetical protein +FIG00817350 FIG00817352: hypothetical protein +FIG00817352 FIG00817353: hypothetical protein +FIG00817353 FIG00999229: probable secreted protein +FIG00817356 FIG00817357: hypothetical protein +FIG00817357 Beta-mannanase-like protein +FIG00817362 FIG00817364: hypothetical protein +FIG00817364 FIG00817366: hypothetical protein +FIG00817366 Probable DEAD-box RNA helicase +FIG00817370 FIG00817372: hypothetical protein +FIG00817372 FIG00817374: hypothetical protein +FIG00817374 FIG00817375: hypothetical protein +FIG00817379 FIG00817381: hypothetical protein +FIG00817384 FIG00817387: hypothetical protein +FIG00817387 FIG00817388: hypothetical protein +FIG00817389 FIG01043024: hypothetical protein +FIG00817392 FIG00817396: hypothetical protein +FIG00817396 FIG00817398: hypothetical protein +FIG00817398 FIG00817399: hypothetical protein +FIG00817399 FIG00817400: hypothetical protein +FIG00817400 FIG00817401: hypothetical protein +FIG00817401 FIG00817402: hypothetical protein +FIG00817402 FIG00817403: hypothetical protein +FIG00817403 FIG00817404: hypothetical protein +FIG00817408 FIG00817412: hypothetical protein +FIG00817417 Cellulose-binding, family II, bacterial type:Fibronectin, type III precursor +FIG00817421 FIG00817423: hypothetical protein +FIG00817423 FIG00817424: hypothetical protein +FIG00817428 FIG00817429: hypothetical protein +FIG00817431 FIG00817432: hypothetical protein +FIG00817432 FIG00817433: hypothetical protein +FIG00817435 FIG00817438: hypothetical protein +FIG00817438 FIG00817439: hypothetical protein +FIG00817439 cholesterol oxidase +FIG00817446 FIG00817448: hypothetical protein +FIG00817448 FIG00817449: hypothetical protein +FIG00817451 possible streptomycin 6-kinase, N-terminal( EC:2.7.1.72 ) +FIG00817454 FIG00817455: hypothetical protein +FIG00817456 FIG00817457: hypothetical protein +FIG00817459 FIG00817460: hypothetical protein +FIG00817461 FIG00817464: hypothetical protein +FIG00817468 FIG00817469: hypothetical protein +FIG00817469 FIG00817470: hypothetical protein +FIG00817471 FIG00817472: hypothetical protein +FIG00817472 FIG00817473: hypothetical protein +FIG00817473 FIG00817474: hypothetical protein +FIG00817474 FIG00817475: hypothetical protein +FIG00817475 FIG00817476: hypothetical protein +FIG00817479 L-lysine 6-monooxygenase +FIG00817487 FIG00817489: hypothetical protein +FIG00817491 FIG00817492: hypothetical protein +FIG00817492 FIG00817493: hypothetical protein +FIG00817493 FIG00817494: hypothetical protein +FIG00817497 FIG00817498: hypothetical protein +FIG00817498 FIG00817499: hypothetical protein +FIG00817502 FIG00817503: hypothetical protein +FIG00817504 FIG00817505: hypothetical protein +FIG00817505 FIG00817506: hypothetical protein +FIG00817506 FIG00817507: hypothetical protein +FIG00817508 FIG00817511: hypothetical protein +FIG00817511 Uncharacterized protein SCO1141 +FIG00817521 FIG00817522: hypothetical protein +FIG00817529 FIG00817530: hypothetical protein +FIG00817533 FIG00817534: hypothetical protein +FIG00817534 FIG00817535: hypothetical protein +FIG00817538 FIG00817539: hypothetical protein +FIG00817539 similar to interphotoreceptor retinoid-binding protein +FIG00817540 FIG00817543: hypothetical protein +FIG00817543 FIG00817544: hypothetical protein +FIG00817544 FIG00817545: hypothetical protein +FIG00817545 Two-component regulator +FIG00817548 Lantibiotic dehydratase domain protein +FIG00817551 FIG00817552: hypothetical protein +FIG00817554 FIG00817555: hypothetical protein +FIG00817557 FIG00817558: hypothetical protein +FIG00817559 FIG00817560: hypothetical protein +FIG00817563 FIG00817564: hypothetical protein +FIG00817568 FIG00817569: hypothetical protein +FIG00817575 Acyl carrier protein, putative +FIG00817576 FIG00817577: hypothetical protein +FIG00817577 FIG00817578: hypothetical protein +FIG00817578 FIG00817579: hypothetical protein +FIG00817579 Membrane-bound lytic murein transglycosylase B-like protein +FIG00817583 FIG00817585: hypothetical protein +FIG00817585 FIG00817586: hypothetical protein +FIG00817586 FIG00817596: hypothetical protein +FIG00817600 FIG00817601: hypothetical protein +FIG00817601 FIG00817602: hypothetical protein +FIG00817604 FIG00817605: hypothetical protein +FIG00817605 FIG00817606: hypothetical protein +FIG00817608 FIG00817610: hypothetical protein +FIG00817613 FIG00817614: hypothetical protein +FIG00817615 FIG00817617: hypothetical protein +FIG00817621 FIG00817622: hypothetical protein +FIG00817622 FIG00817623: hypothetical protein +FIG00817623 FIG00817624: hypothetical protein +FIG00817624 ABC peptide transporter, permease component +FIG00817625 FIG00817628: hypothetical protein +FIG00817628 FIG00817629: hypothetical protein +FIG00817629 FIG00817630: hypothetical protein +FIG00817631 Alpha/beta hydrolase fold-3 +FIG00817632 FIG00817636: hypothetical protein +FIG00817636 FIG00817637: hypothetical protein +FIG00817637 FIG00817639: hypothetical protein +FIG00817639 FIG00817640: hypothetical protein +FIG00817640 FIG00817641: hypothetical protein +FIG00817642 FIG00817643: hypothetical protein +FIG00817643 FIG00817644: hypothetical protein +FIG00817648 FIG00817649: hypothetical protein +FIG00817649 FIG00817651: hypothetical protein +FIG00817651 FIG00817652: hypothetical protein +FIG00817655 FIG00817657: hypothetical protein +FIG00817658 FIG00817659: hypothetical protein +FIG00817659 FIG00817660: hypothetical protein +FIG00817660 FIG00817662: hypothetical protein +FIG00817662 FIG00817663: hypothetical protein +FIG00817663 DedA-like protein +FIG00817669 putative secreted pectate lyase +FIG00817672 FIG00817675: hypothetical protein +FIG00817676 FIG00817678: hypothetical protein +FIG00817678 FIG00817679: hypothetical protein +FIG00817679 FIG01042869: hypothetical protein +FIG00817681 FIG00817682: hypothetical protein +FIG00817682 FIG00817683: hypothetical protein +FIG00817683 Adenylyl cyclase class-3/4/guanylyl cyclase / Disease resistance domain-containing protein / Tetratricopeptide repeat-containing protein +FIG00817690 FIG00817691: hypothetical protein +FIG00817691 FIG00817692: hypothetical protein +FIG00817692 FIG00817694: hypothetical protein +FIG00817697 FIG00817698: hypothetical protein +FIG00817699 FIG00817700: hypothetical protein +FIG00817700 FIG00817701: hypothetical protein +FIG00817703 FIG00817704: hypothetical protein +FIG00817704 FIG00817705: hypothetical protein +FIG00817708 FIG00817711: hypothetical protein +FIG00817711 LysR-family transcriptional regulatory protein +FIG00817712 FIG00817713: hypothetical protein +FIG00817719 putative CoA transferase A subunit +FIG00817722 FIG00817724: hypothetical protein +FIG00817725 FIG00817726: hypothetical protein +FIG00817726 FIG00817727: hypothetical protein +FIG00817727 FIG00817728: hypothetical protein +FIG00817729 putative ABC transporter integral membrane permease +FIG00817730 trypsin precursor +FIG00817731 aminoglycoside acetyltransferase (6') type I +FIG00817735 FIG00817737: hypothetical protein +FIG00817745 Subtilisin inhibitor-like protein 2 (SIL-2) (SIL2) +FIG00817747 FIG00817748: hypothetical protein +FIG00817748 FIG00817749: hypothetical protein +FIG00817749 FIG00817750: hypothetical protein +FIG00817750 FIG00817751: hypothetical protein +FIG00817751 FIG00817752: hypothetical protein +FIG00817753 FIG00817754: hypothetical protein +FIG00817761 FIG00817762: hypothetical protein +FIG00817762 FIG00817763: hypothetical protein +FIG00817763 FIG00817764: hypothetical protein +FIG00817765 FIG00817766: hypothetical protein +FIG00817766 FIG00817767: hypothetical protein +FIG00817767 FIG00817769: hypothetical protein +FIG00817769 FIG00817770: hypothetical protein +FIG00817771 FIG00817772: hypothetical protein +FIG00817772 FIG00817774: hypothetical protein +FIG00817775 Protein serine/threonine kinase +FIG00817778 FIG00817779: hypothetical protein +FIG00817779 polysaccharide biosynthesis protein CpsF +FIG00817783 FIG00817784: hypothetical protein +FIG00817784 FIG00817785: hypothetical protein +FIG00817785 FIG00817786: hypothetical protein +FIG00817786 FIG00817788: hypothetical protein +FIG00817788 FIG00817790: hypothetical protein +FIG00817790 Endoglucanase E1 precursor (EC 3.2.1.4) (Endo-1,4-beta-glucanase E1) (Cellulase E1) (Endocellulase E1) +FIG00817793 FIG01044210: hypothetical protein +FIG00817794 FIG00817795: hypothetical protein +FIG00817800 FIG00817801: hypothetical protein +FIG00817805 FIG00817807: hypothetical protein +FIG00817807 FIG00817809: hypothetical protein +FIG00817809 FIG00817810: hypothetical protein +FIG00817810 FIG00817811: hypothetical protein +FIG00817812 FIG00817814: hypothetical protein +FIG00817814 FIG00817815: hypothetical protein +FIG00817815 FIG00817816: hypothetical protein +FIG00817826 FIG00817828: hypothetical protein +FIG00817828 FIG01042965: hypothetical protein +FIG00817830 glutamate--cysteine ligase, GCS2 +FIG00817831 FIG00817833: hypothetical protein +FIG00817833 FIG00817834: hypothetical protein +FIG00817834 FIG00817836: hypothetical protein +FIG00817836 Signal transduction response regulator / Disease resistance domain-containing protein +FIG00817837 FIG00817838: hypothetical protein +FIG00817844 FIG00817845: hypothetical protein +FIG00817845 FIG00817847: hypothetical protein +FIG00817850 FIG00817852: hypothetical protein +FIG00817853 Hemagglutinin-related protein +FIG00817855 FIG00817858: hypothetical protein +FIG00817858 FIG00817860: hypothetical protein +FIG00817861 FIG00817863: hypothetical protein +FIG00817863 glutamine transport ATP-binding protein glnQ +FIG00817873 FIG00817874: hypothetical protein +FIG00817874 FIG00817875: hypothetical protein +FIG00817875 FIG00817876: hypothetical protein +FIG00817878 FIG00817879: hypothetical protein +FIG00817879 FIG00817880: hypothetical protein +FIG00817883 FIG00817884: hypothetical protein +FIG00817887 FIG00817888: hypothetical protein +FIG00817888 FIG00817890: hypothetical protein +FIG00817891 FIG00817892: hypothetical protein +FIG00817892 FIG00817893: hypothetical protein +FIG00817894 phosphoglycolate phosphatase +FIG00817896 FIG00817897: hypothetical protein +FIG00817898 FIG00817899: hypothetical protein +FIG00817903 FIG00817904: hypothetical protein +FIG00817904 FIG00817906: hypothetical protein +FIG00817913 FIG00817914: hypothetical protein +FIG00817914 FIG00817916: hypothetical protein +FIG00817916 FIG00817917: hypothetical protein +FIG00817917 FIG00817918: hypothetical protein +FIG00817918 FIG00817919: hypothetical protein +FIG00817919 FIG00817920: hypothetical protein +FIG00817921 FIG00817922: hypothetical protein +FIG00817922 FIG00817924: hypothetical protein +FIG00817929 FIG00817930: hypothetical protein +FIG00817930 eukaryotic-type serine/threonine protein kinase +FIG00817932 FIG00817937: hypothetical protein +FIG00817938 FIG00817940: hypothetical protein +FIG00817940 FIG00817941: hypothetical protein +FIG00817941 FIG00817942: hypothetical protein +FIG00817944 FIG00817946: hypothetical protein +FIG00817958 FIG00817959: hypothetical protein +FIG00817959 FIG00817960: hypothetical protein +FIG00817960 FIG00817961: hypothetical protein +FIG00817961 FIG00817968: hypothetical protein +FIG00817968 FIG00817969: hypothetical protein +FIG00817970 abc-transporter atp-binding protein +FIG00817971 FIG00817972: hypothetical protein +FIG00817972 FIG00817975: hypothetical protein +FIG00817977 FIG00817982: hypothetical protein +FIG00817982 FIG00817983: hypothetical protein +FIG00817983 FIG00817984: hypothetical protein +FIG00817987 FIG00817988: hypothetical protein +FIG00817988 FIG00817989: hypothetical protein +FIG00817992 FIG00817994: hypothetical protein +FIG00817994 FIG00817995: hypothetical protein +FIG00817997 FIG00817999: hypothetical protein +FIG00817999 FIG00818001: hypothetical protein +FIG00818004 putative FKBP-type peptidyl-prolyl cis-trans isomerase( EC:5.2.1.8 ) +FIG00818005 Flagellar hook-associated protein flgL +FIG00818007 FIG00818008: hypothetical protein +FIG00818008 FIG00818009: hypothetical protein +FIG00818009 FIG00818010: hypothetical protein +FIG00818016 FIG00818018: hypothetical protein +FIG00818018 FIG00818019: hypothetical protein +FIG00818019 FIG00818021: hypothetical protein +FIG00818021 serine protease precursor +FIG00818023 FIG00818027: hypothetical protein +FIG00818027 FIG00818028: hypothetical protein +FIG00818028 FIG00818029: hypothetical protein +FIG00818029 FIG00818030: hypothetical protein +FIG00818030 FIG00818031: hypothetical protein +FIG00818031 FIG00818032: hypothetical protein +FIG00818032 FIG00818033: hypothetical protein +FIG00818033 FIG00818034: hypothetical protein +FIG00818040 putative type IV peptidase +FIG00818042 FIG00818044: hypothetical protein +FIG00818044 Csp +FIG00818046 NAD-dependent dehydrogenase +FIG00818048 FIG00818049: hypothetical protein +FIG00818049 FIG00818050: hypothetical protein +FIG00818050 FIG00818051: hypothetical protein +FIG00818051 FIG00818053: hypothetical protein +FIG00818053 FIG00818056: hypothetical protein +FIG00818056 FIG00818060: hypothetical protein +FIG00818060 FIG00818061: hypothetical protein +FIG00818061 FIG00818062: hypothetical protein +FIG00818062 FIG00818066: hypothetical protein +FIG00818073 FIG00818074: hypothetical protein +FIG00818074 FIG00818075: hypothetical protein +FIG00818075 CONSERVED MEMBRANE PROTEIN +FIG00818077 FIG00818078: hypothetical protein +FIG00818078 FIG00818079: hypothetical protein +FIG00818080 FIG00818081: hypothetical protein +FIG00818088 FIG00818089: hypothetical protein +FIG00818090 FIG00818094: hypothetical protein +FIG00818095 FIG00818096: hypothetical protein +FIG00818098 FIG00818099: hypothetical protein +FIG00818101 FIG00818104: hypothetical protein +FIG00818104 FIG00818105: hypothetical protein +FIG00818105 FIG00818108: hypothetical protein +FIG00818108 FIG00818109: hypothetical protein +FIG00818109 Arginine repressor (partial match) +FIG00818110 FIG00818112: hypothetical protein +FIG00818112 FIG00818113: hypothetical protein +FIG00818113 FIG00818115: hypothetical protein +FIG00818115 O-methyltransferase, family 3 +FIG00818116 FIG00818117: hypothetical protein +FIG00818117 MJ0042 family finger-like protein +FIG00818118 FIG00818119: hypothetical protein +FIG00818121 FIG00818123: hypothetical protein +FIG00818125 FIG00818126: hypothetical protein +FIG00818126 FIG00818127: hypothetical protein +FIG00818127 FIG00818128: hypothetical protein +FIG00818134 FIG00818136: hypothetical protein +FIG00818136 zinc metalloprotease +FIG00818137 FIG00818138: hypothetical protein +FIG00818138 FIG00818139: hypothetical protein +FIG00818145 FIG00818148: hypothetical protein +FIG00818148 FIG00818150: hypothetical protein +FIG00818151 FIG00818153: hypothetical protein +FIG00818153 FIG00818154: hypothetical protein +FIG00818156 FIG00818157: hypothetical protein +FIG00818157 FIG00818159: hypothetical protein +FIG00818159 FIG00818160: hypothetical protein +FIG00818166 FIG00818168: hypothetical protein +FIG00818172 periplasmic protein +FIG00818173 hypothetical glycine-rich protein +FIG00818174 FIG00818175: hypothetical protein +FIG00818176 FIG00818178: hypothetical protein +FIG00818178 FIG00818179: hypothetical protein +FIG00818182 FIG00818183: hypothetical protein +FIG00818183 FIG00818184: hypothetical protein +FIG00818184 FIG00818185: hypothetical protein +FIG00818185 FIG00818186: hypothetical protein +FIG00818189 FIG00818192: hypothetical protein +FIG00818195 NADPH-dependent oxidoreductase with 4Fe-4S binding domain, in cluster with PFOR +FIG00818199 ABC transporter membrane-spanning permease, sugar transport YcjO +FIG00818203 probable ABC transporter system, ATP-binding protein +FIG00818208 FIG00818209: hypothetical protein +FIG00818209 FIG00818210: hypothetical protein +FIG00818210 FIG00818211: hypothetical protein +FIG00818214 FIG00818215: hypothetical protein +FIG00818215 FIG00818216: hypothetical protein +FIG00818218 predicted ABC-type polar amino acid transport system, periplasmic substrate-binding protein +FIG00818219 FIG00818221: hypothetical protein +FIG00818221 FIG00818222: hypothetical protein +FIG00818222 FIG00818223: hypothetical protein +FIG00818223 FIG00818224: hypothetical protein +FIG00818224 FIG00818225: hypothetical protein +FIG00818225 FIG00818227: hypothetical protein +FIG00818229 FIG00818235: hypothetical protein +FIG00818235 FIG00818236: hypothetical protein +FIG00818236 FIG00818237: hypothetical protein +FIG00818237 FIG00818240: hypothetical protein +FIG00818240 FIG00818241: hypothetical protein +FIG00818241 FIG00818243: hypothetical protein +FIG00818243 FIG00818244: hypothetical protein +FIG00818249 FIG00818250: hypothetical protein +FIG00818250 FIG00818251: hypothetical protein +FIG00818251 FIG00818252: hypothetical protein +FIG00818252 YidD +FIG00818255 FIG00818256: hypothetical protein +FIG00818256 Putative hydrogenase nickel incorporation protein +FIG00818259 FIG00818260: hypothetical protein +FIG00818260 COG1566: Multidrug resistance efflux pump +FIG00818262 FIG00818265: hypothetical protein +FIG00818265 FIG00818268: hypothetical protein +FIG00818272 Heat shock protein 22.5 (Hsp22.5) +FIG00818273 COG0834: ABC-type amino acid transport/signal transduction systems, periplasmic component/domain +FIG00818275 FIG00818276: hypothetical protein +FIG00818282 FIG00818287: hypothetical protein +FIG00818290 FIG00818291: hypothetical protein +FIG00818291 FIG00818295: hypothetical protein +FIG00818295 FIG00818296: hypothetical protein +FIG00818298 FIG00818300: hypothetical protein +FIG00818301 FIG00818302: hypothetical protein +FIG00818302 FIG00818304: hypothetical protein +FIG00818313 FIG00818315: hypothetical protein +FIG00818316 FIG00818318: hypothetical protein +FIG00818318 FIG00818319: hypothetical protein +FIG00818321 FIG00818322: hypothetical protein +FIG00818331 FIG00818332: hypothetical protein +FIG00818332 FIG00818334: hypothetical protein +FIG00818334 FIG00818335: hypothetical protein +FIG00818336 FIG00818339: hypothetical protein +FIG00818340 FIG00818342: hypothetical protein +FIG00818342 FIG00818343: hypothetical protein +FIG00818347 FIG00818349: hypothetical protein +FIG00818349 FIG00818350: hypothetical protein +FIG00818350 FIG00818351: hypothetical protein +FIG00818351 FIG00818352: hypothetical protein +FIG00818352 FIG00818353: hypothetical protein +FIG00818353 D-xylose-proton symporter (D-xylose transporter) +FIG00818358 FIG00818359: hypothetical protein +FIG00818359 FIG00818360: hypothetical protein +FIG00818360 FIG00818364: hypothetical protein +FIG00818364 FIG00818365: hypothetical protein +FIG00818370 COG3764: Sortase (surface protein transpeptidase) +FIG00818375 FIG00818376: hypothetical protein +FIG00818376 FIG00818378: hypothetical protein +FIG00818380 FIG00818382: hypothetical protein +FIG00818382 FIG00818384: hypothetical protein +FIG00818384 FIG00818385: hypothetical protein +FIG00818386 COG1840: ABC-type Fe3+ transport system, periplasmic component +FIG00818395 FIG00818398: hypothetical protein +FIG00818398 hemagglutinin-related protein +FIG00818401 FIG00818403: hypothetical protein +FIG00818403 FIG00818404: hypothetical protein +FIG00818405 FIG00818406: hypothetical protein +FIG00818406 FIG00818408: hypothetical protein +FIG00818411 FIG00818412: hypothetical protein +FIG00818412 FIG00818415: hypothetical protein +FIG00818416 FIG00818418: hypothetical protein +FIG00818420 FIG00818422: hypothetical protein +FIG00818422 FIG00818423: hypothetical protein +FIG00818423 FIG00818427: hypothetical protein +FIG00818427 FIG00818429: hypothetical protein +FIG00818431 FIG00818434: hypothetical protein +FIG00818434 FIG00818435: hypothetical protein +FIG00818435 FIG00818440: hypothetical protein +FIG00818442 putative hemin transport system ATP-binding protein fecE +FIG00818445 FIG00818446: hypothetical protein +FIG00818446 FIG00818448: hypothetical protein +FIG00818448 Eco57I restriction endonuclease +FIG00818451 FIG00818452: hypothetical protein +FIG00818455 FIG00818456: hypothetical protein +FIG00818456 FIG00818457: hypothetical protein +FIG00818457 FIG00818459: hypothetical protein +FIG00818459 FIG00818460: hypothetical protein +FIG00818460 FIG00818462: hypothetical protein +FIG00818464 FIG00818465: hypothetical protein +FIG00818465 FIG00818467: hypothetical protein +FIG00818475 FIG00818476: hypothetical protein +FIG00818476 FIG00818477: hypothetical protein +FIG00818477 FIG00818478: hypothetical protein +FIG00818479 FIG00818480: hypothetical protein +FIG00818480 polar amino acid ABC transporter, permease component +FIG00818481 FIG00818482: hypothetical protein +FIG00818490 FIG00818491: hypothetical protein +FIG00818491 FIG00818492: hypothetical protein +FIG00818493 FIG00818494: hypothetical protein +FIG00818494 FIG00818495: hypothetical protein +FIG00818495 FIG00818496: hypothetical protein +FIG00818496 FIG00818498: hypothetical protein +FIG00818498 FIG00818499: hypothetical protein +FIG00818499 beta-N-acetylglucosaminidase +FIG00818500 FIG00818501: hypothetical protein +FIG00818501 FIG00818502: hypothetical protein +FIG00818502 FIG00818503: hypothetical protein +FIG00818503 peptidase M20 +FIG00818504 FIG00818505: hypothetical protein +FIG00818505 FIG00818506: hypothetical protein +FIG00818506 FIG00818507: hypothetical protein +FIG00818507 FIG00818508: hypothetical protein +FIG00818509 FIG00818511: hypothetical protein +FIG00818516 FIG00818519: hypothetical protein +FIG00818519 FIG00818520: hypothetical protein +FIG00818520 FIG00818521: hypothetical protein +FIG00818521 Uncharacterized transporter STH2172 +FIG00818523 FIG00818525: hypothetical protein +FIG00818525 FIG00818526: hypothetical protein +FIG00818528 FIG00818529: hypothetical protein +FIG00818535 FIG00818536: hypothetical protein +FIG00818536 FIG00818537: hypothetical protein +FIG00818538 FIG00818539: hypothetical protein +FIG00818539 FIG00818542: hypothetical protein +FIG00818542 FIG00818543: hypothetical protein +FIG00818545 FIG00818546: hypothetical protein +FIG00818546 FIG00818547: hypothetical protein +FIG00818547 FIG00818548: hypothetical protein +FIG00818548 FIG00818549: hypothetical protein +FIG00818549 FIG00818552: hypothetical protein +FIG00818553 Fructosamine kinase family protein, At3g61080 homolog +FIG00818555 FIG00818560: hypothetical protein +FIG00818560 FIG00818561: hypothetical protein +FIG00818561 FIG00818562: hypothetical protein +FIG00818568 FIG00818570: hypothetical protein +FIG00818575 FIG00818580: hypothetical protein +FIG00818584 FIG00818586: hypothetical protein +FIG00818586 FIG00818588: hypothetical protein +FIG00818591 FIG00818594: hypothetical protein +FIG00818594 FIG00818595: hypothetical protein +FIG00818596 FIG00818599: hypothetical protein +FIG00818599 FIG00818601: hypothetical protein +FIG00818604 FIG00818606: hypothetical protein +FIG00818606 FIG00818607: hypothetical protein +FIG00818610 putative type III restriction enzyme +FIG00818612 FIG00818613: hypothetical protein +FIG00818613 FIG00818615: hypothetical protein +FIG00818615 FIG00818616: hypothetical protein +FIG00818616 FIG00818617: hypothetical protein +FIG00818618 FIG00818619: hypothetical protein +FIG00818619 FIG00818620: hypothetical protein +FIG00818620 FIG00818621: hypothetical protein +FIG00818623 FIG00818624: hypothetical protein +FIG00818624 FIG00818626: hypothetical protein +FIG00818626 Cell envelope-related transcriptional attenuator +FIG00818632 FIG00818633: hypothetical protein +FIG00818633 FIG00818635: hypothetical protein +FIG00818635 FIG00818636: hypothetical protein +FIG00818639 FIG00818640: hypothetical protein +FIG00818640 FIG00818642: hypothetical protein +FIG00818644 FIG00818646: hypothetical protein +FIG00818646 FIG00818647: hypothetical protein +FIG00818647 FIG00818649: hypothetical protein +FIG00818649 FIG00818651: hypothetical protein +FIG00818651 FIG00818653: hypothetical protein +FIG00818653 FIG00818654: hypothetical protein +FIG00818656 FIG00818659: hypothetical protein +FIG00818659 FIG00818660: hypothetical protein +FIG00818662 FIG00818663: hypothetical protein +FIG00818663 FIG00818664: hypothetical protein +FIG00818664 COG1722: Exonuclease VII small subunit +FIG00818667 FIG00818668: hypothetical protein +FIG00818671 FIG00818674: hypothetical protein +FIG00818674 FIG00818675: hypothetical protein +FIG00818675 FIG00818676: hypothetical protein +FIG00818677 FIG00818678: hypothetical protein +FIG00818678 FIG00818679: hypothetical protein +FIG00818679 FIG00818681: hypothetical protein +FIG00818682 Flagellar protein flbD +FIG00818683 FIG00818684: hypothetical protein +FIG00818684 FIG00818685: hypothetical protein +FIG00818685 FIG00818687: hypothetical protein +FIG00818689 FIG00818690: hypothetical protein +FIG00818690 FIG00818691: hypothetical protein +FIG00818692 FIG00818696: hypothetical protein +FIG00818698 FIG00818699: hypothetical protein +FIG00818699 FIG00818702: hypothetical protein +FIG00818703 probable cell division protein, FtsQ +FIG00818705 FIG00818707: hypothetical protein +FIG00818707 FIG00818708: hypothetical protein +FIG00818711 FIG00818713: hypothetical protein +FIG00818715 putative protein of unknown function (DUF552) +FIG00818716 FIG00818717: hypothetical protein +FIG00818718 FIG00818719: hypothetical protein +FIG00818719 FIG00818720: hypothetical protein +FIG00818721 FIG00818723: hypothetical protein +FIG00818723 FIG00818725: hypothetical protein +FIG00818726 FIG00818728: hypothetical protein +FIG00818728 FIG00818729: hypothetical protein +FIG00818731 FIG00818733: hypothetical protein +FIG00818736 FIG00818737: hypothetical protein +FIG00818739 ABC transporter ATP-binding protein (putative cobalt transport system) +FIG00818741 FIG00818742: hypothetical protein +FIG00818742 COG0776: Bacterial nucleoid DNA-binding protein +FIG00818746 FIG00818752: hypothetical protein +FIG00818752 FIG00818753: hypothetical protein +FIG00818753 FIG00818754: hypothetical protein +FIG00818755 protein of unknown function DUF180 +FIG00818756 ATPases involved in chromosome partitioning-like +FIG00818758 FIG00818760: hypothetical protein +FIG00818762 FIG00818766: hypothetical protein +FIG00818767 FIG00818769: hypothetical protein +FIG00818769 FIG00818770: hypothetical protein +FIG00818774 FIG00818776: hypothetical protein +FIG00818786 FIG00818787: hypothetical protein +FIG00818787 FIG00818788: hypothetical protein +FIG00818790 Orf351' +FIG00818792 FIG00818793: hypothetical protein +FIG00818793 FIG00818794: hypothetical protein +FIG00818799 FIG00818801: hypothetical protein +FIG00818804 FIG00818805: hypothetical protein +FIG00818805 FIG00818806: hypothetical protein +FIG00818809 FIG00818811: hypothetical protein +FIG00818813 FIG00818815: hypothetical protein +FIG00818816 FIG00818818: hypothetical protein +FIG00818819 flagellar hook-basal body complex subunit FliE +FIG00818822 FIG00818823: hypothetical protein +FIG00818823 uracil-xanthine permease +FIG00818824 ABC transporter substrate-binding protein - sugar transport +FIG00818830 type II site-specific deoxyribonuclease +FIG00818832 FIG00818833: hypothetical protein +FIG00818840 FIG00818842: hypothetical protein +FIG00818842 FIG00818843: hypothetical protein +FIG00818843 FIG00818848: hypothetical protein +FIG00818850 FIG00818854: hypothetical protein +FIG00818854 FIG00818855: hypothetical protein +FIG00818855 FIG00818856: hypothetical protein +FIG00818858 FIG00818862: hypothetical protein +FIG00818862 FIG00818863: hypothetical protein +FIG00818864 FIG00818865: hypothetical protein +FIG00818865 FIG00818866: hypothetical protein +FIG00818868 FIG00818869: hypothetical protein +FIG00818874 FIG00818875: hypothetical protein +FIG00818878 FIG00818879: hypothetical protein +FIG00818880 FIG00818881: hypothetical protein +FIG00818886 FIG00818887: hypothetical protein +FIG00818887 Putative cell wall binding repeat 2 +FIG00818890 FIG00818891: hypothetical protein +FIG00818891 Adenine specific DNA methylase +FIG00818892 FIG00818895: hypothetical protein +FIG00818895 COG3610: Uncharacterized conserved protein +FIG00818914 FIG00818915: hypothetical protein +FIG00818915 FIG00818917: hypothetical protein +FIG00818917 FIG00818918: hypothetical protein +FIG00818918 FIG00818920: hypothetical protein +FIG00818922 FIG00818923: hypothetical protein +FIG00818931 FIG00818932: hypothetical protein +FIG00818932 FIG00818933: hypothetical protein +FIG00818934 FIG00818935: hypothetical protein +FIG00818935 FIG00818937: hypothetical protein +FIG00818937 FIG00818941: hypothetical protein +FIG00818941 FIG00818942: hypothetical protein +FIG00818942 FIG00818944: hypothetical protein +FIG00818944 FIG00818946: hypothetical protein +FIG00818946 FIG00818949: hypothetical protein +FIG00818949 FIG00818952: hypothetical protein +FIG00818952 FIG00818955: hypothetical protein +FIG00818955 FIG00818956: hypothetical protein +FIG00818956 FIG00818957: hypothetical protein +FIG00818957 FIG00818959: hypothetical protein +FIG00818959 FIG00818961: hypothetical protein +FIG00818961 FIG00818963: hypothetical protein +FIG00818968 FIG00818971: hypothetical protein +FIG00818971 FIG00818972: hypothetical protein +FIG00818972 FIG00818973: hypothetical protein +FIG00818973 FIG00818976: hypothetical protein +FIG00818979 FIG00818980: hypothetical protein +FIG00818980 Putative ABC transport system membrane protein +FIG00818983 possible sedoheptulose 7-phosphate isomerase +FIG00818984 FIG00818990: hypothetical protein +FIG00818990 FIG00818991: hypothetical protein +FIG00819263 Methylated DNA-protein cysteine methyltransferase +FIG00819325 Probable osmotically inducible protein Y +FIG00819387 FIG00895136: hypothetical protein +FIG00819436 putative DNA-binding prophage protein +FIG00819609 FIG00819610: hypothetical protein +FIG00819974 FIG00819975: hypothetical protein +FIG00819975 FIG00819976: hypothetical protein +FIG00819976 FIG00819977: hypothetical protein +FIG00819977 FIG00819980: hypothetical protein +FIG00819980 FIG00819982: hypothetical protein +FIG00819982 FIG00819984: hypothetical protein +FIG00819984 Protein tyrosine phosphatase (EC 3.1.3.48) +FIG00819985 Iron-regulated heparin binding hemagglutinin HbhA (Adhesin) +FIG00819987 FIG00819989: hypothetical protein +FIG00819989 FIG00819990: hypothetical protein +FIG00819990 PROBABLE CONSERVED TRANSMEMBRANE PROTEIN RICH IN ALANINE AND ARGININE AND PROLINE +FIG00819991 FIG00819992: hypothetical protein +FIG00819992 FIG00819993: hypothetical protein +FIG00819996 FIG00819998: hypothetical protein +FIG00819998 MCE family protein of Mce E Subgroup +FIG00820000 FIG00995176: hypothetical protein +FIG00820001 FIG00821176: hypothetical protein +FIG00820002 FIG00820003: hypothetical protein +FIG00820003 FIG00820004: hypothetical protein +FIG00820004 FIG00820005: hypothetical protein +FIG00820005 FIG00820006: hypothetical protein +FIG00820006 RNA polymerase factor sigma-70 +FIG00820007 FIG00820008: hypothetical protein +FIG00820008 FIG00820010: hypothetical protein +FIG00820010 FIG00820011: hypothetical protein +FIG00820011 FIG00820014: hypothetical protein +FIG00820014 FIG00820016: hypothetical protein +FIG00820016 FIG00820017: hypothetical protein +FIG00820017 POSSIBLE OXIDOREDUCTASE +FIG00820021 FIG00820022: hypothetical protein +FIG00820022 Enoyl-CoA hydratase +FIG00820023 FIG00820024: hypothetical protein +FIG00820024 FIG00820025: hypothetical protein +FIG00820025 FIG00820026: hypothetical protein +FIG00820026 FIG00820028: hypothetical protein +FIG00820031 FIG00820035: hypothetical protein +FIG00820035 FIG00820038: hypothetical protein +FIG00820038 FIG00820040: hypothetical protein +FIG00820041 FIG00820044: hypothetical protein +FIG00820045 FIG00820046: hypothetical protein +FIG00820047 FIG00820048: hypothetical protein +FIG00820048 FIG00820050: hypothetical protein +FIG00820050 hypothetical protein +FIG00820052 FIG00820054: hypothetical protein +FIG00820054 FIG00820055: hypothetical protein +FIG00820055 FIG00820057: hypothetical protein +FIG00820057 FIG00820058: hypothetical protein +FIG00820058 FIG00820059: hypothetical protein +FIG00820061 FIG00820062: hypothetical protein +FIG00820062 FIG00820063: hypothetical protein +FIG00820063 FIG00820064: hypothetical protein +FIG00820064 FIG00820065: hypothetical protein +FIG00820065 FIG00820067: hypothetical protein +FIG00820067 FIG00820068: hypothetical protein +FIG00820069 FIG00820071: hypothetical protein +FIG00820071 FIG00820074: hypothetical protein +FIG00820078 FIG00820079: hypothetical protein +FIG00820079 FIG00820081: hypothetical protein +FIG00820081 FIG00820082: hypothetical protein +FIG00820082 FIG00820084: hypothetical protein +FIG00820084 FIG00820085: hypothetical protein +FIG00820085 FIG00820086: hypothetical protein +FIG00820086 FIG00820088: hypothetical protein +FIG00820088 FIG00820089: hypothetical protein +FIG00820089 FIG00820090: hypothetical protein +FIG00820090 FIG00820092: hypothetical protein +FIG00820092 FIG00820093: hypothetical protein +FIG00820093 FIG00820095: hypothetical protein +FIG00820096 FIG00820102: hypothetical protein +FIG00820102 FIG00820103: hypothetical protein +FIG00820103 FIG00820106: hypothetical protein +FIG00820108 FIG00820111: hypothetical protein +FIG00820111 FIG00820113: hypothetical protein +FIG00820113 FIG00820116: hypothetical protein +FIG00820116 FIG00820117: hypothetical protein +FIG00820117 PROBABLE NADPH QUINONE OXIDOREDUCTASE FADB4 (NADPH:QUINONE REDUCTASE) (ZETA-CRYSTALLIN) (EC 1.6.5.5) +FIG00820118 FIG00820119: hypothetical protein +FIG00820119 FIG00820120: hypothetical protein +FIG00820120 Membrane protein Rv3446c, component of Type VII secretion system ESX-4 +FIG00820122 FIG00820123: hypothetical protein +FIG00820123 FIG00820125: hypothetical protein +FIG00820125 FIG00820126: hypothetical protein +FIG00820126 FIG00820127: hypothetical protein +FIG00820129 4-coumarate--CoA ligase 1 (EC 6.2.1.12) +FIG00820130 FIG00820131: hypothetical protein +FIG00820131 FIG00820132: hypothetical protein +FIG00820132 FIG00820133: hypothetical protein +FIG00820133 FIG00820134: hypothetical protein +FIG00820136 FIG00820137: hypothetical protein +FIG00820137 FIG00820138: hypothetical protein +FIG00820138 FIG00820139: hypothetical protein +FIG00820139 Drugs-transport transmembrane ATP-binding protein ABC transporter +FIG00820141 FIG00820143: hypothetical protein +FIG00820143 FIG00820144: hypothetical protein +FIG00820145 FIG00820146: hypothetical protein +FIG00820146 FIG00820147: hypothetical protein +FIG00820147 FIG00820149: hypothetical protein +FIG00820153 FIG00820156: hypothetical protein +FIG00820156 FIG00820161: hypothetical protein +FIG00820162 Mycofactocin precursor +FIG00820164 FIG00820166: hypothetical protein +FIG00820168 FIG00820169: hypothetical protein +FIG00820169 FIG00820170: hypothetical protein +FIG00820170 FIG00820172: hypothetical protein +FIG00820172 FIG00820173: hypothetical protein +FIG00820176 FIG00820177: hypothetical protein +FIG00820178 FIG00820182: hypothetical protein +FIG00820182 FIG00820183: hypothetical protein +FIG00820183 Probable arabinosyltransferase B (EC 2.4.2.-) +FIG00820186 FIG00820187: hypothetical protein +FIG00820187 FIG00820188: hypothetical protein +FIG00820190 FIG00820191: hypothetical protein +FIG00820191 FIG00820194: hypothetical protein +FIG00820194 FIG00820195: hypothetical protein +FIG00820195 POSSIBLE MEMBRANE PROTEIN +FIG00820197 FIG00820198: hypothetical protein +FIG00820198 FIG00820199: hypothetical protein +FIG00820200 FIG00820201: hypothetical protein +FIG00820201 FIG00820202: hypothetical protein +FIG00820202 FIG00820204: hypothetical protein +FIG00820204 Integral membrane transport protein +FIG00820205 Twin-arginine translocation protein TatA +FIG00820206 FIG00820207: hypothetical protein +FIG00820207 FIG00820208: hypothetical protein +FIG00820208 FIG00820210: hypothetical protein +FIG00820211 FIG00820212: hypothetical protein +FIG00820212 FIG00820216: hypothetical protein +FIG00820216 FIG00820217: hypothetical protein +FIG00820217 FIG00820218: hypothetical protein +FIG00820218 FIG00820219: hypothetical protein +FIG00820219 Malonyl CoA-acyl carrier protein transacylase FabD2 +FIG00820220 Oxidoreductase, short-chain dehydrogenase/reductase family +FIG00820223 FIG00820224: hypothetical protein +FIG00820225 POSSIBLE LIPOPROTEIN PEPTIDASE LPQM +FIG00820226 FIG00820227: hypothetical protein +FIG00820227 FIG00820230: hypothetical protein +FIG00820230 FIG00820233: hypothetical protein +FIG00820233 FIG00820235: hypothetical protein +FIG00820235 FIG00820237: hypothetical protein +FIG00820237 FIG00820239: hypothetical protein +FIG00820239 FIG00820240: hypothetical protein +FIG00820240 FIG00820242: hypothetical protein +FIG00820242 MCE-associated transmembrane protein +FIG00820243 FIG00820244: hypothetical protein +FIG00820244 FIG00820247: hypothetical protein +FIG00820247 FIG00820249: hypothetical protein +FIG00820249 FIG00820250: hypothetical protein +FIG00820250 Phenyloxazoline synthase MbtB (EC 6.3.2.-) [mycobactin] siderophore +FIG00820251 FIG00820252: hypothetical protein +FIG00820252 FIG00820253: hypothetical protein +FIG00820253 FIG00820255: hypothetical protein +FIG00820255 Lipoprotein LprB +FIG00820256 FIG00820257: hypothetical protein +FIG00820258 FIG00820259: hypothetical protein +FIG00820259 FIG00820260: hypothetical protein +FIG00820260 FIG00820262: hypothetical protein +FIG00820262 Oxidoreductase, short-chain dehydrogenase/reductase family +FIG00820264 FIG00820266: hypothetical protein +FIG00820266 Single-strand DNA binding protein +FIG00820268 hypothetical protein +FIG00820270 FIG00820271: hypothetical protein +FIG00820271 ABC-type Mn2+ and Zn2+ transport systems, permease components +FIG00820273 FIG00820275: hypothetical protein +FIG00820277 FIG00820278: hypothetical protein +FIG00820280 FIG00996932: hypothetical protein +FIG00820281 FIG00820282: hypothetical protein +FIG00820283 FIG00820284: hypothetical protein +FIG00820285 FIG00820286: hypothetical protein +FIG00820286 FIG00820289: hypothetical protein +FIG00820289 DNA-methyltransferase +FIG00820290 FIG00820291: hypothetical protein +FIG00820293 FIG00820294: hypothetical protein +FIG00820294 FIG00820297: hypothetical protein +FIG00820297 FIG00820298: hypothetical protein +FIG00820298 FIG00820302: hypothetical protein +FIG00820303 FIG00820304: hypothetical protein +FIG00820304 FIG00820305: hypothetical protein +FIG00820305 FIG00820306: hypothetical protein +FIG00820306 FIG00820307: hypothetical protein +FIG00820307 FIG00820308: hypothetical protein +FIG00820308 FIG00820309: hypothetical protein +FIG00820309 FIG00820310: hypothetical protein +FIG00820310 FIG00820311: hypothetical protein +FIG00820311 hypothetical protein +FIG00820317 FIG00820318: hypothetical protein +FIG00820318 FIG00820319: hypothetical protein +FIG00820319 FIG00820321: hypothetical protein +FIG00820321 PROBABLE CONSERVED LIPOPROTEIN LPQD +FIG00820322 FIG00820323: hypothetical protein +FIG00820323 FIG00820324: hypothetical protein +FIG00820324 Protein EspG2, component of Type VII secretion system ESX-2 +FIG00820325 FIG00997866: hypothetical protein +FIG00820327 Hypothetical protein Rv0349 +FIG00820329 FIG00820330: hypothetical protein +FIG00820330 FIG00820332: hypothetical protein +FIG00820332 Esterase, secreted fibronectin-binding protein antigen 85-B FbpB +FIG00820334 FIG00820335: hypothetical protein +FIG00820336 VapC6 antibacterial toxin protein +FIG00820337 FIG00820338: hypothetical protein +FIG00820338 FIG00820339: hypothetical protein +FIG00820343 FIG00820344: hypothetical protein +FIG00820347 FIG00820351: hypothetical protein +FIG00820351 FIG00820353: hypothetical protein +FIG00820353 FIG00820354: hypothetical protein +FIG00820354 FIG00820355: hypothetical protein +FIG00820355 FIG00820356: hypothetical protein +FIG00820356 FIG00820357: hypothetical protein +FIG00820357 FIG00820358: hypothetical protein +FIG00820358 FIG00820359: hypothetical protein +FIG00820359 FIG00820360: hypothetical protein +FIG00820360 FIG00820361: hypothetical protein +FIG00820362 FIG00820363: hypothetical protein +FIG00820364 FIG00820366: hypothetical protein +FIG00820366 FIG00820367: hypothetical protein +FIG00820367 FIG00820368: hypothetical protein +FIG00820368 FIG00820369: hypothetical protein +FIG00820370 FIG00820371: hypothetical protein +FIG00820371 FIG00995613: hypothetical protein +FIG00820378 FIG00820380: hypothetical protein +FIG00820380 FIG00820381: hypothetical protein +FIG00820381 FIG00820382: hypothetical protein +FIG00820382 FIG00820383: hypothetical protein +FIG00820383 FIG00820384: hypothetical protein +FIG00820384 FIG00820385: hypothetical protein +FIG00820385 Limonene-1,2-epoxide hydrolase (EC 3.3.2.8) +FIG00820387 FIG00820388: hypothetical protein +FIG00820388 FIG00820390: hypothetical protein +FIG00820391 Sugar phosphate isomerases/epimerases +FIG00820392 FIG00820394: hypothetical protein +FIG00820394 ESAT-6-like protein EsxC +FIG00820395 FIG00820397: hypothetical protein +FIG00820397 FIG00820398: hypothetical protein +FIG00820401 FIG00820402: hypothetical protein +FIG00820402 FIG00820405: hypothetical protein +FIG00820405 FIG00820406: hypothetical protein +FIG00820406 FIG00820409: hypothetical protein +FIG00820409 FIG00820410: hypothetical protein +FIG00820410 FIG025412: hypothetical protein +FIG00820411 FIG004853: possible toxin to DivIC +FIG00820412 FIG00820414: hypothetical protein +FIG00820414 FIG00820415: hypothetical protein +FIG00820415 PE family protein +FIG00820419 FIG00993990: hypothetical protein +FIG00820423 FIG00820425: hypothetical protein +FIG00820425 FIG00820427: hypothetical protein +FIG00820427 3beta-hydroxy-Delta5-steroid dehydrogenase (EC 1.1.1.145) +FIG00820429 FIG00820431: hypothetical protein +FIG00820434 FIG00820436: hypothetical protein +FIG00820440 Acetyl-CoA acetyltransferase +FIG00820442 FIG00820444: hypothetical protein +FIG00820444 FIG00820445: hypothetical protein +FIG00820445 FIG00820447: hypothetical protein +FIG00820448 FIG00820450: hypothetical protein +FIG00820450 FIG00820451: hypothetical protein +FIG00820455 FIG00820456: hypothetical protein +FIG00820458 FIG00820459: hypothetical protein +FIG00820459 FIG00820460: hypothetical protein +FIG00820460 Putative S-adenosyl-L-methionine-dependent methyltransferase (EC 2.1.1.-) +FIG00820463 FIG00820464: hypothetical protein +FIG00820464 Enoyl-CoA hydratase/isomerase +FIG00820465 ESAT-6-like protein EsxL +FIG00820469 FIG00820470: hypothetical protein +FIG00820471 FIG00820472: hypothetical protein +FIG00820472 FIG00820473: hypothetical protein +FIG00820474 FIG00820475: hypothetical protein +FIG00820475 FIG00820476: hypothetical protein +FIG00820476 FIG00820477: hypothetical protein +FIG00820478 FIG00820480: hypothetical protein +FIG00820480 FIG00820482: hypothetical protein +FIG00820482 FIG00820486: hypothetical protein +FIG00820486 Acetyl hydrolase MbtJ +FIG00820489 FIG00820492: hypothetical protein +FIG00820492 FIG00820494: hypothetical protein +FIG00820494 MCE family protein of Mce A Subgroup +FIG00820495 FIG00820497: hypothetical protein +FIG00820497 FIG00820498: hypothetical protein +FIG00820498 FIG00820499: hypothetical protein +FIG00820499 FIG00820501: hypothetical protein +FIG00820501 FIG00820503: hypothetical protein +FIG00820507 Cutinase +FIG00820514 FIG00820518: hypothetical protein +FIG00820518 FIG00820520: hypothetical protein +FIG00820522 FIG00820523: hypothetical protein +FIG00820523 FIG00821425: hypothetical protein +FIG00820524 FIG00820525: hypothetical protein +FIG00820525 FIG00820526: hypothetical protein +FIG00820526 FIG00820527: hypothetical protein +FIG00820527 FIG00999418: hypothetical protein +FIG00820528 FIG00820531: hypothetical protein +FIG00820531 FIG00820532: hypothetical protein +FIG00820533 FIG00820534: hypothetical protein +FIG00820536 (3R)-hydroxyacyl-ACP dehydratase subunit HadC +FIG00820537 FIG00820541: hypothetical protein +FIG00820541 FIG00820542: hypothetical protein +FIG00820542 FIG00820543: hypothetical protein +FIG00820544 FIG00820545: hypothetical protein +FIG00820545 FIG00820548: hypothetical protein +FIG00820548 FIG00820549: hypothetical protein +FIG00820549 FIG00820551: hypothetical protein +FIG00820553 Putative secreted protein +FIG00820555 FIG00820556: hypothetical protein +FIG00820556 FIG00820558: hypothetical protein +FIG00820564 FIG00820565: hypothetical protein +FIG00820565 FIG00820568: hypothetical protein +FIG00820568 FIG00820570: hypothetical protein +FIG00820570 FIG00820572: hypothetical protein +FIG00820572 FIG00820573: hypothetical protein +FIG00820573 FIG00820574: hypothetical protein +FIG00820575 FIG00820576: hypothetical protein +FIG00820583 FIG00820584: hypothetical protein +FIG00820584 FIG00820585: hypothetical protein +FIG00820585 FIG00820125: hypothetical protein +FIG00820589 FIG00820590: hypothetical protein +FIG00820590 FIG00820592: hypothetical protein +FIG00820593 FIG00820595: hypothetical protein +FIG00820596 FIG00820598: hypothetical protein +FIG00820598 FIG00820599: hypothetical protein +FIG00820599 FIG00820600: hypothetical protein +FIG00820601 FIG00820602: hypothetical protein +FIG00820603 FIG00995176: hypothetical protein +FIG00820604 FIG00820605: hypothetical protein +FIG00820606 FIG00820608: hypothetical protein +FIG00820608 FIG00820609: hypothetical protein +FIG00820609 Long-chain fatty-acid-CoA ligase (EC 6.2.1.3), Mycobacterial subgroup FadD16 +FIG00820613 CrcB protein +FIG00820616 FIG00820617: hypothetical protein +FIG00820617 FIG00820618: hypothetical protein +FIG00820618 FIG00820622: hypothetical protein +FIG00820622 FIG00820623: hypothetical protein +FIG00820623 FIG00820624: hypothetical protein +FIG00820624 FIG00820627: hypothetical protein +FIG00820627 FIG00820629: hypothetical protein +FIG00820629 FIG00820630: hypothetical protein +FIG00820630 hypothetical protein +FIG00820632 FIG00820633: hypothetical protein +FIG00820635 FIG00820636: hypothetical protein +FIG00820636 Secreted protein EspA, component of Type VII secretion system ESX-1 +FIG00820637 FIG00820637:: Acyl dehydratase +FIG00820639 FIG00820640: hypothetical protein +FIG00820640 FIG00820641: hypothetical protein +FIG00820641 FIG00820643: hypothetical protein +FIG00820644 FIG00820646: hypothetical protein +FIG00820646 FIG00820647: hypothetical protein +FIG00820647 FIG00820648: hypothetical protein +FIG00820648 CAIB/BAIF family protein +FIG00820650 FIG00820652: hypothetical protein +FIG00820652 FIG00820653: hypothetical protein +FIG00820653 FIG00820654: hypothetical protein +FIG00820654 FIG00820655: hypothetical protein +FIG00820656 FIG00820657: hypothetical protein +FIG00820657 FIG00820658: hypothetical protein +FIG00820658 FIG00820660: hypothetical protein +FIG00820660 FIG00820662: hypothetical protein +FIG00820663 FIG00820664: hypothetical protein +FIG00820666 FIG00820667: hypothetical protein +FIG00820667 FIG00820669: hypothetical protein +FIG00820669 MCE family protein of Mce D Subgroup +FIG00820670 FIG00820671: hypothetical protein +FIG00820671 FIG00820672: hypothetical protein +FIG00820672 FIG00820673: hypothetical protein +FIG00820674 Ferredoxin Rv1786 +FIG00820675 FIG00820677: hypothetical protein +FIG00820677 FIG00820679: hypothetical protein +FIG00820679 FIG00820680: hypothetical protein +FIG00820680 FIG00820681: hypothetical protein +FIG00820681 FIG00820682: hypothetical protein +FIG00820682 FIG00820684: hypothetical protein +FIG00820690 FIG00820691: hypothetical protein +FIG00820691 FIG00820693: hypothetical protein +FIG00820693 FIG00820694: hypothetical protein +FIG00820694 FIG00820695: hypothetical protein +FIG00820696 FIG00820697: hypothetical protein +FIG00820697 FIG00820698: hypothetical protein +FIG00820698 FIG00820699: hypothetical protein +FIG00820699 FIG00820700: hypothetical protein +FIG00820700 FIG00820701: hypothetical protein +FIG00820703 FIG00820704: hypothetical protein +FIG00820704 FIG00820705: hypothetical protein +FIG00820706 FIG00820708: hypothetical protein +FIG00820709 FIG00820710: hypothetical protein +FIG00820711 FIG00820712: hypothetical protein +FIG00820712 FIG00820713: hypothetical protein +FIG00820713 FIG00820714: hypothetical protein +FIG00820714 membrane protein, MmpL family +FIG00820715 FIG00820716: hypothetical protein +FIG00820716 LpqJ +FIG00820719 FIG00820720: hypothetical protein +FIG00820720 FIG00820722: hypothetical protein +FIG00820722 FIG00820725: hypothetical protein +FIG00820725 FIG00820726: hypothetical protein +FIG00820727 FIG00820728: hypothetical protein +FIG00820728 FIG00820729: hypothetical protein +FIG00820729 Luciferase family protein +FIG00820731 FIG00820733: hypothetical protein, Rv0207c +FIG00820733 FIG00820734: hypothetical protein +FIG00820734 FIG00820735: hypothetical protein +FIG00820739 FIG01121868: secreted protein +FIG00820740 hypothetical protein +FIG00820742 FIG00820743: hypothetical protein +FIG00820743 FIG00820744: hypothetical protein +FIG00820744 FIG00820746: hypothetical protein +FIG00820753 FIG00820754: hypothetical protein +FIG00820760 Phospholipase D family protein +FIG00820761 FIG00820763: hypothetical protein +FIG00820763 FIG00820764: hypothetical protein +FIG00820764 FIG00820765: hypothetical protein +FIG00820765 FIG00820766: hypothetical protein +FIG00820766 FIG00820767: hypothetical protein +FIG00820768 FIG00820769: hypothetical protein +FIG00820769 FIG00820770: hypothetical membrane protein +FIG00820770 FIG00820771: hypothetical protein +FIG00820771 FIG00820772: hypothetical protein +FIG00820774 FIG00820775: hypothetical protein +FIG00820778 FIG00820781: hypothetical protein +FIG00820781 FIG00820782: hypothetical protein +FIG00820783 FIG00820785: hypothetical protein +FIG00820785 FIG00820786: hypothetical protein +FIG00820786 FIG00820787: hypothetical protein +FIG00820787 FIG00820789: hypothetical protein +FIG00820789 FIG00820791: hypothetical protein +FIG00820791 FIG00820792: hypothetical protein +FIG00820792 FIG00820793: hypothetical protein +FIG00820796 FIG00820798: hypothetical protein +FIG00820798 FIG00820800: hypothetical protein +FIG00820800 FIG00820804: hypothetical protein +FIG00820804 enoyl-CoA hydratase/isomerase +FIG00820805 FIG00820809: hypothetical protein +FIG00820809 PROBABLE LIPOPROTEIN LPPP +FIG00820810 FIG00820811: hypothetical protein +FIG00820811 Esat-6 like protein EsxE +FIG00820812 FIG00820815: hypothetical protein +FIG00820815 FIG00820816: hypothetical protein +FIG00820817 FIG00820818: hypothetical protein +FIG00820818 FIG00820819: hypothetical protein +FIG00820819 FIG00820821: hypothetical protein +FIG00820823 FIG00820824: hypothetical protein +FIG00820824 FIG00820825: hypothetical protein +FIG00820825 FIG00820826: hypothetical protein +FIG00820827 Partial REP13E12 repeat protein +FIG00820828 FIG00820829: hypothetical protein +FIG00820829 HNH endonuclease domain protein +FIG00820830 FIG00820831: hypothetical protein +FIG00820831 F420-dependent N(5),N(10)-methylenetetrahydromethanopterin reductase (EC 1.5.99.11) +FIG00820832 FIG00820833: hypothetical protein +FIG00820833 FIG00820835: hypothetical protein +FIG00820835 FIG00820839: hypothetical protein +FIG00820839 Limonene-1,2-epoxide hydrolase +FIG00820841 FIG00820842: hypothetical protein +FIG00820842 FIG00820845: hypothetical protein +FIG00820845 FIG00820846: hypothetical protein +FIG00820846 FIG00820847: hypothetical protein +FIG00820848 FIG01334132: Putative conserved alanine, valine and leucine rich integral membrane protein +FIG00820849 FIG00820850: hypothetical protein +FIG00820850 FIG00820852: hypothetical protein +FIG00820852 hypothetical protein Rv2034 +FIG00820853 FIG00820854: hypothetical protein +FIG00820854 FIG00820856: hypothetical protein +FIG00820856 Probable polyketide synthase pks7 +FIG00820859 FIG00820860: hypothetical protein +FIG00820860 FIG00820861: hypothetical protein +FIG00820861 FIG00820863: hypothetical protein +FIG00820865 FIG00820867: hypothetical protein +FIG00820867 FIG00820868: hypothetical protein +FIG00820868 FIG00820869: hypothetical protein +FIG00820872 FIG00820873: hypothetical protein +FIG00820874 FIG00820875: hypothetical protein +FIG00820875 FIG00821404: hypothetical protein +FIG00820877 FIG00820878: hypothetical protein +FIG00820878 Acetyltransferase, GNAT family +FIG00820883 MoxR-like ATPase +FIG00820884 FIG00820885: hypothetical protein +FIG00820885 FIG00820886: hypothetical protein +FIG00820886 FIG00820887: hypothetical protein +FIG00820887 FIG00820889: hypothetical protein +FIG00820889 FIG00820890: hypothetical protein +FIG00820893 FIG00820894: hypothetical protein +FIG00820894 FIG00820895: hypothetical protein +FIG00820897 FIG00820898: hypothetical protein +FIG00820898 FIG00820899: hypothetical protein +FIG00820899 FIG00820900: hypothetical protein +FIG00820900 FIG00820902: hypothetical protein +FIG00820903 FIG00820904: hypothetical protein +FIG00820904 FIG00820905: hypothetical protein +FIG00820905 FIG00820906: hypothetical protein +FIG00820906 FIG00820907: hypothetical protein +FIG00820910 FIG00820911: hypothetical protein +FIG00820911 FIG00820912: hypothetical protein +FIG00820912 FIG00820913: hypothetical protein +FIG00820913 FIG00820914: hypothetical protein +FIG00820914 FIG00820917: hypothetical protein +FIG00820917 FIG00820918: hypothetical protein +FIG00820921 FIG00820922: hypothetical protein +FIG00820924 FIG00820925: hypothetical protein +FIG00820925 FIG00820926: hypothetical protein +FIG00820926 FIG00820927: hypothetical protein +FIG00820927 FIG00820928: hypothetical protein +FIG00820928 FIG00820929: hypothetical protein +FIG00820929 FIG00820930: hypothetical protein +FIG00820930 FIG00820932: hypothetical protein +FIG00820932 FIG00820933: hypothetical protein +FIG00820933 HtrA protease/chaperone family protein, Rv0983 homolog +FIG00820934 FIG00820935: hypothetical protein +FIG00820935 Acyl-CoA dehydrogenase (EC 1.3.8.1), Mycobacterial subgroup FadE34 +FIG00820936 FIG00820937: hypothetical protein +FIG00820937 FIG00820938: hypothetical protein +FIG00820938 FIG00820939: hypothetical protein +FIG00820939 FIG00820940: hypothetical protein +FIG00820940 FIG00820941: hypothetical protein +FIG00820941 FIG00820944: hypothetical protein +FIG00820944 FIG00820946: hypothetical protein +FIG00820946 VapC11 antibacterial toxin protein +FIG00820947 FIG00820948: hypothetical protein +FIG00820948 VapB14 protein (antitoxin to VapC14) +FIG00820949 FIG00820951: hypothetical protein +FIG00820951 FIG00820952: hypothetical protein +FIG00820952 FIG00820953: hypothetical protein +FIG00820953 Lipoprotein LppB +FIG00820954 FIG00820956: hypothetical protein +FIG00820956 FIG023076: hypothetical protein in PPE gene cluster +FIG00820962 FIG00820963: hypothetical protein +FIG00820963 FIG00820963: Predicted deacetylase +FIG00820965 Probable dipeptidase PepE (EC 3.4.13.-) +FIG00820967 FIG00820970: hypothetical protein +FIG00820970 FIG00820972: hypothetical protein +FIG00820972 FIG00820973: hypothetical protein +FIG00820973 FIG00820978: hypothetical protein +FIG00820978 FIG00820982: hypothetical protein +FIG00820982 FIG00820983: hypothetical protein +FIG00820983 FIG00820984: hypothetical protein +FIG00820987 FIG00820989: hypothetical protein +FIG00820989 FIG00820990: hypothetical protein +FIG00820991 FIG00820992: hypothetical protein +FIG00820993 FIG00820994: hypothetical protein +FIG00820994 FIG00820997: hypothetical protein +FIG00820997 FIG00821000: hypothetical protein +FIG00821000 FIG00997706: hypothetical protein +FIG00821001 FIG235734: hypothetical protein +FIG00821012 FIG00821014: hypothetical protein +FIG00821014 FIG00821015: hypothetical protein +FIG00821015 FIG00821016: hypothetical protein +FIG00821016 LOW MOLECULAR WEIGHT T-CELL ANTIGEN TB8.4 +FIG00821018 Hydrogenase assembly chaperone HypC/HupF +FIG00821019 FIG00821020: hypothetical protein +FIG00821020 FIG00821021: hypothetical protein +FIG00821021 FIG00821028: hypothetical protein +FIG00821028 FIG00821032: hypothetical protein +FIG00821032 FIG00821033: hypothetical protein +FIG00821033 FIG00821034: hypothetical protein +FIG00821034 FIG00821036: hypothetical protein +FIG00821036 FIG00821038: hypothetical protein +FIG00821040 FIG00821041: hypothetical protein +FIG00821041 FIG00821042: hypothetical protein +FIG00821042 FIG00821043: hypothetical protein +FIG00821047 FIG00821048: hypothetical protein +FIG00821048 Methyltransferase domain +FIG00821051 FIG00821052: hypothetical protein +FIG00821052 FIG00821053: hypothetical protein +FIG00821054 FIG00821055: hypothetical protein +FIG00821055 FIG00821059: hypothetical protein +FIG00821059 FIG00821060: hypothetical protein +FIG00821060 FIG00821061: hypothetical protein +FIG00821065 FIG00821066: hypothetical protein +FIG00821066 FIG00821068: hypothetical protein +FIG00821068 FIG00821069: hypothetical protein +FIG00821069 FIG00821070: hypothetical protein +FIG00821070 FIG00821071: hypothetical protein +FIG00821072 FIG00821073: hypothetical protein +FIG00821073 FIG00821074: hypothetical protein +FIG00821076 FIG00821078: hypothetical protein +FIG00821078 FIG00821084: hypothetical protein +FIG00821086 FIG00821087: hypothetical protein +FIG00821088 FIG00821089: hypothetical protein +FIG00821089 FIG00821091: hypothetical protein +FIG00821091 FIG00821093: hypothetical protein +FIG00821093 FIG00821096: hypothetical protein +FIG00821096 FIG00821098: hypothetical protein +FIG00821098 VapB21 protein (antitoxin to VapC21) +FIG00821100 FIG00821101: hypothetical protein +FIG00821101 Glycoside hydrolase family protein +FIG00821107 FIG00821108: hypothetical protein +FIG00821108 FIG00821109: hypothetical protein +FIG00821110 FIG00821111: hypothetical protein +FIG00821111 FIG00821113: hypothetical protein +FIG00821113 VapB15 protein (antitoxin to VapC15) +FIG00821114 FIG00821115: hypothetical protein +FIG00821116 FIG00821119: hypothetical protein +FIG00821119 FIG00821120: hypothetical protein +FIG00821128 VapC8 antibacterial toxin protein +FIG00821129 Protein EspL, component of Type VII secretion system ESX-1 +FIG00821130 FIG00821131: hypothetical protein +FIG00821131 FIG00821176: hypothetical protein +FIG00821133 FIG00821135: hypothetical protein +FIG00821135 FIG00821136: hypothetical protein +FIG00821136 FIG00821137: secreted protein +FIG00821137 FIG00821138: hypothetical protein +FIG00821138 ATP-dependent efflux pump essential for phthiocerol dimycocerosates translocation, ATP-binding protein DrrA-like +FIG00821140 Two component system sensor histidine kinase +FIG00821141 2-oxopent-4-dienoate hydratase +FIG00821142 FIG00821143: hypothetical protein +FIG00821143 FIG00821149: hypothetical protein +FIG00821149 FIG00821151: hypothetical protein +FIG00821151 VapB17 protein (antitoxin to VapC17) +FIG00821153 ParD1 protein (antitoxin to ParE1) +FIG00821155 Polyketide synthetase MbtD +FIG00821158 FIG00821159: hypothetical protein +FIG00821160 FIG00821164: hypothetical protein +FIG00821164 FIG00821167: hypothetical protein +FIG00821167 FIG00821170: hypothetical protein +FIG00821170 FIG00821171: hypothetical protein +FIG00821171 MCE family protein of Mce F Subgroup +FIG00821172 FIG00821173: hypothetical protein +FIG00821175 FIG00821176: hypothetical protein +FIG00821178 FIG01000472: hypothetical protein +FIG00821179 (3R)-hydroxyacyl-ACP dehydratase subunit HadA +FIG00821187 FIG00821188: hypothetical protein +FIG00821190 FIG00821191: hypothetical protein +FIG00821192 FIG00821193: hypothetical protein +FIG00821193 FIG00821194: hypothetical protein +FIG00821194 FIG00821195: hypothetical protein +FIG00821195 FIG00821196: hypothetical protein +FIG00821197 FIG00821199: hypothetical protein +FIG00821199 FIG00821200: hypothetical protein +FIG00821200 VapC10 antibacterial toxin protein +FIG00821201 FIG00821203: hypothetical protein +FIG00821203 FIG00821204: hypothetical protein +FIG00821204 3-hydroxyisobutyrate dehydrogenase (EC 1.1.1.31) +FIG00821210 FIG00821212: hypothetical protein +FIG00821212 hypothetical protein +FIG00821213 FIG00821214: hypothetical protein +FIG00821214 FIG00821215: hypothetical protein +FIG00821215 FIG00821218: hypothetical protein +FIG00821218 FIG00821219: hypothetical protein +FIG00821220 FIG00821221: hypothetical protein +FIG00821221 FIG00821224: hypothetical protein +FIG00821224 FIG00821226: hypothetical protein +FIG00821228 O-methyltransferase +FIG00821233 FIG00821234: hypothetical protein +FIG00821234 FIG00821235: hypothetical protein +FIG00821235 FIG00821236: hypothetical protein +FIG00821236 FIG00821239: hypothetical protein +FIG00821239 FIG00821242: hypothetical protein +FIG00821242 FIG00821243: hypothetical protein +FIG00821243 FIG037376: hypothetical protein +FIG00821246 FIG00821247: hypothetical protein +FIG00821247 VapB6 protein (antitoxin to VapC6) +FIG00821259 Oxidoreductase, short-chain dehydrogenase/reductase family +FIG00821260 FIG00821261: hypothetical protein +FIG00821261 FIG00821262: hypothetical protein +FIG00821262 FIG00821263: hypothetical protein +FIG00821263 FIG00821266: hypothetical protein +FIG00821266 COG0714: MoxR-like ATPases +FIG00821267 Possible ESAT-6 like protein EsxF +FIG00821270 FIG00821271: hypothetical protein +FIG00821274 FIG00821277: hypothetical protein +FIG00821277 FIG00821281: hypothetical protein +FIG00821281 FIG00821282: hypothetical protein +FIG00821283 FIG00821284: hypothetical protein +FIG00821284 FIG00821285: hypothetical protein +FIG00821286 FIG00821287: hypothetical protein +FIG00821287 FIG00821288: hypothetical protein +FIG00821288 FIG00821290: hypothetical protein +FIG00821290 FIG00821291: hypothetical protein +FIG00821291 FIG00821293: hypothetical protein +FIG00821293 MCE family protein of Mce C Subgroup +FIG00821294 Cytochrome P450 124 +FIG00821297 Two-component sensor histidine kinase +FIG00821299 FIG00821302: hypothetical protein +FIG00821303 FIG00821305: hypothetical protein +FIG00821305 Regulator protein EspR, component of Type VII secretion system ESX-1 +FIG00821306 FIG00821308: hypothetical protein +FIG00821308 FIG00821309: hypothetical protein +FIG00821311 OB-fold nucleic acid binding amino acid transporter +FIG00821312 FIG00821313: hypothetical protein +FIG00821313 Metal cation transporter p-type ATPase a +FIG00821316 FIG00821319: hypothetical protein +FIG00821319 FIG00821320: hypothetical protein +FIG00821320 FIG00821321: hypothetical protein +FIG00821322 FIG00821324: hypothetical protein +FIG00821324 FIG00821326: hypothetical protein +FIG00821326 FIG00821328: hypothetical protein +FIG00821328 FIG00821329: hypothetical protein +FIG00821329 FIG00821330: hypothetical protein +FIG00821330 Phthiocerol/phthiodiolone dimycocerosyl transferase PapA5 (EC 2.3.1.-) +FIG00821331 FIG00821333: hypothetical protein +FIG00821337 Chitinase-related protein +FIG00821340 FIG00821341: hypothetical protein +FIG00821345 FIG00821346: hypothetical protein +FIG00821346 FIG00821347: hypothetical protein +FIG00821347 FIG00821350: hypothetical protein +FIG00821350 FIG00821351: hypothetical protein +FIG00821351 FIG00821357: hypothetical protein +FIG00821357 Rieske [2Fe-2S] domain protein +FIG00821359 FIG00821360: hypothetical protein +FIG00821361 FIG00821362: hypothetical protein +FIG00821362 FIG00821363: hypothetical protein +FIG00821363 FIG00821364: hypothetical protein +FIG00821364 Precollagen-NG +FIG00821366 FIG00821367: hypothetical protein +FIG00821370 FIG00821372: hypothetical protein +FIG00821372 VapC14 antibacterial toxin protein +FIG00821374 FIG00821375: hypothetical protein +FIG00821375 FIG00821376: hypothetical protein +FIG00821376 Probable dehydrogenase +FIG00821378 FIG00823130: hypothetical protein +FIG00821379 ESAT-6-like protein EsxK +FIG00821381 FIG00821383: hypothetical protein +FIG00821383 FIG00821384: hypothetical protein +FIG00821384 FIG00821388: hypothetical protein +FIG00821388 FIG00821389: hypothetical protein +FIG00821389 FIG00821390: hypothetical protein +FIG00821390 FIG00821392: hypothetical protein +FIG00821392 FIG00821394: hypothetical protein +FIG00821396 Methyltransferase (EC 2.1.1.-) +FIG00821398 FIG00821399: hypothetical protein +FIG00821399 FIG00821400: hypothetical protein +FIG00821400 FIG00821402: hypothetical protein +FIG00821403 FIG00821404: hypothetical protein +FIG00821404 FIG00821405: hypothetical protein +FIG00821407 FIG00821408: hypothetical protein +FIG00821408 FIG00821410: hypothetical protein +FIG00821410 FIG00998915: membrane protein +FIG00821414 FIG00821415: hypothetical protein +FIG00821415 hypothetical protein +FIG00821416 VapC17 antibacterial toxin protein +FIG00821417 FIG00821418: hypothetical protein +FIG00821419 FIG00821420: hypothetical protein +FIG00821424 FIG00821425: hypothetical protein +FIG00821425 FIG00821427: hypothetical protein +FIG00821427 FIG00821430: hypothetical protein +FIG00821430 FIG00821431: hypothetical protein +FIG00821431 hypothetical protein +FIG00821434 FIG00821436: hypothetical protein +FIG00821436 FIG00821437: hypothetical protein +FIG00821437 FIG00821438: hypothetical protein +FIG00821438 FIG00821439: hypothetical protein +FIG00821439 FIG00821440: hypothetical protein +FIG00821441 FIG00821442: hypothetical protein +FIG00821445 FIG00821446: hypothetical protein +FIG00821446 FIG00821447: hypothetical protein +FIG00821452 FIG00821454: hypothetical protein +FIG00821454 PROBABLE MONOOXYGENASE (EC 1.-.-.-) +FIG00821455 FIG00821456: hypothetical protein +FIG00821456 """Glycolate oxidase, subunit GlcD""" +FIG00821457 FIG00821458: hypothetical protein +FIG00821458 FIG00821460: hypothetical protein +FIG00821460 FIG00821462: hypothetical protein +FIG00821462 FIG00821465: hypothetical protein +FIG00821466 FIG00821467: hypothetical protein +FIG00821469 FIG00821470: hypothetical protein +FIG00821470 Thiopurine S-methyltransferase (Tpmt) superfamily protein +FIG00821471 YibE/F family membrane protein +FIG00821472 Amidohydrolase 2 +FIG00821473 FIG00821474: hypothetical protein +FIG00821474 COG1872 +FIG00821477 possible membrane protein +FIG00821478 FIG00821480: hypothetical protein +FIG00821483 Esterase LipW +FIG00821484 FIG00821485: hypothetical protein +FIG00821485 FIG00821487: hypothetical protein +FIG00821488 FIG00821489: hypothetical protein +FIG00821490 FIG00821491: hypothetical protein +FIG00821496 FIG00821497: hypothetical protein +FIG00821497 FIG00821498: hypothetical protein +FIG00821498 FIG00821499: hypothetical protein +FIG00821499 Acyl-CoA dehydrogenase +FIG00821501 FIG00821502: hypothetical protein +FIG00821502 FIG00821503: hypothetical protein +FIG00821503 FIG00821505: hypothetical protein +FIG00821505 FIG021250: possible hydrolase +FIG00821507 FIG00821508: hypothetical protein +FIG00821511 FIG00821513: hypothetical protein +FIG00821513 FIG00821514: hypothetical protein +FIG00821514 FIG00821515: hypothetical protein +FIG00821515 FIG00821517: hypothetical protein +FIG00821517 FIG00821519: hypothetical protein +FIG00821519 FIG00821520: hypothetical protein +FIG00821520 FIG00821521: hypothetical protein +FIG00821521 FIG00821522: hypothetical protein +FIG00821522 FIG00821524: hypothetical protein +FIG00821524 FIG00821525: hypothetical protein +FIG00821525 hypothetical protein +FIG00821527 FIG033285: Conserved MCE associated transmembrane protein +FIG00821532 FIG00821533: hypothetical protein +FIG00821533 FIG00821541: hypothetical protein +FIG00821541 MazE4 protein (antitoxin to MazF4) +FIG00821542 FIG00821544: hypothetical protein +FIG00821544 FIG00821545: hypothetical protein +FIG00821545 FIG00821546: hypothetical protein +FIG00821546 FIG00821548: hypothetical protein +FIG00821548 FIG00821549: hypothetical protein +FIG00821551 FIG00821552: hypothetical protein +FIG00821552 FIG00821553: hypothetical protein +FIG00821556 FIG00821557: hypothetical protein +FIG00821557 Lipoprotein LppF +FIG00821559 FIG00821560: hypothetical protein +FIG00821560 FIG00821562: hypothetical protein +FIG00821562 FIG00821563: hypothetical protein +FIG00821563 FIG00821564: hypothetical protein +FIG00821566 Uncharacterized protein Mb2590 +FIG00821569 FIG00821571: hypothetical protein +FIG00821571 FIG00821576: hypothetical protein +FIG00821576 FIG00821577: hypothetical protein +FIG00821577 FIG00821579: hypothetical protein +FIG00821579 FIG00821580: hypothetical protein +FIG00821581 FIG00821582: hypothetical protein +FIG00821585 FIG00821587: hypothetical protein +FIG00821587 FIG00821588: hypothetical protein +FIG00821588 Glycosyl transferase, group 1 family protein +FIG00821589 FIG00821590: hypothetical protein +FIG00821590 FIG00821592: hypothetical protein +FIG00821592 FIG00821593: hypothetical protein +FIG00821596 FIG00821598: hypothetical protein +FIG00821598 CONSERVED HYPOTHETICAL ALA-, PRO-RICH PROTEIN +FIG00821600 FIG00821602: hypothetical protein +FIG00821602 FIG00821604: hypothetical protein +FIG00821604 L-Proline/Glycine betaine transporter ProP +FIG00821605 FIG00821607: hypothetical protein +FIG00821607 FIG00821608: hypothetical protein +FIG00821608 FIG00821610: hypothetical protein +FIG00821610 Pimeloyl-CoA dehydrogenase, small subunit +FIG00821613 (MTCY24G1.02), len: 496 aa, Probable polyketide synthase, almost identical to G560508 PKS002B (495 aa), fasta scores, opt: 3270, E(): 0, (99.6% identity in 496 aa overlap); contains PS00606 Beta-ketoacyl synthases active site; similar to MTCY338.20 (49.9% identity in 465 aa overlap) and MTCY24G1.09 (50.2% identity in 454 aa overlap) and MTCY22H8.03 (47.6% identity in 437 aa overlap) +FIG00821617 Heat shock protein 22.5 (Hsp22.5) +FIG00821620 FIG00821624: hypothetical protein +FIG00821624 FIG00821625: hypothetical protein +FIG00821625 FIG00821626: hypothetical protein +FIG00821629 FIG00821630: hypothetical protein +FIG00821630 FIG00821633: hypothetical protein +FIG00821633 Long-chain fatty-acid-AMP ligase, Mycobacterial subgroup FadD34 +FIG00821634 FIG00821635: hypothetical protein +FIG00821635 FIG00821636: hypothetical protein +FIG00821636 FIG00821637: hypothetical protein +FIG00821638 FIG00821639: hypothetical protein +FIG00821639 FIG00821641: hypothetical protein +FIG00821645 FIG00821646: hypothetical protein +FIG00821646 Pyridoxamine 5'-phosphate oxidase-related, FMN-binding +FIG00821653 FIG00821654: hypothetical protein +FIG00821654 FIG00821655: hypothetical protein +FIG00821655 FIG00821656: hypothetical protein +FIG00821656 FIG00821658: hypothetical protein +FIG00821658 FIG00821659: hypothetical protein +FIG00821663 FIG00821664: hypothetical protein +FIG00821664 FIG00821667: hypothetical protein +FIG00821667 FIG00821670: hypothetical protein +FIG00821671 FIG00821672: hypothetical protein +FIG00821672 FIG00996838: hypothetical protein +FIG00821679 FIG00821680: hypothetical protein +FIG00821680 FIG00821681: hypothetical protein +FIG00821681 FIG00821682: hypothetical protein +FIG00821682 VapC5 antibacterial toxin protein +FIG00821685 FIG00821686: hypothetical protein +FIG00821687 FIG00821688: hypothetical protein +FIG00821688 FIG00821690: hypothetical protein +FIG00821690 Alanine rich transferase +FIG00821692 FIG017534: hypothetical protein +FIG00821694 FIG00821695: hypothetical protein +FIG00821695 FIG00821697: hypothetical protein +FIG00821697 FIG00821698: hypothetical protein +FIG00821698 MazE8 protein (antitoxin to MazF8) +FIG00821699 FIG00821700: hypothetical protein +FIG00821700 FIG036071: hypothetical protein +FIG00821701 FIG00821702: hypothetical protein +FIG00821702 FIG00821705: hypothetical protein +FIG00821705 FIG00821706: hypothetical protein +FIG00821706 FIG00821707: hypothetical protein +FIG00821709 FIG034772: Probable conserved MCE associated protein +FIG00821711 FIG00821712: hypothetical protein +FIG00821712 FIG00821714: hypothetical protein +FIG00821714 FIG00823085: hypothetical protein +FIG00821716 FIG00821718: hypothetical protein +FIG00821718 FIG00821720: hypothetical protein +FIG00821720 FIG00995588: hypothetical protein +FIG00821721 FIG00821722: hypothetical protein +FIG00821722 FIG00821723: hypothetical protein +FIG00821723 FIG00821724: hypothetical protein +FIG00821724 FIG00821727: hypothetical protein +FIG00821727 FIG00821728: hypothetical protein +FIG00821728 FIG00821729: hypothetical protein +FIG00821729 FIG00821734: hypothetical protein +FIG00821736 hypothetical protein +FIG00821737 FIG00821738: hypothetical protein +FIG00821738 FIG00821740: hypothetical protein +FIG00821740 FIG00832781: hypothetical protein +FIG00821741 FIG00821742: hypothetical protein +FIG00821742 FIG00821743: hypothetical protein +FIG00821743 FIG00821745: hypothetical protein +FIG00821745 VapB22 protein (antitoxin to VapC22) +FIG00821747 FIG00821748: hypothetical protein +FIG00821754 FIG00821756: hypothetical protein +FIG00821756 FIG00994994: hypothetical protein +FIG00821757 FIG00821758: hypothetical protein +FIG00821760 MmpL family protein +FIG00821761 FIG00821766: hypothetical protein +FIG00821766 CAIB-BAIF family protein (caiB-2) +FIG00821767 FIG00821768: hypothetical protein +FIG00821768 FIG00821770: hypothetical protein +FIG00821770 FIG00821772: hypothetical protein +FIG00821772 FIG00821774: hypothetical protein +FIG00821774 FIG00821775: hypothetical protein +FIG00821778 FIG00821779: hypothetical protein +FIG00821779 FIG00821781: hypothetical protein +FIG00821783 FIG00821784: hypothetical protein +FIG00821784 FIG00821786: hypothetical protein +FIG00821786 FIG00821790: hypothetical protein +FIG00821790 FIG00821791: hypothetical protein +FIG00821791 FIG00821793: hypothetical protein +FIG00821793 FIG00821794: hypothetical protein +FIG00821797 FIG00821800: hypothetical protein +FIG00821800 FIG00821802: hypothetical protein +FIG00821804 Colicin E2 tolerance protein CbrC-like protein +FIG00821808 FIG00821812: hypothetical protein +FIG00821812 FIG00821817: hypothetical protein +FIG00821817 FIG00821819: hypothetical protein +FIG00821819 FIG00821822: hypothetical protein +FIG00821822 FIG00821823: hypothetical protein +FIG00821823 FIG00821827: hypothetical protein +FIG00821827 Transmembrane transport protein MmpL11 +FIG00821833 FIG00821835: hypothetical protein +FIG00821835 Lepb1170_F2_64 +FIG00821837 Secreted protein EspC, component of Type VII secretion system ESX-1 +FIG00821838 FIG00821840: hypothetical protein +FIG00821841 FIG00821842: hypothetical protein +FIG00821844 FIG00821845: hypothetical protein +FIG00821846 FIG00821847: hypothetical protein +FIG00821847 FIG00821848: hypothetical protein +FIG00821852 FIG00821853: hypothetical protein +FIG00821853 FIG00821855: hypothetical protein +FIG00821859 FIG00821860: hypothetical protein +FIG00821860 FIG00821861: hypothetical protein +FIG00821862 FIG00821863: hypothetical protein +FIG00821863 FIG00821864: hypothetical protein +FIG00821864 FIG00821865: hypothetical protein +FIG00821868 FIG00821869: hypothetical protein +FIG00821869 FIG00821870: hypothetical protein +FIG00821871 FIG00821872: hypothetical protein +FIG00821872 FIG00821873: hypothetical protein +FIG00821874 Probable integral membrane protein +FIG00821877 FIG00821878: hypothetical protein +FIG00821878 Phage peptidoglycan binding endopeptidase +FIG00821879 FIG00821880: hypothetical protein +FIG00821880 FIG00832352: hypothetical protein +FIG00821882 FIG00821883: hypothetical protein +FIG00821883 Phospholipase C 3 PlcC (EC 3.1.4.3) +FIG00821886 FIG00821888: hypothetical protein +FIG00821888 FIG00821889: hypothetical protein +FIG00821889 FIG00821891: hypothetical protein +FIG00821891 FIG00821892: hypothetical protein +FIG00821892 FIG00821893: hypothetical protein +FIG00821893 FIG00821894: hypothetical protein +FIG00821894 FIG00821895: hypothetical protein +FIG00821895 hypothetical protein +FIG00821897 FIG00821901: hypothetical protein, Rv0504c +FIG00821906 FIG00821908: hypothetical protein +FIG00821909 FIG00821910: hypothetical protein +FIG00821910 FIG00821911: hypothetical protein +FIG00821911 FIG00821912: hypothetical protein +FIG00821912 FIG00821916: hypothetical protein +FIG00821916 FIG00821917: hypothetical protein +FIG00821917 FIG00821918: hypothetical protein +FIG00821922 FIG00821923: hypothetical protein +FIG00821923 VapB11 protein (antitoxin to VapC11) +FIG00821929 FIG00821932: hypothetical protein +FIG00821932 FIG00821933: hypothetical protein +FIG00821933 FIG00821935: hypothetical protein +FIG00821935 FIG00821936: hypothetical protein +FIG00821936 Serine/threonine protein kinase (EC 2.7.11.1) +FIG00821937 FIG00821938: hypothetical protein +FIG00821941 FIG00821943: hypothetical protein +FIG00821944 FIG00821945: hypothetical protein +FIG00821945 FIG00821948: hypothetical protein +FIG00821948 FIG00821950: hypothetical protein +FIG00821950 AtfA_1 +FIG00821954 FIG00821956: hypothetical protein +FIG00821958 glyoxalase/bleomycin resistance protein/dioxygenase +FIG00821959 Enoyl-CoA hydratase (EC 4.2.1.17) +FIG00821961 FIG00821962: hypothetical protein +FIG00821963 FIG00821964: hypothetical protein +FIG00821964 FIG00821966: hypothetical protein +FIG00821967 FIG00821968: hypothetical protein +FIG00821968 L-lysine 6-monooxygenase MbtG (EC 1.14.13.59) [mycobactin] siderophore +FIG00821969 FIG00821973: hypothetical protein +FIG00821973 NidC diol dehydrogenase +FIG00821975 FIG00821976: hypothetical protein +FIG00821978 FIG00821980: hypothetical protein +FIG00821981 FIG00821985: hypothetical protein +FIG00821985 FIG00821989: hypothetical protein +FIG00821989 FIG00821990: hypothetical protein +FIG00821990 FIG00821991: hypothetical protein +FIG00821991 dihydroflavonol 4-reductase +FIG00821993 Cystathionine beta-lyase, type II (EC 4.4.1.8) +FIG00821995 FIG00821996: hypothetical protein +FIG00821996 Esterase/lipase +FIG00821997 FIG00821999: hypothetical protein +FIG00821999 FIG00822000: hypothetical protein +FIG00822000 Basic proline-rich protein +FIG00822007 FIG00822008: hypothetical protein +FIG00822008 FIG01334132: Putative conserved alanine, valine and leucine rich integral membrane protein +FIG00822009 FIG00822010: hypothetical protein +FIG00822016 FIG00822018: hypothetical protein +FIG00822018 FIG00822019: hypothetical protein +FIG00822020 FIG00822021: hypothetical protein +FIG00822021 FIG00822023: hypothetical protein +FIG00822023 FIG00822024: hypothetical protein +FIG00822024 FIG00822025: hypothetical protein +FIG00822025 FIG00822027: hypothetical protein +FIG00822027 FIG00822031: hypothetical protein +FIG00822031 FIG00822032: hypothetical protein +FIG00822032 FIG00822036: hypothetical protein +FIG00822036 FIG00822039: hypothetical protein +FIG00822039 FIG00822041: hypothetical protein +FIG00822041 Transmembrane transport protein MmpL8 +FIG00822044 surface antigen, putative +FIG00822045 VapC4 antibacterial toxin protein +FIG00822047 hypothetical protein +FIG00822054 FIG00822056: hypothetical protein +FIG00822056 FIG00822057: hypothetical protein +FIG00822060 FIG00822063: hypothetical protein +FIG00822063 Possible membrane protein +FIG00822064 FIG00822066: hypothetical protein +FIG00822066 FIG00822067: hypothetical protein +FIG00822073 FIG00822074: hypothetical protein, Rv0678 +FIG00822074 FIG00822076: hypothetical protein +FIG00822076 Probable phiRv1 phage protein +FIG00822077 methyltransferase, putative +FIG00822079 FMN-dependent oxidoreductase, nitrilotriacetate monooxygenase family +FIG00822081 Probable forkhead-associated protein +FIG00822084 Cupin 4 family protein +FIG00822086 FIG00822089: hypothetical protein +FIG00822089 Methyltransferase (EC 2.1.1.-) +FIG00822093 S-adenosyl-L-methionine:salicylic acid carboxyl methyltransferase-like protein +FIG00822095 FIG00822096: hypothetical protein +FIG00822096 FIG00822098: hypothetical protein +FIG00822098 FIG00822099: hypothetical protein +FIG00822102 FIG00822103: hypothetical protein +FIG00822105 FIG00822106: hypothetical protein +FIG00822110 FIG00822111: hypothetical protein +FIG00822111 FIG00822113: hypothetical protein +FIG00822113 FIG00822114: hypothetical protein +FIG00822115 FIG00822116: hypothetical protein +FIG00822116 TspO-MBR family protein +FIG00822117 CONSERVED PROBABLE SECRETED PROTEIN +FIG00822118 Transcription termination protein NusB +FIG00822126 Competence protein F homolog, phosphoribosyltransferase domain; protein YhgH required for utilization of DNA as sole source of carbon and energy +FIG00822128 putative ATP/GTP-binding integral membrane protein +FIG00822132 Membrane protein Rv3611, component of Type VII secretion system ESX-1 +FIG00822136 FIG00822138: hypothetical protein +FIG00822138 FIG00822139: hypothetical protein +FIG00822143 FIG00822145: hypothetical protein +FIG00822145 FIG00822146: hypothetical protein +FIG00822147 Polyketide synthase +FIG00822150 FIG00822152: hypothetical protein +FIG00822156 FIG00822158: hypothetical protein +FIG00822158 FIG00822160: hypothetical protein +FIG00822160 FIG00822168: hypothetical protein +FIG00822168 FIG00822170: hypothetical protein +FIG00822170 Bacterial periplasmic substrate-binding protein +FIG00822171 FIG00822172: hypothetical protein +FIG00822172 FIG00822175: hypothetical protein +FIG00822175 FIG00822179: hypothetical protein +FIG00822182 FIG00822184: hypothetical protein +FIG00822188 FIG00822190: hypothetical protein +FIG00822190 FIG00822192: hypothetical protein +FIG00822192 ESAT-6-like protein EsxU +FIG00822195 FIG00822196: hypothetical protein +FIG00822196 FIG00822196: possible membrane protein +FIG00822197 drug transport protein, putative +FIG00822199 FIG00822200: hypothetical protein +FIG00822200 FIG00822202: hypothetical protein +FIG00822202 FIG00822203: hypothetical protein +FIG00822203 FIG00823153: hypothetical protein +FIG00822206 FIG00822209: hypothetical protein +FIG00822212 Glycosyl transferase family protein +FIG00822213 FIG00822216: hypothetical protein +FIG00822221 Methyltransferase (EC 2.1.1.-) +FIG00822222 FIG00822223: hypothetical protein +FIG00822223 FIG00822224: hypothetical protein +FIG00822224 FIG00822225: hypothetical protein +FIG00822225 FIG00822227: hypothetical protein +FIG00822227 Cutinase +FIG00822231 Artificial two-component regulatory system sensor kinase +FIG00822232 FIG00822233: hypothetical protein +FIG00822233 FIG00822234: hypothetical protein +FIG00822234 FIG033455: hypothetical protein +FIG00822235 FIG00822237: hypothetical protein +FIG00822238 FIG00822240: hypothetical protein +FIG00822244 FIG00822245: hypothetical protein +FIG00822246 FIG00822247: hypothetical protein +FIG00822247 FIG00822248: hypothetical protein +FIG00822249 FIG00822251: hypothetical protein +FIG00822251 FIG00822252: hypothetical protein +FIG00822252 FIG00822253: hypothetical protein +FIG00822255 FIG00822256: hypothetical protein +FIG00822256 Oxidoreductase, short-chain dehydrogenase/reductase family +FIG00822260 FIG00822261: hypothetical protein +FIG00822265 FIG00822268: hypothetical protein +FIG00822268 FIG00822269: hypothetical protein +FIG00822279 FIG00822280: hypothetical protein +FIG00822280 alpha/beta hydrolase, putative +FIG00822283 FIG00822284: hypothetical protein +FIG00822284 FIG00822285: hypothetical protein +FIG00822285 FIG00822286: hypothetical protein +FIG00822286 FIG00822287: hypothetical protein +FIG00822287 FIG00822289: hypothetical protein +FIG00822289 FIG00822290: hypothetical protein +FIG00822290 FIG00822292: hypothetical protein +FIG00822296 FIG00822297: hypothetical protein +FIG00822298 FIG00822299: hypothetical protein +FIG00822305 Possible multi-functional enzyme with acyl-CoA-reductase activity AcrA1 +FIG00822307 FIG00822308: hypothetical protein +FIG00822308 FIG00822309: hypothetical protein +FIG00822309 FIG00822310: hypothetical protein +FIG00822310 ABC-type drug export system, membrane protein +FIG00822313 FIG00822314: hypothetical protein +FIG00822316 glnH, putative +FIG00822317 FIG00822319: hypothetical protein +FIG00822319 FIG00822320: hypothetical protein +FIG00822320 FIG00822322: hypothetical protein +FIG00822322 FIG00822329: hypothetical protein +FIG00822329 FIG00822333: hypothetical protein +FIG00822333 FIG00822334: hypothetical protein +FIG00822334 FIG00822335: hypothetical protein +FIG00822335 FIG00822338: hypothetical protein +FIG00822338 FIG00822339: hypothetical protein +FIG00822339 Phospholipase D/transphosphatidylase +FIG00822340 FIG00822343: hypothetical protein +FIG00822347 FIG00822348: hypothetical protein +FIG00822348 FIG00822349: hypothetical protein +FIG00822349 FIG00822351: hypothetical protein +FIG00822351 FIG00822353: hypothetical protein +FIG00822353 FIG00822359: hypothetical protein +FIG00822361 FIG00822362: hypothetical protein +FIG00822362 FIG00822363: hypothetical protein +FIG00822363 FIG00822364: hypothetical protein +FIG00822364 hydride transferase 1 +FIG00822366 Alanine and proline-rich secreted protein Apa (45 kDa glycoprotein) (45/47 kDa antigen) (Antigen MPT-32) (FAP-B) (Fibronectin attachment protein) (Immunogenic protein MPT32) +FIG00822368 FIG00822369: hypothetical protein +FIG00822369 FIG00822371: hypothetical protein +FIG00822371 FIG00822372: hypothetical protein +FIG00822375 FIG00822376: hypothetical protein +FIG00822376 FIG00822377: hypothetical protein +FIG00822379 Nitroreductase family protein +FIG00822384 FIG00822385: hypothetical protein +FIG00822385 Two-component system response phosphate sensor kinase, PhoR +FIG00822386 Oxidoreductase, short-chain dehydrogenase/reductase family +FIG00822392 FIG00822393: hypothetical protein +FIG00822393 FIG00822394: hypothetical protein +FIG00822394 FIG00822396: hypothetical protein +FIG00822396 MazF4 antibacterial toxin protein +FIG00822402 FIG00822403: hypothetical protein +FIG00822407 FIG00822408: hypothetical protein +FIG00822414 FIG00822416: hypothetical protein +FIG00822416 FIG00822417: hypothetical protein +FIG00822417 FIG00822418: hypothetical protein +FIG00822421 FIG00822423: hypothetical protein +FIG00822423 FIG00822425: hypothetical protein +FIG00822428 FIG055611: hypothetical protein +FIG00822429 FIG00822430: hypothetical protein +FIG00822432 FIG00822433: hypothetical protein +FIG00822433 FIG00822435: hypothetical protein +FIG00822435 FIG00822436: hypothetical protein +FIG00822436 ESAT-6-like protein EsxD +FIG00822439 FIG00822441: hypothetical protein +FIG00822441 FIG00822442: hypothetical protein +FIG00822442 FIG00822443: hypothetical protein +FIG00822444 FIG00822446: hypothetical protein +FIG00822449 FIG00822450: hypothetical protein +FIG00822450 Uncharacterized glycosyltransferase Rv1524/MT1575 (EC 2.-.-.-) +FIG00822451 FIG00822453: hypothetical protein +FIG00822453 FIG00822455: hypothetical protein +FIG00822455 FIG00822456: hypothetical protein +FIG00822456 FIG00822458: hypothetical protein +FIG00822458 FIG00822459: hypothetical protein +FIG00822461 COGs COG2343 +FIG00822464 FIG00822465: hypothetical protein +FIG00822465 FIG00822472: hypothetical protein +FIG00822476 FIG00822478: hypothetical protein +FIG00822479 FIG00822480: hypothetical protein +FIG00822480 FIG00822481: hypothetical protein +FIG00822481 FIG00822482: hypothetical protein +FIG00822483 Cutinase Cut2 (EC 3.1.1.74) +FIG00822484 FIG00822485: hypothetical protein +FIG00822486 FIG00822490: hypothetical protein +FIG00822490 FIG00822491: hypothetical protein +FIG00822495 FIG00822496: hypothetical protein +FIG00822497 FIG00822499: hypothetical protein +FIG00822499 Cytochrome P450 +FIG00822502 FIG00822503: hypothetical protein +FIG00822503 FIG00822504: hypothetical protein +FIG00822505 FIG00822506: hypothetical protein +FIG00822511 FIG00822513: hypothetical protein +FIG00822513 FIG00822515: hypothetical protein +FIG00822515 FIG00822516: hypothetical protein +FIG00822516 FIG00822518: hypothetical protein +FIG00822518 FIG00822519: hypothetical protein +FIG00822519 FIG00822523: hypothetical protein +FIG00822523 Transcriptional regulator, XRE family +FIG00822524 FIG00822527: hypothetical protein +FIG00822527 FIG00822531: hypothetical protein +FIG00822532 Oxidoreductase, short-chain dehydrogenase/reductase family +FIG00822537 FIG00822538: hypothetical protein +FIG00822538 FIG00822543: hypothetical protein +FIG00822543 FIG00822544: hypothetical protein +FIG00822544 FAD dependent oxidoreductase +FIG00822545 FIG00822546: hypothetical protein +FIG00822546 Gluconolactonase (EC 3.1.1.17) +FIG00822547 FIG00822548: hypothetical protein +FIG00822550 FIG00822552: hypothetical protein +FIG00822554 FIG00822555: hypothetical protein +FIG00822557 FIG00822559: hypothetical protein +FIG00822561 FIG00822564: hypothetical protein +FIG00822564 FIG00822565: hypothetical protein +FIG00822565 FIG00822566: hypothetical protein +FIG00822566 FIG00822570: hypothetical protein +FIG00822570 FIG00822571: hypothetical protein +FIG00822571 FIG00822573: hypothetical protein +FIG00822573 FIG00822574: hypothetical protein +FIG00822574 FIG00822575: hypothetical protein +FIG00822575 FIG00822577: hypothetical protein +FIG00822577 FIG00822578: hypothetical protein +FIG00822578 FIG00822580: hypothetical protein +FIG00822580 FIG00822582: hypothetical protein +FIG00822582 FIG00822583: hypothetical protein +FIG00822583 putative acyltransferase +FIG00822585 FIG00999563: hypothetical protein +FIG00822587 FIG00822588: hypothetical protein +FIG00822590 excisionase, putative +FIG00822592 FIG00822594: hypothetical protein +FIG00822600 FIG00822601: hypothetical protein +FIG00822601 FIG00822603: hypothetical protein +FIG00822610 FIG00822613: hypothetical protein +FIG00822613 FIG00822614: hypothetical protein +FIG00822614 FIG00822615: hypothetical protein +FIG00822615 FIG00822620: hypothetical protein +FIG00822624 FIG00822625: hypothetical protein +FIG00822629 FIG00822630: hypothetical protein +FIG00822635 FIG00822636: hypothetical protein +FIG00822636 FIG00822637: hypothetical protein +FIG00822637 VapB5 protein (antitoxin to VapC5) +FIG00822638 periplasmic substrate-binding protein, ABC-type transporter +FIG00822640 Alcohol dehydrogenase IV (EC 1.3.1.32) +FIG00822644 FIG00822645: hypothetical protein +FIG00822645 FIG00822650: hypothetical protein +FIG00822651 FIG00822652: hypothetical protein +FIG00822653 Nucleoside-diphosphate-sugar epimerase +FIG00822654 FIG00822655: hypothetical protein +FIG00822655 FIG00822658: hypothetical protein +FIG00822659 FIG00822662: hypothetical protein +FIG00822663 FIG00822664: hypothetical protein +FIG00822664 FIG00822665: hypothetical protein +FIG00822665 VapC7 antibacterial toxin protein +FIG00822666 Formate/nitrite transporter family protein +FIG00822668 FIG00822669: hypothetical protein +FIG00822669 FIG00822670: hypothetical protein +FIG00822671 FIG00822674: hypothetical protein +FIG00822674 FIG00822675: hypothetical protein +FIG00822675 FIG00822676: hypothetical protein +FIG00822677 FIG00822680: hypothetical protein +FIG00822680 FIG00822681: hypothetical protein +FIG00822681 FIG00822682: hypothetical protein +FIG00822682 FIG00822683: hypothetical protein +FIG00822683 FIG00822685: hypothetical protein +FIG00822685 FIG00822687: hypothetical protein +FIG00822687 FIG00822688: hypothetical protein +FIG00822690 transcriptional regulator, Cro-CI family, putative +FIG00822691 Regulatory protein, ArsR precursor +FIG00822694 FIG00822696: hypothetical protein +FIG00822697 FIG00822698: hypothetical protein +FIG00822698 Response regulator receiver modulated serine phosphatase +FIG00822699 FIG00822701: hypothetical protein +FIG00822701 FIG00822703: hypothetical protein +FIG00822703 FIG00822704: hypothetical protein +FIG00822705 FIG00822707: hypothetical protein +FIG00822707 FIG00822708: hypothetical protein +FIG00822708 FIG00822709: hypothetical protein +FIG00822709 FIG00822710: hypothetical protein +FIG00822710 FIG00822712: hypothetical protein +FIG00822713 FIG00822716: hypothetical protein +FIG00822718 FIG00822720: hypothetical protein +FIG00822723 FIG00822724: hypothetical protein +FIG00822724 FIG00822725: hypothetical protein +FIG00822725 FIG00822728: hypothetical protein +FIG00822728 FIG00822730: hypothetical protein +FIG00822731 FIG00822733: hypothetical protein +FIG00822733 FIG00822734: hypothetical protein +FIG00822736 FIG00822737: hypothetical protein +FIG00822737 FIG00822739: hypothetical protein +FIG00822745 FIG00822747: hypothetical protein +FIG00822747 FIG00822748: hypothetical protein +FIG00822748 FIG00822750: hypothetical protein +FIG00822757 Type VII secretion protein EccE +FIG00822760 FIG00822761: hypothetical protein +FIG00822766 FIG00822767: hypothetical protein +FIG00822767 FIG00822768: hypothetical protein +FIG00822769 FIG00822773: hypothetical protein +FIG00822773 FIG004853: possible toxin to DivIC +FIG00822778 FIG00822780: hypothetical protein +FIG00822780 FIG00822785: hypothetical protein +FIG00822788 FIG00822789: hypothetical protein +FIG00822789 FIG00822791: hypothetical protein +FIG00822791 3-ketoacyl-CoA thiolase (acaB-12) +FIG00822796 hypothetical protein +FIG00822798 FIG00822799: hypothetical protein +FIG00822800 FIG00822801: hypothetical protein +FIG00822801 DnaJ domain protein +FIG00822802 FIG00822803: hypothetical protein +FIG00822805 FIG00822806: hypothetical protein +FIG00822806 FIG00822807: hypothetical protein +FIG00822807 FIG00822808: hypothetical protein +FIG00822809 FIG00822811: hypothetical protein +FIG00822811 Taurine catabolism dioxygenase TauD/TfdA +FIG00822813 FIG00822816: hypothetical protein +FIG00822816 FIG00822817: hypothetical protein +FIG00822817 FIG00822818: hypothetical protein +FIG00822819 FIG00822820: hypothetical protein +FIG00822820 FIG00822822: hypothetical protein +FIG00822822 FIG00822824: hypothetical protein +FIG00822824 FIG00822825: hypothetical protein +FIG00822826 FIG00822827: hypothetical protein +FIG00822827 FIG00822828: hypothetical protein +FIG00822829 FIG00822831: hypothetical protein +FIG00822831 FIG00822835: hypothetical protein +FIG00822835 FIG00822836: hypothetical protein +FIG00822836 FIG00822841: hypothetical protein +FIG00822842 FIG00822845: hypothetical protein +FIG00822845 FIG00822846: hypothetical protein +FIG00822850 FIG00996157: hypothetical protein +FIG00822853 FIG00822854: hypothetical protein +FIG00822855 FIG00822857: hypothetical protein +FIG00822857 FIG00822859: hypothetical protein +FIG00822859 FIG00822861: hypothetical protein +FIG00822861 FIG00822862: hypothetical protein +FIG00822871 FIG00822872: hypothetical protein +FIG00822872 FIG00822874: hypothetical protein +FIG00822874 FIG00822881: hypothetical protein +FIG00822882 FIG00999975: hypothetical protein +FIG00822890 FIG00822891: hypothetical protein +FIG00822891 FIG00822892: hypothetical protein +FIG00822893 FIG00822895: hypothetical protein +FIG00822895 FIG00822896: hypothetical protein +FIG00822896 FIG00822897: hypothetical protein +FIG00822897 FIG00822898: hypothetical protein +FIG00822898 FIG00822903: hypothetical protein +FIG00822904 FIG00822907: hypothetical protein +FIG00822907 FIG00822908: hypothetical protein +FIG00822908 Protein PE35, involved in regulation of esxAB expression in Type VII secretion system ESX-1 +FIG00822909 FIG00822912: hypothetical protein +FIG00822912 FIG00822913: hypothetical protein +FIG00822913 Anti-sigma F factor antagonist (spoIIAA-2); Anti-sigma B factor antagonist RsbV +FIG00822914 FIG00822915: hypothetical protein +FIG00822915 FIG00822916: hypothetical protein +FIG00822916 MtfB protein +FIG00822922 O-Methyltransferase involved in polyketide biosynthesis +FIG00822927 FIG00822929: hypothetical protein +FIG00822929 FIG00822931: hypothetical protein +FIG00822932 FIG00822934: hypothetical protein +FIG00822934 FIG00822937: hypothetical protein +FIG00822939 FIG00822941: hypothetical protein +FIG00822941 FIG00822942: hypothetical protein +FIG00822946 FIG00822947: hypothetical protein +FIG00822947 FIG00822948: hypothetical protein +FIG00822949 FIG00822951: hypothetical protein +FIG00822953 FIG00822955: hypothetical protein +FIG00822959 FIG00822960: hypothetical protein +FIG00822960 ATP-dependent RNA helicase +FIG00822964 EmrB/QacA family drug resistance transporter +FIG00822970 FIG00822975: hypothetical protein +FIG00822975 FIG00822976: hypothetical protein +FIG00822976 FIG00822977: hypothetical protein +FIG00822977 FIG00822978: hypothetical protein +FIG00822978 FIG00822981: hypothetical protein +FIG00822981 FIG00822982: hypothetical protein +FIG00822986 FIG00822987: hypothetical protein +FIG00822988 FIG00822989: hypothetical protein +FIG00822993 FIG00822994: hypothetical protein +FIG00822994 FIG00822995: hypothetical protein +FIG00822995 FIG00822996: hypothetical protein +FIG00822996 FIG00823004: hypothetical protein +FIG00823005 FIG00823010: hypothetical protein +FIG00823014 FIG00823016: hypothetical protein +FIG00823016 FIG00823018: hypothetical protein +FIG00823018 FIG00823025: hypothetical protein +FIG00823025 FIG00823026: hypothetical protein +FIG00823027 FIG00823029: hypothetical protein +FIG00823029 FIG00823030: hypothetical protein +FIG00823032 FIG00823034: hypothetical protein +FIG00823036 FIG00823039: hypothetical protein +FIG00823042 FIG00823043: hypothetical protein +FIG00823043 FIG00823044: hypothetical protein +FIG00823044 FIG00823046: hypothetical protein +FIG00823046 FIG00823047: hypothetical protein +FIG00823050 FIG00823051: hypothetical protein +FIG00823051 FIG00823053: hypothetical protein +FIG00823053 FIG00823054: hypothetical protein +FIG00823054 FIG00995606: hypothetical protein +FIG00823055 iron-regulated elongation factor tu Tuf-like +FIG00823057 FIG00823058: hypothetical protein +FIG00823058 FIG00823064: hypothetical protein +FIG00823064 FIG00823066: hypothetical protein +FIG00823066 FIG00823067: hypothetical protein +FIG00823067 FIG00823074: hypothetical protein +FIG00823076 FIG00823077: hypothetical protein +FIG00823077 FIG00823085: hypothetical protein +FIG00823088 FIG00823091: hypothetical protein +FIG00823092 FIG00823094: hypothetical protein +FIG00823095 FIG00823096: hypothetical protein +FIG00823097 FIG00823098: hypothetical protein +FIG00823101 FIG00823105: hypothetical protein +FIG00823105 FIG00823110: hypothetical protein +FIG00823110 FIG00823111: hypothetical protein +FIG00823120 FIG00823121: hypothetical protein +FIG00823121 Two component system sensor histidine kinase +FIG00823128 FIG00823129: hypothetical protein +FIG00823129 FIG00823130: hypothetical protein +FIG00823133 FIG00823136: hypothetical protein +FIG00823136 FIG00823137: hypothetical protein +FIG00823137 FIG00823138: hypothetical protein +FIG00823138 FIG00823142: hypothetical protein +FIG00823142 FIG00823144: hypothetical protein +FIG00823146 FIG00823149: hypothetical protein +FIG00823149 FIG00823150: hypothetical protein +FIG00823150 FIG00823152: hypothetical protein +FIG00823152 FIG00823153: hypothetical protein +FIG00823153 FIG00823154: hypothetical protein +FIG00823154 FIG00823156: hypothetical protein +FIG00823157 Polyketide beta-ketoacyl synthase Pks4 +FIG00823158 FIG00823160: hypothetical protein +FIG00823160 FIG00823161: hypothetical protein +FIG00823165 FIG00823166: hypothetical protein +FIG00823166 56kDa selenium binding protein +FIG00823167 FIG00823168: hypothetical protein +FIG00823168 FIG00823170: hypothetical protein +FIG00823170 N5,N10-methylenetetrahydromethanopterin reductase-related protein, SAV7403 family +FIG00823171 FIG00823172: hypothetical protein +FIG00823172 FIG00823173: hypothetical protein +FIG00823177 Hydrolase, alpha/beta fold family protein +FIG00823181 FIG00823182: hypothetical protein +FIG00823185 FIG00823188: hypothetical protein +FIG00823189 FIG00823190: hypothetical protein +FIG00823194 FIG00823195: hypothetical protein +FIG00823195 FIG00823196: hypothetical protein +FIG00823196 FIG00823199: hypothetical protein +FIG00823203 FIG00823204: hypothetical protein +FIG00823206 FIG00823211: hypothetical protein +FIG00823212 FIG00823214: hypothetical protein +FIG00823214 Possible membrane protein +FIG00823221 FIG00823222: hypothetical protein +FIG00823222 FIG00823223: hypothetical protein +FIG00823226 FIG00823227: hypothetical protein +FIG00823231 FIG00823232: hypothetical protein +FIG00823233 FIG00823234: hypothetical protein +FIG00823234 FIG00823236: hypothetical protein +FIG00823246 FIG091491: hypothetical protein +FIG00823252 Oxidoreductase, short-chain dehydrogenase/reductase family +FIG00823253 FIG00823255: hypothetical protein +FIG00823255 FIG00823256: hypothetical protein +FIG00823256 ParD2 protein (antitoxin to ParE2) +FIG00823257 FIG00823260: hypothetical protein +FIG00823264 FIG00823265: hypothetical protein +FIG00823265 FIG00823266: hypothetical protein +FIG00823266 FIG00823267: hypothetical protein +FIG00823267 FIG00823272: hypothetical protein +FIG00823273 FIG00823276: hypothetical protein +FIG00823277 Luciferase family protein +FIG00823280 FIG00823285: hypothetical protein +FIG00823285 Diacyglycerol O-acyltransferase (EC 2.3.1.20) +FIG00823287 ParE2 antibacterial toxin protein +FIG00823288 Daunorubicin-DIM-transport ATP-binding protein ABC transporter DrrA +FIG00823290 FIG00823293: hypothetical protein +FIG00823295 FIG00823300: hypothetical protein +FIG00823303 FIG00823304: hypothetical protein +FIG00823305 FIG024080: hypothetical protein +FIG00823307 FIG00823308: hypothetical protein +FIG00823308 FIG00823310: hypothetical protein +FIG00823310 FIG00823311: hypothetical protein +FIG00823312 Integral membrane sensor signal transduction histidine kinase +FIG00823316 FIG00823318: hypothetical protein +FIG00823318 FIG00823322: hypothetical protein +FIG00823322 FIG00823326: hypothetical protein +FIG00823326 FIG00823327: hypothetical protein +FIG00823328 conserved hypothetical proline rich protein +FIG00823329 FIG00823331: hypothetical protein +FIG00823331 FIG00823332: hypothetical protein +FIG00823332 FIG00823333: hypothetical protein +FIG00823333 FIG00823334: hypothetical protein +FIG00823334 FIG00823336: hypothetical protein +FIG00823337 FIG00823340: hypothetical protein +FIG00823340 FIG00823341: hypothetical protein +FIG00823341 FIG00823343: hypothetical protein +FIG00823343 FIG00823344: hypothetical protein +FIG00823344 FIG00823347: hypothetical protein +FIG00823347 FIG00823348: hypothetical protein +FIG00823348 FIG00823358: hypothetical protein +FIG00823359 FIG00823361: hypothetical protein +FIG00823361 FIG00823367: hypothetical protein +FIG00823367 FIG00823369: hypothetical protein +FIG00823369 FIG00823370: hypothetical protein +FIG00823370 FIG00823372: hypothetical protein +FIG00823372 FIG00823373: hypothetical protein +FIG00823373 FIG00823374: hypothetical protein +FIG00823377 FIG00823379: hypothetical protein +FIG00823381 FIG00823382: hypothetical protein +FIG00823382 FIG00823383: hypothetical protein +FIG00823383 FIG00823384: hypothetical protein +FIG00823384 FIG00823385: hypothetical protein +FIG00823386 FIG00823387: hypothetical protein +FIG00823387 Possible membrane protein +FIG00823395 FIG00823396: hypothetical protein +FIG00823398 FIG00823401: hypothetical protein +FIG00823401 FIG00823405: hypothetical protein +FIG00823405 FIG00823407: hypothetical protein +FIG00823407 FIG00823410: hypothetical protein +FIG00823410 FIG00823411: hypothetical protein +FIG00823411 FIG00823413: hypothetical protein +FIG00823415 FIG00823416: hypothetical protein +FIG00823418 FIG00823421: hypothetical protein +FIG00823422 Hydrolase, alpha/beta fold family protein +FIG00823423 FIG00823424: hypothetical protein +FIG00823424 FIG00823426: hypothetical protein +FIG00823426 FIG00823427: hypothetical protein +FIG00823427 FIG00823430: hypothetical protein +FIG00823430 FIG00823434: hypothetical protein +FIG00823434 FIG00823437: hypothetical protein +FIG00823437 oxidoreductase +FIG00823438 FIG00823439: hypothetical protein +FIG00823439 FIG00823440: hypothetical protein +FIG00823440 FIG00823441: hypothetical protein +FIG00823441 FIG00823443: hypothetical protein, Rv2336 +FIG00823443 FIG00823447: hypothetical protein +FIG00823447 FIG00823448: hypothetical protein +FIG00823450 FIG00823451: hypothetical protein +FIG00823453 FIG00823454: hypothetical protein +FIG00823455 Mandelate racemase (EC 5.1.2.2) +FIG00823464 FIG00823468: hypothetical protein +FIG00823468 FIG00823469: hypothetical protein +FIG00823470 FIG00823473: hypothetical protein +FIG00823473 FIG00823474: hypothetical protein +FIG00823474 FIG00823475: hypothetical protein +FIG00823475 FIG00823480: hypothetical protein +FIG00823480 FIG00823482: hypothetical protein +FIG00823487 FIG00823488: hypothetical protein +FIG00823490 FIG00823491: hypothetical protein +FIG00823491 FIG00823492: hypothetical protein +FIG00823492 FIG00823496: hypothetical protein +FIG00823496 FIG00823498: hypothetical protein +FIG00823501 FIG00823502: hypothetical protein +FIG00823502 FIG00823503: hypothetical protein +FIG00823505 FIG00823507: hypothetical protein +FIG00823509 Sulfate adenylyltransferase +FIG00823510 ESAT-6-like protein EsxM +FIG00823513 FIG00823514: hypothetical protein +FIG00823514 FIG00823516: hypothetical protein +FIG00823516 FIG00823518: hypothetical protein +FIG00823525 FIG00823526: hypothetical protein +FIG00823526 FIG00823529: hypothetical protein +FIG00823529 FIG00823530: hypothetical protein +FIG00823532 FIG00823533: hypothetical protein +FIG00823538 hypothetical glycine rich protein +FIG00823545 Metal-dependent hydrolase +FIG00823546 FIG00823547: hypothetical protein +FIG00823547 Methyltransferase type 11 +FIG00823548 FIG00823549: hypothetical protein +FIG00823549 FIG00823551: hypothetical protein +FIG00823551 FIG00823557: hypothetical protein +FIG00823557 FIG00823558: hypothetical protein +FIG00823558 FIG00823559: hypothetical protein +FIG00823560 FIG00823561: hypothetical protein +FIG00823561 FIG00823566: hypothetical protein +FIG00823566 FIG00823567: hypothetical protein +FIG00823567 FIG00823570: hypothetical protein +FIG00823570 hypothetical protein +FIG00823571 FIG00823572: hypothetical protein +FIG00823572 FIG00823576: hypothetical protein +FIG00823576 FIG00823577: hypothetical protein +FIG00823577 FIG00823580: hypothetical protein +FIG00823581 FIG00823582: hypothetical protein +FIG00823585 FIG00823588: hypothetical protein +FIG00823588 FIG00823589: hypothetical protein +FIG00823589 FIG00823590: hypothetical protein +FIG00823596 FIG00823598: hypothetical protein +FIG00823598 FIG00823600: hypothetical protein +FIG00823600 FIG00823602: hypothetical protein +FIG00823602 FIG00823603: hypothetical protein +FIG00823603 FIG00823605: hypothetical protein +FIG00823607 FIG00823608: hypothetical protein +FIG00823617 FIG00823618: hypothetical protein +FIG00823618 FIG00823619: hypothetical protein +FIG00823619 LigA +FIG00823621 FIG00823623: hypothetical protein +FIG00823628 FIG00823629: hypothetical protein +FIG00823629 FIG00823631: hypothetical protein +FIG00823631 FIG00823633: hypothetical protein +FIG00823634 FIG00823635: hypothetical protein +FIG00823635 FAD-dependent pyridine nucleotide-disulfide oxidoreductase +FIG00823636 FIG00823638: hypothetical protein +FIG00823638 FIG00823642: hypothetical protein +FIG00823643 N5,N10-methylenetetrahydromethanopterin reductase-related protein, MSMEG1563 family +FIG00823646 FIG00823649: hypothetical protein +FIG00823649 FIG00823650: hypothetical protein +FIG00823652 FIG00823654: hypothetical protein +FIG00823654 FIG00823655: hypothetical protein +FIG00823660 FIG00823661: hypothetical protein +FIG00823670 FIG00823672: hypothetical protein +FIG00823672 FIG00823673: hypothetical protein +FIG00823674 FIG00823676: hypothetical protein +FIG00823676 FIG00823679: hypothetical protein +FIG00823679 FIG00823680: hypothetical protein +FIG00823680 FIG00823681: hypothetical protein +FIG00823681 FIG00823682: hypothetical protein +FIG00823682 FIG00823683: hypothetical protein +FIG00823686 FIG00823687: hypothetical protein +FIG00823687 FIG00823690: hypothetical protein +FIG00823691 FIG00823693: hypothetical protein +FIG00823693 Short-chain dehydrogenase/reductase SDR +FIG00823698 FIG00823699: hypothetical protein +FIG00823701 FIG00823702: hypothetical protein +FIG00823702 FIG00823704: hypothetical protein +FIG00823712 FIG00823715: hypothetical protein +FIG00823718 FIG00823719: hypothetical protein +FIG00823720 FIG00823721: hypothetical protein +FIG00823724 FIG00823725: hypothetical protein +FIG00823727 alpha/beta hydrolase fold-1 +FIG00823728 FIG00823730: hypothetical protein +FIG00823730 LinA homolog +FIG00823731 FIG00823734: hypothetical protein +FIG00823739 FIG00823740: hypothetical protein +FIG00823740 FIG00823742: hypothetical protein +FIG00823742 FIG00823743: hypothetical protein +FIG00823745 FIG00823749: hypothetical protein +FIG00823749 FIG00823750: hypothetical protein +FIG00823750 FIG00823751: hypothetical protein +FIG00823754 FIG00823755: hypothetical protein +FIG00823755 FIG00823757: hypothetical protein +FIG00823758 FIG00823762: hypothetical protein +FIG00823762 FIG00823763: hypothetical protein +FIG00823763 FIG00823765: hypothetical protein +FIG00823768 Lipoprotein LprO +FIG00823773 FIG00823774: hypothetical protein +FIG00823779 Lipoprotein LppO +FIG00823780 FIG00823781: hypothetical protein +FIG00823781 FIG00823785: hypothetical protein +FIG00823785 FIG00823787: hypothetical protein +FIG00823787 FIG00823788: hypothetical protein +FIG00823789 FIG00823790: hypothetical protein +FIG00823795 FIG00823799: hypothetical protein +FIG00823800 FIG00823801: hypothetical protein +FIG00823801 FIG00823806: hypothetical protein +FIG00823806 FIG00823807: hypothetical protein +FIG00823807 FIG00823809: hypothetical protein +FIG00823809 FIG00823811: hypothetical protein +FIG00823812 Gll1119 protein +FIG00823818 FIG00823819: hypothetical protein +FIG00823819 FIG00823821: hypothetical protein +FIG00823821 FIG00823822: hypothetical protein +FIG00823822 FIG00823823: hypothetical protein +FIG00823824 choloylglycine hydrolase, putative +FIG00823826 FIG00823829: hypothetical protein +FIG00823829 Major Facilitator Superfamily transporter +FIG00823830 FIG00823831: hypothetical protein +FIG00823832 FIG00823833: hypothetical protein +FIG00823833 Amino acid permease +FIG00823834 FIG00823837: hypothetical protein +FIG00823837 FIG00823838: hypothetical protein +FIG00823838 FIG00823839: hypothetical protein +FIG00823839 FIG00823840: hypothetical protein +FIG00823846 FIG00823852: hypothetical protein +FIG00823852 Hydrolase, alpha/beta fold family protein +FIG00823854 FIG00823859: hypothetical protein +FIG00823859 FIG028963: hypothetical protein +FIG00823861 FIG00823862: hypothetical protein +FIG00823870 FIG00831565: hypothetical protein +FIG00823871 FIG00823872: hypothetical protein +FIG00823876 FIG00823877: hypothetical protein +FIG00823877 FIG00823878: hypothetical protein +FIG00823878 FIG00823882: hypothetical protein +FIG00823882 FIG00823883: hypothetical protein +FIG00823883 FIG00823887: hypothetical protein +FIG00823887 FIG00823890: hypothetical protein +FIG00823890 FIG00823891: hypothetical protein +FIG00823894 FIG00823903: hypothetical protein +FIG00823903 FIG00823907: hypothetical protein +FIG00823913 FIG00823916: hypothetical protein +FIG00823917 FIG00823918: hypothetical protein +FIG00823918 FIG00823920: hypothetical protein +FIG00823920 haloacid dehalogenase, type II +FIG00823924 FIG00823925: hypothetical protein +FIG00823927 FIG00823929: hypothetical protein +FIG00823929 FIG00823930: hypothetical protein +FIG00823933 FIG00823934: hypothetical protein +FIG00823934 FIG00823935: hypothetical protein +FIG00823935 FIG00823936: hypothetical protein +FIG00823936 FIG00823938: hypothetical protein +FIG00823938 FIG00823939: hypothetical protein +FIG00823940 FIG00823944: hypothetical protein +FIG00823946 FIG00823950: hypothetical protein +FIG00823950 Membrane protein mosC +FIG00823951 FIG00823954: hypothetical protein +FIG00823954 FIG00823955: hypothetical protein +FIG00823955 FIG00823957: hypothetical protein +FIG00823959 FIG00823964: hypothetical protein +FIG00823964 FIG00823970: hypothetical protein +FIG00823972 FIG00823974: hypothetical protein +FIG00823975 FIG00823976: hypothetical protein +FIG00823976 FIG00823977: hypothetical protein +FIG00823977 FIG00823978: hypothetical protein +FIG00823979 FIG00823980: hypothetical protein +FIG00823980 Membrane permease +FIG00823990 FIG00823991: hypothetical protein +FIG00823991 FIG00823994: hypothetical protein +FIG00823994 FIG00823997: hypothetical protein +FIG00823997 FIG00823998: hypothetical protein +FIG00823998 FIG00824005: hypothetical protein +FIG00824016 FIG00824017: hypothetical protein +FIG00824022 FIG00824024: hypothetical protein +FIG00824024 FIG00824025: hypothetical protein +FIG00824025 FIG00824027: hypothetical protein +FIG00824027 FIG00824032: hypothetical protein +FIG00824033 FIG00824040: hypothetical protein +FIG00824040 FIG00824043: hypothetical protein +FIG00824043 FIG00824044: hypothetical protein +FIG00824051 FIG00824053: hypothetical protein +FIG00824053 FIG00824054: hypothetical protein +FIG00824059 Possible membrane protein +FIG00824065 FIG00824067: hypothetical protein +FIG00824073 FIG00824077: hypothetical protein +FIG00824085 FIG00824088: hypothetical protein +FIG00824088 Cyclase/dehydrase +FIG00824093 FIG00824095: hypothetical protein +FIG00824100 FIG00824101: hypothetical protein +FIG00824104 FIG00824105: hypothetical protein +FIG00824106 FIG00824107: hypothetical protein +FIG00824110 FIG00824114: hypothetical protein +FIG00824120 FIG00824124: hypothetical protein +FIG00824137 aminoglycoside phosphotransferase +FIG00824138 FIG00824139: hypothetical protein +FIG00824150 Aminopeptidase Y precursor (EC 3.4.11.-) +FIG00824157 FIG00824158: hypothetical protein +FIG00824161 FIG00824164: hypothetical protein +FIG00824165 FIG00824171: hypothetical protein +FIG00824171 FIG00824172: hypothetical protein +FIG00824173 FIG00824174: hypothetical protein +FIG00824174 conserved hypothetical protein, unknown function +FIG00824184 FIG00824185: hypothetical protein +FIG00824185 FIG00824187: hypothetical protein +FIG00824187 FIG00824190: hypothetical protein +FIG00824197 FIG00824201: hypothetical protein +FIG00824201 POSSIBLE GLYCOSYL TRANSFERASE +FIG00824202 FIG00824204: hypothetical protein +FIG00824207 FIG00824211: hypothetical protein +FIG00824211 FIG00824215: hypothetical protein +FIG00824217 FIG00660553: hypothetical protein +FIG00824218 FIG00824221: hypothetical protein +FIG00824221 FIG00824222: hypothetical protein +FIG00824226 FIG00824227: hypothetical protein +FIG00824228 FIG00824231: hypothetical protein +FIG00824231 FIG00824233: hypothetical protein +FIG00824233 FIG00824235: hypothetical protein +FIG00824236 FIG00824237: hypothetical protein +FIG00824237 Rhomboid family protein +FIG00824240 FIG00824242: hypothetical protein +FIG00824242 FIG00824246: hypothetical protein +FIG00824246 FIG00824247: hypothetical protein +FIG00824247 FIG00824252: hypothetical protein +FIG00824253 FIG00824259: hypothetical protein +FIG00824260 FIG00824264: hypothetical protein +FIG00824264 POSSIBLE MOLYBDOPTERIN BIOSYNTHESIS PROTEIN MOEY +FIG00824265 FIG00824266: hypothetical protein +FIG00824266 FIG00824268: hypothetical protein +FIG00824268 FIG00824962: possible membrane protein +FIG00824269 VapC22 antibacterial toxin protein +FIG00824273 FIG00824274: hypothetical protein +FIG00824274 FIG00824276: hypothetical protein +FIG00824278 FIG00824284: hypothetical protein +FIG00824286 FIG00824287: hypothetical protein +FIG00824287 NADH dehydrogenase CC0324 [imported] +FIG00824289 FIG00824290: hypothetical protein +FIG00824290 FIG025441: hypothetical protein +FIG00824292 FIG00824294: hypothetical protein +FIG00824296 Oxidoreductase, short-chain dehydrogenase/reductase family +FIG00824300 FIG00824301: hypothetical protein +FIG00824302 FIG00824304: hypothetical protein +FIG00824304 FIG00824306: hypothetical protein +FIG00824306 FIG00824308: hypothetical protein +FIG00824311 FIG00824312: hypothetical protein +FIG00824312 Transcriptional regulator, TetR family +FIG00824313 FIG00824314: hypothetical protein +FIG00824314 FIG00824316: hypothetical protein +FIG00824320 FIG00824322: hypothetical protein +FIG00824325 FIG00824327: hypothetical protein +FIG00824327 FIG00824328: hypothetical protein +FIG00824329 FIG00824333: hypothetical protein +FIG00824338 FIG00824339: hypothetical protein +FIG00824342 FIG00824343: hypothetical protein +FIG00824343 FIG00824345: hypothetical protein +FIG00824348 FIG00824349: hypothetical protein +FIG00824349 L-carnitine dehydratase/bile acid-inducible protein F +FIG00824355 DNA-binding response regulator, +FIG00824357 FIG00824358: hypothetical protein +FIG00824358 Oxidoreductase, short-chain dehydrogenase/reductase family +FIG00824361 FIG00824362: hypothetical protein +FIG00824362 FIG00824363: hypothetical protein +FIG00824363 FIG00824364: hypothetical protein +FIG00824364 FIG00824365: hypothetical protein +FIG00824365 FIG00824368: hypothetical protein +FIG00824368 FIG00824369: hypothetical protein +FIG00824370 FIG00824372: hypothetical protein +FIG00824380 FIG00824381: hypothetical protein +FIG00824381 FIG00824383: hypothetical protein +FIG00824383 Oxidoreductase, short-chain dehydrogenase/reductase family +FIG00824389 FIG00824390: hypothetical protein +FIG00824393 FIG00824394: hypothetical protein +FIG00824395 FIG00824397: hypothetical protein +FIG00824406 FIG00824408: hypothetical protein +FIG00824410 FIG00824412: hypothetical protein +FIG00824412 FIG00824413: hypothetical protein +FIG00824413 FIG00824416: hypothetical protein +FIG00824416 FIG00824417: hypothetical protein +FIG00824418 Methylmalonyl-CoA racemase (EC 5.1.99.1) +FIG00824419 FIG00824423: hypothetical protein +FIG00824423 FIG00824425: hypothetical protein +FIG00824427 FIG00824428: hypothetical protein +FIG00824432 FIG00824435: hypothetical protein +FIG00824441 Oxidoreductase, short-chain dehydrogenase/reductase family +FIG00824444 Peptidase S53 propeptide +FIG00824445 FIG00824447: hypothetical protein +FIG00824450 FIG00824452: hypothetical protein +FIG00824452 FIG00824454: hypothetical protein +FIG00824454 FIG00824456: hypothetical protein +FIG00824467 P450 heme-thiolate protein, putative +FIG00824470 FIG00824473: hypothetical protein +FIG00824473 FIG00824474: hypothetical protein +FIG00824479 FIG00824482: hypothetical protein +FIG00824482 FIG00824483: hypothetical protein +FIG00824483 FIG00824485: hypothetical protein +FIG00824510 FIG00824513: hypothetical protein +FIG00824513 FIG00824515: hypothetical protein +FIG00824524 FIG00824526: hypothetical protein +FIG00824526 FIG00824527: hypothetical protein +FIG00824527 Esterase LipC +FIG00824528 FIG00824529: hypothetical protein +FIG00824529 FIG00824532: hypothetical protein +FIG00824532 FIG00824533: hypothetical protein +FIG00824533 FIG00824535: hypothetical protein +FIG00824535 FIG00824538: hypothetical protein +FIG00824540 FIG00824541: hypothetical protein +FIG00824547 FIG00824548: hypothetical protein +FIG00824548 FIG00824549: hypothetical protein +FIG00824549 FIG00824550: hypothetical protein +FIG00824550 FIG00824553: hypothetical protein +FIG00824561 FIG00824562: hypothetical protein +FIG00824562 FIG00824565: hypothetical protein +FIG00824572 PE family protein +FIG00824573 FIG00824574: hypothetical protein +FIG00824575 ATP-dependent Clp protease +FIG00824579 FIG00824580: hypothetical protein +FIG00824580 FIG00821234: hypothetical protein +FIG00824584 FIG00824585: hypothetical protein +FIG00824585 FIG00824586: hypothetical protein +FIG00824586 FIG00824587: hypothetical protein +FIG00824587 FIG00824589: hypothetical protein +FIG00824589 FIG00824595: hypothetical protein +FIG00824597 FIG00824601: hypothetical protein +FIG00824601 FIG00824602: hypothetical protein +FIG00824602 FIG00824603: hypothetical protein +FIG00824603 Molecular chaperone protein DnaK +FIG00824604 FIG00824606: hypothetical protein +FIG00824606 FIG00824608: hypothetical protein +FIG00824614 FIG00824615: hypothetical protein +FIG00824619 FIG00824620: hypothetical protein +FIG00824620 FIG00824621: hypothetical protein +FIG00824623 FIG00824624: hypothetical protein +FIG00824624 FIG00824627: hypothetical protein +FIG00824627 lignostilbene-alpha,beta-dioxygenase +FIG00824639 FIG00824644: hypothetical protein +FIG00824644 FIG00824646: hypothetical protein +FIG00824655 FIG00824659: hypothetical protein +FIG00824659 FIG00824660: hypothetical protein +FIG00824660 Acyltransferase domain-containing protein +FIG00824664 FIG00824668: hypothetical protein +FIG00824671 FIG00824673: hypothetical protein +FIG00824679 FIG00824686: hypothetical protein +FIG00824686 FIG00824688: hypothetical protein +FIG00824688 FIG00824690: hypothetical protein +FIG00824690 FIG00824694: hypothetical protein +FIG00824695 FIG00824696: hypothetical protein +FIG00824697 FIG00824701: hypothetical protein +FIG00824705 FIG00824706: hypothetical protein +FIG00824707 FIG00824708: hypothetical protein +FIG00824708 FIG00824710: hypothetical protein +FIG00824710 Oxidoreductase, short-chain dehydrogenase/reductase family +FIG00824717 FIG00824719: hypothetical protein +FIG00824719 FIG00824720: hypothetical protein +FIG00824720 FIG00824721: hypothetical protein +FIG00824722 FIG00824726: hypothetical protein +FIG00824726 FIG00824729: hypothetical protein +FIG00824729 FIG00824730: hypothetical protein +FIG00824735 FIG00824736: hypothetical protein +FIG00824736 FIG00824739: hypothetical protein +FIG00824739 FIG00824741: hypothetical protein +FIG00824742 FIG00824746: hypothetical protein +FIG00824746 FIG00824747: hypothetical protein +FIG00824747 Diacyglycerol O-acyltransferase (EC 2.3.1.20) +FIG00824750 FIG00824752: hypothetical protein +FIG00824752 Acyl-CoA dehydrogenase (EC 1.3.8.1), Mycobacterial subgroup FadE6 +FIG00824754 FIG00824757: hypothetical protein +FIG00824760 FIG00824761: hypothetical protein +FIG00824763 Glycosyl transferase family protein +FIG00824765 Phenolpthiocerol synthesis type-I polyketide synthase PpsE +FIG00824766 FIG00824769: hypothetical protein +FIG00824769 FIG00824772: hypothetical protein +FIG00824779 FIG00824780: hypothetical protein +FIG00824782 FIG00824784: hypothetical protein +FIG00824784 FIG00824785: hypothetical protein +FIG00824785 FIG00824786: hypothetical protein +FIG00824798 FIG00824801: hypothetical protein +FIG00824811 Probable serine/threonine-protein kinase pknH (EC 2.7.11.1) +FIG00824812 FIG00824813: hypothetical protein +FIG00824813 FIG00824814: hypothetical protein +FIG00824819 FIG00824821: hypothetical protein +FIG00824830 FIG00824831: hypothetical protein +FIG00824831 FIG00824832: hypothetical protein +FIG00824832 FIG00824833: hypothetical protein +FIG00824833 FIG00824839: hypothetical protein +FIG00824839 Uncharacterized protein PhtU in phthalate degradation operon +FIG00824843 FIG00824845: hypothetical protein +FIG00824845 FIG01128099: hypothetical protein +FIG00824848 FIG00824849: hypothetical protein +FIG00824849 FIG00824851: hypothetical protein +FIG00824851 FIG00824852: hypothetical protein +FIG00824852 FIG00824857: hypothetical protein +FIG00824857 FIG00824858: hypothetical protein +FIG00824863 FIG00824866: hypothetical protein +FIG00824870 oxidoreductase, zinc-binding dehydrogenase family protein +FIG00824871 FIG00824872: hypothetical protein +FIG00824874 FIG00824875: hypothetical protein +FIG00824878 3-ketosteroid-delta-1-dehydrogenase +FIG00824882 FIG00824885: hypothetical protein +FIG00824886 Cutinase +FIG00824887 Acyl-CoA dehydrogenase (EC 1.3.8.1), Mycobacterial subgroup FadE22 +FIG00824890 FIG00824891: hypothetical protein +FIG00824891 FIG00824895: hypothetical protein +FIG00824895 FIG00824900: hypothetical protein +FIG00824910 FIG00824911: hypothetical protein +FIG00824912 FIG00824913: hypothetical protein +FIG00824914 FIG00824916: hypothetical protein +FIG00824916 FIG00824918: hypothetical protein +FIG00824924 FIG00824926: hypothetical protein +FIG00824926 FIG00824929: hypothetical protein +FIG00824929 FIG00824931: hypothetical protein +FIG00824931 FIG00824933: hypothetical protein +FIG00824933 FIG00824935: hypothetical protein +FIG00824935 Patatin-like protein +FIG00824936 FIG00824938: hypothetical protein +FIG00824938 FIG00824941: hypothetical protein +FIG00824949 FIG00824951: hypothetical protein +FIG00824952 Pyridoxamine 5'-phosphate oxidase-related, FMN-binding protein +FIG00824956 FIG00824959: hypothetical protein +FIG00824961 FIG00824962: possible membrane protein +FIG00824962 FIG00824964: hypothetical protein +FIG00824964 FIG00824965: hypothetical protein +FIG00824966 FIG00824968: hypothetical protein +FIG00824970 FIG00824971: hypothetical protein +FIG00824971 FIG00824972: hypothetical protein +FIG00824974 Acyl-CoA dehydrogenase +FIG00824977 FIG00824978: hypothetical protein +FIG00824981 FIG00824982: hypothetical protein +FIG00824982 FIG00824983: hypothetical protein +FIG00824983 FIG00824984: hypothetical protein +FIG00824984 Deblocking aminopeptidase (EC 3.4.11.-) @ Cyanophycinase 2 (EC 3.4.15.6) +FIG00824986 FIG00824987: hypothetical protein +FIG00824987 FIG00824988: hypothetical protein +FIG00824992 FIG00824993: hypothetical protein +FIG00824995 FIG00824997: hypothetical protein +FIG00824997 Carveol dehydrogenase +FIG00825004 FIG00825005: hypothetical protein +FIG00825005 FIG00825007: hypothetical protein +FIG00825007 FIG00825011: hypothetical protein +FIG00825011 FIG00825015: hypothetical protein +FIG00825021 FIG00825022: hypothetical protein +FIG00825022 FIG00825026: hypothetical protein +FIG00825026 FIG00825028: hypothetical protein +FIG00825028 FIG00825029: hypothetical protein +FIG00825029 FIG00825031: hypothetical protein +FIG00825031 FIG00825032: hypothetical protein +FIG00825032 FIG00825033: hypothetical protein +FIG00825036 FIG00825037: hypothetical protein +FIG00825037 FIG00825039: hypothetical protein +FIG00825041 Phospholipase D/transphosphatidylase +FIG00825044 FIG00825045: hypothetical protein +FIG00825048 FIG00825051: hypothetical protein +FIG00825052 Probable enoyl-CoA hydratase 1 (EC 4.2.1.17) +FIG00825055 FIG00825056: hypothetical protein +FIG00825057 FIG00825058: hypothetical protein +FIG00825059 FIG00825062: hypothetical protein +FIG00825062 FIG00825063: hypothetical protein +FIG00825063 FIG00825064: hypothetical protein +FIG00825064 FIG00825065: hypothetical protein +FIG00825071 FIG00825075: hypothetical protein +FIG00825075 Virulence factor mce family protein +FIG00825078 FIG00825079: hypothetical protein +FIG00825081 FIG00825084: hypothetical protein +FIG00825084 HAD family hydrolase +FIG00825090 FIG00825092: hypothetical protein +FIG00825096 FIG00825100: hypothetical protein +FIG00825100 FIG00825102: hypothetical protein +FIG00825104 FIG00825105: hypothetical protein +FIG00825106 FIG00825109: hypothetical protein +FIG00825109 Oxidoreductase, short-chain dehydrogenase/reductase family +FIG00825110 FIG00825114: hypothetical protein +FIG00825117 Ion transport 2 domain-containing protein +FIG00825119 FIG00825120: hypothetical protein +FIG00825120 FIG00825121: hypothetical protein +FIG00825122 FIG00825123: hypothetical protein +FIG00825124 FIG00825125: hypothetical protein +FIG00825126 FIG00825127: hypothetical protein +FIG00825145 FIG00825146: hypothetical protein +FIG00825148 FIG00825150: hypothetical protein +FIG00825155 FIG00825156: hypothetical protein +FIG00825156 FIG00822712: hypothetical protein +FIG00825157 FIG00825159: hypothetical protein +FIG00825159 FIG00825162: hypothetical protein +FIG00825162 FIG00825163: hypothetical protein +FIG00825167 FIG00825170: hypothetical protein +FIG00825171 FIG00825175: hypothetical protein +FIG00825175 FIG00825176: hypothetical protein +FIG00825176 FIG00825179: hypothetical protein +FIG00825179 FIG00825180: hypothetical protein +FIG00825180 FIG00825188: hypothetical protein +FIG00825190 FIG00825195: hypothetical protein +FIG00825198 FIG00825201: hypothetical protein +FIG00825202 FIG00825208: hypothetical protein +FIG00825208 FIG00825209: hypothetical protein +FIG00825212 FIG00825214: hypothetical protein +FIG00825214 Horizontally Transferred TransMembrane Domain (HTTM) protein +FIG00825217 FIG00825218: hypothetical protein +FIG00825218 FIG00825221: hypothetical protein +FIG00825222 FIG00825223: hypothetical protein +FIG00825223 FIG00825226: hypothetical protein +FIG00825228 FIG00825229: hypothetical protein +FIG00825229 FIG00825230: hypothetical protein +FIG00825234 FIG00825235: hypothetical protein +FIG00825249 Geranylgeranyl reductase (EC 1.3.1.83) +FIG00825252 FIG00825256: hypothetical protein +FIG00825256 FIG00825258: hypothetical protein +FIG00825262 FIG00825263: hypothetical protein +FIG00825263 FIG00825264: hypothetical protein +FIG00825264 FIG00825266: hypothetical protein +FIG00825268 FIG00825270: hypothetical protein +FIG00825270 Sigma 1-type opioid receptor +FIG00825272 FIG00825273: hypothetical protein +FIG00825273 3-ketoacyl-CoA thiolase +FIG00825274 FIG00825277: hypothetical protein +FIG00825278 FIG00825280: hypothetical protein +FIG00825280 FIG00825281: hypothetical protein +FIG00825285 Possible membrane protein +FIG00825291 FIG00825293: hypothetical protein +FIG00825293 FIG00825295: hypothetical protein +FIG00825295 FIG00825296: hypothetical protein +FIG00825304 FIG00825306: hypothetical protein +FIG00825307 Probable enoyl-CoA hydratase 1 (EC 4.2.1.17) +FIG00825308 FIG00825309: hypothetical protein +FIG00825313 FIG00825314: hypothetical protein +FIG00825317 FIG00825324: hypothetical protein +FIG00825328 FIG00825336: hypothetical protein +FIG00825336 FIG00825340: hypothetical protein +FIG00825340 FIG00825341: hypothetical protein +FIG00825342 Carboxymuconolactone decarboxylase +FIG00825357 FIG00825359: hypothetical protein +FIG00825359 FIG00825360: hypothetical protein +FIG00825360 FIG00825362: hypothetical protein +FIG00825363 CAIB-BAIF family protein, putative +FIG00825370 FIG00825373: hypothetical protein +FIG00825376 FIG00825378: hypothetical protein +FIG00825378 FIG00825382: hypothetical protein +FIG00825382 FIG00825385: hypothetical protein +FIG00825385 dehydrogenase, putative +FIG00825386 FIG00825392: hypothetical protein +FIG00825394 FIG00825396: hypothetical protein +FIG00825398 Phenylacetic acid degradation protein PaaI +FIG00825403 FIG00825404: hypothetical protein +FIG00825404 FIG00825406: hypothetical protein +FIG00825408 FIG00825411: hypothetical protein +FIG00825412 FIG00825416: hypothetical protein +FIG00825416 FIG00825418: hypothetical protein +FIG00825418 FIG00825420: hypothetical protein +FIG00825421 FIG00825422: hypothetical protein +FIG00825422 Probable carboxylesterase LipT (EC 3.1.1.-) +FIG00825424 FMN-dependent oxidoreductase, nitrilotriacetate monooxygenase family +FIG00825429 FIG00825431: hypothetical protein +FIG00825431 Hydrolase (HAD superfamily) +FIG00825436 FIG00825439: hypothetical protein +FIG00825439 FIG00825445: hypothetical protein +FIG00825445 FIG00825447: hypothetical protein +FIG00825447 FIG00825448: hypothetical protein +FIG00825448 LpqP protein +FIG00825450 FIG00825451: hypothetical protein +FIG00825451 FIG00825453: hypothetical protein +FIG00825454 FIG00825462: hypothetical protein +FIG00825464 FIG00825465: hypothetical protein +FIG00825467 FIG00825470: hypothetical protein +FIG00825476 FIG00825477: hypothetical protein +FIG00825486 FIG00825488: hypothetical protein +FIG00825488 FIG00825489: hypothetical protein +FIG00825489 ABC transporter, ATP-binding protein +FIG00825493 Antigen 85-A precursor (85A) (Antigen 85 complex A) (Ag85A) (Mycolyl transferase 85A) (EC 2.3.1.-) +FIG00825500 MFS transporter, sugar porter family +FIG00825507 FIG00825509: hypothetical protein +FIG00825513 FIG00822248: hypothetical protein +FIG00825516 FIG00825518: hypothetical protein +FIG00825518 Hydrolase, alpha/beta fold family protein +FIG00825522 FIG00825523: hypothetical protein +FIG00825527 FIG00825528: hypothetical protein +FIG00825528 FIG00825530: hypothetical protein +FIG00825530 FIG00825531: hypothetical protein +FIG00825532 Possible membrane protein +FIG00825535 FIG00825538: hypothetical protein +FIG00825540 Oxidoreductase, short-chain dehydrogenase/reductase family +FIG00825545 FIG00825548: hypothetical protein +FIG00825550 FIG00825552: hypothetical protein +FIG00825552 FIG00825553: hypothetical protein +FIG00825554 FIG00825558: hypothetical protein +FIG00825558 hypothetical protein Rv1639c +FIG00825560 FIG00825561: hypothetical protein +FIG00825561 FIG00825562: hypothetical protein +FIG00825562 FIG00825568: hypothetical protein +FIG00825568 FIG00825572: hypothetical protein +FIG00825572 Hydrolase, alpha/beta fold family protein +FIG00825573 FIG00825575: hypothetical protein +FIG00825575 FIG00825576: hypothetical protein +FIG00825576 FIG00825577: hypothetical protein +FIG00825582 FIG00825585: hypothetical protein +FIG00825592 FIG00825593: hypothetical protein +FIG00825593 FIG00825594: hypothetical protein +FIG00825596 FIG00825598: hypothetical protein +FIG00825601 FIG00825602: hypothetical protein +FIG00825603 FIG00825607: hypothetical protein +FIG00825607 AMP-binding enzyme +FIG00825609 FIG00825611: hypothetical protein +FIG00825617 FIG00825618: hypothetical protein +FIG00825625 FIG00825627: hypothetical protein +FIG00825630 cytochrome p450 107b1 +FIG00825631 dioxygenase +FIG00825638 FIG00825639: hypothetical protein +FIG00825643 FIG00825645: hypothetical protein +FIG00825646 FIG00825647: hypothetical protein +FIG00825647 FIG00825648: hypothetical protein +FIG00825648 FIG00825649: hypothetical protein +FIG00825651 FIG00825654: hypothetical protein +FIG00825654 FIG00825655: hypothetical protein +FIG00825659 FIG00825660: hypothetical protein +FIG00825661 FIG00831203: hypothetical protein +FIG00825664 FIG00825666: hypothetical protein +FIG00825674 FIG00825677: hypothetical protein +FIG00825678 FIG00825681: hypothetical protein +FIG00825683 FIG00825688: hypothetical protein +FIG00825690 FIG00825695: hypothetical protein +FIG00825695 DNA-binding response regulator, LuxR family +FIG00825697 Short-chain dehydrogenase/reductase SDR +FIG00825700 FIG00825702: hypothetical protein +FIG00825702 FIG00825705: hypothetical protein +FIG00825705 FIG00825706: hypothetical protein +FIG00825706 FIG00825709: hypothetical protein +FIG00825709 FIG00825710: hypothetical protein +FIG00825710 FIG00825712: hypothetical protein +FIG00825712 FIG00825713: hypothetical protein +FIG00825715 FIG00825717: hypothetical protein +FIG00825717 FIG00825719: hypothetical protein +FIG00825726 FIG00825727: hypothetical protein +FIG00825731 FIG00825734: hypothetical protein +FIG00825744 FIG00825745: hypothetical protein +FIG00825745 FIG00821990: hypothetical protein +FIG00825748 FIG00825754: hypothetical protein +FIG00825754 Serine esterase, cutinase family +FIG00825756 Core component NikM of nickel ECF transporter / Additional substrate-specific component NikN of nickel ECF transporter +FIG00825772 FIG00825775: hypothetical protein +FIG00825775 FIG00825777: hypothetical protein +FIG00825777 Taurine catabolism dioxygenase TauD/TfdA +FIG00825778 FIG00825779: hypothetical protein +FIG00825784 FIG00825785: hypothetical protein +FIG00825785 FIG00825788: hypothetical protein +FIG00825788 FIG00825789: hypothetical protein +FIG00825789 Acetamidase/Formamidase family protein +FIG00825791 FIG00825795: hypothetical protein +FIG00825795 FIG00825796: hypothetical protein +FIG00825796 FIG00825797: hypothetical protein +FIG00825799 FIG00825802: hypothetical protein +FIG00825804 FIG00825805: hypothetical protein +FIG00825805 FIG00825806: hypothetical protein +FIG00825806 FIG00825808: hypothetical protein +FIG00825808 FIG00825813: hypothetical protein +FIG00825813 FIG00825814: hypothetical protein +FIG00825814 FIG00825815: hypothetical protein +FIG00825815 NAD dependent epimerase/dehydratase family protein +FIG00825820 FIG00825821: hypothetical protein +FIG00825821 FIG00825822: hypothetical protein +FIG00825830 FIG00825832: hypothetical protein +FIG00825832 Multi-functional enzyme with acyl-CoA-reductase activity AcrA1_1 +FIG00825840 FIG00825842: hypothetical protein +FIG00825845 FIG00825846: hypothetical protein +FIG00825846 FIG00825847: hypothetical protein +FIG00825851 FIG00825855: hypothetical protein +FIG00825857 FIG00825868: hypothetical protein +FIG00825868 FIG00825871: hypothetical protein +FIG00825871 Glycosyl transferase family protein +FIG00825875 FIG00825878: hypothetical protein +FIG00825878 FIG00825881: hypothetical protein +FIG00825885 FIG00825887: hypothetical protein +FIG00825887 FIG00825894: hypothetical protein +FIG00825896 FIG00825897: hypothetical protein +FIG00825897 Oxidoreductase, short-chain dehydrogenase/reductase family +FIG00825903 FIG00825904: hypothetical protein +FIG00825904 FIG00825906: hypothetical protein +FIG00825912 Uncharacterized protein Rv1362c/MT1407 +FIG00825915 FIG00825921: hypothetical protein +FIG00825921 Luciferase family protein +FIG00825922 FIG00825926: hypothetical protein +FIG00825937 FIG00995176: hypothetical protein +FIG00825941 FIG00825943: hypothetical protein +FIG00825950 FIG00825955: hypothetical protein +FIG00825971 FIG00825973: hypothetical protein +FIG00825973 FIG00825978: hypothetical protein +FIG00825980 FIG00825983: hypothetical protein +FIG00825983 FIG00825986: hypothetical protein +FIG00825988 FIG00825989: hypothetical protein +FIG00825989 FIG00825990: hypothetical protein +FIG00825990 FIG00825991: hypothetical protein +FIG00825991 FIG00825992: hypothetical protein +FIG00825993 FIG00825994: hypothetical protein +FIG00825994 FIG00825996: hypothetical protein +FIG00825996 Rieske [2Fe-2S] domain, putative +FIG00826001 FIG00826004: hypothetical protein +FIG00826004 FIG00826007: hypothetical protein +FIG00826007 FIG00826008: hypothetical protein +FIG00826008 MOSC domain-containing protein +FIG00826010 FIG00826011: hypothetical protein +FIG00826011 FIG00826013: hypothetical protein +FIG00826013 FIG00826016: hypothetical protein +FIG00826022 FIG00826023: hypothetical protein +FIG00826023 FIG00826024: hypothetical protein +FIG00826029 FIG00826035: hypothetical protein +FIG00826038 FIG306134: hypothetical protein +FIG00826047 FIG00826052: hypothetical protein +FIG00826058 FIG00826059: hypothetical protein +FIG00826065 FIG00826069: hypothetical protein +FIG00826070 FIG00826071: hypothetical protein +FIG00826073 FIG00826075: hypothetical protein +FIG00826075 FIG00826076: hypothetical protein +FIG00826080 FIG00826083: hypothetical protein +FIG00826087 FIG00826091: hypothetical protein +FIG00826091 CpsH +FIG00826094 FIG00826101: hypothetical protein +FIG00826101 FIG00826102: hypothetical protein +FIG00826111 FIG00826113: hypothetical protein +FIG00826113 FIG00824720: hypothetical protein +FIG00826114 FIG00826115: hypothetical protein +FIG00826115 FIG00826116: hypothetical protein +FIG00826121 FIG01318144: Rieske (2Fe-2S) domain-containing protein +FIG00826122 response regulator +FIG00826125 FIG00826130: hypothetical protein +FIG00826131 FIG00826132: hypothetical protein +FIG00826134 FIG00826137: hypothetical protein +FIG00826137 FIG00826141: hypothetical protein +FIG00826147 periplasmic glutamine-binding protein; permease (glnH) +FIG00826150 FIG00826152: hypothetical protein +FIG00826156 FIG00826158: hypothetical protein +FIG00826158 FIG00823655: hypothetical protein +FIG00826172 FIG00826175: hypothetical protein +FIG00826177 FIG00826180: hypothetical protein +FIG00826180 FIG00826184: hypothetical protein +FIG00826187 serine esterase, cutinase family +FIG00826189 FIG00826190: hypothetical protein +FIG00826190 FIG00826191: hypothetical protein +FIG00826195 FIG00826196: hypothetical protein +FIG00826196 FIG00826202: hypothetical protein +FIG00826215 FIG00826217: hypothetical protein +FIG00826220 FIG00826221: hypothetical protein +FIG00826221 FIG00826222: hypothetical protein +FIG00826226 FIG00826229: hypothetical protein +FIG00826232 Mobile element protein +FIG00826234 FIG00826235: hypothetical protein +FIG00826238 FIG00826239: hypothetical protein +FIG00826239 FIG00826240: hypothetical protein +FIG00826240 glycine betaine-carnitine-choline ABC transporter, ATP-binding protein (proV) +FIG00826251 FIG00826252: hypothetical protein +FIG00826252 FIG00826255: hypothetical protein +FIG00826255 FIG00826256: hypothetical protein +FIG00826256 Drug resistance transporter, EmrB/QacA subfamily +FIG00826261 FIG00826262: hypothetical protein +FIG00826264 FIG00826265: hypothetical protein +FIG00826266 FIG00826267: hypothetical protein +FIG00826267 Acyl-coenzyme A oxidase 3, peroxisomal (EC 1.3.3.6) +FIG00826270 FIG00826271: hypothetical protein +FIG00826276 (MTV016.43c), len: 2523. Member of PPE-family of M. tuberculosis proteins, Gly-, Asn-rich MPTR subgroup. Most similar to MTV004_5 (3716 aa). FASTA scores: gp|AL0091|MTV004_5 Mycobacterium tuberculosis sequence (3716 aa)opt: 4672 z-score: 3736.8 E(): 0; 44.2% identity in 3174 aaoverlap. Also similar to MTV004_3, MTCY63_9, MTY13E10_17,MTY13E10_16, MTCY180_1, MTV050_1, MTCY3C7_23, MTV014_3, MTCY63_10 etc. TBparse score is 0.923 +FIG00826277 FIG00826280: hypothetical protein +FIG00826280 FIG00826283: hypothetical protein +FIG00826283 FIG00826286: hypothetical protein +FIG00826286 FIG00826287: hypothetical protein +FIG00826293 FIG00826295: hypothetical protein +FIG00826302 FIG00826304: hypothetical protein +FIG00826304 FIG00826306: hypothetical protein +FIG00826306 FIG00826307: hypothetical protein +FIG00826314 FIG00826317: hypothetical protein +FIG00826319 FIG00826320: hypothetical protein +FIG00826323 FIG00826330: hypothetical protein +FIG00826330 FIG00826332: hypothetical protein +FIG00826338 FIG00826340: hypothetical protein +FIG00826340 FIG00826342: hypothetical protein +FIG00826342 FIG00826345: hypothetical protein +FIG00826348 FIG00826350: hypothetical protein +FIG00826353 FIG00826355: hypothetical protein +FIG00826363 FIG00826365: hypothetical protein +FIG00826402 FIG305449: hypothetical protein +FIG00826405 FIG00826409: hypothetical protein +FIG00826413 FIG00826417: hypothetical protein +FIG00826417 FIG00826419: hypothetical protein +FIG00826419 Histidinol-phosphatase [alternative form] (EC 3.1.3.15) +FIG00826428 ABC transporter, ATP-binding component( EC:3.6.3.- ) +FIG00826430 FIG00826431: hypothetical protein +FIG00826431 FIG00826434: hypothetical protein +FIG00826437 FIG00826438: hypothetical protein +FIG00826438 FIG00826442: hypothetical protein +FIG00826446 FIG00826447: hypothetical protein +FIG00826451 FIG00826453: hypothetical protein +FIG00826453 FIG00826454: hypothetical protein +FIG00826454 FIG00826455: hypothetical protein +FIG00826455 FIG00826459: hypothetical protein +FIG00826459 FIG00826460: hypothetical protein +FIG00826461 FIG00826463: hypothetical protein +FIG00826463 FIG00826469: hypothetical protein +FIG00826469 FIG00826473: hypothetical protein +FIG00826477 FIG00826478: hypothetical protein +FIG00826478 FIG00826479: hypothetical protein +FIG00826479 FIG00826481: hypothetical protein +FIG00826496 FIG00826498: hypothetical protein +FIG00826503 FIG00826506: hypothetical protein +FIG00826508 FIG00826509: hypothetical protein +FIG00826509 FIG00826511: hypothetical protein +FIG00826511 FIG00826512: hypothetical protein +FIG00826512 FIG00826513: hypothetical protein +FIG00826517 FIG00826518: hypothetical protein +FIG00826521 FIG00826528: hypothetical protein +FIG00826530 Thiopurine S-methyltransferase (Tpmt) superfamily protein +FIG00826533 Mb1024, -, len: 143 aa. Equivalent to Rv0997, len: 143 aa, from Mycobacterium tuberculosis strain H37Rv, (100% identity in 143 aa overlap). Hypothetical unknown protein, equivalent to AAK45276.1 from Mycobacterium tuberculosis strain CDC1551 (87 aa) but longer 56 aa. +FIG00826538 FIG00826539: hypothetical protein +FIG00826539 lppE +FIG00826544 FIG00826545: hypothetical protein +FIG00826548 Putative uncharacterized protein BCG_2054 +FIG00826551 FIG00826552: hypothetical protein +FIG00826552 FIG00826553: hypothetical protein +FIG00826557 FIG00826558: hypothetical protein +FIG00826564 FIG00826570: hypothetical protein +FIG00826571 FIG00826577: hypothetical protein +FIG00826578 FIG00826582: hypothetical protein +FIG00826582 FIG00826585: hypothetical protein +FIG00826585 FIG00826586: hypothetical protein +FIG00826586 FIG00826587: hypothetical protein +FIG00826588 FIG00824447: hypothetical protein +FIG00826595 FIG00826597: hypothetical protein +FIG00826597 FIG00826598: hypothetical protein +FIG00826598 FIG00826599: hypothetical protein +FIG00826600 FIG00826601: hypothetical protein +FIG00826601 FIG00826603: hypothetical protein +FIG00826612 FIG00826613: hypothetical protein +FIG00826613 Anti-sigma F factor antagonist (spoIIAA-2); Anti-sigma B factor antagonist RsbV +FIG00826617 FIG00826621: hypothetical protein +FIG00826621 FIG00826623: hypothetical protein +FIG00826624 FIG00826631: hypothetical protein +FIG00826633 FIG00826634: hypothetical protein +FIG00826634 FIG00826636: hypothetical protein +FIG00826639 FIG00826642: hypothetical protein +FIG00826646 FIG00826647: hypothetical protein +FIG00826647 FIG00826649: hypothetical protein +FIG00826649 FIG00826652: hypothetical protein +FIG00826652 FadE25_2 +FIG00826653 FIG00826659: hypothetical protein +FIG00826659 Thermolysin precursor (EC 3.4.24.27) (Thermostable neutral proteinase) +FIG00826661 FIG00826662: hypothetical protein +FIG00826662 FIG00826663: hypothetical protein +FIG00826664 FIG00826666: hypothetical protein +FIG00826666 FIG00826668: hypothetical protein +FIG00826668 FIG00826669: hypothetical protein +FIG00826669 S-(hydroxymethyl)glutathione dehydrogenase +FIG00826680 FIG00826682: hypothetical protein +FIG00826682 FIG00826683: hypothetical protein +FIG00826684 FIG00826686: hypothetical protein +FIG00826687 FIG00826691: hypothetical protein +FIG00826691 FIG00826692: hypothetical protein +FIG00826692 FIG00826693: hypothetical protein +FIG00826698 FIG00826701: hypothetical protein +FIG00826701 FIG00826703: hypothetical protein +FIG00826704 FIG00826705: hypothetical protein +FIG00826705 FIG00826709: hypothetical protein +FIG00826725 FIG00826728: hypothetical protein +FIG00826743 FIG00826744: hypothetical protein +FIG00826745 FIG00826749: hypothetical protein +FIG00826759 dimethylmenaquinone methyltransferase +FIG00826761 FIG00826763: hypothetical protein +FIG00826763 FIG00826765: hypothetical protein +FIG00826765 FIG00826766: hypothetical protein +FIG00826767 FIG00826770: hypothetical protein +FIG00826770 FIG00826773: hypothetical protein +FIG00826778 FIG00826779: hypothetical protein +FIG00826779 FIG00826780: hypothetical protein +FIG00826782 FIG00826783: hypothetical protein +FIG00826785 FIG00826787: hypothetical protein +FIG00826787 FIG00826788: hypothetical protein +FIG00826792 FIG00826794: hypothetical protein +FIG00826794 FIG00826795: hypothetical protein +FIG00826795 FIG00826799: hypothetical protein +FIG00826799 FIG00826800: hypothetical protein +FIG00826813 FIG00826817: hypothetical protein +FIG00826817 FIG00826819: hypothetical protein +FIG00826821 FIG00826822: hypothetical protein +FIG00826822 FIG00826825: hypothetical protein +FIG00826825 FIG00826826: hypothetical protein +FIG00826832 FIG00826834: hypothetical protein +FIG00826837 Hydrolase, alpha/beta fold family protein +FIG00826839 FIG00826842: hypothetical protein +FIG00826844 FIG00826845: hypothetical protein +FIG00826845 FIG00826852: hypothetical protein +FIG00826852 PPOX class F420-dependent enzyme +FIG00826853 Thiocyanate hydrolase subunit beta (EC 3.5.5.8) +FIG00826860 FIG00826861: hypothetical protein +FIG00826861 FIG00826866: hypothetical protein +FIG00826866 FIG00826867: hypothetical protein +FIG00826870 FIG00826871: hypothetical protein +FIG00826871 Probable cation-transporting ATPase I (EC 3.6.3.-) +FIG00826875 FIG00826878: hypothetical protein +FIG00826878 DNA-dependent DNA polymerase beta chain +FIG00826881 FIG00826884: hypothetical protein +FIG00826886 FIG00826887: hypothetical protein +FIG00826887 FIG00826891: hypothetical protein +FIG00826892 FIG00826893: hypothetical protein +FIG00826893 PPE family protein +FIG00826898 FIG00826901: hypothetical protein +FIG00826905 FIG00826907: hypothetical protein +FIG00826907 Transcriptional regulator, LacI family protein +FIG00826911 FAD-dependent pyridine nucleotide-disulphide oxidoreductase +FIG00826916 FIG00826918: hypothetical protein +FIG00826918 FIG00826919: hypothetical protein +FIG00826925 FIG00826927: hypothetical protein +FIG00826927 FIG00826932: hypothetical protein +FIG00826932 FIG00826933: hypothetical protein +FIG00826933 FIG00826935: hypothetical protein +FIG00826946 FIG00826949: hypothetical protein +FIG00826959 FIG00826965: hypothetical protein +FIG00826972 Oxidoreductase, short-chain dehydrogenase/reductase family +FIG00826978 FIG00826979: hypothetical protein +FIG00826990 FIG00826994: hypothetical protein +FIG00826994 FIG00826995: hypothetical protein +FIG00826995 PE-PGRS family protein +FIG00826996 FIG00827002: hypothetical protein +FIG00827005 FIG00827007: hypothetical protein +FIG00827007 FIG00827009: hypothetical protein +FIG00827009 FIG00827012: hypothetical protein +FIG00827019 FIG00827021: hypothetical protein +FIG00827021 FIG00827027: hypothetical protein +FIG00827032 FIG00827033: hypothetical protein +FIG00827047 FIG00827048: hypothetical protein +FIG00827048 FIG00827053: hypothetical protein +FIG00827054 TWO COMPONENT SENSOR HISTIDINE KINASE DEVS +FIG00827056 FIG00827057: hypothetical protein +FIG00827057 FIG00827058: hypothetical protein +FIG00827058 putative carboxymethylenebutenolidase( EC:3.1.1.45 ) +FIG00827071 FIG00827072: hypothetical protein +FIG00827072 FIG00827074: hypothetical protein +FIG00827079 FIG00827082: hypothetical protein +FIG00827082 FIG00827084: hypothetical protein +FIG00827084 FIG00827085: hypothetical protein +FIG00827085 FIG00827086: hypothetical protein +FIG00827087 FIG00827089: hypothetical protein +FIG00827089 FIG00827093: hypothetical protein +FIG00827099 FIG00827100: hypothetical protein +FIG00827106 FIG00827107: hypothetical protein +FIG00827107 Cyclohexanecarboxylate-CoA ligase +FIG00827115 FIG00827116: hypothetical protein +FIG00827116 FIG00827117: hypothetical protein +FIG00827123 FIG00827124: hypothetical protein +FIG00827128 FIG00827129: hypothetical protein +FIG00827129 FIG00827130: hypothetical protein +FIG00827130 FIG00827133: hypothetical protein +FIG00827133 hypothetical protein +FIG00827136 (S)-2-hydroxy-acid oxidase chain D (EC 1.1.3.15) +FIG00827143 FIG00827145: hypothetical protein +FIG00827145 FIG00827146: hypothetical protein +FIG00827146 FIG00827150: hypothetical protein +FIG00827150 FIG00827153: hypothetical protein +FIG00827153 FIG00827154: hypothetical protein +FIG00827154 FIG00827155: hypothetical protein +FIG00827158 FIG00827160: hypothetical protein +FIG00827160 FIG00827163: hypothetical protein +FIG00827173 Glycosyl transferase family protein +FIG00827174 FIG00827177: hypothetical protein +FIG00827183 FIG00827185: hypothetical protein +FIG00827185 FIG00827189: hypothetical protein +FIG00827190 FIG00827194: hypothetical protein +FIG00827195 Two component system sensor histidine kinase +FIG00827198 FIG00827199: hypothetical protein +FIG00827203 FIG00827205: hypothetical protein +FIG00827207 FIG00827209: hypothetical protein +FIG00827232 CONSERVED HYPOTHETICAL CYSTEINE RICH PROTEIN (FRAGMENT) +FIG00827245 integral membrane protein ABC transporter +FIG00827249 FIG00827250: hypothetical protein +FIG00827252 Antigen 85-B precursor (85B) (Extracellular alpha-antigen) (Antigen 85 complex B) (Ag85B) (Mycolyl transferase 85B) (EC 2.3.1.-) +FIG00827256 FIG00827257: hypothetical protein +FIG00827257 FIG00827258: hypothetical protein +FIG00827263 FIG00827264: hypothetical protein +FIG00827265 FIG00827268: hypothetical protein +FIG00827270 FIG00827274: hypothetical protein +FIG00827275 FIG00827278: hypothetical protein +FIG00827278 FIG00827279: hypothetical protein +FIG00827279 FIG00827292: hypothetical protein +FIG00827308 FIG00827309: hypothetical protein +FIG00827309 FIG00827313: hypothetical protein +FIG00827313 FIG00827314: hypothetical protein +FIG00827317 FIG00827322: hypothetical protein +FIG00827327 Metal-dependent hydrolase +FIG00827337 FIG00827338: hypothetical protein +FIG00827338 Monoamine oxidase +FIG00827352 FIG00827358: hypothetical protein +FIG00827365 FIG00827374: hypothetical protein +FIG00827374 FIG00827377: hypothetical protein +FIG00827377 puromycin N-acetyltransferase, putative +FIG00827380 FIG00827381: hypothetical protein +FIG00827381 Lysophospholipase +FIG00827382 FIG00827386: hypothetical protein +FIG00827389 FIG00827395: hypothetical protein +FIG00827397 FIG00827398: hypothetical protein +FIG00827405 FIG00827406: hypothetical protein +FIG00827418 FIG00827427: hypothetical protein +FIG00827427 Anti-sigma factor antagonist +FIG00827437 FIG00827446: hypothetical protein +FIG00827446 Possible membrane protein +FIG00827449 FIG00827452: hypothetical protein +FIG00827452 FIG00827455: hypothetical protein +FIG00827455 FIG00827456: hypothetical protein +FIG00827456 FIG00827459: hypothetical protein +FIG00827462 FIG00827465: hypothetical protein +FIG00827465 FIG00827468: hypothetical protein +FIG00827468 Morphine 6-dehydrogenase (EC 1.1.1.218) +FIG00827469 FIG00827470: hypothetical protein +FIG00827474 FIG00827478: hypothetical protein +FIG00827479 FIG00827484: hypothetical protein +FIG00827488 FIG00827490: hypothetical protein +FIG00827490 FIG00827497: hypothetical protein +FIG00827503 FIG00827504: hypothetical protein +FIG00827504 FIG00827511: hypothetical protein +FIG00827511 FIG00827514: hypothetical protein +FIG00827521 FIG00827522: hypothetical protein +FIG00827529 Amidohydrolase family protein +FIG00827531 FAD-dependent pyridine nucleotide-disulphide oxidoreductase +FIG00827537 FIG00821176: hypothetical protein +FIG00827540 FIG00827541: hypothetical protein +FIG00827541 FIG00827542: hypothetical protein +FIG00827551 COG1872 +FIG00827557 FIG309211: hypothetical protein +FIG00827558 FIG00827562: hypothetical protein +FIG00827566 FIG00827568: hypothetical protein +FIG00827573 FIG00827576: hypothetical protein +FIG00827585 FIG00827587: hypothetical protein +FIG00827587 FIG00827589: hypothetical protein +FIG00827589 FIG00827590: hypothetical protein +FIG00827592 FIG00827595: hypothetical protein +FIG00827601 FIG00827605: hypothetical protein +FIG00827605 FIG00827606: hypothetical protein +FIG00827606 FIG00827613: hypothetical protein +FIG00827616 FIG00827617: hypothetical protein +FIG00827625 FIG00827626: hypothetical protein +FIG00827626 FIG00827627: hypothetical protein +FIG00827632 FIG00827638: hypothetical protein +FIG00827641 FIG00827643: hypothetical protein +FIG00827643 FIG00827644: hypothetical protein +FIG00827644 UDP-galactopyranose mutase (EC 5.4.99.9) +FIG00827648 FIG00827650: hypothetical protein +FIG00827653 FIG00827657: hypothetical protein +FIG00827657 FIG00827661: hypothetical protein +FIG00827679 FIG00827685: hypothetical protein +FIG00827686 FIG00827687: hypothetical protein +FIG00827690 FIG00827691: hypothetical protein +FIG00827691 Possible membrane protein +FIG00827700 FIG00827706: hypothetical protein +FIG00827706 FIG00827717: hypothetical protein +FIG00827719 FIG00827721: hypothetical protein +FIG00827725 FIG00827727: hypothetical protein +FIG00827738 FIG00827739: hypothetical protein +FIG00827739 FIG00827740: hypothetical protein +FIG00827740 FIG00827741: hypothetical protein +FIG00827747 FIG00827749: hypothetical protein +FIG00827749 FIG00827750: hypothetical protein +FIG00827761 FIG00827766: hypothetical protein +FIG00827769 FIG00827770: hypothetical protein +FIG00827770 FIG00827772: hypothetical protein +FIG00827775 FIG00827776: hypothetical protein +FIG00827785 FIG01121868: membrane protein +FIG00827792 FIG00827793: hypothetical protein +FIG00827793 FIG00827796: hypothetical protein +FIG00827796 FIG00827803: hypothetical protein +FIG00827803 FIG00827807: hypothetical protein +FIG00827807 FIG00827809: hypothetical protein +FIG00827812 nitrilotriacetate monooxygenase component A +FIG00827816 protein of unknown function DUF732 +FIG00827818 FIG022780: hypothetical protein +FIG00827827 FIG00827828: hypothetical protein +FIG00827830 FIG00827839: hypothetical protein +FIG00827839 ABC-type multidrug transport system, ATPase component +FIG00827850 FIG00827853: hypothetical protein +FIG00827861 Molecular chaperone protein DnaK +FIG00827865 FIG00827866: hypothetical protein +FIG00827868 FIG00827873: hypothetical protein +FIG00827874 FIG00827875: hypothetical protein +FIG00827875 FIG00827881: hypothetical protein +FIG00827881 FIG00827884: hypothetical protein +FIG00827884 FIG00827885: hypothetical protein +FIG00827885 FIG00827886: hypothetical protein +FIG00827893 FIG00827895: hypothetical protein +FIG00827895 FIG00827897: hypothetical protein +FIG00827901 FIG00827904: hypothetical protein +FIG00827904 FIG00827910: hypothetical protein +FIG00827910 FIG00827912: hypothetical protein +FIG00827918 FIG00827920: hypothetical protein +FIG00827927 FIG00827928: hypothetical protein +FIG00827928 Sugar phosphate isomerase/epimerase +FIG00827931 FIG00827933: hypothetical protein +FIG00827933 FIG00827934: hypothetical protein +FIG00827934 FIG00827939: hypothetical protein +FIG00827939 FIG00827945: hypothetical protein +FIG00827946 FIG00827948: hypothetical protein +FIG00827950 FIG00827952: hypothetical protein +FIG00827952 FIG00827953: hypothetical protein +FIG00827958 Monooxygenase, FAD-binding protein +FIG00827960 FIG00827962: hypothetical protein +FIG00827965 Ssl5025 protein +FIG00827969 Aminoglycoside phosphotransferase +FIG00827970 FIG00827972: hypothetical protein +FIG00827972 FIG00827974: hypothetical protein +FIG00827980 FIG00827981: hypothetical protein +FIG00827990 Oxidoreductase, short-chain dehydrogenase/reductase family +FIG00827996 FIG00827997: hypothetical protein +FIG00827997 FIG00828006: hypothetical protein +FIG00828021 FIG00828022: hypothetical protein +FIG00828022 FIG00828024: hypothetical protein +FIG00828032 FIG00828034: hypothetical protein +FIG00828034 FIG00828035: hypothetical protein +FIG00828035 FIG00828039: hypothetical protein +FIG00828040 FIG00828044: hypothetical protein +FIG00828045 helicase, C-terminal:DEAD/DEAH box helicase, N-terminal +FIG00828046 FIG00828048: hypothetical protein +FIG00828048 FIG00828053: hypothetical protein +FIG00828056 FIG00828063: hypothetical protein +FIG00828077 FIG00828079: hypothetical protein +FIG00828079 FIG00828082: hypothetical protein +FIG00828082 FIG00828083: hypothetical protein +FIG00828083 Probable pyruvate carboxylase +FIG00828084 FIG00828086: hypothetical protein +FIG00828086 FIG00828089: hypothetical protein +FIG00828091 FIG00828092: hypothetical protein +FIG00828092 FIG00828093: hypothetical protein +FIG00828095 FIG00828096: hypothetical protein +FIG00828096 FIG00828098: hypothetical protein +FIG00828109 FIG00828114: hypothetical protein +FIG00828117 FIG00828118: hypothetical protein +FIG00828123 FIG00828124: hypothetical protein +FIG00828129 FIG00828132: hypothetical protein +FIG00828136 FIG00828138: hypothetical protein +FIG00828138 acetyltransferase Atu4896, GNAT family +FIG00828139 FIG00828140: hypothetical protein +FIG00828140 FIG00828143: hypothetical protein +FIG00828143 FIG00828149: hypothetical protein +FIG00828152 Pirin family protein +FIG00828163 FIG00828164: hypothetical protein +FIG00828176 FIG00828178: hypothetical protein +FIG00828178 FIG00828182: hypothetical protein +FIG00828184 FIG00828188: hypothetical protein +FIG00828188 FIG00828189: hypothetical protein +FIG00828196 FIG00828198: hypothetical protein +FIG00828206 FIG00828209: hypothetical protein +FIG00828220 FIG00828221: hypothetical protein +FIG00828221 FIG00828224: hypothetical protein +FIG00828224 FIG00828228: hypothetical protein +FIG00828228 FIG00828234: hypothetical protein +FIG00828234 FIG00832292: hypothetical protein +FIG00828235 Oxidoreductase, short-chain dehydrogenase/reductase family +FIG00828240 FIG00828243: hypothetical protein +FIG00828255 FIG00828264: hypothetical protein +FIG00828264 FIG00828275: hypothetical protein +FIG00828279 FIG00828281: hypothetical protein +FIG00828281 Possible membrane protein +FIG00828285 hypothetical protein Rv1639c +FIG00828290 FIG00828292: hypothetical protein +FIG00828293 FIG00828295: hypothetical protein +FIG00828297 FIG00828299: hypothetical protein +FIG00828299 FIG022825: hypothetical protein +FIG00828300 FIG00828303: hypothetical protein +FIG00828303 Transcriptional regulator, AraC family +FIG00828307 Protein PE35, involved in regulation of esxAB expression in Type VII secretion system ESX-1 +FIG00828310 FIG00828312: hypothetical protein +FIG00828321 FIG00828322: hypothetical protein +FIG00828324 FIG00828325: hypothetical protein +FIG00828325 Carveol dehydrogenase (EC 1.1.1.243) +FIG00828326 FIG00828329: hypothetical protein +FIG00828331 FIG00828332: hypothetical protein +FIG00828334 FIG00828335: hypothetical protein +FIG00828335 FIG00828338: hypothetical protein +FIG00828341 FIG00828343: hypothetical protein +FIG00828344 FIG00828355: hypothetical protein +FIG00828355 FIG00828360: hypothetical protein +FIG00828368 FIG00828370: hypothetical protein +FIG00828370 FIG00828372: hypothetical protein +FIG00828377 FIG00828378: hypothetical protein +FIG00828378 FIG00828381: hypothetical protein +FIG00828394 FIG00995176: hypothetical protein +FIG00828399 FIG00828401: hypothetical protein +FIG00828416 FIG00828423: hypothetical protein +FIG00828428 FIG00828429: hypothetical protein +FIG00828441 FIG00828442: hypothetical protein +FIG00828442 FIG00828443: hypothetical protein +FIG00828443 FIG00828445: hypothetical protein +FIG00828448 FIG00828449: hypothetical protein +FIG00828451 FIG00828455: hypothetical protein +FIG00828455 FIG00828457: hypothetical protein +FIG00828458 FIG00828461: hypothetical protein +FIG00828461 FIG00828462: hypothetical protein +FIG00828464 FIG00828465: hypothetical protein +FIG00828468 FIG00828469: hypothetical protein +FIG00828473 FIG00828474: hypothetical protein +FIG00828486 ABC-type dipeptide transport system, periplasmic component +FIG00828487 FIG00828488: hypothetical protein +FIG00828496 FIG00828498: hypothetical protein +FIG00828499 FIG00828501: hypothetical protein +FIG00828501 FIG00828503: hypothetical protein +FIG00828503 FIG00828504: hypothetical protein +FIG00828504 FIG00828505: hypothetical protein +FIG00828516 FIG00828517: hypothetical protein +FIG00828517 FIG00828522: hypothetical protein +FIG00828522 FIG00828524: hypothetical protein +FIG00828524 FIG00828529: hypothetical protein +FIG00828529 FIG00828531: hypothetical protein +FIG00828532 FIG00828533: hypothetical protein +FIG00828533 FIG00828534: hypothetical protein +FIG00828535 FIG00828536: hypothetical protein +FIG00828543 FIG00828544: hypothetical protein +FIG00828546 FIG00828551: hypothetical protein +FIG00828551 FIG00828553: hypothetical protein +FIG00828553 FIG00828555: hypothetical protein +FIG00828564 FIG00828565: hypothetical protein +FIG00828566 FIG00828568: hypothetical protein +FIG00828568 FIG00828569: hypothetical protein +FIG00828569 FIG00828570: hypothetical protein +FIG00828573 FIG00828576: hypothetical protein +FIG00828576 FIG00828579: hypothetical protein +FIG00828579 FIG00828580: hypothetical protein +FIG00828580 FIG00828583: hypothetical protein +FIG00828586 FIG00828587: hypothetical protein +FIG00828587 FIG00828596: hypothetical protein +FIG00828596 FIG00828598: hypothetical protein +FIG00828598 FIG00828599: hypothetical protein +FIG00828610 FIG00828612: hypothetical protein +FIG00828614 FIG00828616: hypothetical protein +FIG00828619 FIG00828620: hypothetical protein +FIG00828620 Cytochrome c oxidase caa3-type, assembly factor CtaG-related protein +FIG00828625 FIG00828626: hypothetical protein +FIG00828628 FIG00828629: hypothetical protein +FIG00828629 transcriptional regulatory protein (probably TetR/AcrR-family) +FIG00828645 FIG00828647: hypothetical protein +FIG00828647 FIG00828651: hypothetical protein +FIG00828651 FIG00828655: hypothetical protein +FIG00828655 teichoic acid biosynthesis protein +FIG00828664 FIG00828666: hypothetical protein +FIG00828668 FIG00828673: hypothetical protein +FIG00828673 FIG00828675: hypothetical protein +FIG00828675 FIG00828677: hypothetical protein +FIG00828677 anti-sigma-factor antagonist +FIG00828682 FIG00828683: hypothetical protein +FIG00828683 FIG00828686: hypothetical protein +FIG00828686 FIG00828690: hypothetical protein +FIG00828690 FIG00828696: hypothetical protein +FIG00828696 FIG00828697: hypothetical protein +FIG00828700 FIG00828703: hypothetical protein +FIG00828708 FIG00828709: hypothetical protein +FIG00828709 FIG00828711: hypothetical protein +FIG00828711 FIG00828712: hypothetical protein +FIG00828713 FIG00828716: hypothetical protein +FIG00828716 FIG00828719: hypothetical protein +FIG00828733 FIG00828734: hypothetical protein +FIG00828735 FIG00828737: hypothetical protein +FIG00828737 PE-PGRS FAMILY PROTEIN, PROBABLY TRIACYLGLYCEROL LIPASE (ESTERASE/LIPASE) (TRIGLYCERIDE LIPASE) (TRIBUTYRASE) (EC 3.1.1.3) +FIG00828739 Possible membrane protein +FIG00828742 FIG00828743: hypothetical protein +FIG00828743 diterpenoid dioxygenase +FIG00828756 FIG00828757: hypothetical protein +FIG00828758 peptide synthetase ScpsB, putative +FIG00828759 FIG00828763: hypothetical protein +FIG00828768 FIG00828776: hypothetical protein +FIG00828776 FIG00828779: hypothetical protein +FIG00828781 FIG00828783: hypothetical protein +FIG00828796 FIG00828798: hypothetical protein +FIG00828800 FIG00828801: hypothetical protein +FIG00828801 FIG00828804: hypothetical protein +FIG00828804 FIG00828807: hypothetical protein +FIG00828807 FIG00828809: hypothetical protein +FIG00828810 FIG00828811: hypothetical protein +FIG00828813 FIG00828814: hypothetical protein +FIG00828814 FIG00828816: hypothetical protein +FIG00828816 FIG00828817: hypothetical protein +FIG00828830 FIG00828834: hypothetical protein +FIG00828834 FIG00828836: hypothetical protein +FIG00828836 FIG00828840: hypothetical protein +FIG00828845 FIG00828846: hypothetical protein +FIG00828846 FIG00828847: hypothetical protein +FIG00828854 FIG00828855: hypothetical protein +FIG00828855 FIG00828859: hypothetical protein +FIG00828865 PE family protein +FIG00828872 FIG00828873: hypothetical protein +FIG00828876 FIG00828877: hypothetical protein +FIG00828881 FIG00828883: hypothetical protein +FIG00828884 FIG00828893: hypothetical protein +FIG00828897 19 kDa lipoprotein antigen LpqH +FIG00828899 FIG00828906: hypothetical protein +FIG00828906 FIG00828907: hypothetical protein +FIG00828907 FIG00828908: hypothetical protein +FIG00828908 FIG00828909: hypothetical protein +FIG00828909 FIG00828910: hypothetical protein +FIG00828910 FIG00828911: hypothetical protein +FIG00828912 FIG00828915: hypothetical protein +FIG00828915 FIG00828916: hypothetical protein +FIG00828916 FIG00828917: hypothetical protein +FIG00828926 FIG00828929: hypothetical protein +FIG00828929 FIG00828931: hypothetical protein +FIG00828932 FIG00828933: hypothetical protein +FIG00828933 FIG00828935: hypothetical protein +FIG00828940 hypothetical protein +FIG00828949 FIG00828950: hypothetical protein +FIG00828962 Antigen 85-A precursor (85A) (Antigen 85 complex A) (Ag85A) (Mycolyl transferase 85A) (EC 2.3.1.-) +FIG00828965 FIG00828966: hypothetical protein +FIG00828969 Possible membrane protein +FIG00828970 Phosphoesterase, PA-phosphatase related +FIG00828976 FIG00828983: hypothetical protein +FIG00828998 FIG00829003: hypothetical protein +FIG00829006 FIG00829014: hypothetical protein +FIG00829024 FIG00829025: hypothetical protein +FIG00829025 FIG00829027: hypothetical protein +FIG00829027 FIG00829031: hypothetical protein +FIG00829031 FIG00829038: hypothetical protein +FIG00829038 FIG00829040: hypothetical protein +FIG00829049 FIG00829050: hypothetical protein +FIG00829050 FIG00829051: hypothetical protein +FIG00829056 FIG00829057: hypothetical protein +FIG00829057 Transglutaminase-like enzymes, putative cysteine proteases +FIG00829061 FIG00829064: hypothetical protein +FIG00829064 FIG00829066: hypothetical protein +FIG00829072 FIG00829073: hypothetical protein +FIG00829076 FIG00829077: hypothetical protein +FIG00829077 FIG00829078: hypothetical protein +FIG00829084 FIG00829085: hypothetical protein +FIG00829096 FIG00829100: hypothetical protein +FIG00829105 FIG00829106: hypothetical protein +FIG00829108 FIG00829109: hypothetical protein +FIG00829119 Thiamine pyrophosphate-requiring protein Saci_2281 +FIG00829125 FIG00829131: hypothetical protein +FIG00829131 FIG00829133: hypothetical protein +FIG00829133 FIG00829134: hypothetical protein +FIG00829138 FIG00829140: hypothetical protein +FIG00829140 FIG00829144: hypothetical protein +FIG00829147 FIG00829148: hypothetical protein +FIG00829148 FIG00829155: hypothetical protein +FIG00829159 Cutinase Cut2 (EC 3.1.1.74) +FIG00829167 FIG00829170: hypothetical protein +FIG00829170 FIG00829171: hypothetical protein +FIG00829171 FIG00829174: hypothetical protein +FIG00829174 FIG00829181: hypothetical protein +FIG00829181 FIG00829186: hypothetical protein +FIG00829186 FIG00829190: hypothetical protein +FIG00829190 FIG00829193: hypothetical protein +FIG00829193 FIG00829194: hypothetical protein +FIG00829203 FIG00829211: hypothetical protein +FIG00829211 FIG00829215: hypothetical protein +FIG00829217 FIG00829219: hypothetical protein +FIG00829222 FIG00829224: hypothetical protein +FIG00829224 signal-transducing histidine kinase, putative +FIG00829227 FIG00829229: hypothetical protein +FIG00829229 FIG00829233: hypothetical protein +FIG00829256 FIG00829258: hypothetical protein +FIG00829263 FIG00829265: hypothetical protein +FIG00829279 FIG00829281: hypothetical protein +FIG00829297 FIG00829299: hypothetical protein +FIG00829303 FIG00829307: hypothetical protein +FIG00829307 FIG00829308: hypothetical protein +FIG00829312 Possible membrane protein +FIG00829313 FIG00829314: hypothetical protein +FIG00829314 FIG00829316: hypothetical protein +FIG00829319 FIG00829320: hypothetical protein +FIG00829323 putative PE-family protein +FIG00829346 2-deoxy-D-gluconate 3-dehydrogenase (kduD) +FIG00829349 FIG00829350: hypothetical protein +FIG00829350 FIG312471: hypothetical protein +FIG00829359 FIG00829361: hypothetical protein +FIG00829361 Oxalate/formate antiporter +FIG00829369 Polycyclic aromatic hydrocarbon dioxygenase alpha subunit +FIG00829373 FIG00829376: hypothetical protein +FIG00829376 FIG00829378: hypothetical protein +FIG00829378 FIG00829380: hypothetical protein +FIG00829404 FIG00829405: hypothetical protein +FIG00829406 FIG00829409: hypothetical protein +FIG00829421 FIG00829423: hypothetical protein +FIG00829425 UDP-glucoronosyl and UDP-glucosyltransferases family protein +FIG00829428 FIG00829433: hypothetical protein +FIG00829433 Possible lipoprotein LprC +FIG00829434 FIG00829435: hypothetical protein +FIG00829437 FIG00829439: hypothetical protein +FIG00829443 FIG00829446: hypothetical protein +FIG00829446 FIG00829448: hypothetical protein +FIG00829448 FIG00829451: secreted protein +FIG00829461 FIG00829465: hypothetical protein +FIG00829465 FIG00829470: hypothetical protein +FIG00829470 FIG00829472: hypothetical protein +FIG00829472 FIG00829475: hypothetical protein +FIG00829478 FIG00829479: hypothetical protein +FIG00829479 FIG00829481: hypothetical protein +FIG00829481 FIG00829482: hypothetical protein +FIG00829482 FIG00829483: hypothetical protein +FIG00829484 FIG00829488: hypothetical protein +FIG00829489 FIG00829490: hypothetical protein +FIG00829492 FIG00829495: hypothetical protein +FIG00829499 osteoblast specific factor 2-related protein +FIG00829501 FIG00829505: hypothetical protein +FIG00829505 FIG00829507: hypothetical protein +FIG00829509 FIG00829511: hypothetical protein +FIG00829523 FIG00829525: hypothetical protein +FIG00829527 FIG00829536: hypothetical protein +FIG00829546 FIG00829547: hypothetical protein +FIG00829548 FIG00829549: hypothetical protein +FIG00829550 FIG00829552: hypothetical protein +FIG00829556 FIG00829569: hypothetical protein +FIG00829573 FIG00829574: hypothetical protein +FIG00829575 FIG01318144: Rieske (2Fe-2S) domain-containing protein +FIG00829580 FIG00829583: hypothetical protein +FIG00829583 FIG00829585: hypothetical protein +FIG00829585 FIG00829587: hypothetical protein +FIG00829587 FIG00829589: hypothetical protein +FIG00829609 Putative acyl-CoA transferase/carnitine dehydratase +FIG00829615 FIG00829618: hypothetical protein +FIG00829623 Glucokinase +FIG00829631 FIG00829633: hypothetical protein +FIG00829633 FIG00829634: hypothetical protein +FIG00829646 FIG00829649: hypothetical protein +FIG00829670 FIG00829672: hypothetical protein +FIG00829672 FIG00829675: hypothetical protein +FIG00829675 FIG00829678: hypothetical protein +FIG00829682 FIG00829691: hypothetical protein +FIG00829693 Possible membrane protein +FIG00829696 transcriptional repressor, CopY family +FIG00829705 FIG00829707: hypothetical protein +FIG00829708 FIG00829710: hypothetical protein +FIG00829710 FIG00829714: hypothetical protein +FIG00829734 FIG00829736: hypothetical protein +FIG00829737 FIG00829738: hypothetical protein +FIG00829739 FIG00829740: hypothetical protein +FIG00829746 hypothetical protein Rv1667c +FIG00829748 FIG00833209: hypothetical protein +FIG00829753 FIG00829758: hypothetical protein +FIG00829763 Glucose-6-phosphate 1-dehydrogenase (EC 1.1.1.49) +FIG00829765 FIG00829766: hypothetical protein +FIG00829766 FIG00829768: hypothetical protein +FIG00829776 FIG00829777: hypothetical protein +FIG00829792 FIG00829793: hypothetical protein +FIG00829796 Hydrolase, alpha/beta fold family protein +FIG00829800 FIG00829802: hypothetical protein +FIG00829804 FIG00829806: hypothetical protein +FIG00829815 FIG00829821: hypothetical protein +FIG00829827 FIG00829829: hypothetical protein +FIG00829829 Mucin 2 precursor +FIG00829831 FIG00829832: hypothetical protein +FIG00829836 Putative S-adenosyl-L-methionine-dependent methyltransferase (EC 2.1.1.-) +FIG00829840 FIG00829843: hypothetical protein +FIG00829860 FIG00829864: hypothetical protein +FIG00829870 FIG00829872: hypothetical protein +FIG00829882 glutamyl aminopeptidase, M42 family +FIG00829885 FIG00829886: hypothetical protein +FIG00829886 FIG00829888: hypothetical protein +FIG00829889 FIG00829891: hypothetical protein +FIG00829897 FIG00829901: hypothetical protein +FIG00829901 FIG00829902: hypothetical protein +FIG00829903 FIG00829905: hypothetical protein +FIG00829905 FIG00829909: hypothetical protein +FIG00829914 FIG00829916: hypothetical protein +FIG00829920 FIG00829922: hypothetical protein +FIG00829932 FIG00829938: hypothetical protein +FIG00829939 FIG00829943: hypothetical protein +FIG00829944 FIG00829945: hypothetical protein +FIG00829945 FIG00829947: hypothetical protein +FIG00829951 FIG00829963: hypothetical protein +FIG00829967 FIG00829968: hypothetical protein +FIG00829968 FIG00829970: hypothetical protein +FIG00829974 PE family protein +FIG00829988 FIG00829989: hypothetical protein +FIG00830008 FIG00830011: hypothetical protein +FIG00830016 Acyl-CoA dehydrogenase (EC 1.3.8.1), Mycobacterial subgroup FadE27 +FIG00830017 FIG00830018: hypothetical protein +FIG00830018 FIG00830022: hypothetical protein +FIG00830023 FIG00830025: hypothetical protein +FIG00830027 Esat-6 like protein EsxE +FIG00830038 Possible membrane protein +FIG00830041 FIG00830042: hypothetical protein +FIG00830045 FIG00830052: hypothetical protein +FIG00830061 FIG00830062: hypothetical protein +FIG00830067 FIG00830068: hypothetical protein +FIG00830070 FIG00830071: hypothetical protein +FIG00830076 FIG00830078: hypothetical protein +FIG00830082 FIG00830083: hypothetical protein +FIG00830083 Alkaline phosphodiesterase I (EC 3.1.4.1) @ Nucleotide pyrophosphatase (EC 3.6.1.9) +FIG00830099 FIG00830100: hypothetical protein +FIG00830100 FIG00830106: hypothetical protein +FIG00830107 Capsular polysaccharide biosynthesis protein +FIG00830113 hydrolase, haloacid dehalogenase-like family, putative +FIG00830125 putative aminotransferase +FIG00830128 FIG00830129: hypothetical protein +FIG00830129 FIG00830132: hypothetical protein +FIG00830137 FIG00830140: hypothetical protein +FIG00830140 FIG00830141: hypothetical protein +FIG00830150 EphC +FIG00830153 FIG00830155: hypothetical protein +FIG00830166 FIG00830170: hypothetical protein +FIG00830170 PROBABLE CONSERVED MEMBRANE PROTEIN MMPS3 +FIG00830171 Sulfate adenylyltransferase +FIG00830173 FIG00830175: hypothetical protein +FIG00830184 FIG00830186: hypothetical protein +FIG00830191 FIG00830195: hypothetical protein +FIG00830213 FIG00830214: hypothetical protein +FIG00830217 COG3866 Pectate lyase +FIG00830218 FIG00830223: hypothetical protein +FIG00830229 tRNA uridine 5-carboxymethylaminomethyl modification enzyme GidA +FIG00830231 COG1872 +FIG00830237 FIG00830241: hypothetical protein +FIG00830243 FIG00830246: hypothetical protein +FIG00830246 Transmembrane transport protein MmpL family +FIG00830249 FIG00830255: hypothetical protein +FIG00830265 FIG00830266: hypothetical protein +FIG00830266 FIG00830267: hypothetical protein +FIG00830267 FIG00830268: hypothetical protein +FIG00830268 FIG00830271: hypothetical protein +FIG00830283 FIG00830285: hypothetical protein +FIG00830285 FIG00830288: hypothetical protein +FIG00830288 FIG00830295: hypothetical protein +FIG00830295 FIG00830296: hypothetical protein +FIG00830296 FIG00830298: hypothetical protein +FIG00830298 FIG00830305: hypothetical protein +FIG00830305 FIG00830308: hypothetical protein +FIG00830322 FIG00830326: hypothetical protein +FIG00830326 Heat shock protein transcriptional repressor HspR +FIG00830349 FIG00830350: hypothetical protein +FIG00830350 Glucoamylase and related glycosyl hydrolases +FIG00830353 FIG00830355: hypothetical protein +FIG00830362 FIG00830363: hypothetical protein +FIG00830367 FIG00830370: hypothetical protein +FIG00830374 FIG00830380: hypothetical protein +FIG00830394 putative cytochrome P450 hydroxylase +FIG00830412 FIG00830415: hypothetical protein +FIG00830418 FIG00830426: hypothetical protein +FIG00830426 POSSIBLE MCE-FAMILY LIPOPROTEIN LPRL (MCE-FAMILY LIPOPROTEIN MCE2E) +FIG00830430 FIG00830431: hypothetical protein +FIG00830431 Glyoxalase/bleomycin resistance protein/dioxygenase +FIG00830441 FIG00830446: hypothetical protein +FIG00830451 FIG00830452: hypothetical protein +FIG00830458 FIG00830461: hypothetical protein +FIG00830461 FIG00830464: hypothetical protein +FIG00830465 Esterase/lipase +FIG00830476 UDP-glucose 6-dehydrogenase, UdgL +FIG00830477 FIG00830478: hypothetical protein +FIG00830483 FIG00830487: hypothetical protein +FIG00830493 FIG00830498: hypothetical protein +FIG00830498 FIG00830502: hypothetical protein +FIG00830502 FIG00830506: hypothetical protein +FIG00830506 3-alpha-hydroxysteroid dehydrogenase (EC 1.1.1.50) +FIG00830510 FIG00830511: hypothetical protein +FIG00830516 Short chain oxidoreductase +FIG00830528 FIG00830529: hypothetical protein +FIG00830531 PE-PPE, C-terminal domain protein +FIG00830533 FIG00830542: hypothetical protein +FIG00830542 FIG00830544: hypothetical protein +FIG00830544 FIG00830547: hypothetical protein +FIG00830549 FIG00830555: hypothetical protein +FIG00830555 FIG00830560: hypothetical protein +FIG00830560 FIG00830561: hypothetical protein +FIG00830563 FIG00830569: hypothetical protein +FIG00830569 FIG00830575: hypothetical protein +FIG00830575 FIG00830576: hypothetical protein +FIG00830577 FIG00830581: hypothetical protein +FIG00830581 FIG00830582: hypothetical protein +FIG00830582 FIG00830586: hypothetical protein +FIG00830591 FIG01956052: Probable drugs-transport transmembrane ATP-binding protein ABC transporter +FIG00830599 FIG00830608: hypothetical protein +FIG00830609 FIG00830617: hypothetical protein +FIG00830617 FIG00830619: hypothetical protein +FIG00830630 Nitroreductase family protein +FIG00830631 FIG00830632: hypothetical protein +FIG00830644 FIG00830647: hypothetical monooxygenase +FIG00830647 Geranylgeranyl pyrophosphate synthetase (EC 2.5.1.29) +FIG00830654 FIG00830655: hypothetical protein +FIG00830656 FIG00830659: hypothetical protein +FIG00830659 FIG00830660: hypothetical protein +FIG00830661 FIG00830662: hypothetical protein +FIG00830669 FIG00830670: hypothetical protein +FIG00830670 FIG00830672: hypothetical protein +FIG00830677 FIG00830679: hypothetical protein +FIG00830679 FIG00830683: hypothetical protein +FIG00830685 FIG00830689: hypothetical protein +FIG00830690 NLP-P60 family protein +FIG00830734 FIG00830738: hypothetical protein +FIG00830743 taurine ABC transporter, permease protein, putative +FIG00830760 PE-PGRS family protein +FIG00830769 conserved hypothetical regulatory protein +FIG00830781 FIG00830782: hypothetical protein +FIG00830794 FIG00830796: hypothetical protein +FIG00830802 FIG00830806: hypothetical protein +FIG00830810 FIG00830811: hypothetical protein +FIG00830811 FIG00830813: hypothetical protein +FIG00830826 FIG00822248: hypothetical protein +FIG00830834 FIG00830836: hypothetical protein +FIG00830836 FIG00830837: hypothetical protein +FIG00830837 FIG00830838: hypothetical protein +FIG00830838 FIG00830839: hypothetical protein +FIG00830839 FIG00830841: hypothetical protein +FIG00830846 FIG00830848: hypothetical protein +FIG00830848 FIG00830849: hypothetical protein +FIG00830857 FIG00830858: hypothetical protein +FIG00830868 FIG00830869: hypothetical protein +FIG00830870 FIG00830871: hypothetical protein +FIG00830871 FIG00830878: hypothetical protein +FIG00830881 FIG00830883: hypothetical protein +FIG00830886 FIG00830888: hypothetical protein +FIG00830888 FIG00830890: hypothetical protein +FIG00830893 FIG00830895: hypothetical protein +FIG00830905 FIG00830906: hypothetical protein +FIG00830922 FIG00830927: hypothetical protein +FIG00830927 FIG00830929: hypothetical protein +FIG00830929 FIG00830930: hypothetical protein +FIG00830936 Rmt2 protein +FIG00830940 FIG00830946: hypothetical protein +FIG00830951 FIG00830955: hypothetical protein +FIG00830972 FIG00830981: hypothetical protein +FIG00830998 FIG00831000: hypothetical protein +FIG00831003 FIG00831004: hypothetical protein +FIG00831006 FIG00831021: hypothetical protein +FIG00831038 FIG00831040: hypothetical protein +FIG00831045 FIG00831047: hypothetical protein +FIG00831048 FIG00831053: hypothetical protein +FIG00831056 FIG00831057: hypothetical protein +FIG00831059 Mobile element protein +FIG00831062 FIG00831064: hypothetical protein +FIG00831070 DTDP-glucose 4,6-dehydratase (EC 4.2.1.46) +FIG00831092 FIG00831094: hypothetical protein +FIG00831112 Putative uncharacterized protein BCG_1787 +FIG00831113 1,4-dihydroxy-2-naphthoyl-CoA hydrolase (EC 3.1.2.28) in phylloquinone biosynthesis +FIG00831116 FIG00831122: hypothetical protein +FIG00831127 FIG00831128: hypothetical protein +FIG00831129 Putative uncharacterized protein BCG_3369 +FIG00831150 FIG311170: hypothetical protein +FIG00831154 FIG00831158: hypothetical protein +FIG00831183 FIG00831184: hypothetical protein +FIG00831184 FIG00831186: hypothetical protein +FIG00831186 Probable short-chain type dehydrogenase/reductase (EC 1.1.-.-) +FIG00831194 FIG00831195: hypothetical protein +FIG00831195 FIG00831203: hypothetical protein +FIG00831203 FIG00831205: hypothetical protein +FIG00831205 FIG00831206: hypothetical protein +FIG00831214 FIG00831221: hypothetical protein +FIG00831221 FIG00831225: hypothetical protein +FIG00831225 FIG00831227: hypothetical protein +FIG00831232 COG0383: Alpha-mannosidase +FIG00831233 Possible membrane protein +FIG00831237 FIG00823153: hypothetical protein +FIG00831240 FIG00831243: hypothetical protein +FIG00831246 Lipoprotein LpqQ +FIG00831252 Valiolone-7-phosphate 2-epimerase +FIG00831255 FIG00831262: hypothetical protein +FIG00831280 FIG00831285: hypothetical protein +FIG00831285 helix-turn-helix, Fis-type +FIG00831290 FIG00831293: hypothetical protein +FIG00831294 FIG00831301: hypothetical protein +FIG00831301 FIG00831302: hypothetical protein +FIG00831305 Transcriptional regulator, LysR family +FIG00831306 FIG00831316: hypothetical protein +FIG00831316 FIG00831317: hypothetical protein +FIG00831317 FIG00831320: hypothetical protein +FIG00831320 Zinc finger, UBP-type protein +FIG00831328 Diacyglycerol O-acyltransferase (EC 2.3.1.20) +FIG00831336 FIG00831338: hypothetical protein +FIG00831338 FIG00831340: hypothetical protein +FIG00831344 FIG00831345: hypothetical protein +FIG00831345 Plasma membrane ATPase (EC 3.6.3.6) +FIG00831352 Possible membrane protein +FIG00831356 FIG00831361: hypothetical protein +FIG00831366 FIG00831368: hypothetical protein +FIG00831370 FIG00831374: hypothetical protein +FIG00831374 POSSIBLE INTEGRASE (FRAGMENT) +FIG00831400 UPF0053 protein Rv1842c/MT1890 +FIG00831409 FIG00831411: hypothetical protein +FIG00831411 FIG00831412: hypothetical protein +FIG00831415 fig|164757.10.peg.4560 +FIG00831435 FIG00831440: hypothetical protein +FIG00831444 FIG00831448: hypothetical protein +FIG00831449 FIG00831454: hypothetical protein +FIG00831454 FIG00831455: hypothetical protein +FIG00831466 FIG00831469: hypothetical protein +FIG00831484 hypothetical glycosyl transferase( EC:2.- ) +FIG00831485 Oxidoreductase, 2-nitropropane dioxygenase family protein +FIG00831507 FIG00831516: hypothetical protein +FIG00831516 Oxidoreductase, short-chain dehydrogenase/reductase family +FIG00831524 FIG00831532: hypothetical protein +FIG00831552 FIG00831553: hypothetical protein +FIG00831556 CONSERVED 13E12 REPEAT FAMILY PROTEIN +FIG00831559 COG1872 +FIG00831562 FIG00831565: hypothetical protein +FIG00831565 FIG00831571: hypothetical protein +FIG00831582 FIG00831585: hypothetical protein +FIG00831594 FIG00831599: hypothetical protein +FIG00831606 FIG00831608: hypothetical protein +FIG00831619 FIG00831624: hypothetical protein +FIG00831625 FIG00831633: hypothetical protein +FIG00831633 FIG00831635: hypothetical protein +FIG00831635 Hydrolase, alpha/beta fold family protein +FIG00831639 FIG00831641: hypothetical protein +FIG00831643 FIG00831644: hypothetical protein +FIG00831655 FIG00831665: hypothetical protein +FIG00831667 FIG00831668: hypothetical protein +FIG00831700 FIG00831703: hypothetical protein +FIG00831705 FIG00831706: hypothetical protein +FIG00831706 FIG00831707: hypothetical protein +FIG00831707 ABC transporter, permease protein +FIG00831719 putative permease binding-protein component +FIG00831724 FIG00831729: hypothetical protein +FIG00831731 FIG00831733: hypothetical protein +FIG00831733 FIG00831734: hypothetical protein +FIG00831743 FIG00831745: hypothetical protein +FIG00831750 FIG00831752: hypothetical protein +FIG00831790 FIG00831791: hypothetical protein +FIG00831791 FIG00831796: hypothetical protein +FIG00831811 FIG00831815: hypothetical protein +FIG00831817 gluconate kinase, putative +FIG00831821 FIG00831832: hypothetical protein +FIG00831840 FIG00831842: hypothetical oxidoreductase +FIG00831842 FIG00831843: hypothetical protein +FIG00831847 FIG00831850: hypothetical protein +FIG00831850 FIG00831851: hypothetical protein +FIG00831853 FIG00831858: hypothetical protein +FIG00831872 FIG00831874: hypothetical protein +FIG00831880 FIG00831883: hypothetical protein +FIG00831883 Nucleoside-diphosphate-sugar epimerase +FIG00831889 FIG00831891: hypothetical protein +FIG00831905 Oxidoreductase, short-chain dehydrogenase/reductase family +FIG00831955 FIG00831959: hypothetical protein +FIG00831962 FIG00831964: hypothetical protein +FIG00831966 FIG00831968: hypothetical protein +FIG00831972 FIG00831975: hypothetical protein +FIG00831978 FIG00831980: hypothetical protein +FIG00831994 FIG00832000: hypothetical protein +FIG00832003 FIG00832005: hypothetical protein +FIG00832005 Possible oxidoreductase (EC 1.-.-.-) +FIG00832006 FIG00832010: hypothetical protein +FIG00832012 FIG00832022: hypothetical protein +FIG00832022 FIG00832024: hypothetical protein +FIG00832038 FIG00832039: hypothetical protein +FIG00832041 FIG00832047: hypothetical protein +FIG00832056 transcriptional regulator, CdaR +FIG00832060 FIG00832061: hypothetical protein +FIG00832061 FIG00832063: hypothetical protein +FIG00832083 NAD-dependent epimerase/dehydratase +FIG00832084 FIG00832085: hypothetical protein +FIG00832090 FIG00832092: hypothetical protein +FIG00832106 FIG00832108: hypothetical protein +FIG00832113 FIG00832116: hypothetical protein +FIG00832121 FIG00832125: hypothetical protein +FIG00832154 FIG00832158: hypothetical protein +FIG00832158 FIG00832159: hypothetical protein +FIG00832174 FIG00832177: hypothetical protein +FIG00832185 FIG00832188: hypothetical protein +FIG00832217 Probable cutinase Rv1984c/MT2037 precursor (EC 3.1.1.74) +FIG00832228 FIG00832229: hypothetical protein +FIG00832229 Short-chain dehydrogenase/reductase SDR +FIG00832231 FIG00832233: hypothetical protein +FIG00832236 FIG00832246: hypothetical protein +FIG00832246 FIG00832253: hypothetical protein +FIG00832257 FIG00832266: hypothetical protein +FIG00832284 Thioredoxin +FIG00832316 FIG00832317: hypothetical protein +FIG00832318 FIG00832319: hypothetical protein +FIG00832319 FIG00832323: hypothetical protein +FIG00832340 FIG00832345: hypothetical protein +FIG00832346 Acyltransferase family protein +FIG00832381 FIG00820558: hypothetical protein +FIG00832410 FIG00832411: hypothetical protein +FIG00832419 FIG00832420: hypothetical protein +FIG00832420 FIG00832423: hypothetical protein +FIG00832423 Acetyl-CoA acetyltransferase +FIG00832439 FIG00832440: hypothetical protein +FIG00832440 FIG00832443: hypothetical protein +FIG00832443 putative coenzyme PQQ synthesis protein +FIG00832448 FIG00832454: hypothetical protein +FIG00832474 FIG00832477: hypothetical protein +FIG00832493 FIG00832501: hypothetical protein +FIG00832501 FIG00832502: hypothetical protein +FIG00832502 FIG00832503: hypothetical protein +FIG00832520 FIG00832537: hypothetical protein +FIG00832537 FIG00826404: hypothetical protein +FIG00832577 FIG00832581: hypothetical protein +FIG00832589 FIG00832597: hypothetical protein +FIG00832607 FIG00832610: hypothetical protein +FIG00832619 FIG00832621: hypothetical protein +FIG00832627 FIG00832631: hypothetical protein +FIG00832636 FIG00832639: hypothetical protein +FIG00832639 FIG00832643: hypothetical protein +FIG00832684 FIG00832690: hypothetical protein +FIG00832700 FIG00832704: hypothetical protein +FIG00832705 FIG00832709: hypothetical protein +FIG00832739 FIG00832750: hypothetical protein +FIG00832764 FIG00832776: hypothetical protein +FIG00832781 FIG00832788: hypothetical protein +FIG00832788 fumarylacetoacetate hydrolase family protein +FIG00832797 FIG00832800: hypothetical protein +FIG00832800 FIG00832805: hypothetical protein +FIG00832821 FIG00832822: hypothetical protein +FIG00832843 FIG00832845: hypothetical protein +FIG00832889 FIG00832891: hypothetical protein +FIG00832910 FIG00832913: hypothetical protein +FIG00832971 FIG00832974: hypothetical protein +FIG00832974 FIG00832976: hypothetical protein +FIG00832989 FIG00832991: hypothetical protein +FIG00833008 FIG00833009: hypothetical protein +FIG00833016 FIG00833022: hypothetical protein +FIG00833055 FIG00833057: hypothetical protein +FIG00833081 FIG00833085: hypothetical protein +FIG00833090 FIG00833092: hypothetical protein +FIG00833093 FIG00833095: hypothetical protein +FIG00833095 FIG00833096: hypothetical protein +FIG00833101 oligosaccharide repeat unit transporter +FIG00833116 Sll1830 protein +FIG00833117 FIG00833118: hypothetical protein +FIG00833118 FIG00833122: hypothetical protein +FIG00833191 FIG00833193: hypothetical protein +FIG00833201 CONSERVED HYPOTHETICAL PROTEIN [FIRST PART] +FIG00833241 FIG00833251: hypothetical protein +FIG00833259 FIG00833263: hypothetical protein +FIG00833288 FIG00833290: hypothetical protein +FIG00833373 FIG00833378: hypothetical protein +FIG00833388 FIG00833391: hypothetical protein +FIG00833431 FIG00833435: hypothetical protein +FIG00833443 probable phosphoadenylyl-sulfate reductase (thioredoxin)( EC:1.8.4.8 ) +FIG00833502 FIG00833504: hypothetical protein +FIG00833517 FIG00833520: hypothetical protein +FIG00833557 FIG310674: hypothetical protein +FIG00833618 FIG00833620: hypothetical protein +FIG00833624 FIG00833626: hypothetical protein +FIG00833665 FIG00833668: hypothetical protein +FIG00833706 metabolite-proton symporter, putative +FIG00833727 sorbitol dehydrogenase, putative +FIG00833775 LipQ +FIG00833784 Mlr7324 protein +FIG00833842 FIG00833850: hypothetical protein +FIG00833850 FIG00833851: hypothetical protein +FIG00833851 FIG00833854: hypothetical protein +FIG00833854 FIG00833855: hypothetical protein +FIG00833855 FIG00833856: hypothetical protein +FIG00833857 putative DNase/RNase endonuclease( EC:3.1.31.1 ) +FIG00833858 FIG00833859: hypothetical protein +FIG00833859 FIG00833861: hypothetical protein +FIG00833861 FIG00833864: hypothetical protein +FIG00833864 FIG00833865: hypothetical protein +FIG00833865 putative vesicular transport factor Uso1p +FIG00833866 FIG00833867: hypothetical protein +FIG00833867 FIG00833868: hypothetical protein +FIG00833868 FIG00833870: hypothetical protein +FIG00833870 FIG00833872: hypothetical protein +FIG00833872 FIG00833873: hypothetical protein +FIG00833873 FIG00833878: hypothetical protein +FIG00833878 glutamine transport ATP-binding protein +FIG00833879 FIG00833880: hypothetical protein +FIG00833880 COG0596: Predicted hydrolases or acyltransferases (alpha/beta hydrolase superfamily) +FIG00833882 FIG00833885: hypothetical protein +FIG00833886 FIG00833888: hypothetical protein +FIG00833888 FIG00833889: hypothetical protein +FIG00833889 FIG00833893: hypothetical protein +FIG00833893 hypothetical prolipoprotein +FIG00833897 FIG00833898: hypothetical protein +FIG00833901 FIG00833905: hypothetical protein +FIG00833907 FIG00833908: hypothetical protein +FIG00833908 FIG00833910: hypothetical protein +FIG00833910 FIG00833911: hypothetical protein +FIG00833914 FIG00833916: hypothetical protein +FIG00833916 FIG00835598: hypothetical protein +FIG00833917 FIG00833919: hypothetical protein +FIG00833919 FIG00833920: hypothetical protein +FIG00833921 FIG00833922: hypothetical protein +FIG00833922 FIG00833923: hypothetical protein +FIG00833928 endopeptidase O( EC:3.4.24.- ) +FIG00833930 FIG00833931: hypothetical protein +FIG00833931 FIG00833932: hypothetical protein +FIG00833932 FIG00833935: hypothetical protein +FIG00833935 FIG00833937: hypothetical protein +FIG00833937 FIG00833938: hypothetical protein +FIG00833938 HAD-superfamily hydrolase subfamily IIB, protein +FIG00833940 FIG00833941: hypothetical protein +FIG00833945 FIG00833947: hypothetical protein +FIG00833950 FIG00833954: hypothetical protein +FIG00833954 FIG00833955: hypothetical protein +FIG00833960 FIG00833962: hypothetical protein +FIG00833962 FIG00833964: hypothetical protein +FIG00833966 FIG00833967: hypothetical protein +FIG00833967 FIG00833968: hypothetical protein +FIG00833969 FIG00833970: hypothetical protein +FIG00833970 P76 membrane protein +FIG00833971 FIG00833972: hypothetical protein +FIG00833972 FIG00833973: hypothetical protein +FIG00833973 FIG00833974: hypothetical protein +FIG00833976 FIG00833978: hypothetical protein +FIG00833978 FIG00833980: hypothetical protein +FIG00833981 FIG00833982: hypothetical protein +FIG00833984 FIG00833987: hypothetical protein +FIG00833987 FIG00833989: hypothetical protein +FIG00833989 FIG00833990: hypothetical protein +FIG00833990 FIG00833991: hypothetical protein +FIG00833994 FIG00833997: hypothetical protein +FIG00833997 FIG00833998: hypothetical protein +FIG00834007 FIG00834008: hypothetical protein +FIG00834008 FIG00834009: hypothetical protein +FIG00834009 COG1744: Uncharacterized ABC-type transport system, periplasmic component/surface lipoprotein +FIG00834010 FIG00834011: hypothetical protein +FIG00834016 hypothetical protein +FIG00834019 FIG00834020: hypothetical protein +FIG00834021 FIG00834022: hypothetical protein +FIG00834022 FIG00834024: hypothetical protein +FIG00834024 FIG00834026: hypothetical protein +FIG00834026 FIG00834027: hypothetical protein +FIG00834031 FIG00834032: hypothetical protein +FIG00834032 LIPOPROTEIN +FIG00834033 FIG00834035: hypothetical protein +FIG00834036 FIG066432: hypothetical protein cooccurring with ATP synthase chains +FIG00834038 Uncharacterized protein MG269.1 homolog +FIG00834039 FIG00834041: hypothetical protein +FIG00834041 Phase-variable hemagglutinin +FIG00834044 FIG00834050: hypothetical protein +FIG00834050 FIG00834052: hypothetical protein +FIG00834052 lipase/esterase, putative +FIG00834053 FIG00834055: hypothetical protein +FIG00834055 FIG00834056: hypothetical protein +FIG00834056 FIG00834057: hypothetical protein +FIG00834059 FIG00834062: hypothetical protein +FIG00834064 FIG00834065: hypothetical protein +FIG00834065 FIG00834066: hypothetical protein +FIG00834066 FIG00834068: hypothetical protein +FIG00834068 FIG00834069: hypothetical protein +FIG00834069 FIG00834070: hypothetical protein +FIG00834070 putative phase-variable hemagglutinin +FIG00834071 FIG00834073: hypothetical protein +FIG00834073 FIG00834075: hypothetical protein +FIG00834075 FIG00834077: hypothetical protein +FIG00834077 FIG00834078: hypothetical protein +FIG00834078 FIG00834080: hypothetical protein +FIG00834080 FIG00834085: hypothetical protein +FIG00834085 FIG00834086: hypothetical protein +FIG00834086 FIG00834087: hypothetical protein +FIG00834087 FIG00834090: hypothetical protein +FIG00834090 FIG00834092: hypothetical protein +FIG00834096 FIG00834104: hypothetical protein +FIG00834104 FIG00834105: hypothetical protein +FIG00834109 FIG00834110: hypothetical protein +FIG00834110 FIG00834111: hypothetical protein +FIG00834111 FIG00834112: hypothetical protein +FIG00834120 FIG00834124: hypothetical protein +FIG00834124 FIG00834125: hypothetical protein +FIG00834125 FIG00834126: hypothetical protein +FIG00834127 Conserved putative prolipoprotein +FIG00834128 FIG00834131: hypothetical protein +FIG00834136 Na+ ABC transporter, ATP-binding component +FIG00834141 Extracytoplasmic thiamin (pyrophosphate?) binding lipoprotein p37, specific for Mycoplasma +FIG00834144 FIG00834146: hypothetical protein +FIG00834149 FIG00834150: hypothetical protein +FIG00834153 putative potassium channel protein +FIG00834155 FIG00834157: hypothetical protein +FIG00834160 FIG00834162: hypothetical protein +FIG00834164 FIG00834165: hypothetical protein +FIG00834165 CrmA +FIG00834167 FIG00834169: hypothetical protein +FIG00834169 FIG00834172: hypothetical protein +FIG00834173 FIG00834175: hypothetical protein +FIG00834175 FIG059958: hypothetical in cluster with ATP synthase chains +FIG00834179 Uncharacterized protein MG105 +FIG00834180 FIG00834182: hypothetical protein +FIG00834182 FIG00834188: hypothetical protein +FIG00834192 COG0622: Predicted phosphoesterase +FIG00834195 FIG00834196: hypothetical protein +FIG00834197 Protein P97-like +FIG00834198 FIG00834199: hypothetical protein +FIG00834199 FIG00834201: hypothetical protein +FIG00834205 FIG00834206: hypothetical protein +FIG00834206 ABC TRANSPORTER PERMEASE PROTEIN +FIG00834207 FIG00834211: hypothetical protein +FIG00834211 FIG00834213: hypothetical protein +FIG00834213 Nuclease, lipoprotein (EC 3.1.31.1) +FIG00834216 FIG00834217: hypothetical protein +FIG00834217 FIG00834218: hypothetical protein +FIG00834237 FIG00834239: hypothetical protein +FIG00834239 FIG00834241: hypothetical protein +FIG00834244 FIG00834245: hypothetical protein +FIG00834248 FIG187434: hypothetical protein in cluster with ATP synthase chains +FIG00834252 FIG00834253: hypothetical protein +FIG00834253 FIG00834257: hypothetical protein +FIG00834257 FIG00834258: hypothetical protein +FIG00834269 FIG00834270: hypothetical protein +FIG00834270 FIG065159: hypothetical 2 cooccurring with ATP synthase chains +FIG00834274 FIG00834275: hypothetical protein +FIG00834276 FIG00834277: hypothetical protein +FIG00834278 GLYCOSYLTRANSFERASE +FIG00834279 FIG00834281: hypothetical protein +FIG00834282 FIG00834283: hypothetical protein +FIG00834289 FIG00834290: hypothetical protein +FIG00834291 FIG00834292: hypothetical protein +FIG00834296 FIG00834298: hypothetical protein +FIG00834301 FIG00834304: hypothetical protein +FIG00834304 AMINOPEPTIDASE +FIG00834305 Protein P102 +FIG00834308 FIG00834309: hypothetical protein +FIG00834310 FIG00834312: hypothetical protein +FIG00834313 Deoxynucleoside kinase +FIG00834316 FIG00834320: hypothetical protein +FIG00834320 transport ATP-binding protein +FIG00834321 COG1079: Uncharacterized ABC-type transport system, permease component +FIG00834322 FIG00834323: hypothetical protein +FIG00834323 dnaJ-like protein +FIG00834325 FIG00834329: hypothetical protein +FIG00834329 FIG00834330: hypothetical protein +FIG00834330 FIG00834331: hypothetical protein +FIG00834331 FIG00834335: hypothetical protein +FIG00834341 FIG00834342: hypothetical protein +FIG00834342 FIG00834343: hypothetical protein +FIG00834343 FIG00834344: hypothetical protein +FIG00834344 FIG00834348: hypothetical protein +FIG00834349 FIG00834351: hypothetical protein +FIG00834351 FIG00834354: hypothetical protein +FIG00834354 FIG00834355: hypothetical protein +FIG00834355 FIG00834358: hypothetical protein +FIG00834358 FIG00834359: hypothetical protein +FIG00834359 FIG00834360: hypothetical protein +FIG00834360 ABC transporter xylose-binding lipoprotein +FIG00834362 phenylalanyl-tRNA synthetase beta chain( EC:6.1.1.20 ) +FIG00834363 FIG00834364: hypothetical protein +FIG00834364 FIG00834365: hypothetical protein +FIG00834365 FIG00834366: hypothetical protein +FIG00834366 FIG00834367: hypothetical protein +FIG00834367 FIG00834370: hypothetical protein +FIG00834376 FIG00834379: hypothetical protein +FIG00834379 FIG00834381: hypothetical protein +FIG00834381 Uncharacterized protein MG133 +FIG00834389 FIG00834393: hypothetical protein +FIG00834396 unspecified toxin/drug ABC transporter ATP-binding and permease protein +FIG00834402 FIG00834407: hypothetical protein +FIG00834407 FIG00834408: hypothetical protein +FIG00834408 FIG00834409: hypothetical protein +FIG00834419 FIG00834422: hypothetical protein +FIG00834422 FIG00834424: hypothetical protein +FIG00834424 FIG00834426: hypothetical protein +FIG00834426 Uncharacterized glycosyltransferase MG335.2 (EC 2.-.-.-) +FIG00834429 FIG00834430: hypothetical protein +FIG00834430 FIG00834433: hypothetical protein +FIG00834441 FIG00834442: hypothetical protein +FIG00834442 FIG00834449: hypothetical protein +FIG00834449 FIG00834450: hypothetical protein +FIG00834452 VlhA.2.01 +FIG00834455 FIG00834456: hypothetical protein +FIG00834456 FIG00834458: hypothetical protein +FIG00834459 FIG00834460: hypothetical protein +FIG00834460 FIG00834461: hypothetical protein +FIG00834461 FIG00834462: hypothetical protein +FIG00834462 FIG00834465: hypothetical protein +FIG00834465 FIG00834467: hypothetical protein +FIG00834467 FIG00834468: hypothetical protein +FIG00834468 FIG00834471: hypothetical protein +FIG00834471 membrane nuclease +FIG00834473 FIG00834474: hypothetical protein +FIG00834475 FIG00834476: hypothetical protein +FIG00834478 PTS system, glucose-specific IIABC component (ptsG) +FIG00834481 unspecified ABC transporter ATP-binding subunit +FIG00834483 MGC2 +FIG00834484 FIG00834490: hypothetical protein +FIG00834490 FIG00834491: hypothetical protein +FIG00834495 FIG00834500: hypothetical protein +FIG00834504 FIG00834505: hypothetical protein +FIG00834505 FIG00834507: hypothetical protein +FIG00834507 FIG00834508: hypothetical protein +FIG00834508 FIG00834511: hypothetical protein +FIG00834511 FIG00834517: hypothetical protein +FIG00834521 FIG00834522: hypothetical protein +FIG00834522 FIG00834523: hypothetical protein +FIG00834523 FIG00834524: hypothetical protein +FIG00834524 FIG00834525: hypothetical protein +FIG00834525 FIG00834526: hypothetical protein +FIG00834526 FIG00834528: hypothetical protein +FIG00834531 FIG00834532: hypothetical protein +FIG00834532 FIG00834533: hypothetical protein +FIG00834536 FIG00834537: hypothetical protein +FIG00834538 FIG00834540: hypothetical protein +FIG00834540 FIG00834541: hypothetical protein +FIG00834541 FIG00834543: hypothetical protein +FIG00834546 FIG00834547: hypothetical protein +FIG00834547 FIG00834549: hypothetical protein +FIG00834549 FIG00834551: hypothetical protein +FIG00834551 YatU +FIG00834560 FIG00834561: hypothetical protein +FIG00834561 FIG00834565: hypothetical protein +FIG00834565 FIG00834566: hypothetical protein +FIG00834566 FIG00834567: hypothetical protein +FIG00834569 FIG00834570: hypothetical protein +FIG00834570 bacterial nucleoid DNA-binding protein +FIG00834573 FIG00834574: hypothetical protein +FIG00834579 FIG00834580: hypothetical protein +FIG00834580 FIG00834581: hypothetical protein +FIG00834581 FIG00834585: hypothetical protein +FIG00834585 FIG00834586: hypothetical protein +FIG00834588 FIG00834589: hypothetical protein +FIG00834589 FIG00834590: hypothetical protein +FIG00834590 FIG00834591: hypothetical protein +FIG00834596 FIG00834597: hypothetical protein +FIG00834599 FIG057547: hypothetical cooccurring with ATP synthase chains +FIG00834600 FIG00834601: hypothetical protein +FIG00834601 FIG00834608: hypothetical protein +FIG00834610 Glycerol ABC transporter, permease component +FIG00834611 FIG00834615: hypothetical protein +FIG00834616 FIG00834617: hypothetical protein +FIG00834617 FIG00834618: hypothetical protein +FIG00834618 FIG00834623: hypothetical protein +FIG00834624 FIG00834625: hypothetical protein +FIG00834626 FIG00834628: hypothetical protein +FIG00834628 FIG00834629: hypothetical protein +FIG00834629 FIG00834630: hypothetical protein +FIG00834632 FIG00834633: hypothetical protein +FIG00834634 FIG00834636: hypothetical protein +FIG00834639 Putative prophage protein (ps3) +FIG00834642 FIG00834646: hypothetical protein +FIG00834646 FIG00834647: hypothetical protein +FIG00834649 FIG00834650: hypothetical protein +FIG00834652 FIG00834653: hypothetical protein +FIG00834653 FIG00834655: hypothetical protein +FIG00834659 FIG00834660: hypothetical protein +FIG00834662 FIG00834663: hypothetical protein +FIG00834663 FIG00834664: hypothetical protein +FIG00834672 FIG00834673: hypothetical protein +FIG00834673 FIG00834674: hypothetical protein +FIG00834676 FIG00834677: hypothetical protein +FIG00834677 FIG00834679: hypothetical protein +FIG00834679 FIG00834682: hypothetical protein +FIG00834691 FIG00834693: hypothetical protein +FIG00834694 FIG00834695: hypothetical protein +FIG00834700 FIG00834704: hypothetical protein +FIG00834705 FIG00834710: hypothetical protein +FIG00834711 FIG00834713: hypothetical protein +FIG00834713 FIG00834714: hypothetical protein +FIG00834714 FIG00834720: hypothetical protein +FIG00834720 FIG00834723: hypothetical protein +FIG00834723 FIG00834725: hypothetical protein +FIG00834725 FIG00834726: hypothetical protein +FIG00834726 FIG00834729: hypothetical protein +FIG00834734 FIG00834736: hypothetical protein +FIG00834739 FIG00834740: hypothetical protein +FIG00834740 Acyl carrier protein phosphodiesterase +FIG00834742 FIG00834743: hypothetical protein +FIG00834743 FIG00834744: hypothetical protein +FIG00834748 FIG00834751: hypothetical protein +FIG00834754 FIG00834756: hypothetical protein +FIG00834756 FIG00834757: hypothetical protein +FIG00834760 FIG00834762: hypothetical protein +FIG00834762 FIG00834763: hypothetical protein +FIG00834773 FIG00834774: hypothetical protein +FIG00834777 FIG00834779: hypothetical protein +FIG00834786 FIG00834796: hypothetical protein +FIG00834796 FIG00834797: hypothetical protein +FIG00834804 FIG00834805: hypothetical protein +FIG00834805 FIG00834811: hypothetical protein +FIG00834811 FIG00834812: hypothetical protein +FIG00834815 FIG00834819: hypothetical protein +FIG00834822 FIG00834824: hypothetical protein +FIG00834824 FIG00834826: hypothetical protein +FIG00834826 FIG00834827: hypothetical protein +FIG00834827 FIG00834829: hypothetical protein +FIG00834829 FIG00834838: hypothetical protein +FIG00834839 FIG00834840: hypothetical protein +FIG00834840 Uncharacterized protein MG277 homolog +FIG00834845 FIG00834848: hypothetical protein +FIG00834848 Subtilisin-like serine protease (EC 3.4.21.-) +FIG00834849 FIG00834852: hypothetical protein +FIG00834854 FIG00834856: hypothetical protein +FIG00834856 FIG00834859: hypothetical protein +FIG00834859 FIG00834862: hypothetical protein +FIG00834863 FIG00834865: hypothetical protein +FIG00834866 COG1393: Arsenate reductase and related proteins, glutaredoxin family +FIG00834869 FIG00834871: hypothetical protein +FIG00834871 FIG00834872: hypothetical protein +FIG00834872 FIG00834878: hypothetical protein +FIG00834892 FIG00834897: hypothetical protein +FIG00834897 FIG00834904: hypothetical protein +FIG00834904 FIG00834906: hypothetical protein +FIG00834906 FIG00834907: hypothetical protein +FIG00834907 FIG00834908: hypothetical protein +FIG00834908 FIG00834909: hypothetical protein +FIG00834912 FIG00834914: hypothetical protein +FIG00834914 FIG00834916: hypothetical protein +FIG00834916 DEAD-box ATP-dependent RNA helicase CshB (EC 3.6.4.13) +FIG00834919 FIG00834920: hypothetical protein +FIG00834923 FIG00834927: hypothetical protein +FIG00834941 FIG00834943: hypothetical protein +FIG00834944 Hydrolase of the HAD family +FIG00834945 FIG00834947: hypothetical protein +FIG00834947 FIG00834948: hypothetical protein +FIG00834949 FIG00834952: hypothetical protein +FIG00834953 FIG00834954: hypothetical protein +FIG00834956 FIG00834959: hypothetical protein +FIG00834959 FIG00834960: hypothetical protein +FIG00834960 FIG00834964: hypothetical protein +FIG00834964 adenine-specific methyltransferase EcoRI +FIG00834970 FIG00834971: hypothetical protein +FIG00834971 Glycerol ABC transporter, ATP-binding component +FIG00834977 FIG00834979: hypothetical protein +FIG00834979 FIG00834980: hypothetical protein +FIG00834983 FIG00834984: hypothetical protein +FIG00834984 FIG00834986: hypothetical protein +FIG00834986 FIG00834988: hypothetical protein +FIG00834993 ABC TRANSPORTER ATP-BINDING +FIG00835000 NADPH-linked nitro/flavin oxidoreductase +FIG00835003 putative P60-like lipoprotein +FIG00835008 FIG00835010: hypothetical protein +FIG00835010 FIG00835013: hypothetical protein +FIG00835018 FIG00835019: hypothetical protein +FIG00835019 FIG00835020: hypothetical protein +FIG00835029 FIG00835030: hypothetical protein +FIG00835030 Putative C5 methylase (MAV1virus-like) +FIG00835031 FIG00835038: hypothetical protein +FIG00835038 FIG00835040: hypothetical protein +FIG00835040 expression not validated +FIG00835044 FIG00835050: hypothetical protein +FIG00835052 putative variable prolipoprotein +FIG00835055 Prolipoprotein lppC +FIG00835056 FIG00835058: hypothetical protein +FIG00835058 FIG00835059: hypothetical protein +FIG00835068 FIG00835069: hypothetical protein +FIG00835069 FIG00835074: hypothetical protein +FIG00835076 FIG00835078: hypothetical protein +FIG00835080 FIG00835081: hypothetical protein +FIG00835082 FIG00835084: hypothetical protein +FIG00835084 FIG00835088: hypothetical protein +FIG00835092 FIG00835094: hypothetical protein +FIG00835094 FIG00835096: hypothetical protein +FIG00835096 FIG00835097: hypothetical protein +FIG00835097 FIG00835098: hypothetical protein +FIG00835098 FIG00835105: hypothetical protein +FIG00835105 FIG00835107: hypothetical protein +FIG00835107 Transport system permease protein, associated with thiamin (pyrophosphate?) binding lipoprotein p37 +FIG00835108 FIG00835109: hypothetical protein +FIG00835109 HinA/Hup +FIG00835112 FIG00835114: hypothetical protein +FIG00835114 PTS system, mannitol-specific IIA component, putative( EC:2.7.1.69 ) +FIG00835117 FIG00835119: hypothetical protein +FIG00835121 FIG00835122: hypothetical protein +FIG00835122 FIG00835123: hypothetical protein +FIG00835123 FIG00835129: hypothetical protein +FIG00835131 FIG00835134: hypothetical protein +FIG00835135 FIG00835138: hypothetical protein +FIG00835142 FIG00835147: hypothetical protein +FIG00835148 FIG00835149: hypothetical protein +FIG00835150 FIG00835153: hypothetical protein +FIG00835153 FIG00835154: hypothetical protein +FIG00835155 FIG00835157: hypothetical protein +FIG00835157 FIG00835158: hypothetical protein +FIG00835158 FIG00835159: hypothetical protein +FIG00835159 FIG000557: hypothetical protein co-occurring with RecR +FIG00835166 FIG00835167: hypothetical protein +FIG00835167 FIG00835169: hypothetical protein +FIG00835170 FIG00835171: hypothetical protein +FIG00835171 FIG00835172: hypothetical protein +FIG00835172 FIG00835173: hypothetical protein +FIG00835173 FIG00835175: hypothetical protein +FIG00835175 FIG00835178: hypothetical protein +FIG00835178 FIG00835180: hypothetical protein +FIG00835180 FIG00835181: hypothetical protein +FIG00835185 FIG00835187: hypothetical protein +FIG00835187 FIG00835188: hypothetical protein +FIG00835188 FIG00835189: hypothetical protein +FIG00835189 FIG00835193: hypothetical protein +FIG00835201 FIG00835202: hypothetical protein +FIG00835204 FIG00835205: hypothetical protein +FIG00835214 FIG00835220: hypothetical protein +FIG00835221 Acyl carrier protein homolog +FIG00835231 FIG00835232: hypothetical protein +FIG00835233 FIG00835234: hypothetical protein +FIG00835236 FIG00835239: hypothetical protein +FIG00835249 P40, predicted lipoprotein +FIG00835250 cof-like hydrolase, HAD-superfamily +FIG00835257 FIG00835259: hypothetical protein +FIG00835261 FIG00835267: hypothetical protein +FIG00835268 FIG00835269: hypothetical protein +FIG00835269 FIG00835271: hypothetical protein +FIG00835276 FIG00835281: hypothetical protein +FIG00835289 FIG00835290: hypothetical protein +FIG00835290 FIG00835291: hypothetical protein +FIG00835291 FIG00835293: hypothetical protein +FIG00835295 FIG00835296: hypothetical protein +FIG00835296 FIG00835298: hypothetical protein +FIG00835299 FIG00835300: hypothetical protein +FIG00835300 FIG00835303: hypothetical protein +FIG00835309 FIG00835312: hypothetical protein +FIG00835314 FIG00835315: hypothetical protein +FIG00835318 FIG00835319: hypothetical protein +FIG00835319 FIG00835320: hypothetical protein +FIG00835320 FIG00835322: hypothetical protein +FIG00835322 FIG00835323: hypothetical protein +FIG00835324 FIG00835325: hypothetical protein +FIG00835325 FIG00835333: hypothetical protein +FIG00835333 FIG00835337: hypothetical protein +FIG00835337 FIG00835340: hypothetical protein +FIG00835340 FIG00835342: hypothetical protein +FIG00835351 FIG00835354: hypothetical protein +FIG00835354 FIG00835355: hypothetical protein +FIG00835355 FIG00835358: hypothetical protein +FIG00835358 FIG00835361: hypothetical protein +FIG00835361 proline-rich P65 protein +FIG00835363 GLUCOKINASE( EC:2.7.1.2 ) +FIG00835369 FIG00835370: hypothetical protein +FIG00835370 FIG00835371: hypothetical protein +FIG00835371 FIG00835372: hypothetical protein +FIG00835372 VlhA.3.07 +FIG00835374 FIG00835377: hypothetical protein +FIG00835378 Uncharacterized lipoprotein MG439 homolog 5 precursor +FIG00835379 FIG00835382: hypothetical protein +FIG00835382 FIG00835384: hypothetical protein +FIG00835384 FIG00835385: hypothetical protein +FIG00835388 FIG00835392: hypothetical protein +FIG00835393 FIG00835395: hypothetical protein +FIG00835395 30S ribosomal protein S1 +FIG00835396 ESTERASE/LIPASE +FIG00835401 uncharacterized domain HDIG +FIG00835405 FIG00835406: hypothetical protein +FIG00835406 FIG00835407: hypothetical protein +FIG00835407 FIG00835410: hypothetical protein +FIG00835416 FIG00835418: hypothetical protein +FIG00835420 FIG00835424: hypothetical protein +FIG00835425 FIG00835426: hypothetical protein +FIG00835431 Methionine ABC transporter ATP-binding protein +FIG00835432 FIG00835435: hypothetical protein +FIG00835438 FIG00835439: hypothetical protein +FIG00835439 Lipoprotein B +FIG00835441 FIG00835442: hypothetical protein +FIG00835442 FIG00835447: hypothetical protein +FIG00835451 FIG00835452: hypothetical protein +FIG00835453 FIG00835459: hypothetical protein +FIG00835461 FIG00835467: hypothetical protein +FIG00835467 FIG00835472: hypothetical protein +FIG00835472 FIG00835473: hypothetical protein +FIG00835485 FIG00835486: hypothetical protein +FIG00835488 FIG00835489: hypothetical protein +FIG00835489 FIG00835492: hypothetical protein +FIG00835497 FIG00835498: hypothetical protein +FIG00835499 FIG00835500: hypothetical protein +FIG00835504 proline rich protein 2 +FIG00835506 FIG00835507: hypothetical protein +FIG00835507 FIG00835512: hypothetical protein +FIG00835520 FIG00835522: hypothetical protein +FIG00835525 FIG00835526: hypothetical protein +FIG00835527 FIG00835529: hypothetical protein +FIG00835531 FIG00835532: hypothetical protein +FIG00835537 FIG00835538: hypothetical protein +FIG00835538 FIG00835541: hypothetical protein +FIG00835541 FIG00835542: hypothetical protein +FIG00835543 FIG00835545: hypothetical protein +FIG00835545 FIG00835546: hypothetical protein +FIG00835546 FIG00835551: hypothetical protein +FIG00835551 FIG00835554: hypothetical protein +FIG00835554 FIG00835557: hypothetical protein +FIG00835566 FIG00835567: hypothetical protein +FIG00835567 FIG00835569: hypothetical protein +FIG00835569 FIG00835573: hypothetical protein +FIG00835573 FIG00835575: hypothetical protein +FIG00835576 FIG00835580: hypothetical protein +FIG00835580 FIG00835582: hypothetical protein +FIG00835582 FIG00835583: hypothetical protein +FIG00835583 FIG00835588: hypothetical protein +FIG00835594 VlhA.3.08 variable lipoprotein family protein +FIG00835595 FIG00835596: hypothetical protein +FIG00835596 FIG00835597: hypothetical protein +FIG00835607 FIG00835609: hypothetical protein +FIG00835609 FIG00835610: hypothetical protein +FIG00835612 FIG00835613: hypothetical protein +FIG00835613 FIG00835614: hypothetical protein +FIG00835616 FIG00835617: hypothetical protein +FIG00835617 FIG00835618: hypothetical protein +FIG00835618 FIG00835628: hypothetical protein +FIG00835637 FIG00835638: hypothetical protein +FIG00835638 FIG00835639: hypothetical protein +FIG00835645 FIG00835646: hypothetical protein +FIG00835646 FIG00835648: hypothetical protein +FIG00835650 glucose/sucrose specific PTS system IIB component +FIG00835652 FIG00835657: hypothetical protein +FIG00835658 FIG00835660: hypothetical protein +FIG00835665 FIG00835667: hypothetical protein +FIG00835667 FIG00835668: hypothetical protein +FIG00835672 FIG00835673: hypothetical protein +FIG00835673 FIG00835674: hypothetical protein +FIG00835674 FIG00835677: hypothetical protein +FIG00835677 FIG00835678: hypothetical protein +FIG00835678 FIG00835683: hypothetical protein +FIG00835683 FIG00835686: hypothetical protein +FIG00835686 FIG00835687: hypothetical protein +FIG00835687 FIG00835691: hypothetical protein +FIG00835698 FIG00835699: hypothetical protein +FIG00835704 FIG00835707: hypothetical protein +FIG00835708 FIG00835709: hypothetical protein +FIG00835709 FIG00835710: hypothetical protein +FIG00835710 FIG00835711: hypothetical protein +FIG00835711 FIG00835712: hypothetical protein +FIG00835712 FIG00835714: hypothetical protein +FIG00835714 FIG00835718: hypothetical protein +FIG00835718 FIG00835722: hypothetical protein +FIG00835722 FIG00835723: hypothetical protein +FIG00835727 COG4603: ABC-type uncharacterized transport system, permease component +FIG00835736 FIG00835738: hypothetical protein +FIG00835749 FIG00835750: hypothetical protein +FIG00835757 FIG00835758: hypothetical protein +FIG00835764 Methylgalactoside permease ATP-binding protein +FIG00835772 FIG00835778: hypothetical protein +FIG00835778 FIG00835782: hypothetical protein +FIG00835782 competence locus operon protein 3 homolog; similar to Swiss-Prot Accession Number P39695, from B. subtilis +FIG00835785 FIG00835789: hypothetical protein +FIG00835791 FIG00835792: hypothetical protein +FIG00835796 FIG00835797: hypothetical protein +FIG00835798 FIG00835800: hypothetical protein +FIG00835800 FIG00835802: hypothetical protein +FIG00835802 FIG00835803: hypothetical protein +FIG00835812 FIG00835813: hypothetical protein +FIG00835813 FIG00835815: hypothetical protein +FIG00835819 FIG00835825: hypothetical protein +FIG00835826 FIG00835827: hypothetical protein +FIG00835827 FIG00835828: hypothetical protein +FIG00835828 FIG00835829: hypothetical protein +FIG00835833 FIG00835834: hypothetical protein +FIG00835834 protein-export membrane protein SecD +FIG00835837 FIG00835840: hypothetical protein +FIG00835845 FIG00835849: hypothetical protein +FIG00835851 FIG00835852: hypothetical protein +FIG00835852 FIG00835853: hypothetical protein +FIG00835853 FIG00835854: hypothetical protein +FIG00835872 putative variable surface protein +FIG00835878 FIG00835879: hypothetical protein +FIG00835879 FIG00835882: hypothetical protein +FIG00835885 FIG00835886: hypothetical protein +FIG00835886 FIG00835888: hypothetical protein +FIG00835889 FIG00835891: hypothetical protein +FIG00835891 FIG00835895: hypothetical protein +FIG00835903 FIG00835904: hypothetical protein +FIG00835904 FIG00835909: hypothetical protein +FIG00835909 onserved hypothetical +FIG00835911 FIG00835917: hypothetical protein +FIG00835919 FIG00835920: hypothetical protein +FIG00835922 FIG00835923: hypothetical protein +FIG00835923 FIG00835931: hypothetical protein +FIG00835931 FIG00835934: hypothetical protein +FIG00835934 FIG00835938: hypothetical protein +FIG00835938 WcaA +FIG00835944 FIG00835946: hypothetical protein +FIG00835946 FIG00835949: hypothetical protein +FIG00835952 FIG00835955: hypothetical protein +FIG00835957 FIG00835958: hypothetical protein +FIG00835959 FIG00835962: hypothetical protein +FIG00835966 FIG00835969: hypothetical protein +FIG00835969 FIG00835971: hypothetical protein +FIG00835971 FIG00835973: hypothetical protein +FIG00835980 FIG00835982: hypothetical protein +FIG00835987 competence protein ComEC +FIG00835989 FIG00835993: hypothetical protein +FIG00835998 cytadherence accessory protein HMW1 +FIG00835999 FIG00836003: hypothetical protein +FIG00836011 FIG00836012: hypothetical protein +FIG00836013 FIG00836014: hypothetical protein +FIG00836014 expression validated by proteogenomic mapping: 18 unique peptides covering 67.7% of sequence +FIG00836022 FIG00836024: hypothetical protein +FIG00836029 FIG00836030: hypothetical protein +FIG00836030 ABC TRANSPORTER ATP-BINDING AND PERMEASE PROTEIN (MDR HOMOLOG) +FIG00836032 FIG00836033: hypothetical protein +FIG00836034 FIG00836037: hypothetical protein +FIG00836037 FIG00836038: hypothetical protein +FIG00836038 FIG00836041: hypothetical protein +FIG00836041 FIG00836044: hypothetical protein +FIG00836057 membrane export protein family +FIG00836059 FIG00836061: hypothetical protein +FIG00836061 FIG00836063: hypothetical protein +FIG00836063 FIG00836066: hypothetical protein +FIG00836067 unique hypothetical lipoprotein +FIG00836076 FIG00836077: hypothetical protein +FIG00836077 FIG00836079: hypothetical protein +FIG00836094 Uncharacterized protein MG061 +FIG00836096 FIG00836097: hypothetical protein +FIG00836097 FIG00836098: hypothetical protein +FIG00836098 FIG00836099: hypothetical protein +FIG00836099 FIG00836109: hypothetical protein +FIG00836110 Heat shock protein GrpE +FIG00836111 FIG00836113: hypothetical protein +FIG00836114 FIG00836116: hypothetical protein +FIG00836119 FIG00836121: hypothetical protein +FIG00836127 sublancin 168 lantibiotic transporter +FIG00836129 FIG00836132: hypothetical protein +FIG00836134 FIG00836137: hypothetical protein +FIG00836148 FIG00836158: hypothetical protein +FIG00836158 similar to choline kinase +FIG00836162 FIG00836163: hypothetical protein +FIG00836164 FIG00836167: hypothetical protein +FIG00836173 FIG00836174: hypothetical protein +FIG00836175 FIG00836176: hypothetical protein +FIG00836176 FIG00836177: hypothetical protein +FIG00836181 FIG00836182: hypothetical protein +FIG00836182 FIG00836184: hypothetical protein +FIG00836185 FIG00836186: hypothetical protein +FIG00836186 FIG00836189: hypothetical protein +FIG00836189 FIG00836191: hypothetical protein +FIG00836192 FIG00836194: hypothetical protein +FIG00836195 FIG00836202: hypothetical protein +FIG00836202 FIG00836204: hypothetical protein +FIG00836207 FIG00836208: hypothetical protein +FIG00836208 FIG00836209: hypothetical protein +FIG00836213 Soj protein +FIG00836228 FIG00836230: hypothetical protein +FIG00836233 FIG00836234: hypothetical protein +FIG00836235 FIG00836236: hypothetical protein +FIG00836244 FIG00836245: hypothetical protein +FIG00836250 FIG00836252: hypothetical protein +FIG00836255 FIG00836257: hypothetical protein +FIG00836277 Prolipoprotein B +FIG00836282 FIG00836284: hypothetical protein +FIG00836293 FIG00836294: hypothetical protein +FIG00836296 FIG00836297: hypothetical protein +FIG00836297 FIG00836298: hypothetical protein +FIG00836298 FIG00836299: hypothetical protein +FIG00836299 FIG00836300: hypothetical protein +FIG00836304 FIG00836305: hypothetical protein +FIG00836305 FIG00836312: hypothetical protein +FIG00836312 FIG00836314: hypothetical protein +FIG00836326 FIG00836330: hypothetical protein +FIG00836332 FIG00836333: hypothetical protein +FIG00836334 FIG00836335: hypothetical protein +FIG00836335 FIG00836336: hypothetical protein +FIG00836346 FIG00836347: hypothetical protein +FIG00836352 FIG00836353: hypothetical protein +FIG00836353 FIG00836364: hypothetical protein +FIG00836364 FIG00836367: hypothetical protein +FIG00836370 FIG00836371: hypothetical protein +FIG00836372 FIG00836373: hypothetical protein +FIG00836374 FIG00836376: hypothetical protein +FIG00836377 FIG00836381: hypothetical protein +FIG00836394 VlhA.3.08 +FIG00836400 FIG00836405: hypothetical protein +FIG00836405 FIG00836408: hypothetical protein +FIG00836408 FIG00836412: hypothetical protein +FIG00836412 FIG00836416: hypothetical protein +FIG00836416 FIG00836419: hypothetical protein +FIG00836442 VLPE-LIKE (Mycoplasma hyorhinis) LIPOPROTEIN +FIG00836444 FIG00836445: hypothetical protein +FIG00836445 FIG00836446: hypothetical protein +FIG00836446 FIG00836448: hypothetical protein +FIG00836449 Transcription regulator gntR +FIG00836460 FIG00836461: hypothetical protein +FIG00836464 FIG00836465: hypothetical protein +FIG00836469 FIG00836470: hypothetical protein +FIG00836470 FIG00836473: hypothetical protein +FIG00836475 FIG00836477: hypothetical protein +FIG00836491 FIG00836492: hypothetical protein +FIG00836492 FIG00836494: hypothetical protein +FIG00836494 FIG00836496: hypothetical protein +FIG00836496 FIG00836497: hypothetical protein +FIG00836497 FIG00836500: hypothetical protein +FIG00836500 FIG00836503: hypothetical protein +FIG00836512 FIG00836514: hypothetical protein +FIG00836514 FIG00836515: hypothetical protein +FIG00836539 FIG00836543: hypothetical protein +FIG00836543 FIG00836546: hypothetical protein +FIG00836551 FIG00836556: hypothetical protein +FIG00836563 FIG00836564: hypothetical protein +FIG00836564 Conserved hypothetical protein, predictedlipoprotein +FIG00836565 FIG00836566: hypothetical protein +FIG00836571 FIG00836572: hypothetical protein +FIG00836573 FIG00836574: hypothetical protein +FIG00836576 FIG00836579: hypothetical protein +FIG00836586 FIG00836592: hypothetical protein +FIG00836592 chromate ion transporter (CHR) family, putative +FIG00836597 AprE-like +FIG00836607 FIG00836608: hypothetical protein +FIG00836608 FIG00836615: hypothetical protein +FIG00836616 FIG00836620: hypothetical protein +FIG00836620 FIG00836624: hypothetical protein +FIG00836629 ATP-dependent RNA helicase DeaD +FIG00836631 FIG00836632: hypothetical protein +FIG00836632 FIG00836638: hypothetical protein +FIG00836638 FIG00836640: hypothetical protein +FIG00836644 FIG00836649: hypothetical protein +FIG00836654 FIG00836658: hypothetical protein +FIG00836658 FIG00836664: hypothetical protein +FIG00836668 FIG00836669: hypothetical protein +FIG00836671 FIG00836672: hypothetical protein +FIG00836672 FIG00836674: hypothetical protein +FIG00836676 FIG00836677: hypothetical protein +FIG00836683 FIG00836686: hypothetical protein +FIG00836690 FIG00836691: hypothetical protein +FIG00836692 FIG00836693: hypothetical protein +FIG00836693 FIG00836694: hypothetical protein +FIG00836694 FIG00836695: hypothetical protein +FIG00836700 FIG00836704: hypothetical protein +FIG00836708 FIG00836710: hypothetical protein +FIG00836710 FIG00836715: hypothetical protein +FIG00836726 FIG00836727: hypothetical protein +FIG00836748 FIG00836756: hypothetical protein +FIG00836761 FIG00836762: hypothetical protein +FIG00836780 FIG00836783: hypothetical protein +FIG00836785 FIG00836788: hypothetical protein +FIG00836790 FIG00836794: hypothetical protein +FIG00836794 FIG00836795: hypothetical protein +FIG00836802 FIG00836804: hypothetical protein +FIG00836817 FIG00836819: hypothetical protein +FIG00836819 FIG00836825: hypothetical protein +FIG00836825 FIG00836827: hypothetical protein +FIG00836827 FIG00836830: hypothetical protein +FIG00836833 FIG00836837: hypothetical protein +FIG00836837 FIG00836840: hypothetical protein +FIG00836856 FIG00836857: hypothetical protein +FIG00836858 FIG00836861: hypothetical protein +FIG00836861 FIG00836867: hypothetical protein +FIG00836867 Mg/Co/Ni transporter MgtE / CBS domain +FIG00836880 FIG00836881: hypothetical protein +FIG00836881 FIG00836890: hypothetical protein +FIG00836890 FIG00836895: hypothetical protein +FIG00836905 FIG00836907: hypothetical protein +FIG00836908 FIG00836909: hypothetical protein +FIG00836912 FIG00836913: hypothetical protein +FIG00836913 FIG00836914: hypothetical protein +FIG00836914 FIG00836915: hypothetical protein +FIG00836931 FIG00836935: hypothetical protein +FIG00836935 transfer complex protein TrsE +FIG00836946 FIG00836948: hypothetical protein +FIG00836948 FIG00836952: hypothetical protein +FIG00836952 FIG00836957: hypothetical protein +FIG00836965 FIG00836967: hypothetical protein +FIG00836968 FIG00836971: hypothetical protein +FIG00836971 Putative variable prolipoprotein +FIG00836982 FIG00836983: hypothetical protein +FIG00836991 FIG00836993: hypothetical protein +FIG00836993 FIG00836994: hypothetical protein +FIG00837006 FIG00837008: hypothetical protein +FIG00837011 FIG00837012: hypothetical protein +FIG00837012 FIG00837015: hypothetical protein +FIG00837015 FIG00837018: hypothetical protein +FIG00837018 Pseudogene of RecU (N-terminal part) +FIG00837035 FIG00837036: hypothetical protein +FIG00837060 FIG00837062: hypothetical protein +FIG00837062 FIG00837064: hypothetical protein +FIG00837064 RNAse G and E associated domain containing protein +FIG00837069 FIG00837072: hypothetical protein +FIG00837074 FIG00837076: hypothetical protein +FIG00837091 FIG00837094: hypothetical protein +FIG00837094 FIG00837095: hypothetical protein +FIG00837095 FIG00837097: hypothetical protein +FIG00837097 FIG00837099: hypothetical protein +FIG00837109 FIG00837111: hypothetical protein +FIG00837111 FIG00837115: hypothetical protein +FIG00837115 FIG00837116: hypothetical protein +FIG00837117 ATP-BINDING PROTEIN +FIG00837120 FIG00837121: hypothetical protein +FIG00837124 FIG00837125: hypothetical protein +FIG00837129 FIG00837131: hypothetical protein +FIG00837131 FIG00837132: hypothetical protein +FIG00837132 FIG00837135: hypothetical protein +FIG00837136 FIG00837139: hypothetical protein +FIG00837140 FIG00837145: hypothetical protein +FIG00837145 FIG00837146: hypothetical protein +FIG00837148 FIG00837152: hypothetical protein +FIG00837152 FIG00837153: hypothetical protein +FIG00837153 FIG00837158: hypothetical protein +FIG00837158 FIG00837160: hypothetical protein +FIG00837167 FIG311301: hypothetical lipoprotein LppH +FIG00837187 FIG00837189: hypothetical protein +FIG00837194 FIG00837201: hypothetical protein +FIG00837202 FIG00837204: hypothetical protein +FIG00837204 FIG00837207: hypothetical protein +FIG00837226 FIG00837234: hypothetical protein +FIG00837238 Viral A-type inclusion protein repeat, putative +FIG00837252 FIG00837253: hypothetical protein +FIG00837253 FIG00837255: hypothetical protein +FIG00837270 Uncharacterized protein MG449 +FIG00837273 Prolipoprotein +FIG00837277 Hypothetical protein, predicted lipoprotein +FIG00837287 Uncharacterized 31.2 kDa protein in licA 3'region (ORF268) +FIG00837310 FIG00837311: hypothetical protein +FIG00837315 predicted protease +FIG00837340 FIG00837342: hypothetical protein +FIG00837351 FIG00837353: hypothetical protein +FIG00837353 FIG00837354: hypothetical protein +FIG00837361 FIG00837362: hypothetical protein +FIG00837362 FIG00837363: hypothetical protein +FIG00837363 FIG00837364: hypothetical protein +FIG00837364 prolipoprotein +FIG00837379 regulatory protein PfoR +FIG00837381 FIG00837382: hypothetical protein +FIG00837383 FIG00837385: hypothetical protein +FIG00837385 FIG00837386: hypothetical protein +FIG00837394 FIG00837396: hypothetical protein +FIG00837419 FIG00837421: hypothetical protein +FIG00837434 FIG00837435: hypothetical protein +FIG00837443 FIG00837446: hypothetical protein +FIG00837447 adenine-specific DNA methylase, putative( EC:2.1.1.72 ) +FIG00837451 FIG00837454: hypothetical protein +FIG00837454 FIG00837455: hypothetical protein +FIG00837463 FIG00837464: hypothetical protein +FIG00837466 FIG00837467: hypothetical protein +FIG00837468 FIG00837470: hypothetical protein +FIG00837473 FIG00837474: hypothetical protein +FIG00837474 FIG00837475: hypothetical protein +FIG00837475 FIG00837477: hypothetical protein +FIG00837479 FIG00837480: hypothetical protein +FIG00837494 FIG00837495: hypothetical protein +FIG00837501 PTS system mannitol-specific EIICB component (EIICB-Mtl) (EII-Mtl) [Includes: Mannitol permease IIC component (PTS system mannitol-specific EIIC component); Mannitol-specific phosphotransferase enzyme IIB component (EC 2.7.1.69) (PTS system mannitol-specific EIIB component)] +FIG00837509 FIG00837511: hypothetical protein +FIG00837527 FIG00837529: hypothetical protein +FIG00837537 FIG00837546: hypothetical protein +FIG00837566 FIG00837577: hypothetical protein +FIG00837597 FIG00837600: hypothetical protein +FIG00837605 FIG00837609: hypothetical protein +FIG00837609 FIG00837614: hypothetical protein +FIG00837620 FIG00837621: hypothetical protein +FIG00837628 FIG00837629: hypothetical protein +FIG00837633 FIG00837638: hypothetical protein +FIG00837638 FIG00837640: hypothetical protein +FIG00837640 FIG00837642: hypothetical protein +FIG00837644 FIG00837657: hypothetical protein +FIG00837672 FIG00837676: hypothetical protein +FIG00837687 FIG00837689: hypothetical protein +FIG00837689 MYPE8480 paralog +FIG00837701 FIG00837705: hypothetical protein +FIG00837721 FIG00837722: hypothetical protein +FIG00837730 FIG00837734: hypothetical protein +FIG00837734 FIG00837736: hypothetical protein +FIG00837747 FIG00837750: hypothetical protein +FIG00837767 FIG00837778: hypothetical protein +FIG00837780 FIG00837782: hypothetical protein +FIG00837785 FIG00837787: hypothetical protein +FIG00837853 Prolipoprotein Q +FIG00837868 FIG00837872: hypothetical protein +FIG00837874 FIG00837878: hypothetical protein +FIG00837879 FIG00837880: hypothetical protein +FIG00837923 FIG00837925: hypothetical protein +FIG00837936 Glycosyltransferase( EC:2.- ) +FIG00837992 FIG00837993: hypothetical protein +FIG00838009 Capsule biosynthesis protein +FIG00838018 FIG00838019: hypothetical protein +FIG00838034 FIG00838035: hypothetical protein +FIG00838048 phospholipase D. Active site motif domain protein +FIG00838051 FIG00838052: hypothetical protein +FIG00838069 FIG00838070: hypothetical protein +FIG00838071 FIG00838073: hypothetical protein +FIG00838082 FIG00838083: hypothetical protein +FIG00838089 Beta-hydroxyacid dehydrogenase +FIG00838090 FIG00838091: hypothetical protein +FIG00838091 FIG00838093: hypothetical protein +FIG00838107 FIG00838108: hypothetical protein +FIG00838110 FIG00838111: hypothetical protein +FIG00838111 Alg9 family protein mannosyltransferase +FIG00838121 peptidase, M19 family +FIG00838127 FIG00838130: hypothetical protein +FIG00838131 FIG00838134: hypothetical protein +FIG00838135 FIG00838136: hypothetical protein +FIG00838148 Putative membrane protein of ExoQ family, involved in exopolysaccharide production +FIG00838174 glycosyl transferase, group 1( EC:2.4.1.- ) +FIG00838189 PHP domain protein +FIG00838196 FIG00838197: hypothetical protein +FIG00838201 FIG00838202: hypothetical protein +FIG00838204 FIG00838205: hypothetical protein +FIG00838235 Probable ATP-dependent DNA helicase +FIG00838236 FIG00838239: hypothetical protein +FIG00838253 adventurous gliding motility protein O +FIG00838264 FIG00838265: hypothetical protein +FIG00838272 FIG00838274: hypothetical protein +FIG00838304 FIG00838305: hypothetical protein +FIG00838305 FIG00838307: hypothetical protein +FIG00838307 FIG00838310: hypothetical protein +FIG00838328 FIG00838329: hypothetical protein +FIG00838329 FIG00838333: hypothetical protein +FIG00838345 FIG00838346: hypothetical protein +FIG00838348 FIG00838350: hypothetical protein +FIG00838354 FIG00838357: hypothetical protein +FIG00838369 FIG00838370: hypothetical protein +FIG00838376 FIG00838379: hypothetical protein +FIG00838385 FIG00838389: hypothetical protein +FIG00838389 FIG00838390: hypothetical protein +FIG00838409 FIG00838410: hypothetical protein +FIG00838411 Sensor protein degS (EC 2.7.13.3) +FIG00838413 FIG00838414: hypothetical protein +FIG00838432 FIG00838433: hypothetical protein +FIG00838437 FIG00838438: hypothetical protein +FIG00838448 FIG00838449: hypothetical protein +FIG00838449 FIG00838451: hypothetical protein +FIG00838460 Soluble lytic murein transglycosylase and related regulatory proteins (some contain LysM/invasin domains) +FIG00838474 FIG00838475: hypothetical protein +FIG00838480 FIG00838481: hypothetical protein +FIG00838490 FIG00838491: hypothetical protein +FIG00838491 FIG00838492: hypothetical protein +FIG00838503 FIG00838504: hypothetical protein +FIG00838516 FIG00838517: hypothetical protein +FIG00838525 FIG00838526: hypothetical protein +FIG00838544 FIG00838547: hypothetical protein +FIG00838549 FIG00838550: hypothetical protein +FIG00838558 FIG00838562: hypothetical protein +FIG00838570 FIG00838574: hypothetical protein +FIG00838576 FIG00838578: hypothetical protein +FIG00838583 FIG00838584: hypothetical protein +FIG00838585 FIG00838586: hypothetical protein +FIG00838589 FIG00838592: hypothetical protein +FIG00838611 FIG00838616: hypothetical protein +FIG00838633 FIG00838634: hypothetical protein +FIG00838638 FIG00838640: hypothetical protein +FIG00838648 FIG00838649: hypothetical protein +FIG00838655 Gll1201 protein +FIG00838668 FIG00838669: hypothetical protein +FIG00838671 FIG00838672: hypothetical protein +FIG00838692 FIG00838693: hypothetical protein +FIG00838716 FIG00838717: hypothetical protein +FIG00838723 Fruiting body developmental protein R +FIG00838756 FIG00838758: hypothetical protein +FIG00838777 FIG00838778: hypothetical protein +FIG00838781 FIG00838783: hypothetical protein +FIG00838792 FIG00838793: hypothetical protein +FIG00838795 FIG00838796: hypothetical protein +FIG00838810 FIG00838811: hypothetical protein +FIG00838821 FIG00838823: hypothetical protein +FIG00838849 FIG00838851: hypothetical protein +FIG00838852 FIG00838853: hypothetical protein +FIG00838853 FIG00838854: hypothetical protein +FIG00838864 FIG00838865: hypothetical protein +FIG00838874 FIG00838877: hypothetical protein +FIG00838878 FIG00838879: hypothetical protein +FIG00838886 probable cycloinulo-oligosaccharide fructanotransferase +FIG00838887 FIG00838889: hypothetical protein +FIG00838889 HAD superfamily (Subfamily IG) hydrolase, 5'-Nucleotidase +FIG00838894 putative RNA polymerase sigma-70 factor +FIG00838918 FIG00838920: hypothetical protein +FIG00838931 putative molybdenum cofactor carrier protein +FIG00838934 chemotactic response regulator +FIG00838952 FIG00838954: hypothetical protein +FIG00838959 FIG00838960: hypothetical protein +FIG00838966 FIG00838967: hypothetical protein +FIG00838982 FIG00838983: hypothetical protein +FIG00838986 FIG00838988: hypothetical protein +FIG00839002 FIG00839005: hypothetical protein +FIG00839005 FIG00839007: hypothetical protein +FIG00839007 FIG00839008: hypothetical protein +FIG00839011 FIG00839012: hypothetical protein +FIG00839036 FIG00839038: hypothetical protein +FIG00839038 FIG00839042: hypothetical protein +FIG00839044 FIG00839045: hypothetical protein +FIG00839053 FIG00839054: hypothetical protein +FIG00839063 FIG00839065: hypothetical protein +FIG00839065 FIG00839066: hypothetical protein +FIG00839066 FIG00839068: hypothetical protein +FIG00839078 FIG00839081: hypothetical protein +FIG00839086 FIG00839087: hypothetical protein +FIG00839088 FIG00839089: hypothetical protein +FIG00839101 FIG00839103: hypothetical protein +FIG00839103 FIG00839105: hypothetical protein +FIG00839116 Collagen, type IX, alpha 1 +FIG00839124 FIG00839127: hypothetical protein +FIG00839155 FIG00839156: hypothetical protein +FIG00839157 FIG00839159: hypothetical protein +FIG00839159 Tyrosine-protein kinase masK (EC 2.7.10.2) +FIG00839161 putative protein phosphatase +FIG00839169 FIG00839174: hypothetical protein +FIG00839175 FIG00839176: hypothetical protein +FIG00839181 FIG00839182: hypothetical protein +FIG00839182 FIG00839185: hypothetical protein +FIG00839191 filamentation induced by cAMP protein Fic +FIG00839203 S1D (lysyl endopeptidase) subfamily C-terminal domain protein +FIG00839210 FIG01081881: hypothetical protein +FIG00839216 FIG00839219: hypothetical protein +FIG00839227 FIG00839231: hypothetical protein +FIG00839231 Menaquinone biosynthesis related protein, putative DHNA-CoA thioesterase +FIG00839233 FIG00839234: hypothetical protein +FIG00839238 FIG00839241: hypothetical protein +FIG00839251 FIG00839252: hypothetical protein +FIG00839252 FIG00839253: hypothetical protein +FIG00839254 FIG00839259: hypothetical protein +FIG00839266 Lytic transglycosylase, catalytic +FIG00839271 Carboxyl-terminal protease precursor (EC 3.4.21.102) +FIG00839277 Calcium-binding acidic-repeat protein precursor (ARP) +FIG00839306 NtrC +FIG00839310 FIG00839312: hypothetical protein +FIG00839317 FIG00839321: hypothetical protein +FIG00839338 FIG00839339: hypothetical protein +FIG00839345 FIG00839348: hypothetical protein +FIG00839357 FIG00839363: hypothetical protein +FIG00839379 chaperonin (HSP60) family protein +FIG00839389 FIG00839390: hypothetical protein +FIG00839392 FIG00839396: hypothetical protein +FIG00839396 protease, insulinase family/protease, insulinase family +FIG00839410 Probable DNA polymerase family X +FIG00839414 Thioesterase family domain protein +FIG00839417 FIG00839421: hypothetical protein +FIG00839430 SasN +FIG00839447 FIG00839448: hypothetical protein +FIG00839467 FIG00839469: hypothetical protein +FIG00839473 FIG00839474: hypothetical protein +FIG00839480 FIG00839484: hypothetical protein +FIG00839510 FIG00839511: hypothetical protein +FIG00839519 RNA polymerase sigma-70 factor, group 3 +FIG00839522 FIG00839524: hypothetical protein +FIG00839525 FrgA +FIG00839531 FIG00839532: hypothetical protein +FIG00839532 FIG00839533: hypothetical protein +FIG00839545 FIG00839547: hypothetical protein +FIG00839547 FIG00839548: hypothetical protein +FIG00839549 FIG00839550: hypothetical protein +FIG00839552 Serine/threonine kinase Pkn14 +FIG00839553 NAD dependent epimerase/dehydratase family protein +FIG00839561 FIG00839562: hypothetical protein +FIG00839582 FIG00839583: hypothetical protein +FIG00839594 FIG00839595: hypothetical protein +FIG00839611 FIG00839615: hypothetical protein +FIG00839621 FIG00839622: hypothetical protein +FIG00839622 FIG00839623: hypothetical protein +FIG00839625 FIG00839627: hypothetical protein +FIG00839627 FIG00839628: hypothetical protein +FIG00839632 pilus biogenesis protein, TadE family +FIG00839635 Peptidase S9, prolyl oligopeptidase active site region precursor +FIG00839643 nitrogen assimilation regulatory protein +FIG00839648 type IV pilus assembly PilZ +FIG00839672 FIG00839673: hypothetical protein +FIG00839682 expressed protein +FIG00839683 protein kinase domain, putative +FIG00839698 cellulose biosynthesis (CelD)-like protein +FIG00839711 FIG00839712: hypothetical protein +FIG00839717 FIG00839718: hypothetical protein +FIG00839740 FIG00839743: hypothetical protein +FIG00839746 FIG00839749: hypothetical protein +FIG00839774 FIG00839775: hypothetical protein +FIG00839777 FIG00839780: hypothetical protein +FIG00839789 FIG00839790: hypothetical protein +FIG00839790 FIG00839791: hypothetical protein +FIG00839795 FIG00839797: hypothetical protein +FIG00839820 FIG00839822: hypothetical protein +FIG00839826 Transcriptional regulator, LuxR family protein +FIG00839827 FIG00839828: hypothetical protein +FIG00839828 Immediate early protein ICP0 +FIG00839847 FIG00839848: hypothetical protein +FIG00839865 FIG00839866: hypothetical protein +FIG00839878 FIG00839879: hypothetical protein +FIG00839880 FIG00839881: hypothetical protein +FIG00839882 FIG00839883: hypothetical protein +FIG00839891 FIG00839893: hypothetical protein +FIG00839898 FIG00839900: hypothetical protein +FIG00839913 FIG00839914: hypothetical protein +FIG00839918 FIG00839919: hypothetical protein +FIG00839921 FIG00839922: hypothetical protein +FIG00839928 FIG00839929: hypothetical protein +FIG00839929 FIG00839931: hypothetical protein +FIG00839931 FIG00839932: hypothetical protein +FIG00839938 FIG00839940: hypothetical protein +FIG00839945 FIG00839946: hypothetical protein +FIG00839958 FIG00839960: hypothetical protein +FIG00839960 FIG00839961: hypothetical protein +FIG00839968 response regulator/GGDEF/GAF domain protein +FIG00839975 FIG00839976: hypothetical protein +FIG00839992 FIG00839993: hypothetical protein +FIG00839995 FIG00839996: hypothetical protein +FIG00839998 FIG00839999: hypothetical protein +FIG00840025 FIG00840026: hypothetical protein +FIG00840026 FIG00840028: hypothetical protein +FIG00840028 FIG00840029: hypothetical protein +FIG00840037 patatin-like phospholipase family protein +FIG00840041 FIG00840042: hypothetical protein +FIG00840049 Serine/threonine kinase Pkn10 +FIG00840065 FIG00840066: hypothetical protein +FIG00840071 FIG00840074: hypothetical protein +FIG00840078 FIG00840079: hypothetical protein +FIG00840087 FIG00840088: hypothetical protein +FIG00840088 FIG00840090: hypothetical protein +FIG00840099 FIG00840100: hypothetical protein +FIG00840101 FIG00840103: hypothetical protein +FIG00840103 FIG00840105: hypothetical protein +FIG00840111 FIG01232333: hypothetical protein +FIG00840124 FIG00840126: hypothetical protein +FIG00840126 FIG00840128: hypothetical protein +FIG00840154 FIG00840155: hypothetical protein +FIG00840155 FIG00840156: hypothetical protein +FIG00840163 FIG00840164: hypothetical protein +FIG00840169 FIG00840170: hypothetical protein +FIG00840177 FIG00840178: hypothetical protein +FIG00840188 FIG00840191: hypothetical protein +FIG00840198 FIG00840199: hypothetical protein +FIG00840203 FIG00840204: hypothetical protein +FIG00840228 FIG00840229: hypothetical protein +FIG00840229 Peptidase domain protein precursor +FIG00840230 FIG00840231: hypothetical protein +FIG00840271 FIG00840272: hypothetical protein +FIG00840277 Signal peptide peptidase SppA, 67K type (EC 3.4.21.-) +FIG00840287 Oxidoreductase, molybdopterin-binding +FIG00840301 FIG00840302: hypothetical protein +FIG00840312 FIG00840313: hypothetical protein +FIG00840317 FIG00840319: hypothetical protein +FIG00840324 FIG00840325: hypothetical protein +FIG00840329 FHA domain/GGDEF domain protein +FIG00840337 FIG00840338: hypothetical protein +FIG00840343 FIG00840344: hypothetical protein +FIG00840347 FIG00840348: hypothetical protein +FIG00840348 FIG00840353: hypothetical protein +FIG00840379 FIG00840380: hypothetical protein +FIG00840382 FIG00840387: hypothetical protein +FIG00840406 FIG00840407: hypothetical protein +FIG00840407 sensor histidine kinase/response rgulator +FIG00840412 FIG00840413: hypothetical protein +FIG00840418 FIG00840419: hypothetical protein +FIG00840420 Methyltransferase family protein +FIG00840438 FIG00840440: hypothetical protein +FIG00840440 FIG00840441: hypothetical protein +FIG00840444 FIG00840445: hypothetical protein +FIG00840449 FIG00840450: hypothetical protein +FIG00840469 FIG00840470: hypothetical protein +FIG00840472 FIG00840473: hypothetical protein +FIG00840473 Cation-binding protein, hemerythrin HHE family +FIG00840486 FIG00840490: hypothetical protein +FIG00840509 Serine/threonine-protein kinase pkn3 (EC 2.7.11.1) +FIG00840526 FIG00840529: hypothetical protein +FIG00840538 FIG00840539: hypothetical protein +FIG00840551 FIG00840552: hypothetical protein +FIG00840560 Serine/threonine kinase family protein (EC 2.7.1.-) +FIG00840579 FIG00840581: hypothetical protein +FIG00840581 AsgA +FIG00840597 terminal quinol oxidase subunit +FIG00840599 FIG00840600: hypothetical protein +FIG00840606 FIG00840607: hypothetical protein +FIG00840609 FIG00840613: hypothetical protein +FIG00840625 Tetratricopeptide repeat domain protein +FIG00840629 FIG00840631: hypothetical protein +FIG00840647 epidermal growth factor receptor +FIG00840653 Acetyltransferase, gnat family +FIG00840683 FIG00840684: hypothetical protein +FIG00840687 FIG00840688: hypothetical protein +FIG00840688 FIG00840689: hypothetical protein +FIG00840705 FIG00840708: hypothetical protein +FIG00840709 FIG00840710: hypothetical protein +FIG00840718 Metal dependent amidohydrolase +FIG00840731 FIG00840732: hypothetical protein +FIG00840746 FIG00840749: hypothetical protein +FIG00840752 FIG00840754: hypothetical protein +FIG00840754 FIG00840757: hypothetical protein +FIG00840771 Hydrolase, CocE/NonD family +FIG00840772 FIG00840774: hypothetical protein +FIG00840784 Di-haem Cytochrome c peroxidase +FIG00840792 FIG00840793: hypothetical protein +FIG00840793 FIG00840794: hypothetical protein +FIG00840802 FIG00840805: hypothetical protein +FIG00840826 Hsp33 family protein +FIG00840830 FIG00840833: hypothetical protein +FIG00840835 FIG00840837: hypothetical protein +FIG00840839 FIG00840840: hypothetical protein +FIG00840845 FIG00840848: hypothetical protein +FIG00840864 FIG00840865: hypothetical protein +FIG00840868 FIG00840870: hypothetical protein +FIG00840874 FIG00840875: hypothetical protein +FIG00840881 FIG00840882: hypothetical protein +FIG00840890 FIG00840891: hypothetical protein +FIG00840900 FIG00840902: hypothetical protein +FIG00840905 FIG00840907: hypothetical protein +FIG00840908 FIG00840910: hypothetical protein +FIG00840930 FIG00840932: hypothetical protein +FIG00840933 Vegetative protein +FIG00840936 Chemoreceptor Mcp1 +FIG00840943 FIG00840944: hypothetical protein +FIG00840947 FIG00840948: hypothetical protein +FIG00840956 PilH +FIG00840974 FIG00840977: hypothetical protein +FIG00840979 FIG00840981: hypothetical protein +FIG00840988 FIG00840990: hypothetical protein +FIG00841001 Delta-60 repeat domain protein +FIG00841006 FIG00841007: hypothetical protein +FIG00841008 Adventurous gliding motility protein G +FIG00841032 FIG00841033: hypothetical protein +FIG00841044 FIG00841047: hypothetical protein +FIG00841057 FIG00841058: hypothetical protein +FIG00841070 response regulator ActA +FIG00841076 FIG00841078: hypothetical protein +FIG00841079 FIG00841080: hypothetical protein +FIG00841083 FIG00841084: hypothetical protein +FIG00841084 FIG00841085: hypothetical protein +FIG00841085 FIG00841086: hypothetical protein +FIG00841089 FIG00841090: hypothetical protein +FIG00841091 FIG00841093: hypothetical protein +FIG00841111 FIG00841112: hypothetical protein +FIG00841139 FIG00841144: hypothetical protein +FIG00841148 ATP-dependent helicase, DEAD/DEAH box family +FIG00841191 chemotaxis coupling protein CheW +FIG00841201 FIG00841202: hypothetical protein +FIG00841208 Bis(5'-nucleosyl)-tetraphosphatase, symmetrical( EC:3.6.1.41 ) +FIG00841212 FIG00841214: hypothetical protein +FIG00841215 FIG00841216: hypothetical protein +FIG00841217 FIG00841220: hypothetical protein +FIG00841221 FIG00841223: hypothetical protein +FIG00841223 FIG00841225: hypothetical protein +FIG00841225 ActD +FIG00841246 putative transcriptional repressor +FIG00841272 FIG00841275: hypothetical protein +FIG00841304 FIG00841307: hypothetical protein +FIG00841307 FIG00841309: hypothetical protein +FIG00841317 FIG00841319: hypothetical protein +FIG00841351 FIG00841353: hypothetical protein +FIG00841363 Ribosomal protein L29 +FIG00841381 Adventurous gliding motility protein K +FIG00841388 FIG00841390: hypothetical protein +FIG00841390 FIG00841391: hypothetical protein +FIG00841391 FIG00841393: hypothetical protein +FIG00841396 Glucan endo-1,3-beta-glucosidase A1 ((1->3)-beta-glucan endohydrolase) ((1->3)-beta-glucanase A1) (EC 3.2.1.39) +FIG00841400 Sigma-54 dependent transcriptional regulator, Fis family +FIG00841403 FIG00841406: hypothetical protein +FIG00841408 FIG00841409: hypothetical protein +FIG00841418 FIG00841420: hypothetical protein +FIG00841434 FIG00841437: hypothetical protein +FIG00841440 Bll4818 protein +FIG00841468 FIG00841471: hypothetical protein +FIG00841484 FIG00841485: hypothetical protein +FIG00841498 FIG00841499: hypothetical protein +FIG00841530 FIG00841532: hypothetical protein +FIG00841542 FIG00841544: hypothetical protein +FIG00841546 FIG00841547: hypothetical protein +FIG00841556 FIG00841557: hypothetical protein +FIG00841563 Prephenate and/or arogenate dehydrogenase (unknown specificity) (EC 1.3.1.12)(EC 1.3.1.43) / Chorismate mutase I (EC 5.4.99.5) +FIG00841576 FIG00841580: hypothetical protein +FIG00841587 FIG00841589: hypothetical protein +FIG00841594 FIG00841596: hypothetical protein +FIG00841599 Nitrogen regulation protein ntrY (EC 2.7.3.-) +FIG00841610 FIG00841611: hypothetical protein +FIG00841611 FIG00841614: hypothetical protein +FIG00841614 FIG00841615: hypothetical protein +FIG00841615 putative O-methyltransferase +FIG00841621 FIG00841623: hypothetical protein +FIG00841623 Serine/threonine-protein kinase Pkn6 (EC 2.7.11.1) +FIG00841631 FIG00841632: hypothetical protein +FIG00841651 FIG00841652: hypothetical protein +FIG00841671 FIG00841672: hypothetical protein +FIG00841674 Acyl-CoA dehydrogenase, C-terminal:Acyl-CoA dehydrogenase, central region +FIG00841678 Serine/threonine kinase PKN13 +FIG00841695 FIG00841696: hypothetical protein +FIG00841701 WD domain G-beta repeat protein +FIG00841706 FIG00841707: hypothetical protein +FIG00841708 FIG00841714: hypothetical protein +FIG00841714 FIG00841716: hypothetical protein +FIG00841721 FIG00841724: hypothetical protein +FIG00841736 FIG00841737: hypothetical protein +FIG00841743 FIG00841744: hypothetical protein +FIG00841744 FIG00841746: hypothetical protein +FIG00841754 amidohydrolase domain protein +FIG00841767 FIG00841769: hypothetical protein +FIG00841772 FIG00841773: hypothetical protein +FIG00841778 CRISPR-associated protein, Cas6-related +FIG00841800 FIG00841801: hypothetical protein +FIG00841803 FIG00841804: hypothetical protein +FIG00841815 FIG00841818: hypothetical protein +FIG00841821 FIG00841822: hypothetical protein +FIG00841833 Cellulose synthase (UDP-forming)( EC:2.4.1.12 ) +FIG00841842 Acyl-CoA dehydrogenase/oxidase domain protein +FIG00841937 POSSIBLE CARBOXYLASE +FIG00842054 cobalamin (vitamin B12) biosynthesis CbiX protein +FIG00842065 possible lyase, glyoxalase family protein +FIG00842069 FIG00842074: hypothetical protein +FIG00842080 FIG00842086: hypothetical protein +FIG00842101 FIG00842127: hypothetical protein +FIG00842769 Small protein containing transglutaminase-like domain +FIG00843676 proline-rich proteoglycan 2 +FIG00843960 FIG00843967: hypothetical protein +FIG00844117 glutamyl-tRNA(Gln) amidotransferase subunit A( EC:6.3.5.- ) +FIG00844133 extracellular solute-binding protein, family 5 +FIG00844355 putative GroES-family molecular chaperone +FIG00844614 putative efflux MFS permease +FIG00844626 FIG00844639: hypothetical protein +FIG00844724 FIG00844755: hypothetical protein +FIG00845092 FIG00845093: hypothetical protein +FIG00845093 FIG00845094: hypothetical protein +FIG00845189 sodium:proline symporter +FIG00845295 FIG00845296: hypothetical protein +FIG00845334 competence protein ComEC/Rec2-related protein +FIG00845379 FIG00845380: hypothetical protein +FIG00845387 FIG00845388: hypothetical protein +FIG00845439 Cell wall hydrolase, SleB +FIG00845572 Molybdopterin-containing protein YdhV, similar to aldehyde:ferredoxin oxidoreductase +FIG00845901 FIG00845902: hypothetical protein +FIG00845932 nadh oxidase (noxc) +FIG00845977 Ferredoxin 2 +FIG00846123 FIG00846124: hypothetical protein +FIG00846150 FIG00846155: hypothetical protein +FIG00846302 aluminium resistance protein +FIG00846437 Protein of unknown function DUF405:Protein of unknown function DUF418 +FIG00846493 signal transduction histidine kinase regulating citrate/malate metabolism +FIG00846560 FIG00846563: hypothetical protein +FIG00846615 DNA-3-methyladenine glycosylase +FIG00846688 FIG00846690: hypothetical protein +FIG00846691 FIG00846692: hypothetical protein +FIG00846692 FIG00846695: hypothetical protein +FIG00846695 FIG00846696: hypothetical protein +FIG00846699 FIG00846700: hypothetical protein +FIG00846700 ABC-transporter permease protein with unknown substrate +FIG00846701 PHAGE-RELATED DNA BINDING PROTEIN +FIG00846702 FIG00846703: hypothetical protein +FIG00846703 FIG00846704: hypothetical protein +FIG00846704 hypothetical protein +FIG00846705 FIG00846706: hypothetical protein +FIG00846709 RTX toxins determinant A and related Ca2+-binding proteins / Putative large exoprotein involved in heme utilization or adhesion of ShlA/HecA/FhaA family +FIG00846710 FIG00846711: hypothetical protein +FIG00846711 FIG00846712: hypothetical protein +FIG00846712 FIG00846713: hypothetical protein +FIG00846713 FIG00846714: hypothetical protein +FIG00846714 FIG00846715: hypothetical protein +FIG00846715 unknown, len: 191aa +FIG00846718 FIG00846719: hypothetical protein +FIG00846719 FIG00846720: hypothetical protein +FIG00846720 FIG00846722: hypothetical protein +FIG00846722 FIG00846723: hypothetical protein +FIG00846724 FIG00846725: hypothetical protein +FIG00846725 FIG00846726: hypothetical protein +FIG00846726 FIG00846727: hypothetical protein +FIG00846727 FIG00846728: hypothetical protein +FIG00846728 FIG00846729: hypothetical protein +FIG00846731 ATP-binding cassette transporter, subfamily C, member 5, group MRP protein PpABCC5 +FIG00846732 FIG00846733: hypothetical protein +FIG00846733 Capsular polysaccharide biosynthesis glycosyl transferase capM (EC 2.-.-.-) +FIG00846738 unknown, len: 49aa +FIG00846740 FIG00846741: hypothetical protein +FIG00846741 FIG00846744: hypothetical protein +FIG00846744 FIG00846745: hypothetical protein +FIG00846746 FIG00846747: hypothetical protein +FIG00846747 FIG00846749: hypothetical protein +FIG00846749 putative adhesin component +FIG00846753 FIG00846754: hypothetical protein +FIG00846755 hypothetical protein, len: 62aa +FIG00846758 probable integral membrane protein NMA1265 +FIG00846761 FIG00846762: hypothetical protein +FIG00846762 FIG00846763: hypothetical protein +FIG00846763 FIG00846764: hypothetical protein +FIG00846766 MutT +FIG00846773 Permease of the drug/metabolite transporter (DMT) superfamily +FIG00846778 FIG00846780: hypothetical protein +FIG00846780 FIG00846781: hypothetical protein +FIG00846781 unnamed protein product +FIG00846783 FIG00846785: hypothetical protein +FIG00846785 FIG00846786: hypothetical protein +FIG00846786 Putative uncharacterized protein STY4523 (Putative uncharacterized protein) +FIG00846788 FIG00846789: hypothetical protein +FIG00846792 Tpc protein +FIG00846796 FIG00846797: hypothetical protein +FIG00846797 FIG00846798: hypothetical protein +FIG00846798 FIG00846799: hypothetical protein +FIG00846800 FIG00846802: hypothetical protein +FIG00846802 FIG00846803: hypothetical protein +FIG00846803 FIG00846804: hypothetical protein +FIG00846804 FIG00846805: hypothetical protein +FIG00846805 FIG00846807: hypothetical protein +FIG00846807 FIG00846809: hypothetical protein +FIG00846809 FIG00846810: hypothetical protein +FIG00846810 FIG00846811: hypothetical protein +FIG00846811 putative type-II restriction endonuclease +FIG00846813 FIG00846814: hypothetical protein +FIG00846814 FIG00846815: hypothetical protein +FIG00846815 FIG00846818: hypothetical protein +FIG00846818 FIG00846819: hypothetical protein +FIG00846823 FIG00846824: hypothetical protein +FIG00846824 FIG00846827: hypothetical protein +FIG00846827 FIG00846829: hypothetical protein +FIG00846829 FIG00846830: hypothetical protein +FIG00846830 FIG00846831: hypothetical protein +FIG00846832 FIG00846834: hypothetical protein +FIG00846834 Putative efflux (PET) family transporter +FIG00846836 FIG00846837: hypothetical protein +FIG00846837 FIG00846838: hypothetical protein +FIG00846838 hypothetical protein, len: 58aa +FIG00846840 FIG00846841: hypothetical protein +FIG00846841 probable integral membrane protein NMA0973 +FIG00846844 hypothetical protein NMA1489 +FIG00846845 FIG00846846: hypothetical protein +FIG00846846 hypothetical protein +FIG00846848 FIG00846849: hypothetical protein +FIG00846849 FIG00846850: hypothetical protein +FIG00846850 FIG00846851: hypothetical protein +FIG00846852 FIG00846853: hypothetical protein +FIG00846853 putative RtxC homolog +FIG00846855 FIG00846856: hypothetical protein +FIG00846856 probable integral membrane protein NMA0078 +FIG00846857 FIG00846858: hypothetical protein +FIG00846858 FIG00846859: hypothetical protein +FIG00846859 FIG00846861: hypothetical protein +FIG00846863 FIG00846864: hypothetical protein +FIG00846864 FIG00846865: hypothetical protein +FIG00846867 FIG00846869: hypothetical protein +FIG00846869 FIG00846870: hypothetical protein +FIG00846870 FIG00846871: hypothetical protein +FIG00846872 FIG00846873: hypothetical protein +FIG00846873 FIG00846874: hypothetical protein +FIG00846874 Adhesin MafA +FIG00846878 FIG00846879: hypothetical protein +FIG00846881 FIG00846882: hypothetical protein +FIG00846883 FIG00846885: hypothetical protein +FIG00846885 protein A +FIG00846886 probable integral membrane protein NMA0055 +FIG00846887 FIG00846888: hypothetical protein +FIG00846888 hypothetical integral membrane protein +FIG00846890 FIG00846891: hypothetical protein +FIG00846891 hypothetical protein NMA1484 +FIG00846892 FIG00846893: hypothetical protein +FIG00846893 FIG00846894: hypothetical protein +FIG00846894 FIG00847468: hypothetical protein +FIG00846895 FIG00846896: hypothetical protein +FIG00846900 FIG00846901: hypothetical protein +FIG00846901 Cytochrome c' +FIG00846902 FIG00846903: hypothetical protein +FIG00846903 ATP-dependent helicase hrpA +FIG00846904 FIG00846905: hypothetical protein +FIG00846905 FIG00846906: hypothetical protein +FIG00846906 FIG00846907: hypothetical protein +FIG00846907 FIG00846909: hypothetical protein +FIG00846910 FIG00846911: hypothetical protein +FIG00846911 FIG00846912: hypothetical protein +FIG00846912 FIG00846913: hypothetical protein +FIG00846915 pseudogene (putative glycosyl transferase) +FIG00846917 Molybdopterin biosynthesis MoeB protein +FIG00846920 Type II restriction enzyme NlaIV (EC 3.1.21.4) +FIG00846921 FIG00846922: hypothetical protein +FIG00846925 FIG00846927: hypothetical protein +FIG00846927 FIG00846928: hypothetical protein +FIG00846928 modulator of drug activity B, putative +FIG00846931 ABC transporter ATP-binding protein +FIG00846932 FIG00846933: hypothetical protein +FIG00846936 FIG00846937: hypothetical protein +FIG00846937 FIG00846938: hypothetical protein +FIG00846938 FIG00846939: hypothetical protein +FIG00846939 FIG00846940: hypothetical protein +FIG00846940 FIG00846941: hypothetical protein +FIG00846941 FIG00846942: hypothetical protein +FIG00846942 FIG00846943: hypothetical protein +FIG00846947 2-acylglycerophosphoethanolamine acyltransferase +FIG00846949 FIG00846950: hypothetical protein +FIG00846951 FIG00846952: hypothetical protein +FIG00846952 FIG00846953: hypothetical protein +FIG00846954 FIG00846955: hypothetical protein +FIG00846955 FIG00846956: hypothetical protein +FIG00846956 FIG00846957: hypothetical protein +FIG00846957 FIG00846958: hypothetical protein +FIG00846958 FIG00846959: hypothetical protein +FIG00846959 FIG00846960: hypothetical protein +FIG00846960 FIG00849374: hypothetical protein +FIG00846964 FIG00846965: hypothetical protein +FIG00846971 FIG00846972: hypothetical protein +FIG00846972 FIG00846974: hypothetical protein +FIG00846977 FIG00846978: hypothetical protein +FIG00846978 Modification methylase NgoFVII +FIG00846980 FIG00846981: hypothetical protein +FIG00846983 FIG00846984: hypothetical protein +FIG00846986 FIG00846987: hypothetical protein +FIG00846987 mercury transport periplasmic protein, putative +FIG00846989 probable periplasmic protein NMA0358 +FIG00846991 FIG00846992: hypothetical protein +FIG00846992 FIG00846993: hypothetical protein +FIG00846993 FIG00846994: hypothetical protein +FIG00846994 FIG00846995: hypothetical protein +FIG00846996 FIG00846997: hypothetical protein +FIG00846998 PTS system, IIAB component +FIG00847003 FIG00847004: hypothetical protein +FIG00847006 fimbrial biogenesis and twitching motility protein, probable NMB1309 +FIG00847008 FIG00847009: hypothetical protein +FIG00847009 FIG00847010: hypothetical protein +FIG00847010 FIG00847011: hypothetical protein +FIG00847012 FIG00847013: hypothetical protein +FIG00847014 FIG00850058: hypothetical protein +FIG00847018 FIG00847019: hypothetical protein +FIG00847019 porin, major outer membrane protein P.I +FIG00847020 FIG00847021: hypothetical protein +FIG00847021 heat shock protein HtpX +FIG00847022 FIG00847024: hypothetical protein +FIG00847024 FIG00847025: hypothetical protein +FIG00847025 Smr domain +FIG00847026 FIG00847028: hypothetical protein +FIG00847030 conserved hypothetical protein, phage associated protein +FIG00847032 FIG00847034: hypothetical protein +FIG00847034 FIG00847035: hypothetical protein +FIG00847035 FIG00847036: hypothetical protein +FIG00847036 FIG00847037: hypothetical protein +FIG00847038 FIG00847040: hypothetical protein +FIG00847040 Surface protein A +FIG00847042 FIG00847043: hypothetical protein +FIG00847044 FIG00847045: hypothetical protein +FIG00847045 FIG00847046: hypothetical protein +FIG00847049 FIG00847050: hypothetical protein +FIG00847053 LgtB +FIG00847055 Type I restriction enzyme M protein +FIG00847057 putative lysR-family transcriptional regulator +FIG00847059 FIG00847060: hypothetical protein +FIG00847062 FIG00847063: hypothetical protein +FIG00847064 FIG00847065: hypothetical protein +FIG00847065 mobilization relaxase +FIG00847066 FIG00847068: hypothetical protein +FIG00847068 FIG00847069: hypothetical protein +FIG00847078 FIG00847079: hypothetical protein +FIG00847079 FIG00847081: hypothetical protein +FIG00847081 FIG00847083: hypothetical protein +FIG00847085 beta-hexosaminidase precursor +FIG00847087 FIG00847088: hypothetical protein +FIG00847088 FIG00847089: hypothetical protein +FIG00847089 FIG00847090: hypothetical protein +FIG00847090 FIG00847093: hypothetical protein +FIG00847093 FIG00847094: hypothetical protein +FIG00847095 Nitrogen regulation protein NtrX +FIG00847096 FIG00847097: hypothetical protein +FIG00847097 probable lipoprotein NMA0883 +FIG00847098 FIG00847099: hypothetical protein +FIG00847099 conserved hypothetical protein, putative phage associated protein +FIG00847101 probable periplasmic protein NMA1652 +FIG00847103 FIG00849552: hypothetical protein +FIG00847104 type I restriction-modification system, M subunit +FIG00847107 putative adhesion and penetration protein +FIG00847108 FIG00847109: hypothetical protein +FIG00847109 FIG00847110: hypothetical protein +FIG00847110 probable lipoprotein NMA0216 +FIG00847112 FIG00847113: hypothetical protein +FIG00847113 FIG00847115: hypothetical protein +FIG00847115 FIG00847116: hypothetical protein +FIG00847118 FIG00847121: hypothetical protein +FIG00847121 FIG00847122: hypothetical protein +FIG00847122 FIG00847123: hypothetical protein +FIG00847123 hypothetical protein, putative phage associated protein +FIG00847124 FIG00847125: hypothetical protein +FIG00847127 FIG00847128: hypothetical protein +FIG00847130 FIG00847134: hypothetical protein +FIG00847134 FIG00847135: hypothetical protein +FIG00847136 FIG00847137: hypothetical protein +FIG00847137 FIG00847138: hypothetical protein +FIG00847138 FIG00847139: hypothetical protein +FIG00847139 probable integral membrane protein NMA0260 +FIG00847141 FIG00847142: hypothetical protein +FIG00847142 FIG00847143: hypothetical protein +FIG00847146 FIG00847147: hypothetical protein +FIG00847147 FIG00847148: hypothetical protein +FIG00847149 FIG00847150: hypothetical protein +FIG00847150 FIG00847151: hypothetical protein +FIG00847151 FIG00847152: hypothetical protein +FIG00847152 FIG00847153: hypothetical protein +FIG00847153 DcaA +FIG00847156 FIG00847158: hypothetical protein +FIG00847160 FIG00847162: hypothetical protein +FIG00847163 FIG00847164: hypothetical protein +FIG00847164 FIG00849350: hypothetical protein +FIG00847166 FIG00847167: hypothetical protein +FIG00847167 FIG00847168: hypothetical protein +FIG00847168 FIG00847169: hypothetical protein +FIG00847170 FIG00847172: hypothetical protein +FIG00847172 Nickel-dependent hydrogenase, b-type cytochrome subunit +FIG00847173 probable periplasmic protein NMA1911 +FIG00847174 FIG00847175: hypothetical protein +FIG00847176 FIG00847178: hypothetical protein +FIG00847180 FIG00847181: hypothetical protein +FIG00847182 FIG00847183: hypothetical protein +FIG00847183 FIG00847184: hypothetical protein +FIG00847187 FIG00847188: hypothetical protein +FIG00847188 Adhesion and penetration protein precursor (EC 3.4.21.-) +FIG00847190 FIG00847191: hypothetical protein +FIG00847191 FIG00847193: hypothetical protein +FIG00847196 FIG00847198: hypothetical protein +FIG00847198 FIG00847199: hypothetical protein +FIG00847199 FIG00847200: hypothetical protein +FIG00847200 FIG00847204: hypothetical protein +FIG00847204 FIG00847205: hypothetical protein +FIG00847205 FIG00847206: hypothetical protein +FIG00847206 FIG00847208: hypothetical protein +FIG00847208 FIG00847209: hypothetical protein +FIG00847213 FIG00847214: hypothetical protein +FIG00847214 iron-regulated protein FrpC +FIG00847216 probable lipopolysaccharide biosynthesis translocase NMA0643 +FIG00847218 FIG00847219: hypothetical protein +FIG00847219 FIG00847220: hypothetical protein +FIG00847221 FIG00847224: hypothetical protein +FIG00847224 FIG00847226: hypothetical protein +FIG00847227 type II DNA restriction endonuclease R.NGOI +FIG00847229 FIG00847230: hypothetical protein +FIG00847230 FIG00847233: hypothetical protein +FIG00847234 hypothetical protein +FIG00847236 FIG00847239: hypothetical protein +FIG00847240 FIG00847241: hypothetical protein +FIG00847241 Zn-ribbon-containing, possibly RNA-binding protein and truncated derivatives +FIG00847242 FIG00847243: hypothetical protein +FIG00847243 FIG00847244: hypothetical protein +FIG00847248 FIG00847251: hypothetical protein +FIG00847251 FIG00847252: hypothetical protein +FIG00847252 FIG00847253: hypothetical protein +FIG00847255 FIG00847256: hypothetical protein +FIG00847256 Type II restriction enzyme MthTI (EC 3.1.21.4) (Endonuclease MthTI) (R.MthTI) +FIG00847257 FIG00847258: hypothetical protein +FIG00847258 TspB protein +FIG00847259 hypothetical protein NMA1080 +FIG00847260 FIG00847261: hypothetical protein +FIG00847261 FIG00847263: hypothetical protein +FIG00847263 probable secreted protein NMA0987 +FIG00847266 FIG00847269: hypothetical protein +FIG00847275 FIG00847277: hypothetical protein +FIG00847278 hypothetical DNA-binding protein +FIG00847279 FIG00847280: hypothetical protein +FIG00847280 FIG00847281: hypothetical protein +FIG00847281 FIG00847282: hypothetical protein +FIG00847282 hypothetical protein +FIG00847284 Protein SlyX +FIG00847287 FIG00847288: hypothetical protein +FIG00847288 FIG00847289: hypothetical protein +FIG00847289 FIG00847290: hypothetical protein +FIG00847290 FIG00847291: hypothetical protein +FIG00847291 unknown, len: 42aa +FIG00847293 FIG00847294: hypothetical protein +FIG00847294 FIG00847295: hypothetical protein +FIG00847295 hypothetical protein, len: 45aa +FIG00847296 FIG00847299: hypothetical protein +FIG00847303 FIG00847304: hypothetical protein +FIG00847305 FIG00847307: hypothetical protein +FIG00847307 FIG00847308: hypothetical protein +FIG00847308 Virion structural protein +FIG00847309 FIG00847310: hypothetical protein +FIG00847310 FIG00847312: hypothetical protein +FIG00847313 hypothetical protein +FIG00847314 FIG00847315: hypothetical protein +FIG00847315 FIG00847316: hypothetical protein +FIG00847316 FIG00847318: hypothetical protein +FIG00847318 FIG00847319: hypothetical protein +FIG00847319 FIG00847321: hypothetical protein +FIG00847321 FIG00847322: hypothetical protein +FIG00847322 FIG00847325: hypothetical protein +FIG00847326 FIG00847327: hypothetical protein +FIG00847327 probable lipoprotein NMA0182 +FIG00847331 FIG00847332: hypothetical protein +FIG00847332 FIG00847333: hypothetical protein +FIG00847333 FIG00847334: hypothetical protein +FIG00847335 FIG00847337: hypothetical protein +FIG00847337 FIG00847338: hypothetical protein +FIG00847339 FIG00847340: hypothetical protein +FIG00847340 FIG00847341: hypothetical protein +FIG00847341 FIG00847342: hypothetical protein +FIG00847346 FIG00847347: hypothetical protein +FIG00847349 serotype-1-specific antigen, putative +FIG00847355 FIG00847356: hypothetical protein +FIG00847358 FIG00847359: hypothetical protein +FIG00847359 FIG00847361: hypothetical protein +FIG00847363 FIG00847364: hypothetical protein +FIG00847364 FIG00847365: hypothetical protein +FIG00847366 FIG00847367: hypothetical protein +FIG00847367 FIG00847368: hypothetical protein +FIG00847368 TspA protein +FIG00847369 FIG00847370: hypothetical protein +FIG00847370 Bacterial/Archaeal Transporter family protein +FIG00847371 FIG00847373: hypothetical protein +FIG00847373 FIG00847375: hypothetical protein +FIG00847375 FIG00847376: hypothetical protein +FIG00847377 FIG00847378: hypothetical protein +FIG00847379 FIG00847380: hypothetical protein +FIG00847380 FIG00847383: hypothetical protein +FIG00847383 FIG00847384: hypothetical protein +FIG00847385 FIG00847386: hypothetical protein +FIG00847386 FIG00847387: hypothetical protein +FIG00847387 FIG00847388: hypothetical protein +FIG00847388 FIG00847389: hypothetical protein +FIG00847389 FIG00847390: hypothetical protein +FIG00847390 Sugar transporter +FIG00847391 FIG00847393: hypothetical protein +FIG00847394 FIG00847395: hypothetical protein +FIG00847395 FIG00847399: hypothetical protein +FIG00847399 FIG00847400: hypothetical protein +FIG00847400 probable periplasmic protein NMA0249 +FIG00847403 FIG00847407: hypothetical protein +FIG00847407 FIG00847408: hypothetical protein +FIG00847408 nuclease +FIG00847410 FIG00847411: hypothetical protein +FIG00847411 FIG00847414: hypothetical protein +FIG00847414 FIG00847415: hypothetical protein +FIG00847416 hypothetical protein; Some similarities with the C-terminal region of hemagglutinin/hemolysin-related protein and with purine NTPase +FIG00847417 FIG00847418: hypothetical protein +FIG00847418 FIG00847419: hypothetical protein +FIG00847419 FIG00847421: hypothetical protein +FIG00847429 FIG00847431: hypothetical protein +FIG00847431 FIG00847433: hypothetical protein +FIG00847434 FIG00847437: hypothetical protein +FIG00847444 FIG00847445: hypothetical protein +FIG00847445 FIG00847446: hypothetical protein +FIG00847446 FIG00847448: hypothetical protein +FIG00847448 FIG00847450: hypothetical protein +FIG00847451 FIG00847452: hypothetical protein +FIG00847452 FIG00847453: hypothetical protein +FIG00847454 FIG00847455: hypothetical protein +FIG00847455 FIG00847456: hypothetical protein +FIG00847456 FIG00847457: hypothetical protein +FIG00847457 FIG00847460: hypothetical protein +FIG00847464 Col +FIG00847468 FIG00847469: hypothetical protein +FIG00847469 FIG00847470: hypothetical protein +FIG00847473 FIG00847474: hypothetical protein +FIG00847474 FIG00847476: hypothetical protein +FIG00847476 FIG00847478: hypothetical protein +FIG00847478 FIG00847480: hypothetical protein +FIG00847485 FIG00847486: hypothetical protein +FIG00847487 FIG00847488: hypothetical protein +FIG00847488 putative virulence associated protein +FIG00847490 FIG00847492: hypothetical protein +FIG00847493 FIG00847495: hypothetical protein +FIG00847496 FIG00847497: hypothetical protein +FIG00847497 FIG00847498: hypothetical protein +FIG00847498 FIG00847503: hypothetical protein +FIG00847503 FIG00847504: hypothetical protein +FIG00847506 Heat shock protein HtpX +FIG00847507 FIG00847509: hypothetical protein +FIG00847509 FIG00847511: hypothetical protein +FIG00847511 FIG00847512: hypothetical protein +FIG00847515 hypothetical protein +FIG00847517 FIG00847518: hypothetical protein +FIG00847518 FIG00847519: hypothetical protein +FIG00847521 FIG00847522: hypothetical protein +FIG00847522 COG0705: Uncharacterized membrane protein (homolog of Drosophila rhomboid) +FIG00847525 FIG00847526: hypothetical protein +FIG00847526 FIG00847527: hypothetical protein +FIG00847528 YadA C-terminal domain protein +FIG00847529 FIG00847530: hypothetical protein +FIG00847530 FIG00847531: hypothetical protein +FIG00847532 FIG00847533: hypothetical protein +FIG00847533 FIG00847534: hypothetical protein +FIG00847534 FIG00847535: hypothetical protein +FIG00847536 Phage (Mu-like) virion morphogenesis protein +FIG00847537 FIG00847538: hypothetical protein +FIG00847538 FIG00847539: hypothetical protein +FIG00847539 FIG00847540: hypothetical protein +FIG00847540 FIG00847541: hypothetical protein +FIG00847541 probable membrane protein NMA0915 +FIG00847544 FIG00847548: hypothetical protein +FIG00847548 FIG00847549: hypothetical protein +FIG00847549 FIG00847551: hypothetical protein +FIG00847553 FIG00847555: hypothetical protein +FIG00847557 FIG00847558: hypothetical protein +FIG00847558 FIG00847559: hypothetical protein +FIG00847560 FIG00847561: hypothetical protein +FIG00847561 FIG00847562: hypothetical protein +FIG00847564 FIG00847567: hypothetical protein +FIG00847567 FIG00847568: hypothetical protein +FIG00847570 FIG00847572: hypothetical protein +FIG00847572 hypothetical protein +FIG00847574 FIG00847575: hypothetical protein +FIG00847575 FIG00847576: hypothetical protein +FIG00847576 FIG00847577: hypothetical protein +FIG00847578 FIG00847579: hypothetical protein +FIG00847580 FIG00847581: hypothetical protein +FIG00847581 FIG00847582: hypothetical protein +FIG00847582 FIG00847583: hypothetical protein +FIG00847583 FIG00847586: hypothetical protein +FIG00847586 FIG00847587: hypothetical protein +FIG00847588 FIG00847589: hypothetical protein +FIG00847591 FIG00847593: hypothetical protein +FIG00847593 FIG00847594: hypothetical protein +FIG00847594 FIG00847595: hypothetical protein +FIG00847595 FIG00847599: hypothetical protein +FIG00847599 probable thioredoxin NMA0966 +FIG00847602 FIG00847603: hypothetical protein +FIG00847607 FIG00847608: hypothetical protein +FIG00847611 FIG00847615: hypothetical protein +FIG00847619 FIG00847620: hypothetical protein +FIG00847623 FIG00847624: hypothetical protein +FIG00847626 hypothetical protein NMA0036 +FIG00847627 Uncharacterized protein UPF0114 +FIG00847629 FIG00847630: hypothetical protein +FIG00847630 probable oxidoreductase NMA1206 +FIG00847631 FIG00847632: hypothetical protein +FIG00847633 FIG00847634: hypothetical protein +FIG00847634 FIG00847635: hypothetical protein +FIG00847635 DNA modification methylase M.NGOI +FIG00847636 FIG00847637: hypothetical protein +FIG00847637 probable inner membrane protein NMA0497 +FIG00847638 FIG00847639: hypothetical protein +FIG00847639 FIG00847642: hypothetical protein +FIG00847642 FIG00847643: hypothetical protein +FIG00847644 adherence and invasion outermembrane protein (binds collagen,fibronectin and laminins,provides protection against antimicrobial polypeptides) +FIG00847647 FIG00847648: hypothetical protein +FIG00847650 probable acetyltransferase NMA0248 +FIG00847653 FIG00847654: hypothetical protein +FIG00847655 FIG00847656: hypothetical protein +FIG00847660 FIG00847661: hypothetical protein +FIG00847665 FIG00847667: hypothetical protein +FIG00847667 FIG00847668: hypothetical protein +FIG00847668 DNA methylase, putative +FIG00847671 Ydf +FIG00847672 FIG00847673: hypothetical protein +FIG00847673 IgA1 protease (Fragment) +FIG00847674 FIG00847678: hypothetical protein +FIG00847678 H.8 outer membrane protein +FIG00847680 FIG00847682: hypothetical protein +FIG00847683 FIG00847684: hypothetical protein +FIG00847684 probable lipoprotein NMA1439 +FIG00847694 FIG00847696: hypothetical protein +FIG00847696 FIG00847697: hypothetical protein +FIG00847697 FIG00847698: hypothetical protein +FIG00847698 FIG00847701: hypothetical protein +FIG00847701 probable lipoprotein NMA1697 +FIG00847702 FIG00847704: hypothetical protein +FIG00847704 iron-regulated outer membrane protein FrpB +FIG00847706 FIG00847707: hypothetical protein +FIG00847708 FIG00847710: hypothetical protein +FIG00847710 transcription regulator NMB1007 +FIG00847714 FIG00847715: hypothetical protein +FIG00847715 FIG00847719: hypothetical protein +FIG00847719 FIG00847720: hypothetical protein +FIG00847720 FIG00847721: hypothetical protein +FIG00847721 FIG00847722: hypothetical protein +FIG00847723 FIG00847724: hypothetical protein +FIG00847725 Phage-related baseplate assembly protein V +FIG00847726 FIG00847727: hypothetical protein +FIG00847727 probable membrane protein NMA1276 +FIG00847728 FIG00847729: hypothetical protein +FIG00847733 FIG00847734: hypothetical protein +FIG00847734 FIG00847735: hypothetical protein +FIG00847735 FIG00847736: hypothetical protein +FIG00847736 FIG00848048: hypothetical protein +FIG00847737 FIG00847738: hypothetical protein +FIG00847738 FIG00847739: hypothetical protein +FIG00847739 FIG00847740: hypothetical protein +FIG00847740 hypothetical protein NMA0846 +FIG00847741 FIG00847743: hypothetical protein +FIG00847745 FIG00847748: hypothetical protein +FIG00847748 FIG00847750: hypothetical protein +FIG00847750 FIG00848856: hypothetical protein +FIG00847751 FIG00847752: hypothetical protein +FIG00847752 probable membrane protein NMA0940 +FIG00847753 FIG00847757: hypothetical protein +FIG00847758 FIG00847759: hypothetical protein +FIG00847759 FIG00847760: hypothetical protein +FIG00847762 FIG00847763: hypothetical protein +FIG00847763 Yee +FIG00847764 FIG00847766: hypothetical protein +FIG00847766 LgtC +FIG00847767 FIG00847768: hypothetical protein +FIG00847768 FIG00847769: hypothetical protein +FIG00847769 FIG00847770: hypothetical protein +FIG00847774 FIG00847775: hypothetical protein +FIG00847776 FIG00847777: hypothetical protein +FIG00847777 FIG00847778: hypothetical protein +FIG00847778 hypothetical protein, len: 96aa; lies within a region of unusually low GC content. +FIG00847779 FIG00847780: hypothetical protein +FIG00847780 FIG00848622: hypothetical protein +FIG00847784 FIG00847785: hypothetical protein +FIG00847785 FIG00847786: hypothetical protein +FIG00847787 FIG00847788: hypothetical protein +FIG00847788 FIG00847789: hypothetical protein +FIG00847789 FIG00847791: hypothetical protein +FIG00847791 UPF0114 protein +FIG00847792 FIG00847793: hypothetical protein +FIG00847793 FIG00847794: hypothetical protein +FIG00847795 FIG00847796: hypothetical protein +FIG00847796 FIG00847798: hypothetical protein +FIG00847798 FIG00847800: hypothetical protein +FIG00847800 FIG00847801: hypothetical protein +FIG00847801 FIG00847802: hypothetical protein +FIG00847802 FIG00847803: hypothetical protein +FIG00847803 FIG00847804: hypothetical protein +FIG00847806 FIG00847808: hypothetical protein +FIG00847808 FIG00847809: hypothetical protein +FIG00847810 FIG00847812: hypothetical protein +FIG00847815 FIG00847816: hypothetical protein +FIG00847817 FIG00847819: hypothetical protein +FIG00847819 probable transcription regulator NMA0738 +FIG00847820 probable periplasmic protein NMA1414 +FIG00847822 Beta 1,4 glucosyltransferase +FIG00847823 FIG00847826: hypothetical protein +FIG00847826 hypothetical inner membrane protein +FIG00847827 FIG00848721: hypothetical protein +FIG00847828 FIG00847830: hypothetical protein +FIG00847831 Type II restriction enzyme HaeII (EC 3.1.21.4) +FIG00847833 FIG00847837: hypothetical protein +FIG00847840 FIG00847841: hypothetical protein +FIG00847842 putative autotransporter +FIG00847844 FIG00847845: hypothetical protein +FIG00847847 FIG00847848: hypothetical protein +FIG00847849 C4-dicarboxylate-binding periplasmic protein +FIG00847851 FIG00847852: hypothetical protein +FIG00847860 FIG00847861: hypothetical protein +FIG00847872 FIG00847873: hypothetical protein +FIG00847873 FIG00847874: hypothetical protein +FIG00847879 FIG00847880: hypothetical protein +FIG00847884 FIG00847885: hypothetical protein +FIG00847891 FIG00847892: hypothetical protein +FIG00847892 hypothetical protein +FIG00847894 FIG00847895: hypothetical protein +FIG00847897 PROBABLE DNA MISMATCH ENDONUCLEASE, PATCH REPAIR PROTEIN +FIG00847898 FIG00847899: hypothetical protein +FIG00847900 FIG00847901: hypothetical protein +FIG00847903 FIG00847904: hypothetical protein +FIG00847904 FIG00847905: hypothetical protein +FIG00847908 FIG00847909: hypothetical protein +FIG00847909 FIG00847910: hypothetical protein +FIG00847910 FIG00847911: hypothetical protein +FIG00847911 FIG00847912: hypothetical protein +FIG00847916 FIG00847917: hypothetical protein +FIG00847920 FIG00847921: hypothetical protein +FIG00847921 FIG00847922: hypothetical protein +FIG00847922 FIG00847923: hypothetical protein +FIG00847923 FIG00847924: hypothetical protein +FIG00847925 FIG00847926: hypothetical protein +FIG00847928 FIG00847929: hypothetical protein +FIG00847929 FIG00847931: hypothetical protein +FIG00847931 FIG00967744: hypothetical protein +FIG00847934 FIG00847935: hypothetical protein +FIG00847935 FIG00847936: hypothetical protein +FIG00847936 FIG00847937: hypothetical protein +FIG00847937 FIG00847939: hypothetical protein +FIG00847942 FIG00847943: hypothetical protein +FIG00847944 FIG00847945: hypothetical protein +FIG00847945 FIG00847946: hypothetical protein +FIG00847948 FIG00847949: hypothetical protein +FIG00847949 FIG00847950: hypothetical protein +FIG00847950 FIG00847951: hypothetical protein +FIG00847953 FIG00847955: hypothetical protein +FIG00847955 FIG00847956: hypothetical protein +FIG00847956 Outer membrane protein class 1 +FIG00847957 FIG00847960: hypothetical protein +FIG00847960 FIG00847961: hypothetical protein +FIG00847963 cytochrome, putative +FIG00847964 FIG00847965: hypothetical protein +FIG00847967 Protein of unknown function DUF1568 +FIG00847968 FIG00847970: hypothetical protein +FIG00847970 FIG00847971: hypothetical protein +FIG00847971 FIG00847973: hypothetical protein +FIG00847973 FIG00847975: hypothetical protein +FIG00847975 FIG00847976: hypothetical protein +FIG00847977 FIG00847978: hypothetical protein +FIG00847978 FIG00847979: hypothetical protein +FIG00847979 FIG00847980: hypothetical protein +FIG00847981 FIG00847982: hypothetical protein +FIG00847982 FIG00847986: hypothetical protein +FIG00847987 hypothetical protein NMA0591 +FIG00847991 putative type II restriction endonuclease +FIG00847994 Probable tail fiber protein +FIG00847995 probable periplasmic protein NMA2067 +FIG00847996 FIG00847997: hypothetical protein +FIG00847997 FIG00847998: hypothetical protein +FIG00847999 FIG00848000: hypothetical protein +FIG00848000 FIG00848001: hypothetical protein +FIG00848001 FIG00848002: hypothetical protein +FIG00848007 FIG00848008: hypothetical protein +FIG00848008 putative cytolysin secretion ABC transporter +FIG00848010 FIG00848011: hypothetical protein +FIG00848011 FIG00848012: hypothetical protein +FIG00848012 FIG00848013: hypothetical protein +FIG00848013 FIG00848014: hypothetical protein +FIG00848015 competence protein ComA +FIG00848025 FIG00848026: hypothetical protein +FIG00848027 transglycosylase, probable NMB1462 +FIG00848033 FIG00848034: hypothetical protein +FIG00848035 FIG00848037: hypothetical protein +FIG00848039 FIG00848041: hypothetical protein +FIG00848043 FIG00848044: hypothetical protein +FIG00848044 FIG023873: Plasmid related protein +FIG00848046 Cadmium resistance protein +FIG00848049 FIG00848050: hypothetical protein +FIG00848053 FIG00848054: hypothetical protein +FIG00848054 FIG00848056: hypothetical protein +FIG00848057 FIG00848058: hypothetical protein +FIG00848059 hypothetical protein, len: 51aa +FIG00848060 FIG00848061: hypothetical protein +FIG00848061 FIG00848062: hypothetical protein +FIG00848062 FIG00848063: hypothetical protein +FIG00848064 FIG00848066: hypothetical protein +FIG00848066 FIG00848067: hypothetical protein +FIG00848067 FIG00848072: hypothetical protein +FIG00848073 prophage CP4-like integrase +FIG00848074 probable membrane protein NMA1396 +FIG00848076 FIG00848078: hypothetical protein +FIG00848078 probable integral membrane protein NMA0174 +FIG00848079 FIG00848080: hypothetical protein +FIG00848080 FIG00848081: hypothetical protein +FIG00848081 FIG00848082: hypothetical protein +FIG00848083 FIG00848084: hypothetical protein +FIG00848084 FIG00848085: hypothetical protein +FIG00848086 FIG00848088: hypothetical protein +FIG00848088 FIG00848090: hypothetical protein +FIG00848090 FIG00848091: hypothetical protein +FIG00848091 FIG00848092: hypothetical protein +FIG00848100 FIG00848101: hypothetical protein +FIG00848102 probable periplasmic protein NMA1391 +FIG00848103 hypothetical protein +FIG00848108 FIG00848109: hypothetical protein +FIG00848109 FIG00848110: hypothetical protein +FIG00848110 FIG00848111: hypothetical protein +FIG00848111 FIG00848112: hypothetical protein +FIG00848116 FIG00849271: hypothetical protein +FIG00848117 FIG00848120: hypothetical protein +FIG00848120 FIG00848122: hypothetical protein +FIG00848123 FIG00848124: hypothetical protein +FIG00848125 FIG00848127: hypothetical protein +FIG00848127 hypothetical protein +FIG00848128 FIG00848129: hypothetical protein +FIG00848129 FIG00848131: hypothetical protein +FIG00848131 FIG00848132: hypothetical protein +FIG00848132 FIG00848133: hypothetical protein +FIG00848133 FIG00848134: hypothetical protein +FIG00848137 FIG00848138: hypothetical protein +FIG00848139 FIG00848140: hypothetical protein +FIG00848141 hypothetical protein +FIG00848142 serotype-1-specific antigen, putative +FIG00848143 FIG00848144: hypothetical protein +FIG00848145 FIG00848146: hypothetical protein +FIG00848150 FIG00848151: hypothetical protein +FIG00848151 transcription regulator, ArsR family NMB0398 +FIG00848153 FIG00848155: hypothetical protein +FIG00848155 FIG00848156: hypothetical protein +FIG00848156 FIG00848157: hypothetical protein +FIG00848158 FIG00848161: hypothetical protein +FIG00848164 FIG00848165: hypothetical protein +FIG00848165 FIG00848166: hypothetical protein +FIG00848166 FIG00848167: hypothetical protein +FIG00848168 FIG00848169: hypothetical protein +FIG00848169 FIG00848170: hypothetical protein +FIG00848170 FIG00848172: hypothetical protein +FIG00848173 FIG00848174: hypothetical protein +FIG00848174 FIG00848175: hypothetical protein +FIG00848175 FIG00848176: hypothetical protein +FIG00848176 FIG00848177: hypothetical protein +FIG00848179 FIG00848180: hypothetical protein +FIG00848180 FIG00848181: hypothetical protein +FIG00848183 FIG00848184: hypothetical protein +FIG00848185 putative protein export protein +FIG00848186 FIG00848187: hypothetical protein +FIG00848187 FIG00848188: hypothetical protein +FIG00848188 FIG00848191: hypothetical protein +FIG00848193 Modification methylase +FIG00848196 FIG00848197: hypothetical protein +FIG00848199 FIG00848200: hypothetical protein +FIG00848201 FIG00848202: hypothetical protein +FIG00848202 FIG00848203: hypothetical protein +FIG00848203 FIG00848205: hypothetical protein +FIG00848209 FIG00848210: hypothetical protein +FIG00848210 FIG00848211: hypothetical protein +FIG00848211 probable periplasmic protein NMA1446 +FIG00848214 FIG00848215: hypothetical protein +FIG00848215 FIG00848220: hypothetical protein +FIG00848220 very hypothetical protein NMA0380 +FIG00848223 Putative carbamoylphosphate synthase large subunit, short form +FIG00848224 FIG00672359: hypothetical protein +FIG00848225 FIG00848226: hypothetical protein +FIG00848226 FIG00848227: hypothetical protein +FIG00848229 FIG00848230: hypothetical protein +FIG00848231 FIG00848232: hypothetical protein +FIG00848232 FIG00848233: hypothetical protein +FIG00848233 FIG00848234: hypothetical protein +FIG00848234 FIG00848235: hypothetical protein +FIG00848237 FIG00848238: hypothetical protein +FIG00848238 FIG00848239: hypothetical protein +FIG00848239 FIG00848241: hypothetical protein +FIG00848241 FIG00848242: hypothetical protein +FIG00848243 FIG00848244: hypothetical protein +FIG00848249 FIG00848250: hypothetical protein +FIG00848250 FIG00848251: hypothetical protein +FIG00848251 FIG00848252: hypothetical protein +FIG00848252 FIG00848253: hypothetical protein +FIG00848253 FIG00848254: hypothetical protein +FIG00848255 FIG00848256: hypothetical protein +FIG00848256 FIG00848257: hypothetical protein +FIG00848257 hypothetical protein NMA1197 +FIG00848260 FIG00848261: hypothetical protein +FIG00848261 FIG00848262: hypothetical protein +FIG00848262 FIG00848264: hypothetical protein +FIG00848264 hypothetical protein NMA1468 +FIG00848266 FIG00848269: hypothetical protein +FIG00848269 FIG00848271: hypothetical protein +FIG00848271 FIG00848273: hypothetical protein +FIG00848273 FIG00848274: hypothetical protein +FIG00848278 probable periplasmic protein NMA1084 +FIG00848279 FIG00848282: hypothetical protein +FIG00848282 FIG00848283: hypothetical protein +FIG00848285 FIG00848286: hypothetical protein +FIG00848289 FIG00848290: hypothetical protein +FIG00848290 FIG00848291: hypothetical protein +FIG00848295 FIG00848296: hypothetical protein +FIG00848296 FIG00848298: hypothetical protein +FIG00848299 FIG00848851: hypothetical protein +FIG00848300 FIG00848301: hypothetical protein +FIG00848301 outer membrane protein GNA992 +FIG00848303 FIG00848304: hypothetical protein +FIG00848306 FIG00848308: hypothetical protein +FIG00848310 FIG00848311: hypothetical protein +FIG00848311 FIG00848312: hypothetical protein +FIG00848316 adhesin +FIG00848319 FIG00848321: hypothetical protein +FIG00848321 probable integral membrane protein NMA0171A +FIG00848322 thioredoxin +FIG00848325 FIG00848327: hypothetical protein +FIG00848329 FIG00848330: hypothetical protein +FIG00848334 hypothetical protein NMA0210 +FIG00848337 Autotransporter adhesin +FIG00848338 FIG00848339: hypothetical protein +FIG00848339 FIG00848340: hypothetical protein +FIG00848340 FIG00848341: hypothetical protein +FIG00848342 FIG00848347: hypothetical protein +FIG00848347 FIG00848348: hypothetical protein +FIG00848348 FIG00848349: hypothetical protein +FIG00848351 FIG00848353: hypothetical protein +FIG00848354 FIG00848357: hypothetical protein +FIG00848358 FIG00848359: hypothetical protein +FIG00848360 hypothetical protein, putative phage associated protein +FIG00848365 FIG00848366: hypothetical protein +FIG00848366 FIG00848356: hypothetical protein +FIG00848370 FIG00848371: hypothetical protein +FIG00848371 FIG00848373: hypothetical protein +FIG00848373 FIG00848374: hypothetical protein +FIG00848374 FIG00848375: hypothetical protein +FIG00848376 FIG00848377: hypothetical protein +FIG00848379 3-hydroxydecanoyl-[ACP] dehydratase (EC 4.2.1.60) +FIG00848380 cell filamentation protein +FIG00848381 FIG00848382: hypothetical protein +FIG00848382 FIG00848383: hypothetical protein +FIG00848383 FIG00848384: hypothetical protein +FIG00848388 trp repressor binding protein +FIG00848394 FIG00848395: hypothetical protein +FIG00848395 FIG00848397: hypothetical protein +FIG00848397 FIG00848398: hypothetical protein +FIG00848398 FIG00848399: hypothetical protein +FIG00848402 FIG00848403: hypothetical protein +FIG00848403 23S rRNA (uracil-5-)-methyltransferase rumA +FIG00848404 FIG00848405: hypothetical protein +FIG00848405 FIG00848406: hypothetical protein +FIG00848407 FIG00848409: hypothetical protein +FIG00848409 FIG00848412: hypothetical protein +FIG00848412 FIG00848415: hypothetical protein +FIG00848415 FIG00848417: hypothetical protein +FIG00848417 NUDIX hydrolase, associated with Thiamin pyrophosphokinase +FIG00848418 adhesin MafA2 +FIG00848420 phage anti-repressor protein +FIG00848421 serine-type peptidase +FIG00848424 FIG00848425: hypothetical protein +FIG00848425 hypothetical protein +FIG00848431 FIG00848432: hypothetical protein +FIG00848434 Thiamin biosynthesis lipoprotein ApbE +FIG00848439 FIG00848441: hypothetical protein +FIG00848441 FIG00848442: hypothetical protein +FIG00848442 FIG00848443: hypothetical protein +FIG00848443 FIG00848447: hypothetical protein +FIG00848447 ferric citrate transport system ATP-binding protein +FIG00848448 FIG00848449: hypothetical protein +FIG00848449 FIG00848450: hypothetical protein +FIG00848450 polysialic acid capsule biosynthesis protein SiaD; disrupted by foreign ermC (NMB0066) cassette +FIG00848453 HYPOTHETICAL PROTEIN-Predicted membrane protein +FIG00848454 FIG00848456: hypothetical protein +FIG00848457 FIG00848458: hypothetical protein +FIG00848461 hypothetical protein +FIG00848463 FIG00848464: hypothetical protein +FIG00848464 FIG00848466: hypothetical protein +FIG00848468 FIG00848469: hypothetical protein +FIG00848469 FIG00848473: hypothetical protein +FIG00848474 FIG00848475: hypothetical protein +FIG00848475 FIG00848476: hypothetical protein +FIG00848476 FIG00848481: hypothetical protein +FIG00848483 FIG00848484: hypothetical protein +FIG00848486 FIG00848487: hypothetical protein +FIG00848487 FIG00848491: hypothetical protein +FIG00848494 FIG00848496: hypothetical protein +FIG00848496 FIG00848497: hypothetical protein +FIG00848499 FIG00848501: hypothetical protein +FIG00848501 FIG00848502: hypothetical protein +FIG00848502 FIG00848503: hypothetical protein +FIG00848505 FIG00848506: hypothetical protein +FIG00848507 FIG00848509: hypothetical protein +FIG00848510 FIG00848511: hypothetical protein +FIG00848517 FIG00849144: hypothetical protein +FIG00848518 FIG00848519: hypothetical protein +FIG00848519 FIG00848520: hypothetical protein +FIG00848520 FIG00848522: hypothetical protein +FIG00848525 FIG00848526: hypothetical protein +FIG00848526 FIG00848527: hypothetical protein +FIG00848531 FIG00848532: hypothetical protein +FIG00848532 FIG00848535: hypothetical protein +FIG00848535 FIG00848536: hypothetical protein +FIG00848536 Outer membrane hemoglobin-haptoglobin utilization protein HpuA +FIG00848544 FIG00848545: hypothetical protein +FIG00848545 FIG00848549: hypothetical protein +FIG00848549 FIG00848550: hypothetical protein +FIG00848550 FIG00848552: hypothetical protein +FIG00848553 FIG00848554: hypothetical protein +FIG00848554 FIG00848555: hypothetical protein +FIG00848555 probable integral membrane protein NMA0349 +FIG00848557 FIG00848559: hypothetical protein +FIG00848559 FIG00848560: hypothetical protein +FIG00848561 Ybe +FIG00848562 FIG00848563: hypothetical protein +FIG00848563 FIG00848564: hypothetical protein +FIG00848564 Adhesin MafA +FIG00848565 FIG00848566: hypothetical protein +FIG00848566 FIG00848567: hypothetical protein +FIG00848574 FIG00848575: hypothetical protein +FIG00848576 FIG00848578: hypothetical protein +FIG00848580 FIG00848583: hypothetical protein +FIG00848583 FIG00848584: hypothetical protein +FIG00848586 FIG00848589: hypothetical protein +FIG00848589 FIG00848591: hypothetical protein +FIG00848593 probable periplasmic transport protein NMA0488 +FIG00848597 FIG00848600: hypothetical protein +FIG00848604 FIG00848606: hypothetical protein +FIG00848606 FIG00848607: hypothetical protein +FIG00848607 FIG00848609: hypothetical protein +FIG00848609 FIG00848610: hypothetical protein +FIG00848613 FIG00848614: hypothetical protein +FIG00848614 FIG00848615: hypothetical protein +FIG00848615 FIG00848616: hypothetical protein +FIG00848617 FIG00848620: hypothetical protein +FIG00848620 hypothetical protein +FIG00848627 FIG00848629: hypothetical protein +FIG00848630 FIG00848631: hypothetical protein +FIG00848631 FIG00848632: hypothetical protein +FIG00848632 FIG00848633: hypothetical protein +FIG00848633 FIG00848634: hypothetical protein +FIG00848636 FIG00848637: hypothetical protein +FIG00848637 FIG00848638: hypothetical protein +FIG00848638 FIG00848641: hypothetical protein +FIG00848642 FIG00848643: hypothetical protein +FIG00848644 FIG00848646: hypothetical protein +FIG00848648 FIG00848649: hypothetical protein +FIG00848652 Trafficking protein A +FIG00848661 FIG00848662: hypothetical protein +FIG00848663 FIG00848664: hypothetical protein +FIG00848664 FIG00848665: hypothetical protein +FIG00848665 FIG00848666: hypothetical protein +FIG00848666 FIG00848667: hypothetical protein +FIG00848667 FIG00848670: hypothetical protein +FIG00848670 FIG00848672: hypothetical protein +FIG00848672 FIG00848673: hypothetical protein +FIG00848677 FIG00848680: hypothetical protein +FIG00848681 FIG00848682: hypothetical protein +FIG00848682 FIG00848683: hypothetical protein +FIG00848685 putative cytochrome B561 +FIG00848687 FIG00848689: hypothetical protein +FIG00848689 FIG00848692: hypothetical protein +FIG00848692 FIG00848693: hypothetical protein +FIG00848696 FIG00848697: hypothetical protein +FIG00848699 FIG00848700: hypothetical protein +FIG00848700 FIG00848701: hypothetical protein +FIG00848705 FIG00848706: hypothetical protein +FIG00848709 FIG00848710: hypothetical protein +FIG00848710 FIG00848711: hypothetical protein +FIG00848711 FIG00848712: hypothetical protein +FIG00848714 FIG00848715: hypothetical protein +FIG00848715 FrpC operon protein +FIG00848716 FIG00848718: hypothetical protein +FIG00848718 FIG00848719: hypothetical protein +FIG00848719 FIG00848720: hypothetical protein +FIG00848721 sodium-dependent transporter +FIG00848722 FIG00848723: hypothetical protein +FIG00848723 FIG00848725: hypothetical protein +FIG00848726 FIG00848727: hypothetical protein +FIG00848727 FIG00848728: hypothetical protein +FIG00848729 FIG00848730: hypothetical protein +FIG00848730 FIG00848731: hypothetical protein +FIG00848732 FIG00848733: hypothetical protein +FIG00848735 FIG00848736: hypothetical protein +FIG00848736 probable periplasmic protein NMA1061 +FIG00848737 FIG00848738: hypothetical protein +FIG00848739 FIG00848740: hypothetical protein +FIG00848740 FIG00848741: hypothetical protein +FIG00848747 OpcA +FIG00848748 FIG00848749: hypothetical protein +FIG00848751 FIG00848752: hypothetical protein +FIG00848752 FIG00848753: hypothetical protein +FIG00848757 FIG00848758: hypothetical protein +FIG00848760 MAFB alternative C-terminus +FIG00848761 FIG00848762: hypothetical protein +FIG00848764 FIG00848765: hypothetical protein +FIG00848765 FIG00848766: hypothetical protein +FIG00848767 FIG00848769: hypothetical protein +FIG00848774 FIG00848775: hypothetical protein +FIG00848777 FIG00848778: hypothetical protein +FIG00848778 FIG00848779: hypothetical protein +FIG00848779 FIG00848780: hypothetical protein +FIG00848784 FIG00848785: hypothetical protein +FIG00848786 DNA primase (bacterial type) +FIG00848787 FIG00848788: hypothetical protein +FIG00848788 Putative type II restriction enzyme NmeDIP (EC 3.1.21.4) (Endonuclease NmeDIP) (R.NmeDIP) +FIG00848789 FIG00848790: hypothetical protein +FIG00848790 FIG00848792: hypothetical protein +FIG00848792 FIG00848793: hypothetical protein +FIG00848797 FIG00848800: hypothetical protein +FIG00848800 FIG00848801: hypothetical protein +FIG00848801 FIG00848802: hypothetical protein +FIG00848802 FIG00848803: hypothetical protein +FIG00848806 FIG00848808: hypothetical protein +FIG00848808 probable integral membrane protein NMA0408 +FIG00848810 FIG00848811: hypothetical protein +FIG00848818 FIG00848820: hypothetical protein +FIG00848822 Yfb +FIG00848827 FIG00848829: hypothetical protein +FIG00848829 FIG00848830: hypothetical protein +FIG00848830 FIG00848831: hypothetical protein +FIG00848835 FIG00848836: hypothetical protein +FIG00848836 FIG00848840: hypothetical protein +FIG00848843 FIG00848844: hypothetical protein +FIG00848844 FIG00848846: hypothetical protein +FIG00848847 OUTER MEMBRANE PROTEIN NOSA PRECURSOR +FIG00848851 FIG00848853: hypothetical protein +FIG00848853 FIG00848854: hypothetical protein +FIG00848856 FIG00848857: hypothetical protein +FIG00848859 FIG00848861: hypothetical protein +FIG00848862 FIG00848864: hypothetical protein +FIG00848864 FIG00848865: hypothetical protein +FIG00848867 FIG00848868: hypothetical protein +FIG00848868 FIG00848869: hypothetical protein +FIG00848869 FIG00848872: hypothetical protein +FIG00848873 FIG00848875: hypothetical protein +FIG00848875 FIG00848877: hypothetical protein +FIG00848880 small secreted protein +FIG00848882 FIG00848883: hypothetical protein +FIG00848883 FIG00848884: hypothetical protein +FIG00848884 FIG00848886: hypothetical protein +FIG00848886 FIG00848887: hypothetical protein +FIG00848888 FIG00848889: hypothetical protein +FIG00848889 FIG00848890: hypothetical protein +FIG00848894 FIG00848896: hypothetical protein +FIG00848896 FIG00848897: hypothetical protein +FIG00848899 FIG00848901: hypothetical protein +FIG00848901 FIG00848902: hypothetical protein +FIG00848905 FIG00848907: hypothetical protein +FIG00848912 FIG00848916: hypothetical protein +FIG00848918 FIG00848919: hypothetical protein +FIG00848919 FIG00848920: hypothetical protein +FIG00848922 GTPase and tRNA-U34 5-formylation enzyme TrmE +FIG00848925 FIG00848927: hypothetical protein +FIG00848928 FIG00848929: hypothetical protein +FIG00848929 FIG00848930: hypothetical protein +FIG00848930 FIG00848932: hypothetical protein +FIG00848932 hypothetical protein +FIG00848933 FIG00848934: hypothetical protein +FIG00848935 FIG00848936: hypothetical protein +FIG00848936 FIG00848937: hypothetical protein +FIG00848938 FIG00848939: hypothetical protein +FIG00848940 FIG00848941: hypothetical protein +FIG00848941 Type cbb3 cytochrome oxidase biogenesis protein CcoG, involved in Cu oxidation +FIG00848942 FIG00848943: hypothetical protein +FIG00848947 FIG00848948: hypothetical protein +FIG00848948 putative dehydrogenase fragment +FIG00848950 FIG00848951: hypothetical protein +FIG00848955 FIG00848956: hypothetical protein +FIG00848957 Ycb +FIG00848960 3-oxoacyl-(acyl-carrier-protein) synthase +FIG00848966 FIG00848967: hypothetical protein +FIG00848971 FIG00848972: hypothetical protein +FIG00848974 FIG00848976: hypothetical protein +FIG00848976 FIG00848977: hypothetical protein +FIG00848977 putative inner membrane hypothetical protein +FIG00848980 FIG00848983: hypothetical protein +FIG00848983 FIG00848984: hypothetical protein +FIG00848992 FIG00848995: hypothetical protein +FIG00848995 FIG00848996: hypothetical protein +FIG00848996 FIG00848999: hypothetical protein +FIG00849005 FIG00849007: hypothetical protein +FIG00849007 FIG00849008: hypothetical protein +FIG00849011 FIG00849012: hypothetical protein +FIG00849012 FIG00849013: hypothetical protein +FIG00849016 FIG00849017: hypothetical protein +FIG00849017 FIG00849018: hypothetical protein +FIG00849018 FIG00849019: hypothetical protein +FIG00849029 FIG00849030: hypothetical protein +FIG00849034 FIG00849036: hypothetical protein +FIG00849044 FIG00849045: hypothetical protein +FIG00849049 FIG00849050: hypothetical protein +FIG00849054 FIG00849056: hypothetical protein +FIG00849060 FIG00849061: hypothetical protein +FIG00849062 FIG00849063: hypothetical protein +FIG00849064 FIG00849065: hypothetical protein +FIG00849065 FIG00849066: hypothetical protein +FIG00849066 FIG00849067: hypothetical protein +FIG00849072 FIG00849074: hypothetical protein +FIG00849074 FIG00849075: hypothetical protein +FIG00849075 FIG00849076: hypothetical protein +FIG00849076 FIG00849078: hypothetical protein +FIG00849078 FIG00849079: hypothetical protein +FIG00849086 FIG00849087: hypothetical protein +FIG00849088 FIG00849089: hypothetical protein +FIG00849089 FIG00849090: hypothetical protein +FIG00849091 FIG00849092: hypothetical protein +FIG00849093 FIG00849096: hypothetical protein +FIG00849097 FIG00849100: hypothetical protein +FIG00849103 FIG00849105: hypothetical protein +FIG00849106 FIG00849107: hypothetical protein +FIG00849107 FIG00849110: hypothetical protein +FIG00849110 FIG00849112: hypothetical protein +FIG00849112 FIG00849115: hypothetical protein +FIG00849117 FIG00849118: hypothetical protein +FIG00849118 FIG00849119: hypothetical protein +FIG00849127 FIG00849128: hypothetical protein +FIG00849128 FIG00849129: hypothetical protein +FIG00849129 Adhesin MafA +FIG00849130 FIG00849131: hypothetical protein +FIG00849131 FIG00849134: hypothetical protein +FIG00849134 FIG00849135: hypothetical protein +FIG00849138 FIG00849139: hypothetical protein +FIG00849139 FIG00849140: hypothetical protein +FIG00849147 FIG00849149: hypothetical protein +FIG00849151 FIG00849153: hypothetical protein +FIG00849153 hypothetical protein +FIG00849156 FIG00849158: hypothetical protein +FIG00849158 FIG00849159: hypothetical protein +FIG00849159 FIG00849160: hypothetical protein +FIG00849164 FIG00849165: hypothetical protein +FIG00849166 probable cytochrome B561 NMA0343 +FIG00849168 FIG00849169: hypothetical protein +FIG00849169 FIG00849170: hypothetical protein +FIG00849174 FIG00849176: hypothetical protein +FIG00849176 FIG00849177: hypothetical protein +FIG00849186 FIG00849187: hypothetical protein +FIG00849187 bacteriocin resistance protein, putative +FIG00849190 FIG00849191: hypothetical protein +FIG00849191 FIG00849194: hypothetical protein +FIG00849194 FIG00849195: hypothetical protein +FIG00849196 FIG00849197: hypothetical protein +FIG00849198 FIG00849199: hypothetical protein +FIG00849199 FIG00849206: hypothetical protein +FIG00849210 FIG00849211: hypothetical protein +FIG00849218 hypothetical protein +FIG00849219 FIG00849220: hypothetical protein +FIG00849221 hypothetical protein +FIG00849222 putative DNA transport competence protein +FIG00849224 FIG00849228: hypothetical protein +FIG00849229 FIG00849230: hypothetical protein +FIG00849230 FIG00849231: hypothetical protein +FIG00849231 FIG00849233: hypothetical protein +FIG00849233 FIG00849234: hypothetical protein +FIG00849234 FIG00849236: hypothetical protein +FIG00849236 FIG00849237: hypothetical protein +FIG00849237 FIG00849238: hypothetical protein +FIG00849241 FIG00849244: hypothetical protein +FIG00849245 FIG00849246: hypothetical protein +FIG00849246 FIG00849247: hypothetical protein +FIG00849249 FIG00849250: hypothetical protein +FIG00849251 FIG00849252: hypothetical protein +FIG00849252 FIG00849253: hypothetical protein +FIG00849259 FIG00849261: hypothetical protein +FIG00849269 FIG00849271: hypothetical protein +FIG00849278 probable integral membrane protein NMA0975 +FIG00849279 FIG00849283: hypothetical protein +FIG00849283 FIG00849284: hypothetical protein +FIG00849284 FIG00849287: hypothetical protein +FIG00849288 FIG00849290: hypothetical protein +FIG00849290 FIG00849291: hypothetical protein +FIG00849299 FIG00849300: hypothetical protein +FIG00849305 FIG00849306: hypothetical protein +FIG00849306 FIG00849307: hypothetical protein +FIG00849308 IroE protein +FIG00849313 FIG00849316: hypothetical protein +FIG00849317 FIG00849318: hypothetical protein +FIG00849321 FIG00849323: hypothetical protein +FIG00849323 FIG00849324: hypothetical protein +FIG00849324 FIG00849325: hypothetical protein +FIG00849325 FIG00849326: hypothetical protein +FIG00849327 FIG00849330: hypothetical protein +FIG00849330 FIG00849332: hypothetical protein +FIG00849332 hypothetical protein +FIG00849335 FIG00849337: hypothetical protein +FIG00849337 FIG00849338: hypothetical protein +FIG00849340 FIG00849341: hypothetical protein +FIG00849344 FIG00849345: hypothetical protein +FIG00849345 FIG00849347: hypothetical protein +FIG00849347 FIG00849349: hypothetical protein +FIG00849353 4'-phosphopantetheinyl transferase superfamily domain protein +FIG00849354 FIG00849357: hypothetical protein +FIG00849357 putative adhesion and penetration protein +FIG00849358 FIG00849359: hypothetical protein +FIG00849362 FIG00849363: hypothetical protein +FIG00849365 FIG00849366: hypothetical protein +FIG00849366 FIG00849367: hypothetical protein +FIG00849372 FIG00849373: hypothetical protein +FIG00849375 FIG00849376: hypothetical protein +FIG00849376 Opacity protein (Fragment) +FIG00849378 FIG00849382: hypothetical protein +FIG00849382 FIG00849383: hypothetical protein +FIG00849384 FIG00849385: hypothetical protein +FIG00849386 FIG00849389: hypothetical protein +FIG00849389 FIG00849390: hypothetical protein +FIG00849390 FIG00849391: hypothetical protein +FIG00849392 FIG00849393: hypothetical protein +FIG00849393 FIG00849396: hypothetical protein +FIG00849396 FIG00849397: hypothetical protein +FIG00849398 FIG00849399: hypothetical protein +FIG00849409 FIG00849411: hypothetical protein +FIG00849411 FIG00849412: hypothetical protein +FIG00849412 FIG00849413: hypothetical protein +FIG00849413 FIG00849414: hypothetical protein +FIG00849414 FIG00849415: hypothetical protein +FIG00849415 FIG00849416: hypothetical protein +FIG00849421 FIG00849425: hypothetical protein +FIG00849431 FIG00849432: hypothetical protein +FIG00849432 FIG00849435: hypothetical protein +FIG00849435 FIG00849436: hypothetical protein +FIG00849445 FIG00849446: hypothetical protein +FIG00849446 FIG00849448: hypothetical protein +FIG00849448 FIG00849449: hypothetical protein +FIG00849449 FIG00849450: hypothetical protein +FIG00849450 FIG00849451: hypothetical protein +FIG00849453 FIG00849454: hypothetical protein +FIG00849456 FIG00849457: hypothetical protein +FIG00849462 FIG00849464: hypothetical protein +FIG00849468 FIG00849471: hypothetical protein +FIG00849479 FIG00849480: hypothetical protein +FIG00849480 FIG00849481: hypothetical protein +FIG00849481 probable phosphinothricin acetyltransferase +FIG00849482 FIG00849483: hypothetical protein +FIG00849489 FIG00849490: hypothetical protein +FIG00849490 FIG00849495: hypothetical protein +FIG00849495 FIG00849496: hypothetical protein +FIG00849506 FIG00849507: hypothetical protein +FIG00849508 FIG00849509: hypothetical protein +FIG00849512 hypothetical protein +FIG00849513 FIG00849515: hypothetical protein +FIG00849516 FIG00849517: hypothetical protein +FIG00849517 FIG00849521: hypothetical protein +FIG00849521 Type II restriction enzyme NgoFVII (EC 3.1.21.4) (Endonuclease NgoFVII) (R.NgoFVII) (R.NgoVII) +FIG00849522 FIG00849523: hypothetical protein +FIG00849523 FIG00849524: hypothetical protein +FIG00849524 hypothetical protein NMA0131 +FIG00849528 FIG00849530: hypothetical protein +FIG00849536 FIG00849539: hypothetical protein +FIG00849544 FIG00849548: hypothetical protein +FIG00849552 FIG00849553: hypothetical protein +FIG00849553 FIG00849554: hypothetical protein +FIG00849561 FIG00849562: hypothetical protein +FIG00849563 FIG00849742: hypothetical protein +FIG00849570 FIG00849571: hypothetical protein +FIG00849575 FIG00849579: hypothetical protein +FIG00849580 FIG00849583: hypothetical protein +FIG00849590 FIG00849595: hypothetical protein +FIG00849595 FIG00849599: hypothetical protein +FIG00849599 FIG00849600: hypothetical protein +FIG00849604 FIG00849605: hypothetical protein +FIG00849607 FIG00849609: hypothetical protein +FIG00849612 FIG00849613: hypothetical protein +FIG00849618 FIG00849619: hypothetical protein +FIG00849619 OrfB +FIG00849620 FIG00849621: hypothetical protein +FIG00849624 FIG00849625: hypothetical protein +FIG00849625 FIG00849626: hypothetical protein +FIG00849627 FIG00849628: hypothetical protein +FIG00849629 Response regulator receiver:Transcriptional regulatory protein, C- terminal precursor +FIG00849632 FIG00849633: hypothetical protein +FIG00849633 unknown, len: 60aa +FIG00849636 FIG00849637: hypothetical protein +FIG00849637 BirA-related protein +FIG00849638 FIG00849640: hypothetical protein +FIG00849642 FIG00849643: hypothetical protein +FIG00849644 FIG00849646: hypothetical protein +FIG00849646 FIG00849647: hypothetical protein +FIG00849647 probable phage integrase NMA1221 +FIG00849651 FIG00849652: hypothetical protein +FIG00849657 FIG00849658: hypothetical protein +FIG00849662 FIG00849663: hypothetical protein +FIG00849669 FIG00849671: hypothetical protein +FIG00849671 FIG00849673: hypothetical protein +FIG00849678 FIG00849679: hypothetical protein +FIG00849679 FIG00849680: hypothetical protein +FIG00849683 FIG00849685: hypothetical protein +FIG00849692 FIG00849696: hypothetical protein +FIG00849696 FIG00849698: hypothetical protein +FIG00849698 FIG00849699: hypothetical protein +FIG00849699 FIG00849700: hypothetical protein +FIG00849700 FIG00849701: hypothetical protein +FIG00849701 FIG00849702: hypothetical protein +FIG00849702 FIG00849703: hypothetical protein +FIG00849712 FIG00849713: hypothetical protein +FIG00849714 FIG00849715: hypothetical protein +FIG00849715 Hemolysin-type calcium-binding region +FIG00849724 FIG00849725: hypothetical protein +FIG00849735 FIG00849736: hypothetical protein +FIG00849736 unknown, len: 36aa +FIG00849742 FIG00849743: hypothetical protein +FIG00849743 FIG00849744: hypothetical protein +FIG00849745 FIG00849747: hypothetical protein +FIG00849747 FIG00849748: hypothetical protein +FIG00849753 FIG00849754: hypothetical protein +FIG00849763 FIG00849769: hypothetical protein +FIG00849774 FIG00849775: hypothetical protein +FIG00849776 FIG00849777: hypothetical protein +FIG00849779 FIG00849782: hypothetical protein +FIG00849792 FIG00849793: hypothetical protein +FIG00849794 FIG00849795: hypothetical protein +FIG00849799 FIG00849800: hypothetical protein +FIG00849801 FIG00849802: hypothetical protein +FIG00849803 FIG00849804: hypothetical protein +FIG00849806 putative mercuric ion binding protein +FIG00849808 FIG00849811: hypothetical protein +FIG00849811 FIG00849813: hypothetical protein +FIG00849817 FIG00849818: hypothetical protein +FIG00849818 FIG00849820: hypothetical protein +FIG00849829 FIG00849830: hypothetical protein +FIG00849842 ABC transporter, ATP-binding protein +FIG00849843 molybdenum cofactor biosynthesis protein C +FIG00849844 FIG00849845: hypothetical protein +FIG00849848 FIG00849849: hypothetical protein +FIG00849853 FIG00849857: hypothetical protein +FIG00849857 FIG00849858: hypothetical protein +FIG00849861 FIG00849862: hypothetical protein +FIG00849862 FIG00849865: hypothetical protein +FIG00849865 FIG00849866: hypothetical protein +FIG00849866 Nitrous oxide reductase maturation periplasmic protein NosX +FIG00849868 FIG00849869: hypothetical protein +FIG00849869 FIG00849870: hypothetical protein +FIG00849873 FIG00849875: hypothetical protein +FIG00849876 FIG00849877: hypothetical protein +FIG00849877 FIG00849879: hypothetical protein +FIG00849879 FIG00849881: hypothetical protein +FIG00849884 conserved hypothetical protein Msm_0212 +FIG00849890 FIG00849892: hypothetical protein +FIG00849892 FIG00849893: hypothetical protein +FIG00849893 FIG00849895: hypothetical protein +FIG00849896 FIG00849897: hypothetical protein +FIG00849899 FIG00849900: hypothetical protein +FIG00849901 Yfd +FIG00849910 FIG00849911: hypothetical protein +FIG00849917 FIG00849918: hypothetical protein +FIG00849918 FIG00849919: hypothetical protein +FIG00849919 FIG00849922: hypothetical protein +FIG00849924 FIG00849925: hypothetical protein +FIG00849928 FIG00849929: hypothetical protein +FIG00849930 FIG00849932: hypothetical protein +FIG00849933 FIG00849938: hypothetical protein +FIG00849938 Phasyl DNA replicon protein arp +FIG00849941 FIG00849942: hypothetical protein +FIG00849942 FIG00849943: hypothetical protein +FIG00849950 FIG00849952: hypothetical protein +FIG00849954 putative fucosyl transferase +FIG00849957 FIG00849958: hypothetical protein +FIG00849958 putative amidotransferase +FIG00849979 FIG00849981: hypothetical protein +FIG00849981 FIG00849983: hypothetical protein +FIG00849983 FIG00849984: hypothetical protein +FIG00849986 FIG00849987: hypothetical protein +FIG00849989 Caffeoyl-CoA O-methyltransferase (EC 2.1.1.104) +FIG00849991 FIG00849992: hypothetical protein +FIG00849996 FIG00849998: hypothetical protein +FIG00849999 FIG00850000: hypothetical protein +FIG00850000 FIG00850001: hypothetical protein +FIG00850001 FIG00850002: hypothetical protein +FIG00850002 FIG00850007: hypothetical protein +FIG00850007 "RTX toxin activating lysine-acyltransferase " +FIG00850014 FIG00850015: hypothetical protein +FIG00850015 FIG00850016: hypothetical protein +FIG00850019 FIG00850021: hypothetical protein +FIG00850028 FIG00850029: hypothetical protein +FIG00850029 FIG00850030: hypothetical protein +FIG00850032 FIG00850033: hypothetical protein +FIG00850033 FIG00850034: hypothetical protein +FIG00850034 hypothetical protein +FIG00850035 FIG00850037: hypothetical protein +FIG00850037 FIG00850038: hypothetical protein +FIG00850038 FIG00850039: hypothetical protein +FIG00850039 FIG00850040: hypothetical protein +FIG00850042 FIG00850043: hypothetical protein +FIG00850043 FIG00850044: hypothetical protein +FIG00850048 FIG00850051: hypothetical protein +FIG00850051 FIG00850052: hypothetical protein +FIG00850052 FIG00850053: hypothetical protein +FIG00850053 FIG00850054: hypothetical protein +FIG00850058 FIG00850059: hypothetical protein +FIG00850062 FIG00850066: hypothetical protein +FIG00850072 FIG00850074: hypothetical protein +FIG00850074 FIG00850076: hypothetical protein +FIG00850076 FIG00850078: hypothetical protein +FIG00850081 FIG00850082: hypothetical protein +FIG00850082 FIG00850085: hypothetical protein +FIG00850085 FIG00850086: hypothetical protein +FIG00850089 FIG00850090: hypothetical protein +FIG00850090 FIG00850091: hypothetical protein +FIG00850101 FIG00850102: hypothetical protein +FIG00850107 FIG00850108: hypothetical protein +FIG00850110 FIG00850239: hypothetical protein +FIG00850112 FIG00850114: hypothetical protein +FIG00850116 FIG00850117: hypothetical protein +FIG00850124 FIG00850127: hypothetical protein +FIG00850127 FIG00850128: hypothetical protein +FIG00850130 FIG00850132: hypothetical protein +FIG00850133 FIG00850134: hypothetical protein +FIG00850134 FIG00850136: hypothetical protein +FIG00850138 FIG00850139: hypothetical protein +FIG00850139 FIG00850140: hypothetical protein +FIG00850140 FIG00850145: hypothetical protein +FIG00850145 FIG00850146: hypothetical protein +FIG00850153 FIG00850155: hypothetical protein +FIG00850157 FIG00850158: hypothetical protein +FIG00850162 FIG00850163: hypothetical protein +FIG00850166 FIG00850167: hypothetical protein +FIG00850167 FIG00850236: hypothetical protein +FIG00850176 FIG00850178: hypothetical protein +FIG00850201 FIG00850203: hypothetical protein +FIG00850203 FIG00850204: hypothetical protein +FIG00850207 FIG00850209: hypothetical protein +FIG00850209 FIG00850210: hypothetical protein +FIG00850210 FIG00850211: hypothetical protein +FIG00850211 FIG00850213: hypothetical protein +FIG00850216 FIG00850217: hypothetical protein +FIG00850239 FIG00850243: hypothetical protein +FIG00850246 FIG00850247: hypothetical protein +FIG00850247 FIG00850248: hypothetical protein +FIG00850248 FIG00850252: hypothetical protein +FIG00850254 FIG00850257: hypothetical protein +FIG00850257 Transcription repressor of tripartite multidrug resistance system +FIG00850260 FIG00850261: hypothetical protein +FIG00850261 probable membrane protein NMA0706 +FIG00850263 FIG00850264: hypothetical protein +FIG00850268 FIG00850269: hypothetical protein +FIG00850270 FIG00850271: hypothetical protein +FIG00850271 FIG00850272: hypothetical protein +FIG00850272 FIG00850279: hypothetical protein +FIG00850280 FIG00850281: hypothetical protein +FIG00850281 FIG00850282: hypothetical protein +FIG00850284 FIG00850285: hypothetical protein +FIG00850285 FIG00850286: hypothetical protein +FIG00850289 FIG00850291: hypothetical protein +FIG00850304 protein of unknown function DUF125, transmembrane +FIG00850306 FIG00850309: hypothetical protein +FIG00850309 FIG00850312: hypothetical protein +FIG00850317 FIG00850318: hypothetical protein +FIG00850328 FIG00850329: hypothetical protein +FIG00850330 FIG00850331: hypothetical protein +FIG00850331 FIG00850334: hypothetical protein +FIG00850336 FIG00850338: hypothetical protein +FIG00850338 FIG00850340: hypothetical protein +FIG00850340 FIG00850341: hypothetical protein +FIG00850341 FIG00850343: hypothetical protein +FIG00850346 FIG00850347: hypothetical protein +FIG00850356 FIG00850358: hypothetical protein +FIG00850359 FIG00850361: hypothetical protein +FIG00850361 FIG00850363: hypothetical protein +FIG00850365 FIG00850366: hypothetical protein +FIG00850366 FIG00850367: hypothetical protein +FIG00850373 FIG00850374: hypothetical protein +FIG00850374 plasmid stability-like protein +FIG00850383 FIG00850384: hypothetical protein +FIG00850385 FIG00850387: hypothetical protein +FIG00850387 FIG00850388: hypothetical protein +FIG00850403 hypothetical protein +FIG00850405 FIG00850406: hypothetical protein +FIG00850414 FIG00850415: hypothetical protein +FIG00850416 FIG00850417: hypothetical protein +FIG00850421 FIG00850423: hypothetical protein +FIG00850424 FIG00850426: hypothetical protein +FIG00850428 FIG00850429: hypothetical protein +FIG00850449 hypothetical protein +FIG00850450 FIG00850453: hypothetical protein +FIG00850453 FIG00850454: hypothetical protein +FIG00850454 FIG00850455: hypothetical protein +FIG00850455 FIG00850457: hypothetical protein +FIG00850457 FIG00850458: hypothetical protein +FIG00850467 FIG00850468: hypothetical protein +FIG00850469 FIG00850473: hypothetical protein +FIG00850473 FIG00850475: hypothetical protein +FIG00850476 FIG00850477: hypothetical protein +FIG00850478 FIG00850480: hypothetical protein +FIG00850480 FIG00850481: hypothetical protein +FIG00850481 FIG00849876: hypothetical protein +FIG00850484 FIG00850485: hypothetical protein +FIG00850485 FIG00850486: hypothetical protein +FIG00850487 FIG00850488: hypothetical protein +FIG00850492 FIG00850494: hypothetical protein +FIG00850494 FIG00850495: hypothetical protein +FIG00850495 FIG00850496: hypothetical protein +FIG00850496 FIG00850497: hypothetical protein +FIG00850509 FIG00850511: hypothetical protein +FIG00850518 FIG00850519: hypothetical protein +FIG00850531 FIG00850532: hypothetical protein +FIG00850538 FIG00850539: hypothetical protein +FIG00850539 FIG00850540: hypothetical protein +FIG00850543 FIG00850545: hypothetical protein +FIG00850545 FIG00850546: hypothetical protein +FIG00850548 FIG00850549: hypothetical protein +FIG00850552 FIG00850553: hypothetical protein +FIG00850563 FIG00850564: hypothetical protein +FIG00850567 FIG00850570: hypothetical protein +FIG00850575 FIG00850579: hypothetical protein +FIG00850579 FIG00850581: hypothetical protein +FIG00850585 FIG00850586: hypothetical protein +FIG00850588 FIG00850589: hypothetical protein +FIG00850600 FIG00850603: hypothetical protein +FIG00850604 SUN protein +FIG00850606 FIG00850608: hypothetical protein +FIG00850616 FIG00850617: hypothetical protein +FIG00850635 FIG00850636: hypothetical protein +FIG00850640 hypothetical protein +FIG00850641 FIG00850642: hypothetical protein +FIG00850651 FIG00850652: hypothetical protein +FIG00850653 FIG00850654: hypothetical protein +FIG00850654 FIG00850655: hypothetical protein +FIG00850655 FIG00850656: hypothetical protein +FIG00850658 FIG00850661: hypothetical protein +FIG00850665 FIG00850668: hypothetical protein +FIG00850672 FIG00850673: hypothetical protein +FIG00850680 hypothetical protein NMA1289 +FIG00850682 FIG00850683: hypothetical protein +FIG00850687 FIG00850688: hypothetical protein +FIG00850694 FIG00850695: hypothetical protein +FIG00850704 FIG00850707: hypothetical protein +FIG00850716 FIG00850717: hypothetical protein +FIG00850717 hypothetical protein +FIG00850722 FIG00850723: hypothetical protein +FIG00850723 FIG00850724: hypothetical protein +FIG00850724 FIG00850725: hypothetical protein +FIG00850733 FIG00850735: hypothetical protein +FIG00850735 FIG00850736: hypothetical protein +FIG00850736 FIG00850738: hypothetical protein +FIG00850745 FIG00850746: hypothetical protein +FIG00850747 FIG00850748: hypothetical protein +FIG00850748 FIG00850749: hypothetical protein +FIG00850753 FIG00850754: hypothetical protein +FIG00850759 FIG00850761: hypothetical protein +FIG00850770 FIG00850771: hypothetical protein +FIG00850772 FIG00850773: hypothetical protein +FIG00850785 FIG00850789: hypothetical protein +FIG00850790 FIG00850792: hypothetical protein +FIG00850796 FIG00850797: hypothetical protein +FIG00850797 FIG00850799: hypothetical protein +FIG00850806 FIG00850807: hypothetical protein +FIG00850809 FIG00850813: hypothetical protein +FIG00850816 FIG00850818: hypothetical protein +FIG00850821 FIG00850823: hypothetical protein +FIG00850823 FIG00850825: hypothetical protein +FIG00850829 FIG00850832: hypothetical protein +FIG00850832 FIG00850833: hypothetical protein +FIG00850851 FIG00850852: hypothetical protein +FIG00850865 FIG00850866: hypothetical protein +FIG00850875 FIG00850877: hypothetical protein +FIG00850877 FIG00850879: hypothetical protein +FIG00850879 FIG00850880: hypothetical protein +FIG00850890 transfer origin protein, TraL +FIG00850895 UDP-N-acetylmuramoyl-tripeptide--D-alanyl-D-alanine ligase, truncation +FIG00850901 FIG00850902: hypothetical protein +FIG00850902 FIG00850903: hypothetical protein +FIG00850903 FIG00850904: hypothetical protein +FIG00850904 FIG00850905: hypothetical protein +FIG00850907 FIG00850912: hypothetical protein +FIG00850912 FIG00850914: hypothetical protein +FIG00850914 FIG00850915: hypothetical protein +FIG00850915 FIG00850916: hypothetical protein +FIG00850916 FIG00850918: hypothetical protein +FIG00850920 FIG00850924: hypothetical protein +FIG00850924 FIG00850925: hypothetical protein +FIG00850925 FIG00850926: hypothetical protein +FIG00850926 FIG00850928: hypothetical protein +FIG00850930 FIG00850931: hypothetical protein +FIG00850932 FIG00850933: hypothetical protein +FIG00850936 FIG00850937: hypothetical protein +FIG00850937 FIG00850938: hypothetical protein +FIG00850938 FIG00850939: hypothetical protein +FIG00850941 FIG00850942: hypothetical protein +FIG00850944 FIG00850945: hypothetical protein +FIG00850945 FIG00850946: hypothetical protein +FIG00850946 FIG00850948: hypothetical protein +FIG00850948 FIG00850949: hypothetical protein +FIG00850949 FIG00850950: hypothetical protein +FIG00850951 FIG00850953: hypothetical protein +FIG00850953 FIG00850956: hypothetical protein +FIG00850956 putative ribosome-binding factor A +FIG00850959 FIG00850960: hypothetical protein +FIG00850960 FIG00850963: hypothetical protein +FIG00850967 FIG00850969: hypothetical protein +FIG00850969 FIG00850970: hypothetical protein +FIG00850970 FIG00850971: hypothetical protein +FIG00850972 FIG00850973: hypothetical protein +FIG00850973 FIG00850974: hypothetical protein +FIG00850974 FIG00850975: hypothetical protein +FIG00850975 FIG00850976: hypothetical protein +FIG00850976 FIG00850977: hypothetical protein +FIG00850977 FIG00850978: hypothetical protein +FIG00850979 Believed to be involved in assembly of Fe-S clusters +FIG00850981 FIG00850982: hypothetical protein +FIG00850982 FIG00850984: hypothetical protein +FIG00850985 FIG00850986: hypothetical protein +FIG00850986 FIG00850987: hypothetical protein +FIG00850988 FIG00850989: hypothetical protein +FIG00850991 FIG00850992: hypothetical protein +FIG00850999 FIG00851000: hypothetical protein +FIG00851000 FIG00851001: hypothetical protein +FIG00851001 FIG00851002: hypothetical protein +FIG00851002 FIG00851004: hypothetical protein +FIG00851004 FIG00851005: hypothetical protein +FIG00851006 sodium/proline symporter +FIG00851007 FIG00851010: hypothetical protein +FIG00851010 FIG00851012: hypothetical protein +FIG00851012 FIG00851014: hypothetical protein +FIG00851014 FIG00851015: hypothetical protein +FIG00851015 CBS/transporter associated domain protein +FIG00851020 FIG00851021: hypothetical protein +FIG00851021 vacJ lipoprotein precursor +FIG00851022 FIG00851023: hypothetical protein +FIG00851023 ATP-dependent helicase/nuclease +FIG00851026 FIG00851028: hypothetical protein +FIG00851028 putative glutamyl-tRNA(Gln) amidotransferase, C subunit +FIG00851030 FIG00851031: hypothetical protein +FIG00851031 FIG00851032: hypothetical protein +FIG00851032 protease B( EC:3.4.99.- ) +FIG00851033 FIG00851034: hypothetical protein +FIG00851034 FIG00851035: hypothetical protein +FIG00851035 Transcriptional Regulator, XRE family +FIG00851038 FIG00851039: hypothetical protein +FIG00851039 FIG00851040: hypothetical protein +FIG00851040 FIG00851041: hypothetical protein +FIG00851041 FIG00851042: hypothetical protein +FIG00851042 FIG00851043: hypothetical protein +FIG00851043 FIG00851044: hypothetical protein +FIG00851044 Inner membrane protein forms channel for type IV secretion of T-DNA complex, VirB8 +FIG00851045 putative outer surface protein +FIG00851046 FIG00851047: hypothetical protein +FIG00851047 Tim44-like domain protein +FIG00851048 FIG00851049: hypothetical protein +FIG00851050 FIG00851051: hypothetical protein +FIG00851053 FIG00851054: hypothetical protein +FIG00851056 FIG00851057: hypothetical protein +FIG00851058 FIG00851060: hypothetical protein +FIG00851060 outer membrane lipoprotein carrier protein LolA, putative +FIG00851063 FIG00851064: hypothetical protein +FIG00851064 FIG00851065: hypothetical protein +FIG00851065 FIG00851066: hypothetical protein +FIG00851066 Inner membrane protein of type IV secretion of T-DNA complex, VirB6 +FIG00851067 putative peptidoglycan-associated lipoprotein +FIG00851069 FIG00851071: hypothetical protein +FIG00851071 possible regulator of murein genes BolA +FIG00851074 FIG00851075: hypothetical protein +FIG00851077 Protein-export membrane protein secG +FIG00851078 FIG00851079: hypothetical protein +FIG00851084 FIG00851085: hypothetical protein +FIG00851089 FIG00851091: hypothetical protein +FIG00851091 FIG00851092: hypothetical protein +FIG00851092 FIG00851093: hypothetical protein +FIG00851095 FIG00851096: hypothetical protein +FIG00851096 FIG00851100: hypothetical protein +FIG00851100 FIG00851101: hypothetical protein +FIG00851102 FIG00851103: hypothetical protein +FIG00851104 FIG00851106: hypothetical protein +FIG00851106 FIG00851107: hypothetical protein +FIG00851107 FIG00851108: hypothetical protein +FIG00851108 FIG00851109: hypothetical protein +FIG00851109 FIG00851110: hypothetical protein +FIG00851110 FIG00851111: hypothetical protein +FIG00851113 FIG00851114: hypothetical protein +FIG00851114 FIG00851115: hypothetical protein +FIG00851120 FIG00851121: hypothetical protein +FIG00851121 FIG00851122: hypothetical protein +FIG00851122 FIG00851124: hypothetical protein +FIG00851124 FIG00851125: hypothetical protein +FIG00851126 FIG00851128: hypothetical protein +FIG00851128 FIG00851129: hypothetical protein +FIG00851129 Transcriptional activator protein +FIG00851130 FIG00851131: hypothetical protein +FIG00851134 Lysyl-tRNA synthetase (class II) (EC 6.1.1.6) @ Lysyl-tRNA synthetase (class II) (EC 6.1.1.6), mitochondrial +FIG00851136 FIG00851137: hypothetical protein +FIG00851137 FIG00851139: hypothetical protein +FIG00851146 FIG00851148: hypothetical protein +FIG00851148 FIG00851149: hypothetical protein +FIG00851149 Inner membrane protein of type IV secretion of T-DNA complex, VirB6 +FIG00851150 Biotin synthesis protein BioH +FIG00851153 FIG00851154: hypothetical protein +FIG00851155 FIG00851156: hypothetical protein +FIG00851163 FIG00851164: hypothetical protein +FIG00851165 FIG00851168: hypothetical protein +FIG00851171 FIG00851172: hypothetical protein +FIG00851172 putative competence protein ComL +FIG00851173 histidine kinase sensor protein( EC:2.7.1.- ) +FIG00851463 molybdopterin oxidoreductase, iron sulfur subunit +FIG00851983 FIG00852003: hypothetical protein +FIG00852233 FIG00852234: hypothetical protein +FIG00852235 cytochrome c biogenesis protein +FIG00852246 FIG00852247: hypothetical protein +FIG00852247 FIG00852249: hypothetical protein +FIG00852249 FIG00852251: hypothetical protein +FIG00852251 Bll4347 protein +FIG00852255 FIG00852256: hypothetical protein +FIG00852256 FIG00852257: hypothetical protein +FIG00852263 FIG00852266: hypothetical protein +FIG00852266 FIG00852267: hypothetical protein +FIG00852271 putative carbohydrates permease +FIG00852274 FIG00852276: hypothetical protein +FIG00852277 FIG00852278: hypothetical protein +FIG00852279 FIG00852280: hypothetical protein +FIG00852281 FIG00852282: hypothetical protein +FIG00852286 FIG00852288: hypothetical protein +FIG00852291 Bll5862 protein +FIG00852295 Mlr3471 protein +FIG00852300 Sel1-like repeat +FIG00852304 FIG00852309: hypothetical protein +FIG00852309 FIG00852310: hypothetical protein +FIG00852310 FIG00852311: hypothetical protein +FIG00852311 FIG00852314: hypothetical protein +FIG00852314 FIG00852317: hypothetical protein +FIG00852317 FIG00852318: hypothetical protein +FIG00852319 NADH-UBIQUINONE OXIDOREDUCTASE 18 KD SUBUNIT (EC 1.6.5.3) (EC 1.6.99.3) +FIG00852320 FIG00852321: hypothetical protein +FIG00852326 FIG00852328: hypothetical protein +FIG00852328 FIG00852329: hypothetical protein +FIG00852330 FIG00852332: hypothetical protein +FIG00852336 FIG00852339: hypothetical protein +FIG00852339 FIG00852341: hypothetical protein +FIG00852341 FIG01261915: hypothetical protein +FIG00852352 FIG00852353: hypothetical protein +FIG00852359 FIG00852360: hypothetical protein +FIG00852360 FIG00852361: hypothetical protein +FIG00852365 FIG00852367: hypothetical protein +FIG00852369 FIG00852372: hypothetical protein +FIG00852377 FIG00852386: hypothetical protein +FIG00852386 FIG00852388: hypothetical protein +FIG00852388 FIG00852389: hypothetical protein +FIG00852389 FIG00852390: hypothetical protein +FIG00852390 Serine protease precursor +FIG00852391 FIG00852392: hypothetical protein +FIG00852398 FIG00852399: hypothetical protein +FIG00852399 FIG00852400: hypothetical protein +FIG00852400 FIG01131703: hypothetical protein +FIG00852404 FIG00852405: hypothetical protein +FIG00852405 FIG00852407: hypothetical protein +FIG00852407 FIG00450905: hypothetical protein +FIG00852410 FIG00852411: hypothetical protein +FIG00852422 CBS domain containing membrane protein +FIG00852423 FIG00852424: hypothetical protein +FIG00852424 FIG00852425: hypothetical protein +FIG00852426 FIG00852427: hypothetical protein +FIG00852427 FIG00852428: hypothetical protein +FIG00852428 FIG00852441: hypothetical protein +FIG00852446 protein of unknown function DUF299 +FIG00852459 FIG00852460: hypothetical protein +FIG00852467 FIG00852469: hypothetical protein +FIG00852469 FIG00852472: hypothetical protein +FIG00852474 FIG00852476: hypothetical protein +FIG00852476 FIG00852477: hypothetical protein +FIG00852483 FIG00852486: hypothetical protein +FIG00852486 FIG00852489: hypothetical protein +FIG00852489 FIG00852490: hypothetical protein +FIG00852495 FIG00852496: hypothetical protein +FIG00852496 Bll7562 protein +FIG00852504 FIG00852505: hypothetical protein +FIG00852507 2-polyprenyl-6-methoxyphenol hydroxylase and related FAD-dependent oxidoreductases +FIG00852513 FIG00852517: hypothetical protein +FIG00852517 FIG00852524: hypothetical protein +FIG00852524 FIG00852527: hypothetical protein +FIG00852534 FIG00852536: hypothetical protein +FIG00852536 FIG00852537: hypothetical protein +FIG00852537 FIG00852541: hypothetical protein +FIG00852541 FIG00852542: hypothetical protein +FIG00852542 FIG00852545: hypothetical protein +FIG00852545 FIG00852549: hypothetical protein +FIG00852549 FIG00852550: hypothetical protein +FIG00852550 putative signal transduction histidine kinase with response regulator receiver domain +FIG00852551 FIG00852552: hypothetical protein +FIG00852552 Bsl2907 protein +FIG00852554 FIG00852555: hypothetical protein +FIG00852561 FIG00852565: hypothetical protein +FIG00852566 FIG00852571: hypothetical protein +FIG00852571 FIG00852574: hypothetical protein +FIG00852574 FIG00852575: hypothetical protein +FIG00852575 FIG00852576: hypothetical protein +FIG00852578 FIG00852579: hypothetical protein +FIG00852592 FIG00852593: hypothetical protein +FIG00852594 FIG00852595: hypothetical protein +FIG00852595 FIG00852601: hypothetical protein +FIG00852601 FIG00741759: hypothetical protein +FIG00852608 FIG01004599: hypothetical protein +FIG00852612 FIG00852613: hypothetical protein +FIG00852613 FIG00852614: hypothetical protein +FIG00852614 FIG00852616: hypothetical protein +FIG00852618 FIG00852620: hypothetical protein +FIG00852620 FIG00852621: hypothetical protein +FIG00852626 FIG00852630: hypothetical protein +FIG00852630 Bll4915 protein +FIG00852633 FIG00852634: hypothetical protein +FIG00852634 FIG00888113: hypothetical protein +FIG00852635 FIG00852636: hypothetical protein +FIG00852641 FIG00852642: hypothetical protein +FIG00852643 FIG00852644: hypothetical protein +FIG00852647 Bll7673 protein +FIG00852651 FIG01005674: hypothetical protein +FIG00852653 FIG00852654: hypothetical protein +FIG00852654 FIG00852656: hypothetical protein +FIG00852658 FIG00852663: hypothetical protein +FIG00852663 FIG00852664: hypothetical protein +FIG00852664 FIG00852668: hypothetical protein +FIG00852668 FIG00852671: hypothetical protein +FIG00852672 FIG00852674: hypothetical protein +FIG00852681 FIG00852686: hypothetical protein +FIG00852689 Chaperone protein Hsp33 +FIG00852690 Probable glycosyl transferase +FIG00852691 FIG00852692: hypothetical protein +FIG00852692 FIG00852694: hypothetical protein +FIG00852694 FIG00852695: hypothetical protein +FIG00852695 ribonuclease T2 +FIG00852698 type III secretion protein +FIG00852699 FIG00852701: hypothetical protein +FIG00852701 FIG00852707: hypothetical protein +FIG00852707 Kinesin-like protein +FIG00852709 putative transcriptional regulator, CopG family +FIG00852710 FIG00852713: hypothetical protein +FIG00852713 FIG00852714: hypothetical protein +FIG00852722 FIG00852723: hypothetical protein +FIG00852723 FIG00852724: hypothetical protein +FIG00852741 CsoS1D +FIG00852745 FIG00852747: hypothetical protein +FIG00852748 FIG00852749: hypothetical protein +FIG00852760 FIG00852761: hypothetical protein +FIG00852761 FIG00852762: hypothetical protein +FIG00852778 FIG00852779: hypothetical protein +FIG00852779 FIG00852780: hypothetical protein +FIG00852788 FIG00852789: hypothetical protein +FIG00852803 FIG00852805: hypothetical protein +FIG00852809 FIG00852810: hypothetical protein +FIG00852813 FIG01004437: hypothetical protein +FIG00852815 FIG00852816: hypothetical protein +FIG00852828 FIG00852830: hypothetical protein +FIG00852830 protein of unknown function DUF540 +FIG00852831 FIG00852833: hypothetical protein +FIG00852833 Cytochrome c, class I +FIG00852834 FIG00852840: hypothetical protein +FIG00852841 FIG00852843: hypothetical protein +FIG00852846 FIG00852849: hypothetical protein +FIG00852849 FIG00852850: hypothetical protein +FIG00852864 FIG00852865: hypothetical protein +FIG00852867 hypothetical protein +FIG00852874 FIG00852876: hypothetical protein +FIG00852876 FIG00852878: hypothetical protein +FIG00852882 blr3068; probable transcriptional regulator +FIG00852890 FIG00852891: hypothetical protein +FIG00852891 FIG00852892: hypothetical protein +FIG00852892 FIG00852894: hypothetical protein +FIG00852894 FIG00852896: hypothetical protein +FIG00852896 Bll0880 protein +FIG00852898 FIG00344505: hypothetical protein +FIG00852899 FIG00852901: hypothetical protein +FIG00852909 possible outer membrane protein +FIG00852918 FIG00852919: hypothetical protein +FIG00852920 FIG00852924: hypothetical protein +FIG00852924 Ergothioneine biosynthesis protein EgtB +FIG00852928 FIG00852929: hypothetical protein +FIG00852929 FIG00852937: hypothetical protein +FIG00852937 FIG00852942: hypothetical protein +FIG00852942 FIG00852943: hypothetical protein +FIG00852943 FIG00852949: hypothetical protein +FIG00852950 FIG00852951: hypothetical protein +FIG00852960 FIG00852962: hypothetical protein +FIG00852968 FIG00852969: hypothetical protein +FIG00852969 FIG00852970: hypothetical protein +FIG00852970 FIG00852971: hypothetical protein +FIG00852971 FIG00852972: hypothetical protein +FIG00852974 FIG00852976: hypothetical protein +FIG00852981 FIG00852982: hypothetical protein +FIG00852988 FIG00852990: hypothetical protein +FIG00852991 FIG00852992: hypothetical protein +FIG00852993 FIG00852994: hypothetical protein +FIG00852996 Bsr4694 protein +FIG00852999 FIG00853005: hypothetical protein +FIG00853007 FIG00853011: hypothetical protein +FIG00853011 FIG00853012: hypothetical protein +FIG00853013 FIG00853015: hypothetical protein +FIG00853015 glycosyl transferase, group 1 +FIG00853018 FIG00853019: hypothetical protein +FIG00853020 FIG00853024: hypothetical protein +FIG00853025 periplasmic serine endoprotease +FIG00853030 ATP-DEPENDENT DNA HELICASE +FIG00853034 FIG00853037: hypothetical protein +FIG00853037 FIG01124596: hypothetical protein +FIG00853042 Invasion associated locus B +FIG00853049 FIG00853055: hypothetical protein +FIG00853055 FIG00853059: hypothetical protein +FIG00853059 FIG00853060: hypothetical protein +FIG00853060 FIG00853061: hypothetical protein +FIG00853061 FIG00853062: hypothetical protein +FIG00853062 Bll1031 protein +FIG00853068 FIG00853069: hypothetical protein +FIG00853069 FIG01004279: hypothetical protein +FIG00853079 FIG00853080: hypothetical protein +FIG00853080 FIG00853081: hypothetical protein +FIG00853081 FIG00853082: hypothetical protein +FIG00853085 FIG00853088: hypothetical protein +FIG00853088 FIG01265301: hypothetical protein +FIG00853091 FIG00853092: hypothetical protein +FIG00853096 FIG00853097: hypothetical protein +FIG00853109 periplasmic sensor signal transduction histidine kinase +FIG00853120 FIG00853128: hypothetical protein +FIG00853130 putative regulator in two-component regulatory system; LuxR family +FIG00853136 FIG00853143: hypothetical protein +FIG00853143 PRC-barrel +FIG00853145 FIG00853146: hypothetical protein +FIG00853147 FIG00853148: hypothetical protein +FIG00853148 Bll0493 protein +FIG00853150 Lytic murein transglycosylase +FIG00853156 FIG00853158: hypothetical protein +FIG00853158 FIG00853160: hypothetical protein +FIG00853163 Bll3711 protein +FIG00853168 FIG00853169: hypothetical protein +FIG00853171 Farnesyl cysteine carboxyl-methyltransferase (EC 2.1.1.100) +FIG00853181 Hypothetical protein with RNA-binding region RNP-1 +FIG00853186 FIG00853191: hypothetical protein +FIG00853197 FIG00853198: hypothetical protein +FIG00853198 protein of unknown function DUF983 +FIG00853200 FIG00853202: hypothetical protein +FIG00853202 FIG00853203: hypothetical protein +FIG00853203 FIG00439845: hypothetical protein +FIG00853204 FIG00853205: hypothetical protein +FIG00853205 Bll0605 protein +FIG00853206 FIG00853207: hypothetical protein +FIG00853212 FIG00853216: hypothetical protein +FIG00853218 FIG00853219: hypothetical protein +FIG00853236 Universal stress protein UspA and related nucleotide-binding proteins +FIG00853241 FIG00853242: hypothetical protein +FIG00853242 FIG00853243: hypothetical protein +FIG00853245 aspartate/glutamate/uridylate kinase +FIG00853246 FIG00853247: hypothetical protein +FIG00853255 FIG00853265: hypothetical protein +FIG00853265 putative Methyl-accepting chemotaxis protein +FIG00853267 FIG00853268: hypothetical protein +FIG00853268 Possible DNA methylase +FIG00853274 FIG00853276: hypothetical protein +FIG00853276 FIG00853280: hypothetical protein +FIG00853284 FIG00853286: hypothetical protein +FIG00853286 FIG00853289: hypothetical protein +FIG00853289 FIG00853291: hypothetical protein +FIG00853292 FIG00853293: hypothetical protein +FIG00853295 FIG00853296: hypothetical protein +FIG00853302 FIG00853303: hypothetical protein +FIG00853303 FIG00853305: hypothetical protein +FIG00853311 FIG00853313: hypothetical protein +FIG00853313 FIG00853314: hypothetical protein +FIG00853314 FIG00853317: hypothetical protein +FIG00853317 FIG00853321: hypothetical protein +FIG00853321 Molybdate ABC transporter, permease protein +FIG00853330 FIG00853336: hypothetical protein +FIG00853336 FIG00853337: hypothetical protein +FIG00853338 FIG00853339: hypothetical protein +FIG00853347 FIG00853348: hypothetical protein +FIG00853348 FIG00853350: hypothetical protein +FIG00853352 FIG00853353: hypothetical protein +FIG00853353 FIG00853355: hypothetical protein +FIG00853355 FIG00853361: hypothetical protein +FIG00853370 FIG00853371: hypothetical protein +FIG00853371 FIG00853372: hypothetical protein +FIG00853375 Ubiquinol-cytochrome C chaperone +FIG00853379 FIG00853381: hypothetical protein +FIG00853386 FIG00853388: hypothetical protein +FIG00853397 FIG00853399: hypothetical protein +FIG00853399 CsoS1D-associated protein 3 +FIG00853400 FIG00853403: hypothetical protein +FIG00853408 FIG00853409: hypothetical protein +FIG00853411 Radical SAM protein required for addition of adenosine to hopane skeleton, HpnH +FIG00853417 FIG00853419: hypothetical protein +FIG00853419 FIG00853431: hypothetical protein +FIG00853431 FIG00853433: hypothetical protein +FIG00853433 FIG01004236: hypothetical protein +FIG00853435 Bll0555 protein +FIG00853440 FIG00853441: hypothetical protein +FIG00853441 Bll2902 protein +FIG00853452 FIG00853453: hypothetical protein +FIG00853454 FIG00853455: hypothetical protein +FIG00853460 FIG01007177: hypothetical protein +FIG00853462 FIG00853466: hypothetical protein +FIG00853467 FIG00853473: hypothetical protein +FIG00853474 FIG00853481: hypothetical protein +FIG00853481 FIG00853482: hypothetical protein +FIG00853482 FIG00853486: hypothetical protein +FIG00853491 phage P2 GpU +FIG00853494 FIG00853496: hypothetical protein +FIG00853496 FIG00853498: hypothetical protein +FIG00853512 FIG00853515: hypothetical protein +FIG00853535 FIG00853536: hypothetical protein +FIG00853536 FIG00853538: hypothetical protein +FIG00853538 FIG00853540: hypothetical protein +FIG00853540 FIG00853542: hypothetical protein +FIG00853543 FIG00853545: hypothetical protein +FIG00853545 FIG00853546: hypothetical protein +FIG00853556 Dolichol-phosphate mannosyltransferase +FIG00853561 FIG00853563: hypothetical protein +FIG00853563 FIG00853564: hypothetical protein +FIG00853564 FIG00853565: hypothetical protein +FIG00853567 FIG00853570: hypothetical protein +FIG00853573 FIG00853574: hypothetical protein +FIG00853575 FIG00853576: hypothetical protein +FIG00853577 FIG00853578: hypothetical protein +FIG00853579 FIG00853580: hypothetical protein +FIG00853580 FIG00853581: hypothetical protein +FIG00853581 FIG00853582: hypothetical protein +FIG00853583 Mll5190 protein +FIG00853584 FIG00853585: hypothetical protein +FIG00853591 FIG00853593: hypothetical protein +FIG00853601 FIG00853603: hypothetical protein +FIG00853610 FIG00853611: hypothetical protein +FIG00853611 FIG00853613: hypothetical protein +FIG00853618 FIG00853619: hypothetical protein +FIG00853620 Conserved hypothetical protein, gene in Ubiquinol-cytochrome C chaperone locus +FIG00853621 FIG00439930: hypothetical protein +FIG00853631 FIG00853633: hypothetical protein +FIG00853633 FIG00854243: hypothetical protein +FIG00853635 FIG00853637: hypothetical protein +FIG00853637 FIG00853639: hypothetical protein +FIG00853648 FIG00853649: hypothetical protein +FIG00853650 FIG00853651: hypothetical protein +FIG00853651 FIG00853654: hypothetical protein +FIG00853654 FIG00853658: hypothetical protein +FIG00853658 FIG00853659: hypothetical protein +FIG00853659 FIG00853661: hypothetical protein +FIG00853664 FIG00853665: hypothetical protein +FIG00853665 FIG00853668: hypothetical protein +FIG00853680 FIG00853685: hypothetical protein +FIG00853688 FIG00853698: hypothetical protein +FIG00853704 FIG00853707: hypothetical protein +FIG00853712 FIG00853984: hypothetical protein +FIG00853718 nuclear protein SET +FIG00853723 FIG00853724: hypothetical protein +FIG00853724 FIG00853729: hypothetical protein +FIG00853729 FIG00853730: hypothetical protein +FIG00853730 FIG00853731: hypothetical protein +FIG00853740 FIG00853741: hypothetical protein +FIG00853741 FIG01004475: hypothetical protein +FIG00853748 FIG00853749: hypothetical protein +FIG00853751 FIG00853754: hypothetical protein +FIG00853754 Bll5638 protein +FIG00853757 FIG00853758: hypothetical protein +FIG00853760 FIG00853761: hypothetical protein +FIG00853771 FIG00853772: hypothetical protein +FIG00853772 FIG00853773: hypothetical protein +FIG00853775 FIG00853778: hypothetical protein +FIG00853778 Sun protein +FIG00853781 FIG01008242: hypothetical protein +FIG00853789 FIG00853790: hypothetical protein +FIG00853791 Carbamoyl-phosphate synthase L chain, ATP-binding +FIG00853798 FIG00853800: hypothetical protein +FIG00853809 FIG00853812: hypothetical protein +FIG00853814 FIG00853815: hypothetical protein +FIG00853815 FIG00853817: hypothetical protein +FIG00853820 hypothetical protein +FIG00853834 FIG00853835: hypothetical protein +FIG00853837 FIG00853838: hypothetical protein +FIG00853838 Mll0909 protein +FIG00853857 Dimethylhistidine N-methyltransferase +FIG00853861 FIG00853872: hypothetical protein +FIG00853878 FIG00853880: hypothetical protein +FIG00853886 FIG00853887: hypothetical protein +FIG00853888 FIG00853890: hypothetical protein +FIG00853894 FIG00853896: hypothetical protein +FIG00853898 Amine oxidase +FIG00853901 FIG00853903: hypothetical protein +FIG00853904 cupin region +FIG00853910 FIG00853912: hypothetical protein +FIG00853912 FIG00853916: hypothetical protein +FIG00853916 FIG00853917: hypothetical protein +FIG00853917 Lipolytic enzyme, G-D-S-L family precursor +FIG00853922 FIG00853926: hypothetical protein +FIG00853926 FIG00853928: hypothetical protein +FIG00853929 FIG00853930: hypothetical protein +FIG00853933 FIG00853935: hypothetical protein +FIG00853943 FIG00853945: hypothetical protein +FIG00853961 FIG00853963: hypothetical protein +FIG00853963 FIG00853966: hypothetical protein +FIG00853979 FIG00853981: hypothetical protein +FIG00853981 FIG00853983: hypothetical protein +FIG00853984 FIG00853985: hypothetical protein +FIG00853987 Type I secretion system ATPase, PrtD +FIG00853992 FIG00853999: hypothetical protein +FIG00853999 FIG00854000: hypothetical protein +FIG00854000 FIG00854001: hypothetical protein +FIG00854006 FIG00854007: hypothetical protein +FIG00854009 FIG00854014: hypothetical protein +FIG00854014 FIG00854015: hypothetical protein +FIG00854015 FIG00854017: hypothetical protein +FIG00854025 FIG00854029: hypothetical protein +FIG00854030 FIG00854034: hypothetical protein +FIG00854034 FIG00854035: hypothetical protein +FIG00854051 putative peptidase, M23/M37 family +FIG00854053 PAS domain +FIG00854059 Neuropathy target esterase +FIG00854062 FIG00854066: hypothetical protein +FIG00854066 FIG00854067: hypothetical protein +FIG00854080 FIG00854082: hypothetical protein +FIG00854082 FIG00854083: hypothetical protein +FIG00854090 FIG00854092: hypothetical protein +FIG00854092 FIG00854094: hypothetical protein +FIG00854094 FIG00854095: hypothetical protein +FIG00854096 toprim domain-containing protein +FIG00854098 FIG00854100: hypothetical protein +FIG00854103 FIG01121096: hypothetical protein +FIG00854110 FIG00854116: hypothetical protein +FIG00854120 response regulator receiver (CheY-like) modulated diguanylate phosphodiesterase (EAL domain) +FIG00854123 FIG00793979: hypothetical protein +FIG00854126 FIG00854129: hypothetical protein +FIG00854129 FIG00854132: hypothetical protein +FIG00854132 Bll5807 protein +FIG00854159 lipopolysaccharide biosynthesis +FIG00854173 FIG00854175: hypothetical protein +FIG00854176 FIG00741453: hypothetical protein +FIG00854185 Bll3966 protein +FIG00854189 tyrosinase +FIG00854191 FIG00854193: hypothetical protein +FIG00854193 FIG00854198: hypothetical protein +FIG00854198 Mll4959 protein +FIG00854202 Integrative genetic element Gsu32, integrase +FIG00854206 FIG00854209: hypothetical protein +FIG00854209 FIG00854210: hypothetical protein +FIG00854213 FIG00854215: hypothetical protein +FIG00854216 FIG00854218: hypothetical protein +FIG00854218 FIG00854222: hypothetical protein +FIG00854243 Probable secretion ATP-binding protein +FIG00854244 Bll6480 protein +FIG00854251 FIG00854256: hypothetical protein +FIG00854260 FIG00854265: hypothetical protein +FIG00854269 FIG00854271: hypothetical protein +FIG00854271 FIG00854272: hypothetical protein +FIG00854272 FIG00557681: hypothetical protein +FIG00854274 FIG00854275: hypothetical protein +FIG00854283 virulence-associated E +FIG00854331 FIG00854336: hypothetical protein +FIG00854344 FIG00854346: hypothetical protein +FIG00854346 FIG00854348: hypothetical protein +FIG00854348 putative 3-oxoacyl-[acyl-carrier-protein] reductase +FIG00854351 Gll1166 protein +FIG00854376 FIG00854380: hypothetical protein +FIG00854389 FIG00854392: hypothetical protein +FIG00854392 thioredoxin/glutaredoxin +FIG00854400 FIG00854401: hypothetical protein +FIG00854409 FIG00854410: hypothetical protein +FIG00854415 FIG00854416: hypothetical protein +FIG00854427 FIG00854428: hypothetical protein +FIG00854428 FIG00854431: hypothetical protein +FIG00854431 FIG00854433: hypothetical protein +FIG00854433 FIG00854434: hypothetical protein +FIG00854455 invasion associated locus B +FIG00854464 FIG00854467: hypothetical protein +FIG00854468 FIG00854477: hypothetical protein +FIG00854487 FIG00854488: hypothetical protein +FIG00854489 ABC-type nitrate/sulfonate/bicarbonate transport systems periplasmic components +FIG00854517 FIG00854518: hypothetical protein +FIG00854518 FIG00854520: hypothetical protein +FIG00854520 FIG00854521: hypothetical protein +FIG00854526 cytochrome B561 +FIG00854556 FIG00854559: hypothetical protein +FIG00854585 arylsulfate sulfotransferase-related protein +FIG00854599 FIG00854600: hypothetical protein +FIG00854600 FIG00854601: hypothetical protein +FIG00854605 FIG00854606: hypothetical protein +FIG00854606 FIG00854610: hypothetical protein +FIG00854623 glycosyltransferases-like +FIG00854632 FIG00854634: hypothetical protein +FIG00854674 FIG00854677: hypothetical protein +FIG00854677 FIG00854680: hypothetical protein +FIG00854681 FIG00854682: hypothetical protein +FIG00854682 FIG00854683: hypothetical protein +FIG00854683 FIG00854684: hypothetical protein +FIG00854684 FIG00854688: hypothetical protein +FIG00854702 FIG00854704: hypothetical protein +FIG00854704 FIG00854705: hypothetical protein +FIG00854705 FIG00854710: hypothetical protein +FIG00854710 FIG00854711: hypothetical protein +FIG00854713 FIG00854716: hypothetical protein +FIG00854722 FIG00854723: hypothetical protein +FIG00854725 FIG00854731: hypothetical protein +FIG00854731 FIG00854738: hypothetical protein +FIG00854738 FIG00854740: hypothetical protein +FIG00854754 FIG00854755: hypothetical protein +FIG00854755 FIG00854756: hypothetical protein +FIG00854756 FIG00854759: hypothetical protein +FIG00854770 FIG00854774: hypothetical protein +FIG00854787 FIG00854793: hypothetical protein +FIG00854813 FIG00854816: hypothetical protein +FIG00854837 FIG00854842: hypothetical protein +FIG00854842 FIG01131865: hypothetical protein +FIG00854843 FIG00854844: hypothetical protein +FIG00854855 FIG00854856: hypothetical protein +FIG00854858 putative 3-oxoacyl-[acyl-carrier protein] reductase +FIG00854877 FIG00854878: hypothetical protein +FIG00854887 FIG00854889: hypothetical protein +FIG00854897 FIG00854898: hypothetical protein +FIG00854914 LipA a lipoprotein +FIG00854933 FIG00854937: hypothetical protein +FIG00854960 PDZ/DHR/GLGF +FIG00854982 Bll4089 protein +FIG00854988 FIG00854991: hypothetical protein +FIG00854994 FIG00854998: hypothetical protein +FIG00855017 FIG00855020: hypothetical protein +FIG00855047 FIG00855053: hypothetical protein +FIG00855070 FIG00855071: hypothetical protein +FIG00855118 putative pirin family protein +FIG00855121 phage late control D +FIG00855144 Mlr4574 protein +FIG00855146 ChrB domain protein +FIG00855173 FIG01008026: hypothetical protein +FIG00855216 PvdE, pyoverdine ABC export system, fused ATPase and permease components +FIG00855218 FIG00855220: hypothetical protein +FIG00855251 FIG00855254: hypothetical protein +FIG00855315 FIG00857750: hypothetical protein +FIG00855382 FIG00855386: hypothetical protein +FIG00855458 FIG00855465: hypothetical protein +FIG00855565 Two component response regulator homolog +FIG00855621 competence protein comEA +FIG00855720 FIG00855721: hypothetical protein +FIG00855727 FIG00855730: hypothetical protein +FIG00855767 cytochrome c peroxidase family protein +FIG00855854 FIG00855864: hypothetical protein +FIG00855890 Mlr0512 protein +FIG00855931 Pyrophosphatase, MutT/nudix family (EC 3.6.1.-) +FIG00855954 Alginate biosynthesis protein AlgZ/FimS +FIG00856007 FIG00856011: hypothetical protein +FIG00856017 FIG00856023: hypothetical protein +FIG00856210 Peroxinectin (EC 1.11.1.7) +FIG00856231 Sodium bicarbonate cotransporter +FIG00856553 Alpha/beta hydrolase fold protein +FIG00856557 COG3170: Tfp pilus assembly protein FimV +FIG00856561 FIG00856563: hypothetical protein +FIG00856563 FIG00856568: hypothetical protein +FIG00856568 FIG00856569: hypothetical protein +FIG00856577 FIG00856581: hypothetical protein +FIG00856581 FIG00856585: hypothetical protein +FIG00856585 FIG00856586: hypothetical protein +FIG00856586 FIG00856589: hypothetical protein +FIG00856591 FIG00856592: hypothetical protein +FIG00856592 FIG00856594: hypothetical protein +FIG00856594 Helix-turn-helix protein, CopG family +FIG00856595 copper resistance protein +FIG00856596 FIG00856603: hypothetical protein +FIG00856611 FIG00856616: hypothetical protein +FIG00856616 FIG00856617: hypothetical protein +FIG00856618 FIG00856619: hypothetical protein +FIG00856619 FIG00856620: hypothetical protein +FIG00856623 FIG00856624: hypothetical protein +FIG00856624 FIG00856629: hypothetical protein +FIG00856629 FIG00856630: hypothetical protein +FIG00856630 FIG00856636: hypothetical protein +FIG00856636 FIG00856637: hypothetical protein +FIG00856645 FIG00856648: hypothetical protein +FIG00856648 ABC transporter-like +FIG00856653 FIG00856654: hypothetical protein +FIG00856654 FIG00856658: hypothetical protein +FIG00856658 FIG00856661: hypothetical protein +FIG00856662 FIG00856664: hypothetical protein +FIG00856664 FIG00856669: hypothetical protein +FIG00856671 FIG00856673: hypothetical protein +FIG00856674 FIG00856675: hypothetical protein +FIG00856675 FIG00856676: hypothetical protein +FIG00856676 FIG00856682: hypothetical protein +FIG00856684 FIG00856688: hypothetical protein +FIG00856688 FIG00856690: hypothetical protein +FIG00856691 FIG00856694: hypothetical protein +FIG00856694 FIG00856695: hypothetical protein +FIG00856695 FIG00856696: hypothetical protein +FIG00856697 FIG00856699: hypothetical protein +FIG00856701 FIG00856703: hypothetical protein +FIG00856703 FIG00856706: hypothetical protein +FIG00856711 FIG00856723: hypothetical protein +FIG00856723 FIG00856724: hypothetical protein +FIG00856724 FIG00856729: hypothetical protein +FIG00856735 FIG00856737: hypothetical protein +FIG00856744 predicted periplasmic or secreted lipoprotein +FIG00856749 FIG00856751: hypothetical protein +FIG00856763 Oligopeptide transport system permease protein +FIG00856773 FIG00856775: hypothetical protein +FIG00856783 FIG00856785: hypothetical protein +FIG00856785 Ketohexokinase (EC 2.7.1.3) +FIG00856793 FIG00856796: hypothetical protein +FIG00856796 FIG00856797: hypothetical protein +FIG00856797 FIG00856802: hypothetical protein +FIG00856802 FIG00856803: hypothetical protein +FIG00856813 FIG00856816: hypothetical protein +FIG00856816 sigma-54-dependent transcriptional regulator +FIG00856820 FIG00856821: hypothetical protein +FIG00856821 FIG00856825: hypothetical protein +FIG00856825 FIG00856827: hypothetical protein +FIG00856827 FIG00856828: hypothetical protein +FIG00856828 FIG00856829: hypothetical protein +FIG00856829 FIG00856831: hypothetical protein +FIG00856849 FIG00856850: hypothetical protein +FIG00856850 Hopanoid-associated RND transporter, HpnN +FIG00856853 FIG00856854: hypothetical protein +FIG00856854 FIG00856855: hypothetical protein +FIG00856863 FIG00856865: hypothetical protein +FIG00856867 FIG00856869: hypothetical protein +FIG00856869 FIG00856872: hypothetical protein +FIG00856874 FIG00856880: hypothetical protein +FIG00856880 FIG00856882: hypothetical protein +FIG00856882 Ferrichrome transport ATP-binding protein fhuA (TC 1.B.14.1.4) +FIG00856884 FIG00856886: hypothetical protein +FIG00856886 FIG00856888: hypothetical protein +FIG00856897 FIG00856898: hypothetical protein +FIG00856898 FIG00856903: hypothetical protein +FIG00856903 FIG00856904: hypothetical protein +FIG00856904 FIG00856910: hypothetical protein +FIG00856910 FIG00856912: hypothetical protein +FIG00856912 FIG00856917: hypothetical protein +FIG00856917 FIG00856919: hypothetical protein +FIG00856919 FIG00856920: hypothetical protein +FIG00856920 FIG00856921: hypothetical protein +FIG00856921 ABC-type phosphate/phosphonate transport system periplasmic component +FIG00856923 FIG00856926: hypothetical protein +FIG00856926 FIG00856936: hypothetical protein +FIG00856936 FIG00856937: hypothetical protein +FIG00856939 FIG00856941: hypothetical protein +FIG00856941 sohB protein +FIG00856945 FIG00856949: hypothetical protein +FIG00856950 FIG00856952: hypothetical protein +FIG00856957 FIG00856958: hypothetical protein +FIG00856958 FIG00856959: hypothetical protein +FIG00856959 FIG00856961: hypothetical protein +FIG00856961 FIG00856962: hypothetical protein +FIG00856962 FIG00856966: hypothetical protein +FIG00856966 FIG00856979: hypothetical protein +FIG00856979 FIG00856981: hypothetical protein +FIG00856981 FIG00856982: hypothetical protein +FIG00856982 FIG00856985: hypothetical protein +FIG00856985 FIG00856987: hypothetical protein +FIG00856987 FIG00856990: hypothetical protein +FIG00856994 FIG00857000: hypothetical protein +FIG00857000 FIG00857007: hypothetical protein +FIG00857007 FIG00857008: hypothetical protein +FIG00857008 putative low molecular weight heat shock protein +FIG00857017 FIG00857022: hypothetical protein +FIG00857022 FIG00857023: hypothetical protein +FIG00857023 FIG00857033: hypothetical protein +FIG00857033 FIG00857037: hypothetical protein +FIG00857037 FIG00857039: hypothetical protein +FIG00857039 FIG00857040: hypothetical protein +FIG00857040 FIG00857041: hypothetical protein +FIG00857041 FIG00857042: hypothetical protein +FIG00857042 FIG00857043: hypothetical protein +FIG00857043 ABC transporter, fused permease and ATPase domains +FIG00857045 FIG00857054: hypothetical protein +FIG00857060 FIG00857062: hypothetical protein +FIG00857063 FIG00857064: hypothetical protein +FIG00857064 FIG00857072: hypothetical protein +FIG00857081 FIG00857084: hypothetical protein +FIG00857084 FIG00857085: hypothetical protein +FIG00857085 FIG00857086: hypothetical protein +FIG00857086 FIG00857089: hypothetical protein +FIG00857089 Protein of unknown function DUF190 +FIG00857090 FIG00857091: hypothetical protein +FIG00857091 FIG00857092: hypothetical protein +FIG00857094 FIG00857095: hypothetical protein +FIG00857095 FIG00857096: hypothetical protein +FIG00857101 nucleic acid-binding protein contains PIN domain-like +FIG00857113 Transcriptional regulator, AbrB family +FIG00857125 FIG00857128: hypothetical protein +FIG00857128 FIG00857131: hypothetical protein +FIG00857131 FIG00857132: hypothetical protein +FIG00857132 Sucrose synthase (EC 2.4.1.13) +FIG00857135 FIG00857136: hypothetical protein +FIG00857136 FIG00857137: hypothetical protein +FIG00857144 FIG00857147: hypothetical protein +FIG00857147 FIG00857150: hypothetical protein +FIG00857153 FIG00857162: hypothetical protein +FIG00857162 FIG00857163: hypothetical protein +FIG00857163 FIG00857165: hypothetical protein +FIG00857165 FIG00857166: hypothetical protein +FIG00857166 FIG00857167: hypothetical protein +FIG00857170 FIG00857172: hypothetical protein +FIG00857172 FIG00857173: hypothetical protein +FIG00857177 FIG00857178: hypothetical protein +FIG00857178 FIG00857179: hypothetical protein +FIG00857180 FIG00857182: hypothetical protein +FIG00857182 FIG00857186: hypothetical protein +FIG00857192 FIG048548: ATP synthase protein I2 +FIG00857193 FIG00857197: hypothetical protein +FIG00857199 FIG00857205: hypothetical protein +FIG00857205 NolW-like +FIG00857211 FIG00857215: hypothetical protein +FIG00857220 teichoic acid ABC transporter ATP-binding protein +FIG00857224 FIG00857226: hypothetical protein +FIG00857226 FIG00857227: hypothetical protein +FIG00857227 FIG00857230: hypothetical protein +FIG00857230 FIG00857231: hypothetical protein +FIG00857233 FIG00857237: hypothetical protein +FIG00857237 FIG00857238: hypothetical protein +FIG00857248 FIG00857250: hypothetical protein +FIG00857250 FIG00857256: hypothetical protein +FIG00857266 FIG00857271: hypothetical protein +FIG00857271 FIG00857274: hypothetical protein +FIG00857274 Hemimethylated DNA-binding region +FIG00857294 VrlQ +FIG00857299 CRISPR-associated protein, Csy3 family +FIG00857300 FIG00857304: hypothetical protein +FIG00857307 FIG00857311: hypothetical protein +FIG00857311 FIG00857318: hypothetical protein +FIG00857326 FIG00857328: hypothetical protein +FIG00857334 Branched-chain alpha-keto acid dehydrogenase, E3 component, dihydrolipoamide dehydrogenase (EC 1.8.1.4); Dihydrolipoamide dehydrogenase (EC 1.8.1.4) +FIG00857338 FIG00857340: hypothetical protein +FIG00857340 FIG00857342: hypothetical protein +FIG00857342 Protein of unknown function DUF107 +FIG00857344 FIG00857345: hypothetical protein +FIG00857345 FIG00857346: hypothetical protein +FIG00857354 WGR +FIG00857363 Protein of unknown function DUF336 +FIG00857369 FIG00857377: hypothetical protein +FIG00857377 FIG00857382: hypothetical protein +FIG00857382 FIG00857383: hypothetical protein +FIG00857386 FIG00857389: hypothetical protein +FIG00857393 FIG00857396: hypothetical protein +FIG00857397 subtilisin-like protease +FIG00857406 FIG00857407: hypothetical protein +FIG00857407 FIG00857417: hypothetical protein +FIG00857417 FIG00857420: hypothetical protein +FIG00857420 FIG00857421: hypothetical protein +FIG00857421 FIG00857425: hypothetical protein +FIG00857425 FIG00857434: hypothetical protein +FIG00857434 FIG00857440: hypothetical protein +FIG00857442 uncharacterized domain / RidA/YER057c/UK114 superfamily, group 5 +FIG00857449 FIG00857450: hypothetical protein +FIG00857450 FIG00857453: hypothetical protein +FIG00857453 FIG00857456: hypothetical protein +FIG00857456 FIG00857457: hypothetical protein +FIG00857462 FIG00857464: hypothetical protein +FIG00857464 FIG00857466: hypothetical protein +FIG00857467 FIG00857468: hypothetical protein +FIG00857468 FIG00857473: hypothetical protein +FIG00857473 FIG00857475: hypothetical protein +FIG00857486 FIG00857491: hypothetical protein +FIG00857491 FIG00857492: hypothetical protein +FIG00857493 FIG00857497: hypothetical protein +FIG00857501 FIG00857506: hypothetical protein +FIG00857506 FIG00857511: hypothetical protein +FIG00857511 FIG00857512: hypothetical protein +FIG00857512 FIG00857513: hypothetical protein +FIG00857514 FIG00857521: hypothetical protein +FIG00857521 FIG00857522: hypothetical protein +FIG00857526 Putative protein-S-isoprenylcysteine methyltransferase-like +FIG00857527 FIG00857528: hypothetical protein +FIG00857528 Uncharacterised conserved protein UCP033924 +FIG00857530 FIG00857538: hypothetical protein +FIG00857538 FIG00857539: hypothetical protein +FIG00857545 FIG00857546: hypothetical protein +FIG00857546 FIG00857549: hypothetical protein +FIG00857556 PAS sensor signal transduction histidine kinase +FIG00857562 FIG00857563: hypothetical protein +FIG00857563 FIG00857571: hypothetical protein +FIG00857571 FIG00857573: hypothetical protein +FIG00857573 FIG00857579: hypothetical protein +FIG00857585 FIG00857587: hypothetical protein +FIG00857588 FIG00857592: hypothetical protein +FIG00857592 FIG00857598: hypothetical protein +FIG00857598 FIG00857600: hypothetical protein +FIG00857606 FIG00857607: hypothetical protein +FIG00857607 FIG00857608: hypothetical protein +FIG00857610 Ferroxidase( EC:1.16.3.1 ) +FIG00857615 FIG00857619: hypothetical protein +FIG00857619 FIG00857620: hypothetical protein +FIG00857620 FIG00857623: hypothetical protein +FIG00857623 FIG00857624: hypothetical protein +FIG00857624 FIG00857625: hypothetical protein +FIG00857625 FIG00857635: hypothetical protein +FIG00857635 FIG00857637: hypothetical protein +FIG00857648 FIG00857650: hypothetical protein +FIG00857650 FIG00857653: hypothetical protein +FIG00857653 FIG00857656: hypothetical protein +FIG00857656 Toluene tolerance +FIG00857658 FIG00857661: hypothetical protein +FIG00857667 Invasion gene expression up-regulator, SirB +FIG00857669 FIG00857672: hypothetical protein +FIG00857685 FIG00857688: hypothetical protein +FIG00857688 FIG00857691: hypothetical protein +FIG00857691 FIG00857692: hypothetical protein +FIG00857692 Ring canal kelch-like protein +FIG00857711 FIG00857713: hypothetical protein +FIG00857713 FIG00857724: hypothetical protein +FIG00857724 FIG00857725: hypothetical protein +FIG00857727 FIG00857728: hypothetical protein +FIG00857730 FIG00857734: hypothetical protein +FIG00857734 FIG00857735: hypothetical protein +FIG00857736 FIG00857737: hypothetical protein +FIG00857737 FIG00857738: hypothetical protein +FIG00857750 FIG00857757: hypothetical protein +FIG00857757 FIG00857759: hypothetical protein +FIG00857759 FIG00857760: hypothetical protein +FIG00857760 FIG00857763: hypothetical protein +FIG00857763 micrococcal nuclease-like protein +FIG00857781 FIG00857782: hypothetical protein +FIG00857782 FIG00857784: hypothetical protein +FIG00857787 FIG00857790: hypothetical protein +FIG00857798 FIG00857799: hypothetical protein +FIG00857799 FIG00857800: hypothetical protein +FIG00857800 FIG00857801: hypothetical protein +FIG00857803 FIG00857807: hypothetical protein +FIG00857807 FIG00857813: hypothetical protein +FIG00857822 FIG00857829: hypothetical protein +FIG00857829 FIG00857831: hypothetical protein +FIG00857831 FIG00857835: hypothetical protein +FIG00857835 FIG00857836: hypothetical protein +FIG00857836 FIG00857837: hypothetical protein +FIG00857837 FIG00857839: hypothetical protein +FIG00857839 FIG00857843: hypothetical protein +FIG00857847 FIG00857849: hypothetical protein +FIG00857852 FIG00857853: hypothetical protein +FIG00857853 FIG00857856: hypothetical protein +FIG00857856 FIG00857857: hypothetical protein +FIG00857858 FIG00857859: hypothetical protein +FIG00857859 FIG00857861: hypothetical protein +FIG00857861 FIG00857863: hypothetical protein +FIG00857863 FIG00857871: hypothetical protein +FIG00857871 FIG00857872: hypothetical protein +FIG00857872 FIG00857874: hypothetical protein +FIG00857877 response regulator receiver modulated diguanylate cyclase/phosphodiesterase with PAS/PAC sensor(s) +FIG00857882 FIG00857885: hypothetical protein +FIG00857885 Sucrose phosphate synthase +FIG00857893 FIG00857896: hypothetical protein +FIG00857896 FIG00857897: hypothetical protein +FIG00857897 Addiction module antidote protein +FIG00857901 COG1548 family protein +FIG00857906 FIG00857908: hypothetical protein +FIG00857908 FIG00857912: hypothetical protein +FIG00857912 FIG00857915: hypothetical protein +FIG00857915 FIG00857919: hypothetical protein +FIG00857925 type IV pilus biogenesis protein PilF, putative +FIG00857937 FIG00857938: hypothetical protein +FIG00857938 FIG00857942: hypothetical protein +FIG00857942 FIG00857943: hypothetical protein +FIG00857944 FIG00857959: hypothetical protein +FIG00857959 FIG00857961: hypothetical protein +FIG00857971 FIG00857973: hypothetical protein +FIG00857983 FIG00857988: hypothetical protein +FIG00857997 FIG00858005: hypothetical protein +FIG00858005 FIG00858011: hypothetical protein +FIG00858011 FIG00858014: hypothetical protein +FIG00858024 FIG00858025: hypothetical protein +FIG00858027 FIG00858034: hypothetical protein +FIG00858036 FIG00858042: hypothetical protein +FIG00858046 FIG00858050: hypothetical protein +FIG00858050 FIG00858052: hypothetical protein +FIG00858052 FIG00858067: hypothetical protein +FIG00858067 FIG00858075: hypothetical protein +FIG00858075 FIG00858078: hypothetical protein +FIG00858078 FIG00858083: hypothetical protein +FIG00858083 FIG00858089: hypothetical protein +FIG00858089 FIG00858090: hypothetical protein +FIG00858090 FIG00858094: hypothetical protein +FIG00858094 FIG00858095: hypothetical protein +FIG00858095 FIG00858098: hypothetical protein +FIG00858098 FIG00858100: hypothetical protein +FIG00858100 FIG00858105: hypothetical protein +FIG00858105 FIG00858113: hypothetical protein +FIG00858118 FIG00858119: hypothetical protein +FIG00858119 FIG00858121: hypothetical protein +FIG00858121 FIG00858122: hypothetical protein +FIG00858122 FIG00858126: hypothetical protein +FIG00858126 FIG00858130: hypothetical protein +FIG00858130 FIG00858131: hypothetical protein +FIG00858131 FIG00858136: hypothetical protein +FIG00858136 Protein of unknown function DUF77 +FIG00858171 PpiC-type peptidyl-prolyl cis-trans isomerase( EC:5.2.1.8 ) +FIG00858185 FIG00858187: hypothetical protein +FIG00858196 FIG00858197: hypothetical protein +FIG00858197 FIG00858199: hypothetical protein +FIG00858199 COGs COG2929 +FIG00858200 FIG00858206: hypothetical protein +FIG00858206 FIG00858210: hypothetical protein +FIG00858210 FIG00858215: hypothetical protein +FIG00858217 FIG00858222: hypothetical protein +FIG00858222 FIG00858224: hypothetical protein +FIG00858238 FIG00858241: hypothetical protein +FIG00858248 FIG00858249: hypothetical protein +FIG00858255 FIG00858256: hypothetical protein +FIG00858256 FIG00858258: hypothetical protein +FIG00858270 FIG00858274: hypothetical protein +FIG00858276 N-carbamoylsarcosine amidase related protein-putative amidase +FIG00858277 FIG00858285: hypothetical protein +FIG00858316 FIG00858326: hypothetical protein +FIG00858333 FIG00858336: hypothetical protein +FIG00858336 FIG00858357: hypothetical protein +FIG00858357 FIG00858362: hypothetical protein +FIG00858362 FIG00858368: hypothetical protein +FIG00858371 FIG00858375: hypothetical protein +FIG00858411 HD domain +FIG00858417 FIG00858425: hypothetical protein +FIG00858426 FIG00858430: hypothetical protein +FIG00858430 FIG00858431: hypothetical protein +FIG00858434 FIG00858435: hypothetical protein +FIG00858441 FIG00858443: hypothetical protein +FIG00858445 FIG00858447: hypothetical protein +FIG00858452 FIG00858455: hypothetical protein +FIG00858455 FIG00858457: hypothetical protein +FIG00858478 FIG00858481: hypothetical protein +FIG00858488 FIG00858490: hypothetical protein +FIG00858491 FIG00858492: hypothetical protein +FIG00858502 FIG00858504: hypothetical protein +FIG00858504 FIG00858507: hypothetical protein +FIG00858507 FIG00858508: hypothetical protein +FIG00858508 FIG00858510: hypothetical protein +FIG00858512 FIG00858513: hypothetical protein +FIG00858514 InterPro IPR001822 COGs COG1961 +FIG00858517 FIG00858519: hypothetical protein +FIG00858519 FIG00858523: hypothetical protein +FIG00858524 FIG00858527: hypothetical protein +FIG00858543 uncharacterized conserved protein, ElaB family +FIG00858545 FIG00858546: hypothetical protein +FIG00858546 FIG00858548: hypothetical protein +FIG00858548 FIG00858549: hypothetical protein +FIG00858558 FIG00858562: hypothetical protein +FIG00858564 FIG00858567: hypothetical protein +FIG00858567 FIG00858571: hypothetical protein +FIG00858574 FIG00858575: hypothetical protein +FIG00858575 FIG00858578: hypothetical protein +FIG00858579 FIG00858580: hypothetical protein +FIG00858580 InterPro IPR001173 COGs COG0463 +FIG00858581 FIG00858582: hypothetical protein +FIG00858584 FIG00858586: hypothetical protein +FIG00858586 FIG00858587: hypothetical protein +FIG00858617 FIG00858624: hypothetical protein +FIG00858632 FIG00858634: hypothetical protein +FIG00858648 ParB-like nuclease domain +FIG00858650 putative integrase protein +FIG00858655 FIG00858658: hypothetical protein +FIG00858658 FIG00858660: hypothetical protein +FIG00858665 FIG00858667: hypothetical protein +FIG00858667 FIG00858668: hypothetical protein +FIG00858668 FIG00858669: hypothetical protein +FIG00858703 COGs COG3384 +FIG00858705 FIG00858706: hypothetical protein +FIG00858713 FIG00858714: hypothetical protein +FIG00858718 FIG00858721: hypothetical protein +FIG00858729 FIG00858730: hypothetical protein +FIG00858737 FIG00858740: hypothetical protein +FIG00858740 FIG00858746: hypothetical protein +FIG00858753 FIG00858754: hypothetical protein +FIG00858765 FIG00858769: hypothetical protein +FIG00858773 FIG00858774: hypothetical protein +FIG00858774 Mucin 2 precursor +FIG00858775 FIG00858776: hypothetical protein +FIG00858787 FIG00858788: hypothetical protein +FIG00858788 FIG00858790: hypothetical protein +FIG00858796 FIG00858797: hypothetical protein +FIG00858808 COGs COG1917 +FIG00858822 FIG00858826: hypothetical protein +FIG00858830 FIG00858834: hypothetical protein +FIG00858836 FIG00858837: hypothetical protein +FIG00858848 FIG00858849: hypothetical protein +FIG00858860 FIG00858867: hypothetical protein +FIG00858875 FIG00858878: hypothetical protein +FIG00858878 FIG00858881: hypothetical protein +FIG00858898 FIG00858905: hypothetical protein +FIG00858905 putative (AJ245540) NrfJ [Wolinella succinogenes] +FIG00858924 FIG00858925: hypothetical protein +FIG00858925 FIG00858928: hypothetical protein +FIG00858928 FIG00858931: hypothetical protein +FIG00858949 Cyclic nucleotide-binding domain:cAMP-dependent protein kinase +FIG00858963 FIG00858966: hypothetical protein +FIG00858966 Uncharacterized protein family UPF0016 +FIG00858970 FIG00858972: hypothetical protein +FIG00858983 FIG00858984: hypothetical protein +FIG00858994 FIG00858997: hypothetical protein +FIG00858997 FIG00858998: hypothetical protein +FIG00858998 FIG00858999: hypothetical protein +FIG00859000 FIG00859002: hypothetical protein +FIG00859004 putative cyclooxygenase-2 +FIG00859010 FIG00859011: hypothetical protein +FIG00859029 FIG00859034: hypothetical protein +FIG00859036 Molybdopterin biosynthesis protein MoeB +FIG00859037 FIG00859041: hypothetical protein +FIG00859041 InterPro IPR001789:IPR002078:IPR002197:IPR003593 COGs COG2204 +FIG00859045 FIG00859049: hypothetical protein +FIG00859050 FIG00859053: hypothetical protein +FIG00859053 possible spore protein [UI:20467420] +FIG00859056 FIG00859061: hypothetical protein +FIG00859061 FIG00859064: hypothetical protein +FIG00859064 InterPro IPR001687 COGs COG3073 +FIG00859069 FIG010505: hypothetical protein +FIG00859075 VapC toxin protein +FIG00859082 FIG00859085: hypothetical protein +FIG00859088 FIG00859089: hypothetical protein +FIG00859089 FIG00859091: hypothetical protein +FIG00859091 InterPro IPR001687 +FIG00859110 FIG00859115: hypothetical protein +FIG00859116 FIG00973888: hypothetical protein +FIG00859124 FIG00859125: hypothetical protein +FIG00859142 FIG00859169: hypothetical protein +FIG00859183 possible unsaturated glucuronyl hydrolase +FIG00859190 FIG01211007: hypothetical protein +FIG00859195 FIG00859197: hypothetical protein +FIG00859218 FIG00859219: hypothetical protein +FIG00859238 FIG00859241: hypothetical protein +FIG00859241 FIG00859242: hypothetical protein +FIG00859242 FIG00859246: hypothetical protein +FIG00859254 FIG00859257: hypothetical protein +FIG00859259 FIG00859262: hypothetical protein +FIG00859270 FIG00859274: hypothetical protein +FIG00859274 FIG00859276: hypothetical protein +FIG00859294 FIG00859295: hypothetical protein +FIG00859297 FIG00859298: hypothetical protein +FIG00859301 FIG00859304: hypothetical protein +FIG00859308 FIG00859309: hypothetical protein +FIG00859311 FIG00859317: hypothetical protein +FIG00859324 FIG00859331: hypothetical protein +FIG00859338 FIG00859340: hypothetical protein +FIG00859409 FIG00859415: hypothetical protein +FIG00859418 FIG00859419: hypothetical protein +FIG00859419 FIG00859424: hypothetical protein +FIG00859444 Universal stress protein (Usp) +FIG00859448 FIG00859458: hypothetical protein +FIG00859459 TraJ protein +FIG00859461 FIG00859469: hypothetical protein +FIG00859473 FIG00859475: hypothetical protein +FIG00859476 FIG00859479: hypothetical protein +FIG00859479 FIG00859483: hypothetical protein +FIG00859483 FIG00859485: hypothetical protein +FIG00859510 FIG00859511: hypothetical protein +FIG00859511 FIG00859512: hypothetical protein +FIG00859520 FIG00859523: hypothetical protein +FIG00859527 FIG00859528: hypothetical protein +FIG00859536 FIG00859545: hypothetical protein +FIG00859545 putative (U92432) ORF4 (Nitrosospira sp. NpAV) +FIG00859551 FIG00859557: hypothetical protein +FIG00859578 putative multidrug efflux membrane fusion protein +FIG00859586 FIG00859587: hypothetical protein +FIG00859602 putative ORF1 [Plasmid pTOM9] +FIG00859603 FIG00859610: hypothetical protein +FIG00859616 FIG00859622: hypothetical protein +FIG00859624 FIG00859627: hypothetical protein +FIG00859689 possible mcrC protein +FIG00859691 FIG00859706: hypothetical protein +FIG00859706 FIG00859708: hypothetical protein +FIG00859712 CRISPR-associated protein Csx16 +FIG00859728 COGs COG1595 +FIG00859749 InterPro IPR000531 COGs COG1629 +FIG00859776 FIG00859786: hypothetical protein +FIG00859786 FIG00859788: hypothetical protein +FIG00859788 FIG00859793: hypothetical protein +FIG00859795 FIG00859796: hypothetical protein +FIG00859799 FIG00859800: hypothetical protein +FIG00859802 FIG00859807: hypothetical protein +FIG00859832 COG3267: Type II secretory pathway, component ExeA (predicted ATPase) +FIG00859842 Possible glycosyltransferase +FIG00859914 FIG00859915: hypothetical protein +FIG00859923 Mov34 family +FIG00859929 Relaxase/mobilization nuclease domain +FIG00859965 FIG00859968: hypothetical protein +FIG00859985 FIG00859986: hypothetical protein +FIG00859999 FIG00860005: hypothetical protein +FIG00860043 InterPro IPR000838 COGs COG1595 +FIG00860065 FIG00860066: hypothetical protein +FIG00860128 Hopanoid-associated RND transporter, HpnN +FIG00860189 FIG00860192: hypothetical protein +FIG00860192 FIG00860194: hypothetical protein +FIG00860222 Capsule polysaccharide export ATP-binding protein ctrD (EC 3.6.3.38) +FIG00860276 FkbH domain +FIG00860298 FIG00860302: hypothetical protein +FIG00860323 Poly-gamma-glutamate synthesis protein +FIG00860414 Arachidonate 15-lipoxygenase (EC 1.13.11.33) +FIG00860552 FIG00860556: hypothetical protein +FIG00860626 FIG00860628: hypothetical protein +FIG00860776 FIG010505: hypothetical protein +FIG00860851 FIG00860852: hypothetical protein +FIG00860854 COG3321: Polyketide synthase modules and related proteins +FIG00860992 Probable DNA transport competence protein +FIG00861152 FIG00861154: hypothetical protein +FIG00861170 FIG00861173: hypothetical protein +FIG00861173 possible (AF047705) unknown [Nitrosococcus oceani] +FIG00861261 FIG00861263: hypothetical protein +FIG00861282 Putative Dyp-type peroxidase, associated with bacterial analog of Cox17 protein +FIG00861293 FIG00861294: hypothetical protein +FIG00861553 Putative secreted/membrane protein +FIG00861590 FIG00861591: hypothetical protein +FIG00861686 PROBABLE CONSERVED LIPOPROTEIN LPRD +FIG00861696 glycolate oxidase subunit +FIG00861709 putative secreted oxidoreductase +FIG00861720 FIG00861721: hypothetical protein +FIG00861775 FIG00861777: hypothetical protein +FIG00861888 Alanine-rich, phage-related, membrane protein +FIG00861900 FIG00861900: possible membrane protein +FIG00861911 fructose-bisphosphate aldolase family protein +FIG00861965 FIG00861972: hypothetical protein +FIG00861980 Succinyl-CoA synthetase, alpha subunit +FIG00862012 Short-chain dehydrogenase/reductase SDR:Glucose/ribitol dehydrogenase +FIG00862138 FIG00862139: hypothetical protein +FIG00862348 FIG00862349: hypothetical protein +FIG00862404 probable phenol hydrolase +FIG00862420 Possible secreted alanine rich protein +FIG00862434 Putative cyanamide hydratase +FIG00862463 FIG00862465: hypothetical protein +FIG00862489 LpqG +FIG00862579 putative cytidine/deoxycytidylate deaminase +FIG00862611 Cell division protein FtsL / proline rich membrane protein +FIG00862715 FIG00862716: hypothetical protein +FIG00862767 Putative nitroreductase +FIG00862887 FIG00862889: hypothetical protein +FIG00862992 Substrate-binding region of ABC-type glycine betaine transport system +FIG00863062 FIG00863064: hypothetical protein +FIG00863066 FIG00995007: hypothetical protein +FIG00863116 FIG00863121: hypothetical protein +FIG00863150 LpqB +FIG00863286 C-5 cytosine-specific DNA methylase family protein +FIG00863306 ABC transporter system integral membrane protein +FIG00863496 secreted tripeptidylaminopeptidase +FIG00863638 FIG00863644: hypothetical protein +FIG00863727 Secreted protease +FIG00863733 B2126_C3_228 +FIG00863776 Carnitine O-palmitoyltransferase I, mitochondrial muscle isoform (EC 2.3.1.21) +FIG00863777 probable myosin +FIG00863837 FIG00863843: hypothetical protein +FIG00863906 FIG00863909: hypothetical protein +FIG00864003 FIG00864007: hypothetical protein +FIG00864011 putative phage tail +FIG00864191 desaturase-related protein +FIG00864239 Possible lipoprotein LprQ +FIG00864268 FIG00864270: hypothetical protein +FIG00864274 FIG00864278: hypothetical protein +FIG00864285 FIG00864286: hypothetical protein +FIG00864343 FIG01126937: hypothetical protein +FIG00864344 FIG00864345: hypothetical protein +FIG00864356 Iron(III) ABC transporter, periplasmic-binding protein +FIG00864412 FIG00864414: hypothetical protein +FIG00864422 Mannan endo-1,4-beta-mannosidase (EC 3.2.1.78) (Endo-(1,4)-beta-mannanase) +FIG00864515 FIG00864516: hypothetical protein +FIG00864532 FIG00864534: hypothetical protein +FIG00864535 FIG00864536: hypothetical protein +FIG00864537 FIG00864538: hypothetical protein +FIG00864624 Clp N terminal domain protein +FIG00864631 FIG00864634: hypothetical protein +FIG00864634 FIG00734456: hypothetical protein +FIG00864726 FIG00864727: hypothetical protein +FIG00864771 DNA-binding response regulator (narL) +FIG00864796 Probable ABC transporter permease protein PH1215 +FIG00864816 dnaA domain protein +FIG00864829 FIG00864832: hypothetical protein +FIG00864860 dolichol-P-glucose synthetase homolog +FIG00864872 FIG00864875: hypothetical protein +FIG00864915 Sigma factor, sigma 70 type, group 4 +FIG00865060 putative S-layer domain protein +FIG00865094 FIG00865095: hypothetical protein +FIG00865102 2,4-dienoyl-CoA reductase (EC 1.3.1.34) +FIG00865216 DNA for SgaA, complete cds +FIG00865346 FIG00865350: hypothetical protein +FIG00865492 3-ketosteroid dehydrogenase +FIG00865672 FIG00865674: hypothetical protein +FIG00865708 FIG00865710: hypothetical protein +FIG00865786 Peptidase M29, aminopeptidase II +FIG00865880 FIG00865881: hypothetical protein +FIG00865940 FIG00865945: hypothetical protein +FIG00865964 FIG00865966: hypothetical protein +FIG00865985 Alkylmercury lyase (EC 4.99.1.2) +FIG00866061 Zn-dependent dipeptidase, microsomal dipeptidase homolog +FIG00866073 FIG00866074: hypothetical protein +FIG00866108 Possible phosphotransferase +FIG00866126 3-hydroxyacyl-CoA dehydrogenase PaaC +FIG00866201 FIG00866204: hypothetical protein +FIG00866209 Sphingolipid ceramide N-deacylase +FIG00866251 FIG00866252: hypothetical protein +FIG00866397 FIG00866410: hypothetical protein +FIG00866426 FIG00866427: hypothetical protein +FIG00866427 FIG00866431: hypothetical protein +FIG00866431 StrR protein +FIG00866440 FIG00866443: hypothetical protein +FIG00866443 FIG00866456: hypothetical protein +FIG00866456 FIG00866458: hypothetical protein +FIG00866459 similar to Zn-dependent hydrolase including glyoxylases +FIG00866490 histidine kinase, dimerisation and phosphoacceptor region +FIG00866537 FIG00866543: hypothetical protein +FIG00866562 putative manganese-containing catalase +FIG00866574 FIG00866579: hypothetical protein +FIG00866579 FIG00866581: hypothetical protein +FIG00866581 FIG00866590: hypothetical protein +FIG00866590 FIG00866592: hypothetical protein +FIG00866602 FIG00866605: hypothetical protein +FIG00866605 FIG00866610: hypothetical protein +FIG00866610 FIG00866611: hypothetical protein +FIG00866611 FIG00866613: hypothetical protein +FIG00866648 FIG00866649: hypothetical protein +FIG00866649 putative cytochrome P450 +FIG00866668 FIG00866671: hypothetical protein +FIG00866671 FIG00866675: hypothetical protein +FIG00866675 transcription elongation factor GreA +FIG00866701 FIG00866705: hypothetical protein +FIG00866730 3-oxoacyl-ACP synthase III +FIG00866731 FIG00866732: hypothetical protein +FIG00866732 FIG00866748: hypothetical protein +FIG00866750 FIG00866767: hypothetical protein +FIG00866767 FIG00866783: hypothetical protein +FIG00866783 FIG00866791: hypothetical protein +FIG00866791 FIG00866799: hypothetical protein +FIG00866800 FIG00866807: hypothetical protein +FIG00866807 FIG00866814: hypothetical protein +FIG00866815 FIG00866822: hypothetical protein +FIG00866823 FIG00866827: hypothetical protein +FIG00866837 FIG00866845: hypothetical protein +FIG00866845 FIG00866846: hypothetical protein +FIG00866846 carbonic anhydrase/acetyltransferase isoleucine patch superfamily-like protein +FIG00866856 Secreted protein precursor +FIG00866867 Homoserine dehydrogenase, NAD-binding +FIG00866885 FIG00866894: hypothetical protein +FIG00866894 FIG00866895: hypothetical protein +FIG00866895 FIG00866901: hypothetical protein +FIG00866903 FIG00866915: hypothetical protein +FIG00866915 FIG00866920: hypothetical protein +FIG00866924 FIG00866927: hypothetical protein +FIG00866927 FIG00866928: hypothetical protein +FIG00866928 FIG00866930: hypothetical protein +FIG00866930 FIG00866934: hypothetical protein +FIG00866934 CAAX amino terminal protease family, putative +FIG00866943 FIG00866950: hypothetical protein +FIG00866950 FIG00866952: hypothetical protein +FIG00867010 FIG00867016: hypothetical protein +FIG00867031 FIG00867035: hypothetical protein +FIG00867035 FIG00867036: hypothetical protein +FIG00867036 FIG00867037: hypothetical protein +FIG00867049 FIG00867052: hypothetical protein +FIG00867052 FIG00867056: hypothetical protein +FIG00867056 FIG00867057: hypothetical protein +FIG00867057 FIG00867064: hypothetical protein +FIG00867064 FIG00867069: hypothetical protein +FIG00867082 FIG00867092: hypothetical protein +FIG00867099 FIG00867105: hypothetical protein +FIG00867105 FIG00867107: hypothetical protein +FIG00867122 FIG00867134: hypothetical protein +FIG00867149 FIG00867151: hypothetical protein +FIG00867151 FIG00867160: hypothetical protein +FIG00867171 FIG00867185: hypothetical protein +FIG00867195 cystathionine gamma-lyase +FIG00867206 FIG00867216: hypothetical protein +FIG00867218 FIG00867242: hypothetical protein +FIG00867263 FIG00867267: hypothetical protein +FIG00867287 Protein of unknown function (DUF742) +FIG00867297 Alpha-L-arabinofuranosidase precursor +FIG00867299 FIG00867304: hypothetical protein +FIG00867316 FIG00867319: hypothetical protein +FIG00867326 FIG00867328: hypothetical protein +FIG00867328 FIG00867330: hypothetical protein +FIG00867332 FIG00867336: hypothetical protein +FIG00867336 FIG00867339: hypothetical protein +FIG00867339 calcium-binding protein +FIG00867351 FIG00867355: hypothetical protein +FIG00867355 FIG00867359: hypothetical protein +FIG00867359 FIG00867360: hypothetical protein +FIG00867376 FIG00867380: hypothetical protein +FIG00867383 FIG00867388: hypothetical protein +FIG00867389 similar to Uncharacterized membrane protein +FIG00867405 sugar-binding lipoprotein +FIG00867419 FIG00867420: hypothetical protein +FIG00867420 similar to FKBP-type peptidyl-prolyl cis-trans isomerase 1 +FIG00867421 FIG00867430: hypothetical protein +FIG00867430 FIG00867440: hypothetical protein +FIG00867440 FIG00867447: hypothetical protein +FIG00867447 FIG00867449: hypothetical protein +FIG00867449 COG2610: H+/gluconate symporter and related permeases +FIG00867456 FIG00867460: hypothetical protein +FIG00867460 Bona fide RidA/YjgF/TdcF/RutC subgroup +FIG00867462 ABC-type cobalamin/Fe3+-siderophores transport systems ATPase components +FIG00867473 FIG00867489: hypothetical protein +FIG00867489 putative mutT-like protein +FIG00867496 FIG00867499: hypothetical protein +FIG00867513 FIG00867514: hypothetical protein +FIG00867517 FIG00867520: hypothetical protein +FIG00867523 FIG00867533: hypothetical protein +FIG00867533 FIG00867539: hypothetical protein +FIG00867539 possible amidohydrolase +FIG00867541 FIG00867544: hypothetical protein +FIG00867544 FIG00867546: hypothetical protein +FIG00867549 FIG00867550: hypothetical protein +FIG00867550 Chalcone and stilbene synthases-like +FIG00867557 FIG00867565: hypothetical protein +FIG00867565 FIG00867566: hypothetical protein +FIG00867566 carboxylesterase, type B +FIG00867600 FIG00867605: hypothetical protein +FIG00867613 FIG00867616: hypothetical protein +FIG00867616 FIG00867619: hypothetical protein +FIG00867619 4-carboxymuconolactone decarboxylase +FIG00867621 FIG00867630: hypothetical protein +FIG00867630 FIG00867654: hypothetical protein +FIG00867654 putaive isomerase +FIG00867664 FIG00867670: hypothetical protein +FIG00867670 FIG00867674: hypothetical protein +FIG00867692 FIG00867694: hypothetical protein +FIG00867694 FIG00867698: hypothetical protein +FIG00867698 FIG00867700: hypothetical protein +FIG00867719 FIG00867731: hypothetical protein +FIG00867736 blr3675; putative alcohol dehydrogenase (EC 1.1.1.1) +FIG00867743 putative secreted esterase/lipase/thioesterase family protein +FIG00867747 FIG00867750: hypothetical protein +FIG00867750 FIG00867754: hypothetical protein +FIG00867754 FIG00867755: hypothetical protein +FIG00867760 FIG00867777: hypothetical protein +FIG00867777 sugar ABC transporter, sugar-binding protein +FIG00867799 FIG00867804: hypothetical protein +FIG00867804 FIG00867807: hypothetical protein +FIG00867807 FIG00867808: hypothetical protein +FIG00867815 FIG00867823: hypothetical protein +FIG00867826 FIG00867827: hypothetical protein +FIG00867838 FIG00867841: hypothetical protein +FIG00867842 FIG00867850: hypothetical protein +FIG00867862 probable ABC transporter, ATP-binding component +FIG00867877 FIG00867879: hypothetical protein +FIG00867909 FIG00867912: hypothetical protein +FIG00867912 FIG00867914: hypothetical protein +FIG00867914 FIG00867930: hypothetical protein +FIG00867930 NAD-dependent formate dehydrogenase gamma subunit +FIG00867932 FIG00867934: hypothetical protein +FIG00867942 FIG00867945: hypothetical protein +FIG00867957 FIG00867958: hypothetical protein +FIG00867958 FIG00867969: hypothetical protein +FIG00867969 FIG00867972: hypothetical protein +FIG00867977 FIG00867978: hypothetical protein +FIG00867978 FIG00868005: hypothetical protein +FIG00868005 FIG00868009: hypothetical protein +FIG00868009 FIG00868011: hypothetical protein +FIG00868011 FIG00868013: hypothetical protein +FIG00868013 Ava_C0101 and related proteins +FIG00868015 FIG00868025: hypothetical protein +FIG00868029 FIG00868031: hypothetical protein +FIG00868045 FIG00868048: hypothetical protein +FIG00868053 putative carboxylesterase/lipase( EC:3.1.1.- ) +FIG00868055 FIG00868060: hypothetical protein +FIG00868060 FIG00868067: hypothetical protein +FIG00868073 FIG00868080: hypothetical protein +FIG00868080 FIG00868083: hypothetical protein +FIG00868083 FIG00868086: hypothetical protein +FIG00868089 FIG00868091: hypothetical protein +FIG00868091 FIG00868095: hypothetical protein +FIG00868121 FIG00868132: hypothetical protein +FIG00868132 bacterial regulatory protein, MarR family protein +FIG00868137 FIG00868138: hypothetical protein +FIG00868138 FIG00868140: hypothetical protein +FIG00868140 Molybdenum cofactor biosynthesis protein MoaD +FIG00868144 FIG00868155: hypothetical protein +FIG00868175 FIG00868177: hypothetical protein +FIG00868209 FIG00868213: hypothetical protein +FIG00868219 FIG00868227: hypothetical protein +FIG00868237 FIG00868242: hypothetical protein +FIG00868243 FIG00868254: hypothetical protein +FIG00868259 FIG00868264: hypothetical protein +FIG00868284 FIG004853: possible toxin to DivIC +FIG00868303 FIG00868305: hypothetical protein +FIG00868314 type I modular polyketide synthase +FIG00868319 FIG00868326: hypothetical protein +FIG00868326 FIG00868332: hypothetical protein +FIG00868332 HTH-type transcriptional regulator celR +FIG00868343 Sensor histidine kinase MtrB (EC 2.7.3.-) +FIG00868348 FIG00868353: hypothetical protein +FIG00868353 FIG00868366: hypothetical protein +FIG00868366 FIG00868377: hypothetical protein +FIG00868377 Mov34/MPN/PAD-1 family protein +FIG00868393 FIG00868396: hypothetical protein +FIG00868396 FIG00868398: hypothetical protein +FIG00868399 FIG00868407: hypothetical protein +FIG00868407 FIG00868408: hypothetical protein +FIG00868408 FIG00868418: hypothetical protein +FIG00868418 FIG00868427: hypothetical protein +FIG00868427 FIG00868433: hypothetical protein +FIG00868433 FIG00868444: hypothetical protein +FIG00868445 FIG00868452: hypothetical protein +FIG00868452 FIG00868453: hypothetical protein +FIG00868453 FIG00868460: hypothetical protein +FIG00868464 ABC-type Fe3+-siderophore transport system, permease component +FIG00868485 FIG00868492: hypothetical protein +FIG00868499 FIG00868500: hypothetical protein +FIG00868500 FIG00868502: hypothetical protein +FIG00868503 FIG00868505: hypothetical protein +FIG00868551 FIG00868552: hypothetical protein +FIG00868552 FIG00868553: hypothetical protein +FIG00868563 FIG00868571: hypothetical protein +FIG00868571 putative two-component system sensor kinase +FIG00868573 FIG00868581: hypothetical protein +FIG00868581 FIG00868588: hypothetical protein +FIG00868588 FIG00868594: hypothetical protein +FIG00868609 FIG00868616: hypothetical protein +FIG00868616 Aspartate aminotransferase (AspB-4) (EC 2.6.1.1) +FIG00868626 FIG00868640: hypothetical protein +FIG00868644 FIG00868645: hypothetical protein +FIG00868654 FIG00868660: hypothetical protein +FIG00868660 FIG00868662: hypothetical protein +FIG00868667 FIG00868671: hypothetical protein +FIG00868671 FIG00868673: hypothetical protein +FIG00868676 FIG00868682: hypothetical protein +FIG00868691 FIG00868697: hypothetical protein +FIG00868697 FIG00868698: hypothetical protein +FIG00868705 FIG00868715: hypothetical protein +FIG00868718 monooxygenase, putative +FIG00868722 FIG00868727: hypothetical protein +FIG00868727 FIG00868729: hypothetical protein +FIG00868758 FIG00868764: hypothetical protein +FIG00868764 FIG00868767: hypothetical protein +FIG00868767 hypothetical protein; Putative integral membrane protein (partial) +FIG00868777 antibiotic biosynthesis monooxygenase +FIG00868779 FIG00868784: hypothetical protein +FIG00868784 FIG00868786: hypothetical protein +FIG00868808 FIG00868816: hypothetical protein +FIG00868820 FIG00868823: hypothetical protein +FIG00868823 FIG00868826: hypothetical protein +FIG00868832 FIG00868835: hypothetical protein +FIG00868835 FIG00868838: hypothetical protein +FIG00868838 FIG00868839: hypothetical protein +FIG00868844 FIG00868845: hypothetical protein +FIG00868847 FIG00868848: hypothetical protein +FIG00868856 FIG00868860: hypothetical protein +FIG00868860 FIG00868883: hypothetical protein +FIG00868885 FIG00868888: hypothetical protein +FIG00868888 citryl-CoA lyase( EC:4.1.3.34 ) +FIG00868890 conserved hypothetical Na(+)/H(+) antiporter +FIG00868926 FIG00868928: hypothetical protein +FIG00868931 FIG00868934: hypothetical protein +FIG00868945 FIG00868952: hypothetical protein +FIG00868952 FIG00868958: hypothetical protein +FIG00868962 FIG00868965: hypothetical protein +FIG00868965 putative aminoglycoside phosphotransferase +FIG00868967 FIG00868978: hypothetical protein +FIG00868979 FIG00868982: hypothetical protein +FIG00868982 Putative nucleoside-diphosphate-sugar epimerase +FIG00868984 FIG00868986: hypothetical protein +FIG00868986 FIG00868997: hypothetical protein +FIG00868997 FIG00869002: hypothetical protein +FIG00869002 FIG00869006: hypothetical protein +FIG00869010 FIG00869035: hypothetical protein +FIG00869042 FIG00869052: hypothetical protein +FIG00869052 FIG00869056: hypothetical protein +FIG00869056 FIG00869058: hypothetical protein +FIG00869058 FIG00869064: hypothetical protein +FIG00869064 FIG00869073: hypothetical protein +FIG00869073 FIG00869078: hypothetical protein +FIG00869078 FIG00869082: hypothetical protein +FIG00869082 FIG00869084: hypothetical protein +FIG00869084 Tyrosine protein kinase:Serine/threonine protein kinase +FIG00869087 Homolog of eukaryotic DNA ligase III +FIG00869091 FIG00869092: hypothetical protein +FIG00869100 FIG00869104: hypothetical protein +FIG00869114 FIG00869115: hypothetical protein +FIG00869119 FIG00869120: hypothetical protein +FIG00869120 FIG00869123: hypothetical protein +FIG00869129 Mandelate racemase/muconate lactonizing enzyme-like +FIG00869165 integral-membrane protein +FIG00869174 FIG00869175: hypothetical protein +FIG00869175 FIG00869181: hypothetical protein +FIG00869181 FIG00869184: hypothetical protein +FIG00869230 putative atp/gtp-binding protein +FIG00869238 FIG00869243: hypothetical protein +FIG00869252 FIG00869253: hypothetical protein +FIG00869253 FIG00869255: hypothetical protein +FIG00869255 FIG00869257: hypothetical protein +FIG00869262 FIG00869266: hypothetical protein +FIG00869272 FIG00869273: hypothetical protein +FIG00869273 FIG00869275: hypothetical protein +FIG00869275 FIG00869276: hypothetical protein +FIG00869276 FIG00869280: hypothetical protein +FIG00869281 FIG00869292: hypothetical protein +FIG00869293 FIG00869294: hypothetical protein +FIG00869294 FIG00869299: hypothetical protein +FIG00869299 similar to Methylase involved in ubiquinone/menaquinone biosynthesis +FIG00869305 FIG00869310: hypothetical protein +FIG00869312 FIG00869323: hypothetical protein +FIG00869323 COG0614: ABC-type Fe3+-hydroxamate transport system, periplasmic component +FIG00869325 FIG00869326: hypothetical protein +FIG00869326 FIG00869330: hypothetical protein +FIG00869347 FIG00869354: hypothetical protein +FIG00869354 FIG00869359: hypothetical protein +FIG00869360 FIG00869369: hypothetical protein +FIG00869369 FIG00869374: hypothetical protein +FIG00869374 FIG00869377: hypothetical protein +FIG00869377 FIG00869381: hypothetical protein +FIG00869383 FIG00869388: hypothetical protein +FIG00869388 FIG00869401: hypothetical protein +FIG00869401 FIG00869404: hypothetical protein +FIG00869404 transcriptional regulator, TetR family protein +FIG00869421 FIG00869422: hypothetical protein +FIG00869454 FIG00869460: hypothetical protein +FIG00869460 FIG00869461: hypothetical protein +FIG00869461 FIG00869473: hypothetical protein +FIG00869473 FIG00869474: hypothetical protein +FIG00869478 FIG00869486: hypothetical protein +FIG00869486 FIG00869497: hypothetical protein +FIG00869502 FIG00869504: hypothetical protein +FIG00869504 FIG00869507: hypothetical protein +FIG00869507 FIG00869515: hypothetical protein +FIG00869515 FIG00869525: hypothetical protein +FIG00869536 FIG00869542: hypothetical protein +FIG00869542 FIG00869560: hypothetical protein +FIG00869560 FIG00869567: hypothetical protein +FIG00869568 FIG00869569: hypothetical protein +FIG00869576 FIG00869582: hypothetical protein +FIG00869582 FIG00869583: hypothetical protein +FIG00869583 FIG00869589: hypothetical protein +FIG00869589 FIG00869597: hypothetical protein +FIG00869604 FIG00869613: hypothetical protein +FIG00869613 FIG00869618: hypothetical protein +FIG00869618 FIG00869624: hypothetical protein +FIG00869624 Ribosomal large subunit pseudouridine synthase B (EC 4.2.1.70) +FIG00869629 FIG00869632: hypothetical protein +FIG00869632 FIG00869646: hypothetical protein +FIG00869659 FIG00869661: hypothetical protein +FIG00869661 FIG00869663: hypothetical protein +FIG00869705 FIG00869716: hypothetical protein +FIG00869716 FIG00869723: hypothetical protein +FIG00869732 AraC-like transcriptional regulator +FIG00869739 FIG00869743: hypothetical protein +FIG00869743 FIG00869745: hypothetical protein +FIG00869746 FIG00869756: hypothetical protein +FIG00869761 FIG00869763: hypothetical protein +FIG00869763 FIG00869770: hypothetical protein +FIG00869770 FIG00869773: hypothetical protein +FIG00869782 FIG00869792: hypothetical protein +FIG00869814 FIG00869826: hypothetical protein +FIG00869826 FIG00869835: hypothetical protein +FIG00869835 FIG00869840: hypothetical protein +FIG00869849 FIG00869878: hypothetical protein +FIG00869878 FIG00869879: hypothetical protein +FIG00869879 FIG00869884: hypothetical protein +FIG00869913 FIG00869932: hypothetical protein +FIG00869933 FIG00869940: hypothetical protein +FIG00869943 predicted membrane protein/domain +FIG00869948 FIG00869952: hypothetical protein +FIG00869952 RRNA methyltransferase AviRa +FIG00869957 FIG00869963: hypothetical protein +FIG00869963 FIG00869964: hypothetical protein +FIG00869964 FIG00869967: hypothetical protein +FIG00869967 FIG00869975: hypothetical protein +FIG00869975 FIG00869976: hypothetical protein +FIG00869976 FIG00869988: hypothetical protein +FIG00869988 FIG00869993: hypothetical protein +FIG00869993 FIG00869995: hypothetical protein +FIG00870005 FIG00870006: hypothetical protein +FIG00870006 FIG00870009: hypothetical protein +FIG00870009 FIG00870015: hypothetical protein +FIG00870015 FIG00870016: hypothetical protein +FIG00870016 FIG00870036: hypothetical protein +FIG00870042 FIG00870046: hypothetical protein +FIG00870064 FIG00870068: hypothetical protein +FIG00870072 FIG00870076: hypothetical protein +FIG00870076 Glutathione-dependent formaldehyde dehydrogenase +FIG00870150 FIG00870152: hypothetical protein +FIG00870152 FIG00870153: hypothetical protein +FIG00870153 FIG00870159: hypothetical protein +FIG00870159 FIG00870175: hypothetical protein +FIG00870175 FIG00870179: hypothetical protein +FIG00870193 FIG00870204: hypothetical protein +FIG00870205 FIG00870223: hypothetical protein +FIG00870224 FIG00870226: hypothetical protein +FIG00870254 FIG00870257: hypothetical protein +FIG00870278 FIG00870284: hypothetical protein +FIG00870291 Probable oxidoreductase +FIG00870292 FIG00870294: hypothetical protein +FIG00870298 FIG00870303: hypothetical protein +FIG00870313 FIG00870315: hypothetical protein +FIG00870316 FIG00870318: hypothetical protein +FIG00870322 FIG00870323: hypothetical protein +FIG00870323 FIG00870325: hypothetical protein +FIG00870325 FIG00870326: hypothetical protein +FIG00870338 FIG00870344: hypothetical protein +FIG00870345 membrane-spanning protein +FIG00870366 FIG00870368: hypothetical protein +FIG00870373 ORF_ID:alr2840 +FIG00870410 FIG00870412: hypothetical protein +FIG00870420 FIG00870422: hypothetical protein +FIG00870435 FIG00870441: hypothetical protein +FIG00870441 FIG00870443: hypothetical protein +FIG00870452 Protein serine/threonine phosphatases (EC 3.1.3.16) +FIG00870464 FIG00870466: hypothetical protein +FIG00870473 FIG00870478: hypothetical protein +FIG00870484 FIG00870485: hypothetical protein +FIG00870486 FIG00870488: hypothetical protein +FIG00870488 FIG00870489: hypothetical protein +FIG00870494 FIG00870496: hypothetical protein +FIG00870496 FIG00870497: hypothetical protein +FIG00870497 FIG00870498: hypothetical protein +FIG00870502 FIG00870510: hypothetical protein +FIG00870516 Chemotaxis motB protein +FIG00870520 FIG00870521: hypothetical protein +FIG00870523 FIG00870531: hypothetical protein +FIG00870542 FIG00870545: hypothetical protein +FIG00870548 FIG00870551: hypothetical protein +FIG00870551 FIG00870556: hypothetical protein +FIG00870556 FIG00870559: hypothetical protein +FIG00870560 FIG00870566: hypothetical protein +FIG00870575 Cell division protein FtsI/penicillin-binding protein 2 +FIG00870578 FIG00870579: hypothetical protein +FIG00870579 FIG00870587: hypothetical protein +FIG00870587 FIG00870592: hypothetical protein +FIG00870602 Modification methylase AvaI (EC 2.1.1.113) +FIG00870613 FIG00870614: hypothetical protein +FIG00870614 LysR-family transcriptional regulator PtxE, associated with phosphonate utilization +FIG00870618 FIG00870620: hypothetical protein +FIG00870620 FIG00870625: hypothetical protein +FIG00870628 FIG00870636: hypothetical protein +FIG00870640 FIG00870641: hypothetical protein +FIG00870641 FIG00870642: hypothetical protein +FIG00870645 FIG00870646: hypothetical protein +FIG00870648 FIG00870650: hypothetical protein +FIG00870650 FIG00870654: hypothetical protein +FIG00870674 FIG00870681: hypothetical protein +FIG00870690 FIG00870693: hypothetical protein +FIG00870693 FIG00870694: hypothetical protein +FIG00870694 FIG00870696: hypothetical protein +FIG00870696 FIG00870700: hypothetical protein +FIG00870704 FIG00870711: hypothetical protein +FIG00870717 FIG00870718: hypothetical protein +FIG00870720 FIG00870723: hypothetical protein +FIG00870725 FIG00870729: hypothetical protein +FIG00870732 FIG00870734: hypothetical protein +FIG00870753 FIG00870757: hypothetical protein +FIG00870762 NADH dehydrogenase subunit NdhL (EC 1.6.5.3) +FIG00870808 FIG00870810: hypothetical protein +FIG00870812 FIG00870814: hypothetical protein +FIG00870815 FIG00870817: hypothetical protein +FIG00870855 Glutathione synthase/Ribosomal protein S6 modification enzyme (glutaminyl transferase) +FIG00870859 FIG00870861: hypothetical protein +FIG00870862 FIG00870864: hypothetical protein +FIG00870872 Enolase +FIG00870885 COG1511: Predicted membrane protein +FIG00870893 FIG00870903: hypothetical protein +FIG00870903 FIG00870904: hypothetical protein +FIG00870912 FIG00870917: hypothetical protein +FIG00870917 FIG00870918: hypothetical protein +FIG00870927 FIG00870929: hypothetical protein +FIG00870929 FIG00870937: hypothetical protein +FIG00870940 heat shock protein, class I +FIG00870948 MFS general substrate transporter +FIG00870950 FIG00870953: hypothetical protein +FIG00870957 FIG00870958: hypothetical protein +FIG00870958 FIG00870962: hypothetical protein +FIG00871010 FIG00871012: hypothetical protein +FIG00871012 FIG00871020: hypothetical protein +FIG00871023 FIG00871025: hypothetical protein +FIG00871036 FIG00871039: hypothetical protein +FIG00871051 FIG00871052: hypothetical protein +FIG00871054 FIG00871059: hypothetical protein +FIG00871059 FIG00871064: hypothetical protein +FIG00871064 Cleavage and polyadenylation specificity factor, 73 kDa subunit +FIG00871068 FIG00871069: hypothetical protein +FIG00871074 FIG00871075: hypothetical protein +FIG00871077 FIG00871079: hypothetical protein +FIG00871079 FIG00871081: hypothetical protein +FIG00871081 FIG00871087: hypothetical protein +FIG00871107 SpoIID protein homolog +FIG00871122 FIG00871123: hypothetical protein +FIG00871123 FIG00871128: hypothetical protein +FIG00871130 FIG00871132: hypothetical protein +FIG00871132 FIG00871134: hypothetical protein +FIG00871174 FIG00871175: hypothetical protein +FIG00871175 FIG00871177: hypothetical protein +FIG00871179 FIG00871181: hypothetical protein +FIG00871191 FIG00871193: hypothetical protein +FIG00871198 FIG00871199: hypothetical protein +FIG00871199 FIG00871203: hypothetical protein +FIG00871203 FIG00871204: hypothetical protein +FIG00871204 COG0627: Predicted esterase +FIG00871210 FIG00871212: hypothetical protein +FIG00871214 FIG00871218: hypothetical protein +FIG00871218 FIG00871219: hypothetical protein +FIG00871220 FIG00871221: hypothetical protein +FIG00871221 FIG00871222: hypothetical protein +FIG00871222 FIG00871224: hypothetical protein +FIG00871224 reverse transcriptase homolog +FIG00871232 FIG00871236: hypothetical protein +FIG00871238 FIG00871239: hypothetical protein +FIG00871244 FIG00871248: hypothetical protein +FIG00871267 FIG00871268: hypothetical protein +FIG00871268 FIG00871273: hypothetical protein +FIG00871275 FIG00871277: hypothetical protein +FIG00871290 FIG00871294: hypothetical protein +FIG00871312 FIG00871323: hypothetical protein +FIG00871331 FIG00871332: hypothetical protein +FIG00871350 FIG00871359: hypothetical protein +FIG00871366 FIG00871370: hypothetical protein +FIG00871381 FIG00871383: hypothetical protein +FIG00871384 FIG00871385: hypothetical protein +FIG00871390 FIG00871393: hypothetical protein +FIG00871393 FIG00871394: hypothetical protein +FIG00871394 FIG00871397: hypothetical protein +FIG00871400 FIG00871402: hypothetical protein +FIG00871413 FIG00871415: hypothetical protein +FIG00871427 FIG00871428: hypothetical protein +FIG00871432 FIG00871434: hypothetical protein +FIG00871434 FIG00871435: hypothetical protein +FIG00871436 plasmid recombinant protein +FIG00871440 FIG00871449: hypothetical protein +FIG00871449 glutamate--cysteine ligase, putative +FIG00871473 FIG00871474: hypothetical protein +FIG00871479 FIG00871483: hypothetical protein +FIG00871483 FIG00871485: hypothetical protein +FIG00871487 FIG00871488: hypothetical protein +FIG00871488 FIG00871497: hypothetical protein +FIG00871518 FIG00871525: hypothetical protein +FIG00871525 FIG00871526: hypothetical protein +FIG00871536 FIG00871540: hypothetical protein +FIG00871559 FIG00871566: hypothetical protein +FIG00871604 FIG00871607: hypothetical protein +FIG00871615 FIG00871617: hypothetical protein +FIG00871625 Alr2834 protein +FIG00871630 FIG00871631: hypothetical protein +FIG00871631 FIG00871635: hypothetical protein +FIG00871642 FIG00871643: hypothetical protein +FIG00871643 FIG00871645: hypothetical protein +FIG00871669 FIG00871670: hypothetical protein +FIG00871671 Lipid A core O-antigen ligase related Slr0728 +FIG00871673 FIG00871675: hypothetical protein +FIG00871675 Hydrophobic protein (Fragment) +FIG00871706 ORF_ID:all8037 unknown protein +FIG00871716 FIG00871718: hypothetical protein +FIG00871719 FIG00871720: hypothetical protein +FIG00871730 FIG00871735: hypothetical protein +FIG00871746 FIG00871747: hypothetical protein +FIG00871747 FIG00871750: hypothetical protein +FIG00871753 FIG00871756: hypothetical protein +FIG00871765 gas vesicle protein +FIG00871783 Oligopeptide ABC transporter, periplasmic substrate-binding component +FIG00871790 FIG00871791: hypothetical protein +FIG00871793 Mlr3248 protein +FIG00871816 FIG00871817: hypothetical protein +FIG00871826 FIG00871829: hypothetical protein +FIG00871830 FIG00871832: hypothetical protein +FIG00871832 Zn-dependent protease slr1971 +FIG00871839 FIG00871840: hypothetical protein +FIG00871844 FIG00871849: hypothetical protein +FIG00871854 nutrient-stress induced DNA binding protein +FIG00871856 FIG00871857: hypothetical protein +FIG00871858 FIG00871861: hypothetical protein +FIG00871869 FIG00871877: hypothetical protein +FIG00871877 FIG00871881: hypothetical protein +FIG00871898 FIG00871902: hypothetical protein +FIG00871903 FIG00871906: hypothetical protein +FIG00871927 FIG00871928: hypothetical protein +FIG00871938 FIG00871940: hypothetical protein +FIG00872009 ORF_ID:alr7147 +FIG00872013 FIG00872017: hypothetical protein +FIG00872020 FIG00872027: hypothetical protein +FIG00872028 FIG00872029: hypothetical protein +FIG00872069 FIG00872070: hypothetical protein +FIG00872073 FIG00872080: hypothetical protein +FIG00872080 FIG00872083: hypothetical protein +FIG00872083 FIG00872085: hypothetical protein +FIG00872087 hupL element site-specific recombinase +FIG00872126 periplasmic amino acid-binding protein of amino acid ABC transporter +FIG00872150 FIG00872152: hypothetical protein +FIG00872162 CsaB protein +FIG00872163 FIG00872168: hypothetical protein +FIG00872169 Gll3521 protein +FIG00872174 FIG00872178: hypothetical protein +FIG00872185 FIG00872195: hypothetical protein +FIG00872195 FIG00872196: hypothetical protein +FIG00872196 FIG00872197: hypothetical protein +FIG00872210 Putative NADP-dependent oxidoreductases +FIG00872220 FIG00872222: hypothetical protein +FIG00872222 FIG00872224: hypothetical protein +FIG00872224 Protein phosphatase 2C (EC 3.1.3.16) +FIG00872239 fibrillin +FIG00872253 FIG00872254: hypothetical protein +FIG00872271 FIG00872272: hypothetical protein +FIG00872284 FIG00872285: hypothetical protein +FIG00872290 Gas vesicle protein gvpN +FIG00872295 FIG00872296: hypothetical protein +FIG00872296 Cyanobacteria-specific protein +FIG00872301 FIG00872302: hypothetical protein +FIG00872305 FIG00872311: hypothetical protein +FIG00872341 FIG00872344: hypothetical protein +FIG00872373 FIG00872379: hypothetical protein +FIG00872404 FIG00872406: hypothetical protein +FIG00872406 Mov34/MPN/PAD-1 family protein +FIG00872424 FIG00872427: hypothetical protein +FIG00872427 FIG00872428: hypothetical protein +FIG00872439 FIG00872441: hypothetical protein +FIG00872441 FIG00566036: hypothetical protein +FIG00872453 FIG00872456: hypothetical protein +FIG00872456 FIG00872464: hypothetical protein +FIG00872467 FIG00872471: hypothetical protein +FIG00872476 FIG00872479: hypothetical protein +FIG00872491 FIG00872492: hypothetical protein +FIG00872497 FIG00872498: hypothetical protein +FIG00872500 Phosphate ABC transporter, periplasmic phosphate-binding protein pstS +FIG00872516 FIG00872517: hypothetical protein +FIG00872517 FIG00872520: hypothetical protein +FIG00872520 FIG00872527: hypothetical protein +FIG00872527 FIG00872528: hypothetical protein +FIG00872528 FIG00872530: hypothetical protein +FIG00872542 FIG00872546: hypothetical protein +FIG00872552 Amylopullulanase +FIG00872554 FIG00872555: hypothetical protein +FIG00872555 FIG00872560: hypothetical protein +FIG00872560 FIG00872561: hypothetical protein +FIG00872573 Dipeptide/tripeptide permease +FIG00872585 FIG00872588: hypothetical protein +FIG00872593 FIG00872597: hypothetical protein +FIG00872601 FIG00872606: hypothetical protein +FIG00872624 FIG00872626: hypothetical protein +FIG00872626 FIG00872629: hypothetical protein +FIG00872631 FIG00872633: hypothetical protein +FIG00872633 O-acetylhomoserine sulfhydrylase +FIG00872634 FIG00872636: hypothetical protein +FIG00872647 FIG00872651: hypothetical protein +FIG00872651 short-chain dehydrogenase/reductase family +FIG00872660 FIG00872666: hypothetical protein +FIG00872697 FIG00872700: hypothetical protein +FIG00872700 FIG00872701: hypothetical protein +FIG00872701 FIG00872702: hypothetical protein +FIG00872732 FIG00872733: hypothetical protein +FIG00872734 FIG00872736: hypothetical protein +FIG00872739 FIG00872741: hypothetical protein +FIG00872751 FIG00872754: hypothetical protein +FIG00872771 FIG00872781: hypothetical protein +FIG00872781 Inosine-uridine nucleoside N-ribohydrolase +FIG00872796 FIG00872798: hypothetical protein +FIG00872800 FIG00872807: hypothetical protein +FIG00872809 FIG00872811: hypothetical protein +FIG00872811 ORF_ID:all8004 unknown protein +FIG00872819 Domain of unknown function DUF1537 +FIG00872832 FIG00872835: hypothetical protein +FIG00872835 FIG00872838: hypothetical protein +FIG00872838 FIG00872839: hypothetical protein +FIG00872848 FIG00872850: hypothetical protein +FIG00872850 ATP-binding protein of ferrichrome ABC transporter +FIG00872862 FIG00872870: hypothetical protein +FIG00872885 FIG00872888: hypothetical protein +FIG00872888 FIG00872889: hypothetical protein +FIG00872889 ORF_ID:all8048 unknown protein +FIG00872891 FIG00557539: hypothetical protein +FIG00872892 FIG00872893: hypothetical protein +FIG00872893 FIG00872897: hypothetical protein +FIG00872913 FIG00872916: hypothetical protein +FIG00872918 FIG00566423: hypothetical protein +FIG00872924 FIG00872925: hypothetical protein +FIG00872927 FIG00872932: hypothetical protein +FIG00872932 FIG00872933: hypothetical protein +FIG00872940 FIG00872941: hypothetical protein +FIG00872941 sulfite oxidase homolog +FIG00872971 FIG00872972: hypothetical protein +FIG00872974 FIG00872977: hypothetical protein +FIG00872977 FIG00875368: hypothetical protein +FIG00872991 FIG00872992: hypothetical protein +FIG00873008 FIG00873010: hypothetical protein +FIG00873010 FIG00873013: hypothetical protein +FIG00873018 FIG00873020: hypothetical protein +FIG00873041 Flagellar GTP-binding protein +FIG00873060 FIG00873069: hypothetical protein +FIG00873069 FIG00873079: hypothetical protein +FIG00873079 FIG00873082: hypothetical protein +FIG00873096 FIG00873100: hypothetical protein +FIG00873125 FIG00873126: hypothetical protein +FIG00873128 FIG00873129: hypothetical protein +FIG00873129 FIG00873130: hypothetical protein +FIG00873130 FIG00873134: hypothetical protein +FIG00873135 FIG00873141: hypothetical protein +FIG00873152 FIG00873153: hypothetical protein +FIG00873154 FIG00873157: hypothetical protein +FIG00873159 FIG00873162: hypothetical protein +FIG00873162 FIG00873164: hypothetical protein +FIG00873181 FIG00873186: hypothetical protein +FIG00873199 ORF_ID:all8036 unknown protein +FIG00873205 FIG00873207: hypothetical protein +FIG00873211 FIG00873212: hypothetical protein +FIG00873228 FIG00873229: hypothetical protein +FIG00873247 FIG00873248: hypothetical protein +FIG00873248 FIG00873251: hypothetical protein +FIG00873251 FIG00873258: hypothetical protein +FIG00873266 FIG00873268: hypothetical protein +FIG00873268 FIG00873277: hypothetical protein +FIG00873295 FIG00873307: hypothetical protein +FIG00873308 FIG00873310: hypothetical protein +FIG00873327 FIG00873332: hypothetical protein +FIG00873333 FIG00873336: hypothetical protein +FIG00873336 FIG00873338: hypothetical protein +FIG00873359 FIG00873361: hypothetical protein +FIG00873366 FIG00873367: hypothetical protein +FIG00873367 FIG00873373: hypothetical protein +FIG00873373 FIG00873374: hypothetical protein +FIG00873386 FIG00873388: hypothetical protein +FIG00873413 FIG00873418: hypothetical protein +FIG00873427 Cell division protein Ftn6 +FIG00873441 FIG00873446: hypothetical protein +FIG00873463 Pyruvate dehydrogenase complex, dehydrogenase (E1) component +FIG00873465 hemolysin secretion protein +FIG00873470 FIG00873471: hypothetical protein +FIG00873471 Gas vesicle protein +FIG00873482 S-layer associated multidomain endoglucanase +FIG00873511 FIG00873515: hypothetical protein +FIG00873523 FIG00873525: hypothetical protein +FIG00873535 FIG00873536: hypothetical protein +FIG00873543 FIG00873547: hypothetical protein +FIG00873548 FIG00873550: hypothetical protein +FIG00873567 FIG00873568: hypothetical protein +FIG00873578 FIG00873579: hypothetical protein +FIG00873584 FIG00873585: hypothetical protein +FIG00873591 Multidrug efflux transporter, MFS family +FIG00873593 FIG00873594: hypothetical protein +FIG00873615 FIG00873616: hypothetical protein +FIG00873633 FIG00873634: hypothetical protein +FIG00873634 FIG00873636: hypothetical protein +FIG00873652 FIG00873653: hypothetical protein +FIG00873663 Group 2 RNA polymerase sigma factor; Cyanobacteria-specific RpoD-like sigma factor, type-7 +FIG00873666 Blue-copper-protein-like protein +FIG00873689 FIG00873692: hypothetical protein +FIG00873709 PatU +FIG00873726 FIG00873731: hypothetical protein +FIG00873731 FIG00873734: hypothetical protein +FIG00873736 FIG00873739: hypothetical protein +FIG00873743 Phosphotransferase system, mannose/fructose/N-acetylgalactosamine-specific component IID +FIG00873763 FIG00873771: hypothetical protein +FIG00873774 FIG00873775: hypothetical protein +FIG00873784 FIG00873785: hypothetical protein +FIG00873785 FIG00873786: hypothetical protein +FIG00873799 Thioesterase (EC 3.1.2.14) +FIG00873806 FIG00873807: hypothetical protein +FIG00873831 O-acetylhomoserine sulfhydrylase +FIG00873838 FIG00873841: hypothetical protein +FIG00873861 FIG00873863: hypothetical protein +FIG00873866 FIG00873868: hypothetical protein +FIG00873877 ATP-grasp ligase forming mycosporine-glycine, MysC +FIG00873878 FIG00393399: hypothetical protein +FIG00873884 iron(III) dicitrate-binding protein of ABC transporter +FIG00873888 FIG00873889: hypothetical protein +FIG00873894 FIG00873895: hypothetical protein +FIG00873926 FIG00873927: hypothetical protein +FIG00873927 FIG00873932: hypothetical protein +FIG00873936 FIG00873939: hypothetical protein +FIG00873943 FIG00873947: hypothetical protein +FIG00873954 FIG00873965: hypothetical protein +FIG00873971 FIG00873973: hypothetical protein +FIG00873981 FIG00873983: hypothetical protein +FIG00873990 FIG00874000: hypothetical protein +FIG00874037 WD repeat protein with Ser/Thr protein kinase motif +FIG00874038 FIG00874042: hypothetical protein +FIG00874098 FIG00874099: hypothetical protein +FIG00874099 FIG00874101: hypothetical protein +FIG00874115 FIG00874119: hypothetical protein +FIG00874119 FIG00874121: hypothetical protein +FIG00874142 FIG00874145: hypothetical protein +FIG00874152 FIG00874156: hypothetical protein +FIG00874203 FIG00874207: hypothetical protein +FIG00874220 Superfamily II RNA helicase +FIG00874222 FIG00874225: hypothetical protein +FIG00874225 FIG00874227: hypothetical protein +FIG00874233 FIG00874235: hypothetical protein +FIG00874235 FIG00874236: hypothetical protein +FIG00874246 Preprotein translocase subunit SecD +FIG00874254 FIG00874260: hypothetical protein +FIG00874260 FIG00874263: hypothetical protein +FIG00874271 FIG00874278: hypothetical protein +FIG00874292 ORF_ID:alr8051 unknown protein +FIG00874304 FIG00874307: hypothetical protein +FIG00874327 Gll1897 protein +FIG00874353 FIG00874361: hypothetical protein +FIG00874372 FIG00874375: hypothetical protein +FIG00874382 FIG00874384: hypothetical protein +FIG00874396 FIG00874404: hypothetical protein +FIG00874404 FIG00874405: hypothetical protein +FIG00874426 FIG00874429: hypothetical protein +FIG00874430 FIG00874431: hypothetical protein +FIG00874449 FIG00874456: hypothetical protein +FIG00874456 FIG00874459: hypothetical protein +FIG00874459 FIG00874466: hypothetical protein +FIG00874513 FIG00874520: hypothetical protein +FIG00874529 FIG00874530: hypothetical protein +FIG00874530 ORF_ID:all7527 unknown protein +FIG00874545 ORF_ID:all8046 unknown protein +FIG00874553 FIG00874557: hypothetical protein +FIG00874557 FIG00874558: hypothetical protein +FIG00874608 FIG00874614: hypothetical protein +FIG00874614 Sll5075 protein +FIG00874621 FIG00874622: hypothetical protein +FIG00874632 FIG00874641: hypothetical protein +FIG00874649 FIG00874650: hypothetical protein +FIG00874650 FIG00874657: hypothetical protein +FIG00874657 FIG00874659: hypothetical protein +FIG00874660 Cytosine-specific DNA methyltransferase +FIG00874670 FIG00874674: hypothetical protein +FIG00874676 FIG00874679: hypothetical protein +FIG00874722 heterocyst differentiation protein +FIG00874723 FIG00874725: hypothetical protein +FIG00874735 GUN4-like protein Sll0558 +FIG00874741 FIG00874746: hypothetical protein +FIG00874753 FIG00874759: hypothetical protein +FIG00874759 FIG00874760: hypothetical protein +FIG00874767 FIG00874768: hypothetical protein +FIG00874772 FIG00874773: hypothetical protein +FIG00874773 FIG00874774: hypothetical protein +FIG00874788 FIG00874789: hypothetical protein +FIG00874799 serine proteinase +FIG00874812 Virulence factor mviN homolog +FIG00874824 FIG00874826: hypothetical protein +FIG00874827 Periplasmic component of the Tol biopolymer transport system +FIG00874833 FIG00874835: hypothetical protein +FIG00874843 FIG00874846: hypothetical protein +FIG00874849 DUF98 family +FIG00874858 FIG00874860: hypothetical protein +FIG00874863 FIG00874866: hypothetical protein +FIG00874915 FIG00874918: hypothetical protein +FIG00874921 Uncharacterized protein AF2050 (similar to YjbQ) +FIG00874941 FIG00874944: hypothetical protein +FIG00874944 FIG00874945: hypothetical protein +FIG00874951 heterocyst glycolipid synthase +FIG00875001 FIG00875007: hypothetical protein +FIG00875008 FIG00875011: hypothetical protein +FIG00875011 Glycerol dehydrogenase and related enzymes +FIG00875019 FIG00875021: hypothetical protein +FIG00875032 FIG00875037: hypothetical protein +FIG00875037 FIG00875038: hypothetical protein +FIG00875041 protein serine-threonine kinase +FIG00875043 FIG00875044: hypothetical protein +FIG00875044 FIG00875049: hypothetical protein +FIG00875072 Adenosylhopane nucleosidase, HpnG +FIG00875082 FIG00875085: hypothetical protein +FIG00875100 FIG00875102: hypothetical protein +FIG00875109 FIG00875110: hypothetical protein +FIG00875110 FIG00875118: hypothetical protein +FIG00875144 purine-binding chemotaxis protein +FIG00875152 COG4585: Signal transduction histidine kinase +FIG00875182 FIG00875187: hypothetical protein +FIG00875187 Possible membrane associated protease +FIG00875192 FIG00875198: hypothetical protein +FIG00875210 FIG00875211: hypothetical protein +FIG00875222 FIG00875227: hypothetical protein +FIG00875234 FIG00875236: hypothetical protein +FIG00875269 FIG00875279: hypothetical protein +FIG00875279 FIG00875280: hypothetical protein +FIG00875290 FIG00875298: hypothetical protein +FIG00875298 FIG00875313: hypothetical protein +FIG00875335 FIG00875339: hypothetical protein +FIG00875339 FIG00875342: hypothetical protein +FIG00875368 FIG00875370: hypothetical protein +FIG00875370 FIG00875373: hypothetical protein +FIG00875376 FIG00875382: hypothetical protein +FIG00875416 FIG00875423: hypothetical protein +FIG00875453 FIG00875457: hypothetical protein +FIG00875466 FIG00875470: hypothetical protein +FIG00875470 FIG00875471: hypothetical protein +FIG00875493 FIG00875501: hypothetical protein +FIG00875501 FIG00875504: hypothetical protein +FIG00875508 FIG00875515: hypothetical protein +FIG00875546 Glycosyltransferase +FIG00875570 FIG00875571: hypothetical protein +FIG00875584 FIG00875589: hypothetical protein +FIG00875609 FIG00875611: hypothetical protein +FIG00875611 FIG00875612: hypothetical protein +FIG00875614 FIG00875617: hypothetical protein +FIG00875625 probable O-antigen acetylase +FIG00875641 FIG00875644: hypothetical protein +FIG00875646 FIG00875653: hypothetical protein +FIG00875715 FIG00875718: hypothetical protein +FIG00875724 FIG00875725: hypothetical protein +FIG00875738 FIG00875745: hypothetical protein +FIG00875755 FIG00563313: hypothetical protein +FIG00875779 FIG00875780: hypothetical protein +FIG00875780 FIG00875790: hypothetical protein +FIG00875819 FIG00875820: hypothetical protein +FIG00875822 FIG00875823: hypothetical protein +FIG00875834 FIG00875839: hypothetical protein +FIG00875839 FIG00875844: hypothetical protein +FIG00875862 ORF_ID:all8045 unknown protein +FIG00875883 Isocitrate dehydrogenases +FIG00875907 FIG00875909: hypothetical protein +FIG00875946 FIG00875948: hypothetical protein +FIG00875977 Two component Transcriptional regulator, Winged helix family (EC 3.1.1.61) +FIG00875981 FIG00875984: hypothetical protein +FIG00876021 FIG00876026: hypothetical protein +FIG00876075 probable dioxygenase Rieske iron-sulfur component +FIG00876089 FIG00876090: hypothetical protein +FIG00876124 Inward rectifier potassium channel 2 +FIG00876138 FIG00876141: hypothetical protein +FIG00876141 similar to Aminopeptidase N +FIG00876145 FIG00876147: hypothetical protein +FIG00876156 FIG00876157: hypothetical protein +FIG00876157 FIG00876158: hypothetical protein +FIG00876162 FIG00876168: hypothetical protein +FIG00876172 FIG01178974: hypothetical protein +FIG00876178 FIG00876185: hypothetical protein +FIG00876226 oxidoreductase, Gfo/Idh/MocA family/transferase hexapeptide repeat protein +FIG00876234 FIG00876240: hypothetical protein +FIG00876307 FIG00876308: hypothetical protein +FIG00876338 FIG00876341: hypothetical protein +FIG00876341 FIG00876342: hypothetical protein +FIG00876344 FIG00876350: hypothetical protein +FIG00876350 hypothetical protein +FIG00876352 ORF_ID:alr7604 unknown protein +FIG00876361 FIG00876367: hypothetical protein +FIG00876379 FIG00876381: hypothetical protein +FIG00876446 FIG00876449: hypothetical protein +FIG00876449 ATP-dependent Lon protease, bacterial type +FIG00876458 FIG00876461: hypothetical protein +FIG00876474 SAM (and some other nucleotide) binding motif:Generic methyl-transferase +FIG00876488 FIG00876497: hypothetical protein +FIG00876499 FIG00876501: hypothetical protein +FIG00876511 FIG00876515: hypothetical protein +FIG00876525 Cytochrome P450 (EC 1.14.14.1) +FIG00876537 COG3210: Large exoproteins involved in heme utilization or adhesion +FIG00876556 Hypothetical protein, slr1506/slr1944 homolog +FIG00876563 FIG00876564: hypothetical protein +FIG00876593 FIG00876594: hypothetical protein +FIG00876616 FIG00876617: hypothetical protein +FIG00876631 FIG00876635: hypothetical protein +FIG00876639 FIG00876640: hypothetical protein +FIG00876644 FIG00876649: hypothetical protein +FIG00876658 ABC-type phosphate transport system, permease component +FIG00876770 FIG00876772: hypothetical protein +FIG00876775 FIG00876787: hypothetical protein +FIG00876815 FIG00876825: hypothetical protein +FIG00876855 Peptidoglycan-binding domain 1 precursor +FIG00876927 FIG00876934: hypothetical protein +FIG00876946 protease htpX-like protein +FIG00876980 FIG00876982: hypothetical protein +FIG00877002 FIG00877003: hypothetical protein +FIG00877056 FIG00877060: hypothetical protein +FIG00877062 FIG00877064: hypothetical protein +FIG00877066 FIG00877067: hypothetical protein +FIG00877089 FIG00877091: hypothetical protein +FIG00877104 FIG00877106: hypothetical protein +FIG00877131 FIG00877147: hypothetical protein +FIG00877179 FIG00877180: hypothetical protein +FIG00877260 FIG00877262: hypothetical protein +FIG00877262 putative UV-endonuclease +FIG00877266 ABC-type dipeptide/oligopeptide/nickel transport systems, permease components +FIG00877299 FIG00877300: hypothetical protein +FIG00877303 FIG00877304: hypothetical protein +FIG00877331 FIG00877332: hypothetical protein +FIG00877348 ORF_ID:asl8028 unknown protein +FIG00877388 FIG00877389: hypothetical protein +FIG00877394 FIG00877401: hypothetical protein +FIG00877418 FIG00877419: hypothetical protein +FIG00877419 FIG00877422: hypothetical protein +FIG00877446 FIG00877447: hypothetical protein +FIG00877467 FIG00877468: hypothetical protein +FIG00877525 Alcohol dehydrogenase, zinc-containing +FIG00877558 unknown; putative inner membrane protein +FIG00877731 FIG00877732: hypothetical protein +FIG00877764 FIG00877770: hypothetical protein +FIG00877804 Free methionine-(R)-sulfoxide reductase, contains GAF domain +FIG00878028 FIG00878031: hypothetical protein +FIG00878071 FIG00878073: hypothetical protein +FIG00878228 Gll3385 protein +FIG00878297 FIG00878299: hypothetical protein +FIG00878414 FIG00878415: hypothetical protein +FIG00878440 FIG00878444: hypothetical protein +FIG00878520 FIG00878524: hypothetical protein +FIG00878527 Arylamine N-acetyltransferase +FIG00878533 FIG00878535: hypothetical protein +FIG00878631 FIG00902651: hypothetical protein +FIG00878635 FIG00878636: hypothetical protein +FIG00878652 FIG00878655: hypothetical protein +FIG00878707 FIG00878709: hypothetical protein +FIG00878830 Histone protein +FIG00878864 FIG00878865: hypothetical protein +FIG00878865 FIG00878869: hypothetical protein +FIG00878979 FIG00878980: hypothetical protein +FIG00879016 Bll3818 protein +FIG00879035 FIG00879036: hypothetical protein +FIG00879049 20-beta-hydroxysteroid dehydrogenase (EC 1.1.1.53) +FIG00879092 FIG00879096: hypothetical protein +FIG00879216 myc induced nuclear antigen +FIG00879220 FIG00879223: hypothetical protein +FIG00879399 FIG00879402: hypothetical protein +FIG00879404 FIG00879405: hypothetical protein +FIG00879418 FIG167255: hypothetical protein +FIG00879482 FIG00879484: hypothetical protein +FIG00879606 FIG00879607: hypothetical protein +FIG00879618 FIG00879619: hypothetical protein +FIG00879780 putative RNA methyltransferase, TrmH family +FIG00879834 FIG00879836: hypothetical protein +FIG00879926 methyl-accepting chemotaxis receptor/sensory transducer +FIG00879988 FIG00879991: hypothetical protein +FIG00880140 FIG00880151: hypothetical protein +FIG00880183 FIG00880187: hypothetical protein +FIG00880236 FIG00880240: hypothetical protein +FIG00880242 FIG00880250: hypothetical protein +FIG00880250 FIG00880255: hypothetical protein +FIG00880255 FIG01031499: hypothetical protein +FIG00880265 FIG00880269: hypothetical protein +FIG00880297 FIG00880298: hypothetical protein +FIG00880302 FIG00880303: hypothetical protein +FIG00880303 FIG00880305: hypothetical protein +FIG00880312 FIG00880315: hypothetical protein +FIG00880315 FIG00880316: hypothetical protein +FIG00880316 FIG00880319: hypothetical protein +FIG00880319 Homospermidine synthase +FIG00880323 FIG00880324: hypothetical protein +FIG00880324 FIG00880325: hypothetical protein +FIG00880338 FIG00880341: hypothetical protein +FIG00880341 FIG00880342: hypothetical protein +FIG00880362 FIG00880366: hypothetical protein +FIG00880369 FIG00880371: hypothetical protein +FIG00880391 FIG00880399: hypothetical protein +FIG00880399 FIG00880403: hypothetical protein +FIG00880403 FIG00880412: hypothetical protein +FIG00880415 FIG00880416: hypothetical protein +FIG00880431 FIG00880434: hypothetical protein +FIG00880451 FIG00880452: hypothetical protein +FIG00880452 High-affinity K+ transport system, ATPase chain B +FIG00880470 FIG00880471: hypothetical protein +FIG00880471 FIG00880473: hypothetical protein +FIG00880477 FIG00880484: hypothetical protein +FIG00880484 FIG00990273: hypothetical protein +FIG00880495 FIG00880498: hypothetical protein +FIG00880519 FIG00880522: hypothetical protein +FIG00880523 FIG00880525: hypothetical protein +FIG00880525 FIG00880528: hypothetical protein +FIG00880529 FIG00880530: hypothetical protein +FIG00880544 FIG00880545: hypothetical protein +FIG00880545 Conserved hypothetical protein, gene in Ubiquinol-cytochrome C chaperone locus +FIG00880551 FlaF protein +FIG00880552 FIG00880558: hypothetical protein +FIG00880575 FIG00880584: hypothetical protein +FIG00880586 FIG00880595: hypothetical protein +FIG00880634 FIG00880639: hypothetical protein +FIG00880639 FIG00880640: hypothetical protein +FIG00880647 Membrane-bound lytic murein transglycosylase B precursor (EC 3.2.1.-) +FIG00880650 FIG00880653: hypothetical protein +FIG00880677 FIG00880678: hypothetical protein +FIG00880682 FIG00880685: hypothetical protein +FIG00880685 FIG00880692: hypothetical protein +FIG00880692 FIG00880694: hypothetical protein +FIG00880708 FIG00880715: hypothetical protein +FIG00880715 FIG00880716: hypothetical protein +FIG00880730 CcaA protein +FIG00880734 Response regulator CtrA +FIG00880749 FIG00880754: hypothetical protein +FIG00880758 FIG00880760: hypothetical protein +FIG00880778 FIG00880786: hypothetical protein +FIG00880805 FIG00880811: hypothetical protein +FIG00880817 FIG00880818: hypothetical protein +FIG00880821 FIG00880825: hypothetical protein +FIG00880838 FIG00880841: hypothetical protein +FIG00880841 Mg(2+) transport ATPase protein C +FIG00880862 FIG00880864: hypothetical protein +FIG00880865 Possible multiple sugar transport system permease protein +FIG00880867 FIG00880869: hypothetical protein +FIG00880875 FIG00880880: hypothetical protein +FIG00880880 FIG00880883: hypothetical protein +FIG00880893 FIG00880894: hypothetical protein +FIG00880897 COG0457: FOG: TPR repeat +FIG00880906 FIG00880909: hypothetical protein +FIG00880922 FIG00880926: hypothetical protein +FIG00880926 FIG00880929: hypothetical protein +FIG00880975 FIG00880981: hypothetical protein +FIG00880988 putative mucR family transcriptional regulatory protein +FIG00881010 FIG00881013: hypothetical protein +FIG00881013 putative metal chaperone, involved in Fe-nitrile hydratase activation, GTPase of COG0523 family +FIG00881016 FIG00881020: hypothetical protein +FIG00881020 FIG00881023: hypothetical protein +FIG00881066 FIG00881069: hypothetical protein +FIG00881088 Adenine-specific DNA methyltransferase +FIG00881105 FIG00881109: hypothetical protein +FIG00881115 FIG00881121: hypothetical protein +FIG00881127 FIG00881132: hypothetical protein +FIG00881133 FIG00881134: hypothetical protein +FIG00881202 OXIDOREDUCTASE (EC 1.1.1.-) +FIG00881221 FIG01026938: hypothetical protein +FIG00881237 FIG00881243: hypothetical protein +FIG00881265 FIG00992960: hypothetical protein +FIG00881283 FIG00881288: hypothetical protein +FIG00881288 FIG00881296: hypothetical protein +FIG00881299 FIG00881302: hypothetical protein +FIG00881302 FIG00881303: hypothetical protein +FIG00881483 YbbM +FIG00881610 CDS_ID OB3198 +FIG00881900 FIG00881906: hypothetical protein +FIG00882049 metallo-beta-lactamase family protein +FIG00882218 positive regulator of comK +FIG00882250 FIG00882261: hypothetical protein +FIG00882404 Zn-dependent hydroxyacylglutathione hydrolase +FIG00882713 CDS_ID OB0927 +FIG00882948 Transporter LiaF +FIG00882957 HIT1 PROTEIN +FIG00882972 SUGAR TRANSPORTER +FIG00882984 Predicted Zn-dependent peptidase +FIG00882991 Nudix hydrolase +FIG00882994 Phosphinothricin N-acetyltransferase +FIG00883001 octopine transport system permease protein +FIG00883003 PIRIN +FIG00883016 Outer membrane protein and related peptidoglycan-associated (lipo)proteins +FIG00883039 FIG00883040: hypothetical protein +FIG00883042 FIG167255: hypothetical protein +FIG00883044 Outer membrane lipoprotein omp10 precursor +FIG00883054 INVASION PROTEIN B +FIG00883067 Fusaric acid resistance protein FusE +FIG00883071 Virulence protein, type IV secretory pathway, VirJ component +FIG00883085 ErfK/YbiS/YcfS/YnhG +FIG00883121 Glutamyl-tRNA(Gln) amidotransferase subunit A-like protein +FIG00883149 gramicidin S biosynthesis grst protein (EC 3.1.2.-) +FIG00883153 MlrC +FIG00883158 ABC transporter ATP-binding protein YvcR +FIG00883163 FIG00883165: hypothetical protein +FIG00883169 Drug resistance transporter, Bcr/CflA family +FIG00883183 Zinc carboxypeptidase A metalloprotease (M14):ATP/GTP-binding site motif A (P-loop):Sigma-54 factor interaction domain:ABC tr +FIG00883200 Kinesin-like protein +FIG00883202 Chemotaxis protein motC +FIG00883203 FIG00883204: hypothetical protein +FIG00883237 Phenazine biosynthesis protein PhzF like +FIG00883249 Sulfide-quinone reductase +FIG00883253 Manganese uptake regulation protein MUR +FIG00883257 SECRETION ACTIVATOR PROTEIN +FIG00883264 Possible regulatory protein BirS +FIG00883270 GDP-L-fucose synthetase (EC 1.1.1.271) +FIG00883291 FIG00883292: hypothetical protein +FIG00883327 ABC sugar transporter, inner membrane subunit +FIG00883336 Saccharopine dehydrogenase (EC 1.5.1.7) +FIG00883337 FIG00883338: hypothetical protein +FIG00883347 Glutathione S-transferase-like +FIG00883360 Cell cycle transcriptional regulator CtrA +FIG00883382 Protein SlyX +FIG00883398 ABC opine/polyamine transporter, inner membrane subunit +FIG00883402 Transglycosylase associated gene +FIG00883417 exopolysaccharide production protein, putative +FIG00883425 FIG044612: hypothetical protein +FIG00883440 Brucella protein BruAb1_0660 +FIG00883445 Signal recognition particle GTPase +FIG00883468 Phage tail tube protein FII +FIG00883495 L,D-transpeptidase +FIG00883498 methyltransferase, putative +FIG00883502 ferric vibriobactin ABC transporter permease protein +FIG00883523 L-proline glycine betaine binding ABC transporter protein ProX (TC 3.A.1.12.1) / Osmotic adaptation +FIG00883539 Glycoprotein +FIG00883554 Alpha-ketoglutarate transporter +FIG00883567 DsbA family, Com1-like subfamily +FIG00883568 Purple acid phosphatase family protein +FIG00883577 Spermidine/putrescine-binding periplasmic protein +FIG00883594 L,D-transpeptidase +FIG00883599 Serine kinase of the HPr protein, regulates carbohydrate metabolism +FIG00883600 Fusaric acid resistance protein FusB / Fusaric acid resistance protein FusC +FIG00883611 PROTEIN ERFK/SRFK +FIG00883613 COGs COG3339 +FIG00883624 TRANSPORTER, DME FAMILY +FIG00883644 Polyphosphate kinase 2 (EC 2.7.4.1) +FIG00883651 FIG00883652: hypothetical protein +FIG00883666 Sugar ABC transporter, periplasmic sugar-binding protein +FIG00883667 spore-cortex-lytic enzyme prepeptide precursor +FIG00883675 Bacteroid development protein BacA +FIG00883680 GLCG PROTEIN +FIG00883688 ATPase associated with chromosome architecture/replication +FIG00883712 FIG097019: Amino acid efflux protein +FIG00883733 FIG00883734: hypothetical protein +FIG00883740 Endo-type 6-aminohexanoate oligomer hydrolase +FIG00883743 Msr0042 protein +FIG00883748 Succinoglycan biosynthesis transport protein ExoP +FIG00883786 Integral membrane protein TerC family +FIG00883791 Hypothetical Membrane Spanning Protein +FIG00883792 FIG038036: Predicted membrane protein +FIG00883809 Msr0370 protein +FIG00883829 FIG00984616: hypothetical protein +FIG00883836 FIG00883839: hypothetical protein +FIG00883856 Hypothetical Cytosolic Protein +FIG00883862 FIG035060: hypothetical protein +FIG00883868 Oxidoreductase, FMN-binding +FIG00883873 Probable multidrug resistance protein norM (Multidrug-efflux transporter) +FIG00883877 PUTATIVE ACETYLTRANSFERASE PROTEIN( EC:2.3.1.- ) +FIG00883884 Beta-lactamase class C and other penicillin binding proteins +FIG00883885 GLUCOSE 1-DEHYDROGENASE II (EC 1.1.1.47) +FIG00883889 Common-antigen +FIG00883902 HDED PROTEIN +FIG00883903 ETC complex I subunit conserved region +FIG00883905 Phospholipase/carboxylesterase family protein +FIG00883919 SLT domain (EC 3.2.1.-) +FIG00883920 FIG049039: Transcriptional regulator, LysR family +FIG00883923 AP endonuclease family 1 domain protein +FIG00883924 DedA-family integral membrane protein +FIG00883937 FIG00983692: hypothetical protein +FIG00883987 FIG00883988: hypothetical protein +FIG00883988 FIG00883991: hypothetical protein +FIG00884023 ATP/GTP-binding protein +FIG00884032 similar to ribulose-1,5-bisphosphate carboxylase, Type III +FIG00884060 Extensin family protein +FIG00884067 ABC-type uncharacterized transport system +FIG00884086 Sulfoacetaldehyde acetyltransferase (EC 2.3.3.15) +FIG00884093 Predicted esterase of the alpha/beta hydrolase fold +FIG00884100 hypothetical protein co-occurring with urease in Rhizobiales +FIG00884102 COG0385 sodium-dependent transporter +FIG00884104 Membrane protein, MarC family +FIG00884130 FIG004694: Hypothetical protein +FIG00884133 TRANSPORTER +FIG00884142 MULTIDRUG RESISTANCE PROTEIN 1 +FIG00884172 CLC voltage-gated chloride channel +FIG00884176 Hypothetical transmembrane iron-regulated protein +FIG00884180 Putative AsnC family alanine catabolic operon regulator +FIG00884193 FIG00884196: hypothetical protein +FIG00884226 SENSORY TRANSDUCTION HISTIDINE KINASE +FIG00884229 Glycosyl transferase, family 25 +FIG00884242 Extensin-like protein +FIG00884244 FIG00884245: hypothetical protein +FIG00884261 procollagen, type VI, alpha 3 +FIG00884264 Inositol monophosphatase and related sulfite synthesis enzyme +FIG00884269 ABC TRANSPORTER ATP-BINDING PROTEIN +FIG00884288 Nodulation protein N +FIG00884291 Membrane protein YbgT +FIG00884293 Major Facilitator Superfamily transporter +FIG00884296 DNA polymerase III subunit epsilon( EC:2.7.7.7 ) +FIG00884297 Deoxycytidylate deaminase (EC 3.5.4.12) +FIG00884305 GCN5-related N-acetyltransferase +FIG00884308 Quaternary ammonium compound-resistance protein SugE +FIG00884332 Inositol transport system permease protein +FIG00884348 FIG00884349: hypothetical protein +FIG00884353 FIG00884354: hypothetical protein +FIG00884358 PROBABLE LACTOYLGLUTATHIONE LYASE (EC 4.4.1.5) +FIG00884379 Membrane protein involved in aromatic hydrocarbon degradation +FIG00884401 Membrane protein with CBS domain protein +FIG00884405 Uncharacterized protein involved in exopolysaccharide biosynthesis +FIG00884424 FIG00884426: hypothetical protein +FIG00884446 Lipocalin family protein +FIG00884468 putative UDP-glucose 4-epimerase +FIG00884492 corrinoid methyltransferase protein +FIG00884503 FIG00884504: hypothetical protein +FIG00884509 FIG00884512: hypothetical protein +FIG00884532 FIG00884535: hypothetical protein +FIG00884571 HpcH/HpaI aldolase +FIG00884574 FIG00884578: hypothetical protein +FIG00884578 FIG00884582: hypothetical protein +FIG00884608 FIG00884609: hypothetical protein +FIG00884735 TfoX-like +FIG00884745 Transcription elongation factor +FIG00884806 Mesenchymal stem cell protein DSCD75 +FIG00884814 FIG00884816: hypothetical protein +FIG00884860 FIG00884861: hypothetical protein +FIG00884865 FIG00884867: hypothetical protein +FIG00884883 FIG00884887: hypothetical protein +FIG00884934 Peptidase, M16 family +FIG00884989 Penicillin amidase family protein +FIG00885007 FIG00885008: hypothetical protein +FIG00885023 FIG00885025: hypothetical protein +FIG00885043 Core-2/I-branching enzyme family protein +FIG00885049 Negative transcriptional regulator +FIG00885067 FIG00885068: hypothetical protein +FIG00885079 Uncharacterized protein containing a von Willebrand factor type A (vWA) domain +FIG00885088 Malate/L-lactate dehydrogenase +FIG00885096 FIG00885097: hypothetical protein +FIG00885102 FIG01023860: hypothetical protein +FIG00885107 putative histidinol dehydrogenase (but probably not) +FIG00885118 FIG00885119: hypothetical protein +FIG00885283 Gas vesicle protein gvpJ +FIG00885284 polyphosphate kinase 2 +FIG00885292 K+-transporting ATPase, A chain +FIG00885296 Glutamate-ammonia ligase adenylyltransferase (EC 2.7.7.42) +FIG00885300 pyridoxal phosphate biosynthetic protein +FIG00885304 Glycine/D-amino acid oxidase +FIG00885305 FIG00885306: hypothetical protein +FIG00885315 Granule-associated protein +FIG00885316 glutamine amidotransferase class-I +FIG00885319 FIG00885323: hypothetical protein +FIG00885365 Plastocyanin-like protein +FIG00885395 Mlr4105 protein +FIG00885399 FIG00885400: hypothetical protein +FIG00885400 FIG00885401: hypothetical protein +FIG00885401 FIG00885403: hypothetical protein +FIG00885412 FIG00885413: hypothetical protein +FIG00885417 FIG00885418: hypothetical protein +FIG00885420 FIG00885422: hypothetical protein +FIG00885422 FIG00885423: hypothetical protein +FIG00885423 FIG00885425: hypothetical protein +FIG00885425 FIG00885427: hypothetical protein +FIG00885428 transcriptional regulator, AcrR family +FIG00885429 tRNA-dependent lipid II-AlaAla--L-serine ligase +FIG00885436 FIG00885438: hypothetical protein +FIG00885440 transcriptional regulator, MutR family +FIG00885444 FIG00885445: hypothetical protein +FIG00885445 FIG00885447: hypothetical protein +FIG00885447 Phosphate regulon transcriptional regulatory protein PhoB +FIG00885448 FIG00885449: hypothetical protein +FIG00885450 FIG00885451: hypothetical protein +FIG00885451 cell division protein (putative) +FIG00885462 FIG00885464: hypothetical protein +FIG00885464 N-acetylmuramidase +FIG00885471 FIG00885474: hypothetical protein +FIG00885476 FIG00885478: hypothetical protein +FIG00885478 FIG00885487: hypothetical protein +FIG00885493 FIG00885499: hypothetical protein +FIG00885500 FIG00885505: hypothetical protein +FIG00885511 FIG00885512: hypothetical protein +FIG00885524 FIG00885526: hypothetical protein +FIG00885526 FIG00885528: hypothetical protein +FIG00885533 FIG00885535: hypothetical protein +FIG00885535 FIG00885538: hypothetical protein +FIG00885538 immunity protein PlnI, membrane-bound protease CAAX family +FIG00885539 FIG00885540: hypothetical protein +FIG00885540 FIG00885541: hypothetical protein +FIG00885541 FIG00885544: hypothetical protein +FIG00885544 FIG00885547: hypothetical protein +FIG00885547 FIG00885548: hypothetical protein +FIG00885564 FIG00885565: hypothetical protein +FIG00885565 FIG00885568: hypothetical protein +FIG00885568 Nucleoside permease +FIG00885578 FIG00885579: hypothetical protein +FIG00885579 FIG00885580: hypothetical protein +FIG00885586 FIG00885587: hypothetical protein +FIG00885587 FIG00885588: hypothetical protein +FIG00885588 FIG00885590: hypothetical protein +FIG00885595 FIG00885597: hypothetical protein +FIG00885599 FIG00885600: hypothetical protein +FIG00885603 D-Ala-teichoic acid biosynthesis protein (putative) +FIG00885608 FIG00885610: hypothetical protein +FIG00885612 FIG00885613: hypothetical protein +FIG00885616 FIG00885619: hypothetical protein +FIG00885625 FIG00885630: hypothetical protein +FIG00885630 FIG00885631: hypothetical protein +FIG00885631 FIG00885632: hypothetical protein +FIG00885635 FIG00885636: hypothetical protein +FIG00885636 FIG00885637: hypothetical protein +FIG00885640 FIG00885645: hypothetical protein +FIG00885645 FIG00885647: hypothetical protein +FIG00885647 AraC-type DNA-binding protein, response regulator +FIG00885662 FIG00885664: hypothetical protein +FIG00885672 FIG00885675: hypothetical protein +FIG00885675 FIG00885677: hypothetical protein +FIG00885678 FIG00885680: hypothetical protein +FIG00885688 FIG00885689: hypothetical protein +FIG00885692 FIG00885693: hypothetical protein +FIG00885694 FIG00885696: hypothetical protein +FIG00885696 FIG00885697: hypothetical protein +FIG00885701 FIG00885702: hypothetical protein +FIG00885702 FIG00885703: hypothetical protein +FIG00885703 FIG00885704: hypothetical protein +FIG00885704 FIG00885705: hypothetical protein +FIG00885716 FIG00885717: hypothetical protein +FIG00885718 FIG00885719: hypothetical protein +FIG00885719 FIG00885721: hypothetical protein +FIG00885721 FIG00885722: hypothetical protein +FIG00885722 FIG00885723: hypothetical protein +FIG00885723 FIG00885724: hypothetical protein +FIG00885724 FIG00885726: hypothetical protein +FIG00885730 FIG00885734: hypothetical protein +FIG00885734 FIG00885736: hypothetical protein +FIG00885736 FIG00885737: hypothetical protein +FIG00885748 FIG00885750: hypothetical protein +FIG00885754 FIG00885755: hypothetical protein +FIG00885756 FIG00885757: hypothetical protein +FIG00885764 FIG00885765: hypothetical protein +FIG00885765 FIG00885766: hypothetical protein +FIG00885766 FIG00885767: hypothetical protein +FIG00885767 FIG00885768: hypothetical protein +FIG00885781 FIG00885784: hypothetical protein +FIG00885784 epimerase +FIG00885788 FIG00885789: hypothetical protein +FIG00885791 FIG00885793: hypothetical protein +FIG00885793 FIG00885797: hypothetical protein +FIG00885797 FIG00885798: hypothetical protein +FIG00885799 FIG00885800: hypothetical protein +FIG00885803 FIG00885804: hypothetical protein +FIG00885804 FIG00885805: hypothetical protein +FIG00885816 Fructosamine-3-kinase (EC 2.7.1.-) +FIG00885819 FIG00885820: hypothetical protein +FIG00885820 FIG00885822: hypothetical protein +FIG00885829 FIG00885831: hypothetical protein +FIG00885833 FIG00885834: hypothetical protein +FIG00885843 formate hydrogenlyase, subunit 3, multisubunit Na+/H+ antiporter, MnhD subunit +FIG00885845 Guanine deaminase( EC:3.5.4.3 ) +FIG00885847 permease, major facilitator superfamily +FIG00885848 FIG00885849: hypothetical protein +FIG00885849 penicillin acylase +FIG00885850 metallopeptidase, SprT family +FIG00885851 FIG00885853: hypothetical protein +FIG00885853 FIG00885855: hypothetical protein +FIG00885855 FIG00885857: hypothetical protein +FIG00885858 FIG00885861: hypothetical protein +FIG00885861 FIG00885863: hypothetical protein +FIG00885864 FIG00885865: hypothetical protein +FIG00885865 FIG00885866: hypothetical protein +FIG00885866 Glutaredoxin or related protein +FIG00885867 FIG00885869: hypothetical protein +FIG00885874 glycosyl transferase, 2 family 2 +FIG00885879 FIG00885880: hypothetical protein +FIG00885888 FIG00885890: hypothetical protein +FIG00885893 FIG00885894: hypothetical protein +FIG00885896 FIG00885898: hypothetical protein +FIG00885902 FIG00885903: hypothetical protein +FIG00885903 FIG00885904: hypothetical protein +FIG00885904 FIG00885905: hypothetical protein +FIG00885907 FIG00885908: hypothetical protein +FIG00885908 FIG00885910: hypothetical protein +FIG00885911 hypothetical acetyltransferase( EC:2.3.1.- ) +FIG00885912 esterase C +FIG00885917 FIG00885923: hypothetical protein +FIG00885923 FIG00885924: hypothetical protein +FIG00885924 acylphosphatase +FIG00885926 FIG00885928: hypothetical protein +FIG00885928 FIG00885929: hypothetical protein +FIG00885934 FIG00885937: hypothetical protein +FIG00885940 FIG00885942: hypothetical protein +FIG00885942 FIG00885943: hypothetical protein +FIG00885946 Lactoylglutathione lyase or related lyase +FIG00885952 FIG00885953: hypothetical protein +FIG00885953 FIG00885959: hypothetical protein +FIG00885959 FIG00885960: hypothetical protein +FIG00885963 FIG00885965: hypothetical protein +FIG00885965 FIG00885966: hypothetical protein +FIG00885969 FIG00885971: hypothetical protein +FIG00885971 FIG00885973: hypothetical protein +FIG00885973 FIG00885975: hypothetical protein +FIG00885977 FIG00885980: hypothetical protein +FIG00885985 FIG00885986: hypothetical protein +FIG00885986 FIG00885988: hypothetical protein +FIG00885990 FIG00885991: hypothetical protein +FIG00885991 FIG00885993: hypothetical protein +FIG00885998 macrolide-efflux protein +FIG00886000 FIG00886001: hypothetical protein +FIG00886001 FIG00886006: hypothetical protein +FIG00886006 FIG00886007: hypothetical protein +FIG00886007 FIG00886008: hypothetical protein +FIG00886008 FIG00886009: hypothetical protein +FIG00886009 phosphoesterase (putative) +FIG00886012 FIG00886014: hypothetical protein +FIG00886021 FIG00886025: hypothetical protein +FIG00886025 FIG00886026: hypothetical protein +FIG00886026 FIG00886027: hypothetical protein +FIG00886027 ATP-binding subunit of Clp protease and DnaK/DnaJ chaperones +FIG00886031 FIG00886032: hypothetical protein +FIG00886034 FIG00886035: hypothetical protein +FIG00886038 FIG00886039: hypothetical protein +FIG00886045 FIG00886046: hypothetical protein +FIG00886046 FIG00886047: hypothetical protein +FIG00886049 AraC-like transcriptional regulator (HTH domain) +FIG00886060 FIG00886063: hypothetical protein +FIG00886069 FIG00886070: hypothetical protein +FIG00886070 FIG00886071: hypothetical protein +FIG00886071 FIG00886074: hypothetical protein +FIG00886077 serine O-acetyltransferase( EC:2.3.1.30 ) +FIG00886079 HAD superfamily phosphatase +FIG00886081 FIG00886084: hypothetical protein +FIG00886084 FIG00886090: hypothetical protein +FIG00886090 FIG00886092: hypothetical protein +FIG00886092 O-Glycosyl hydrolase family 30 +FIG00886097 thiamine biosynthesis lipoprotein precursor +FIG00886101 FIG00886103: hypothetical protein +FIG00886103 FIG00886105: hypothetical protein +FIG00886119 cupin domain, putative +FIG00886131 FIG00886132: hypothetical protein +FIG00886133 FIG00886135: hypothetical protein +FIG00886135 FIG00886136: hypothetical protein +FIG00886136 FIG00886137: hypothetical protein +FIG00886140 FIG00886141: hypothetical protein +FIG00886141 Short-chain dehydrogenase of various substrate specificities +FIG00886145 FIG00886149: hypothetical protein +FIG00886150 FIG00886151: hypothetical protein +FIG00886151 FIG00886155: hypothetical protein +FIG00886161 FIG00886162: hypothetical protein +FIG00886163 FIG00886165: hypothetical protein +FIG00886171 FIG00886172: hypothetical protein +FIG00886172 FIG00886173: hypothetical protein +FIG00886177 FIG00886178: hypothetical protein +FIG00886185 FIG00886187: hypothetical protein +FIG00886199 FIG00886200: hypothetical protein +FIG00886200 FIG00886201: hypothetical protein +FIG00886201 FIG00886203: hypothetical protein +FIG00886203 FIG00886204: hypothetical protein +FIG00886206 FIG00886208: hypothetical protein +FIG00886210 FIG00886211: hypothetical protein +FIG00886214 FIG00886216: hypothetical protein +FIG00886217 FIG00886220: hypothetical protein +FIG00886225 FIG00886226: hypothetical protein +FIG00886226 FIG00886227: hypothetical protein +FIG00886233 transcription regulator, TetR family protein +FIG00886237 Putative hydrolase, haloacid dehalogenase-like family +FIG00886238 FIG00886240: hypothetical protein +FIG00886242 Carbonate dehydratase( EC:4.2.1.1 ) +FIG00886250 FIG00886258: hypothetical protein +FIG00886259 FIG00886261: hypothetical protein +FIG00886261 FIG00886264: hypothetical protein +FIG00886270 FIG00886272: hypothetical protein +FIG00886272 FIG00886276: hypothetical protein +FIG00886279 FIG00886281: hypothetical protein +FIG00886281 FIG00886282: hypothetical protein +FIG00886286 FIG00886287: hypothetical protein +FIG00886287 FIG00886289: hypothetical protein +FIG00886291 FIG00886292: hypothetical protein +FIG00886292 FIG00886293: hypothetical protein +FIG00886305 FIG00886307: hypothetical protein +FIG00886307 FIG00886310: hypothetical protein +FIG00886314 COG0715: ABC-type nitrate/sulfonate/bicarbonate transport systems, periplasmic components +FIG00886325 transcriptional regulator, helix-turn-helix XRE-family +FIG00886328 Beta-lactamase class C related penicillin binding protein +FIG00886332 FIG00886337: hypothetical protein +FIG00886350 FIG00886353: hypothetical protein +FIG00886353 FIG00886358: hypothetical protein +FIG00886359 FIG00886363: hypothetical protein +FIG00886484 FIG00886492: hypothetical protein +FIG00886553 DNA methylase N-4/N-6 +FIG00886579 FIG00886635: hypothetical protein +FIG00886635 FIG00886669: hypothetical protein +FIG00886845 Macrophage infectivity potentiator-related protein +FIG00886924 FIG033376: Heat shock protein DnaJ-like +FIG00886930 putative OpgC protein +FIG00887180 FIG00887242: hypothetical protein +FIG00887268 Universal stress protein Usp +FIG00887469 protein of unknown function DUF736 +FIG00887567 Na+/H+ antiporter NhaD and related arsenite permeases-like +FIG00887578 FIG00887622: hypothetical protein +FIG00887728 Mll0832 protein +FIG00887733 FIG00887751: hypothetical protein +FIG00887785 (Carboxyethyl)arginine beta-lactam-synthase (EC 6.3.3.4) +FIG00887848 FIG00887861: hypothetical protein +FIG00887915 autoinducer synthase +FIG00887996 FIG00888027: hypothetical protein +FIG00888068 FIG00888076: hypothetical protein +FIG00888113 Uncharacterized phage protein +FIG00888185 FIG00888188: hypothetical protein +FIG00888213 single-strand binding protein/Primosomal replication protein n +FIG00888260 FIG00888265: hypothetical protein +FIG00888306 FIG00888308: hypothetical protein +FIG00888310 amino acid transporter, amino acid-binding protein +FIG00888332 endo-1,4-beta-glucanase homolog +FIG00888343 DNA-directed RNA polymerase specialized sigma subunit +FIG00888346 FIG00888352: hypothetical protein +FIG00888377 FIG00888383: hypothetical protein +FIG00888383 diadenosine tetraphosphate hydrolase +FIG00888423 ABC-type amino acid transport system, periplasmic component +FIG00888430 site-specific DNA methylase +FIG00888448 chromosome segregation ATPase homolog +FIG00888453 GYF domain, putative +FIG00888474 sugar-binding periplasmic protein +FIG00888539 FIG00888540: hypothetical protein +FIG00888540 FIG00888543: hypothetical protein +FIG00888562 uncharacterized BCR +FIG00888572 Phosphoesterase, DHH family protein / LSU ribosomal protein L9p +FIG00888598 FIG00888605: hypothetical protein +FIG00888608 FIG00888612: hypothetical protein +FIG00888663 FIG00888664: hypothetical protein +FIG00888675 FIG00888686: hypothetical protein +FIG00888758 FIG00888774: hypothetical protein +FIG00888970 Immunoglobulin I-set domain protein +FIG00889058 Polypeptide-transport-associated domain protein FtsQ-type +FIG00889234 FIG00889240: hypothetical protein +FIG00889271 similar to asparagine synthase (glutamine-hydrolyzing) +FIG00889410 FIG00889421: hypothetical protein +FIG00889457 possible OmpA family member +FIG00889947 export ABC transporter permease protein +FIG00890338 pleiotropic regulatory protein DegT +FIG00890838 cupin 2, conserved barrel +FIG00890969 FIG00890970: hypothetical protein +FIG00890973 two component transcriptional regulator +FIG00891118 glycosyl hydrolase, family 88 +FIG00891371 FIG00891379: hypothetical protein +FIG00891396 FIG00891404: hypothetical protein +FIG00891584 FIG00891595: hypothetical protein +FIG00891649 glycoside hydrolase family 43 +FIG00891727 Uncharacterized protein-like protein +FIG00891743 flagellin domain protein +FIG00891796 FIG00891798: hypothetical protein +FIG00891965 similar to phytoene dehydrogenase +FIG00892136 glycosyl hydrolase, BNR repeat-containing protein +FIG00892266 multiple sugar-binding transport system multiple sugar-binding protein +FIG00892287 Sucrose-6-phosphate hydrolase (EC 3.2.1.26) +FIG00892295 FIG00892296: hypothetical protein +FIG00892307 Peptidase U32 +FIG00892316 FIG00892318: hypothetical protein +FIG00892352 multiple sugar-binding transport system permease +FIG00892433 FIG00892435: hypothetical protein +FIG00892436 FIG00892438: hypothetical protein +FIG00892491 FIG00892492: hypothetical protein +FIG00892526 hemolysin C +FIG00892532 ankyrin repeat protein with 5 ankyrin repeats +FIG00892534 FIG00892536: hypothetical protein +FIG00892540 50S ribosomal protein L29 +FIG00892547 FIG00892557: hypothetical protein +FIG00892557 FIG00892562: hypothetical protein +FIG00892564 FIG00892568: hypothetical protein +FIG00892569 phosphohistidine phosphatase( EC:3.1.3.- ) +FIG00892575 FIG00892576: hypothetical protein +FIG00892584 protocatechuate 3,4-dioxygenase beta subunit +FIG00892592 FIG00892593: hypothetical protein +FIG00892593 FIG00892595: hypothetical protein +FIG00892595 FIG00892601: hypothetical protein +FIG00892613 FIG00892614: hypothetical protein +FIG00892614 ankyrin repeat-containing protein +FIG00892617 phosphate regulon response regulator +FIG00892643 FIG00892646: hypothetical protein +FIG00892660 FIG00892669: hypothetical protein +FIG00892669 FIG00892671: hypothetical protein +FIG00892671 FIG00892673: hypothetical protein +FIG00892675 FIG00892677: hypothetical protein +FIG00892677 FIG00892687: hypothetical protein +FIG00892687 intracellular septation protein A +FIG00892692 FIG00892695: hypothetical protein +FIG00892696 FIG00892698: hypothetical protein +FIG00892698 FIG00892699: hypothetical protein +FIG00892721 FIG00892724: hypothetical protein +FIG00892729 FIG00892761: hypothetical protein +FIG00892761 FIG00892762: hypothetical protein +FIG00892762 FIG00892772: hypothetical protein +FIG00892772 FIG00892777: hypothetical protein +FIG00892777 FIG00892780: hypothetical protein +FIG00892793 FIG00892799: hypothetical protein +FIG00892803 FIG00892805: hypothetical protein +FIG00892805 FIG00892810: hypothetical protein +FIG00892825 FIG00892831: hypothetical protein +FIG00892831 FIG00892833: hypothetical protein +FIG00892833 FIG00892853: hypothetical protein +FIG00892853 FIG00892866: hypothetical protein +FIG00892874 FIG00892875: hypothetical protein +FIG00892875 FIG00892876: hypothetical protein +FIG00892876 FIG00892878: hypothetical protein +FIG00892880 FIG00892883: hypothetical protein +FIG00892883 FIG00892885: hypothetical protein +FIG00892885 FIG00892894: hypothetical protein +FIG00892894 FIG00892897: hypothetical protein +FIG00892909 FIG00892916: hypothetical protein +FIG00892919 possible 1-acyl-sn-glycerol-3-phosphate acyltransferase +FIG00892945 FIG00892946: hypothetical protein +FIG00892946 FIG00892976: hypothetical protein +FIG00892976 putative monovalent cation/H+ antiporter subunit D +FIG00892979 FIG00893001: hypothetical protein +FIG00893001 FIG00893007: hypothetical protein +FIG00893007 multisubunit Na+/H+ antiporter, MnhB subunit +FIG00893015 FIG00893022: hypothetical protein +FIG00893023 FIG00893026: hypothetical protein +FIG00893030 FIG00893033: hypothetical protein +FIG00893034 FIG00893043: hypothetical protein +FIG00893043 putative ABC transporter substrate binding protein +FIG00893044 Conjugative transfer protein TraE +FIG00893045 amino acid ABC transporter substrate binding protein +FIG00893057 FIG00893061: hypothetical protein +FIG00893061 FIG00893063: hypothetical protein +FIG00893063 FIG00893066: hypothetical protein +FIG00893066 FIG00893074: hypothetical protein +FIG00893074 ribonucleotide ABC transporter ATP-binding protein +FIG00893075 spoT-like ppGpp hydrolase +FIG00893113 FIG00893114: hypothetical protein +FIG00893124 ankyrin repeat protein with 4 ankyrin repeats +FIG00893138 nitrogen regulation protein NtrY +FIG00893145 FIG00893148: hypothetical protein +FIG00893154 FIG00893157: hypothetical protein +FIG00893157 FIG00893171: hypothetical protein +FIG00893179 FIG00893186: hypothetical protein +FIG00893186 FIG00893204: hypothetical protein +FIG00893204 FIG00893205: hypothetical protein +FIG00893226 FIG00893232: hypothetical protein +FIG00893252 FIG00893256: hypothetical protein +FIG00893260 FIG00893261: hypothetical protein +FIG00893261 FIG00893276: hypothetical protein +FIG00893283 FIG00893289: hypothetical protein +FIG00893289 Zinc/manganese ABC transporter permease protein +FIG00893314 ADP,ATP carrier protein homolog +FIG00893318 FIG00893319: hypothetical protein +FIG00893324 FIG00893337: hypothetical protein +FIG00893337 FIG00893353: hypothetical protein +FIG00893360 FIG00893362: hypothetical protein +FIG00893362 FIG00893368: hypothetical protein +FIG00893368 DNA polymerase III chi subunit +FIG00893376 FIG00893384: hypothetical protein +FIG00893384 protein export protein PrsA precursor +FIG00893413 HAD-superfamily subfamily IIA hydrolase +FIG00893431 FIG00893432: hypothetical protein +FIG00893438 putative Orientia tsutsugamushi type-specific antigen +FIG00893453 FIG00893460: hypothetical protein +FIG00893460 FIG00893465: hypothetical protein +FIG00893478 FIG00893480: hypothetical protein +FIG00893480 FIG00893498: hypothetical protein +FIG00893498 FIG00893502: hypothetical protein +FIG00893511 thermostable carboxypeptidase +FIG00893533 FIG00893538: hypothetical protein +FIG00893538 NADH dehydrogenase I chain N +FIG00893539 FIG00893546: hypothetical protein +FIG00893555 FIG00893560: hypothetical protein +FIG00893560 FIG00893574: hypothetical protein +FIG00893579 ompA-like, putative autotransporter +FIG00893585 FIG00893586: hypothetical protein +FIG00893586 FIG00893595: hypothetical protein +FIG00893595 FIG00893605: hypothetical protein +FIG00893605 FIG00893606: hypothetical protein +FIG00893606 FIG00893616: hypothetical protein +FIG00893616 C-terminal domain of CinA type S +FIG00893641 FIG00893644: hypothetical protein +FIG00893644 FIG00893660: hypothetical protein +FIG00893692 FIG00893719: hypothetical protein +FIG00893698 succinate dehydrogenase hydrophobic membrane anchor protein +FIG00893699 tyrosine recombinase XerC +FIG00893716 FIG00893717: hypothetical protein +FIG00893719 Protease IV (EC 3.4.-.-) +FIG00893720 virB4 protein precursor +FIG00893732 FIG00893740: hypothetical protein +FIG00893740 FIG00893741: hypothetical protein +FIG00893743 hypotheticaal protein +FIG00893764 FIG00893775: hypothetical protein +FIG00893807 Site-specific DNA-methyltransferase, putative( EC:2.1.1.72 ) +FIG00893819 FIG00893835: hypothetical protein +FIG00893835 FIG00893836: hypothetical protein +FIG00893836 FIG00893853: hypothetical protein +FIG00893860 Protein chain release factor A +FIG00893910 zgc:55705( EC:2.7.11.1 ) +FIG00893922 FIG00893926: hypothetical protein +FIG00893938 cationic amino acid transporter-1 +FIG00893953 FIG00893964: hypothetical protein +FIG00893964 BRCT domain protein +FIG00893989 FIG00893995: hypothetical protein +FIG00893995 FIG00894006: hypothetical protein +FIG00894006 putative conjugative transfer protein TraE +FIG00894017 FIG00894019: hypothetical protein +FIG00894019 FIG00894020: hypothetical protein +FIG00894033 putative conjugative transfer protein TraN +FIG00894041 FIG00894044: hypothetical protein +FIG00894044 FIG00894047: hypothetical protein +FIG00894047 FIG00894087: hypothetical protein +FIG00894108 FIG00894122: hypothetical protein +FIG00894165 hypothetical protein +FIG00894294 putative ompA-like autotransporter +FIG00894344 FIG00894371: hypothetical protein +FIG00894371 putative mechanosensitive ion channel +FIG00894402 putative conjugative transfer protein TraD +FIG00894410 FIG00894440: hypothetical protein +FIG00894519 FIG00894530: hypothetical protein +FIG00894613 Hypothetical protein YceD (clustered with ribosomal protein L32p) +FIG00894640 Hemin ABC transporter, permease protein +FIG00894693 FOG: Ankyrin repeat +FIG00894709 HhH-GPD base excision DNA repair family protein; Probable 3-methyladenine DNA glycosylase/8-oxoguanine DNA glycosylase +FIG00894762 UPF0125 protein yfjF +FIG00894827 putative multidrug efflux protein +FIG00894864 FIG00894865: hypothetical protein +FIG00894867 Predicted nucleotidyltransferase +FIG00894879 FIG015547: peptidase, M16 family +FIG00894894 FIG00894895: hypothetical protein +FIG00894934 FIG00894935: hypothetical protein +FIG00894951 FIG00894952: hypothetical protein +FIG00895011 heat shock protease, integral membrane protein +FIG00895077 FIG01054658: hypothetical protein +FIG00895081 FIG00895082: hypothetical protein +FIG00895082 FIG00895084: hypothetical protein +FIG00895088 FIG00895089: hypothetical protein +FIG00895092 FIG00895095: hypothetical protein +FIG00895095 FIG00895096: hypothetical protein +FIG00895102 OrfW +FIG00895106 FIG00895109: hypothetical protein +FIG00895109 FIG00895110: hypothetical protein +FIG00895110 FIG00895111: hypothetical protein +FIG00895112 FIG00895113: hypothetical protein +FIG00895116 FIG00895117: hypothetical protein +FIG00895119 FIG00895120: hypothetical protein +FIG00895124 FIG00895125: hypothetical protein +FIG00895125 FIG00895126: hypothetical protein +FIG00895127 Lmbe-related protein +FIG00895137 FIG00895138: hypothetical protein +FIG00895139 FIG00895141: hypothetical protein +FIG00895141 FIG00895142: hypothetical protein +FIG00895142 putative luciferase-family oxidoreductase +FIG00895148 FIG00895150: hypothetical protein +FIG00895157 FIG00895158: hypothetical protein +FIG00895161 FIG00895162: hypothetical protein +FIG00895164 IG hypothetical protein 17041 +FIG00895171 FIG00895172: hypothetical protein +FIG00895173 FIG00895178: hypothetical protein +FIG00895178 CtaG protein +FIG00895186 FIG00895187: hypothetical protein +FIG00895188 FIG00895189: hypothetical protein +FIG00895189 FIG00895190: hypothetical protein +FIG00895196 FIG00895197: hypothetical protein +FIG00895203 FIG00895204: hypothetical protein +FIG00895215 peptidase T( EC:3.4.11.- ) +FIG00895216 Flagellar M-ring protein fliF +FIG00895220 molybdopterin converting factor (subunit 2) +FIG00895221 FIG00895223: hypothetical protein +FIG00895226 FIG00895227: hypothetical protein +FIG00895228 HAD-superfamily hydrolase protein +FIG00895234 protein of unknown function DUF95, transmembrane +FIG00895239 FIG01225334: hypothetical protein +FIG00895241 FIG00895242: hypothetical protein +FIG00895249 FIG00895253: hypothetical protein +FIG00895264 FIG00895267: hypothetical protein +FIG00895269 transcription attenuation protein MtrB +FIG00895272 FIG00895273: hypothetical protein +FIG00895273 regulatory protein GntR HTH +FIG00895275 FIG00895277: hypothetical protein +FIG00895279 flagellar protein +FIG00895281 FIG00895284: hypothetical protein +FIG00895285 FIG00895286: hypothetical protein +FIG00895292 putative alpha-1,6-mannanase +FIG00895294 FIG00895295: hypothetical protein +FIG00895297 FIG00895298: hypothetical protein +FIG00895300 FIG00895303: hypothetical protein +FIG00895312 FIG00895313: hypothetical protein +FIG00895316 FIG00895317: hypothetical protein +FIG00895320 FIG00895323: hypothetical protein +FIG00895331 FIG00895332: hypothetical protein +FIG00895334 FIG00895335: hypothetical protein +FIG00895347 FIG00895348: hypothetical protein +FIG00895349 FIG00895350: hypothetical protein +FIG00895350 FIG00895352: hypothetical protein +FIG00895352 FIG00895354: hypothetical protein +FIG00895354 FIG00895355: hypothetical protein +FIG00895355 FIG00895356: hypothetical protein +FIG00895360 FIG00895361: hypothetical protein +FIG00895361 FIG00895362: hypothetical protein +FIG00895370 FIG00895371: hypothetical protein +FIG00895372 FIG00895373: hypothetical protein +FIG00895373 FIG00895374: hypothetical protein +FIG00895374 FIG00895375: hypothetical protein +FIG00895380 FIG00895381: hypothetical protein +FIG00895383 flagellar protein required for formation of basal body +FIG00895389 FIG00895391: hypothetical protein +FIG00895403 FIG00895405: hypothetical protein +FIG00895408 FIG00895410: hypothetical protein +FIG00895410 phosphoglycerate mutase +FIG00895412 DUF327 domain-containing protein +FIG00895419 FIG00895420: hypothetical protein +FIG00895423 FIG00895425: hypothetical protein +FIG00895428 FIG00895429: hypothetical protein +FIG00895429 OrfX +FIG00895435 polysaccharide ABC transporter substrate-binding protein +FIG00895436 FIG00895439: hypothetical protein +FIG00895439 FIG00895440: hypothetical protein +FIG00895456 FIG00895457: hypothetical protein +FIG00895457 spore maturation protein cgeB, putative +FIG00895458 Transcription factor fapR +FIG00895462 FIG00895463: hypothetical protein +FIG00895463 FIG00895464: hypothetical protein +FIG00895469 FIG00895471: hypothetical protein +FIG00895480 FIG00895481: hypothetical protein +FIG00895484 FIG00895485: hypothetical protein +FIG00895487 FIG00895488: hypothetical protein +FIG00895502 FIG00895504: hypothetical protein +FIG00895504 FIG00895507: hypothetical protein +FIG00895507 FIG00895512: hypothetical protein +FIG00895522 possible secretory protein +FIG00895533 Flavoprotein WrbA +FIG00895566 FIG00895569: hypothetical protein +FIG00895569 FIG00895570: hypothetical protein +FIG00895570 FIG00895571: hypothetical protein +FIG00895581 FIG00895591: hypothetical protein +FIG00895616 FIG00895618: hypothetical protein +FIG00895627 FIG00895629: hypothetical protein +FIG00895635 FIG00895636: hypothetical protein +FIG00895636 CrcB homolog +FIG00895654 FIG00895657: hypothetical protein +FIG00895657 D-alanyl-D-alanine dipeptidase (EC 3.4.13.22) +FIG00895677 FIG00895678: hypothetical protein +FIG00895724 FIG00895726: hypothetical protein +FIG00895747 FIG00895751: hypothetical protein +FIG00895764 FIG00895769: hypothetical protein +FIG00895783 hypothetical protein +FIG00895791 FIG00895797: hypothetical protein +FIG00895798 YbjC protein, clustered with oxygen-insensitive NADPH nitroreductase +FIG00895823 FIG00895825: hypothetical protein +FIG00895850 FIG00895851: hypothetical protein +FIG00895863 FIG00895870: hypothetical protein +FIG00895870 FIG00895872: hypothetical protein +FIG00895873 Permease of the drug/metabolite transporter superfamily +FIG00895900 FIG00895901: hypothetical protein +FIG00895903 FIG00895904: hypothetical protein +FIG00895915 probable sugar ABC transporter, substrate-binding protein, putative +FIG00895923 Baseplate assembly protein V +FIG00895946 multiple resistance protein +FIG00895947 Putative deaminase YahJ +FIG00895950 Putative aldo/keto reductase +FIG00895958 FIG00895959: hypothetical protein +FIG00895959 FIG00895963: hypothetical protein +FIG00895977 amino acid ABC transporter, permease protein +FIG00895992 FIG00895996: hypothetical protein +FIG00896000 putative bacteriophage late gene regulator +FIG00896012 FIG00896016: hypothetical protein +FIG00896021 FIG00896022: hypothetical protein +FIG00896032 FIG00896033: hypothetical protein +FIG00896043 FIG00896045: hypothetical protein +FIG00896064 Multidrug translocase +FIG00896147 Putative two-component response regulator precursor +FIG00896151 Haloacid dehalogenase, type II +FIG00896164 COG2732: Barstar, RNAse (barnase) inhibitor +FIG00896185 FIG00896188: hypothetical protein +FIG00896201 FIG00896205: hypothetical protein +FIG00896221 FIG00896226: hypothetical protein +FIG00896226 FIG00896233: hypothetical protein +FIG00896264 FIG00896267: hypothetical protein +FIG00896278 Cys regulon transcriptional activator CysB +FIG00896280 FIG00896281: hypothetical protein +FIG00896289 FIG00896291: hypothetical protein +FIG00896319 Putative aldolase Z5687 +FIG00896326 phage tail tape measure protein +FIG00896330 FIG00896331: hypothetical protein +FIG00896331 FIG00896332: hypothetical protein +FIG00896334 FIG00896335: hypothetical protein +FIG00896336 FIG00896337: hypothetical protein +FIG00896337 FIG00896339: hypothetical protein +FIG00896341 FIG00896342: hypothetical protein +FIG00896345 FIG00896346: hypothetical protein +FIG00896346 FIG00896348: hypothetical protein +FIG00896348 FIG00896350: hypothetical protein +FIG00896353 FIG00896355: hypothetical protein +FIG00896356 FIG00896357: hypothetical protein +FIG00896357 FIG00896358: hypothetical protein +FIG00896359 FIG00896360: hypothetical protein +FIG00896360 FIG00896361: hypothetical protein +FIG00896361 FIG00896362: hypothetical protein +FIG00896363 FIG00896367: hypothetical protein +FIG00896374 FIG00896375: hypothetical protein +FIG00896376 FIG00896378: hypothetical protein +FIG00896378 FIG00896380: hypothetical protein +FIG00896380 FIG00896382: hypothetical protein +FIG00896383 FIG00896386: hypothetical protein +FIG00896387 putative sodium-dependent transporter +FIG00896389 FIG00896390: hypothetical protein +FIG00896390 FIG00896391: hypothetical protein +FIG00896392 FIG00896393: hypothetical protein +FIG00896396 FIG00896397: hypothetical protein +FIG00896398 FIG00897452: hypothetical protein +FIG00896401 FIG00896402: hypothetical protein +FIG00896402 FIG00896403: hypothetical protein +FIG00896405 FIG00896409: hypothetical protein +FIG00896410 FIG00896412: hypothetical protein +FIG00896413 FIG00896414: hypothetical protein +FIG00896416 FIG00896417: hypothetical protein +FIG00896419 FIG00896421: hypothetical protein +FIG00896423 FIG00896424: hypothetical protein +FIG00896425 FIG00896426: hypothetical protein +FIG00896429 FIG00896430: hypothetical protein +FIG00896430 FIG00896431: hypothetical protein +FIG00896441 FIG00896442: hypothetical protein +FIG00896446 sodium/iodide co-transporter +FIG00896451 Beta-glucanase +FIG00896454 putative FtsX-related transmembrane transport protein +FIG00896456 FIG00896457: hypothetical protein +FIG00896457 FIG00896458: hypothetical protein +FIG00896458 FIG00896459: hypothetical protein +FIG00896459 FIG00896461: hypothetical protein +FIG00896465 FIG00896466: hypothetical protein +FIG00896466 FIG00896469: hypothetical protein +FIG00896470 FIG00896472: hypothetical protein +FIG00896473 FIG00896475: hypothetical protein +FIG00896477 abortive infection protein family +FIG00896482 FIG00896483: hypothetical protein +FIG00896485 FIG00896486: hypothetical protein +FIG00896488 FIG00896489: hypothetical protein +FIG00896490 FIG00896491: hypothetical protein +FIG00896491 FIG00896494: hypothetical protein +FIG00896496 FIG00896497: hypothetical protein +FIG00896498 Type I restriction enzyme, M subunit +FIG00896499 FIG00896500: hypothetical protein +FIG00896505 FIG00896507: hypothetical protein +FIG00896510 FIG00896511: hypothetical protein +FIG00896514 FIG00897200: hypothetical protein +FIG00896515 FIG00896517: hypothetical protein +FIG00896522 FIG00896523: hypothetical protein +FIG00896523 FIG00896524: hypothetical protein +FIG00896524 Acylaminoacyl-peptidase (EC 3.4.19.1) +FIG00896526 FIG00896527: hypothetical protein +FIG00896527 FIG00896529: hypothetical protein +FIG00896531 FIG00896532: hypothetical protein +FIG00896535 FIG00896536: hypothetical protein +FIG00896536 FIG00896539: hypothetical protein +FIG00896545 Mannan endo-1,4-beta-mannosidase +FIG00896547 FIG00896548: hypothetical protein +FIG00896548 FIG00896549: hypothetical protein +FIG00896555 Siderophore (Surfactin) biosynthesis regulatory protein +FIG00896556 FIG00896557: hypothetical protein +FIG00896558 FIG00896559: hypothetical protein +FIG00896560 FIG00896561: hypothetical protein +FIG00896574 FIG00896576: hypothetical protein +FIG00896579 FIG00896580: hypothetical protein +FIG00896580 FIG00896581: hypothetical protein +FIG00896581 FIG00896582: hypothetical protein +FIG00896582 FIG00896583: hypothetical protein +FIG00896583 FIG00896584: hypothetical protein +FIG00896592 FIG00896593: hypothetical protein +FIG00896595 FIG00896597: hypothetical protein +FIG00896597 FIG00896599: hypothetical protein +FIG00896602 FIG00896603: hypothetical protein +FIG00896613 FIG00896615: hypothetical protein +FIG00896615 FIG00896617: hypothetical protein +FIG00896617 FIG00896620: hypothetical protein +FIG00896621 FIG00898664: hypothetical protein +FIG00896626 Mobilization protein BmgB +FIG00896628 FIG00896631: hypothetical protein +FIG00896631 FIG00896635: hypothetical protein +FIG00896635 FIG00896636: hypothetical protein +FIG00896640 FIG00896642: hypothetical protein +FIG00896644 FIG00896645: hypothetical protein +FIG00896652 FIG00896660: hypothetical protein +FIG00896660 FIG00896661: hypothetical protein +FIG00896663 FIG00896664: hypothetical protein +FIG00896666 FIG00896667: hypothetical protein +FIG00896669 FIG00896672: hypothetical protein +FIG00896672 FIG00896673: hypothetical protein +FIG00896673 FIG00896675: hypothetical protein +FIG00896675 FIG00896676: hypothetical protein +FIG00896676 Probable NADH-dependent dehydrogenase +FIG00896677 FIG00896678: hypothetical protein +FIG00896678 FIG00896679: hypothetical protein +FIG00896679 FIG00896680: hypothetical protein +FIG00896686 FIG00896689: hypothetical protein +FIG00896689 FIG00896690: hypothetical protein +FIG00896695 FIG00896696: hypothetical protein +FIG00896706 FIG00896707: hypothetical protein +FIG00896707 FIG00896710: hypothetical protein +FIG00896714 FIG00896715: hypothetical protein +FIG00896715 Hypothetical protein clustered with UpdY +FIG00896722 FIG00896723: hypothetical protein +FIG00896723 FIG00896724: hypothetical protein +FIG00896737 FIG00896738: hypothetical protein +FIG00896740 FIG00896744: hypothetical protein +FIG00896744 FIG00896745: hypothetical protein +FIG00896745 FIG00896747: hypothetical protein +FIG00896747 FIG00896750: hypothetical protein +FIG00896751 FIG00896754: hypothetical protein +FIG00896759 FIG00896760: hypothetical protein +FIG00896760 Tlr1343 protein +FIG00896761 FIG00896762: hypothetical protein +FIG00896762 FIG00896764: hypothetical protein +FIG00896765 FIG00896766: hypothetical protein +FIG00896779 FIG00896781: hypothetical protein +FIG00896781 FIG00896782: hypothetical protein +FIG00896782 AcrB/D/F family transporter +FIG00896785 FIG00896786: hypothetical protein +FIG00896786 FIG00896789: hypothetical protein +FIG00896790 FIG00896791: hypothetical protein +FIG00896792 FIG00896793: hypothetical protein +FIG00896795 FIG00896796: hypothetical protein +FIG00896801 FIG00896802: hypothetical protein +FIG00896810 FIG00896812: hypothetical protein +FIG00896815 FIG00896816: hypothetical protein +FIG00896816 FIG137884: hypothetical protein +FIG00896824 FIG00896825: hypothetical protein +FIG00896826 FIG00896827: hypothetical protein +FIG00896828 FIG00896829: hypothetical protein +FIG00896829 FIG00896831: hypothetical protein +FIG00896836 FIG00896837: hypothetical protein +FIG00896837 FIG00896838: hypothetical protein +FIG00896838 FIG00896840: hypothetical protein +FIG00896842 FIG00896845: hypothetical protein +FIG00896845 putative auxin-regulated protein +FIG00896846 FIG00896847: hypothetical protein +FIG00896847 FIG00896849: hypothetical protein +FIG00896850 FIG00896851: hypothetical protein +FIG00896854 FIG00896855: hypothetical protein +FIG00896862 FIG00896863: hypothetical protein +FIG00896863 FIG00896865: hypothetical protein +FIG00896866 FIG00407580: hypothetical protein +FIG00896868 FIG00896870: hypothetical protein +FIG00896870 FIG00896871: hypothetical protein +FIG00896871 FIG00896873: hypothetical protein +FIG00896873 putative heavy-metal binding protein +FIG00896874 FIG00896876: hypothetical protein +FIG00896877 FIG00896878: hypothetical protein +FIG00896879 FIG00896880: hypothetical protein +FIG00896881 FIG00896882: hypothetical protein +FIG00896882 putative hexapeptide transferase family protein +FIG00896887 FIG00896888: hypothetical protein +FIG00896891 FIG00896893: hypothetical protein +FIG00896893 FIG00896896: hypothetical protein +FIG00896901 FIG00896902: hypothetical protein +FIG00896911 FIG00896912: hypothetical protein +FIG00896912 FIG00896913: hypothetical protein +FIG00896914 FIG00896915: hypothetical protein +FIG00896915 FIG00896917: hypothetical protein +FIG00896918 FIG00896920: hypothetical protein +FIG00896928 FIG00896929: hypothetical protein +FIG00896935 FIG00896936: hypothetical protein +FIG00896936 FIG00896937: hypothetical protein +FIG00896944 FIG00896945: hypothetical protein +FIG00896945 FIG00896946: hypothetical protein +FIG00896946 FIG00896947: hypothetical protein +FIG00896947 FIG00896949: hypothetical protein +FIG00896949 FIG00896950: hypothetical protein +FIG00896952 FIG00896953: hypothetical protein +FIG00896953 dehydrogenase, putative exo-alpha-sialidase +FIG00896956 FIG00896957: hypothetical protein +FIG00896959 nickel responsive regulator +FIG00896960 FIG00414945: hypothetical protein +FIG00896963 Oxidoreductase, N-terminal precursor +FIG00896969 23S rRNA methyltransferase (EC 2.1.1.-) +FIG00896970 putative metalloendopeptidase +FIG00896974 FIG00896976: hypothetical protein +FIG00896978 FIG00896979: hypothetical protein +FIG00896982 FIG00896984: hypothetical protein +FIG00896984 FIG00896986: hypothetical protein +FIG00896986 FIG00896987: hypothetical protein +FIG00896998 FIG00896999: hypothetical protein +FIG00897003 iron(III) ABC transporter ATP-binding protein +FIG00897010 FIG00897011: hypothetical protein +FIG00897011 FIG00897013: hypothetical protein +FIG00897014 FIG00897015: hypothetical protein +FIG00897015 FIG00898535: hypothetical protein +FIG00897016 FIG00897017: hypothetical protein +FIG00897017 conserved hypothetical protein, putative mannosyltransferase +FIG00897020 protein containing DUF488 +FIG00897021 lipoprotein PG3 +FIG00897024 FIG00897025: hypothetical protein +FIG00897026 FIG00897027: hypothetical protein +FIG00897027 AP endonuclease domain protein +FIG00897030 FIG00898363: hypothetical protein +FIG00897032 FIG00897033: hypothetical protein +FIG00897036 putative carboxylesterase +FIG00897037 FIG00898090: hypothetical protein +FIG00897040 FIG00897041: hypothetical protein +FIG00897041 FIG00897042: hypothetical protein +FIG00897044 FIG00897045: hypothetical protein +FIG00897048 FIG00897050: hypothetical protein +FIG00897051 FIG00897052: hypothetical protein +FIG00897052 FIG00939867: hypothetical protein +FIG00897053 FIG00897054: hypothetical protein +FIG00897054 FIG00897055: hypothetical protein +FIG00897055 FIG00897056: hypothetical protein +FIG00897058 FIG00897059: hypothetical protein +FIG00897059 FIG00897060: hypothetical protein +FIG00897060 FIG00897063: hypothetical protein +FIG00897067 FIG00897068: hypothetical protein +FIG00897068 FIG00897069: hypothetical protein +FIG00897070 S-layer domain +FIG00897071 FIG00897073: hypothetical protein +FIG00897074 FIG00897075: hypothetical protein +FIG00897076 FIG00897077: hypothetical protein +FIG00897078 FIG00897079: hypothetical protein +FIG00897080 FIG00897081: hypothetical protein +FIG00897088 FIG00897089: hypothetical protein +FIG00897094 FIG00897097: hypothetical protein +FIG00897098 FIG00897099: hypothetical protein +FIG00897102 FIG00897103: hypothetical protein +FIG00897106 FIG00897107: hypothetical protein +FIG00897112 FIG00897115: hypothetical protein +FIG00897115 FIG00897116: hypothetical protein +FIG00897116 FIG00897117: hypothetical protein +FIG00897117 FIG00897118: hypothetical protein +FIG00897119 FIG00897120: hypothetical protein +FIG00897125 FIG00897126: hypothetical protein +FIG00897128 FIG00897129: hypothetical protein +FIG00897132 FIG00897133: hypothetical protein +FIG00897133 FIG00897134: hypothetical protein +FIG00897134 FIG00897135: hypothetical protein +FIG00897135 FIG00897136: hypothetical protein +FIG00897141 FIG00897142: hypothetical protein +FIG00897143 FIG00897144: hypothetical protein +FIG00897144 FIG00897145: hypothetical protein +FIG00897145 FIG00899063: hypothetical protein +FIG00897146 FIG00897148: hypothetical protein +FIG00897148 FIG00897149: hypothetical protein +FIG00897149 FIG00897152: hypothetical protein +FIG00897155 FIG00899328: hypothetical protein +FIG00897159 FIG00897161: hypothetical protein +FIG00897163 FIG00897164: hypothetical protein +FIG00897164 FIG00897165: hypothetical protein +FIG00897165 FIG00897168: hypothetical protein +FIG00897169 FIG00897170: hypothetical protein +FIG00897170 FIG00897171: hypothetical protein +FIG00897176 FIG00897177: hypothetical protein +FIG00897177 FIG00897178: hypothetical protein +FIG00897178 FIG00897179: hypothetical protein +FIG00897179 FIG00897180: hypothetical protein +FIG00897180 FIG00897181: hypothetical protein +FIG00897181 FIG00897182: hypothetical protein +FIG00897184 FIG00897401: hypothetical protein +FIG00897185 FIG00897187: hypothetical protein +FIG00897188 FIG00897189: hypothetical protein +FIG00897189 gluconolactonase precursor +FIG00897191 FIG00897193: hypothetical protein +FIG00897193 FIG00897195: hypothetical protein +FIG00897195 FIG00897197: hypothetical protein +FIG00897203 FIG00897204: hypothetical protein +FIG00897204 FIG00897205: hypothetical protein +FIG00897205 FIG00897206: hypothetical protein +FIG00897209 FIG00897708: hypothetical protein +FIG00897218 FIG00897219: hypothetical protein +FIG00897219 FIG00897221: hypothetical protein +FIG00897222 FIG00897223: hypothetical protein +FIG00897227 FIG00897229: hypothetical protein +FIG00897232 FIG00897233: hypothetical protein +FIG00897238 FIG00897239: hypothetical protein +FIG00897239 sugar phosphate isomerase/epimerase +FIG00897242 FIG00897243: hypothetical protein +FIG00897243 FIG00897244: hypothetical protein +FIG00897244 FIG00897246: hypothetical protein +FIG00897246 FIG00897247: hypothetical protein +FIG00897247 FIG00897248: hypothetical protein +FIG00897252 FIG00897255: hypothetical protein +FIG00897258 FIG00897260: hypothetical protein +FIG00897266 FIG00897267: hypothetical protein +FIG00897267 ADP-heptose--LPS heptosyltransferase, putative +FIG00897268 FIG00897269: hypothetical protein +FIG00897273 FIG00897274: hypothetical protein +FIG00897276 FIG00897277: hypothetical protein +FIG00897280 FIG00897282: hypothetical protein +FIG00897282 Arabinan endo-1,5-alpha-L-arabinosidase A +FIG00897286 modification methylase +FIG00897289 FIG00897290: hypothetical protein +FIG00897290 FIG00897291: hypothetical protein +FIG00897297 FIG00897298: hypothetical protein +FIG00897298 FIG00897300: hypothetical protein +FIG00897302 FIG00897303: hypothetical protein +FIG00897305 FIG00897306: hypothetical protein +FIG00897319 FIG00897320: hypothetical protein +FIG00897320 FIG00897321: hypothetical protein +FIG00897323 FIG00897324: hypothetical protein +FIG00897325 FIG00897326: hypothetical protein +FIG00897332 FIG00897334: hypothetical protein +FIG00897338 Mobilization protein BmgA +FIG00897344 FIG00897345: hypothetical protein +FIG00897346 FIG00897347: hypothetical protein +FIG00897348 FIG00897351: hypothetical protein +FIG00897351 FIG00897353: hypothetical protein +FIG00897353 FIG00897354: hypothetical protein +FIG00897354 leucine aminopeptidase precursor +FIG00897363 FIG00897365: hypothetical protein +FIG00897368 FIG00897369: hypothetical protein +FIG00897374 FIG00897375: hypothetical protein +FIG00897375 probable NADH-dependent dehydrogenase +FIG00897384 FIG00897385: hypothetical protein +FIG00897385 FIG00897390: hypothetical protein +FIG00897390 FIG00897391: hypothetical protein +FIG00897391 multidrug resistance protein; HlyD family secretion protein +FIG00897393 FIG00897394: hypothetical protein +FIG00897395 FIG00897396: hypothetical protein +FIG00897396 FIG00897398: hypothetical protein +FIG00897401 FIG00937754: hypothetical protein +FIG00897402 FIG00897403: hypothetical protein +FIG00897403 FIG00897404: hypothetical protein +FIG00897404 Cation efflux system protein +FIG00897407 FIG00897409: hypothetical protein +FIG00897410 FIG00897411: hypothetical protein +FIG00897411 FIG00897412: hypothetical protein +FIG00897414 FIG00897415: hypothetical protein +FIG00897418 FIG00897420: hypothetical protein +FIG00897420 FIG00897421: hypothetical protein +FIG00897421 FIG00897423: hypothetical protein +FIG00897423 FIG00897424: hypothetical protein +FIG00897430 putative ECF sigma factor +FIG00897431 FIG00897433: hypothetical protein +FIG00897433 FIG00897434: hypothetical protein +FIG00897436 FIG00897437: hypothetical protein +FIG00897437 Mucin-desulfating sulfatase +FIG00897439 FIG00897440: hypothetical protein +FIG00897440 FIG00897443: hypothetical protein +FIG00897445 FIG00897447: hypothetical protein +FIG00897449 FIG00897450: hypothetical protein +FIG00897453 peptidase M28 +FIG00897454 FIG00897455: hypothetical protein +FIG00897457 FIG00897460: hypothetical protein +FIG00897460 FIG00897461: hypothetical protein +FIG00897462 FIG00897464: hypothetical protein +FIG00897466 UPF0251 protein MTH_1178 +FIG00897474 Periplasmic beta-glucosidase/beta-xylosidase precursor [Includes: Beta-glucosidase (EC 3.2.1.21) (Gentiobiase) (Cellobiase); Beta-xylosidase (EC 3.2.1.37) (1,4-beta-D-xylan xylohydrolase) (Xylan 1,4-beta-xylosidase)] +FIG00897478 FIG00897480: hypothetical protein +FIG00897480 FIG00897481: hypothetical protein +FIG00897483 FIG00897485: hypothetical protein +FIG00897485 FIG00897488: hypothetical protein +FIG00897488 FIG00897489: hypothetical protein +FIG00897494 FIG00897495: hypothetical protein +FIG00897499 FIG00897500: hypothetical protein +FIG00897502 FIG00897503: hypothetical protein +FIG00897503 FIG00897507: hypothetical protein +FIG00897507 FIG00897508: hypothetical protein +FIG00897516 FIG00897518: hypothetical protein +FIG00897519 FIG00897520: hypothetical protein +FIG00897520 FIG00897521: hypothetical protein +FIG00897521 outer membrane protein TolC, putative +FIG00897523 FIG00897525: hypothetical protein +FIG00897526 FIG00897527: hypothetical protein +FIG00897528 FIG00897529: hypothetical protein +FIG00897529 FIG00897530: hypothetical protein +FIG00897532 FIG00897533: hypothetical protein +FIG00897533 FIG00897534: hypothetical protein +FIG00897538 HDIG domain protein +FIG00897541 FIG00897542: hypothetical protein +FIG00897550 FIG00897551: hypothetical protein +FIG00897552 FIG00897553: hypothetical protein +FIG00897561 FIG00897565: hypothetical protein +FIG00897565 FIG00897567: hypothetical protein +FIG00897567 FIG00897568: hypothetical protein +FIG00897568 FIG00897569: hypothetical protein +FIG00897571 FIG00897572: hypothetical protein +FIG00897572 FrrB +FIG00897573 FIG00897575: hypothetical protein +FIG00897575 FIG00897576: hypothetical protein +FIG00897577 putative membrane-associated phospholipid phosphatase +FIG00897578 FIG00897581: hypothetical protein +FIG00897582 FIG00897584: hypothetical protein +FIG00897590 FIG00897591: hypothetical protein +FIG00897594 FIG00897596: hypothetical protein +FIG00897597 FIG00897598: hypothetical protein +FIG00897599 FIG00897600: hypothetical protein +FIG00897606 FIG00897607: hypothetical protein +FIG00897607 FIG00897609: hypothetical protein +FIG00897609 FIG00897612: hypothetical protein +FIG00897618 FIG00897619: hypothetical protein +FIG00897619 FIG00897622: hypothetical protein +FIG00897622 Similar to conjugative transposon protein TraH +FIG00897624 FIG00897625: hypothetical protein +FIG00897626 FIG00897627: hypothetical protein +FIG00897627 FIG00897629: hypothetical protein +FIG00897629 FIG00897632: hypothetical protein +FIG00897632 anti-FecI sigma factor, FecR +FIG00897637 FIG00897638: hypothetical protein +FIG00897640 FIG00897641: hypothetical protein +FIG00897641 FIG00897642: hypothetical protein +FIG00897642 putative two-component system sensor protein, no kinase domain +FIG00897643 FIG00897645: hypothetical protein +FIG00897648 FIG00897649: hypothetical protein +FIG00897651 putative ABC transporter permease component +FIG00897657 FIG00897658: hypothetical protein +FIG00897658 FIG00897662: hypothetical protein +FIG00897663 FIG00897664: hypothetical protein +FIG00897664 FIG00897665: hypothetical protein +FIG00897665 FIG00897667: hypothetical protein +FIG00897670 FIG00897671: hypothetical protein +FIG00897671 FIG00897673: hypothetical protein +FIG00897676 FIG00897677: hypothetical protein +FIG00897678 FIG00897683: hypothetical protein +FIG00897684 FIG00897685: hypothetical protein +FIG00897688 Ferritin (EC 1.16.3.1) +FIG00897689 FIG00897691: hypothetical protein +FIG00897695 FIG00897696: hypothetical protein +FIG00897703 FIG00897705: hypothetical protein +FIG00897709 FIG00897712: hypothetical protein +FIG00897713 Fe-S OXIDOREDUCTASE (1.8.-.-) +FIG00897714 FIG00897715: hypothetical protein +FIG00897723 FIG00897725: hypothetical protein +FIG00897727 FIG00897728: hypothetical protein +FIG00897728 FIG00897729: hypothetical protein +FIG00897733 FIG00897734: hypothetical protein +FIG00897735 FIG00897737: hypothetical protein +FIG00897737 FIG00897738: hypothetical protein +FIG00897738 FIG00897739: hypothetical protein +FIG00897743 FIG00897744: hypothetical protein +FIG00897746 FIG00897747: hypothetical protein +FIG00897749 FIG00897750: hypothetical protein +FIG00897750 FIG00897751: hypothetical protein +FIG00897753 FIG00897755: hypothetical protein +FIG00897758 FIG00897759: hypothetical protein +FIG00897760 FIG00897761: hypothetical protein +FIG00897762 FIG00897763: hypothetical protein +FIG00897765 FIG00897766: hypothetical protein +FIG00897766 FIG00897767: hypothetical protein +FIG00897767 FIG00897768: hypothetical protein +FIG00897769 FIG00897771: hypothetical protein +FIG00897771 FIG00897772: hypothetical protein +FIG00897773 FIG00897775: hypothetical protein +FIG00897775 FIG00897776: hypothetical protein +FIG00897785 FIG00897786: hypothetical protein +FIG00897786 FIG00897787: hypothetical protein +FIG00897787 FIG00897788: hypothetical protein +FIG00897789 Probable glucose-fructose oxidoreductase (EC 1.1.99.28) +FIG00897792 FIG00897793: hypothetical protein +FIG00897793 FIG00897794: hypothetical protein +FIG00897796 FIG00897797: hypothetical protein +FIG00897797 Bacterial transferase hexapeptide repeat:ADP-glucose pyrophosphorylase (EC 2.7.7.24) +FIG00897798 FIG00897799: hypothetical protein +FIG00897799 FIG00897800: hypothetical protein +FIG00897801 FIG00897802: hypothetical protein +FIG00897802 FIG00897803: hypothetical protein +FIG00897803 FIG00897805: hypothetical protein +FIG00897818 FIG00897819: hypothetical protein +FIG00897819 FIG00897820: hypothetical protein +FIG00897824 FIG00897826: hypothetical protein +FIG00897829 Bll2647 protein +FIG00897832 FIG00897833: hypothetical protein +FIG00897833 FIG00897834: hypothetical protein +FIG00897834 FIG00899040: hypothetical protein +FIG00897844 FIG00897847: hypothetical protein +FIG00897847 FIG00897849: hypothetical protein +FIG00897849 FIG00897850: hypothetical protein +FIG00897850 FIG00897851: hypothetical protein +FIG00897851 FIG00897854: hypothetical protein +FIG00897858 FIG00897861: hypothetical protein +FIG00897861 FIG00897862: hypothetical protein +FIG00897866 FIG00898920: hypothetical protein +FIG00897867 FIG00897868: hypothetical protein +FIG00897868 FIG00897869: hypothetical protein +FIG00897869 FIG00897871: hypothetical protein +FIG00897871 FIG00897873: hypothetical protein +FIG00897873 Membrane dipeptidase (EC 3.4.13.19) +FIG00897880 FIG00897881: hypothetical protein +FIG00897883 FIG00897884: hypothetical protein +FIG00897884 FIG00897885: hypothetical protein +FIG00897887 FIG00897888: hypothetical protein +FIG00897894 FIG00897895: hypothetical protein +FIG00897896 Transcriptional regulator, AraC family +FIG00897897 FIG00897898: hypothetical protein +FIG00897898 FIG00897899: hypothetical protein +FIG00897900 FIG00897901: hypothetical protein +FIG00897901 FIG00897902: hypothetical protein +FIG00897902 FIG00897903: hypothetical protein +FIG00897905 FIG00897906: hypothetical protein +FIG00897906 FIG00936866: hypothetical protein +FIG00897907 FIG00897908: hypothetical protein +FIG00897915 FIG00897916: hypothetical protein +FIG00897922 FIG00897923: hypothetical protein +FIG00897923 FIG00897927: hypothetical protein +FIG00897927 FIG00897928: hypothetical protein +FIG00897929 Mg(2+) transport ATPase protein C +FIG00897930 FIG00897931: hypothetical protein +FIG00897931 FIG00897933: hypothetical protein +FIG00897933 FIG00897934: hypothetical protein +FIG00897938 FIG00897939: hypothetical protein +FIG00897939 FIG00897940: hypothetical protein +FIG00897941 FIG00897943: hypothetical protein +FIG00897943 FIG00897944: hypothetical protein +FIG00897945 FIG00897947: hypothetical protein +FIG00897947 FIG00897949: hypothetical protein +FIG00897949 FIG00897950: hypothetical protein +FIG00897950 N-acetylgalactosamine-6-sulfatase +FIG00897953 FIG00897954: hypothetical protein +FIG00897959 FIG00897961: hypothetical protein +FIG00897961 FIG00897962: hypothetical protein +FIG00897965 FIG00897967: hypothetical protein +FIG00897973 FIG00897974: hypothetical protein +FIG00897974 FIG00897975: hypothetical protein +FIG00897975 FIG00899222: hypothetical protein +FIG00897977 FIG00897978: hypothetical protein +FIG00897979 FIG00897980: hypothetical protein +FIG00897988 Sensor protein rprX (EC 2.7.13.3) +FIG00897991 FIG00897992: hypothetical protein +FIG00897992 BexA +FIG00897993 FIG00897994: hypothetical protein +FIG00897994 FIG00897995: hypothetical protein +FIG00897995 FIG00897996: hypothetical protein +FIG00898001 FIG00898002: hypothetical protein +FIG00898002 FIG00898003: hypothetical protein +FIG00898003 FIG00898004: hypothetical protein +FIG00898004 FIG00898005: hypothetical protein +FIG00898011 related to competence proteins +FIG00898014 FIG00898015: hypothetical protein +FIG00898018 FIG00898020: hypothetical protein +FIG00898024 FIG00898025: hypothetical protein +FIG00898028 FIG00935947: hypothetical protein +FIG00898030 Capsular polysaccharide biosynthesis protein capD +FIG00898032 FIG00898034: hypothetical protein +FIG00898038 FIG00898040: hypothetical protein +FIG00898041 FIG00898042: hypothetical protein +FIG00898045 FIG00898048: hypothetical protein +FIG00898049 FIG00898050: hypothetical protein +FIG00898055 FIG00898056: hypothetical protein +FIG00898056 FIG00898059: hypothetical protein +FIG00898062 FIG00898063: hypothetical protein +FIG00898078 FIG00898079: hypothetical protein +FIG00898081 FIG00898082: hypothetical protein +FIG00898084 putative surface layer protein, with cytochrome c domain +FIG00898085 FIG00936535: hypothetical protein +FIG00898087 alpha-mannosidase +FIG00898093 endo-1,4-beta-xylanase D precursor +FIG00898094 FIG00898096: hypothetical protein +FIG00898096 FIG00898098: hypothetical protein +FIG00898105 Possible anti-sigma factor +FIG00898108 FIG00898111: hypothetical protein +FIG00898114 FIG00898116: hypothetical protein +FIG00898119 FIG00898120: hypothetical protein +FIG00898121 FIG00898123: hypothetical protein +FIG00898123 FIG00898124: hypothetical protein +FIG00898125 FIG00898127: hypothetical protein +FIG00898127 FIG00898128: hypothetical protein +FIG00898130 FIG00898131: hypothetical protein +FIG00898146 FIG00898149: hypothetical protein +FIG00898152 FIG00898155: hypothetical protein +FIG00898155 FIG00415187: hypothetical protein +FIG00898157 FIG00898160: hypothetical protein +FIG00898162 FIG00898163: hypothetical protein +FIG00898163 FIG00898165: hypothetical protein +FIG00898165 FIG00898166: hypothetical protein +FIG00898169 FIG00898170: hypothetical protein +FIG00898170 putative 7-alpha-hydroxysteroid dehydrogenase +FIG00898171 FIG00898172: hypothetical protein +FIG00898172 FIG00898173: hypothetical protein +FIG00898173 FIG00898174: hypothetical protein +FIG00898174 Endonuclease (EC 3.1.-.-) +FIG00898180 FIG00898713: hypothetical protein +FIG00898183 FIG00898184: hypothetical protein +FIG00898184 FIG00898186: hypothetical protein +FIG00898187 FIG00898188: hypothetical protein +FIG00898197 FIG00898198: hypothetical protein +FIG00898202 FIG00898204: hypothetical protein +FIG00898205 FIG00898206: hypothetical protein +FIG00898209 FIG00899102: hypothetical protein +FIG00898210 FIG00898211: hypothetical protein +FIG00898212 FIG00898213: hypothetical protein +FIG00898214 FIG00898215: hypothetical protein +FIG00898216 FIG00898218: hypothetical protein +FIG00898226 Beta-glucosidase +FIG00898228 FIG00898230: hypothetical protein +FIG00898230 putative outer membrane protein precursor +FIG00898236 FIG00898237: hypothetical protein +FIG00898237 FIG00898239: hypothetical protein +FIG00898244 FIG00898246: hypothetical protein +FIG00898246 FIG00898247: hypothetical protein +FIG00898251 FIG00898253: hypothetical protein +FIG00898258 FIG00898259: hypothetical protein +FIG00898259 FIG00898261: hypothetical protein +FIG00898261 putative cell wall endopeptidase family protein +FIG00898270 FIG00898271: hypothetical protein +FIG00898277 FIG00898278: hypothetical protein +FIG00898293 putative two-component system sensor but no kinase domain +FIG00898297 Serine/threonine kinase with two-component sensor domain +FIG00898299 FIG00898302: hypothetical protein +FIG00898302 FIG00898303: hypothetical protein +FIG00898306 FIG00898307: hypothetical protein +FIG00898307 FIG00898308: hypothetical protein +FIG00898309 FIG00898310: hypothetical protein +FIG00898313 Bll2637 protein +FIG00898315 FIG00898316: hypothetical protein +FIG00898316 FIG00898317: hypothetical protein +FIG00898322 putative hemagglutinin +FIG00898323 FIG00898324: hypothetical protein +FIG00898324 FIG00898328: hypothetical protein +FIG00898331 FIG00898332: hypothetical protein +FIG00898332 FIG00898333: hypothetical protein +FIG00898333 FIG00898334: hypothetical protein +FIG00898334 FIG00898336: hypothetical protein +FIG00898340 p5482_19 +FIG00898343 FIG00898344: hypothetical protein +FIG00898346 FIG00898348: hypothetical protein +FIG00898348 FIG00898349: hypothetical protein +FIG00898349 FIG00898352: hypothetical protein +FIG00898356 FIG00898357: hypothetical protein +FIG00898357 putative two-component system sensor protein histidine kinase +FIG00898366 FIG00898367: hypothetical protein +FIG00898367 FIG00898370: hypothetical protein +FIG00898373 FIG00898374: hypothetical protein +FIG00898374 FIG00898378: hypothetical protein +FIG00898379 FIG00898380: hypothetical protein +FIG00898380 FIG00936036: hypothetical protein +FIG00898381 FIG00898382: hypothetical protein +FIG00898382 conserved hypothetical protein, putative iron uptake factor +FIG00898386 FIG00898388: hypothetical protein +FIG00898388 FIG00898393: hypothetical protein +FIG00898396 FIG00898398: hypothetical protein +FIG00898399 FIG00898400: hypothetical protein +FIG00898405 FIG00898406: hypothetical protein +FIG00898410 FIG00898411: hypothetical protein +FIG00898411 FIG00898413: hypothetical protein +FIG00898414 FIG00898415: hypothetical protein +FIG00898415 FIG00898417: hypothetical protein +FIG00898418 FIG00898420: hypothetical protein +FIG00898425 FIG00898427: hypothetical protein +FIG00898427 FIG00898428: hypothetical protein +FIG00898430 FIG00898434: hypothetical protein +FIG00898436 FIG00898438: hypothetical protein +FIG00898438 FIG00898441: hypothetical protein +FIG00898443 FIG00898445: hypothetical protein +FIG00898445 FIG00898446: hypothetical protein +FIG00898453 FIG00898454: hypothetical protein +FIG00898454 FIG00898457: hypothetical protein +FIG00898459 FIG00898460: hypothetical protein +FIG00898462 two-component system sensor histidine kinase/response regulator, hybrid +FIG00898463 FIG00898464: hypothetical protein +FIG00898466 FIG00898469: hypothetical protein +FIG00898477 FIG00898480: hypothetical protein +FIG00898489 FIG00898490: hypothetical protein +FIG00898490 FIG00898491: hypothetical protein +FIG00898495 FIG00898496: hypothetical protein +FIG00898504 FIG00898505: hypothetical protein +FIG00898506 FIG00898507: hypothetical protein +FIG00898507 FIG00898509: hypothetical protein +FIG00898510 FIG00898511: hypothetical protein +FIG00898515 FIG00898516: hypothetical protein +FIG00898518 FIG00898519: hypothetical protein +FIG00898519 adenylate cyclase; Cya3, putative +FIG00898527 FIG00898528: hypothetical protein +FIG00898533 FIG00898534: hypothetical protein +FIG00898535 FIG00898536: hypothetical protein +FIG00898540 FIG00898541: hypothetical protein +FIG00898543 FIG00898544: hypothetical protein +FIG00898544 putative DNA methylase +FIG00898545 FIG00898546: hypothetical protein +FIG00898555 FIG00898556: hypothetical protein +FIG00898558 FIG00898560: hypothetical protein +FIG00898560 FIG00898561: hypothetical protein +FIG00898561 FIG00898562: hypothetical protein +FIG00898562 FIG00898563: hypothetical protein +FIG00898570 FIG01018870: hypothetical protein +FIG00898574 Uncharacterized protein MJ0298 +FIG00898576 FIG00898577: hypothetical protein +FIG00898580 FIG00898581: hypothetical protein +FIG00898584 FIG00899384: hypothetical protein +FIG00898586 FIG00898589: hypothetical protein +FIG00898590 FIG00898591: hypothetical protein +FIG00898591 FIG00898592: hypothetical protein +FIG00898592 FIG00898594: hypothetical protein +FIG00898594 FIG00898597: hypothetical protein +FIG00898597 FIG00898600: hypothetical protein +FIG00898603 UDP-N-acetylmuramate--L-alanine ligase (EC 6.3.2.8) (UDP-N-acetylmuramoyl-L-alanine synthetase) +FIG00898604 FIG00898607: hypothetical protein +FIG00898607 FIG00898609: hypothetical protein +FIG00898609 FIG00898612: hypothetical protein +FIG00898613 FIG00898614: hypothetical protein +FIG00898614 FIG00898615: hypothetical protein +FIG00898617 FIG00898619: hypothetical protein +FIG00898619 FIG00898620: hypothetical protein +FIG00898620 FIG00898621: hypothetical protein +FIG00898631 FIG00898632: hypothetical protein +FIG00898633 FIG00898634: hypothetical protein +FIG00898643 FIG00898644: hypothetical protein +FIG00898644 Transglycosylase +FIG00898650 FIG00898651: hypothetical protein +FIG00898655 FIG00898657: hypothetical protein +FIG00898657 putative fimbrilin precursor +FIG00898671 FIG00898674: hypothetical protein +FIG00898681 FIG00898683: hypothetical protein +FIG00898692 Membrane dipeptidase precursor (EC 3.4.13.19) +FIG00898701 FIG00898702: hypothetical protein +FIG00898704 FIG00898705: hypothetical protein +FIG00898705 FIG00898706: hypothetical protein +FIG00898715 FIG00898716: hypothetical protein +FIG00898720 FIG00898721: hypothetical protein +FIG00898726 FIG00898728: hypothetical protein +FIG00898728 FIG00898729: hypothetical protein +FIG00898730 FIG00898733: hypothetical protein +FIG00898733 ABC transporter, ATP-binding protein-related protein +FIG00898737 FIG00898740: hypothetical protein +FIG00898744 FIG00898745: hypothetical protein +FIG00898747 FIG00898748: hypothetical protein +FIG00898749 FIG00898752: hypothetical protein +FIG00898753 FIG00898754: hypothetical protein +FIG00898754 FIG00898757: hypothetical protein +FIG00898757 FIG00898758: hypothetical protein +FIG00898763 FIG00898764: hypothetical protein +FIG00898768 FIG00898772: hypothetical protein +FIG00898776 FIG00898779: hypothetical protein +FIG00898779 FIG00898784: hypothetical protein +FIG00898785 FIG00898786: hypothetical protein +FIG00898786 FIG00898787: hypothetical protein +FIG00898787 FIG00898788: hypothetical protein +FIG00898791 FIG00898792: hypothetical protein +FIG00898792 putative acetylhydrolase +FIG00898796 FIG00898797: hypothetical protein +FIG00898799 FIG00898800: hypothetical protein +FIG00898801 FIG00898802: hypothetical protein +FIG00898813 FIG00898814: hypothetical protein +FIG00898819 FIG00898821: hypothetical protein +FIG00898821 FIG00898822: hypothetical protein +FIG00898823 FIG00898824: hypothetical protein +FIG00898827 FIG00898829: hypothetical protein +FIG00898829 FIG00898830: hypothetical protein +FIG00898831 FIG00898832: hypothetical protein +FIG00898834 Membrane fusion efflux protein +FIG00898843 FIG00898844: hypothetical protein +FIG00898844 FIG00898845: hypothetical protein +FIG00898845 FIG00898846: hypothetical protein +FIG00898853 Probable multidrug resistance protein norM +FIG00898860 FIG00898861: hypothetical protein +FIG00898863 FIG00899404: hypothetical protein +FIG00898867 two-component system response regulator protein +FIG00898870 FIG00898871: hypothetical protein +FIG00898885 FIG00898886: hypothetical protein +FIG00898886 FIG00898888: hypothetical protein +FIG00898897 FIG00898898: hypothetical protein +FIG00898898 FIG00403252: hypothetical protein +FIG00898908 Acetylhydrolase +FIG00898909 FIG00898910: hypothetical protein +FIG00898912 FIG00898913: hypothetical protein +FIG00898923 FIG00898926: hypothetical protein +FIG00898926 FIG00898928: hypothetical protein +FIG00898928 FIG00898929: hypothetical protein +FIG00898932 FIG00898933: hypothetical protein +FIG00898939 FIG00898945: hypothetical protein +FIG00898946 FIG00935602: hypothetical protein +FIG00898948 oxidoreductase, FAD-binding, putative +FIG00898950 FIG00898956: hypothetical protein +FIG00898956 FIG00898958: hypothetical protein +FIG00898963 FIG00898968: hypothetical protein +FIG00898969 FIG00898971: hypothetical protein +FIG00898972 FIG00898974: hypothetical protein +FIG00898974 protein of unknown function DUF262 +FIG00898975 FIG00898976: hypothetical protein +FIG00898984 FIG00898986: hypothetical protein +FIG00898987 FIG00898989: hypothetical protein +FIG00898995 capA protein, putative +FIG00898998 FIG00898999: hypothetical protein +FIG00899000 FIG00899001: hypothetical protein +FIG00899001 FIG00899002: hypothetical protein +FIG00899002 FIG00899003: hypothetical protein +FIG00899003 FIG00899004: hypothetical protein +FIG00899006 FIG00899008: hypothetical protein +FIG00899008 FIG00899009: hypothetical protein +FIG00899011 FIG00899012: hypothetical protein +FIG00899015 FIG00899016: hypothetical protein +FIG00899021 FIG00899022: hypothetical protein +FIG00899022 FIG00899023: hypothetical protein +FIG00899023 FIG00899024: hypothetical protein +FIG00899026 FIG00899028: hypothetical protein +FIG00899030 FIG00899032: hypothetical protein +FIG00899033 FIG00899034: hypothetical protein +FIG00899034 FIG00899035: hypothetical protein +FIG00899044 FIG00899046: hypothetical protein +FIG00899046 BexA, membrane protein +FIG00899049 FIG00899054: hypothetical protein +FIG00899055 FIG00405865: hypothetical protein +FIG00899056 FIG00899057: hypothetical protein +FIG00899057 FIG00899059: hypothetical protein +FIG00899059 FIG00899060: hypothetical protein +FIG00899060 3-oxo-5-alpha-steroid 4-dehydrogenase +FIG00899065 Outer membrane efflux protein precursor +FIG00899066 FIG00899068: hypothetical protein +FIG00899068 FIG00899069: hypothetical protein +FIG00899069 FIG00899072: hypothetical protein +FIG00899083 FIG00899085: hypothetical protein +FIG00899085 FIG00899086: hypothetical protein +FIG00899091 FIG00899092: hypothetical protein +FIG00899094 FIG00899096: hypothetical protein +FIG00899102 FIG00899104: hypothetical protein +FIG00899108 FIG00899109: hypothetical protein +FIG00899110 FIG00936660: hypothetical protein +FIG00899116 FIG00899119: hypothetical protein +FIG00899119 FIG00899122: hypothetical protein +FIG00899125 ABC-type transport, permease protein +FIG00899130 FIG00899133: hypothetical protein +FIG00899139 FIG00899140: hypothetical protein +FIG00899140 FIG00899141: hypothetical protein +FIG00899142 FIG00899144: hypothetical protein +FIG00899144 FIG00899145: hypothetical protein +FIG00899145 FIG00899146: hypothetical protein +FIG00899149 FIG00899150: hypothetical protein +FIG00899162 FIG00899163: hypothetical protein +FIG00899163 FIG00899164: hypothetical protein +FIG00899166 FIG00899170: hypothetical protein +FIG00899171 FIG00899174: hypothetical protein +FIG00899174 FIG00899176: hypothetical protein +FIG00899176 FIG00899178: hypothetical protein +FIG00899179 FIG00899180: hypothetical protein +FIG00899180 putative DNA primase +FIG00899184 FIG00899185: hypothetical protein +FIG00899185 serine type site-specific recombinase +FIG00899186 FIG00899187: hypothetical protein +FIG00899187 FIG00899188: hypothetical protein +FIG00899189 FIG00899191: hypothetical protein +FIG00899199 FIG00899205: hypothetical protein +FIG00899227 FIG00899229: hypothetical protein +FIG00899230 FIG00899231: hypothetical protein +FIG00899239 FIG00899240: hypothetical protein +FIG00899241 FIG00899242: hypothetical protein +FIG00899247 FIG00899249: hypothetical protein +FIG00899250 FIG00938698: hypothetical protein +FIG00899251 FIG00417797: hypothetical protein +FIG00899254 FIG00899255: hypothetical protein +FIG00899261 FIG00899262: hypothetical protein +FIG00899262 FIG00899263: hypothetical protein +FIG00899263 FIG00899264: hypothetical protein +FIG00899266 FIG00899267: hypothetical protein +FIG00899267 FIG00899269: hypothetical protein +FIG00899270 FIG00899271: hypothetical protein +FIG00899272 FIG00899273: hypothetical protein +FIG00899281 FIG00899283: hypothetical protein +FIG00899283 FIG00899284: hypothetical protein +FIG00899284 FIG00899285: hypothetical protein +FIG00899292 FIG00899293: hypothetical protein +FIG00899304 FIG00899305: hypothetical protein +FIG00899307 Monofunctional biosynthetic peptidoglycan transglycosylase (EC 2.4.2.-) +FIG00899308 FIG00899309: hypothetical protein +FIG00899312 FIG00899313: hypothetical protein +FIG00899313 FIG00899314: hypothetical protein +FIG00899316 FIG00899317: hypothetical protein +FIG00899317 FIG00899319: hypothetical protein +FIG00899321 FIG00899322: hypothetical protein +FIG00899331 FIG00899332: hypothetical protein +FIG00899335 FIG00404118: hypothetical protein +FIG00899345 hypothetical protein +FIG00899347 putative outer membrane lipoprotein silC precursor +FIG00899352 FIG00899353: hypothetical protein +FIG00899361 FIG00899363: hypothetical protein +FIG00899364 FIG00899365: hypothetical protein +FIG00899366 Beta-lactamase induction signal transducer +FIG00899387 FIG00899389: hypothetical protein +FIG00899400 FIG00899401: hypothetical protein +FIG00899404 FIG00899407: hypothetical protein +FIG00899409 Dihydroneopterin triphosphate pyrophosphohydolase / Dihydroneopterin aldolase (EC 4.1.2.25) +FIG00899411 phosphohydrolase +FIG00899413 FIG00899414: hypothetical protein +FIG00899415 FIG00899417: hypothetical protein +FIG00899417 FIG00899422: hypothetical protein +FIG00899422 Type III secretion inner membrane protein SctR +FIG00899426 FIG00899427: hypothetical protein +FIG00899434 FIG00899436: hypothetical protein +FIG00899440 putative batE protein +FIG00899443 Type III secretion protein SctJ +FIG00899445 FIG00899446: hypothetical protein +FIG00899446 FIG00899448: hypothetical protein +FIG00899448 FIG00899449: hypothetical protein +FIG00899449 FIG00899450: hypothetical protein +FIG00899457 FIG00899458: hypothetical protein +FIG00899461 FIG00899462: hypothetical protein +FIG00899462 Type III secretion translocase SctL +FIG00899463 FIG00899465: hypothetical protein +FIG00899467 FIG00899468: hypothetical protein +FIG00899468 FIG00899469: hypothetical protein +FIG00899471 putative dolichol-phosphate mannosyltransferase +FIG00899477 Type III secretion inner membrane protein SctT +FIG00899487 SWIB/MDM2 domain-containing proteins +FIG00899491 putative mip (macrophage infectivity potentiator, fkbp-type peptidyl-prolyl cis-trans isomerase) +FIG00899497 probable type III secretion inner membrane protein SctS +FIG00899502 FIG00899503: hypothetical protein +FIG00899503 putative glpG protein +FIG00899506 FIG00899507: hypothetical protein +FIG00899507 FIG00899508: hypothetical protein +FIG00899510 FIG00899511: hypothetical protein +FIG00899511 FIG00899512: hypothetical protein +FIG00899516 FIG00899519: hypothetical protein +FIG00899522 FIG00899523: hypothetical protein +FIG00899523 Low Calcium Response D (Type III secretion inner membrane protein SctV) +FIG00899524 Methylamine utilization protein mauF +FIG00899574 FIG00899575: hypothetical protein +FIG00899590 FIG00899591: hypothetical protein +FIG00899603 resolvase helix-turn-helix domain protein +FIG00899698 Mll4127 protein +FIG00899708 FIG00899709: hypothetical protein +FIG00899731 FIG00899739: hypothetical protein +FIG00899812 FIG00899817: hypothetical protein +FIG00899823 Putative MFS Superfamily sugar transporter +FIG00899833 Phenylacetic acid catabolic protein +FIG00899855 FIG00899859: hypothetical protein +FIG00899896 protein of unknown function DUF1234 +FIG00899908 FIG00987679: hypothetical protein +FIG00899916 FIG00899917: hypothetical protein +FIG00899936 Arc domain protein DNA binding domain protein +FIG00899944 FIG00899948: hypothetical protein +FIG00899999 FIG00900003: hypothetical protein +FIG00900040 GcrA cell cycle regulator +FIG00900047 Replication protein C +FIG00900067 FIG00900072: hypothetical protein +FIG00900072 FIG00900075: hypothetical protein +FIG00900079 FIG00900080: hypothetical protein +FIG00900191 FIG00988655: hypothetical protein +FIG00900219 MltA-interacting MipA family protein +FIG00900224 MORN repeat protein +FIG00900241 FIG00900244: hypothetical protein +FIG00900250 FIG00987535: hypothetical protein +FIG00900297 putative flavodoxin monooxygenase +FIG00900357 FIG00900359: hypothetical protein +FIG00900359 FIG00900360: hypothetical protein +FIG00900382 Exopolysaccharide biosynthesis domain protein +FIG00900417 FIG00900422: hypothetical protein +FIG00900429 penicillin amidase [EC:3.5.1.11] +FIG00900471 FIG00900475: hypothetical protein +FIG00900481 Transcriptional regulator associated with utilization of aromatics, LysR family +FIG00900515 FIG00900516: hypothetical protein +FIG00900587 FIG00900589: hypothetical protein +FIG00900695 Quinohemoprotein amine dehydrogenase alpha subunit (EC 1.4.99.-) +FIG00900700 putative transport protein transmembrane +FIG00900759 Putative outer membrane efflux protein +FIG00900788 FIG00900795: hypothetical protein +FIG00900823 FIG00900825: hypothetical protein +FIG00900856 Antifreeze protein, type I +FIG00900896 FIG00991902: hypothetical protein +FIG00900902 FIG00900904: hypothetical protein +FIG00901010 FIG00901011: hypothetical protein +FIG00901026 FIG00901028: hypothetical protein +FIG00901087 FIG00993170: hypothetical protein +FIG00901090 FIG00901093: hypothetical protein +FIG00901124 ATP-binding component of transport system +FIG00901176 Isochorismate pyruvate-lyase +FIG00901208 FIG00901213: hypothetical protein +FIG00901217 FIG00901223: hypothetical protein +FIG00901255 Mll6424 protein +FIG00901274 Mll7563 protein +FIG00901291 FIG00901292: hypothetical protein +FIG00901316 Bll0575 protein +FIG00901433 FIG00901434: hypothetical protein +FIG00901510 FIG00901513: hypothetical protein +FIG00901518 FIG00901522: hypothetical protein +FIG00901628 Hypothetical protein in Rubrerythrin cluster +FIG00901688 Mlr8397 protein +FIG00901701 FIG00909566: hypothetical protein +FIG00901800 FIG00901801: hypothetical protein +FIG00901867 ABC-type multidrug transport system, permease component +FIG00901880 Outer membrane autotransporter barrel precursor +FIG00901888 FIG00901899: hypothetical protein +FIG00901946 Mll3781 protein +FIG00901949 putative M20/M25/M40 family peptidase +FIG00902106 FIG00902108: hypothetical protein +FIG00902246 Mll0231 protein +FIG00902351 Flavin-binding family monooxygenase +FIG00902657 FIG01006409: hypothetical protein +FIG00902709 Amidohydrolase-like protein +FIG00902753 Mlr5066 protein +FIG00902764 FIG00902775: hypothetical protein +FIG00902775 FIG00902776: hypothetical protein +FIG00902776 FIG00902777: hypothetical protein +FIG00902777 Gll0312 protein +FIG00902782 FIG00902784: hypothetical protein +FIG00902786 FIG00902795: hypothetical protein +FIG00902795 FIG00902797: hypothetical protein +FIG00902810 Transcriptional regulator PecS +FIG00902813 FIG00902815: hypothetical protein +FIG00902824 FIG00902825: hypothetical protein +FIG00902827 Mlr4100 protein +FIG00902837 Mlr7432 protein +FIG00902872 FIG00902878: hypothetical protein +FIG00902887 FIG00902888: hypothetical protein +FIG00902906 FIG00902917: hypothetical protein +FIG00902917 FIG00902925: hypothetical protein +FIG00902925 FIG00902927: hypothetical protein +FIG00902927 FIG00902934: hypothetical protein +FIG00902934 FIG00902942: hypothetical protein +FIG00902942 FIG00902945: hypothetical protein +FIG00902945 FIG00902952: hypothetical protein +FIG00902953 FIG00902956: hypothetical protein +FIG00902959 FIG00902960: hypothetical protein +FIG00902960 2-nitropropane dioxygenase family protein +FIG00902967 FIG00902968: hypothetical protein +FIG00902968 FIG00902971: hypothetical protein +FIG00902972 FIG00902975: hypothetical protein +FIG00902975 FIG00902976: hypothetical protein +FIG00902988 FIG00902993: hypothetical protein +FIG00902996 FIG00903001: hypothetical protein +FIG00903005 FIG00903008: hypothetical protein +FIG00903008 FIG00903013: hypothetical protein +FIG00903013 FIG00903018: hypothetical protein +FIG00903022 FIG00903029: hypothetical protein +FIG00903036 FIG00903050: hypothetical protein +FIG00903050 FIG00903051: hypothetical protein +FIG00903053 FIG00903061: hypothetical protein +FIG00903070 FIG00903073: hypothetical protein +FIG00903073 FIG00903074: hypothetical protein +FIG00903079 FIG00903089: hypothetical protein +FIG00903096 FIG00903101: hypothetical protein +FIG00903101 FIG00903102: hypothetical protein +FIG00903102 FIG00903104: hypothetical protein +FIG00903104 FIG00903107: hypothetical protein +FIG00903107 FIG00903113: hypothetical protein +FIG00903113 methyl-accepting chemotaxis protein McpD +FIG00903140 FIG00903142: hypothetical protein +FIG00903142 FIG00903143: hypothetical protein +FIG00903148 FIG00903150: hypothetical protein +FIG00903150 FIG00903152: hypothetical protein +FIG00903152 FIG00903156: hypothetical protein +FIG00903162 FIG00903168: hypothetical protein +FIG00903168 type IIS restriction enzyme [EC:3.1.21.4 2.1.1.72] +FIG00903174 FIG00903176: hypothetical protein +FIG00903178 FIG00903186: hypothetical protein +FIG00903186 FIG00903191: hypothetical protein +FIG00903199 Mechanosensitive (MS) ion channel +FIG00903209 FIG00903217: hypothetical protein +FIG00903224 FIG00903228: hypothetical protein +FIG00903228 FIG00903232: hypothetical protein +FIG00903250 FIG00903253: hypothetical protein +FIG00903263 FIG00903271: hypothetical protein +FIG00903273 FIG00903276: hypothetical protein +FIG00903282 FIG00903283: hypothetical protein +FIG00903283 FIG00903287: hypothetical protein +FIG00903287 Uncharacterized protein jhp_0259 +FIG00903291 FIG00903293: hypothetical protein +FIG00903293 Bll5364 protein +FIG00903300 FIG00903301: hypothetical protein +FIG00903317 FIG00903319: hypothetical protein +FIG00903321 FIG00903326: hypothetical protein +FIG00903326 FIG00903331: hypothetical protein +FIG00903364 FIG00903370: hypothetical protein +FIG00903370 FIG00903372: hypothetical protein +FIG00903372 EpsH +FIG00903376 FIG00903384: hypothetical protein +FIG00903384 Localization factor podJL +FIG00903386 FIG00903387: hypothetical protein +FIG00903387 FIG00903389: hypothetical protein +FIG00903389 FIG00903394: hypothetical protein +FIG00903394 FIG00903396: hypothetical protein +FIG00903396 FIG00903398: hypothetical protein +FIG00903398 FIG00903402: hypothetical protein +FIG00903405 FIG00903416: hypothetical protein +FIG00903416 FIG00903417: hypothetical protein +FIG00903417 Gll1302 protein +FIG00903423 FIG00903428: hypothetical protein +FIG00903428 FIG00903429: hypothetical protein +FIG00903429 Bll7924 protein +FIG00903431 FIG00903440: hypothetical protein +FIG00903440 FIG00903457: hypothetical protein +FIG00903462 FIG00903466: hypothetical protein +FIG00903466 Mll0178 protein +FIG00903494 FIG00903496: hypothetical protein +FIG00903496 FIG00903497: hypothetical protein +FIG00903497 FIG00903499: hypothetical protein +FIG00903501 FIG00903502: hypothetical protein +FIG00903505 FIG00903513: hypothetical protein +FIG00903525 FIG00903527: hypothetical protein +FIG00903531 FIG00903535: hypothetical protein +FIG00903535 FIG00903539: hypothetical protein +FIG00903539 FIG00903546: hypothetical protein +FIG00903547 FIG00903552: hypothetical protein +FIG00903556 Bll4107 protein +FIG00903564 FIG00903567: hypothetical protein +FIG00903567 FIG00903573: hypothetical protein +FIG00903576 FIG00903577: hypothetical protein +FIG00903577 FIG00903579: hypothetical protein +FIG00903580 FIG00903583: hypothetical protein +FIG00903583 FIG00903586: hypothetical protein +FIG00903586 FIG00903587: hypothetical protein +FIG00903589 FIG00903601: hypothetical protein +FIG00903623 FIG00903627: hypothetical protein +FIG00903627 FIG00903640: hypothetical protein +FIG00903640 FIG00903642: hypothetical protein +FIG00903643 FIG00903648: hypothetical protein +FIG00903648 Msr6186 protein +FIG00903653 FIG00903658: hypothetical protein +FIG00903658 FIG00903660: hypothetical protein +FIG00903664 FIG00903670: hypothetical protein +FIG00903670 RsaD +FIG00903673 FIG00903674: hypothetical protein +FIG00903677 FIG00903681: hypothetical protein +FIG00903685 FIG00903686: hypothetical protein +FIG00903690 FIG00903698: hypothetical protein +FIG00903698 FIG00903704: hypothetical protein +FIG00903716 FIG00903725: hypothetical protein +FIG00903727 FIG00903733: hypothetical protein +FIG00903737 Mlr6204 protein +FIG00903746 FIG00903747: hypothetical protein +FIG00903755 FIG00903757: hypothetical protein +FIG00903765 FIG00903768: hypothetical protein +FIG00903768 FIG00903775: hypothetical protein +FIG00903777 FIG00903782: hypothetical protein +FIG00903785 FIG00903789: hypothetical protein +FIG00903793 FIG00903806: hypothetical protein +FIG00903806 FIG00903808: hypothetical protein +FIG00903822 FIG00903824: hypothetical protein +FIG00903824 FIG00903827: hypothetical protein +FIG00903828 FIG00903835: hypothetical protein +FIG00903835 FIG00903846: hypothetical protein +FIG00903846 FIG00903847: hypothetical protein +FIG00903847 FIG00903848: hypothetical protein +FIG00903853 FIG00903854: hypothetical protein +FIG00903854 Prepilin peptidase (EC 3.4.23.43) +FIG00903872 FIG00903873: hypothetical protein +FIG00903873 FIG00903875: hypothetical protein +FIG00903877 FIG00903878: hypothetical protein +FIG00903878 FIG00903880: hypothetical protein +FIG00903880 FIG00903881: hypothetical protein +FIG00903911 putative ATP-dependent protease +FIG00903925 FIG00903928: hypothetical protein +FIG00903928 FIG00903930: hypothetical protein +FIG00903930 Fumarylacetoacetate (FAA) hydrolase( EC:5.3.3.10 ) +FIG00903931 GTN reductase +FIG00903937 FIG00903938: hypothetical protein +FIG00903938 FIG00903941: hypothetical protein +FIG00903941 FIG00903945: hypothetical protein +FIG00903949 FIG00903952: hypothetical protein +FIG00903952 FIG00903955: hypothetical protein +FIG00903966 FIG00903969: hypothetical protein +FIG00903977 Cell envelope opacity-associated protein A +FIG00903983 Leader peptidase (Prepilin peptidase) (EC 3.4.23.43) / N-methyltransferase (EC 2.1.1.-) +FIG00903987 FIG00903988: hypothetical protein +FIG00903990 UPF0266 membrane protein YobD +FIG00903993 FIG00903995: hypothetical protein +FIG00903997 FIG00904000: hypothetical protein +FIG00904003 FIG00904006: hypothetical protein +FIG00904018 Uncharacterized protein PM1082 +FIG00904022 PlpE +FIG00904025 Anaerobic C4-dicarboxylate membrane transporter DcuA +FIG00904029 FIG00904031: hypothetical protein +FIG00904031 FIG00904032: hypothetical protein +FIG00904032 FIG00904039: hypothetical protein +FIG00904041 FIG00904047: hypothetical protein +FIG00904047 FIG00904049: hypothetical protein +FIG00904049 FIG00904054: hypothetical protein +FIG00904054 FIG00904058: hypothetical protein +FIG00904058 FIG00904059: hypothetical protein +FIG00904061 FIG00904064: hypothetical protein +FIG00904064 FIG00904067: hypothetical protein +FIG00904071 FIG00904074: hypothetical protein +FIG00904093 FIG00904095: hypothetical protein +FIG00904111 FIG00904112: hypothetical protein +FIG00904115 PfkB family carbohydrate kinase Z5686, in cluster with transporter and aldolase +FIG00904123 FIG00904125: hypothetical protein +FIG00904125 FIG00904129: hypothetical protein +FIG00904132 FIG00904133: hypothetical protein +FIG00904147 FIG00904150: hypothetical protein +FIG00904153 FIG00904157: hypothetical protein +FIG00904166 FIG00904168: hypothetical protein +FIG00904171 FIG00904179: hypothetical protein +FIG00904189 FIG00904191: hypothetical protein +FIG00904192 FIG00904193: hypothetical protein +FIG00904193 FIG00904194: hypothetical protein +FIG00904210 FIG00904212: hypothetical protein +FIG00904221 Uncharacterized protein PM0157 precursor +FIG00904226 FIG00904228: hypothetical protein +FIG00904228 FIG00904229: hypothetical protein +FIG00904234 FIG00904239: hypothetical protein +FIG00904244 FIG00904247: hypothetical protein +FIG00904252 Uncharacterized protein PM0758 +FIG00904265 FIG00904266: hypothetical protein +FIG00904270 FIG00904274: hypothetical protein +FIG00904274 FIG00904275: hypothetical protein +FIG00904275 Uncharacterized protein PM1095 +FIG00904278 FIG00904279: hypothetical protein +FIG00904279 FIG00904280: hypothetical protein +FIG00904280 FIG00904286: hypothetical protein +FIG00904286 Uncharacterized protein PM1189 +FIG00904302 Opa +FIG00904304 Uncharacterized protein PM1775 +FIG00904313 OmpH +FIG00904317 FIG00904318: hypothetical protein +FIG00904318 tryptophan-specific transport protein +FIG00904325 IbeB +FIG00904326 Uncharacterized protein PM1780 +FIG00904341 FIG00904342: hypothetical protein +FIG00904342 FIG00904346: hypothetical protein +FIG00904346 FIG00904359: hypothetical protein +FIG00904362 FIG00904364: hypothetical protein +FIG00904365 FIG00904366: hypothetical protein +FIG00904375 FIG00904377: hypothetical protein +FIG00904385 FIG00904387: hypothetical protein +FIG00904388 Uncharacterized protein PM1773 +FIG00904391 FIG00904394: hypothetical protein +FIG00904418 FIG00904421: hypothetical protein +FIG00904431 Uncharacterized lipoprotein PM1897 precursor +FIG00904440 Delta 5 fatty acid desaturase +FIG00904448 FIG00904449: hypothetical protein +FIG00904451 FIG00904452: hypothetical protein +FIG00904455 FIG00904457: hypothetical protein +FIG00904462 FIG00904466: hypothetical protein +FIG00904469 FIG00904470: hypothetical protein +FIG00904471 FIG00904474: hypothetical protein +FIG00904478 Probable oxidoreductase ydfG (EC 1.-.-.-) +FIG00904480 N-acetyl-D-glucosamine kinase (EC 2.7.1.59) +FIG00904482 Endoglucanase precursor (EC 3.2.1.4) +FIG00904483 FIG00904484: hypothetical protein +FIG00904486 FIG00904487: hypothetical protein +FIG00904494 entericidin A precursor +FIG00904495 FIG00904496: hypothetical protein +FIG00904496 FIG00904498: hypothetical protein +FIG00904498 Putative rpiR-family transcriptional regulatory protein +FIG00904504 FIG00904507: hypothetical protein +FIG00904510 Mandelate racemase (EC 5.1.2.2) +FIG00904516 Linoleoyl-CoA desaturase (EC 1.14.19.3) +FIG00904517 FIG00904518: hypothetical protein +FIG00904518 FIG074102: hypothetical protein +FIG00904526 FIG00904528: hypothetical protein +FIG00904529 putative iron ABC transporter, priplasmic binding protein +FIG00904532 Pectinesterase precursor (EC 3.1.1.11) +FIG00904534 FIG00904536: hypothetical protein +FIG00904538 Protein sprT +FIG00904540 YaaH protein +FIG00904542 FIG00613412: hypothetical protein +FIG00904544 FIG00904545: hypothetical protein +FIG00904545 methylated-DNA--protein-cysteine methyltransferase-related protein +FIG00904546 FIG00904547: hypothetical protein +FIG00904558 FIG00904559: hypothetical protein +FIG00904562 FIG00904564: hypothetical protein +FIG00904565 putative Type IV pilus nucleotide-binding protein +FIG00904567 FIG00904568: hypothetical protein +FIG00904571 FIG00904572: hypothetical protein +FIG00904572 FIG002337: predicted inner membrane protein +FIG00904581 FIG00904582: hypothetical protein +FIG00904582 FIG00904583: hypothetical protein +FIG00904584 FIG00904585: hypothetical protein +FIG00904587 FIG00613597: hypothetical protein +FIG00904588 FIG00904589: hypothetical protein +FIG00904603 FIG00904604: hypothetical protein +FIG00904604 probable exported protein YPO4070 +FIG00904605 FIG00904606: hypothetical protein +FIG00904612 FIG00904613: hypothetical protein +FIG00904613 FIG00904614: hypothetical protein +FIG00904614 FIG00904616: hypothetical protein +FIG00904624 Putative ECA polymerase +FIG00904627 GNAT family acetyltransferase YiiD potentially involved in tRNA processing +FIG00904637 FIG00904640: hypothetical protein +FIG00904655 Similar to ABC transporter: eg YBJZ_ECOLI hypothetical ABC transporter +FIG00904660 FIG00904662: hypothetical protein +FIG00904669 FIG00904670: hypothetical protein +FIG00904671 putative avirulence protein +FIG00904683 probable amino-acid ABC transporter permease protein +FIG00904690 FIG00904692: hypothetical protein +FIG00904694 global regulatory protein +FIG00904697 Putative short chain oxidoreductase +FIG00904699 Possible AEC family malate permease +FIG00904700 FIG00904702: hypothetical protein +FIG00904702 FIG00904705: hypothetical protein +FIG00904715 Regulator of L-galactonate catabolism YjjM +FIG00904717 Putative amidase +FIG00904718 Outer membrane receptor proteins, likely involved in siderophore uptake +FIG00904719 FIG00904721: hypothetical protein +FIG00904726 periplasmic binding protein precursor +FIG00904727 FIG00904729: hypothetical protein +FIG00904735 LuxR-family transcriptional regulator +FIG00904745 FIG00904746: hypothetical protein +FIG00904746 FIG00904750: hypothetical protein +FIG00904752 protease inhibitor +FIG00904753 FIG00904754: hypothetical protein +FIG00904754 FIG00904755: hypothetical protein +FIG00904755 FIG00904756: hypothetical protein +FIG00904757 FIG00904758: hypothetical protein +FIG00904761 FIG00613686: hypothetical protein +FIG00904765 FIG00904767: hypothetical protein +FIG00904767 FIG00904768: hypothetical protein +FIG00904769 Peptidase M50 +FIG00904770 Probable membrane-fusion protein +FIG00904773 FIG00904774: hypothetical protein +FIG00904779 FIG00904780: hypothetical protein +FIG00904780 FIG00904781: hypothetical protein +FIG00904785 FIG00904787: hypothetical protein +FIG00904787 FIG004016: Uncharacterized protein YggN +FIG00904790 FIG00904791: hypothetical protein +FIG00904797 FIG00904798: hypothetical protein +FIG00904809 Molybdenum-binding periplasmic protein +FIG00904810 FIG00904812: hypothetical protein +FIG00904815 FIG00904816: hypothetical protein +FIG00904820 FIG00613689: hypothetical protein +FIG00904830 FIG00904831: hypothetical protein +FIG00904831 ABC exporter for hemopore HasA, outer membrane component HasF +FIG00904840 FIG00904844: hypothetical protein +FIG00904846 Putative uncharacterized protein STY4534 (Putative uncharacterized protein) +FIG00904851 FIG00904853: hypothetical protein +FIG00904853 putative SDR family dehydrogenase protein +FIG00904856 FIG00904857: hypothetical protein +FIG00904859 Oxygen-insensitive NADPH nitroreductase (EC 1.-.-.-) +FIG00904863 FIG00904864: hypothetical protein +FIG00904864 FIG00904867: hypothetical protein +FIG00904877 FIG00904878: hypothetical protein +FIG00904878 Citrate-sodium symport +FIG00904880 FIG00904881: hypothetical protein +FIG00904881 FIG00904882: hypothetical protein +FIG00904882 FIG00904883: hypothetical protein +FIG00904890 Putative cytoplasmic protein STM4186 +FIG00904892 Syd protein +FIG00904897 FIG00904898: hypothetical protein +FIG00904899 putative membrane-attached phosphoesterase +FIG00904906 FIG00904907: hypothetical protein +FIG00904909 FIG00904910: hypothetical protein +FIG00904914 putative LysE family transporter +FIG00904916 FIG00904918: hypothetical protein +FIG00904918 FIG00904919: hypothetical protein +FIG00904919 putative PQQ enzyme repeat +FIG00904923 FIG00904924: hypothetical protein +FIG00904929 Methylthioribose transport system permease protein +FIG00904933 FIG00904935: hypothetical protein +FIG00904935 FIG00904936: hypothetical protein +FIG00904938 Lactose-binding protein precursor +FIG00904942 FIG00904944: hypothetical protein +FIG00904948 FIG00904950: hypothetical protein +FIG00904950 FIG00904952: hypothetical protein +FIG00904952 FIG00904954: hypothetical protein +FIG00904954 putative isoflavone oxidoreductase +FIG00904955 Lipoprotein nlpI precursor +FIG00904957 FIG00904958: hypothetical protein +FIG00904968 Lipopolysaccharide biosynthesis protein RffC +FIG00904973 FIG00904974: hypothetical protein +FIG00904978 FIG00904979: hypothetical protein +FIG00904983 FIG00904985: hypothetical protein +FIG00904986 FIG00904988: hypothetical protein +FIG00904988 FIG00904989: hypothetical protein +FIG00904989 GnaT-family acetyltransferase +FIG00904994 FIG00904995: hypothetical protein +FIG00904995 FIG00904998: hypothetical protein +FIG00904999 Inner membrane protein ygjV +FIG00905001 FIG00613599: hypothetical protein +FIG00905003 Membrane protein with DUF350 domain +FIG00905005 FIG00905006: hypothetical protein +FIG00905006 FIG00905007: hypothetical protein +FIG00905007 FIG00905008: hypothetical protein +FIG00905009 FIG00613428: hypothetical protein +FIG00905014 FIG00905015: hypothetical protein +FIG00905019 FIG00905021: hypothetical protein +FIG00905021 FIG00905027: hypothetical protein +FIG00905028 probable acetyltransferase YPO3809 +FIG00905031 FIG00905032: hypothetical protein +FIG00905032 PolyA polymerase related protein (HD hydrolase) and P-loop ATP-ase domain +FIG00905033 FIG00905034: hypothetical protein +FIG00905040 FIG00905041: hypothetical protein +FIG00905041 FIG00905046: hypothetical protein +FIG00905046 FIG00905048: hypothetical protein +FIG00905051 Unknown, probable sigma-70 factor +FIG00905054 FIG00905057: hypothetical protein +FIG00905063 FIG00905065: hypothetical protein +FIG00905065 FIG00905066: hypothetical protein +FIG00905066 FIG00905073: hypothetical protein +FIG00905073 FIG00905076: hypothetical protein +FIG00905076 FIG00905077: hypothetical protein +FIG00905077 Uncharacterised protein family UPF0157 (COG2320) +FIG00905078 FIG00905080: hypothetical protein +FIG00905086 FIG00613542: hypothetical protein +FIG00905091 FIG00905093: hypothetical protein +FIG00905096 endonuclease/Exonuclease/phosphatase family protein +FIG00905101 FIG00613443: hypothetical protein +FIG00905110 FIG00613169: hypothetical protein +FIG00905113 FIG00905114: hypothetical protein +FIG00905116 FIG00905119: hypothetical protein +FIG00905120 putative exported lipase +FIG00905121 FIG00905125: hypothetical protein +FIG00905127 FIG00905128: hypothetical protein +FIG00905128 FIG00905129: hypothetical protein +FIG00905137 FIG00905139: hypothetical protein +FIG00905140 Cellulose synthase catalytic subunit [UDP-forming] (EC 2.4.1.12) +FIG00905149 FIG00905150: hypothetical protein +FIG00905150 FIG00905151: hypothetical protein +FIG00905151 FIG00905152: hypothetical protein +FIG00905152 Pi-fimbriae usher protein +FIG00905154 FIG00613870: hypothetical protein +FIG00905167 FIG00905168: hypothetical protein +FIG00905172 FIG00905173: hypothetical protein +FIG00905184 Putative receptor +FIG00905185 FIG00905186: hypothetical protein +FIG00905197 FIG00905200: hypothetical protein +FIG00905200 ATP transporter ATP-binding protein +FIG00905205 FIG00905206: hypothetical protein +FIG00905208 FIG00905209: hypothetical protein +FIG00905212 rhamnogalacturonate lyase +FIG00905214 WzxE protein +FIG00905222 Transcriptional regulatory protein cpxR +FIG00905223 FIG00905227: hypothetical protein +FIG00905227 FIG00905228: hypothetical protein +FIG00905236 FIG00905237: hypothetical protein +FIG00905240 FIG00614034: hypothetical protein +FIG00905241 FIG00905242: hypothetical protein +FIG00905244 FIG00905245: hypothetical protein +FIG00905255 FIG00905256: hypothetical protein +FIG00905260 FIG00905263: hypothetical protein +FIG00905263 Cellulose synthase, putative +FIG00905265 FIG00905270: hypothetical protein +FIG00905270 FIG00905271: hypothetical protein +FIG00905271 FIG00905272: hypothetical protein +FIG00905275 Endoglucanase S precursor (EC 3.2.1.4) (Endo-1,4-beta-glucanase S) (Cellulase S) +FIG00905283 FIG00905284: hypothetical protein +FIG00905284 FIG00905285: hypothetical protein +FIG00905285 FIG00905286: hypothetical protein +FIG00905287 Putative ABC transporter ATP-binding protein +FIG00905288 FIG00905290: hypothetical protein +FIG00905291 FIG00905295: hypothetical protein +FIG00905295 Probable sugar ABC transporter, ATP-binding protein +FIG00905320 FIG00905322: hypothetical protein +FIG00905323 FIG00905324: hypothetical protein +FIG00905324 MmgE/PrpD +FIG00905326 FIG00905327: hypothetical protein +FIG00905333 FIG00905334: hypothetical protein +FIG00905339 Pectin lyase (EC 4.2.2.10) +FIG00905340 ATP-dependent RNA helicase HrpA (EC 3.6.4.13) +FIG00905341 FIG00614279: hypothetical protein +FIG00905342 ABC exporter for hemopore HasA, ATP-binding component HasD +FIG00905350 ABC exporter for hemopore HasA, membrane fusion protein (MFP) family component HasE +FIG00905362 Acetyltransferase (EC 2.3.1.-) +FIG00905363 FIG00905364: hypothetical protein +FIG00905366 FIG00613896: hypothetical protein +FIG00905378 FIG00905379: hypothetical protein +FIG00905382 InterPro IPR000522 COGs COG0609 +FIG00905391 FIG00905392: hypothetical protein +FIG00905403 FIG00905405: hypothetical protein +FIG00905406 probable exported protein STY0357 +FIG00905408 N-glycosyltransferase +FIG00905410 FIG00905412: hypothetical protein +FIG00905415 FIG00905417: hypothetical protein +FIG00905417 Sigma cross-reacting protein 27A +FIG00905425 sugar ABC transport system, permease protein +FIG00905435 Phospholipase +FIG00905441 FIG00905442: hypothetical protein +FIG00905442 putative sugar phosphotransferase component II B +FIG00905444 putative cellulase +FIG00905445 FIG00905446: hypothetical protein +FIG00905459 FIG00850304: hypothetical protein +FIG00905471 FIG00905474: hypothetical protein +FIG00905474 putative secreted protein +FIG00905485 FIG00905488: hypothetical protein +FIG00905492 FIG00905493: hypothetical protein +FIG00905505 FIG00905506: hypothetical protein +FIG00905506 FIG00638765: hypothetical protein +FIG00905507 FIG00905508: hypothetical protein +FIG00905514 FIG00905516: hypothetical protein +FIG00905526 FIG00905528: hypothetical protein +FIG00905537 putative transport +FIG00905540 FIG00905541: hypothetical protein +FIG00905541 FIG00905542: hypothetical protein +FIG00905542 Branched-chain amino acid transport system carrier protein +FIG00905547 Siderophore biosynthesis protein +FIG00905558 Oxidoreductase (EC 1.1.1.-) +FIG00905561 Osmolarity sensory histidine kinase EnvZ +FIG00905566 FIG00905570: hypothetical protein +FIG00905570 C4-dicarboxylate transporter DcuA +FIG00905575 octopine-binding periplasmic protein +FIG00905576 FIG00905578: hypothetical protein +FIG00905578 FIG00905579: hypothetical protein +FIG00905580 Alpha-D-glucose-1-phosphatase +FIG00905583 FIG00905585: hypothetical protein +FIG00905585 FIG00905586: hypothetical protein +FIG00905586 FIG00905587: hypothetical protein +FIG00905587 FIG00905588: hypothetical protein +FIG00905593 FIG00614148: hypothetical protein +FIG00905595 His-Xaa-Ser system radical SAM maturase HxsB +FIG00905597 putative iron(III) ABC transporter ATP-binding protein +FIG00905608 Pectate lyase 1 precursor (EC 4.2.2.2) (Pectate lyase I) (PEL I) (PLA) +FIG00905609 MutT/nudix family protein (EC 3.6.1.-) +FIG00905610 FIG00905613: hypothetical protein +FIG00905613 FIG00905614: hypothetical protein +FIG00905620 FIG00905621: hypothetical protein +FIG00905622 Outer membrane protein W precursor +FIG00905630 FIG00905632: hypothetical protein +FIG00905633 putative AraC-family transcriptional regulator +FIG00905635 FIG00905637: hypothetical protein +FIG00905637 FIG00905638: hypothetical protein +FIG00905642 MFS permease protein +FIG00905648 FIG00905649: hypothetical protein +FIG00905649 FIG00905650: hypothetical protein +FIG00905650 FIG00905651: hypothetical protein +FIG00905651 FIG00905653: hypothetical protein +FIG00905653 FIG00905655: hypothetical protein +FIG00905655 Cyclic di-GMP binding protein precursor +FIG00905659 FIG00905660: hypothetical protein +FIG00905664 unknown conserved protein in bacilli +FIG00905666 Hypothetical protein, similar to phosphoserine phosphatase +FIG00905676 FIG00905677: hypothetical protein +FIG00905677 FIG00905678: hypothetical protein +FIG00905678 Autolysin sensor kinase (EC 2.7.3.-) +FIG00905679 FIG00613201: hypothetical protein +FIG00905683 FIG00905684: hypothetical protein +FIG00905697 FIG00905698: hypothetical protein +FIG00905703 FIG00905705: hypothetical protein +FIG00905705 FIG00613020: hypothetical protein +FIG00905710 FIG00905712: hypothetical protein +FIG00905714 FIG00905715: hypothetical protein +FIG00905720 FIG00905722: hypothetical protein +FIG00905723 FIG00905724: hypothetical protein +FIG00905725 FIG00905726: hypothetical protein +FIG00905727 Manganese ABC transporter, inner membrane permease protein SitC +FIG00905728 FIG00905729: hypothetical protein +FIG00905740 FIG00905741: hypothetical protein +FIG00905741 FIG00905742: hypothetical protein +FIG00905751 FIG00361523: hypothetical protein +FIG00905753 FIG00905754: hypothetical protein +FIG00905757 FIG00905759: hypothetical protein +FIG00905762 FIG00905763: hypothetical protein +FIG00905763 FIG00905765: hypothetical protein +FIG00905767 FIG00905768: hypothetical protein +FIG00905768 FIG00905771: hypothetical protein +FIG00905771 FIG00905772: hypothetical protein +FIG00905775 FIG00905777: hypothetical protein +FIG00905777 FIG00905778: hypothetical protein +FIG00905784 Methyl-accepting chemotaxis protein II +FIG00905796 Hnr protein +FIG00905806 FIG00905807: hypothetical protein +FIG00905807 FIG00905808: hypothetical protein +FIG00905808 putative exported choloylglycine hydrolase +FIG00905811 Tauropine dehydrogenase +FIG00905812 FIG00905813: hypothetical protein +FIG00905821 FIG00905822: hypothetical protein +FIG00905822 FIG00613847: hypothetical protein +FIG00905825 FIG00905826: hypothetical protein +FIG00905827 FIG00613280: hypothetical protein +FIG00905829 FIG00905832: hypothetical protein +FIG00905834 Pectate lyase precursor (EC 4.2.2.2) +FIG00905846 FIG00905852: hypothetical protein +FIG00905852 regulator of pectin lyase production +FIG00905857 Probable UDP-N-acetyl-D-mannosaminuronic acid transferase (EC 2.4.1.-) +FIG00905861 FIG00905863: hypothetical protein +FIG00905864 FIG00613440: hypothetical protein +FIG00905865 FIG00905872: hypothetical protein +FIG00905872 FIG00905874: hypothetical protein +FIG00905877 Inner membrane ABC-transporter YbtQ +FIG00905888 FIG00905889: hypothetical protein +FIG00905903 ABC transporter, ATP-binding subunit precursor +FIG00905904 FIG00905906: hypothetical protein +FIG00905907 Haemolysin expression modulating protein +FIG00905918 FIG00905919: hypothetical protein +FIG00905920 FIG00613785: hypothetical protein +FIG00905921 FIG00905923: hypothetical protein +FIG00905923 FIG00905924: hypothetical protein +FIG00905924 FIG00613065: hypothetical protein +FIG00905927 FIG00905929: hypothetical protein +FIG00905930 Glycerol-3-phosphate-binding protein +FIG00905935 FIG00905936: hypothetical protein +FIG00905950 FIG00905951: hypothetical protein +FIG00905954 FIG00905955: hypothetical protein +FIG00905955 Putative D-mannonate oxidoreductase (EC 1.1.1.57) +FIG00905963 FIG00905964: hypothetical protein +FIG00905964 FIG00905965: hypothetical protein +FIG00905965 FIG00905966: hypothetical protein +FIG00905980 Cnu protein +FIG00905989 transmembrane sensor +FIG00906006 FIG00906007: hypothetical protein +FIG00906007 potential HrpW-specific chaperone +FIG00906014 FIG00906015: hypothetical protein +FIG00906024 Argininosuccinate synthase +FIG00906025 FIG00906026: hypothetical protein +FIG00906026 FIG00906028: hypothetical protein +FIG00906030 ABC transporter ATP binding component +FIG00906034 FIG00906035: hypothetical protein +FIG00906035 FIG00906036: hypothetical protein +FIG00906036 FIG00906037: hypothetical protein +FIG00906037 FIG00906039: hypothetical protein +FIG00906057 FIG00906058: hypothetical protein +FIG00906064 FIG00906070: hypothetical protein +FIG00906075 Transcriptional regulator, HxlR family +FIG00906091 FIG00906093: hypothetical protein +FIG00906093 FIG00906095: hypothetical protein +FIG00906116 FIG00906120: hypothetical protein +FIG00906120 FIG00906121: hypothetical protein +FIG00906124 FIG00906125: hypothetical protein +FIG00906125 FIG00906126: hypothetical protein +FIG00906128 FIG00906131: hypothetical protein +FIG00906131 FIG00906132: hypothetical protein +FIG00906139 FIG00906140: hypothetical protein +FIG00906159 FIG00906161: hypothetical protein +FIG00906163 FIG00906165: hypothetical protein +FIG00906169 FIG00906170: hypothetical protein +FIG00906172 FIG00906174: hypothetical protein +FIG00906182 FIG00906186: hypothetical protein +FIG00906192 FIG00906193: hypothetical protein +FIG00906193 FIG00906194: hypothetical protein +FIG00906194 FIG00906196: hypothetical protein +FIG00906199 FIG00906200: hypothetical protein +FIG00906200 FIG00906201: hypothetical protein +FIG00906211 FIG00906212: hypothetical protein +FIG00906213 FIG00906214: hypothetical protein +FIG00906217 FIG00906218: hypothetical protein +FIG00906228 FIG00906232: hypothetical protein +FIG00906232 FIG00906233: hypothetical protein +FIG00906233 FIG00906237: hypothetical protein +FIG00906239 FIG00906241: hypothetical protein +FIG00906244 FIG00906245: hypothetical protein +FIG00906246 FIG00906247: hypothetical protein +FIG00906248 FIG00906249: hypothetical protein +FIG00906249 FIG00906253: hypothetical protein +FIG00906254 FIG00906256: hypothetical protein +FIG00906262 FIG00906264: hypothetical protein +FIG00906266 FIG00906267: hypothetical protein +FIG00906275 FIG00906276: hypothetical protein +FIG00906283 FIG00906285: hypothetical protein +FIG00906287 FIG00906289: hypothetical protein +FIG00906296 FIG00906297: hypothetical protein +FIG00906298 FIG00906300: hypothetical protein +FIG00906300 FIG00906301: hypothetical protein +FIG00906301 Hydrolase HAD superfamily +FIG00906302 LSU ribosomal protein L33p @ LSU ribosomal protein L33p, zinc-dependent +FIG00906304 FIG00906308: hypothetical protein +FIG00906310 FIG00906316: hypothetical protein +FIG00906316 FIG00906318: hypothetical protein +FIG00906321 FIG00906326: hypothetical protein +FIG00906331 FIG00906333: hypothetical protein +FIG00906335 FIG00906343: hypothetical protein +FIG00906344 FIG00906346: hypothetical protein +FIG00906351 FIG00906354: hypothetical protein +FIG00906357 FIG00906358: hypothetical protein +FIG00906359 FIG00906360: hypothetical protein +FIG00906365 Transcriptional regulator family +FIG00906368 FIG00906369: hypothetical protein +FIG00906369 Haloacid dehalogenase domain protein hydrolase, type 3 +FIG00906370 FIG00906371: hypothetical protein +FIG00906371 FIG00906372: hypothetical protein +FIG00906372 FIG00906375: hypothetical protein +FIG00906375 FIG00906376: hypothetical protein +FIG00906380 FIG00906381: hypothetical protein +FIG00906383 FIG00906385: hypothetical protein +FIG00906385 FIG00906391: hypothetical protein +FIG00906391 FIG00906393: hypothetical protein +FIG00906393 FIG00906397: hypothetical protein +FIG00906403 prophage Lp2 protein 53 +FIG00906412 FIG00906413: hypothetical protein +FIG00906413 FIG00906417: hypothetical protein +FIG00906424 FIG00906425: hypothetical protein +FIG00906431 dipeptidase +FIG00906437 FIG00906439: hypothetical protein +FIG00906439 FIG00906441: hypothetical protein +FIG00906444 FIG00906445: hypothetical protein +FIG00906445 FIG00906448: hypothetical protein +FIG00906448 FIG00906450: hypothetical protein +FIG00906458 FIG00906459: hypothetical protein +FIG00906461 FIG00906463: hypothetical protein +FIG00906463 FIG00906470: hypothetical protein +FIG00906472 FIG00906473: hypothetical protein +FIG00906476 FIG00906477: hypothetical protein +FIG00906478 FIG00906479: hypothetical protein +FIG00906493 FIG00906494: hypothetical protein +FIG00906494 FIG00906497: hypothetical protein +FIG00906498 FIG00906504: hypothetical protein +FIG00906508 FIG00906511: hypothetical protein +FIG00906512 FIG00906521: hypothetical protein +FIG00906521 FIG00906524: hypothetical protein +FIG00906524 FIG00906525: hypothetical protein +FIG00906525 FIG00906532: hypothetical protein +FIG00906539 FIG00906542: hypothetical protein +FIG00906553 FIG00906556: hypothetical protein +FIG00906556 alkaline shock protein +FIG00906557 FIG00906559: hypothetical protein +FIG00906562 FIG00906563: hypothetical protein +FIG00906563 YibE/F family protein +FIG00906567 FIG00906570: hypothetical protein +FIG00906570 Regulatory protein spx +FIG00906572 FIG00906575: hypothetical protein +FIG00906578 FIG00906580: hypothetical protein +FIG00906582 putative phosphosugar isomerase +FIG00906585 stress-responsive transcription regulator (putative) +FIG00906586 FIG00906588: hypothetical protein +FIG00906588 FIG00906591: hypothetical protein +FIG00906591 COG0174: Glutamine synthetase +FIG00906601 FIG00906602: hypothetical protein +FIG00906602 FIG00906603: hypothetical protein +FIG00906607 FIG00906609: hypothetical protein +FIG00906631 FIG00906634: hypothetical protein +FIG00906634 FIG00906635: hypothetical protein +FIG00906639 FIG00906640: hypothetical protein +FIG00906642 FIG00906643: hypothetical protein +FIG00906643 FIG00906645: hypothetical protein +FIG00906651 FIG00906652: hypothetical protein +FIG00906652 FIG00906655: hypothetical protein +FIG00906659 prophage Lp2 protein 58 +FIG00906660 FIG00906662: hypothetical protein +FIG00906662 Matrilysin precursor (EC 3.4.24.23) +FIG00906681 Putative DNA-directed RNA polymerase sigma factor, sigma H family +FIG00906688 Predicted FAD(NAD)-dependent oxidoreductase +FIG00906690 FIG00906693: hypothetical protein +FIG00906693 FIG00906694: hypothetical protein +FIG00906700 FIG00906704: hypothetical protein +FIG00906705 FIG00906708: hypothetical protein +FIG00906736 septum formation initiator subfamily, putative +FIG00906752 FIG00906754: hypothetical protein +FIG00906754 FIG00906757: hypothetical protein +FIG00906757 FIG00906760: hypothetical protein +FIG00906763 FIG00906766: hypothetical protein +FIG00906766 591aa hypothetical protein: FIG00906767 +FIG00906781 FIG00906782: hypothetical protein +FIG00906782 FIG00906787: hypothetical protein +FIG00906787 FIG00906794: hypothetical protein +FIG00906797 FIG00906801: hypothetical protein +FIG00906801 FIG00906802: hypothetical protein +FIG00906802 Gll0736 protein +FIG00906803 WD40-like repeat containing amidohydrolase famil y protein +FIG00906808 FIG00906810: hypothetical protein +FIG00906812 FIG00906814: hypothetical protein +FIG00906824 FIG00906826: hypothetical protein +FIG00906828 FIG00906829: hypothetical protein +FIG00906841 FIG00906842: hypothetical protein +FIG00906842 FIG00906844: hypothetical protein +FIG00906844 FIG00906845: hypothetical protein +FIG00906858 FIG00906859: hypothetical protein +FIG00906865 FIG00906868: hypothetical protein +FIG00906870 FIG00906873: hypothetical protein +FIG00906873 FIG00906875: hypothetical protein +FIG00906878 FIG00906881: hypothetical protein +FIG00906882 FIG00906885: hypothetical protein +FIG00906885 FIG00906890: hypothetical protein +FIG00906891 Naringenin-chalcone synthase (EC 2.3.1.74) +FIG00906894 FIG00906895: hypothetical protein +FIG00906901 FIG00906902: hypothetical protein +FIG00906905 FIG00906912: hypothetical protein +FIG00906914 FIG00906918: hypothetical protein +FIG00906921 FIG00906926: hypothetical protein +FIG00906926 Protein of unknown function (DUF1501) +FIG00906928 FIG00906930: hypothetical protein +FIG00906930 784aa hypothetical protein: FIG00906934 +FIG00906934 FIG00906938: hypothetical protein +FIG00906938 Periplasmic thiol:disulfide interchange protein DsbA +FIG00906940 FIG00906943: hypothetical protein +FIG00906944 FIG00906946: hypothetical protein +FIG00906946 FIG00906947: hypothetical protein +FIG00906953 FIG00906954: hypothetical protein +FIG00906954 FIG00906958: hypothetical protein +FIG00906958 FIG00906959: hypothetical protein +FIG00906963 FIG00906964: hypothetical protein +FIG00906964 FIG00906966: hypothetical protein +FIG00906966 FIG00906967: hypothetical protein +FIG00906967 FIG00906968: hypothetical protein +FIG00906968 FIG00906969: hypothetical protein +FIG00906970 FIG00906971: hypothetical protein +FIG00906971 RNA binding S1 domain-containing protein +FIG00906975 FIG00906977: hypothetical protein +FIG00906978 FIG00906982: hypothetical protein +FIG00906984 FIG00906987: hypothetical protein +FIG00906987 FIG00906988: hypothetical protein +FIG00906989 FIG00906990: hypothetical protein +FIG00906991 FIG00906993: hypothetical protein +FIG00906993 Monofunctional biosynthetic peptidoglycan transglycosylase (EC 2.4.2.-) (Monofunctional TGase) +FIG00906996 FIG00906997: hypothetical protein +FIG00906997 FIG00907002: hypothetical protein +FIG00907003 FIG00907006: hypothetical protein +FIG00907018 FIG00907020: hypothetical protein +FIG00907020 FIG00907022: hypothetical protein +FIG00907024 FIG00907028: hypothetical protein +FIG00907028 FIG00907035: hypothetical protein +FIG00907035 FIG00907036: hypothetical protein +FIG00907036 FIG00907040: hypothetical protein +FIG00907041 FIG00907042: hypothetical protein +FIG00907042 FIG00907047: hypothetical protein +FIG00907052 FIG00907054: hypothetical protein +FIG00907079 FIG00907081: hypothetical protein +FIG00907083 FIG00907086: hypothetical protein +FIG00907086 FIG00907089: hypothetical protein +FIG00907095 FIG00907103: hypothetical protein +FIG00907114 FIG00907115: hypothetical protein +FIG00907117 C-terminal processing peptidase, tail-specific protease( EC:3.4.21.102 ) +FIG00907124 FIG00907126: hypothetical protein +FIG00907128 FIG00907131: hypothetical protein +FIG00907138 FIG00907143: hypothetical protein +FIG00907149 FIG00907150: hypothetical protein +FIG00907153 FIG00907156: hypothetical protein +FIG00907156 FIG00907157: hypothetical protein +FIG00907157 putative glycosyl transferase( EC:2.- ) +FIG00907160 Outer membrane assembly lipoprotein YfiO +FIG00907169 fructose-6-phosphate aldolase( EC:4.1.2.- ) +FIG00907172 FIG00907173: hypothetical protein +FIG00907173 FIG00907174: hypothetical protein +FIG00907180 FIG00907182: hypothetical protein +FIG00907191 FIG00907192: hypothetical protein +FIG00907192 FIG00907195: hypothetical protein +FIG00907201 FIG00907202: hypothetical protein +FIG00907206 FIG00907209: hypothetical protein +FIG00907211 FIG00907214: hypothetical protein +FIG00907234 FIG00907235: hypothetical protein +FIG00907248 FIG00907255: hypothetical protein +FIG00907259 FIG00907260: hypothetical protein +FIG00907260 FIG00907265: hypothetical protein +FIG00907276 FIG00907277: hypothetical protein +FIG00907285 FIG00907288: hypothetical protein +FIG00907292 FIG00907299: hypothetical protein +FIG00907308 FIG00907309: hypothetical protein +FIG00907312 FIG00907313: hypothetical protein +FIG00907319 FIG00907320: hypothetical protein +FIG00907334 FIG00907336: hypothetical protein +FIG00907351 FIG00907355: hypothetical protein +FIG00907366 FIG00907367: hypothetical protein +FIG00907367 drug resistance transporter, Bcr/CflA family protein +FIG00907375 FIG00907377: hypothetical protein +FIG00907379 FIG00907380: hypothetical protein +FIG00907380 probable acylaminoacyl-peptidase +FIG00907384 FIG00907385: hypothetical protein +FIG00907385 FIG00907386: hypothetical protein +FIG00907393 FIG00907394: hypothetical protein +FIG00907394 FIG00907395: hypothetical protein +FIG00907408 FIG00907409: hypothetical protein +FIG00907410 FIG00907411: hypothetical protein +FIG00907413 FIG00907418: hypothetical protein +FIG00907418 efflux ABC transporter, permease protein +FIG00907419 FIG00907423: hypothetical protein +FIG00907423 conserved hypothetical protein, Cupin barrel +FIG00907425 FIG00907426: hypothetical protein +FIG00907426 FIG00481863: hypothetical protein +FIG00907429 FIG00907430: hypothetical protein +FIG00907432 probable secreted glycosyl hydrolase +FIG00907436 FIG00907438: hypothetical protein +FIG00907438 FIG00907440: hypothetical protein +FIG00907442 FIG00907444: hypothetical protein +FIG00907444 FIG00907448: hypothetical protein +FIG00907449 FIG00907450: hypothetical protein +FIG00907450 Acyl carrier protein phosphodiesterase (EC 3.1.4.14) +FIG00907452 FIG00907456: hypothetical protein +FIG00907456 FIG00907457: hypothetical protein +FIG00907461 probable cell wall-associated hydrolase +FIG00907464 FIG00907465: hypothetical protein +FIG00907465 FIG00907466: hypothetical protein +FIG00907466 FIG00907468: hypothetical protein +FIG00907468 FIG00907471: hypothetical protein +FIG00907478 FIG00907479: hypothetical protein +FIG00907479 FIG00907480: hypothetical protein +FIG00907480 FIG00907481: hypothetical protein +FIG00907486 FIG00907493: hypothetical protein +FIG00907498 FIG00907499: hypothetical protein +FIG00907507 FIG00907509: hypothetical protein +FIG00907509 FIG00907512: hypothetical protein +FIG00907524 FIG00907525: hypothetical protein +FIG00907530 FIG00907532: hypothetical protein +FIG00907532 FIG00907533: hypothetical protein +FIG00907534 FIG00907535: hypothetical protein +FIG00907543 FIG00907545: hypothetical protein +FIG00907551 FIG00907552: hypothetical protein +FIG00907552 FIG00907554: hypothetical protein +FIG00907554 FIG00907557: hypothetical protein +FIG00907562 FIG00907563: hypothetical protein +FIG00907563 FIG00907564: hypothetical protein +FIG00907574 FIG00907576: hypothetical protein +FIG00907598 FIG00907600: hypothetical protein +FIG00907600 FIG00907601: hypothetical protein +FIG00907604 FIG00907610: hypothetical protein +FIG00907614 possible ISDet3 transposase: FIG00907615 +FIG00907618 FIG00907620: hypothetical protein +FIG00907620 FIG00907621: hypothetical protein +FIG00907623 FIG00907625: hypothetical protein +FIG00907629 FIG00907630: hypothetical protein +FIG00907630 FIG00907632: hypothetical protein +FIG00907634 FIG00907637: hypothetical protein +FIG00907637 FIG00907639: hypothetical protein +FIG00907645 FIG00907646: hypothetical protein +FIG00907666 FIG00907669: hypothetical protein +FIG00907669 FIG00907670: hypothetical protein +FIG00907670 FIG00907672: hypothetical protein +FIG00907672 FIG00907674: hypothetical protein +FIG00907684 oxidoreductase, short chain dehydrogenase/reductase family( EC:1.1.1.- ) +FIG00907685 FIG00907691: hypothetical protein +FIG00907692 FIG00907694: hypothetical protein +FIG00907694 FIG00907695: hypothetical protein +FIG00907705 FIG00907707: hypothetical protein +FIG00907709 FIG00907711: hypothetical protein +FIG00907714 FIG00907715: hypothetical protein +FIG00907715 FIG00907716: hypothetical protein +FIG00907721 6-phosphogluconolactonase( EC:3.1.1.31 ) +FIG00907725 FIG00907726: hypothetical protein +FIG00907726 FIG00907728: hypothetical protein +FIG00907728 FIG00907729: hypothetical protein +FIG00907736 FIG00907737: hypothetical protein +FIG00907737 FIG00907740: hypothetical protein +FIG00907741 FIG00907745: hypothetical protein +FIG00907745 Chemotaxis protein methyltransferase (EC 2.1.1.80) +FIG00907748 FIG00907752: hypothetical protein +FIG00907759 FIG00907760: hypothetical protein +FIG00907763 FIG00907767: hypothetical protein +FIG00907767 FIG00907769: hypothetical protein +FIG00907769 CBS +FIG00907772 FIG00907773: hypothetical protein +FIG00907778 FIG00907781: hypothetical protein +FIG00907782 FIG00907791: hypothetical protein +FIG00907791 FIG00907798: hypothetical protein +FIG00907798 FIG00907799: hypothetical protein +FIG00907801 FIG00907803: hypothetical protein +FIG00907803 FIG00907804: hypothetical protein +FIG00907804 FIG00907805: hypothetical protein +FIG00907807 FIG00907809: hypothetical protein +FIG00907816 FIG00907818: hypothetical protein +FIG00907820 FIG00907822: hypothetical protein +FIG00907822 FIG00907826: hypothetical protein +FIG00907837 allergen V5/Tpx-1 related +FIG00907842 FIG00907846: hypothetical protein +FIG00907848 FIG00907850: hypothetical protein +FIG00907850 FIG00907851: hypothetical protein +FIG00907851 FIG00907856: hypothetical protein +FIG00907861 Sodium/iodide co-transporter +FIG00907864 FIG00907867: hypothetical protein +FIG00907868 FIG00907871: hypothetical protein +FIG00907875 FIG00907876: hypothetical protein +FIG00907881 gliding motility-related protein; possible outer membrane protein +FIG00907884 FIG00907893: hypothetical protein +FIG00907893 70 kDa peptidylprolyl isomerase( EC:5.2.1.8 ) +FIG00907894 FIG00907896: hypothetical protein +FIG00907897 FIG00907898: hypothetical protein +FIG00907900 FIG00907901: hypothetical protein +FIG00907902 FIG00907903: hypothetical protein +FIG00907906 FIG00907907: hypothetical protein +FIG00907907 FIG00907910: hypothetical protein +FIG00907921 FIG00907922: hypothetical protein +FIG00907922 FIG00907923: hypothetical protein +FIG00907927 chaperone with DnaK; heat shock protein +FIG00907931 sensor histidine kinase/response regulator fusion protein +FIG00907941 FIG00907945: hypothetical protein +FIG00907945 endo/excinuclease amino terminal domain protein +FIG00907961 FIG00907964: hypothetical protein +FIG00907969 FIG00907970: hypothetical protein +FIG00907975 FIG00907976: hypothetical protein +FIG00907990 FIG00907992: hypothetical protein +FIG00907997 FIG00907999: hypothetical protein +FIG00908002 DNA-3-methyladenine glycosidase +FIG00908008 chain A, Identification Of A Disulfide Switch In Bssco, A Member Of The Sco Family Of Cytochrome C Oxidase Assembly Proteins +FIG00908026 FIG00908028: hypothetical protein +FIG00908028 FIG00908031: hypothetical protein +FIG00908040 FIG00908041: hypothetical protein +FIG00908041 FIG00908042: hypothetical protein +FIG00908051 FIG00908053: hypothetical protein +FIG00908054 FIG00908055: hypothetical protein +FIG00908055 sugar metabolism cluster protein +FIG00908057 tyrosine-protein kinase( EC:2.7.10.1 ) +FIG00908058 FIG00908059: hypothetical protein +FIG00908059 FIG00908060: hypothetical protein +FIG00908061 FIG00567468: hypothetical protein +FIG00908064 CheB methylesterase( EC:3.1.1.61 ) +FIG00908067 FIG00908070: hypothetical protein +FIG00908084 FIG00908085: hypothetical protein +FIG00908085 FIG00908087: hypothetical protein +FIG00908100 FIG00908101: hypothetical protein +FIG00908101 FIG00908104: hypothetical protein +FIG00908109 FIG00908110: hypothetical protein +FIG00908111 FIG00908120: hypothetical protein +FIG00908120 FIG00908124: hypothetical protein +FIG00908130 FIG00908131: hypothetical protein +FIG00908143 FIG00908144: hypothetical protein +FIG00908144 FIG00908146: hypothetical protein +FIG00908152 FIG00908154: hypothetical protein +FIG00908157 FIG00908158: hypothetical protein +FIG00908159 FIG00908160: hypothetical protein +FIG00908188 FIG00908190: hypothetical protein +FIG00908192 FIG00908193: hypothetical protein +FIG00908195 FIG00908196: hypothetical protein +FIG00908197 FIG00908198: hypothetical protein +FIG00908199 FIG00908203: hypothetical protein +FIG00908208 FIG00908209: hypothetical protein +FIG00908209 FIG00908210: hypothetical protein +FIG00908210 FIG00908213: hypothetical protein +FIG00908215 FIG00908219: hypothetical protein +FIG00908220 FIG00908222: hypothetical protein +FIG00908222 FIG00908224: hypothetical protein +FIG00908224 FIG00908230: hypothetical protein +FIG00908230 FIG00908235: hypothetical protein +FIG00908239 FIG00908243: hypothetical protein +FIG00908253 conserved hypothetical protein; possible 2-phosphosulpholactate phosphatase +FIG00908273 FIG00908277: hypothetical protein +FIG00908277 FIG00908278: hypothetical protein +FIG00908280 FIG00908285: hypothetical protein +FIG00908289 FIG00908291: hypothetical protein +FIG00908294 FIG00908297: hypothetical protein +FIG00908297 L-alanine-DL-glutamate epimerase +FIG00908304 FIG00908306: hypothetical protein +FIG00908314 FIG00908315: hypothetical protein +FIG00908315 FIG00908318: hypothetical protein +FIG00908320 FIG00908324: hypothetical protein +FIG00908333 FIG00908336: hypothetical protein +FIG00908337 C06H2.3 +FIG00908339 FIG00908344: hypothetical protein +FIG00908344 FIG00908345: hypothetical protein +FIG00908350 FIG00908351: hypothetical protein +FIG00908351 FIG00908352: hypothetical protein +FIG00908352 FIG00908357: hypothetical protein +FIG00908358 FIG00908360: hypothetical protein +FIG00908363 FIG00908367: hypothetical protein +FIG00908381 FIG00908385: hypothetical protein +FIG00908385 FIG00908387: hypothetical protein +FIG00908404 FIG00908406: hypothetical protein +FIG00908406 FIG00908407: hypothetical protein +FIG00908411 FIG00908421: hypothetical protein +FIG00908424 FIG00908428: hypothetical protein +FIG00908433 FIG00908437: hypothetical protein +FIG00908439 FIG00908441: hypothetical protein +FIG00908444 FIG00908445: hypothetical protein +FIG00908445 FIG00908446: hypothetical protein +FIG00908446 FIG00908452: hypothetical protein +FIG00908452 FIG00908453: hypothetical protein +FIG00908453 thiamine pyrophosphokinase +FIG00908455 FKBP-type peptidyl-prolyl isomerase-like( EC:5.2.1.8 ) +FIG00908460 FIG00908466: hypothetical protein +FIG00908466 FIG00908470: hypothetical protein +FIG00908472 FIG00908474: hypothetical protein +FIG00908474 FIG00908477: hypothetical protein +FIG00908484 FIG00908485: hypothetical protein +FIG00908485 FIG00908490: hypothetical protein +FIG00908493 sulfolipid sulfoquinovosyldiacylglycerol biosynthesis protein +FIG00908497 FIG00908499: hypothetical protein +FIG00908499 FIG00908500: hypothetical protein +FIG00908507 FIG00908509: hypothetical protein +FIG00908523 beta-lactamase family protein +FIG00908524 FIG00908527: hypothetical protein +FIG00908532 FIG00908533: hypothetical protein +FIG00908542 FIG00908547: hypothetical protein +FIG00908547 putative sodium/hexose cotransport protein +FIG00908548 PROBABLE PROTEASE SIGNAL PEPTIDE PROTEIN( EC:3.4.- ) +FIG00908549 FIG00908552: hypothetical protein +FIG00908557 FIG00908559: hypothetical protein +FIG00908559 FIG00908578: hypothetical protein +FIG00908591 FIG00908594: hypothetical protein +FIG00908594 hypothetical protein +FIG00908596 FIG00908597: hypothetical protein +FIG00908599 FIG00908601: hypothetical protein +FIG00908601 FIG00908604: hypothetical protein +FIG00908607 FIG00908612: hypothetical protein +FIG00908628 Signal transduction ATPase, FimS family protein +FIG00908635 FIG00908637: hypothetical protein +FIG00908638 FIG00908641: hypothetical protein +FIG00908642 putative PAS/PAC sensor signal transduction histidine kinase +FIG00908643 FIG00908644: hypothetical protein +FIG00908664 FIG00908667: hypothetical protein +FIG00908667 FIG00908668: hypothetical protein +FIG00908675 FIG00908680: hypothetical protein +FIG00908680 FIG00908685: hypothetical protein +FIG00908685 carbohydrate esterase, family 1 +FIG00908688 FIG00908689: hypothetical protein +FIG00908691 FIG00908696: hypothetical protein +FIG00908721 FIG00908722: hypothetical protein +FIG00908722 FIG00908727: hypothetical protein +FIG00908727 FIG00908734: hypothetical protein +FIG00908744 cytochrome cbb3 oxidase maturation protein CcoH +FIG00908785 FIG00908787: hypothetical protein +FIG00908792 FIG00908796: hypothetical protein +FIG00908797 glycine cleavage system protein H +FIG00908802 FIG00908805: hypothetical protein +FIG00908805 Receiver component of a two-component response regulator +FIG00908825 FIG00908826: hypothetical protein +FIG00908835 FIG00908837: hypothetical protein +FIG00908837 FIG00908838: hypothetical protein +FIG00908851 FIG00908852: hypothetical protein +FIG00908854 FIG00908860: hypothetical protein +FIG00908862 FIG00908865: hypothetical protein +FIG00908876 FIG00908878: hypothetical protein +FIG00908879 FIG00908880: hypothetical protein +FIG00908880 Aminopeptidase N-like protein +FIG00908891 FIG00908900: hypothetical protein +FIG00908907 FIG00908910: hypothetical protein +FIG00908927 FIG00908930: hypothetical protein +FIG00908935 FIG00908940: hypothetical protein +FIG00908948 FIG00908949: hypothetical protein +FIG00908949 FIG00908950: hypothetical protein +FIG00908952 FIG00908955: hypothetical protein +FIG00908963 FIG00908967: hypothetical protein +FIG00908967 FIG00908968: hypothetical protein +FIG00908969 FIG00908970: hypothetical protein +FIG00908970 FIG034863: hypothetical protein +FIG00908979 FIG00908981: hypothetical protein +FIG00908981 FIG00908988: hypothetical protein +FIG00908988 FIG00908989: hypothetical protein +FIG00908989 FIG00908995: hypothetical protein +FIG00908995 caax amino terminal protease family +FIG00908999 FIG00909007: hypothetical protein +FIG00909007 FIG00909010: hypothetical protein +FIG00909010 FIG00909014: hypothetical protein +FIG00909014 FIG00909016: hypothetical protein +FIG00909017 FIG00909018: hypothetical protein +FIG00909020 FIG00909027: hypothetical protein +FIG00909027 FIG00909029: hypothetical protein +FIG00909029 FIG00909030: hypothetical protein +FIG00909030 FIG00909032: hypothetical protein +FIG00909032 FIG00909034: hypothetical protein +FIG00909036 sulfur transfer protein involved in thiamine biosynthesis +FIG00909037 FIG00909041: hypothetical protein +FIG00909045 FIG00909047: hypothetical protein +FIG00909057 Possible ABC-type molybdenum transporter, ATP-binding protein +FIG00909073 FIG00909074: hypothetical protein +FIG00909093 FIG00909100: hypothetical protein +FIG00909100 FIG00909104: hypothetical protein +FIG00909111 FIG00909112: hypothetical protein +FIG00909122 FIG00909123: hypothetical protein +FIG00909131 FIG00909132: hypothetical protein +FIG00909142 FIG00909145: hypothetical protein +FIG00909152 FIG00909155: hypothetical protein +FIG00909167 FIG00909171: hypothetical protein +FIG00909204 Regulatory sensor-transducer, BlaR1/MecR1 family / TonB family protein +FIG00909233 FIG00909234: hypothetical protein +FIG00909243 putative penicillin acylase( EC:3.5.1.11 ) +FIG00909251 FIG00909261: hypothetical protein +FIG00909266 FIG00909267: hypothetical protein +FIG00909273 FIG00909275: hypothetical protein +FIG00909283 Regulatory sensor-transducer, BlaR1/MecR1 family / TEA domain-containing protein +FIG00909297 FIG00909298: hypothetical protein +FIG00909298 FIG00909300: hypothetical protein +FIG00909327 sec-independent protein translocase +FIG00909381 FIG00909383: hypothetical protein +FIG00909384 FIG00909385: hypothetical protein +FIG00909385 FIG00909390: hypothetical protein +FIG00909430 FIG00909431: hypothetical protein +FIG00909445 FIG00909446: hypothetical protein +FIG00909446 probable large, multifunctional secreted protein +FIG00909491 FIG00909494: hypothetical protein +FIG00909495 5-formyltetrahydrofolate cyclo-ligase-like protein (EC 6.3.3.2) +FIG00909496 FIG00909497: hypothetical protein +FIG00909497 FIG00909498: hypothetical protein +FIG00909498 FIG00909499: hypothetical protein +FIG00909500 FIG00909501: hypothetical protein +FIG00909505 FIG00909506: hypothetical protein +FIG00909509 potential esterase +FIG00909510 NADH-ubiquinone oxidoreductase 18 kDa subunit, mitochondrial precursor (EC 1.6.5.3) (EC 1.6.99.3) +FIG00909514 FIG00909515: hypothetical protein +FIG00909516 probable membrane permease of unknown function +FIG00909517 TPP-requiring enzyme co-localized with putative O-antigen rfb gene cluster +FIG00909518 FIG00909519: hypothetical protein +FIG00909519 ABC-type transport systems, involved in lipoprotein release, ATPase components +FIG00909522 Taurine transport system permease protein tauC +FIG00909524 FIG00909525: hypothetical protein +FIG00909525 membrane protein of unknown function (DUF1430) +FIG00909531 Diaminopropionate ammonia-lyase (EC 4.3.1.15) +FIG00909532 Putative secretory autotransporter +FIG00909534 FIG00909536: hypothetical protein +FIG00909536 Methionine biosynthesis MetW +FIG00909538 FIG00909539: hypothetical protein +FIG00909542 FIG00909543: hypothetical protein +FIG00909543 FIG00909545: hypothetical protein +FIG00909545 FIG00909547: hypothetical protein +FIG00909548 Glycosyltransferase family 9 (heptosyltransferase) +FIG00909557 UDP-2,3-diacylglucosamine pyrophosphatase +FIG00909559 FIG00909560: hypothetical protein +FIG00909561 FIG00909562: hypothetical protein +FIG00909562 FIG00909563: hypothetical protein +FIG00909569 FIG00909571: hypothetical protein +FIG00909577 FIG00909578: hypothetical protein +FIG00909578 FIG00909580: hypothetical protein +FIG00909580 FIG00909581: hypothetical protein +FIG00909581 FIG00909583: hypothetical protein +FIG00909584 FIG00909586: hypothetical protein +FIG00909586 FIG00909589: hypothetical protein +FIG00909589 FIG00909590: hypothetical protein +FIG00909591 Serine phosphatase RsbU +FIG00909604 Putative Transmembrane transport protein +FIG00909605 Thioesterase superfamily protein +FIG00909610 FIG00909612: hypothetical protein +FIG00909613 ThiS family +FIG00909618 Flavin Mononucleotide Binding Protein +FIG00909621 FIG00909622: hypothetical protein +FIG00909622 FIG00909625: hypothetical protein +FIG00909625 FIG00909627: hypothetical protein +FIG00909630 FIG00909632: hypothetical protein +FIG00909632 FIG00909633: hypothetical protein +FIG00909636 FIG00909637: hypothetical protein +FIG00909642 FIG00909643: hypothetical protein +FIG00909643 Probable aminomethyltransferase (EC 2.1.2.10) +FIG00909646 FIG00909647: hypothetical protein +FIG00909647 FIG00909649: hypothetical protein +FIG00909649 FIG00909650: hypothetical protein +FIG00909651 FIG00909652: hypothetical protein +FIG00909652 thioredoxin 1 +FIG00909653 probable molybdopterin biosynthesis protein moaD +FIG00909654 FIG00909655: hypothetical protein +FIG00909655 L-proline glycine betaine binding ABC transporter protein proX (TC 3.A.1.12.1) / Osmotic adaptation +FIG00909656 FIG00909657: hypothetical protein +FIG00909657 FIG00909658: hypothetical protein +FIG00909658 FIG00909659: hypothetical protein +FIG00909659 possible transmembrane receptor +FIG00909660 possible serine protease inhibitor sgti +FIG00909662 FIG00909663: hypothetical protein +FIG00909663 FIG00909664: hypothetical protein +FIG00909666 FIG00909667: hypothetical protein +FIG00909668 COG0537: Diadenosine tetraphosphate (Ap4A) hydrolase and other HIT family hydrolases +FIG00909669 FIG00909670: hypothetical protein +FIG00909672 FIG00909673: hypothetical protein +FIG00909674 FIG00909675: hypothetical protein +FIG00909676 FIG00909677: hypothetical protein +FIG00909677 FIG00909678: hypothetical protein +FIG00909678 FIG00909679: hypothetical protein +FIG00909679 FIG00909681: hypothetical protein +FIG00909681 FIG00909682: hypothetical protein +FIG00909682 FIG00909683: hypothetical protein +FIG00909684 (S)-2-haloacid dehalogenase (EC 3.8.1.2) +FIG00909686 FIG00909687: hypothetical protein +FIG00909687 type 4 fimbrial biogenesis protein PilP +FIG00909688 AcrA-like protein +FIG00909689 Quaternary ammonium compound-resistance protein qacH +FIG00909690 FIG00909691: hypothetical protein +FIG00909694 possible membrane portion of succinate dehydrogenase +FIG00909695 DNA-damage inducible protein F +FIG00909704 putative rhamnosyltransferase +FIG00909707 FIG00909709: hypothetical protein +FIG00909709 FIG00909711: hypothetical protein +FIG00909720 Predicted permease YjgP/YjgQ family protein +FIG00909721 FIG00909722: hypothetical protein +FIG00909723 FIG00909724: hypothetical protein +FIG00909724 Fumarylacetoacetate (FAA) hydrolase family protein +FIG00909725 FIG00909726: hypothetical protein +FIG00909726 FIG00909729: hypothetical protein +FIG00909731 FIG00909732: hypothetical protein +FIG00909733 spsA-like protein +FIG00909735 possible pilX-type protein +FIG00909736 tRNA dihydrouridine synthase A +FIG00909737 FIG00909738: hypothetical protein +FIG00909739 possible pilin protein similar to PilU +FIG00909741 FIG00909742: hypothetical protein +FIG00909742 FIG00909743: hypothetical protein +FIG00909743 FIG00909744: hypothetical protein +FIG00909752 FIG00909754: hypothetical protein +FIG00909756 FIG00909759: hypothetical protein +FIG00909759 DoxD-like family protein +FIG00909761 spermidine/putrescine transport system permease protein potb +FIG00909763 multi-domain protein +FIG00909775 Novel protein with potential Cupin domain +FIG00909776 glucose dehydrogenase (pyrroloquinoline-quinone) precursor +FIG00909777 FIG00909779: hypothetical protein +FIG00909779 Bacterial protein export chaperone +FIG00909781 FIG00909782: hypothetical protein +FIG00909782 Regulatory protein +FIG00909786 possible Rhodanese-related sulfurtransferase +FIG00909787 iron(III) ABC transporter +FIG00909788 FIG00909789: hypothetical protein +FIG00909789 FIG00909790: hypothetical protein +FIG00909790 FIG00909793: hypothetical protein +FIG00909794 FIG00909795: hypothetical protein +FIG00909796 FIG00909797: hypothetical protein +FIG00909799 FIG00909802: hypothetical protein +FIG00909802 FIG00909805: hypothetical protein +FIG00909812 FIG00909814: hypothetical protein +FIG00909814 ribosomal protein L6e +FIG00909815 crossover junction endodeoxyribonuclease +FIG00909816 FIG00909817: hypothetical protein +FIG00909817 FIG00909818: hypothetical protein +FIG00909823 possible membrane-bound pili assembly protein Fimc +FIG00909835 FIG00909837: hypothetical protein +FIG00909837 FIG00909838: hypothetical protein +FIG00909838 Molybdenum cofactor biosynthesis protein E; Molybdopterin converting factor subunit 2 +FIG00909839 FIG00909840: hypothetical protein +FIG00909841 COG0385 sodium-dependent transporter +FIG00909843 FIG00909844: hypothetical protein +FIG00909847 FIG00909849: hypothetical protein +FIG00909849 tetratricopeptide repeat (tpr) family protein +FIG00909850 FIG00909851: hypothetical protein +FIG00909852 FIG00909853: hypothetical protein +FIG00909854 TPR-like +FIG00909856 Diadenosine tetraphosphate (Ap4A) hydrolase and other HIT family hydrolase +FIG00909857 NifU-like N terminal domain +FIG00909858 heat shock protein a +FIG00909863 vacJ lipoprotein, putative +FIG00909868 FIG00909870: hypothetical protein +FIG00909871 AzlC protein +FIG00909872 Putative phospholipid-binding domain +FIG00909875 FIG00909876: hypothetical protein +FIG00909876 FIG00909877: hypothetical protein +FIG00909883 FIG00909887: hypothetical protein +FIG00909887 ribosomal protein L33 +FIG00909891 COG2917: Intracellular septation protein A +FIG00909893 FIG00909894: hypothetical protein +FIG00909894 FIG00909895: hypothetical protein +FIG00909895 FIG00909897: hypothetical protein +FIG00909897 FIG00909898: hypothetical protein +FIG00909899 Exonuclease VII small subunit +FIG00909909 DMSP breakdown hydrolase protein +FIG00909911 FIG00909912: hypothetical protein +FIG00909913 FIG00909915: hypothetical protein +FIG00909916 Adenylylsulfate reductase membrane anchor +FIG00909918 FIG00909919: hypothetical protein +FIG00909919 FIG00909920: hypothetical protein +FIG00909921 Glycosyl transferase family 8 +FIG00909922 FIG00909924: hypothetical protein +FIG00909924 HAD-superfamily subfamily IIA hydrolase, TIGR01459 +FIG00909933 FIG00909934: hypothetical protein +FIG00909935 FIG00909938: hypothetical protein +FIG00909938 FIG00909940: hypothetical protein +FIG00909940 FIG00909941: hypothetical protein +FIG00909941 FIG00909942: hypothetical protein +FIG00909952 TsaB protein, required for threonylcarbamoyladenosine (t(6)A) formation in tRNA +FIG00909956 Putative NADPH-quinone reductase +FIG00909958 molybdopterin biosynthesis protein moeA +FIG00909960 FIG00909961: hypothetical protein +FIG00909961 Putative pseudo-pilin PulG +FIG00909963 FIG00909964: hypothetical protein +FIG00909964 possible AbrB protein +FIG00909965 Putative transporter, RarD family, DMT superfamily protein +FIG00909970 FIG00909971: hypothetical protein +FIG00909971 FIG00909972: hypothetical protein +FIG00909972 probable transcription regulatory protein +FIG00909973 FIG00909974: hypothetical protein +FIG00909974 unknown membrane protein +FIG00909976 FIG00909977: hypothetical protein +FIG00909977 FIG00909979: hypothetical protein +FIG00909979 FIG00909985: hypothetical protein +FIG00909985 probable heavy metal transport/detoxification protein +FIG00909987 FIG00909988: hypothetical protein +FIG00909988 putative monomeric sarcosine oxidase +FIG00909989 type IV pilin secretion protein +FIG00909992 FIG00909993: hypothetical protein +FIG00909993 DNA-directed DNA polymerase III (EC 2.7.7.7) +FIG00909994 FIG00909995: hypothetical protein +FIG00909995 Glycine amidinotransferase (EC 2.1.4.1) +FIG00909996 FIG00909997: hypothetical protein +FIG00909998 FIG00909999: hypothetical protein +FIG00909999 FIG00910000: hypothetical protein +FIG00910002 FIG00910004: hypothetical protein +FIG00910013 FIG00910015: hypothetical protein +FIG00910015 FIG00910017: hypothetical protein +FIG00910017 FIG167255: hypothetical protein +FIG00910020 Putative pilV-like pilin protein +FIG00910025 Sulfotransferase domain +FIG00910082 FIG00910084: hypothetical protein +FIG00910133 FIG00910137: hypothetical protein +FIG00910144 FIG00910145: hypothetical protein +FIG00910164 FIG00910170: hypothetical protein +FIG00910170 ATPase-like protein +FIG00910244 FIG00910247: hypothetical protein +FIG00910263 FIG00910267: hypothetical protein +FIG00910336 Pyruvate-formate lyase-activating enzyme +FIG00910407 Na+,K+ P-type ATPase +FIG00910410 FIG006388: Possible exported protein +FIG00910451 FIG00910452: hypothetical protein +FIG00910471 FIG00910472: hypothetical protein +FIG00910497 FIG00910499: hypothetical protein +FIG00910501 FIG00910502: hypothetical protein +FIG00910503 NADH-ubiquinone oxidoreductase chain 49kDa +FIG00910532 AslB/AtsB family protein +FIG00910616 FIG00910617: hypothetical protein +FIG00910626 FIG00910629: hypothetical protein +FIG00910653 Putative aminotransferase, DegT family +FIG00910711 FIG00910712: hypothetical protein +FIG00910773 FIG00910774: hypothetical protein +FIG00910795 FIG00910796: hypothetical protein +FIG00910847 FIG00910848: hypothetical protein +FIG00910865 FIG00910876: hypothetical protein +FIG00910910 UV-endonuclease-like protein +FIG00910939 FIG00910943: hypothetical protein +FIG00910952 FIG00910954: hypothetical protein +FIG00910979 FIG00910980: hypothetical protein +FIG00911026 Mce-related protein +FIG00911080 FIG00911085: hypothetical protein +FIG00911087 initiator RepB protein +FIG00911116 FIG00911119: hypothetical protein +FIG00911246 CHC2 zinc finger domain protein +FIG00911321 Kunitz/bovine pancreatic trypsin inhibitor domain protein +FIG00911328 FIG00911339: hypothetical protein +FIG00911360 FIG00911364: hypothetical protein +FIG00911408 FIG00911422: hypothetical protein +FIG00911423 FIG00911425: hypothetical protein +FIG00911425 FIG00911428: hypothetical protein +FIG00911429 NADP-reducing [Fe]-hydrogenase, cytoplasmic, gamma subunit (EC 1.12.1.4) +FIG00911497 FIG00911506: hypothetical protein +FIG00911515 FIG00911517: hypothetical protein +FIG00911567 ABC-type phosphate/phosphonate transport system periplasmic component-like +FIG00911608 Putative serine protein kinase, PrkA +FIG00911697 FIG01161232: hypothetical protein +FIG00911716 FIG00911719: hypothetical protein +FIG00911747 FIG00911750: hypothetical protein +FIG00911809 FIG00613892: hypothetical protein +FIG00911851 FIG00613894: hypothetical protein +FIG00911857 IncF plasmid conjugative transfer protein TraG +FIG00911888 amino acid ligase domain protein +FIG00912061 FIG00912062: hypothetical protein +FIG00912159 COG1872 +FIG00912173 FIG00912174: hypothetical protein +FIG00912180 FIG00912182: hypothetical protein +FIG00912193 FIG00912201: hypothetical protein +FIG00912213 FIG00912214: hypothetical protein +FIG00912229 FIG00912230: hypothetical protein +FIG00912234 Probable outer membrane protein precursor +FIG00912299 FIG00912300: hypothetical protein +FIG00912372 4-hydroxybenzoyl-CoA thioesterase domain protein +FIG00912407 FIG00681248: hypothetical protein +FIG00912408 FIG00912409: hypothetical protein +FIG00912537 FIG00912538: hypothetical protein +FIG00912559 FIG00912562: hypothetical protein +FIG00912633 FIG00912636: hypothetical protein +FIG00912727 4-coumarate--CoA ligase (EC 6.2.1.12) +FIG00912759 Putative pyruvyl-transferase +FIG00912772 probable transport transmembrane protein +FIG00912840 Putative Holliday junction resolvase YggF +FIG00912844 FIG00912845: hypothetical protein +FIG00912889 FIG00912890: hypothetical protein +FIG00912901 FIG00912907: hypothetical protein +FIG00912907 FIG00912915: hypothetical protein +FIG00912932 UspA domain protein +FIG00912938 FIG00912939: hypothetical protein +FIG00912954 FIG00912961: hypothetical protein +FIG00912961 FIG00912965: hypothetical protein +FIG00913102 FIG00913109: hypothetical protein +FIG00913109 protein of unknown function UPF0016 +FIG00913116 succinylglutamate desuccinylase/aspartoacylase +FIG00913124 FIG00913126: hypothetical protein +FIG00913185 MFS transporter family protein +FIG00913243 alpha amylase, catalytic region +FIG00913349 FIG00913350: hypothetical protein +FIG00913359 Gas vesicle synthesis GvpLGvpF +FIG00913409 TPR repeat:tetratricopeptide TPR_4 +FIG00913411 FIG00913428: hypothetical protein +FIG00913428 FIG00913429: hypothetical protein +FIG00913429 FIG00913434: hypothetical protein +FIG00913434 Mannose-1-phosphate guanylyltransferase (EC 2.7.7.13 ) +FIG00913436 C protein immunoglobin-a-binding beta antigen +FIG00913448 Cinnamoyl-CoA reductase (EC 1.2.1.44) +FIG00913517 FIG00913518: hypothetical protein +FIG00913518 PMID: 12093901 +FIG00913523 FIG00913533: hypothetical protein +FIG00913563 thiol:disulfide interchange protein, thioredoxin family protein +FIG00913575 Tia invasion determinant-related protein +FIG00913641 Glycosyl transferase, group 1 precursor +FIG00913665 D-lactate dehydrogenase (Cytochrome) (EC 1.1.2.4) +FIG00913725 Cytochrome c-555 +FIG00913749 Filamentous haemagglutinin-like protein +FIG00913781 peptidase C1A papain +FIG00913822 COG1836 / phytol kinase +FIG00913842 Peptidase M20D, amidohydrolase (EC 3.5.1.32) +FIG00913875 FIG00913907: hypothetical protein +FIG00913999 FIG00914000: hypothetical protein +FIG00914028 FIG00914029: hypothetical protein +FIG00914050 FIG00914052: hypothetical protein +FIG00914198 FIG00914211: hypothetical protein +FIG00914235 bacteriochlorophyll C binding protein +FIG00914238 FIG00914241: hypothetical protein +FIG00914262 alpha-amylase family protein +FIG00914305 DNA topoisomerase type IA zn finger domain protein +FIG00914315 FIG00914320: hypothetical protein +FIG00914469 FIG00914470: hypothetical protein +FIG00914485 protein of unknown function DUF218 +FIG00914495 FIG00914497: hypothetical protein +FIG00914524 FIG00914532: hypothetical protein +FIG00914532 ComEC/Rec2-related protein +FIG00914557 FIG00914562: hypothetical protein +FIG00914689 FIG01077539: hypothetical protein +FIG00914713 putative R-2-hydroxyglutaryl-CoA dehydratase subunit +FIG00914895 FIG00914900: hypothetical protein +FIG00914994 Glutaconate CoA-transferase( EC:2.8.3.12 ) +FIG00915164 histidinol phosphatase and related hydrolases of the PHP family +FIG00915838 sulfur transfer protein +FIG00915867 Membrane-associated sensory histidine kinase with HAMP domain +FIG00916175 glycoside hydrolase, family 57 +FIG00916304 FIG00916335: hypothetical protein +FIG00916389 Spore photoproduct lyase (EC 4.1.99.14) +FIG00916542 type IV prepilin leader peptidase pilD( EC:3.4.99.- ) +FIG00916548 FIG00916549: hypothetical protein +FIG00916555 FIG00916557: hypothetical protein +FIG00916557 FIG00379787: hypothetical protein +FIG00916562 FIG00916565: hypothetical protein +FIG00916568 prophage LambdaCh01, nuclease domain protein +FIG00916572 FIG00916573: hypothetical protein +FIG00916574 FIG00916577: hypothetical protein +FIG00916579 putative transcription regulator (ArsR family) +FIG00916585 FIG00916586: hypothetical protein +FIG00916586 FIG00916587: hypothetical protein +FIG00916587 FIG00916588: hypothetical protein +FIG00916589 FIG00916591: hypothetical protein +FIG00916597 Benzoyl-CoA reductase subunit BadD (EC 1.3.99.15) +FIG00916600 FIG00916601: hypothetical protein +FIG00916601 FIG00916602: hypothetical protein +FIG00916610 3-oxoadipate CoA-transferase subunit B (EC 2.8.3.6); Glutaconate CoA-transferase subunit B (EC 2.8.3.12) +FIG00916612 FIG00916615: hypothetical protein +FIG00916615 FIG00916616: hypothetical protein +FIG00916616 FIG00916619: hypothetical protein +FIG00916631 FIG00916632: hypothetical protein +FIG00916632 NAD(P)H oxidase +FIG00916635 FIG00916639: hypothetical protein +FIG00916639 predicted hydrolase or acyltransferase (alpha/beta hydrolase superfamily) +FIG00916640 FIG00916641: hypothetical protein +FIG00916649 FIG00916650: hypothetical protein +FIG00916651 FIG00916652: hypothetical protein +FIG00916663 FIG00916664: hypothetical protein +FIG00916664 FIG00916665: hypothetical protein +FIG00916670 FIG00916672: hypothetical protein +FIG00916672 FIG00916673: hypothetical protein +FIG00916675 FIG00916677: hypothetical protein +FIG00916677 FIG00916678: hypothetical protein +FIG00916678 FIG00916679: hypothetical protein +FIG00916680 FIG00916681: hypothetical protein +FIG00916681 FIG00916682: hypothetical protein +FIG00916682 FIG00916683: hypothetical protein +FIG00916686 FIG00916687: hypothetical protein +FIG00916687 FIG00916688: hypothetical protein +FIG00916688 FIG00916690: hypothetical protein +FIG00916690 Benzoyl-CoA reductase subunit BadG (EC 1.3.99.15) +FIG00916691 FIG00916692: hypothetical protein +FIG00916712 FIG00916714: hypothetical protein +FIG00916953 putative DNA polymerase III, delta subunit [EC:2.7.7.7] +FIG00916988 Uncharacterized protein MJ1066 +FIG00917048 FIG00917055: hypothetical protein +FIG00917171 putative (R)-2-hydroxyglutaryl-CoA dehydratase activator-related protein +FIG00917301 Predicted glucose oligosaccharide utilization regulator, LacI family +FIG00917367 Tungstate ABC transporter, permease protein WtpB +FIG00917651 FIG00917652: hypothetical protein +FIG00917665 Taurine--pyruvate aminotransferase (EC 2.6.1.77) +FIG00917679 FIG00990760: hypothetical protein +FIG00917682 Probable ATP-binding/permease fusion ABC transporter +FIG00917697 FIG00917699: hypothetical protein +FIG00917747 FIG00917748: hypothetical protein +FIG00917749 FIG00917750: hypothetical protein +FIG00917771 FIG00917773: hypothetical protein +FIG00917784 FIG00917785: hypothetical protein +FIG00917812 Short-chain dehydrogenase/reductase SDR precursor +FIG00917822 FIG00917825: hypothetical protein +FIG00917851 PRC protein +FIG00917862 Universal stress protein family protein +FIG00917868 allergen V5/TPX-1 family protein +FIG00917873 FIG00917874: hypothetical protein +FIG00917878 NUDIX domain protein +FIG00917886 FIG00917887: hypothetical protein +FIG00917896 putative aromatic-L-amino-acid decarboxylase +FIG00917912 outer membrane protein, 28Kda +FIG00917927 Mll8356 protein +FIG00917940 PROBABLE TRANSMEMBRANE SENSOR HISTIDINE KINASE TRANSCRIPTION REGULATOR PROTEIN( EC:2.7.3.- ) +FIG00917964 FIG00917966: hypothetical protein +FIG00917976 FIG00917977: hypothetical protein +FIG00917977 FIG00917978: hypothetical protein +FIG00917985 FIG00917987: hypothetical protein +FIG00917998 FIG00918002: hypothetical protein +FIG00918005 FIG00918008: hypothetical protein +FIG00918014 Glutamate synthase, small subunit (EC 1.4.1.13) +FIG00918060 FIG00918061: hypothetical protein +FIG00918064 FIG00918066: hypothetical protein +FIG00918120 FIG00992211: hypothetical protein +FIG00918137 FIG00918138: hypothetical protein +FIG00918144 FIG00918147: hypothetical protein +FIG00918153 FIG00918154: hypothetical protein +FIG00918167 FIG042921: similarity to aminoacyl-tRNA editing enzymes YbaK, ProX +FIG00918176 FIG00918179: hypothetical protein +FIG00918179 RIKEN cDNA 2310005O14 +FIG00918181 amino acid regulated cytosolic protein +FIG00918184 FIG00918187: hypothetical protein +FIG00918187 RepA +FIG00918208 predicted signal transduction protein containing a membrane domain, an EAL and a GGDEF domain +FIG00918222 FIG00918224: hypothetical protein +FIG00918264 FIG00918265: hypothetical protein +FIG00918330 FIG00918332: hypothetical protein +FIG00918341 FIG00918342: hypothetical protein +FIG00918343 Glycerol-3-phosphate ABC transporter, ATP-binding protein GlpS +FIG00918346 Esterase/lipase +FIG00918359 Sulfatase family protein (EC 3.1.3.-) +FIG00918365 FIG00918370: hypothetical protein +FIG00918378 FIG00918383: hypothetical protein +FIG00918387 FIG00918391: hypothetical protein +FIG00918397 Amino acid ABC transporter, binding protein +FIG00918399 response regulator, putative( EC:2.7.3.- ) +FIG00918414 Arsenic resistance protein ArsH +FIG00918450 Tellurite resistance protein (telA) +FIG00918453 FIG00918454: hypothetical protein +FIG00918454 Mll3428 protein +FIG00918468 FIG00918470: hypothetical protein +FIG00918478 ABC transporter, ATP binding/permease protein +FIG00918502 oligopeptide ABC transporter permease protein +FIG00918525 FIG00918526: hypothetical protein +FIG00918528 FIG00918529: hypothetical protein +FIG00918537 FIG00918538: hypothetical protein +FIG00918538 FIG00918542: hypothetical protein +FIG00918569 ABC-type antimicrobial peptide transport system, permease component +FIG00918586 FIG00918590: hypothetical protein +FIG00918596 Mll1065 protein +FIG00918641 FIG00918646: hypothetical protein +FIG00918672 Sigma-54 dependent response regulator +FIG00918686 Iron ABC transporter permease +FIG00918734 FIG00918735: hypothetical protein +FIG00918774 Penicillin-binding protein 1A +FIG00918807 Protein SlyX +FIG00918814 Transporter, AcrB/AcrD/AcrF family +FIG00918822 FIG00918827: hypothetical protein +FIG00918831 FIG00918833: hypothetical protein +FIG00918833 FIG00918834: hypothetical protein +FIG00918872 C4-dicarboxylate transport sensor protein (EC 2.7.3.-) +FIG00918903 TfoX domain protein +FIG00918905 ankrin repeat protein +FIG00918907 FIG00918908: hypothetical protein +FIG00918909 MgtC family protein +FIG00918913 Protein involved in initiation of plasmid replication +FIG00918914 FIG313892: hypothetical protein +FIG00918918 Conserved domain protein +FIG00918919 FIG00918922: hypothetical protein +FIG00918928 FIG00990057: hypothetical protein +FIG00918938 FIG01073616: hypothetical protein +FIG00918949 FIG00918953: hypothetical protein +FIG00918955 FIG00918956: hypothetical protein +FIG00918979 Phosphonate monoester hydrolase +FIG00918993 FIG00918994: hypothetical protein +FIG00919008 Transmembrane transporter, major facilitator family +FIG00919011 FIG00919012: hypothetical protein +FIG00919012 FIG00919017: hypothetical protein +FIG00919017 FIG00919019: hypothetical protein +FIG00919019 FIG00989364: hypothetical protein +FIG00919026 FIG00919027: hypothetical protein +FIG00919028 FIG00919029: hypothetical protein +FIG00919037 FIG01072755: hypothetical protein +FIG00919044 Porin +FIG00919046 FIG00919048: hypothetical protein +FIG00919048 Cytochrome P-450 hydroxylase +FIG00919059 Cytochrome c biogenesis family protein +FIG00919076 FIG00989546: hypothetical protein +FIG00919106 FIG00919107: hypothetical protein +FIG00919116 FIG00919120: hypothetical protein +FIG00919123 FIG00919126: hypothetical protein +FIG00919133 FIG00919141: hypothetical protein +FIG00919166 FIG00919167: hypothetical protein +FIG00919179 FIG00993008: hypothetical protein +FIG00919183 FIG01024109: hypothetical protein +FIG00919219 Serine/threonine protein phosphatase family protein +FIG00919235 FIG00919237: hypothetical protein +FIG00919239 FIG00919240: hypothetical protein +FIG00919247 identified by similarity to PIR:G97485 +FIG00919255 FIG00919257: hypothetical protein +FIG00919324 FIG00919325: hypothetical protein +FIG00919328 FIG00990609: hypothetical protein +FIG00919371 FIG00919374: hypothetical protein +FIG00919386 Alpha-1,2-fucosyltransferase +FIG00919387 FIG00919389: hypothetical protein +FIG00919395 NADH-FMN oxidoreductase +FIG00919403 FIG00919408: hypothetical protein +FIG00919408 rhodanese-like +FIG00919416 FIG00919417: hypothetical protein +FIG00919417 FIG00919421: hypothetical protein +FIG00919426 MJ0042 family finger-like domain protein +FIG00919438 putative saccharopine reductase +FIG00919458 FIG00919459: hypothetical protein +FIG00919459 FIG00919460: hypothetical protein +FIG00919461 FIG00919463: hypothetical protein +FIG00919463 FIG00919468: hypothetical protein +FIG00919470 Probable ribosomal protein S6 modification protein +FIG00919472 FIG00919473: hypothetical protein +FIG00919476 FIG00919478: hypothetical protein +FIG00919478 FIG00919481: hypothetical protein +FIG00919481 FIG00919482: hypothetical protein +FIG00919482 FIG00919484: hypothetical protein +FIG00919485 FIG00919487: hypothetical protein +FIG00919489 FIG00919492: hypothetical protein +FIG00919497 FIG00919498: hypothetical protein +FIG00919498 FIG00919503: hypothetical protein +FIG00919505 FIG00919506: hypothetical protein +FIG00919507 FIG00919508: hypothetical protein +FIG00919508 FIG00919509: hypothetical protein +FIG00919511 FIG00919513: hypothetical protein +FIG00919513 FIG01200136: hypothetical protein +FIG00919517 FIG00919518: hypothetical protein +FIG00919519 Gsl0042 protein +FIG00919521 FIG00919522: hypothetical protein +FIG00919522 FIG00919523: hypothetical protein +FIG00919523 FIG00919528: hypothetical protein +FIG00919533 FIG00919534: hypothetical protein +FIG00919534 FIG00919535: hypothetical protein +FIG00919536 FIG00919543: hypothetical protein +FIG00919551 FIG00919554: hypothetical protein +FIG00919554 Signal peptide peptidase SppA (EC 3.4.21.-) +FIG00919555 FIG00919557: hypothetical protein +FIG00919561 FIG00919563: hypothetical protein +FIG00919563 FIG00919564: hypothetical protein +FIG00919564 FIG00919565: hypothetical protein +FIG00919565 FIG00919567: hypothetical protein +FIG00919577 flagellar hook-associated protein +FIG00919580 FIG00919582: hypothetical protein +FIG00919586 FIG00919590: hypothetical protein +FIG00919590 FIG00919591: hypothetical protein +FIG00919594 FIG00919599: hypothetical protein +FIG00919599 FIG00919603: hypothetical protein +FIG00919609 FIG00919611: hypothetical protein +FIG00919611 FIG00919612: hypothetical protein +FIG00919619 FIG00919622: hypothetical protein +FIG00919627 FIG00919628: hypothetical protein +FIG00919629 FIG00919630: hypothetical protein +FIG00919637 FIG00919638: hypothetical protein +FIG00919647 FIG00919648: hypothetical protein +FIG00919648 FIG00919649: hypothetical protein +FIG00919649 FIG00919651: hypothetical protein +FIG00919651 FIG00919652: hypothetical protein +FIG00919652 FIG00919653: hypothetical protein +FIG00919658 Curlin genes transcriptional activator +FIG00919659 FIG00919660: hypothetical protein +FIG00919660 FIG00919661: hypothetical protein +FIG00919664 FIG00919670: hypothetical protein +FIG00919670 FIG00919672: hypothetical protein +FIG00919676 FIG00919678: hypothetical protein +FIG00919679 FIG00919680: hypothetical protein +FIG00919682 FIG00919685: hypothetical protein +FIG00919685 FIG00919686: hypothetical protein +FIG00919687 FIG00919688: hypothetical protein +FIG00919689 FIG00919690: hypothetical protein +FIG00919693 FIG00919694: hypothetical protein +FIG00919694 FIG00919696: hypothetical protein +FIG00919696 FIG00919702: hypothetical protein +FIG00919702 FIG00919704: hypothetical protein +FIG00919706 FIG00919708: hypothetical protein +FIG00919711 FIG00919714: hypothetical protein +FIG00919714 FIG00919716: hypothetical protein +FIG00919716 FIG00919718: hypothetical protein +FIG00919718 hypothetical dksA-type zinc finger protein +FIG00919722 FIG00919723: hypothetical protein +FIG00919727 FIG00919728: hypothetical protein +FIG00919728 FIG00919729: hypothetical protein +FIG00919730 FIG00919732: hypothetical protein +FIG00919732 FIG00919734: hypothetical protein +FIG00919734 FIG00919737: hypothetical protein +FIG00919737 FIG00919738: hypothetical protein +FIG00919738 probable proline rich transmembrane protein +FIG00919739 FIG00919740: hypothetical protein +FIG00919741 FIG00919743: hypothetical protein +FIG00919743 FIG00919745: hypothetical protein +FIG00919745 FIG00919748: hypothetical protein +FIG00919748 FIG00919752: hypothetical protein +FIG00919753 FIG00919754: hypothetical protein +FIG00919759 FIG00919760: hypothetical protein +FIG00919760 FIG00919763: hypothetical protein +FIG00919763 FIG00919765: hypothetical protein +FIG00919769 FIG00919770: hypothetical protein +FIG00919770 FIG00919773: hypothetical protein +FIG00919773 FIG00919777: hypothetical protein +FIG00919780 FIG00919781: hypothetical protein +FIG00919784 FIG00919786: hypothetical protein +FIG00919790 FIG00919791: hypothetical protein +FIG00919793 FIG00919795: hypothetical protein +FIG00919795 FIG00919800: hypothetical protein +FIG00919800 FIG00919801: hypothetical protein +FIG00919807 FIG00919808: hypothetical protein +FIG00919808 FIG00919812: hypothetical protein +FIG00919817 FIG00919818: hypothetical protein +FIG00919818 FIG00919822: hypothetical protein +FIG00919822 LfgM +FIG00919824 FIG00919826: hypothetical protein +FIG00919826 FIG00919830: hypothetical protein +FIG00919830 FIG00919833: hypothetical protein +FIG00919841 FIG00919842: hypothetical protein +FIG00919842 FIG00919847: hypothetical protein +FIG00919851 FIG00919854: hypothetical protein +FIG00919854 FIG00919855: hypothetical protein +FIG00919855 FIG00919863: hypothetical protein +FIG00919863 glycine cleavage system regulatory protein +FIG00919866 FIG00919869: hypothetical protein +FIG00919875 hypothetical AraC-family transcriptionalregulatory protein +FIG00919880 FIG00919881: hypothetical protein +FIG00919886 FIG00919888: hypothetical protein +FIG00919888 FIG00919890: hypothetical protein +FIG00919890 FIG00919891: hypothetical protein +FIG00919891 FIG00919892: hypothetical protein +FIG00919893 FIG00919894: hypothetical protein +FIG00919900 FIG00919902: hypothetical protein +FIG00919902 FIG00919903: hypothetical protein +FIG00919904 FIG00919905: hypothetical protein +FIG00919906 FIG00919907: hypothetical protein +FIG00919907 FIG00919909: hypothetical protein +FIG00919909 FIG00919912: hypothetical protein +FIG00919913 FIG00919916: hypothetical protein +FIG00919916 FIG00919917: hypothetical protein +FIG00919920 FIG00919921: hypothetical protein +FIG00919921 FIG00919923: hypothetical protein +FIG00919924 FIG00919927: hypothetical protein +FIG00919931 FIG00919932: hypothetical protein +FIG00919933 Membrane-bound metal-dependent hydrolase +FIG00919934 FIG00919935: hypothetical protein +FIG00919935 FIG00919936: hypothetical protein +FIG00919938 FIG00919939: hypothetical protein +FIG00919939 FIG00919940: hypothetical protein +FIG00919941 FIG00919942: hypothetical protein +FIG00919942 FIG00919948: hypothetical protein +FIG00919948 FIG00919949: hypothetical protein +FIG00919949 FIG00919950: hypothetical protein +FIG00919950 hypothetical Ap4A phosphorylase II +FIG00919955 FIG00919960: hypothetical protein +FIG00919961 FIG00919963: hypothetical protein +FIG00919963 FIG00919964: hypothetical protein +FIG00919964 Aminopeptidase N +FIG00919966 ubiE/COQ5 methyltransferase +FIG00919967 FIG00919969: hypothetical protein +FIG00919972 FIG00919973: hypothetical protein +FIG00919973 putative sodium-type flagellar protein MotY precursor +FIG00919975 FIG00919976: hypothetical protein +FIG00919980 FIG00919982: hypothetical protein +FIG00919982 FIG00919983: hypothetical protein +FIG00919983 FIG00919985: hypothetical protein +FIG00919985 FIG00919987: hypothetical protein +FIG00919988 FIG00919989: hypothetical protein +FIG00919989 FIG00919990: hypothetical protein +FIG00919991 FIG00919995: hypothetical protein +FIG00919995 FIG00919998: hypothetical protein +FIG00919999 FIG00920002: hypothetical protein +FIG00920003 Thioredoxin 2 +FIG00920004 FIG00920005: hypothetical protein +FIG00920005 FIG00920009: hypothetical protein +FIG00920009 FIG00920012: hypothetical protein +FIG00920014 FIG00920016: hypothetical protein +FIG00920016 FIG00920018: hypothetical protein +FIG00920018 FIG00920020: hypothetical protein +FIG00920020 FIG00920022: hypothetical protein +FIG00920027 FIG00920030: hypothetical protein +FIG00920035 FIG00920038: hypothetical protein +FIG00920038 FIG00920041: hypothetical protein +FIG00920041 FIG00920043: hypothetical protein +FIG00920043 FIG00920047: hypothetical protein +FIG00920047 FIG00920048: hypothetical protein +FIG00920049 FIG00920052: hypothetical protein +FIG00920052 FIG00920056: hypothetical protein +FIG00920060 FIG00920061: hypothetical protein +FIG00920066 FIG00920067: hypothetical protein +FIG00920067 FIG00920068: hypothetical protein +FIG00920068 probable anti-sigma factor, ChrR +FIG00920073 FIG00920074: hypothetical protein +FIG00920078 Periplasmic linker protein, putative +FIG00920081 FIG00920083: hypothetical protein +FIG00920083 FIG00920084: hypothetical protein +FIG00920084 FIG00920085: hypothetical protein +FIG00920085 FIG00920087: hypothetical protein +FIG00920087 hypothetical ParA family protein +FIG00920088 FIG00920089: hypothetical protein +FIG00920089 FIG00920090: hypothetical protein +FIG00920090 FIG00920093: hypothetical protein +FIG00920093 FIG00920094: hypothetical protein +FIG00920095 thermolabile hemolysin +FIG00920100 FIG00920102: hypothetical protein +FIG00920107 FIG00920108: hypothetical protein +FIG00920108 FIG00920110: hypothetical protein +FIG00920114 FIG00920116: hypothetical protein +FIG00920130 FIG00920131: hypothetical protein +FIG00920131 FIG00920132: hypothetical protein +FIG00920132 FIG00920133: hypothetical protein +FIG00920133 FIG00920134: hypothetical protein +FIG00920134 FIG00920135: hypothetical protein +FIG00920135 FIG00920136: hypothetical protein +FIG00920136 FIG00920139: hypothetical protein +FIG00920140 LfgN +FIG00920141 FIG00920142: hypothetical protein +FIG00920142 hypothetical transcriptional regulator +FIG00920144 FIG00920146: hypothetical protein +FIG00920146 FIG00920147: hypothetical protein +FIG00920153 FIG00920155: hypothetical protein +FIG00920155 FIG00920156: hypothetical protein +FIG00920156 FIG00920157: hypothetical protein +FIG00920158 FIG00920162: hypothetical protein +FIG00920162 FIG00920164: hypothetical protein +FIG00920165 Auxin-binding protein +FIG00920166 FIG00920167: hypothetical protein +FIG00920168 FIG00920170: hypothetical protein +FIG00920170 FIG00920172: hypothetical protein +FIG00920172 FIG00920173: hypothetical protein +FIG00920173 FIG00920176: hypothetical protein +FIG00920178 FIG00920179: hypothetical protein +FIG00920179 Mlr5527 protein +FIG00920181 FIG00920183: hypothetical protein +FIG00920183 Putative oligoketide cyclase/lipid transport protein, similarity with yeast ubiquinone-binding protein YOL008W +FIG00920184 sucrose operon repressor; transcriptional regulator, LacI family protein +FIG00920190 FIG00920191: hypothetical protein +FIG00920193 FIG00920194: hypothetical protein +FIG00920194 Probable thiol oxidoreductase with 2 cytochrome c heme-binding sites +FIG00920198 FIG00920199: hypothetical protein +FIG00920200 FIG00920203: hypothetical protein +FIG00920203 FIG00920204: hypothetical protein +FIG00920204 FIG00920209: hypothetical protein +FIG00920211 FIG00920212: hypothetical protein +FIG00920220 FIG00920222: hypothetical protein +FIG00920222 FIG00920226: hypothetical protein +FIG00920226 FIG00920227: hypothetical protein +FIG00920229 FIG00920233: hypothetical protein +FIG00920234 FIG00920235: hypothetical protein +FIG00920235 FIG00920236: hypothetical protein +FIG00920237 FIG00920238: hypothetical protein +FIG00920238 FIG00920240: hypothetical protein +FIG00920240 FIG00920243: hypothetical protein +FIG00920243 FIG00920244: hypothetical protein +FIG00920245 FIG00920253: hypothetical protein +FIG00920253 FIG00920257: hypothetical protein +FIG00920257 DOPA-dioxygenase-related protein +FIG00920259 FIG00920260: hypothetical protein +FIG00920260 FIG00920263: hypothetical protein +FIG00920263 FIG00920264: hypothetical protein +FIG00920264 FIG00920267: hypothetical protein +FIG00920267 FIG00920268: hypothetical protein +FIG00920268 FIG00920271: hypothetical protein +FIG00920271 FIG00920272: hypothetical protein +FIG00920273 FIG00920274: hypothetical protein +FIG00920283 FIG00920289: hypothetical protein +FIG00920290 FIG00920291: hypothetical protein +FIG00920291 FIG00920294: hypothetical protein +FIG00920294 FIG00920296: hypothetical protein +FIG00920296 FIG00920297: hypothetical protein +FIG00920303 FIG00920305: hypothetical protein +FIG00920306 FIG00920307: hypothetical protein +FIG00920308 FIG00920311: hypothetical protein +FIG00920311 FIG00920313: hypothetical protein +FIG00920317 FIG00920319: hypothetical protein +FIG00920323 FIG00920324: hypothetical protein +FIG00920325 FIG00920326: hypothetical protein +FIG00920326 FIG00920327: hypothetical protein +FIG00920327 FIG00920328: hypothetical protein +FIG00920328 FIG00920331: hypothetical protein +FIG00920334 FIG00920336: hypothetical protein +FIG00920343 FIG00920344: hypothetical protein +FIG00920345 FIG00920346: hypothetical protein +FIG00920346 FIG00920348: hypothetical protein +FIG00920348 FIG00920349: hypothetical protein +FIG00920351 FIG00920353: hypothetical protein +FIG00920353 FIG00920355: hypothetical protein +FIG00920360 FIG00920361: hypothetical protein +FIG00920362 FIG00920365: hypothetical protein +FIG00920370 Predicted transcriptional regulator +FIG00920377 FIG00920378: hypothetical protein +FIG00920380 FIG00920384: hypothetical protein +FIG00920389 FIG00920391: hypothetical protein +FIG00920397 FIG00920403: hypothetical protein +FIG00920409 FIG00920410: hypothetical protein +FIG00920410 FIG00920413: hypothetical protein +FIG00920419 FIG00920420: hypothetical protein +FIG00920420 FIG00920421: hypothetical protein +FIG00920422 FIG01199992: hypothetical protein +FIG00920423 FIG00920424: hypothetical protein +FIG00920424 FIG00920425: hypothetical protein +FIG00920425 FIG00920427: hypothetical protein +FIG00920427 FIG00920432: hypothetical protein +FIG00920433 FIG00920435: hypothetical protein +FIG00920435 FIG00920440: hypothetical protein +FIG00920440 FIG00920442: hypothetical protein +FIG00920442 FIG00920446: hypothetical protein +FIG00920462 FIG00920463: hypothetical protein +FIG00920463 FIG00920464: hypothetical protein +FIG00920464 FIG00920465: hypothetical protein +FIG00920465 FIG00920466: hypothetical protein +FIG00920475 FIG00920476: hypothetical protein +FIG00920476 FIG00920481: hypothetical protein +FIG00920481 FIG00920482: hypothetical protein +FIG00920482 FIG00920484: hypothetical protein +FIG00920488 FIG00920489: hypothetical protein +FIG00920502 FIG00920505: hypothetical protein +FIG00920505 Putative inner membrane protein +FIG00920511 FIG00920515: hypothetical protein +FIG00920515 FIG00920518: hypothetical protein +FIG00920519 FIG00920520: hypothetical protein +FIG00920520 FIG00920522: hypothetical protein +FIG00920522 FIG00920524: hypothetical protein +FIG00920527 FIG00920530: hypothetical protein +FIG00920537 FIG00920539: hypothetical protein +FIG00920541 FIG00920542: hypothetical protein +FIG00920548 FIG00920552: hypothetical protein +FIG00920552 FIG00920553: hypothetical protein +FIG00920554 FIG00920555: hypothetical protein +FIG00920557 FIG00920558: hypothetical protein +FIG00920559 FIG00920560: hypothetical protein +FIG00920560 FIG00920563: hypothetical protein +FIG00920564 FIG00920569: hypothetical protein +FIG00920574 FIG00920576: hypothetical protein +FIG00920581 FIG00920582: hypothetical protein +FIG00920583 Mll0121 protein +FIG00920584 FIG00920585: hypothetical protein +FIG00920587 FIG00920588: hypothetical protein +FIG00920595 FIG00920597: hypothetical protein +FIG00920612 FIG00920614: hypothetical protein +FIG00920614 FIG00920619: hypothetical protein +FIG00920630 FIG00920635: hypothetical protein +FIG00920635 FIG00920637: hypothetical protein +FIG00920637 FIG00920640: hypothetical protein +FIG00920642 hypothetical cell shape-determining protein +FIG00920644 FIG00920646: hypothetical protein +FIG00920651 FIG00920652: hypothetical protein +FIG00920654 FIG00920656: hypothetical protein +FIG00920657 FIG00920660: hypothetical protein +FIG00920665 hypothetical protein +FIG00920668 FIG00920669: hypothetical protein +FIG00920670 FIG00920671: hypothetical protein +FIG00920671 FIG00920672: hypothetical protein +FIG00920672 FIG00920673: hypothetical protein +FIG00920678 FIG00920680: hypothetical protein +FIG00920680 FIG00920684: hypothetical protein +FIG00920684 FIG00920686: hypothetical protein +FIG00920686 FIG00920687: hypothetical protein +FIG00920687 FIG00920688: hypothetical protein +FIG00920688 FIG00920689: hypothetical protein +FIG00920689 FIG00920691: hypothetical protein +FIG00920693 FIG00920694: hypothetical protein +FIG00920696 FIG00920702: hypothetical protein +FIG00920704 FIG00920705: hypothetical protein +FIG00920705 FIG00920709: hypothetical protein +FIG00920709 4-aminobutyrate aminotransferase (EC 2.6.1.19) +FIG00920710 FIG00920711: hypothetical protein +FIG00920717 FIG00920719: hypothetical protein +FIG00920719 hypothetical SulA, SOS-response cell division inhibitor, blocks FtsZring formation +FIG00920721 COG1196: Chromosome segregation ATPases +FIG00920725 FIG00920726: hypothetical protein +FIG00920726 FIG00920727: hypothetical protein +FIG00920731 FIG00920733: hypothetical protein +FIG00920733 FIG00920734: hypothetical protein +FIG00920734 FIG00920735: hypothetical protein +FIG00920736 FIG00920737: hypothetical protein +FIG00920739 FIG00920740: hypothetical protein +FIG00920740 FIG00920741: hypothetical protein +FIG00920741 FIG00920744: hypothetical protein +FIG00920744 FIG00920745: hypothetical protein +FIG00920746 FIG00920747: hypothetical protein +FIG00920757 FIG00920759: hypothetical protein +FIG00920759 FIG00920761: hypothetical protein +FIG00920762 FIG00920767: hypothetical protein +FIG00920767 FIG00920769: hypothetical protein +FIG00920769 FIG00920770: hypothetical protein +FIG00920774 FIG00920775: hypothetical protein +FIG00920775 FIG00920776: hypothetical protein +FIG00920779 FIG00920782: hypothetical protein +FIG00920782 FIG00920784: hypothetical protein +FIG00920784 Hypothetical heat shock protein +FIG00920791 FIG00920792: hypothetical protein +FIG00920792 FIG00920794: hypothetical protein +FIG00920794 FIG00920799: hypothetical protein +FIG00920801 FIG00920802: hypothetical protein +FIG00920802 Putative NAD(P)-dependent oxidoreductase EC-YbbO +FIG00920807 FIG00920809: hypothetical protein +FIG00920810 FIG00920811: hypothetical protein +FIG00920811 FIG00920813: hypothetical protein +FIG00920813 FIG00920814: hypothetical protein +FIG00920814 FIG00920815: hypothetical protein +FIG00920815 FIG00920816: hypothetical protein +FIG00920816 FIG00920817: hypothetical protein +FIG00920817 FIG00920818: hypothetical protein +FIG00920821 FIG00920822: hypothetical protein +FIG00920825 FIG00920830: hypothetical protein +FIG00920830 FIG00920831: hypothetical protein +FIG00920833 FIG00920835: hypothetical protein +FIG00920837 FIG00920839: hypothetical protein +FIG00920844 FIG00920845: hypothetical protein +FIG00920845 FIG00920846: hypothetical protein +FIG00920848 Coagulation factor IX (EC 3.4.21.22) +FIG00920852 FIG00920853: hypothetical protein +FIG00920861 FIG00920865: hypothetical protein +FIG00920866 FIG00920870: hypothetical protein +FIG00920871 FIG00920872: hypothetical protein +FIG00920878 FIG00989860: hypothetical protein +FIG00920879 FIG00920882: hypothetical protein +FIG00920885 FIG00920886: hypothetical protein +FIG00920892 FIG00920893: hypothetical protein +FIG00920895 FIG00920897: hypothetical protein +FIG00920897 FIG00920900: hypothetical protein +FIG00920907 FIG00920909: hypothetical protein +FIG00920909 FIG00920910: hypothetical protein +FIG00920912 FIG00920914: hypothetical protein +FIG00920914 FIG00920915: hypothetical protein +FIG00920915 FIG00920918: hypothetical protein +FIG00920918 FIG00920919: hypothetical protein +FIG00920919 FIG00920923: hypothetical protein +FIG00920926 FIG00920927: hypothetical protein +FIG00920928 FIG00920935: hypothetical protein +FIG00920935 FIG00920937: hypothetical protein +FIG00920937 FIG00920946: hypothetical protein +FIG00920946 FIG00920947: hypothetical protein +FIG00920947 FIG00920949: hypothetical protein +FIG00920950 FIG00920951: hypothetical protein +FIG00920953 FIG00920955: hypothetical protein +FIG00920955 FIG00920957: hypothetical protein +FIG00920958 FIG00920960: hypothetical protein +FIG00920960 FIG00920964: hypothetical protein +FIG00920964 FIG00920965: hypothetical protein +FIG00920976 FIG00920977: hypothetical protein +FIG00920980 FIG00920981: hypothetical protein +FIG00920981 FIG00920983: hypothetical protein +FIG00920985 Putative acetate efflux pump, MadN +FIG00920986 FIG00920988: hypothetical protein +FIG00921004 FIG00921005: hypothetical protein +FIG00921005 FIG00921007: hypothetical protein +FIG00921010 FIG00921013: hypothetical protein +FIG00921013 FIG00921014: hypothetical protein +FIG00921018 FIG00921023: hypothetical protein +FIG00921023 FIG00921024: hypothetical protein +FIG00921024 FIG00921025: hypothetical protein +FIG00921025 FIG00921027: hypothetical protein +FIG00921030 FIG00921032: hypothetical protein +FIG00921034 FIG00921035: hypothetical protein +FIG00921035 FIG00921036: hypothetical protein +FIG00921038 FIG00921039: hypothetical protein +FIG00921039 FIG00921040: hypothetical protein +FIG00921045 FIG00921046: hypothetical protein +FIG00921046 2'-5' RNA ligase (EC 6.5.1.-) +FIG00921047 FIG00921048: hypothetical protein +FIG00921052 FIG00921056: hypothetical protein +FIG00921057 FIG00921058: hypothetical protein +FIG00921058 Beta-mannosidase +FIG00921068 FIG00921069: hypothetical protein +FIG00921069 FIG00921071: hypothetical protein +FIG00921082 FIG00921084: hypothetical protein +FIG00921093 FIG00921097: hypothetical protein +FIG00921097 FIG00921098: hypothetical protein +FIG00921104 FIG00921106: hypothetical protein +FIG00921110 FIG00921112: hypothetical protein +FIG00921112 FIG00921115: hypothetical protein +FIG00921115 FIG00921116: hypothetical protein +FIG00921116 FIG00921117: hypothetical protein +FIG00921117 FIG00921118: hypothetical protein +FIG00921118 Toxin secretion ATP-binding protein +FIG00921130 FIG00921131: hypothetical protein +FIG00921131 FIG00921134: hypothetical protein +FIG00921134 Alpha-amylase +FIG00921135 FIG00921136: hypothetical protein +FIG00921136 FIG00921137: hypothetical protein +FIG00921137 FIG00921138: hypothetical protein +FIG00921141 FIG00921142: hypothetical protein +FIG00921146 FIG00921147: hypothetical protein +FIG00921147 FIG00921148: hypothetical protein +FIG00921148 FIG00921149: hypothetical protein +FIG00921149 Lipoprotein, ToxR-activated gene, TagA +FIG00921150 FIG00921153: hypothetical protein +FIG00921153 FIG00921154: hypothetical protein +FIG00921154 FIG00921155: hypothetical protein +FIG00921155 FIG00921156: hypothetical protein +FIG00921157 FIG00921162: hypothetical protein +FIG00921163 hypothetical spore germination protein +FIG00921165 P120' protein +FIG00921180 FIG00921183: hypothetical protein +FIG00921183 FIG00921183: possible ligase +FIG00921184 FIG00921185: hypothetical protein +FIG00921185 FIG00921186: hypothetical protein +FIG00921186 FIG00921192: hypothetical protein +FIG00921192 FIG00921197: hypothetical protein +FIG00921197 HrpA-like helicase +FIG00921198 FIG00921199: hypothetical protein +FIG00921203 FIG00921205: hypothetical protein +FIG00921207 FIG00921208: hypothetical protein +FIG00921208 Carboxypeptidase A1 precursor (EC 3.4.17.1) +FIG00921214 FIG00921218: hypothetical protein +FIG00921219 Membrane-bound lytic murein transglycosylase D +FIG00921225 FIG00921226: hypothetical protein +FIG00921226 FIG00921229: hypothetical protein +FIG00921230 FIG00921231: hypothetical protein +FIG00921233 FIG00921234: hypothetical protein +FIG00921234 FIG00921235: hypothetical protein +FIG00921235 FIG00921236: hypothetical protein +FIG00921236 FIG00921239: hypothetical protein +FIG00921239 FIG00921242: hypothetical protein +FIG00921244 FIG00921245: hypothetical protein +FIG00921247 FIG00921249: hypothetical protein +FIG00921249 FIG00921250: hypothetical protein +FIG00921250 FIG00921251: hypothetical protein +FIG00921251 FIG00921254: hypothetical protein +FIG00921257 FIG00921258: hypothetical protein +FIG00921259 FIG00921223: hypothetical protein +FIG00921265 FIG00921266: hypothetical protein +FIG00921272 FIG00921273: hypothetical protein +FIG00921275 FIG00921277: hypothetical protein +FIG00921279 FIG00921281: hypothetical protein +FIG00921287 FIG00921288: hypothetical protein +FIG00921292 FIG00921293: hypothetical protein +FIG00921293 FIG00921294: hypothetical protein +FIG00921294 FIG00921296: hypothetical protein +FIG00921296 FIG00921297: hypothetical protein +FIG00921301 FIG00921303: hypothetical protein +FIG00921303 FIG00921307: hypothetical protein +FIG00921318 FIG00921320: hypothetical protein +FIG00921320 FIG00921322: hypothetical protein +FIG00921322 FIG00921323: hypothetical protein +FIG00921336 FIG00921337: hypothetical protein +FIG00921340 FIG00921341: hypothetical protein +FIG00921349 FIG00921350: hypothetical protein +FIG00921357 FIG00921360: hypothetical protein +FIG00921360 FIG00921362: hypothetical protein +FIG00921364 FIG00921367: hypothetical protein +FIG00921374 FIG00921376: hypothetical protein +FIG00921376 FIG00921378: hypothetical protein +FIG00921378 FIG00921380: hypothetical protein +FIG00921380 FIG00921381: hypothetical protein +FIG00921381 FIG00921382: hypothetical protein +FIG00921389 FIG00921390: hypothetical protein +FIG00921397 FIG00921398: hypothetical protein +FIG00921404 FIG00921406: hypothetical protein +FIG00921411 FIG00921412: hypothetical protein +FIG00921414 FIG00921421: hypothetical protein +FIG00921421 FIG00921422: hypothetical protein +FIG00921422 FIG00921423: hypothetical protein +FIG00921426 FIG00921427: hypothetical protein +FIG00921427 FIG00921428: hypothetical protein +FIG00921431 FIG00921432: hypothetical protein +FIG00921433 FIG00921435: hypothetical protein +FIG00921435 FIG00921436: hypothetical protein +FIG00921445 FIG00921446: hypothetical protein +FIG00921446 FIG00921449: hypothetical protein +FIG00921458 FIG00921459: hypothetical protein +FIG00921468 FIG00921471: hypothetical protein +FIG00921474 FIG00921476: hypothetical protein +FIG00921477 FIG00921478: hypothetical protein +FIG00921480 FIG00921481: hypothetical protein +FIG00921486 FIG00921487: hypothetical protein +FIG00921487 FIG00921488: hypothetical protein +FIG00921493 FIG00921495: hypothetical protein +FIG00921500 probable membrane protein YPO3985 +FIG00921505 FIG00921506: hypothetical protein +FIG00921512 FIG00921513: hypothetical protein +FIG00921513 FIG00921514: hypothetical protein +FIG00921514 FIG00921518: hypothetical protein +FIG00921526 FIG00921527: hypothetical protein +FIG00921528 FIG00921529: hypothetical protein +FIG00921533 FIG00921535: hypothetical protein +FIG00921535 FIG00921536: hypothetical protein +FIG00921536 FIG00921539: hypothetical protein +FIG00921539 FIG00921542: hypothetical protein +FIG00921542 FIG00921544: hypothetical protein +FIG00921551 FIG00921552: hypothetical protein +FIG00921565 FIG00921567: hypothetical protein +FIG00921569 FIG00921574: hypothetical protein +FIG00921576 FIG00921577: hypothetical protein +FIG00921581 FIG00921582: hypothetical protein +FIG00921584 FIG00921585: hypothetical protein +FIG00921591 FIG00921593: hypothetical protein +FIG00921594 FIG00921597: hypothetical protein +FIG00921605 FIG00921606: hypothetical protein +FIG00921613 FIG00921614: hypothetical protein +FIG00921617 FIG00921621: hypothetical protein +FIG00921628 FIG00921629: hypothetical protein +FIG00921640 FIG00921643: hypothetical protein +FIG00921644 hypothetical heat shock protein HslJ +FIG00921649 Transcriptional regulator PtxR +FIG00921654 FIG00921656: hypothetical protein +FIG00921660 FIG00921661: hypothetical protein +FIG00921661 FIG00921668: hypothetical protein +FIG00921668 FIG00921672: hypothetical protein +FIG00921676 FIG00921677: hypothetical protein +FIG00921678 FIG00921681: hypothetical protein +FIG00921681 FIG00921683: hypothetical protein +FIG00921683 flagellar protein FliS +FIG00921684 FIG00921687: hypothetical protein +FIG00921687 FIG00921691: hypothetical protein +FIG00921701 Uncharacterized protein Mlr1045 +FIG00921704 FIG00921706: hypothetical protein +FIG00921707 hypothetical Cell wall-associated hydrolase +FIG00921709 FIG00921710: hypothetical protein +FIG00921710 FIG00921711: hypothetical protein +FIG00921711 endoxylanase precursor +FIG00921714 FIG00921716: hypothetical protein +FIG00921723 FIG00921724: hypothetical protein +FIG00921726 FIG00921727: hypothetical protein +FIG00921727 FIG00921729: hypothetical protein +FIG00921739 FIG00921740: hypothetical protein +FIG00921742 FIG00921744: hypothetical protein +FIG00921744 FIG00921746: hypothetical protein +FIG00921747 FIG00921748: hypothetical protein +FIG00921751 FIG00921753: hypothetical protein +FIG00921753 FIG00921754: hypothetical protein +FIG00921765 FIG00921767: hypothetical protein +FIG00921767 FIG00921772: hypothetical protein +FIG00921784 FIG00921786: hypothetical protein +FIG00921790 FIG00921791: hypothetical protein +FIG00921793 FIG00921794: hypothetical protein +FIG00921794 FIG00921795: hypothetical protein +FIG00921799 FIG00921800: hypothetical protein +FIG00921804 FIG00921807: hypothetical protein +FIG00921807 FIG00921810: hypothetical protein +FIG00921823 FIG00921824: hypothetical protein +FIG00921824 FIG00921826: hypothetical protein +FIG00921826 FIG00921829: hypothetical protein +FIG00921829 FIG00921831: hypothetical protein +FIG00921835 FIG00921838: hypothetical protein +FIG00921844 FIG00921845: hypothetical protein +FIG00921846 FIG00921851: hypothetical protein +FIG00921853 FIG00921857: hypothetical protein +FIG00921858 Transcriptional activator of hca cluster +FIG00921867 FIG00921868: hypothetical protein +FIG00921868 Deacetylase DA1 +FIG00921870 FIG00921871: hypothetical protein +FIG00921871 FIG00921872: hypothetical protein +FIG00921873 FIG00921874: hypothetical protein +FIG00921874 FIG00921876: hypothetical protein +FIG00921877 FIG00921880: hypothetical protein +FIG00921880 FIG00921882: hypothetical protein +FIG00921882 FIG00921888: hypothetical protein +FIG00921895 FIG00921900: hypothetical protein +FIG00921921 FIG00921924: hypothetical protein +FIG00921924 FIG00921925: hypothetical protein +FIG00921925 FIG00921926: hypothetical protein +FIG00921926 FIG00921932: hypothetical protein +FIG00921936 FIG00921938: hypothetical protein +FIG00921938 FIG00921940: hypothetical protein +FIG00921940 FIG00921941: hypothetical protein +FIG00921942 FIG00921945: hypothetical protein +FIG00921949 FIG00921951: hypothetical protein +FIG00921952 possible ATP adenylyltransferase +FIG00921956 FIG00921957: hypothetical protein +FIG00921962 FIG00921964: hypothetical protein +FIG00921967 FIG00921969: hypothetical protein +FIG00921979 FIG00921981: hypothetical protein +FIG00921984 FIG00921985: hypothetical protein +FIG00921987 FIG00921988: hypothetical protein +FIG00921988 FIG00921990: hypothetical protein +FIG00921994 FIG00921996: hypothetical protein +FIG00922001 FIG00922003: hypothetical protein +FIG00922012 hypothetical polyprotein +FIG00922014 FIG00922018: hypothetical protein +FIG00922019 FIG00922020: hypothetical protein +FIG00922021 FIG00922022: hypothetical protein +FIG00922039 FIG00922041: hypothetical protein +FIG00922042 FIG00922043: hypothetical protein +FIG00922047 FIG00922048: hypothetical protein +FIG00922048 FIG00922049: hypothetical protein +FIG00922057 Probable two-component system sensor kinase +FIG00922062 FIG018429: hypothetical protein +FIG00922065 FIG00922066: hypothetical protein +FIG00922084 FIG00922087: hypothetical protein +FIG00922088 FIG00922089: hypothetical protein +FIG00922089 FIG00922090: hypothetical protein +FIG00922093 Predicted acyltransferase +FIG00922098 FIG00102676: hypothetical protein +FIG00922101 FIG00922105: hypothetical protein +FIG00922105 FIG00922106: hypothetical protein +FIG00922107 FIG00922109: hypothetical protein +FIG00922109 FIG00922112: hypothetical protein +FIG00922120 Collagen triple helix repeat precursor +FIG00922125 FIG00922127: hypothetical protein +FIG00922132 FIG00922134: hypothetical protein +FIG00922134 FIG00922142: hypothetical protein +FIG00922147 FIG00922155: hypothetical protein +FIG00922155 FIG00922156: hypothetical protein +FIG00922172 FIG00922173: hypothetical protein +FIG00922173 FIG00922175: hypothetical protein +FIG00922180 FIG00922182: hypothetical protein +FIG00922193 FIG00922195: hypothetical protein +FIG00922202 FIG00922204: hypothetical protein +FIG00922217 FIG00922218: hypothetical protein +FIG00922218 FIG00922221: hypothetical protein +FIG00922226 FIG00922228: hypothetical protein +FIG00922237 FIG00922239: hypothetical protein +FIG00922246 FIG00922247: hypothetical protein +FIG00922254 putative flagellar motor switch protein +FIG00922256 FIG00922258: hypothetical protein +FIG00922259 FIG00922260: hypothetical protein +FIG00922260 FIG00922265: hypothetical protein +FIG00922265 FIG00922268: hypothetical protein +FIG00922268 FIG00922271: hypothetical protein +FIG00922274 FIG00922278: hypothetical protein +FIG00922279 FIG00922285: hypothetical protein +FIG00922285 FIG00922287: hypothetical protein +FIG00922303 FIG00922305: hypothetical protein +FIG00922309 FIG00922310: hypothetical protein +FIG00922324 FIG00922326: hypothetical protein +FIG00922326 FIG00922327: hypothetical protein +FIG00922327 FIG00922328: hypothetical protein +FIG00922328 FIG00922329: hypothetical protein +FIG00922329 FIG00922332: hypothetical protein +FIG00922334 FIG00922337: hypothetical protein +FIG00922337 FIG00922342: hypothetical protein +FIG00922350 FIG00922352: hypothetical protein +FIG00922352 FIG00922357: hypothetical protein +FIG00922357 putative carboxypeptidase G2 +FIG00922361 FIG00922362: hypothetical protein +FIG00922364 FIG00922365: hypothetical protein +FIG00922375 FIG00922376: hypothetical protein +FIG00922376 FIG00922378: hypothetical protein +FIG00922378 FIG00922380: hypothetical protein +FIG00922386 FIG00922390: hypothetical protein +FIG00922395 hypothetical transcriptional regulator, AraC family +FIG00922400 FIG00922401: hypothetical protein +FIG00922408 FIG00922411: hypothetical protein +FIG00922429 FIG00922431: hypothetical protein +FIG00922431 FIG00922432: hypothetical protein +FIG00922432 FIG00922433: hypothetical protein +FIG00922433 FIG00922434: hypothetical protein +FIG00922434 FIG00922437: hypothetical protein +FIG00922446 FIG00922447: hypothetical protein +FIG00922449 FIG00922452: hypothetical protein +FIG00922452 FIG00922453: hypothetical protein +FIG00922454 FIG00922456: hypothetical protein +FIG00922457 FIG00922458: hypothetical protein +FIG00922459 putative transglycosylase associated gene +FIG00922461 FIG00922465: hypothetical protein +FIG00922468 FIG00922471: hypothetical protein +FIG00922472 FIG00922475: hypothetical protein +FIG00922476 FIG00922478: hypothetical protein +FIG00922489 FIG01199766: hypothetical protein +FIG00922491 FIG00922492: hypothetical protein +FIG00922504 FIG00922505: hypothetical protein +FIG00922506 pyridoxamine 5'-phosphate oxidase( EC:1.4.3.5 ) +FIG00922509 FIG00922510: hypothetical protein +FIG00922520 FIG00922522: hypothetical protein +FIG00922522 FIG00922524: hypothetical protein +FIG00922529 FIG00922530: hypothetical protein +FIG00922530 FIG00922531: hypothetical protein +FIG00922533 FIG00922534: hypothetical protein +FIG00922541 FIG00922542: hypothetical protein +FIG00922543 FIG00922546: hypothetical protein +FIG00922551 FIG00922556: hypothetical protein +FIG00922573 FIG00922574: hypothetical protein +FIG00922591 FIG00922595: hypothetical protein +FIG00922595 FIG00922596: hypothetical protein +FIG00922597 FIG00922600: hypothetical protein +FIG00922607 FIG00922608: hypothetical protein +FIG00922610 FIG00922611: hypothetical protein +FIG00922611 FIG00922613: hypothetical protein +FIG00922613 FIG00922615: hypothetical protein +FIG00922615 FIG00922616: hypothetical protein +FIG00922616 FIG00922618: hypothetical protein +FIG00922626 FIG00922629: hypothetical protein +FIG00922647 Glycine betaine transporter opuD +FIG00922648 FIG00922650: hypothetical protein +FIG00922650 FIG00922652: hypothetical protein +FIG00922652 FIG00922653: hypothetical protein +FIG00922678 FIG00922679: hypothetical protein +FIG00922679 FIG00922680: hypothetical protein +FIG00922680 FIG00922682: hypothetical protein +FIG00922685 FIG00922690: hypothetical protein +FIG00922707 FIG00922709: hypothetical protein +FIG00922711 FIG00922723: hypothetical protein +FIG00922730 FIG002292: Phosphodiesterase yfcE (EC 3.1.4.-) +FIG00922735 FIG00922737: hypothetical protein +FIG00922742 FIG00922745: hypothetical protein +FIG00922747 FIG00922748: hypothetical protein +FIG00922773 choloylglycine hydrolase family +FIG00922784 unknown +FIG00922787 FIG00922789: hypothetical protein +FIG00922789 FIG00922790: hypothetical protein +FIG00922796 FIG00922797: hypothetical protein +FIG00922806 FIG00922808: hypothetical protein +FIG00922815 FIG00922818: hypothetical protein +FIG00922819 FIG00922820: hypothetical protein +FIG00922827 FIG00922831: hypothetical protein +FIG00922834 FIG00922836: hypothetical protein +FIG00922836 FIG00922842: hypothetical protein +FIG00922860 FIG00922863: hypothetical protein +FIG00922869 iron aquisition yersiniabactin synthesis enzyme (Irp1,polyketide synthetase) +FIG00922874 FIG00922877: hypothetical protein +FIG00922877 FIG00922879: hypothetical protein +FIG00922888 FIG00922890: hypothetical protein +FIG00922897 FIG00922900: hypothetical protein +FIG00922907 FIG00922910: hypothetical protein +FIG00922912 FIG00922913: hypothetical protein +FIG00922915 FIG00922919: hypothetical protein +FIG00922923 FIG00922924: hypothetical protein +FIG00922930 FIG00922932: hypothetical protein +FIG00922932 FIG00922937: hypothetical protein +FIG00922940 FIG00922943: hypothetical protein +FIG00922952 FIG00922954: hypothetical protein +FIG00922960 FIG00922961: hypothetical protein +FIG00922977 FIG00922981: hypothetical protein +FIG00922986 FIG00922993: hypothetical protein +FIG00922993 FIG00922994: hypothetical protein +FIG00922997 FIG00923000: hypothetical protein +FIG00923000 C factor cell-cell signaling protein +FIG00923004 FIG00923006: hypothetical protein +FIG00923006 FIG00923008: hypothetical protein +FIG00923022 FIG00923030: hypothetical protein +FIG00923037 FIG00923042: hypothetical protein +FIG00923042 FIG00923044: hypothetical protein +FIG00923046 FIG00923047: hypothetical protein +FIG00923047 FIG00923048: hypothetical protein +FIG00923059 FIG00923065: hypothetical protein +FIG00923076 FIG00923077: hypothetical protein +FIG00923077 putative manganese transporter +FIG00923095 FIG00923098: hypothetical protein +FIG00923102 FIG00923103: hypothetical protein +FIG00923116 hypothetical protein; Hypothetical transmembrane protein +FIG00923124 FIG00923133: hypothetical protein +FIG00923137 FIG00923138: hypothetical protein +FIG00923147 FIG00923150: hypothetical protein +FIG00923151 FIG00923152: hypothetical protein +FIG00923152 FIG00923153: hypothetical protein +FIG00923155 FIG00923157: hypothetical protein +FIG00923160 FIG00923162: hypothetical protein +FIG00923162 hypothetical protein; Some similarities with tail fiber protein +FIG00923163 Unknown, probable transport protein +FIG00923164 FIG00923168: hypothetical protein +FIG00923168 probable DNA-binding phage-related protein YPO2320 +FIG00923170 FIG00923172: hypothetical protein +FIG00923172 FIG00923174: hypothetical protein +FIG00923183 FIG00923183: possible membrane protein YebY +FIG00923186 FIG00923188: hypothetical protein +FIG00923188 FIG00923190: hypothetical protein +FIG00923198 hypothetical protein; Some similarities with phosphoglycolate phosphatases and phosphoglucomutases +FIG00923202 FIG00923204: hypothetical protein +FIG00923214 Unknown, probable tranport protein +FIG00923219 Complete genome; segment 7/17 +FIG00923223 FIG00923224: hypothetical protein +FIG00923228 cobalamin B12-binding domain protein +FIG00923232 FIG00923233: hypothetical protein +FIG00923238 FIG00923247: hypothetical protein +FIG00923251 FIG00923254: hypothetical protein +FIG00923254 FIG00923259: hypothetical protein +FIG00923259 FIG00923262: hypothetical protein +FIG00923263 FIG00923264: hypothetical protein +FIG00923270 FIG00923271: hypothetical protein +FIG00923271 FIG00923282: hypothetical protein +FIG00923305 FIG00923306: hypothetical protein +FIG00923307 Hemin receptor precursor +FIG00923311 FIG01219968: hypothetical protein +FIG00923318 Putative molybdenum transport ATP-binding protein modF +FIG00923325 FIG00923330: hypothetical protein +FIG00923330 Tail protein X +FIG00923338 Unknown, probable export and assembly of fimbrial adhesin +FIG00923342 Complete genome; segment 6/17 +FIG00923348 FIG00923350: hypothetical protein +FIG00923350 FATTY-ACID-CoA LIGASE FADD26 (FATTY-ACID-COA SYNTHETASE) (FATTY-ACID-CoA SYNTHASE) +FIG00923353 FIG00923354: hypothetical protein +FIG00923354 FIG00923357: hypothetical protein +FIG00923357 FIG00923361: hypothetical protein +FIG00923371 FIG00923375: hypothetical protein +FIG00923380 Caffeic acid 3-O-methyltransferase (EC 2.1.1.68) +FIG00923382 hypothetical protein; Some similarities with unknown protein. Putative transmembrane protein +FIG00923390 FIG00923392: hypothetical protein +FIG00923392 FIG00923394: hypothetical protein +FIG00923394 FIG00923396: hypothetical protein +FIG00923396 FIG00923399: hypothetical protein +FIG00923409 prophage maintenance protein +FIG00923412 FIG00923419: hypothetical protein +FIG00923427 Unknown, putative siderophore membrane receptor of ABC transport system +FIG00923434 FIG00923440: hypothetical protein +FIG00923452 FIG00923454: hypothetical protein +FIG00923457 hypothetical protein; Some similarities with putative hydrolase +FIG00923458 FIG00923459: hypothetical protein +FIG00923459 FIG00923460: hypothetical protein +FIG00923461 FIG00923462: hypothetical protein +FIG00923464 Phospholipase A +FIG00923465 hypothetical protein; Some similarities with probable acetyltransferase +FIG00923468 FIG00923471: hypothetical protein +FIG00923471 FIG00923474: hypothetical protein +FIG00923477 FIG00923478: hypothetical protein +FIG00923480 Para-amino-L-phenylalanine methyltransferase (EC 2.1.1.-) +FIG00923481 FIG00923484: hypothetical protein +FIG00923492 FIG00923500: hypothetical protein +FIG00923509 Unknown, hypothetical toxin +FIG00923527 FIG00923528: hypothetical protein +FIG00923528 MrfJ +FIG00923551 FIG00923555: hypothetical protein +FIG00923555 FIG002901: hypothetical protein co-occurring with Cardiolipin synthetase +FIG00923563 FIG00923564: hypothetical protein +FIG00923575 FIG00923576: hypothetical protein +FIG00923581 FIG00923583: hypothetical protein +FIG00923587 FIG00923591: hypothetical protein +FIG00923595 FIG00923597: hypothetical protein +FIG00923598 FIG00923599: hypothetical protein +FIG00923605 FIG00923606: hypothetical protein +FIG00923609 FyuA precursor +FIG00923610 FIG00923611: hypothetical protein +FIG00923614 hypothetical protein; Some similarities with a protein from bacteriophage and putative transcriptional regulator +FIG00923623 FIG00923625: hypothetical protein +FIG00923625 FIG00923627: hypothetical protein +FIG00923627 Putative LuxR-family regulatory protein +FIG00923634 FIG00923635: hypothetical protein +FIG00923635 FIG00923636: hypothetical protein +FIG00923636 FIG00923641: hypothetical protein +FIG00923657 FIG00923659: hypothetical protein +FIG00923659 FIG00923662: hypothetical protein +FIG00923703 hcp +FIG00923712 probable membrane protein ycbW +FIG00923715 Non-ribosomal peptide synthetase modules, siderophore biosynthesis +FIG00923730 FIG00923731: hypothetical protein +FIG00923731 FIG00923733: hypothetical protein +FIG00923734 probable outer membrane secretion protein - Rhodobacter capsulatus +FIG00923735 PilS2 +FIG00923739 FIG00923741: hypothetical protein +FIG00923762 FIG00923765: hypothetical protein +FIG00923765 FIG00923766: hypothetical protein +FIG00923766 Probable transporter +FIG00923767 hypothetical protein; Some similarities with tail protein from bacteriophage +FIG00923770 hypothetical protein; Some similarities with phage structural protein P5 +FIG00923773 FIG00923776: hypothetical protein +FIG00923776 FIG00923778: hypothetical protein +FIG00923778 FIG00923779: hypothetical protein +FIG00923781 4-amino-4-deoxychorismate synthase, amidotransferase component , aminase component (EC 2.6.1.-) +FIG00923783 Glycoprotein-polysaccharide metabolism +FIG00923792 FIG00923795: hypothetical protein +FIG00923795 FIG00923797: hypothetical protein +FIG00923797 Aliphatic nitrilase (EC 3.5.5.7) +FIG00923806 Putative phospholipase A accessory protein +FIG00923814 FIG00923816: hypothetical protein +FIG00923819 FIG00923820: hypothetical protein +FIG00923842 FIG00923846: hypothetical protein +FIG00923852 FIG00923853: hypothetical protein +FIG00923853 FIG00923857: hypothetical protein +FIG00923857 Fermentation/respiration switch protein +FIG00923867 FIG00923872: hypothetical protein +FIG00923872 FIG00923879: hypothetical protein +FIG00923879 probable exported protein YPO0661 +FIG00923880 hypothetical protein; Some similarities with the N-terminal region of unknown bacteriophage protein +FIG00923887 FIG00923891: hypothetical protein +FIG00923891 FIG00923899: hypothetical protein +FIG00923943 Dermonecrotic toxin +FIG00923944 FIG00923946: hypothetical protein +FIG00923952 Complete genome; segment 16/17 +FIG00923955 FIG00923958: hypothetical protein +FIG00923972 FIG00923980: hypothetical protein +FIG00923983 FIG00923985: hypothetical protein +FIG00923996 FIG00923999: hypothetical protein +FIG00923999 FIG00924003: hypothetical protein +FIG00924007 FIG00924009: hypothetical protein +FIG00924011 Late control gene B protein +FIG00924022 Similarities with repressor protein CI +FIG00924027 Eha +FIG00924030 FIG00924034: hypothetical protein +FIG00924036 Predicted exported alpha-N-acetylgalactosaminidase (EC 3.2.1.49) +FIG00924052 P pilus assembly/Cpx signaling pathway, periplasmic inhibitor/zinc-resistance associated protein +FIG00924054 FIG00924056: hypothetical protein +FIG00924061 Multifunctional acyl-CoA thioesterase I, protease I, lysophospholipase L1 +FIG00924075 FIG00924079: hypothetical protein +FIG00924081 FIG00924083: hypothetical protein +FIG00924089 CRISPR-associated protein, Csy2 family +FIG00924090 PapA +FIG00924099 hypothetical protein; Some similarities with putative membrane protein +FIG00924106 FIG00924111: hypothetical protein +FIG00924111 CzcD accessory protein +FIG00924113 FIG00924114: hypothetical protein +FIG00924121 FIG00924122: hypothetical protein +FIG00924129 hypothetical protein; Some similarities with PilP_like protein of Photorhabdus +FIG00924138 FIG00924140: hypothetical protein +FIG00924159 S-adenosylhomocysteine hydrolase +FIG00924173 FIG00924178: hypothetical protein +FIG00924178 FIG00924179: hypothetical protein +FIG00924179 FIG00924182: hypothetical protein +FIG00924182 FIG00924183: hypothetical protein +FIG00924185 FIG00924188: hypothetical protein +FIG00924188 UPF0266 membrane protein YobD +FIG00924191 FIG00924192: hypothetical protein +FIG00924206 FIG00924211: hypothetical protein +FIG00924231 FIG00635051: hypothetical protein +FIG00924242 FIG00924251: hypothetical protein +FIG00924259 FIG00924265: hypothetical protein +FIG00924269 Unknown, probable transcriptional regulator +FIG00924274 Putative D-ribulokinase (EC 2.7.1.47) +FIG00924276 Unknown, probable bacteriophage protein +FIG00924279 hypothetical protein; Some similarities with the N-terminal region of phosphatidylserine synthase +FIG00924282 FIG00924283: hypothetical protein +FIG00924283 hypothetical protein; Some similarities with putative integral membrane protein +FIG00924298 FIG00924304: hypothetical protein +FIG00924304 FIG00924305: hypothetical protein +FIG00924305 FIG00924306: hypothetical protein +FIG00924320 SUCCINOGLYCAN BIOSYNTHESIS PROTEIN EXOM +FIG00924326 FIG00924328: hypothetical protein +FIG00924337 FIG00924338: hypothetical protein +FIG00924340 hypothetical protein; Hypothetical gene +FIG00924349 FIG00924351: hypothetical protein +FIG00924351 Unknown, probable glycosyl transferase +FIG00924366 Putative Mut family protein +FIG00924380 FIG00924382: hypothetical protein +FIG00924382 FIG00924383: hypothetical protein +FIG00924406 Unknown, probable Membrane Fusion Protein of ABC transporter +FIG00924415 FIG00924421: hypothetical protein +FIG00924427 FIG00924429: hypothetical protein +FIG00924429 FIG00924433: hypothetical protein +FIG00924445 polysaccharide biosynthesis domain protein +FIG00924446 FIG00924447: hypothetical protein +FIG00924455 CRISPR-associated protein, Csy4 family +FIG00924459 Unknown, putative protease +FIG00924460 FIG00924462: hypothetical protein +FIG00924496 FIG00924498: hypothetical protein +FIG00924507 FIG00924510: hypothetical protein +FIG00924510 MrfF +FIG00924530 hypothetical protein; Unknown protein. Putative transmembrane protein +FIG00924535 FIG00924536: hypothetical protein +FIG00924544 FIG00924546: hypothetical protein +FIG00924546 Two-component response regulator BvgR protein +FIG00924551 hypothetical protein; Some similarities with isobutylamine N-hydroxylase and putative oxidoreductase +FIG00924552 FIG00924564: hypothetical protein +FIG00924572 FIG00924577: hypothetical protein +FIG00924578 FIG00924581: hypothetical protein +FIG00924582 Unknown, probable phage protein +FIG00924600 FIG00923650: hypothetical protein +FIG00924610 hypothetical protein; Some similarities with unknown protein +FIG00924628 FIG00924629: hypothetical protein +FIG00924638 FIG00924647: hypothetical protein +FIG00924651 FIG00896318: hypothetical protein +FIG00924652 FIG00924654: hypothetical protein +FIG00924657 FIG00924662: hypothetical protein +FIG00924665 Cytokinin oxidase +FIG00924670 FIG00924674: hypothetical protein +FIG00924678 RidA/YER057c/UK114 superfamily, group 2, YoaB-like protein +FIG00924689 FIG00924690: hypothetical protein +FIG00924698 hypothetical protein; Some similarities with hypothetical glycine-rich protein +FIG00924715 Putative amino acid ABC transport system permease +FIG00924725 FIG00924726: hypothetical protein +FIG00924726 Crystalline inclusion protein type II +FIG00924728 FIG060031: Fimbriae usher protein StfC +FIG00924731 FIG00924733: hypothetical protein +FIG00924733 hypothetical protein; Some similarities with peptide synthetases like lichenysin synthetase A or bacitracin synthetase 3. Putative transmembrane protein +FIG00924734 FIG00924747: hypothetical protein +FIG00924762 hypothetical protein; Hypothetical gene +FIG00924768 FIG00924773: hypothetical protein +FIG00924776 FIG00924782: hypothetical protein +FIG00924784 FIG00924786: hypothetical protein +FIG00924799 hypothetical protein; Some similarities with reticulocyte-binding protein +FIG00924806 FIG00924809: hypothetical protein +FIG00924811 FIG00924815: hypothetical protein +FIG00924815 FIG00924817: hypothetical protein +FIG00924827 FIG00924834: hypothetical protein +FIG00924887 FIG01220449: hypothetical protein +FIG00924925 FIG01219819: hypothetical protein +FIG00924939 Mu-like prophage FluMu protein gp42 +FIG00924954 FIG00924958: hypothetical protein +FIG00924989 FIG00924991: hypothetical protein +FIG00924991 FIG00924997: hypothetical protein +FIG00924997 FIG00925000: hypothetical protein +FIG00925034 Putative ribonuclease +FIG00925037 FIG00925047: hypothetical protein +FIG00925058 FIG00925064: hypothetical protein +FIG00925078 FIG00925086: hypothetical protein +FIG00925086 Unknown, putative tail fiber synthesis +FIG00925095 aculeacin A acylase +FIG00925103 FIG00925105: hypothetical protein +FIG00925128 FIG00925129: hypothetical protein +FIG00925129 Unknown, probable tail synthesis +FIG00925166 FIG00925167: hypothetical protein +FIG00925185 Unknown, probable protein involved in antibiotic biosynthesis +FIG00925189 FIG00925198: hypothetical protein +FIG00925210 hypothetical protein; Some similarities with Nikkomycin biosynthesis protein, carboxylase +FIG00925215 FIG00948938: hypothetical protein +FIG00925224 hypothetical protein; Some similarities with bicyclomycin resistance protein and multidrug resistance protein D +FIG00925226 hypothetical protein; Some similarities with probable aminopeptidase +FIG00925233 FIG00925238: hypothetical protein +FIG00925239 Selenophosphate synthetase-related proteins +FIG00925240 FIG01200619: hypothetical protein +FIG00925246 FIG00925247: hypothetical protein +FIG00925255 4-amino, 4-deoxyprephenate dehydrogenase (EC 1.3.1.-) +FIG00925266 carboxylase +FIG00925268 FIG00925270: hypothetical protein +FIG00925302 FIG00925304: hypothetical protein +FIG00925322 putative beta-hydroxylase +FIG00925351 FIG00925355: hypothetical protein +FIG00925362 FIG00925363: hypothetical protein +FIG00925363 FIG00925364: hypothetical protein +FIG00925391 Crystalline inclusion protein +FIG00925405 protein gp49 +FIG00925417 FIG00925434: hypothetical protein +FIG00925436 FIG00925440: hypothetical protein +FIG00925440 FIG00925448: hypothetical protein +FIG00925507 Unknown, hypothetical insectidal toxins. +FIG00925533 FIG00925536: hypothetical protein +FIG00925536 FIG00925546: hypothetical protein +FIG00925549 FIG00925551: hypothetical protein +FIG00925571 hypothetical protein; Some similarities with unknown protein of Photorhabdus +FIG00925577 FIG00925580: hypothetical protein +FIG00925607 Phage DNA binding protein HkaK +FIG00925609 FIG00925614: hypothetical protein +FIG00925625 FIG00925626: hypothetical protein +FIG00925630 FIG00925639: hypothetical protein +FIG00925686 FIG00925689: hypothetical protein +FIG00925689 FIG00925691: hypothetical protein +FIG00925693 energy +FIG00925694 FIG00925696: hypothetical protein +FIG00925696 FIG00925698: hypothetical protein +FIG00925698 ethanolamine utilization protein EutN-like +FIG00925699 FIG00925704: hypothetical protein +FIG00925704 FIG00925706: hypothetical protein +FIG00925715 lipid, fatty-acid and isoprenoid metabolism; defense related proteins +FIG00925716 metal ion transporters (Cu(2+), Fe(2+), etc.); transport facilitation +FIG00925719 FIG00925720: hypothetical protein +FIG00925720 transcriptional control +FIG00925721 FIG00925722: hypothetical protein +FIG00925722 DNA synthesis and replication +FIG00925723 FIG00925724: hypothetical protein +FIG00925724 FIG00925725: hypothetical protein +FIG00925725 FIG00925726: hypothetical protein +FIG00925726 FIG00925727: hypothetical protein +FIG00925728 FIG00925732: hypothetical protein +FIG00925732 FIG00925735: hypothetical protein +FIG00925735 FIG00925746: hypothetical protein +FIG00925747 FIG00925773: hypothetical protein +FIG00925777 FIG00925779: hypothetical protein +FIG00925779 FIG00925787: hypothetical protein +FIG00925787 FIG00925796: hypothetical protein +FIG00925800 FIG00925806: hypothetical protein +FIG00925806 FIG00925835: hypothetical protein +FIG00925848 PbrT protein-putative c-type cytochrome-like protein +FIG00925852 FIG00925854: hypothetical protein +FIG00925854 FIG00925858: hypothetical protein +FIG00925865 FIG00925866: hypothetical protein +FIG00925878 glutaminyl-tRNA synthetase +FIG00925889 FIG00925900: hypothetical protein +FIG00925900 FIG00925918: hypothetical protein +FIG00925918 FIG00925933: hypothetical protein +FIG00925933 FIG00925937: hypothetical protein +FIG00925937 FIG00925941: hypothetical protein +FIG00925941 FIG00925943: hypothetical protein +FIG00925948 FIG00925962: hypothetical protein +FIG00925962 FIG00925972: hypothetical protein +FIG00925972 FIG00925975: hypothetical protein +FIG00925975 FIG00926008: hypothetical protein +FIG00926008 FIG00926014: hypothetical protein +FIG00926014 FIG00926021: hypothetical protein +FIG00926031 FIG00926034: hypothetical protein +FIG00926034 FIG00926037: hypothetical protein +FIG00926037 FIG00926045: hypothetical protein +FIG00926065 FIG00926074: hypothetical protein +FIG00926087 FIG00926094: hypothetical protein +FIG00926094 FIG00926098: hypothetical protein +FIG00926098 FIG00926102: hypothetical protein +FIG00926102 probable serine/threonine protein kinase related protein +FIG00926109 FIG00926118: hypothetical protein +FIG00926118 FIG00926130: hypothetical protein +FIG00926141 FIG00926149: hypothetical protein +FIG00926154 FIG00926158: hypothetical protein +FIG00926158 FIG00926161: hypothetical protein +FIG00926161 FIG00926165: hypothetical protein +FIG00926165 FIG00926181: hypothetical protein +FIG00926181 pilus assembly protein +FIG00926205 FIG00926212: hypothetical protein +FIG00926212 FIG00926235: hypothetical protein +FIG00926244 FIG00926251: hypothetical protein +FIG00926251 FIG00926255: hypothetical protein +FIG00926270 FIG00926279: hypothetical protein +FIG00926279 probable ribosomal protein S6 +FIG00926284 FIG00926287: hypothetical protein +FIG00926287 FIG00926294: hypothetical protein +FIG00926295 FIG00926312: hypothetical protein +FIG00926312 FIG00926319: hypothetical protein +FIG00926319 FIG00926329: hypothetical protein +FIG00926353 dehydrogenase-like protein +FIG00926378 FIG00926416: hypothetical protein +FIG00926424 FIG00926427: hypothetical protein +FIG00926427 FIG00926468: hypothetical protein +FIG00926474 FIG00926478: hypothetical protein +FIG00926478 FIG00926487: hypothetical protein +FIG00926487 FIG00926492: hypothetical protein +FIG00926535 FIG00926540: hypothetical protein +FIG00926545 putative aga operon transcriptional repressor +FIG00926546 methanol dehydrogenase regulator (moxR)-like protein +FIG00926553 FIG00926562: hypothetical protein +FIG00926576 FIG00926590: hypothetical protein +FIG00926605 Endopygalactorunase-like +FIG00926607 FIG00926638: hypothetical protein +FIG00926640 FIG00926659: hypothetical protein +FIG00926659 FIG00926673: hypothetical protein +FIG00926673 probable ethanolamine utilization protein EutN +FIG00926674 FIG00926693: hypothetical protein +FIG00926693 FIG00926706: hypothetical protein +FIG00926707 FIG00926715: hypothetical protein +FIG00926715 FIG00926721: hypothetical protein +FIG00926721 Protein of unknown function DUF1592 +FIG00926731 FIG00926736: hypothetical protein +FIG00926736 FIG00926764: hypothetical protein +FIG00926769 FIG00926779: hypothetical protein +FIG00926779 FIG00926787: hypothetical protein +FIG00926787 FIG00926794: hypothetical protein +FIG00926794 FIG00926800: hypothetical protein +FIG00926800 FIG00926802: hypothetical protein +FIG00926805 FIG00926821: hypothetical protein +FIG00926821 FIG00926834: hypothetical protein +FIG00926834 FIG00926839: hypothetical protein +FIG00926839 conserved hypothetical protein-containing SET domain +FIG00926841 FIG00926844: hypothetical protein +FIG00926844 FIG00926857: hypothetical protein +FIG00926865 FIG00926872: hypothetical protein +FIG00926872 FIG00926877: hypothetical protein +FIG00926877 FIG00926880: hypothetical protein +FIG00926880 FIG00926881: hypothetical protein +FIG00926881 FIG00926899: hypothetical protein +FIG00926912 FIG00926919: hypothetical protein +FIG00926919 FIG00926933: hypothetical protein +FIG00926933 FIG00926938: hypothetical protein +FIG00926942 FIG00926948: hypothetical protein +FIG00926948 FIG00926977: hypothetical protein +FIG00926977 FIG00926978: hypothetical protein +FIG00926978 FIG00926980: hypothetical protein +FIG00926980 FIG00926983: hypothetical protein +FIG00926983 FIG00926990: hypothetical protein +FIG00926992 FIG00926997: hypothetical protein +FIG00926997 FIG00927001: hypothetical protein +FIG00927001 FIG00927013: hypothetical protein +FIG00927024 FIG00927025: hypothetical protein +FIG00927025 FIG00927034: hypothetical protein +FIG00927034 FIG00927035: hypothetical protein +FIG00927035 FIG00927039: hypothetical protein +FIG00927039 probable 50S ribosomal protein L29 +FIG00927077 FIG00927100: hypothetical protein +FIG00927100 ferripyochelin-binding protein +FIG00927104 FIG00927119: hypothetical protein +FIG00927119 FIG00927127: hypothetical protein +FIG00927128 FIG00927135: hypothetical protein +FIG00927147 conserved hypothetical protein-putative lipolytic enzyme +FIG00927153 FIG00927160: hypothetical protein +FIG00927160 FIG00927175: hypothetical protein +FIG00927177 FIG00927182: hypothetical protein +FIG00927182 FIG00927187: hypothetical protein +FIG00927187 FIG00927194: hypothetical protein +FIG00927194 probable transmembrane transport protein +FIG00927206 FIG00927209: hypothetical protein +FIG00927213 FIG00927222: hypothetical protein +FIG00927222 FIG00927236: hypothetical protein +FIG00927236 SURF4 domain protein +FIG00927239 FIG00927256: hypothetical protein +FIG00927256 FIG00927259: hypothetical protein +FIG00927259 FIG00927266: hypothetical protein +FIG00927266 FIG00927268: hypothetical protein +FIG00927268 periplasmic serine protease DO (htrA-1) +FIG00927289 FIG00927297: hypothetical protein +FIG00927297 Glycosyl hydrolase family 98, putative carbohydrate binding module +FIG00927305 FIG00927312: hypothetical protein +FIG00927320 FIG00927331: hypothetical protein +FIG00927331 FIG00927353: hypothetical protein +FIG00927353 FIG00927354: hypothetical protein +FIG00927354 FIG00927355: hypothetical protein +FIG00927355 FIG00927371: hypothetical protein +FIG00927373 FIG00927389: hypothetical protein +FIG00927389 FIG00927397: hypothetical protein +FIG00927397 FIG00927400: hypothetical protein +FIG00927400 FIG00927419: hypothetical protein +FIG00927419 FIG00927424: hypothetical protein +FIG00927424 FIG00927430: hypothetical protein +FIG00927450 FIG00927459: hypothetical protein +FIG00927459 FIG00927485: hypothetical protein +FIG00927485 Flageller protein FlgA +FIG00927495 conserved hypothetical protein-putative hydrolase +FIG00927497 FIG00927505: hypothetical protein +FIG00927513 FIG00927534: hypothetical protein +FIG00927534 FIG00927537: hypothetical protein +FIG00927537 FIG00927538: hypothetical protein +FIG00927538 FIG00927545: hypothetical protein +FIG00927545 FIG00927547: hypothetical protein +FIG00927547 FIG00927555: hypothetical protein +FIG00927555 unspecified signal transduction; unspecified kinase or ATP dependent regulatory protein; cellular communication/signal transduction +FIG00927571 FIG00927574: hypothetical protein +FIG00927574 FIG00927577: hypothetical protein +FIG00927577 FIG00927585: hypothetical protein +FIG00927585 adenine-specific methyltransferase +FIG00927595 FIG00927604: hypothetical protein +FIG00927604 FIG00927613: hypothetical protein +FIG00927613 FIG00927625: hypothetical protein +FIG00927640 FIG00927664: hypothetical protein +FIG00927664 FIG00927682: hypothetical protein +FIG00927692 FIG00927698: hypothetical protein +FIG00927698 FIG00927703: hypothetical protein +FIG00927703 FIG00927709: hypothetical protein +FIG00927709 FIG00927713: hypothetical protein +FIG00927713 FIG00927714: hypothetical protein +FIG00927714 Chain A, Crystal Structure Of Leutaa, A Bacterial Homolog Of Na+CL-- Dependent Neurotransmitter Transporters +FIG00927715 FIG00927720: hypothetical protein +FIG00927720 FIG00927736: hypothetical protein +FIG00927765 FIG00927768: hypothetical protein +FIG00927768 FIG00927777: hypothetical protein +FIG00927777 FIG00927784: hypothetical protein +FIG00927784 FIG00927793: hypothetical protein +FIG00927808 FIG00927816: hypothetical protein +FIG00927816 FIG00927830: hypothetical protein +FIG00927830 FIG00927843: hypothetical protein +FIG00927843 HtpG +FIG00927844 FIG00927849: hypothetical protein +FIG00927849 FIG00927853: hypothetical protein +FIG00927853 FIG00927854: hypothetical protein +FIG00927854 RidA/YER057c/UK114 superfamily, group 1 +FIG00927860 FIG00927868: hypothetical protein +FIG00927868 FIG00927882: hypothetical protein +FIG00927882 probable phosphoesterase ykuE +FIG00927894 FIG00927904: hypothetical protein +FIG00927904 FIG00927913: hypothetical protein +FIG00927913 FIG00927922: hypothetical protein +FIG00927924 FIG00927927: hypothetical protein +FIG00927927 FIG00927939: hypothetical protein +FIG00927939 FIG00927946: hypothetical protein +FIG00927946 probable general secretion pathway protein K +FIG00927960 FIG00927971: hypothetical protein +FIG00927971 Chromosomal replication initiator protein DnaA +FIG00927984 FIG00927994: hypothetical protein +FIG00927994 FIG00927997: hypothetical protein +FIG00928008 FIG00928010: hypothetical protein +FIG00928010 FIG00928020: hypothetical protein +FIG00928020 LSU ribosomal protein L28p @ LSU ribosomal protein L28p, zinc-dependent +FIG00928024 FIG00928029: hypothetical protein +FIG00928058 FIG00928061: hypothetical protein +FIG00928061 FIG00928075: hypothetical protein +FIG00928075 FIG00928076: hypothetical protein +FIG00928076 FIG00928080: hypothetical protein +FIG00928080 FIG00928084: hypothetical protein +FIG00928084 FIG00928097: hypothetical protein +FIG00928107 FIG00928109: hypothetical protein +FIG00928109 hypothetical protein-putative large transcriptional regulator +FIG00928124 FIG00928130: hypothetical protein +FIG00928130 FIG00928135: hypothetical protein +FIG00928140 FIG00928149: hypothetical protein +FIG00928149 FIG00928156: hypothetical protein +FIG00928156 FIG00928162: hypothetical protein +FIG00928185 FIG00928211: hypothetical protein +FIG00928211 periplasmic tail-specific proteinase +FIG00928213 probable mu-protocadherin-putative cell-suface protein +FIG00928215 FIG00928219: hypothetical protein +FIG00928219 FIG00928228: hypothetical protein +FIG00928228 FIG00928245: hypothetical protein +FIG00928245 FIG00928260: hypothetical protein +FIG00928260 polyketide synthase-like protein +FIG00928262 FIG00928264: hypothetical protein +FIG00928264 FIG00928269: hypothetical protein +FIG00928269 probable ribosomal RNA small subunit methyltransferase C( EC:2.1.1.52 ) +FIG00928270 probable serine/threonine protein kinase afsK +FIG00928289 FIG00928298: hypothetical protein +FIG00928302 FIG00928309: hypothetical protein +FIG00928320 FIG00928323: hypothetical protein +FIG00928329 FIG00928341: hypothetical protein +FIG00928341 CRISPR-associated helicase Cas3 +FIG00928354 FIG00928362: hypothetical protein +FIG00928372 FIG00928374: hypothetical protein +FIG00928374 FIG00928376: hypothetical protein +FIG00928376 FIG00928378: hypothetical protein +FIG00928378 L-fuculose-phosphate aldolase +FIG00928380 FIG00928383: hypothetical protein +FIG00928383 FIG00928390: hypothetical protein +FIG00928390 FIG00928402: hypothetical protein +FIG00928402 FIG00928415: hypothetical protein +FIG00928419 FIG00928436: hypothetical protein +FIG00928436 FIG00928438: hypothetical protein +FIG00928438 FIG00928439: hypothetical protein +FIG00928505 FIG00928508: hypothetical protein +FIG00928508 FIG00928520: hypothetical protein +FIG00928526 FIG00928536: hypothetical protein +FIG00928541 FIG00928553: hypothetical protein +FIG00928564 FIG00928569: hypothetical protein +FIG00928569 FIG00928574: hypothetical protein +FIG00928574 probable biopolymer transport protein +FIG00928607 FIG00928614: hypothetical protein +FIG00928616 FIG00928622: hypothetical protein +FIG00928625 FIG00928626: hypothetical protein +FIG00928626 FIG00928634: hypothetical protein +FIG00928637 FIG00928642: hypothetical protein +FIG00928642 FIG00928645: hypothetical protein +FIG00928645 FIG00928650: hypothetical protein +FIG00928663 FIG00928669: hypothetical protein +FIG00928669 FIG00928684: hypothetical protein +FIG00928684 FIG00928685: hypothetical protein +FIG00928685 FIG00928689: hypothetical protein +FIG00928689 FIG00928704: hypothetical protein +FIG00928704 FIG00928706: hypothetical protein +FIG00928706 FIG00928708: hypothetical protein +FIG00928716 FIG00928728: hypothetical protein +FIG00928728 FIG00928751: hypothetical protein +FIG00928760 FIG00928762: hypothetical protein +FIG00928762 FIG00928773: hypothetical protein +FIG00928773 FIG00928784: hypothetical protein +FIG00928784 FIG00928787: hypothetical protein +FIG00928787 FIG00928793: hypothetical protein +FIG00928793 FIG00928797: hypothetical protein +FIG00928797 FIG00928800: hypothetical protein +FIG00928800 serine proteinase, HtrA/DegQ/DegS family protein +FIG00928801 FIG00928835: hypothetical protein +FIG00928862 FIG00928865: hypothetical protein +FIG00928865 FIG00928870: hypothetical protein +FIG00928870 FIG00928889: hypothetical protein +FIG00928891 FIG00928895: hypothetical protein +FIG00928912 FIG00928915: hypothetical protein +FIG00928915 FIG00928945: hypothetical protein +FIG00928945 FIG00928947: hypothetical protein +FIG00928947 type IV pilus biogenesis protein PilM +FIG00928960 Protease Do-like 5, chloroplast precursor (EC 3.4.21.-) +FIG00928967 FIG00928971: hypothetical protein +FIG00928971 FIG00928973: hypothetical protein +FIG00928973 FIG00928982: hypothetical protein +FIG00929019 FIG00929024: hypothetical protein +FIG00929024 FIG00929026: hypothetical protein +FIG00929031 FIG00929047: hypothetical protein +FIG00929047 FIG00929056: hypothetical protein +FIG00929056 FIG00929061: hypothetical protein +FIG00929061 domain of unknown function DUF71 +FIG00929068 FIG00929070: hypothetical protein +FIG00929070 FIG00929104: hypothetical protein +FIG00929104 FIG00929111: hypothetical protein +FIG00929111 sucrose phosphate synthase +FIG00929114 FIG00929116: hypothetical protein +FIG00929116 probable ATP /GTP binding protein +FIG00929122 FIG00929134: hypothetical protein +FIG00929134 FIG00929140: hypothetical protein +FIG00929140 conserved protein with 2 CBS domains +FIG00929168 probable cytochrome c oxidase, subunit III +FIG00929186 conserved hypothetical protein-putative transcriptional regulator +FIG00929189 FIG00929197: hypothetical protein +FIG00929207 secreted deacetylase +FIG00929216 FIG00929249: hypothetical protein +FIG00929249 FIG00929254: hypothetical protein +FIG00929254 FIG00929258: hypothetical protein +FIG00929258 FIG00929260: hypothetical protein +FIG00929260 FIG00929269: hypothetical protein +FIG00929289 FIG00929290: hypothetical protein +FIG00929290 FIG00929301: hypothetical protein +FIG00929304 FIG00929306: hypothetical protein +FIG00929306 FIG00929325: hypothetical protein +FIG00929331 FIG00929335: hypothetical protein +FIG00929335 FIG00929343: hypothetical protein +FIG00929343 FIG00929355: hypothetical protein +FIG00929355 FIG00929360: hypothetical protein +FIG00929360 FIG00929365: hypothetical protein +FIG00929365 FIG00929370: hypothetical protein +FIG00929371 carbon dioxide concentrating mechanism protein CcmL-like +FIG00929380 FIG00929391: hypothetical protein +FIG00929391 FIG00929392: hypothetical protein +FIG00929392 FIG00929399: hypothetical protein +FIG00929407 FIG00929408: hypothetical protein +FIG00929412 FIG00929442: hypothetical protein +FIG00929442 FIG00929460: hypothetical protein +FIG00929460 FIG00929480: hypothetical protein +FIG00929480 similar to ethanolamine utilization protein EutN +FIG00929483 FIG00929484: hypothetical protein +FIG00929484 FIG00929490: hypothetical protein +FIG00929494 FIG00929496: hypothetical protein +FIG00929496 FIG00929514: hypothetical protein +FIG00929514 FIG00929519: hypothetical protein +FIG00929519 FIG00929526: hypothetical protein +FIG00929526 FIG00929527: hypothetical protein +FIG00929528 FIG00929532: hypothetical protein +FIG00929532 glycosylase +FIG00929535 FIG00929542: hypothetical protein +FIG00929542 FIG00929549: hypothetical protein +FIG00929549 FIG00929565: hypothetical protein +FIG00929565 FIG00929567: hypothetical protein +FIG00929567 FIG00929577: hypothetical protein +FIG00929615 FIG00929619: hypothetical protein +FIG00929619 FIG00929642: hypothetical protein +FIG00929642 FIG00929646: hypothetical protein +FIG00929646 FIG00929654: hypothetical protein +FIG00929656 FIG00929662: hypothetical protein +FIG00929662 FIG00929680: hypothetical protein +FIG00929680 FIG00929681: hypothetical protein +FIG00929681 putative peptidase (fragment) +FIG00929684 FIG00929689: hypothetical protein +FIG00929689 FIG00929700: hypothetical protein +FIG00929700 periplasmic serine proteinase DO +FIG00929703 Piwi domain protein +FIG00929707 FIG00929725: hypothetical protein +FIG00929725 FIG00929738: hypothetical protein +FIG00929738 FIG00929763: hypothetical protein +FIG00929763 Polycystic kidney and hepatic disease 1 precursor +FIG00929768 FIG00929776: hypothetical protein +FIG00929795 FIG00929846: hypothetical protein +FIG00929846 FIG00929858: hypothetical protein +FIG00929858 FIG00929869: hypothetical protein +FIG00929875 FIG00929881: hypothetical protein +FIG00929881 FIG00929895: hypothetical protein +FIG00929895 FIG00929902: hypothetical protein +FIG00929902 FIG00929903: hypothetical protein +FIG00929903 FIG00929909: hypothetical protein +FIG00929909 FIG00929925: hypothetical protein +FIG00929938 FIG00929942: hypothetical protein +FIG00929942 FIG00929958: hypothetical protein +FIG00929958 FIG00929989: hypothetical protein +FIG00929999 FIG00930009: hypothetical protein +FIG00930026 FIG00930027: hypothetical protein +FIG00930029 FIG00930030: hypothetical protein +FIG00930031 FIG00930035: hypothetical protein +FIG00930035 FIG00930036: hypothetical protein +FIG00930036 FIG00930037: hypothetical protein +FIG00930037 FIG00930038: hypothetical protein +FIG00930038 FIG00930039: hypothetical protein +FIG00930039 FIG00930041: hypothetical protein +FIG00930041 FIG00930042: hypothetical protein +FIG00930045 FIG00930048: hypothetical protein +FIG00930049 FIG00930051: hypothetical protein +FIG00930051 FIG00930053: hypothetical protein +FIG00930054 FIG00930057: hypothetical protein +FIG00930058 FIG00930060: hypothetical protein +FIG00930060 FIG00930062: hypothetical protein +FIG00930062 FIG00930063: hypothetical protein +FIG00930065 FIG00930066: hypothetical protein +FIG00930066 putative PRS2 protein +FIG00930072 FIG00930076: hypothetical protein +FIG00930076 FIG00930077: hypothetical protein +FIG00930077 FIG00930078: hypothetical protein +FIG00930080 FIG00930082: hypothetical protein +FIG00930082 FIG00930083: hypothetical protein +FIG00930083 FIG00930086: hypothetical protein +FIG00930086 FIG00930087: hypothetical protein +FIG00930087 FIG00930089: hypothetical protein +FIG00930089 FIG00930091: hypothetical protein +FIG00930091 FIG00930092: hypothetical protein +FIG00930092 FIG00930093: hypothetical protein +FIG00930093 FIG00930095: hypothetical protein +FIG00930099 FIG00930101: hypothetical protein +FIG00930101 FIG00930108: hypothetical protein +FIG00930108 FIG00930109: hypothetical protein +FIG00930109 FIG00930117: hypothetical protein +FIG00930118 FIG00930122: hypothetical protein +FIG00930122 FIG00930123: hypothetical protein +FIG00930123 FIG00930130: hypothetical protein +FIG00930130 FIG00930138: hypothetical protein +FIG00930138 FIG00930141: hypothetical protein +FIG00930145 FIG00930146: hypothetical protein +FIG00930146 FIG00930147: hypothetical protein +FIG00930147 FIG00930148: hypothetical protein +FIG00930156 transcriptional regulator MarR family +FIG00930157 FIG00930159: hypothetical protein +FIG00930159 FIG00930163: hypothetical protein +FIG00930173 FIG00930177: hypothetical protein +FIG00930177 FIG00930179: hypothetical protein +FIG00930183 FIG00930184: hypothetical protein +FIG00930185 FIG00930186: hypothetical protein +FIG00930186 FIG00930189: hypothetical protein +FIG00930189 FIG00930190: hypothetical protein +FIG00930193 FIG00930195: hypothetical protein +FIG00930201 FIG00930202: hypothetical protein +FIG00930202 FIG00930203: hypothetical protein +FIG00930203 FIG00930204: hypothetical protein +FIG00930204 FIG00930205: hypothetical protein +FIG00930205 FIG00930206: hypothetical protein +FIG00930206 FIG00930212: hypothetical protein +FIG00930213 FIG00930217: hypothetical protein +FIG00930217 FIG00930218: hypothetical protein +FIG00930218 FIG00930220: hypothetical protein +FIG00930220 FIG00930221: hypothetical protein +FIG00930221 FIG00930223: hypothetical protein +FIG00930225 FIG00930229: hypothetical protein +FIG00930231 FIG00930233: hypothetical protein +FIG00930233 DNA repair system specific for alkylated DNA +FIG00930234 FIG00930236: hypothetical protein +FIG00930237 FIG00930242: hypothetical protein +FIG00930242 FIG00930244: hypothetical protein +FIG00930247 FIG00930248: hypothetical protein +FIG00930248 FIG00930249: hypothetical protein +FIG00930249 FIG00930252: hypothetical protein +FIG00930252 FIG00930253: hypothetical protein +FIG00930253 FIG00930254: hypothetical protein +FIG00930254 FIG00930258: hypothetical protein +FIG00930258 FIG00930261: hypothetical protein +FIG00930261 FIG00930262: hypothetical protein +FIG00930263 FIG00930264: hypothetical protein +FIG00930264 Antifreeze protein +FIG00930265 FIG00930274: hypothetical protein +FIG00930274 FIG00930276: hypothetical protein +FIG00930276 FIG00930277: hypothetical protein +FIG00930277 FIG00930280: hypothetical protein +FIG00930280 FIG00651791: hypothetical protein +FIG00930282 FIG00930283: hypothetical protein +FIG00930283 FIG00930285: hypothetical protein +FIG00930285 FIG00930287: hypothetical protein +FIG00930288 FIG00930290: hypothetical protein +FIG00930291 FIG00930294: hypothetical protein +FIG00930296 FIG00930297: hypothetical protein +FIG00930297 FIG00930300: hypothetical protein +FIG00930300 FIG00930301: hypothetical protein +FIG00930301 FIG00930303: hypothetical protein +FIG00930311 FIG00930312: hypothetical protein +FIG00930312 FIG00930313: hypothetical protein +FIG00930313 FIG00930314: hypothetical protein +FIG00930315 FIG00930318: hypothetical protein +FIG00930318 FIG00930319: hypothetical protein +FIG00930319 FIG00930320: hypothetical protein +FIG00930320 FIG00930321: hypothetical protein +FIG00930326 FIG00930327: hypothetical protein +FIG00930327 lipopolysaccharide core biosynthesis mannosyltransferase +FIG00930330 FIG00930334: hypothetical protein +FIG00930335 FIG00930336: hypothetical protein +FIG00930340 probable oxidoreductase-putative NAD-dependent nucleoside-diphosphate-sugar epimerase +FIG00930354 FIG00930357: hypothetical protein +FIG00930357 FIG00930358: hypothetical protein +FIG00930358 FIG00930360: hypothetical protein +FIG00930360 FIG00930362: hypothetical protein +FIG00930362 FIG00930363: hypothetical protein +FIG00930363 FIG00930365: hypothetical protein +FIG00930366 FIG00930371: hypothetical protein +FIG00930372 FIG00930373: hypothetical protein +FIG00930373 FIG00930374: hypothetical protein +FIG00930374 FIG00930375: hypothetical protein +FIG00930376 FIG00930378: hypothetical protein +FIG00930378 FIG00930385: hypothetical protein +FIG00930385 FIG00930387: hypothetical protein +FIG00930387 FIG00930389: hypothetical protein +FIG00930389 FIG00930390: hypothetical protein +FIG00930390 FIG00930393: hypothetical protein +FIG00930405 FIG00930407: hypothetical protein +FIG00930408 FIG00930409: hypothetical protein +FIG00930409 FIG00930413: hypothetical protein +FIG00930414 FIG00930415: hypothetical protein +FIG00930415 FIG00930419: hypothetical protein +FIG00930423 FIG00930424: hypothetical protein +FIG00930425 FIG00930427: hypothetical protein +FIG00930427 FIG00930428: hypothetical protein +FIG00930428 FIG00930429: hypothetical protein +FIG00930429 FIG00930431: hypothetical protein +FIG00930431 FIG00930433: hypothetical protein +FIG00930433 FIG00930434: hypothetical protein +FIG00930436 FIG00930438: hypothetical protein +FIG00930438 FIG00930439: hypothetical protein +FIG00930439 FIG00930441: hypothetical protein +FIG00930445 FIG00930446: hypothetical protein +FIG00930452 FIG00930458: hypothetical protein +FIG00930458 Universal stress protein UspA and related nucleotide-binding proteins +FIG00930460 FIG00930463: hypothetical protein +FIG00930469 FIG00930472: hypothetical protein +FIG00930472 FIG00930473: hypothetical protein +FIG00930474 FIG00930477: hypothetical protein +FIG00930477 FIG00930478: hypothetical protein +FIG00930478 FIG00930480: hypothetical protein +FIG00930480 FIG00930481: hypothetical protein +FIG00930481 FIG00650678: hypothetical protein +FIG00930495 FIG00930497: hypothetical protein +FIG00930497 FIG00930499: hypothetical protein +FIG00930499 FIG00930502: hypothetical protein +FIG00930502 Glycosyl hydrolase, family 16 +FIG00930504 TPR domain protein +FIG00930510 FIG00930511: hypothetical protein +FIG00930511 FIG00930512: hypothetical protein +FIG00930512 FIG00930514: hypothetical protein +FIG00930514 FIG00930515: hypothetical protein +FIG00930516 FIG00930518: hypothetical protein +FIG00930518 FIG00930521: hypothetical protein +FIG00930521 FIG00930522: hypothetical protein +FIG00930524 putative molybdopterin-synthase small subunit +FIG00930530 FIG00930531: hypothetical protein +FIG00930531 FIG00930532: hypothetical protein +FIG00930532 FIG00930533: hypothetical protein +FIG00930538 FIG00930539: hypothetical protein +FIG00930539 FIG00930540: hypothetical protein +FIG00930540 FIG00930542: hypothetical protein +FIG00930544 tRNA (Guanosine-2'-O-) -methyltransferase (EC 2.1.1.34) +FIG00930549 FIG00930550: hypothetical protein +FIG00930559 FIG00930564: hypothetical protein +FIG00930564 FIG00930566: hypothetical protein +FIG00930566 FIG00930567: hypothetical protein +FIG00930567 FIG00930569: hypothetical protein +FIG00930569 FIG00930570: hypothetical protein +FIG00930572 FIG00930574: hypothetical protein +FIG00930578 FIG00930579: hypothetical protein +FIG00930580 FIG00930582: hypothetical protein +FIG00930586 FIG00930587: hypothetical protein +FIG00930589 FIG00930590: hypothetical protein +FIG00930590 FIG00930591: hypothetical protein +FIG00930594 FIG00930596: hypothetical protein +FIG00930596 FIG00930598: hypothetical protein +FIG00930598 FIG00930599: hypothetical protein +FIG00930599 FIG00930603: hypothetical protein +FIG00930603 FIG00930605: hypothetical protein +FIG00930605 FIG00930606: hypothetical protein +FIG00930606 FIG00930607: hypothetical protein +FIG00930607 FIG00693349: hypothetical protein +FIG00930610 FIG00930612: hypothetical protein +FIG00930612 FIG00930613: hypothetical protein +FIG00930626 FIG00930628: hypothetical protein +FIG00930628 FIG00930630: hypothetical protein +FIG00930635 FIG00930636: hypothetical protein +FIG00930639 FIG00930640: hypothetical protein +FIG00930640 FIG00930642: hypothetical protein +FIG00930653 FIG00930655: hypothetical protein +FIG00930656 putative chloride channel protein +FIG00930660 FIG00930665: hypothetical protein +FIG00930665 FIG00930669: hypothetical protein +FIG00930670 FIG00930671: hypothetical protein +FIG00930674 FIG00930679: hypothetical protein +FIG00930686 1-acyl-sn-glycerol-3-phosphate acetyltransferase (EC 2.3.1.51) +FIG00930687 FIG00930688: hypothetical protein +FIG00930688 FIG00930689: hypothetical protein +FIG00930689 FIG00930690: hypothetical protein +FIG00930690 FIG00930692: hypothetical protein +FIG00930703 FIG00930704: hypothetical protein +FIG00930704 FIG00930705: hypothetical protein +FIG00930705 FIG00930707: hypothetical protein +FIG00930716 FIG00930717: hypothetical protein +FIG00930717 FIG00930718: hypothetical protein +FIG00930718 FIG00930723: hypothetical protein +FIG00930723 FIG00930725: hypothetical protein +FIG00930726 FIG00930727: hypothetical protein +FIG00930727 FIG00930728: hypothetical protein +FIG00930729 FIG00930733: hypothetical protein +FIG00930736 FIG00930738: hypothetical protein +FIG00930742 Related to MCBG protein +FIG00930745 FIG00930746: hypothetical protein +FIG00930746 FIG00930747: hypothetical protein +FIG00930759 FIG00930760: hypothetical protein +FIG00930760 FIG00930761: hypothetical protein +FIG00930765 FIG00930772: hypothetical protein +FIG00930777 FIG00930780: hypothetical protein +FIG00930783 FIG00930785: hypothetical protein +FIG00930786 FIG00930793: hypothetical protein +FIG00930796 NifU related protein +FIG00930804 FIG00930805: hypothetical protein +FIG00930805 FIG00930809: hypothetical protein +FIG00930809 FIG00930812: hypothetical protein +FIG00930812 FIG00930813: hypothetical protein +FIG00930813 FIG00930814: hypothetical protein +FIG00930816 FIG00930819: hypothetical protein +FIG00930819 FIG00930821: hypothetical protein +FIG00930821 Putative esterase/lipase ybfF (EC 3.1.-.-) +FIG00930825 FIG00930826: hypothetical protein +FIG00930826 FIG00930827: hypothetical protein +FIG00930841 FIG00930842: hypothetical protein +FIG00930847 FIG00930849: hypothetical protein +FIG00930853 FIG00930854: hypothetical protein +FIG00930854 FIG00930855: hypothetical protein +FIG00930855 FIG00930857: hypothetical protein +FIG00930859 FIG00930860: hypothetical protein +FIG00930860 FIG00930861: hypothetical protein +FIG00930861 FIG00930862: hypothetical protein +FIG00930865 FIG00930866: hypothetical protein +FIG00930866 FIG00930870: hypothetical protein +FIG00930872 FIG00930877: hypothetical protein +FIG00930879 FIG00930880: hypothetical protein +FIG00930881 FIG00930882: hypothetical protein +FIG00930882 FIG00930885: hypothetical protein +FIG00930886 FIG00930888: hypothetical protein +FIG00930888 FIG00930897: hypothetical protein +FIG00930897 FIG00930899: hypothetical protein +FIG00930899 FIG00930900: hypothetical protein +FIG00930903 FIG00930904: hypothetical protein +FIG00930904 FIG00930905: hypothetical protein +FIG00930905 FIG00930906: hypothetical protein +FIG00930906 FIG00930918: hypothetical protein +FIG00930920 FIG00930922: hypothetical protein +FIG00930922 FIG00930925: hypothetical protein +FIG00930925 FIG00930927: hypothetical protein +FIG00930927 FIG00930928: hypothetical protein +FIG00930931 FIG00930933: hypothetical protein +FIG00930933 FIG00930934: hypothetical protein +FIG00930935 FIG00930936: hypothetical protein +FIG00930936 FIG00930942: hypothetical protein +FIG00930954 FIG00930955: hypothetical protein +FIG00930959 FIG00930960: hypothetical protein +FIG00930970 FIG00930972: hypothetical protein +FIG00930974 FIG00930975: hypothetical protein +FIG00930975 FIG00930976: hypothetical protein +FIG00930976 FIG00930981: hypothetical protein +FIG00930982 FIG00930984: hypothetical protein +FIG00930984 FIG00930986: hypothetical protein +FIG00930990 FIG00930998: hypothetical protein +FIG00930998 FIG00930999: hypothetical protein +FIG00930999 FIG00931000: hypothetical protein +FIG00931012 AP superfamily protein +FIG00931015 FIG00931020: hypothetical protein +FIG00931027 FIG00931028: hypothetical protein +FIG00931028 FIG00931033: hypothetical protein +FIG00931040 FIG00931043: hypothetical protein +FIG00931044 FIG00931045: hypothetical protein +FIG00931045 FIG00931046: hypothetical protein +FIG00931046 FIG00931048: hypothetical protein +FIG00931051 Carboxypeptidase +FIG00931068 FIG00931070: hypothetical protein +FIG00931075 FIG00931076: hypothetical protein +FIG00931078 FIG00931087: hypothetical protein +FIG00931091 FIG00931098: hypothetical protein +FIG00931101 FIG00931102: hypothetical protein +FIG00931120 FIG00931122: hypothetical protein +FIG00931133 FIG00931134: hypothetical protein +FIG00931134 cointegrate resolution protein S +FIG00931144 OmpA domain protein transmembrane region-containing protein +FIG00931145 Protein sirB1 +FIG00931149 FIG00931152: hypothetical protein +FIG00931155 FIG00931156: hypothetical protein +FIG00931160 FIG00931163: hypothetical protein +FIG00931165 FIG00931167: hypothetical protein +FIG00931167 FIG00931169: hypothetical protein +FIG00931175 Tetrapyrrole methylase family protein +FIG00931192 Probable NreB protein +FIG00931193 InterPro IPR005134 COGs COG2862 +FIG00931196 FIG00931200: hypothetical protein +FIG00931206 FIG00931207: hypothetical protein +FIG00931211 FIG00931214: hypothetical protein +FIG00931219 putative nitrate transport protein +FIG00931225 Hemin uptake protein +FIG00931245 UbiA prenyltransferase family protein +FIG00931247 FIG00931248: hypothetical protein +FIG00931278 FIG00931281: hypothetical protein +FIG00931281 FIG00931283: hypothetical protein +FIG00931284 FIG00931285: hypothetical protein +FIG00931319 Extracellular ligand-binding receptor precursor +FIG00931322 FIG00931323: hypothetical protein +FIG00931341 FIG00931343: hypothetical protein +FIG00931355 FIG00931356: hypothetical protein +FIG00931381 FIG00931382: hypothetical protein +FIG00931391 FIG00931394: hypothetical protein +FIG00931405 FIG00931411: hypothetical protein +FIG00931411 putative ferric uptake regulator, FUR family +FIG00931442 FIG00931444: hypothetical protein +FIG00931449 Poly-beta-hydroxyalkanoate depolymerase +FIG00931450 FIG00348227: hypothetical protein +FIG00931459 MCE-FAMILY PROTEIN MCE4B +FIG00931473 FIG00931476: hypothetical protein +FIG00931514 FIG00931515: hypothetical protein +FIG00931515 FIG00931519: hypothetical protein +FIG00931519 probable ring-cleaving dioxygenase PA0880 +FIG00931594 FIG00931595: hypothetical protein +FIG00931595 FIG00960841: hypothetical protein +FIG00931608 FIG00931613: hypothetical protein +FIG00931618 FIG00931619: hypothetical protein +FIG00931628 FIG00931629: hypothetical protein +FIG00931662 FIG00931666: hypothetical protein +FIG00931666 FIG00931670: hypothetical protein +FIG00931678 ATP-dependent protease HslVU (ClpYQ), peptidase subunit +FIG00931701 FIG00931703: hypothetical protein +FIG00931715 FIG00931716: hypothetical protein +FIG00931718 FIG00931720: hypothetical protein +FIG00931726 FIG00931729: hypothetical protein +FIG00931733 FIG00931734: hypothetical protein +FIG00931754 FIG00931758: hypothetical protein +FIG00931781 FIG00931782: hypothetical protein +FIG00931805 FIG00989406: hypothetical protein +FIG00931817 FIG00931818: hypothetical protein +FIG00931821 PUTATIVE 4-HYDROXYBENZOYL-COA THIOESTERASE PROTEIN +FIG00931823 FIG00931824: hypothetical protein +FIG00931884 FIG00931886: hypothetical protein +FIG00931901 FIG00931903: hypothetical protein +FIG00931903 FIG00931906: hypothetical protein +FIG00931906 FIG00931908: hypothetical protein +FIG00931973 FIG00931975: hypothetical protein +FIG00932055 FIG00932072: hypothetical protein +FIG00932081 Probable serine protease +FIG00932083 FIG00932085: hypothetical protein +FIG00932097 FIG00932101: hypothetical protein +FIG00932108 probable bifunctional hydroxylase/oxidoreductase +FIG00932120 FIG00932121: hypothetical protein +FIG00932139 FIG00932140: hypothetical protein +FIG00932157 GtrA family protein, putative +FIG00932171 FIG00932172: hypothetical protein +FIG00932174 L-rhamnonate dehydratase (EC 4.2.1.90) +FIG00932176 FIG00932181: hypothetical protein +FIG00932200 Molybdopterin-binding protein +FIG00932206 putative thiol:disulfide interchange protein +FIG00932225 FIG00932227: hypothetical protein +FIG00932276 FIG00932277: hypothetical protein +FIG00932334 FIG00932340: hypothetical protein +FIG00932354 Probable conjugal transfer protein traB +FIG00932361 FIG00932369: hypothetical protein +FIG00932409 FIG00932412: hypothetical protein +FIG00932424 FIG00932425: hypothetical protein +FIG00932446 Acetyl-hydrolase/esterase LipR in mymA operon +FIG00932467 FIG00932469: hypothetical protein +FIG00932479 FIG00932481: hypothetical protein +FIG00932493 FIG00932502: hypothetical protein +FIG00932502 Branched-chain amino acid ABC transporter, amino acid-binding protein +FIG00932508 FIG00932509: hypothetical protein +FIG00932536 FIG00932538: hypothetical protein +FIG00932540 FIG00932541: hypothetical protein +FIG00932570 FIG00932573: hypothetical protein +FIG00932573 Asl0046 protein +FIG00932584 Zn-ribbon-containing, possibly RNA-binding protein and truncated derivatives +FIG00932592 FIG00932594: hypothetical protein +FIG00932594 FIG00932595: hypothetical protein +FIG00932610 FIG00932613: hypothetical protein +FIG00932624 FIG00932626: hypothetical protein +FIG00932636 FIG00932638: hypothetical protein +FIG00932641 FIG00932643: hypothetical protein +FIG00932658 C-type cytochrome biogenesis protein ResA (thioredoxin) +FIG00932685 FIG00932687: hypothetical protein +FIG00932715 FIG00932717: hypothetical protein +FIG00932717 protease, putative +FIG00932743 FIG00932745: hypothetical protein +FIG00932782 FIG00932785: hypothetical protein +FIG00932801 FIG00932805: hypothetical protein +FIG00932836 FIG00932837: hypothetical protein +FIG00932847 FIG00932860: hypothetical protein +FIG00932890 FIG00932893: hypothetical protein +FIG00932908 FIG00932912: hypothetical protein +FIG00932912 FIG00932914: hypothetical protein +FIG00932930 Probable two-component transmembrane sensor histidine kinase transcription regulator protein (EC 2.7.3.-) +FIG00932941 short-chain dehydrogenase/reductase family protein +FIG00932967 FIG00932969: hypothetical protein +FIG00933025 probable hydrolase +FIG00933052 FIG00933054: hypothetical protein +FIG00933059 UPF0100 protein PH0151 +FIG00933086 Subtilisin-like serine protease PR1A +FIG00933089 FIG00933091: hypothetical protein +FIG00933115 FIG00933116: hypothetical protein +FIG00933172 FIG00933173: hypothetical protein +FIG00933191 FIG00933192: hypothetical protein +FIG00933208 FIG00933213: hypothetical protein +FIG00933213 FIG00933224: hypothetical protein +FIG00933241 Probable inner membrane transmembrane protein +FIG00933242 tRNA (5-methylaminomethyl-2-thiouridylate)-methyltransferase (EC 2.1.1.61) / FAD-dependent cmnm(5)s(2)U34 oxidoreductase +FIG00933247 FIG00933249: hypothetical protein +FIG00933366 FIG00933367: hypothetical protein +FIG00933372 Branched-chain amino acid transport system permease protein LivM (TC 3.A.1.4.1) +FIG00933377 FIG00933378: hypothetical protein +FIG00933379 Serine/threonine protein kinase (EC 2.7.11.1) +FIG00933385 FIG00933394: hypothetical protein +FIG00933397 ATP-binding region, ATPase-like:Histidine kinase, HAMP region:Histidine kinase A, N-terminal +FIG00933410 FIG00933417: hypothetical protein +FIG00933417 proline rich protein +FIG00933517 FIG00933524: hypothetical protein +FIG00933524 FIG00933525: hypothetical protein +FIG00933525 FIG00933533: hypothetical protein +FIG00933534 FIG00933538: hypothetical protein +FIG00933552 two-component hybrid sensor and regulator +FIG00933586 Binding-protein-dependent transport systems inner membrane component precursor +FIG00933647 FIG00933650: hypothetical protein +FIG00933650 FIG00933651: hypothetical protein +FIG00933666 Membrane protein +FIG00933670 FIG00933677: hypothetical protein +FIG00933750 Mannose-6-phosphate isomerase +FIG00933761 FIG00933762: hypothetical protein +FIG00933810 FIG00933811: hypothetical protein +FIG00933917 FIG00933920: hypothetical protein +FIG00933945 Response regulator containing CheY-like receiver, AAA-type ATPase, and DNA-binding domains +FIG00933992 FIG00933993: hypothetical protein +FIG00934002 FIG00934003: hypothetical protein +FIG00934007 FIG00934011: hypothetical protein +FIG00934013 FIG00934022: hypothetical protein +FIG00934024 FIG00934032: hypothetical protein +FIG00934091 FIG00934093: hypothetical protein +FIG00934118 FIG00934122: hypothetical protein +FIG00934122 histone deacetylase superfamily +FIG00934143 FIG00934149: hypothetical protein +FIG00934152 FIG00934153: hypothetical protein +FIG00934176 FIG00934183: hypothetical protein +FIG00934220 FIG00934228: hypothetical protein +FIG00934257 FIG00934258: hypothetical protein +FIG00934262 FIG00934268: hypothetical protein +FIG00934268 FIG00934274: hypothetical protein +FIG00934281 FIG00934282: hypothetical protein +FIG00934315 FIG00934318: hypothetical protein +FIG00934318 FIG00934338: hypothetical protein +FIG00934341 FIG00934342: hypothetical protein +FIG00934342 FIG00934344: hypothetical protein +FIG00934356 FIG00934365: hypothetical protein +FIG00934374 FIG00934384: hypothetical protein +FIG00934402 FIG00934408: hypothetical protein +FIG00934411 FIG00934413: hypothetical protein +FIG00934438 FIG00934453: hypothetical protein +FIG00934509 FIG00934510: hypothetical protein +FIG00934510 FIG00934513: hypothetical protein +FIG00934525 FIG00934529: hypothetical protein +FIG00934529 putative polysaccharide deacetylase +FIG00934536 FIG00934539: hypothetical protein +FIG00934574 FIG00934575: hypothetical protein +FIG00934614 ABC-type oligopeptide transport system, periplasmic component yejA +FIG00934627 FIG00934632: hypothetical protein +FIG00934677 FIG00934678: hypothetical protein +FIG00934682 FIG00934696: hypothetical protein +FIG00934696 probable signal peptide protein +FIG00934717 FIG00934724: hypothetical protein +FIG00934732 Zinc finger protein HRX +FIG00934746 FIG00934751: hypothetical protein +FIG00934752 FIG00934754: hypothetical protein +FIG00934754 FIG00934759: hypothetical protein +FIG00934809 FIG00934811: hypothetical protein +FIG00934830 FIG005902: hypothetical protein +FIG00934857 FIG00934858: hypothetical protein +FIG00934909 FIG00934910: hypothetical protein +FIG00934940 FIG00934955: hypothetical protein +FIG00934972 FIG00934975: hypothetical protein +FIG00934987 FIG00934988: hypothetical protein +FIG00935012 Probable ATP-sensitive inward rectifier potassium channel related transmembrane protein +FIG00935018 FIG00935020: hypothetical protein +FIG00935038 FIG00935046: hypothetical protein +FIG00935058 FIG00935061: hypothetical protein +FIG00935154 FIG00935161: hypothetical protein +FIG00935244 FIG00935247: hypothetical protein +FIG00935460 FIG00935462: hypothetical protein +FIG00935462 FIG00935463: hypothetical protein +FIG00935463 FIG00935464: hypothetical protein +FIG00935475 FIG00935478: hypothetical protein +FIG00935479 UspA +FIG00935490 fibronectin type III domain protein +FIG00935491 FIG00935492: hypothetical protein +FIG00935492 hmuY protein +FIG00935493 FIG00935494: hypothetical protein +FIG00935496 FIG00935497: hypothetical protein +FIG00935498 60 kDa protein +FIG00935503 Pyruvoyl-dependent arginine decarboxylase 1 (EC 4.1.1.19) +FIG00935504 immunoreactive 32 kDa antigen PG49 +FIG00935508 FIG00935510: hypothetical protein +FIG00935510 FIG00935511: hypothetical protein +FIG00935511 FIG00935512: hypothetical protein +FIG00935517 FIG00935518: hypothetical protein +FIG00935518 FIG00935519: hypothetical protein +FIG00935519 FIG00935520: hypothetical protein +FIG00935520 FIG00935521: hypothetical protein +FIG00935521 FIG00935522: hypothetical protein +FIG00935523 FIG00935524: hypothetical protein +FIG00935525 FIG00935527: hypothetical protein +FIG00935527 FIG00935530: hypothetical protein +FIG00935530 FIG00935531: hypothetical protein +FIG00935531 FIG00935532: hypothetical protein +FIG00935534 FIG00935539: hypothetical protein +FIG00935539 FIG00935540: hypothetical protein +FIG00935540 Cytochrome c biogenesis protein CcsA +FIG00935542 FIG00935544: hypothetical protein +FIG00935544 FIG00935545: hypothetical protein +FIG00935545 FIG00935549: hypothetical protein +FIG00935554 FIG00935555: hypothetical protein +FIG00935556 carboxy-terminal processing protease precursor +FIG00935558 FIG00935559: hypothetical protein +FIG00935559 FIG00935560: hypothetical protein +FIG00935560 FIG00938859: hypothetical protein +FIG00935562 FIG00935563: hypothetical protein +FIG00935563 sodium/hydrogen antiporter +FIG00935565 FIG00935570: hypothetical protein +FIG00935570 FIG00935571: hypothetical protein +FIG00935571 immunoreactive 42 kDa antigen PG33 +FIG00935573 FIG00935574: hypothetical protein +FIG00935574 peptidase, M23/M37 family, putative +FIG00935575 FIG00935576: hypothetical protein +FIG00935579 FIG00935582: hypothetical protein +FIG00935582 FIG00935583: hypothetical protein +FIG00935583 FIG00935585: hypothetical protein +FIG00935585 FIG00935587: hypothetical protein +FIG00935593 FIG00935594: hypothetical protein +FIG00935594 FIG00935596: hypothetical protein +FIG00935597 FIG00935598: hypothetical protein +FIG00935600 FIG00935601: hypothetical protein +FIG00935602 FIG00936922: hypothetical protein +FIG00935606 FIG00935607: hypothetical protein +FIG00935609 FIG00935611: hypothetical protein +FIG00935611 FIG00935612: hypothetical protein +FIG00935617 bacterial sugar transferase +FIG00935621 FIG00935622: hypothetical protein +FIG00935623 FIG00935626: hypothetical protein +FIG00935626 FIG00935628: hypothetical protein +FIG00935628 FIG00935630: hypothetical protein +FIG00935631 FIG00935632: hypothetical protein +FIG00935632 FIG00935634: hypothetical protein +FIG00935634 FIG00935635: hypothetical protein +FIG00935635 FIG00935638: hypothetical protein +FIG00935638 Beta-N-acetylglucosaminidase +FIG00935640 FIG00935642: hypothetical protein +FIG00935642 FIG00935644: hypothetical protein +FIG00935644 FIG00935645: hypothetical protein +FIG00935646 Collagenase precursor (EC 3.4.-.-) +FIG00935647 FIG00935648: hypothetical protein +FIG00935649 FIG00935651: hypothetical protein +FIG00935651 FIG00935654: hypothetical protein +FIG00935654 FIG00935655: hypothetical protein +FIG00935655 FIG00935657: hypothetical protein +FIG00935663 FIG00935665: hypothetical protein +FIG00935670 FIG00935678: hypothetical protein +FIG00935678 FIG00935679: hypothetical protein +FIG00935682 FIG00935683: hypothetical protein +FIG00935683 FIG00935685: hypothetical protein +FIG00935685 FIG00935687: hypothetical protein +FIG00935687 FIG00935689: hypothetical protein +FIG00935694 FIG00935697: hypothetical protein +FIG00935700 FIG00935701: hypothetical protein +FIG00935703 FIG00935705: hypothetical protein +FIG00935705 FIG00935706: hypothetical protein +FIG00935706 FIG00935708: hypothetical protein +FIG00935709 FIG00935710: hypothetical protein +FIG00935711 FIG00935712: hypothetical protein +FIG00935712 FIG00935713: hypothetical protein +FIG00935713 FIG00935715: hypothetical protein +FIG00935716 FIG00935720: hypothetical protein +FIG00935720 FIG00935721: hypothetical protein +FIG00935725 hypothetical protein +FIG00935726 FIG00935729: hypothetical protein +FIG00935732 FIG00935733: hypothetical protein +FIG00935733 FIG00935736: hypothetical protein +FIG00935736 FIG00935738: hypothetical protein +FIG00935738 UvrD/REP helicase domain protein +FIG00935740 immunoreactive 43 kDa antigen PG32 +FIG00935742 FIG00935743: hypothetical protein +FIG00935747 FIG00935748: hypothetical protein +FIG00935753 CRISPR-associated protein, TM1814 family +FIG00935754 FIG00935756: hypothetical protein +FIG00935758 FIG00935759: hypothetical protein +FIG00935759 FIG00935760: hypothetical protein +FIG00935760 FIG00935762: hypothetical protein +FIG00935762 FIG00935764: hypothetical protein +FIG00935766 FIG00935767: hypothetical protein +FIG00935767 FIG00935768: hypothetical protein +FIG00935768 FIG00935770: hypothetical protein +FIG00935770 FIG00935774: hypothetical protein +FIG00935775 FIG00935776: hypothetical protein +FIG00935776 FIG00935778: hypothetical protein +FIG00935778 FIG00935779: hypothetical protein +FIG00935779 FIG00935780: hypothetical protein +FIG00935780 FIG00935781: hypothetical protein +FIG00935781 hemolysin +FIG00935782 FIG00935784: hypothetical protein +FIG00935784 FIG00935785: hypothetical protein +FIG00935787 FIG00935788: hypothetical protein +FIG00935790 FIG00935792: hypothetical protein +FIG00935792 FIG00935793: hypothetical protein +FIG00935793 FIG00935795: hypothetical protein +FIG00935795 FIG00935796: hypothetical protein +FIG00935796 FIG00935798: hypothetical protein +FIG00935798 FIG00935801: hypothetical protein +FIG00935806 FIG00935807: hypothetical protein +FIG00935807 FIG00935808: hypothetical protein +FIG00935808 FIG00935809: hypothetical protein +FIG00935810 FIG00935811: hypothetical protein +FIG00935811 FIG00935812: hypothetical protein +FIG00935812 FIG00935813: hypothetical protein +FIG00935813 FIG00935814: hypothetical protein +FIG00935818 FIG00935819: hypothetical protein +FIG00935819 FIG00935824: hypothetical protein +FIG00935824 FIG00935826: hypothetical protein +FIG00935831 FIG00935832: hypothetical protein +FIG00935834 FIG00935836: hypothetical protein +FIG00935838 FIG00935839: hypothetical protein +FIG00935849 FIG00935850: hypothetical protein +FIG00935850 FIG00935853: hypothetical protein +FIG00935853 FIG00935861: hypothetical protein +FIG00935861 FIG00935862: hypothetical protein +FIG00935866 FIG00935867: hypothetical protein +FIG00935867 FIG00935868: hypothetical protein +FIG00935870 FIG00935874: hypothetical protein +FIG00935874 similar to GB:M15518, GB:D01096, GB:A01465, GB:A04051, GB:A07197, GB:V00570, GB:K03021, GB:L00153, GB:L00141, GB:L00142, GB:L00143, GB:L00144, GB:L00145, GB:L00146, GB:L00147, GB:L00148, GB:L00149, GB:L00150, GB:L00151, GB:L00152, GB:S77144, SP:P00750, PID:190032, PID:2285954, PID:339818, PID:339834, PID:339839, PID:340177, PID:345129, PID:37244, PID:412165, PID:441174, and PID:575655; identified by sequence similarity; putative +FIG00935878 FIG00935880: hypothetical protein +FIG00935880 FIG00935882: hypothetical protein +FIG00935882 FIG00935885: hypothetical protein +FIG00935886 FIG00935887: hypothetical protein +FIG00935889 FIG00935890: hypothetical protein +FIG00935892 hypothetical protein +FIG00935893 Flavoredoxin +FIG00935897 FIG00935898: hypothetical protein +FIG00935898 FIG00935900: hypothetical protein +FIG00935900 zinc carboxypeptidase, putative +FIG00935902 FIG00935903: hypothetical protein +FIG00935907 FIG00935908: hypothetical protein +FIG00935908 FIG00935909: hypothetical protein +FIG00935909 FIG00935910: hypothetical protein +FIG00935910 FIG00935912: hypothetical protein +FIG00935912 FIG00935916: hypothetical protein +FIG00935916 FIG00935917: hypothetical protein +FIG00935918 FIG00935919: hypothetical protein +FIG00935919 FIG00935920: hypothetical protein +FIG00935921 FIG00935923: hypothetical protein +FIG00935923 FIG00935924: hypothetical protein +FIG00935924 pigmentation and extracellular proteinase regulator +FIG00935930 site-specific recombinase, phage integrase family / Ribosome hibernation protein YhbH +FIG00935931 FIG00935934: hypothetical protein +FIG00935936 FIG00935937: hypothetical protein +FIG00935938 FIG00935940: hypothetical protein +FIG00935944 FIG00935945: hypothetical protein +FIG00935948 FIG00935949: hypothetical protein +FIG00935949 FIG00935951: hypothetical protein +FIG00935953 FIG00935954: hypothetical protein +FIG00935955 FIG00935959: hypothetical protein +FIG00935959 FIG00935961: hypothetical protein +FIG00935966 FIG00935975: hypothetical protein +FIG00935975 FIG00935976: hypothetical protein +FIG00935979 FIG00935981: hypothetical protein +FIG00935990 FIG00935993: hypothetical protein +FIG00935994 ABC transporter, ATP-binding protein, MsbA family +FIG00935996 FIG00935997: hypothetical protein +FIG00935997 FIG00935998: hypothetical protein +FIG00936001 FIG00936004: hypothetical protein +FIG00936005 FIG00936006: hypothetical protein +FIG00936006 lipoprotein RagB +FIG00936018 FIG00898232: hypothetical protein +FIG00936022 FIG00936023: hypothetical protein +FIG00936023 iron dependent repressor, putative +FIG00936025 FIG00936027: hypothetical protein +FIG00936027 FIG00936029: hypothetical protein +FIG00936029 FIG00936030: hypothetical protein +FIG00936033 FIG00936034: hypothetical protein +FIG00936041 FIG00936042: hypothetical protein +FIG00936042 FIG00936044: hypothetical protein +FIG00936044 FIG00936045: hypothetical protein +FIG00936045 FIG00936046: hypothetical protein +FIG00936049 FIG00936050: hypothetical protein +FIG00936053 amino acid exporter, putative +FIG00936054 FIG00936056: hypothetical protein +FIG00936057 hemagglutinin, putative +FIG00936058 FIG00936059: hypothetical protein +FIG00936059 FIG00936064: hypothetical protein +FIG00936065 FIG00936066: hypothetical protein +FIG00936067 FIG00936069: hypothetical protein +FIG00936070 FIG00936071: hypothetical protein +FIG00936074 FIG00936075: hypothetical protein +FIG00936080 putative beta-phosphoglucomutase +FIG00936081 FIG00936082: hypothetical protein +FIG00936083 FIG00936084: hypothetical protein +FIG00936084 FIG00936086: hypothetical protein +FIG00936086 FIG00936088: hypothetical protein +FIG00936090 FIG00936092: hypothetical protein +FIG00936092 FIG00936093: hypothetical protein +FIG00936096 FIG00936097: hypothetical protein +FIG00936103 FIG00936104: hypothetical protein +FIG00936105 signal peptide peptidase SppA, 67K type +FIG00936106 FIG00936107: hypothetical protein +FIG00936107 FIG00936108: hypothetical protein +FIG00936109 FIG00936112: hypothetical protein +FIG00936112 FIG00936113: hypothetical protein +FIG00936113 FIG00936114: hypothetical protein +FIG00936114 FIG00936115: hypothetical protein +FIG00936115 FIG00936116: hypothetical protein +FIG00936121 FIG00936125: hypothetical protein +FIG00936130 FIG00936131: hypothetical protein +FIG00936132 FIG00936133: hypothetical protein +FIG00936133 FIG00936134: hypothetical protein +FIG00936136 FIG00936138: hypothetical protein +FIG00936138 FIG00936139: hypothetical protein +FIG00936142 FIG00936147: hypothetical protein +FIG00936147 FIG00937328: hypothetical protein +FIG00936148 ferric uptake transcriptional regulator +FIG00936152 FIG00936153: hypothetical protein +FIG00936153 FIG00936154: hypothetical protein +FIG00936157 FIG00936158: hypothetical protein +FIG00936158 FIG00936159: hypothetical protein +FIG00936159 FIG00936161: hypothetical protein +FIG00936162 FIG00936163: hypothetical protein +FIG00936163 FIG00936164: hypothetical protein +FIG00936164 FIG00936165: hypothetical protein +FIG00936165 FIG00936169: hypothetical protein +FIG00936169 FIG00936171: hypothetical protein +FIG00936171 FIG00936174: hypothetical protein +FIG00936179 FIG00936180: hypothetical protein +FIG00936180 FIG00936184: hypothetical protein +FIG00936184 FIG00936185: hypothetical protein +FIG00936185 FIG00936187: hypothetical protein +FIG00936187 FIG00936191: hypothetical protein +FIG00936191 probable glutamine ABC transporter +FIG00936193 FIG00936194: hypothetical protein +FIG00936195 FIG00936198: hypothetical protein +FIG00936203 FIG00936204: hypothetical protein +FIG00936204 FIG00936205: hypothetical protein +FIG00936206 FIG00936209: hypothetical protein +FIG00936210 FIG00936211: hypothetical protein +FIG00936211 FIG00936212: hypothetical protein +FIG00936212 FIG00936213: hypothetical protein +FIG00936218 FIG00936810: hypothetical protein +FIG00936221 CDP-glycerol:poly(glycerophosphate) glycerophosphotransferase +FIG00936227 FIG00936228: hypothetical protein +FIG00936228 FIG00936229: hypothetical protein +FIG00936229 FIG00936234: hypothetical protein +FIG00936234 FIG00936236: hypothetical protein +FIG00936237 FIG00936240: hypothetical protein +FIG00936240 FIG00936241: hypothetical protein +FIG00936241 FIG00936242: hypothetical protein +FIG00936242 FIG00936244: hypothetical protein +FIG00936248 FIG00936249: hypothetical protein +FIG00936249 FIG00936250: hypothetical protein +FIG00936252 FIG00936253: hypothetical protein +FIG00936253 FIG00936254: hypothetical protein +FIG00936254 FIG00936255: hypothetical protein +FIG00936255 FIG00936260: hypothetical protein +FIG00936260 FIG00936261: hypothetical protein +FIG00936261 FIG00936262: hypothetical protein +FIG00936270 FIG00936274: hypothetical protein +FIG00936275 FIG00936276: hypothetical protein +FIG00936282 FIG00936285: hypothetical protein +FIG00936285 FIG00936287: hypothetical protein +FIG00936296 FIG00936297: hypothetical protein +FIG00936299 FIG00936301: hypothetical protein +FIG00936302 Tpl protein +FIG00936303 FIG00936304: hypothetical protein +FIG00936304 FIG00936306: hypothetical protein +FIG00936306 FIG00936307: hypothetical protein +FIG00936307 FIG00936309: hypothetical protein +FIG00936310 FIG00936311: hypothetical protein +FIG00936313 FIG00936315: hypothetical protein +FIG00936315 FIG00936316: hypothetical protein +FIG00936317 immunoreactive 46 kDa antigen PG99 +FIG00936318 FIG00936319: hypothetical protein +FIG00936320 FIG00936324: hypothetical protein +FIG00936324 FIG00936325: hypothetical protein +FIG00936325 FIG00936328: hypothetical protein +FIG00936328 FIG00936332: hypothetical protein +FIG00936333 FIG00936334: hypothetical protein +FIG00936335 FIG00936338: hypothetical protein +FIG00936338 FIG00936340: hypothetical protein +FIG00936340 FIG00936342: hypothetical protein +FIG00936345 FIG00936346: hypothetical protein +FIG00936349 FIG00936351: hypothetical protein +FIG00936351 FIG00936355: hypothetical protein +FIG00936355 FIG00936356: hypothetical protein +FIG00936357 FIG00936358: hypothetical protein +FIG00936359 FIG00936361: hypothetical protein +FIG00936366 FIG00936367: hypothetical protein +FIG00936367 FIG00936368: hypothetical protein +FIG00936369 FIG00936370: hypothetical protein +FIG00936370 FIG00936372: hypothetical protein +FIG00936372 FIG00936374: hypothetical protein +FIG00936377 FIG00936378: hypothetical protein +FIG00936379 FIG00936383: hypothetical protein +FIG00936384 FIG00936385: hypothetical protein +FIG00936385 FIG00936386: hypothetical protein +FIG00936386 FIG00936390: hypothetical protein +FIG00936393 FIG00936394: hypothetical protein +FIG00936404 FIG00936405: hypothetical protein +FIG00936405 FIG00936407: hypothetical protein +FIG00936417 FIG00936419: hypothetical protein +FIG00936419 FIG00936421: hypothetical protein +FIG00936422 FIG00936423: hypothetical protein +FIG00936423 FIG00936429: hypothetical protein +FIG00936430 FIG00936431: hypothetical protein +FIG00936433 FIG00936438: hypothetical protein +FIG00936438 FIG00936439: hypothetical protein +FIG00936439 FIG00936442: hypothetical protein +FIG00936442 FIG00936443: hypothetical protein +FIG00936448 FIG00936452: hypothetical protein +FIG00936452 FIG00936453: hypothetical protein +FIG00936455 FIG00694335: hypothetical protein +FIG00936458 FIG00936460: hypothetical protein +FIG00936460 FIG00936461: hypothetical protein +FIG00936461 FIG00936465: hypothetical protein +FIG00936479 FIG00936480: hypothetical protein +FIG00936481 FIG00936482: hypothetical protein +FIG00936487 FIG00936488: hypothetical protein +FIG00936488 FIG00936489: hypothetical protein +FIG00936498 FIG00936499: hypothetical protein +FIG00936503 FIG00936504: hypothetical protein +FIG00936504 FIG00936505: hypothetical protein +FIG00936505 FIG00936509: hypothetical protein +FIG00936510 FIG00936511: hypothetical protein +FIG00936511 FIG00936515: hypothetical protein +FIG00936518 FIG00936522: hypothetical protein +FIG00936525 FIG00936526: hypothetical protein +FIG00936526 FIG00936527: hypothetical protein +FIG00936527 FIG00936528: hypothetical protein +FIG00936528 FIG00936531: hypothetical protein +FIG00936535 FIG00936536: hypothetical protein +FIG00936536 FIG00936543: hypothetical protein +FIG00936552 FIG00936553: hypothetical protein +FIG00936553 FIG00936554: hypothetical protein +FIG00936558 FIG00936563: hypothetical protein +FIG00936563 FIG00936565: hypothetical protein +FIG00936565 FIG00936566: hypothetical protein +FIG00936573 FIG00936574: hypothetical protein +FIG00936574 FIG00936576: hypothetical protein +FIG00936576 FIG00937393: hypothetical protein +FIG00936580 FIG00936583: hypothetical protein +FIG00936583 FIG00936584: hypothetical protein +FIG00936584 FIG00936585: hypothetical protein +FIG00936585 FIG00936587: hypothetical protein +FIG00936589 FIG00936592: hypothetical protein +FIG00936600 FIG00936601: hypothetical protein +FIG00936601 membrane bound regulatory protein, putative +FIG00936609 FIG00936610: hypothetical protein +FIG00936617 FIG00936619: hypothetical protein +FIG00936620 Macrolide-specific ABC-type efflux carrier (TC 3.A.1.122.1) +FIG00936622 FIG00936624: hypothetical protein +FIG00936626 FIG00936628: hypothetical protein +FIG00936628 FIG00936631: hypothetical protein +FIG00936638 FIG00936640: hypothetical protein +FIG00936640 FIG00936641: hypothetical protein +FIG00936641 FIG00936643: hypothetical protein +FIG00936643 FIG00936644: hypothetical protein +FIG00936648 FIG00936650: hypothetical protein +FIG00936652 putative zinc protease ymxG +FIG00936662 FIG00936664: hypothetical protein +FIG00936669 FIG00936670: hypothetical protein +FIG00936675 FIG00936676: hypothetical protein +FIG00936684 FIG00936690: hypothetical protein +FIG00936691 FIG00936693: hypothetical protein +FIG00936693 carboxyl-terminal protease-related protein +FIG00936696 Polysaccharide biosynthesis protein +FIG00936708 FIG00936714: hypothetical protein +FIG00936716 FIG00936717: hypothetical protein +FIG00936717 FIG00936719: hypothetical protein +FIG00936723 FIG00936724: hypothetical protein +FIG00936726 iron compound ABC transporter, periplasmic iron compound-binding protein, putative +FIG00936749 FIG00936753: hypothetical protein +FIG00936753 FIG00936757: hypothetical protein +FIG00936757 FIG00936766: hypothetical protein +FIG00936810 FIG00936811: hypothetical protein +FIG00936813 FIG00936814: hypothetical protein +FIG00936815 FIG00936816: hypothetical protein +FIG00936818 FIG00936819: hypothetical protein +FIG00936824 FIG00936825: hypothetical protein +FIG00936825 FIG00896819: hypothetical protein +FIG00936828 putative outer membrane protein +FIG00936830 FIG00936831: hypothetical protein +FIG00936834 Mce4/Rv3499c/MTV023.06c protein +FIG00936835 FIG00936836: hypothetical protein +FIG00936836 FIG00936838: hypothetical protein +FIG00936839 FIG00936840: hypothetical protein +FIG00936840 FIG00936842: hypothetical protein +FIG00936842 FIG00936844: hypothetical protein +FIG00936845 Integrase, site-specific recombinase +FIG00936847 Outer membrane efflux protein +FIG00936851 FIG00936854: hypothetical protein +FIG00936855 FIG00936857: hypothetical protein +FIG00936857 bi-domain oxidoreductase +FIG00936860 FIG00936861: hypothetical protein +FIG00936862 FIG00936863: hypothetical protein +FIG00936866 FIG00936868: hypothetical protein +FIG00936868 FIG00936869: hypothetical protein +FIG00936869 DNA Pol III Epsilon Chain +FIG00936873 FIG00936874: hypothetical protein +FIG00936874 FIG00936875: hypothetical protein +FIG00936875 FIG00936878: hypothetical protein +FIG00936878 FIG00936879: hypothetical protein +FIG00936882 FIG00936883: hypothetical protein +FIG00936885 uroporphyrinogen-III synthase HemD, putative +FIG00936886 FIG00936887: hypothetical protein +FIG00936888 FIG00936889: hypothetical protein +FIG00936889 tetratricopeptide repeat (TPR) family protein +FIG00936895 FIG00936896: hypothetical protein +FIG00936897 FIG00936898: hypothetical protein +FIG00936898 FIG00936900: hypothetical protein +FIG00936901 FIG00936902: hypothetical protein +FIG00936903 Carboxy-terminal processing protease +FIG00936905 FIG00936906: hypothetical protein +FIG00936912 FIG00936914: hypothetical protein +FIG00936914 conserved hypothetical protein probably involved in transposition +FIG00936916 FIG00936917: hypothetical protein +FIG00936917 FIG00936918: hypothetical protein +FIG00936920 FIG00936921: hypothetical protein +FIG00936923 FIG00936924: hypothetical protein +FIG00936925 FIG00936926: hypothetical protein +FIG00936926 FIG00936927: hypothetical protein +FIG00936929 Putative phosphate ABC transporter, phosphate-binding component +FIG00936930 FIG00936931: hypothetical protein +FIG00936931 FIG00936932: hypothetical protein +FIG00936933 FIG00936938: hypothetical protein +FIG00936938 FIG00936940: hypothetical protein +FIG00936940 FIG00936941: hypothetical protein +FIG00936941 FIG00936942: hypothetical protein +FIG00936942 FIG00936943: hypothetical protein +FIG00936943 FIG00936945: hypothetical protein +FIG00936948 FIG00936951: hypothetical protein +FIG00936958 FIG00936959: hypothetical protein +FIG00936959 Hemolysins and related proteins containing CBS domains +FIG00936961 FIG00936963: hypothetical protein +FIG00936963 FIG00936964: hypothetical protein +FIG00936964 FIG00936965: hypothetical protein +FIG00936965 FIG00404769: hypothetical protein +FIG00936968 FIG00936969: hypothetical protein +FIG00936969 FIG00936970: hypothetical protein +FIG00936970 Xanthan lyase +FIG00936972 FIG00936973: hypothetical protein +FIG00936973 FIG00936974: hypothetical protein +FIG00936974 FIG00936975: hypothetical protein +FIG00936975 FIG00406392: hypothetical protein +FIG00936980 FIG00936982: hypothetical protein +FIG00936985 FIG00936986: hypothetical protein +FIG00936989 FIG00404142: hypothetical protein +FIG00936991 FIG00936993: hypothetical protein +FIG00936998 FIG00937000: hypothetical protein +FIG00937000 FIG00937001: hypothetical protein +FIG00937007 FIG00937008: hypothetical protein +FIG00937010 FIG00405120: hypothetical protein +FIG00937011 putative endonuclease +FIG00937013 FIG00405766: hypothetical protein +FIG00937019 FIG00937020: hypothetical protein +FIG00937020 FIG00937021: hypothetical protein +FIG00937022 FIG00937023: hypothetical protein +FIG00937023 FIG00937024: hypothetical protein +FIG00937025 FIG00937027: hypothetical protein +FIG00937029 FIG00937030: hypothetical protein +FIG00937031 FIG00937032: hypothetical protein +FIG00937034 FIG00937037: hypothetical protein +FIG00937044 FIG00937046: hypothetical protein +FIG00937046 FIG00937047: hypothetical protein +FIG00937050 Dipeptidyl-peptidase III (EC 3.4.14.4) +FIG00937052 FIG00937054: hypothetical protein +FIG00937054 FIG00937056: hypothetical protein +FIG00937056 Preprotein translocase secY subunit (TC 3.A.5.1.1) +FIG00937058 FIG00937059: hypothetical protein +FIG00937059 FenI +FIG00937060 FIG00937061: hypothetical protein +FIG00937070 FIG00937071: hypothetical protein +FIG00937074 FIG00937076: hypothetical protein +FIG00937076 FIG00937077: hypothetical protein +FIG00937077 probable integral membrane protein Cj0341c +FIG00937078 FIG00937080: hypothetical protein +FIG00937083 FIG00937084: hypothetical protein +FIG00937084 FIG00937085: hypothetical protein +FIG00937085 FIG00937086: hypothetical protein +FIG00937086 FIG00937087: hypothetical protein +FIG00937091 FIG00937093: hypothetical protein +FIG00937096 FIG00937098: hypothetical protein +FIG00937098 FIG00937099: hypothetical protein +FIG00937104 FIG00937105: hypothetical protein +FIG00937105 FIG00937106: hypothetical protein +FIG00937107 FIG00937108: hypothetical protein +FIG00937113 AcrB/AcrD family multidrug resistance protein +FIG00937114 FIG00937115: hypothetical protein +FIG00937115 FIG00405862: hypothetical protein +FIG00937116 FIG00937119: hypothetical protein +FIG00937119 FIG00937120: hypothetical protein +FIG00937120 FIG00937121: hypothetical protein +FIG00937122 FIG00937123: hypothetical protein +FIG00937125 FIG00404104: hypothetical protein +FIG00937126 FIG00937127: hypothetical protein +FIG00937127 CobN/magnesium chelatase family protein +FIG00937129 DNA mismatch repair protein precursor (EC 3.2.1.4) +FIG00937135 FIG00937137: hypothetical protein +FIG00937139 FIG00937140: hypothetical protein +FIG00937140 FHA domain protein +FIG00937142 FIG00937143: hypothetical protein +FIG00937148 FIG00937149: hypothetical protein +FIG00937151 FIG00937152: hypothetical protein +FIG00937154 FIG00937155: hypothetical protein +FIG00937156 FIG00937157: hypothetical protein +FIG00937157 FIG00937159: hypothetical protein +FIG00937159 FIG00937160: hypothetical protein +FIG00937165 FIG00937167: hypothetical protein +FIG00937167 hypothetical protein +FIG00937169 FIG00937170: hypothetical protein +FIG00937176 FIG00937177: hypothetical protein +FIG00937178 FIG00937179: hypothetical protein +FIG00937183 FIG00937184: hypothetical protein +FIG00937184 FIG00937185: hypothetical protein +FIG00937186 putative GAF-domain signal transduction protein +FIG00937191 FIG00937192: hypothetical protein +FIG00937195 FIG00937196: hypothetical protein +FIG00937196 FIG00937197: hypothetical protein +FIG00937199 FIG00937200: hypothetical protein +FIG00937206 FIG00937207: hypothetical protein +FIG00937212 Hemolysin A +FIG00937218 FIG00937219: hypothetical protein +FIG00937221 FIG00937222: hypothetical protein +FIG00937222 FIG00937223: hypothetical protein +FIG00937224 FIG00937225: hypothetical protein +FIG00937226 possible thioesterase +FIG00937228 mannose-1-phosphate guanyltransferase +FIG00937229 FIG00937230: hypothetical protein +FIG00937230 FIG00937231: hypothetical protein +FIG00937231 FIG00937232: hypothetical protein +FIG00937232 FIG00937235: hypothetical protein +FIG00937238 FIG00937239: hypothetical protein +FIG00937239 FIG00937240: hypothetical protein +FIG00937241 FIG00937243: hypothetical protein +FIG00937243 FIG00937244: hypothetical protein +FIG00937247 FIG00937248: hypothetical protein +FIG00937249 VCBS +FIG00937254 FIG00937255: hypothetical protein +FIG00937256 3'-5' exonuclease domain protein +FIG00937257 FIG00937258: hypothetical protein +FIG00937260 FIG00937261: hypothetical protein +FIG00937264 Biopolymer transport exbD protein. +FIG00937265 FIG00937266: hypothetical protein +FIG00937268 FIG00937271: hypothetical protein +FIG00937278 FIG00937279: hypothetical protein +FIG00937279 FIG00937280: hypothetical protein +FIG00937280 FIG00937282: hypothetical protein +FIG00937282 FIG00937286: hypothetical protein +FIG00937287 FIG00937288: hypothetical protein +FIG00937290 putative TPR repeat domain exported protein +FIG00937292 FIG00937293: hypothetical protein +FIG00937293 FIG00937294: hypothetical protein +FIG00937296 FIG00937298: hypothetical protein +FIG00937300 FIG00937301: hypothetical protein +FIG00937303 2-oxoglutarate oxidoreductase, alpha subunit (EC 1.2.7.3) +FIG00937310 FIG00937311: hypothetical protein +FIG00937311 FIG00937312: hypothetical protein +FIG00937316 FIG00937317: hypothetical protein +FIG00937317 FIG00937318: hypothetical protein +FIG00937318 FIG00937319: hypothetical protein +FIG00937322 FIG00937323: hypothetical protein +FIG00937323 FIG00937325: hypothetical protein +FIG00937325 FIG00937326: hypothetical protein +FIG00937326 FIG00402742: hypothetical protein +FIG00937336 FIG00937337: hypothetical protein +FIG00937338 FIG00937340: hypothetical protein +FIG00937344 FIG00937345: hypothetical protein +FIG00937345 FIG00937346: hypothetical protein +FIG00937355 FIG00937356: hypothetical protein +FIG00937356 FIG00937357: hypothetical protein +FIG00937357 FIG00937358: hypothetical protein +FIG00937359 FIG00937360: hypothetical protein +FIG00937362 FIG00937364: hypothetical protein +FIG00937368 FIG00937369: hypothetical protein +FIG00937370 putative Fe-S oxidoreductase +FIG00937372 FIG00937374: hypothetical protein +FIG00937378 FIG00937379: hypothetical protein +FIG00937379 Predicted exporter of the RND superfamily +FIG00937380 FIG00937381: hypothetical protein +FIG00937382 FIG00937385: hypothetical protein +FIG00937389 FIG00937390: hypothetical protein +FIG00937393 FIG00937394: hypothetical protein +FIG00937395 Mg2+/Co2+ transporter +FIG00937405 FIG00937406: hypothetical protein +FIG00937406 lysozyme-related protein +FIG00937407 FIG00937408: hypothetical protein +FIG00937408 FIG00937409: hypothetical protein +FIG00937413 FIG00937414: hypothetical protein +FIG00937414 FIG00937415: hypothetical protein +FIG00937415 FIG00937416: hypothetical protein +FIG00937416 Haloacid dehalogenase-like hydrolase +FIG00937417 FIG00937418: hypothetical protein +FIG00937418 transcriptional regulator, tetR family +FIG00937419 FIG00937420: hypothetical protein +FIG00937424 FIG00937425: hypothetical protein +FIG00937431 FIG00937433: hypothetical protein +FIG00937433 FIG00937434: hypothetical protein +FIG00937434 low affinity penicillin binding protein +FIG00937438 FIG00937439: hypothetical protein +FIG00937439 Dipeptidyl peptidase IV +FIG00937442 FIG00937444: hypothetical protein +FIG00937446 FIG00937447: hypothetical protein +FIG00937449 FIG00899114: hypothetical protein +FIG00937451 FIG00937452: hypothetical protein +FIG00937455 FIG00937457: hypothetical protein +FIG00937457 FIG00937458: hypothetical protein +FIG00937465 FIG00937466: hypothetical protein +FIG00937472 RagA protein +FIG00937473 FIG00937475: hypothetical protein +FIG00937475 FIG00937476: hypothetical protein +FIG00937476 putative dolichol-P-glucose synthetase +FIG00937479 FIG00937480: hypothetical protein +FIG00937480 FIG00937481: hypothetical protein +FIG00937481 FIG00937482: hypothetical protein +FIG00937485 FIG00937486: hypothetical protein +FIG00937488 FIG00937489: hypothetical protein +FIG00937490 FIG00403491: hypothetical protein +FIG00937491 FIG00409580: hypothetical protein +FIG00937492 FIG00937494: hypothetical protein +FIG00937496 Chromate transport protein +FIG00937497 FIG00937498: hypothetical protein +FIG00937498 FIG00937499: hypothetical protein +FIG00937499 FIG00937500: hypothetical protein +FIG00937500 FIG00937501: hypothetical protein +FIG00937502 FIG00937504: hypothetical protein +FIG00937504 FIG00937505: hypothetical protein +FIG00937505 FIG00937507: hypothetical protein +FIG00937507 FIG00937509: hypothetical protein +FIG00937509 FIG00937510: hypothetical protein +FIG00937511 heme biosynthesis protein (NirJ) related protein +FIG00937515 FIG00937516: hypothetical protein +FIG00937517 FIG00937518: hypothetical protein +FIG00937518 endoglucanase E precursor (EGE) +FIG00937525 FIG00937526: hypothetical protein +FIG00937535 putative mannosidase +FIG00937537 FIG00937538: hypothetical protein +FIG00937538 FIG00937539: hypothetical protein +FIG00937539 FIG00937540: hypothetical protein +FIG00937543 FIG00937544: hypothetical protein +FIG00937546 FIG00937548: hypothetical protein +FIG00937548 FIG00937549: hypothetical protein +FIG00937552 FIG00937553: hypothetical protein +FIG00937555 FIG00937556: hypothetical protein +FIG00937556 FIG00937557: hypothetical protein +FIG00937557 FIG00937558: hypothetical protein +FIG00937564 FIG00937565: hypothetical protein +FIG00937565 FIG00937566: hypothetical protein +FIG00937568 FIG00937571: hypothetical protein +FIG00937572 conserved hypothetical protein, putative cell surface protein +FIG00937578 FIG00937579: hypothetical protein +FIG00937579 FIG00937580: hypothetical protein +FIG00937584 FIG00937585: hypothetical protein +FIG00937593 FIG00937594: hypothetical protein +FIG00937599 FIG00937600: hypothetical protein +FIG00937600 FIG00937601: hypothetical protein +FIG00937601 FIG00937602: hypothetical protein +FIG00937603 FIG00937605: hypothetical protein +FIG00937607 FIG00937608: hypothetical protein +FIG00937608 FIG00937609: hypothetical protein +FIG00937609 FIG00937610: hypothetical protein +FIG00937610 FIG00937611: hypothetical protein +FIG00937611 FIG00937612: hypothetical protein +FIG00937617 FIG00405083: hypothetical protein +FIG00937618 FIG00937619: hypothetical protein +FIG00937619 FIG00937621: hypothetical protein +FIG00937621 FIG00937622: hypothetical protein +FIG00937630 FIG00937631: hypothetical protein +FIG00937632 dCMP deaminase (EC 3.5.4.12) +FIG00937633 FIG00937634: hypothetical protein +FIG00937634 FIG00937636: hypothetical protein +FIG00937636 FIG00937637: hypothetical protein +FIG00937638 FIG00937640: hypothetical protein +FIG00937640 FIG00937641: hypothetical protein +FIG00937641 FIG00937643: hypothetical protein +FIG00937644 FIG00937646: hypothetical protein +FIG00937646 FIG00937648: hypothetical protein +FIG00937649 FIG00937650: hypothetical protein +FIG00937657 FIG00937658: hypothetical protein +FIG00937662 FIG00937663: hypothetical protein +FIG00937664 FIG00937666: hypothetical protein +FIG00937666 FIG00937668: hypothetical protein +FIG00937668 Similar to glycogen synthase (EC 2.4.1.21) +FIG00937669 putative bacterial transferase hexapeptide repeat:ADP-glucose pyrophosphorylase +FIG00937673 FIG00937674: hypothetical protein +FIG00937674 Outer membrane protein SusF +FIG00937677 FIG00937678: hypothetical protein +FIG00937678 FIG00937679: hypothetical protein +FIG00937679 FIG00937680: hypothetical protein +FIG00937683 FIG00937684: hypothetical protein +FIG00937685 FIG00937686: hypothetical protein +FIG00937686 FIG00937687: hypothetical protein +FIG00937687 FIG00937689: hypothetical protein +FIG00937689 FIG00937690: hypothetical protein +FIG00937694 putative LPS biosynthesis related glycosyltransferase +FIG00937700 FIG00937701: hypothetical protein +FIG00937712 FIG00937713: hypothetical protein +FIG00937713 FIG00937714: hypothetical protein +FIG00937714 FIG00937715: hypothetical protein +FIG00937717 FIG00937718: hypothetical protein +FIG00937719 FIG00937720: hypothetical protein +FIG00937720 FIG00937723: hypothetical protein +FIG00937725 FIG00937726: hypothetical protein +FIG00937729 FIG00937730: hypothetical protein +FIG00937730 FIG00937731: hypothetical protein +FIG00937731 FIG00937732: hypothetical protein +FIG00937735 FIG00937737: hypothetical protein +FIG00937742 FIG00937744: hypothetical protein +FIG00937747 FIG00937748: hypothetical protein +FIG00937749 FIG00937750: hypothetical protein +FIG00937750 FIG00937751: hypothetical protein +FIG00937757 FIG00937759: hypothetical protein +FIG00937768 FIG00937769: hypothetical protein +FIG00937772 FIG00937773: hypothetical protein +FIG00937773 FIG00937774: hypothetical protein +FIG00937774 FIG00937775: hypothetical protein +FIG00937777 FIG00937778: hypothetical protein +FIG00937781 FIG00937782: hypothetical protein +FIG00937790 RNA polymerase ECF-type sigma factor +FIG00937791 FIG00937792: hypothetical protein +FIG00937798 FIG00937799: hypothetical protein +FIG00937801 FIG00937802: hypothetical protein +FIG00937802 FIG00937803: hypothetical protein +FIG00937803 FIG00937804: hypothetical protein +FIG00937810 FIG00937811: hypothetical protein +FIG00937811 Hypothetical Nudix-like regulator +FIG00937816 FIG00937817: hypothetical protein +FIG00937817 FIG00937818: hypothetical protein +FIG00937818 FIG00937820: hypothetical protein +FIG00937829 FIG00937831: hypothetical protein +FIG00937834 FIG00937836: hypothetical protein +FIG00937840 FIG00937841: hypothetical protein +FIG00937841 FIG00937843: hypothetical protein +FIG00937846 FIG00937847: hypothetical protein +FIG00937847 FIG00937848: hypothetical protein +FIG00937848 FIG00937849: hypothetical protein +FIG00937853 FIG00937854: hypothetical protein +FIG00937860 FIG00937861: hypothetical protein +FIG00937861 FIG00937864: hypothetical protein +FIG00937864 FIG00937865: hypothetical protein +FIG00937866 FIG00937868: hypothetical protein +FIG00937869 FIG00937871: hypothetical protein +FIG00937876 FIG00937877: hypothetical protein +FIG00937877 FIG00897535: hypothetical protein +FIG00937878 FIG00937879: hypothetical protein +FIG00937879 FIG00937880: hypothetical protein +FIG00937880 FIG00937881: hypothetical protein +FIG00937884 FIG00937103: hypothetical protein +FIG00937886 DNA primase TraC +FIG00937888 FIG00937889: hypothetical protein +FIG00937892 FIG00937895: hypothetical protein +FIG00937897 FIG00937898: hypothetical protein +FIG00937898 FIG00937899: hypothetical protein +FIG00937899 FIG00937902: hypothetical protein +FIG00937903 FIG00937904: hypothetical protein +FIG00937908 FIG00937910: hypothetical protein +FIG00937914 FIG00937915: hypothetical protein +FIG00937924 FIG00937925: hypothetical protein +FIG00937926 FIG00937927: hypothetical protein +FIG00937927 FIG00937928: hypothetical protein +FIG00937928 FIG00937929: hypothetical protein +FIG00937934 FIG00937935: hypothetical protein +FIG00937935 FIG00937936: hypothetical protein +FIG00937936 FIG00937940: hypothetical protein +FIG00937945 FIG00937946: hypothetical protein +FIG00937952 FIG00898077: hypothetical protein +FIG00937958 putative peptide synthetase +FIG00937960 FIG00937962: hypothetical protein +FIG00937966 FIG00937967: hypothetical protein +FIG00937967 FIG00937968: hypothetical protein +FIG00937972 FIG00937975: hypothetical protein +FIG00937977 FIG00937978: hypothetical protein +FIG00937979 FIG00937980: hypothetical protein +FIG00937983 FIG00937984: hypothetical protein +FIG00937987 FIG00937988: hypothetical protein +FIG00937988 FIG00937990: hypothetical protein +FIG00937990 FIG00937991: hypothetical protein +FIG00937992 FIG00937994: hypothetical protein +FIG00937994 FIG00937995: hypothetical protein +FIG00937995 FIG00937996: hypothetical protein +FIG00937997 FIG00937999: hypothetical protein +FIG00938000 FIG00938001: hypothetical protein +FIG00938008 FIG00938009: hypothetical protein +FIG00938010 BatB +FIG00938020 FIG00938021: hypothetical protein +FIG00938024 FIG00938025: hypothetical protein +FIG00938026 FIG00938028: hypothetical protein +FIG00938028 FIG00938031: hypothetical protein +FIG00938031 FIG00938033: hypothetical protein +FIG00938035 FIG00938036: hypothetical protein +FIG00938041 FIG00938042: hypothetical protein +FIG00938042 FIG00938043: hypothetical protein +FIG00938044 FIG00938045: hypothetical protein +FIG00938046 Smf protein DNA processing chain A +FIG00938047 FIG00938048: hypothetical protein +FIG00938048 FIG00938051: hypothetical protein +FIG00938053 FIG00938054: hypothetical protein +FIG00938054 FIG00938055: hypothetical protein +FIG00938055 FIG00939976: hypothetical protein +FIG00938058 FIG00938059: hypothetical protein +FIG00938059 tyrosine type site-specific recombinase +FIG00938068 FIG00938069: hypothetical protein +FIG00938076 AICAR transformylase domain of PurH-like protein +FIG00938081 FIG00938082: hypothetical protein +FIG00938082 FIG00938083: hypothetical protein +FIG00938083 FIG00938084: hypothetical protein +FIG00938084 FIG00938085: hypothetical protein +FIG00938089 FIG00938091: hypothetical protein +FIG00938093 Acyltransferase family protein +FIG00938096 FIG00938097: hypothetical protein +FIG00938097 FIG00938098: hypothetical protein +FIG00938098 FIG00938099: hypothetical protein +FIG00938102 FIG00938104: hypothetical protein +FIG00938110 FIG00938111: hypothetical protein +FIG00938112 FIG00938115: hypothetical protein +FIG00938121 alpha-amylase type B isozyme( EC:3.2.1.1 ) +FIG00938126 FIG00938127: hypothetical protein +FIG00938131 Immunoreactive 53 kDa antigen PG123 +FIG00938134 FIG00407176: hypothetical protein +FIG00938135 FIG00938136: hypothetical protein +FIG00938139 FIG00938140: hypothetical protein +FIG00938141 MdsC protein +FIG00938143 FIG00938145: hypothetical protein +FIG00938150 FIG00938152: hypothetical protein +FIG00938153 FIG00938154: hypothetical protein +FIG00938156 FIG00938157: hypothetical protein +FIG00938157 FIG00938158: hypothetical protein +FIG00938160 FIG00938161: hypothetical protein +FIG00938164 FIG00938165: hypothetical protein +FIG00938165 FIG00938166: hypothetical protein +FIG00938166 FIG00938167: hypothetical protein +FIG00938173 FIG00938174: hypothetical protein +FIG00938179 FIG00938180: hypothetical protein +FIG00938184 FIG00938185: hypothetical protein +FIG00938185 FIG00938187: hypothetical protein +FIG00938194 FIG00938196: hypothetical protein +FIG00938196 FIG00938197: hypothetical protein +FIG00938198 FIG00938199: hypothetical protein +FIG00938201 FIG00938202: hypothetical protein +FIG00938205 FIG00403149: hypothetical protein +FIG00938207 FIG00938208: hypothetical protein +FIG00938210 FIG00938212: hypothetical protein +FIG00938214 FIG00938215: hypothetical protein +FIG00938216 FIG00938217: hypothetical protein +FIG00938219 FIG00938221: hypothetical protein +FIG00938221 FIG00938223: hypothetical protein +FIG00938224 FIG00938225: hypothetical protein +FIG00938227 FIG00938228: hypothetical protein +FIG00938228 FIG00938229: hypothetical protein +FIG00938229 FIG00938231: hypothetical protein +FIG00938236 FIG00938238: hypothetical protein +FIG00938240 lysozyme precursor +FIG00938250 FIG00938251: hypothetical protein +FIG00938255 FIG00938256: hypothetical protein +FIG00938257 probable chitinase +FIG00938260 FIG00938261: hypothetical protein +FIG00938261 FIG00938262: hypothetical protein +FIG00938262 FIG00938263: hypothetical protein +FIG00938263 FIG00938264: hypothetical protein +FIG00938267 FIG00938268: hypothetical protein +FIG00938268 outer membrane lipoprotein Omp28 +FIG00938269 FIG00938270: hypothetical protein +FIG00938271 FIG00938272: hypothetical protein +FIG00938272 FIG00938273: hypothetical protein +FIG00938273 FIG00938274: hypothetical protein +FIG00938276 lipoprotein protein, putative +FIG00938280 FIG00938284: hypothetical protein +FIG00938284 FIG00938285: hypothetical protein +FIG00938285 FIG00405090: hypothetical protein +FIG00938288 FIG00938290: hypothetical protein +FIG00938290 FIG00404772: hypothetical protein +FIG00938292 FIG00938293: hypothetical protein +FIG00938296 FIG00938297: hypothetical protein +FIG00938297 TPR repeat precursor +FIG00938298 FIG00938299: hypothetical protein +FIG00938301 FIG00938303: hypothetical protein +FIG00938305 tetracycline resistance element regulator RteB - Bacteroides thetaiotaomicron +FIG00938307 ENSANGP00000023945 +FIG00938309 FIG00938310: hypothetical protein +FIG00938310 AmpG protein, beta-lactamase induction signal transducer +FIG00938316 FIG00938317: hypothetical protein +FIG00938317 FIG00938318: hypothetical protein +FIG00938321 FIG00938322: hypothetical protein +FIG00938322 FIG00938323: hypothetical protein +FIG00938323 FIG00938324: hypothetical protein +FIG00938325 FIG00938326: hypothetical protein +FIG00938326 FIG00938327: hypothetical protein +FIG00938327 FIG00938328: hypothetical protein +FIG00938328 FIG00938329: hypothetical protein +FIG00938329 putative archaeal ATPase +FIG00938332 FIG00938334: hypothetical protein +FIG00938335 FIG00938336: hypothetical protein +FIG00938337 FIG00938338: hypothetical protein +FIG00938338 FIG00938339: hypothetical protein +FIG00938339 FIG00938341: hypothetical protein +FIG00938342 FIG00938343: hypothetical protein +FIG00938344 FIG00938345: hypothetical protein +FIG00938349 FIG00938350: hypothetical protein +FIG00938350 FIG00938351: hypothetical protein +FIG00938352 Xylosidase/arabinosidase +FIG00938355 FIG00938356: hypothetical protein +FIG00938358 FIG00938360: hypothetical protein +FIG00938360 FIG00938361: hypothetical protein +FIG00938362 FIG00938363: hypothetical protein +FIG00938363 FIG00404494: hypothetical protein +FIG00938365 probable lipoprotein precursor +FIG00938368 FIG00938369: hypothetical protein +FIG00938369 FIG00938370: hypothetical protein +FIG00938375 excisionase +FIG00938378 FIG00938379: hypothetical protein +FIG00938382 FIG00938383: hypothetical protein +FIG00938386 FIG00938387: hypothetical protein +FIG00938390 FIG00938392: hypothetical protein +FIG00938405 FIG00938406: hypothetical protein +FIG00938406 FIG00938407: hypothetical protein +FIG00938407 Peptidase, M49 family +FIG00938422 FIG00938423: hypothetical protein +FIG00938427 FIG00938428: hypothetical protein +FIG00938430 FIG00938431: hypothetical protein +FIG00938432 FIG00938434: hypothetical protein +FIG00938437 FIG00938439: hypothetical protein +FIG00938440 FIG00938441: hypothetical protein +FIG00938441 FIG00938443: hypothetical protein +FIG00938444 Carboxyl-terminal protease-related protein +FIG00938446 FIG00938448: hypothetical protein +FIG00938449 FIG00938450: hypothetical protein +FIG00938451 FIG00938452: hypothetical protein +FIG00938454 FIG00405790: hypothetical protein +FIG00938457 two component transcriptional regulator, LytTR family +FIG00938459 FIG00938461: hypothetical protein +FIG00938464 FIG00938465: hypothetical protein +FIG00938468 FIG00406346: hypothetical protein +FIG00938478 FIG00938479: hypothetical protein +FIG00938482 FIG00938484: hypothetical protein +FIG00938485 FIG00938486: hypothetical protein +FIG00938486 FIG00938487: hypothetical protein +FIG00938493 FIG00938494: hypothetical protein +FIG00938494 FIG00938495: hypothetical protein +FIG00938501 contains UPF0028 domain +FIG00938510 FIG00938511: hypothetical protein +FIG00938513 tetracycline resistance element mobilization regulatory protein RteC +FIG00938515 FIG00938516: hypothetical protein +FIG00938516 FIG00938518: hypothetical protein +FIG00938518 conserved hypothetical protein; possible acyltransferase +FIG00938521 FIG00938522: hypothetical protein +FIG00938523 FIG00938526: hypothetical protein +FIG00938528 FIG00938530: hypothetical protein +FIG00938530 FIG00938531: hypothetical protein +FIG00938537 FIG00938538: hypothetical protein +FIG00938539 serine (or cysteine) peptidase inhibitor, clade B, member 9 +FIG00938540 FIG00938541: hypothetical protein +FIG00938541 FIG00938542: hypothetical protein +FIG00938542 FIG00935709: hypothetical protein +FIG00938547 FIG00938548: hypothetical protein +FIG00938553 FIG00938555: hypothetical protein +FIG00938557 FIG00938559: hypothetical protein +FIG00938559 FIG00938560: hypothetical protein +FIG00938560 FIG00938561: hypothetical protein +FIG00938561 FIG00938562: hypothetical protein +FIG00938563 FIG00896368: hypothetical protein +FIG00938565 Endo-beta-N-acetylglucosaminidase F2 +FIG00938566 FIG00938567: hypothetical protein +FIG00938568 FIG00938569: hypothetical protein +FIG00938569 FIG00938571: hypothetical protein +FIG00938572 FIG00938573: hypothetical protein +FIG00938578 FIG00938580: hypothetical protein +FIG00938580 FIG00938582: hypothetical protein +FIG00938586 FIG00938588: hypothetical protein +FIG00938592 FIG00938593: hypothetical protein +FIG00938593 FIG00938594: hypothetical protein +FIG00938597 FIG00938598: hypothetical protein +FIG00938601 FIG00403581: hypothetical protein +FIG00938602 Mannan endo-1,4-beta-mannosidase B precursor (EC 3.2.1.78) +FIG00938610 FIG00938612: hypothetical protein +FIG00938617 FIG00938618: hypothetical protein +FIG00938618 FIG00938619: hypothetical protein +FIG00938619 FIG00938620: hypothetical protein +FIG00938621 FIG00938623: hypothetical protein +FIG00938623 FIG00938624: hypothetical protein +FIG00938624 FIG00938625: hypothetical protein +FIG00938625 FIG00938626: hypothetical protein +FIG00938627 FIG00938628: hypothetical protein +FIG00938629 FIG00938631: hypothetical protein +FIG00938631 FIG00938632: hypothetical protein +FIG00938637 FIG00938638: hypothetical protein +FIG00938641 FIG00938643: hypothetical protein +FIG00938646 FIG00938649: hypothetical protein +FIG00938649 FIG00938650: hypothetical protein +FIG00938654 FIG00938655: hypothetical protein +FIG00938655 FIG00938656: hypothetical protein +FIG00938656 FIG00938657: hypothetical protein +FIG00938657 FIG00938658: hypothetical protein +FIG00938676 putative O-antigen related protein +FIG00938681 FIG00938682: hypothetical protein +FIG00938682 FIG00938683: hypothetical protein +FIG00938683 FIG00938684: hypothetical protein +FIG00938684 Outer membrane receptor for Fe3+-dicitrate +FIG00938686 putative endothelin-converting enzyme +FIG00938688 FIG00938689: hypothetical protein +FIG00938690 FIG00403302: hypothetical protein +FIG00938695 FIG00938696: hypothetical protein +FIG00938696 FIG00938697: hypothetical protein +FIG00938699 FIG00938700: hypothetical protein +FIG00938703 FIG00938704: hypothetical protein +FIG00938705 FIG00938706: hypothetical protein +FIG00938714 tricorn protease +FIG00938715 FIG00938717: hypothetical protein +FIG00938721 Predicted sodium-dependent galactose transporter +FIG00938727 FIG00404596: hypothetical protein +FIG00938729 FIG00938730: hypothetical protein +FIG00938732 FIG00938733: hypothetical protein +FIG00938738 FIG00938739: hypothetical protein +FIG00938746 FIG00407687: hypothetical protein +FIG00938749 FIG00938750: hypothetical protein +FIG00938751 FIG00938753: hypothetical protein +FIG00938759 Putative collagenase +FIG00938765 3-oxoacyl-[acyl-carrier-protein] synthase II( EC:2.3.1.41 ) +FIG00938766 FIG00938767: hypothetical protein +FIG00938768 FIG00938769: hypothetical protein +FIG00938770 FIG00938771: hypothetical protein +FIG00938773 FIG00938774: hypothetical protein +FIG00938774 FIG00938776: hypothetical protein +FIG00938786 FIG01057005: hypothetical protein +FIG00938791 FIG00938792: hypothetical protein +FIG00938792 deoxynucleoside 5'-monophosphate N-glycosidase +FIG00938793 FIG00938795: hypothetical protein +FIG00938799 FIG00938801: hypothetical protein +FIG00938801 FIG00938802: hypothetical protein +FIG00938803 Patatin-like protein +FIG00938804 FIG00938805: hypothetical protein +FIG00938805 FIG00938806: hypothetical protein +FIG00938806 FIG00938807: hypothetical protein +FIG00938813 FIG00938814: hypothetical protein +FIG00938820 FIG00938821: hypothetical protein +FIG00938823 FIG00938824: hypothetical protein +FIG00938824 FIG00938825: hypothetical protein +FIG00938833 FIG00938834: hypothetical protein +FIG00938836 FIG00938837: hypothetical protein +FIG00938838 FIG00411912: hypothetical protein +FIG00938840 M6 family metalloprotease domain protein +FIG00938841 FIG00938842: hypothetical protein +FIG00938842 OXYGEN-INSENSITIVE NAD(P)H NITROREDUCTASE +FIG00938845 FIG00938846: hypothetical protein +FIG00938846 FIG00938847: hypothetical protein +FIG00938851 FIG00938853: hypothetical protein +FIG00938859 Glucose-1-phosphatase precursor (EC 3.1.3.10) +FIG00938876 FIG00938878: hypothetical protein +FIG00938880 FIG00938881: hypothetical protein +FIG00938884 FIG00938889: hypothetical protein +FIG00938892 FIG00938893: hypothetical protein +FIG00938893 FIG00938894: hypothetical protein +FIG00938895 FIG00938896: hypothetical protein +FIG00938899 FIG00938900: hypothetical protein +FIG00938900 FIG00938901: hypothetical protein +FIG00938902 FIG00938903: hypothetical protein +FIG00938906 FIG00938907: hypothetical protein +FIG00938907 FIG00938908: hypothetical protein +FIG00938912 FIG00938913: hypothetical protein +FIG00938914 FIG00938915: hypothetical protein +FIG00938916 FIG00938917: hypothetical protein +FIG00938921 FIG00938922: hypothetical protein +FIG00938924 FIG00938925: hypothetical protein +FIG00938925 FIG00938926: hypothetical protein +FIG00938926 FIG00938927: hypothetical protein +FIG00938929 FIG00938930: hypothetical protein +FIG00938932 Cobalamin (vitamin B12) biosynthesis CbiX protein +FIG00938937 putative alpha-glucosidase II( EC:3.2.1.20 ) +FIG00938941 FIG00939854: hypothetical protein +FIG00938942 FIG00938943: hypothetical protein +FIG00938953 FIG00938954: hypothetical protein +FIG00938957 FIG00938958: hypothetical protein +FIG00938958 FIG00938959: hypothetical protein +FIG00938964 hypothetical transporter PduT for various metalloporphyrins +FIG00938967 DNA binding protein, excisionase family, putative +FIG00938973 FIG00938974: hypothetical protein +FIG00938977 Fic +FIG00938979 FIG00938980: hypothetical protein +FIG00938985 COG0671: Membrane-associated phospholipid phosphatase +FIG00938986 FIG00938987: hypothetical protein +FIG00938990 FIG00938991: hypothetical protein +FIG00938991 FIG00938992: hypothetical protein +FIG00938992 FIG00938993: hypothetical protein +FIG00938994 FIG00938996: hypothetical protein +FIG00938996 FIG00938997: hypothetical protein +FIG00938998 FIG00938999: hypothetical protein +FIG00939000 FIG00939001: hypothetical protein +FIG00939001 FIG00939003: hypothetical protein +FIG00939015 FIG00939016: hypothetical protein +FIG00939017 FIG00939018: hypothetical protein +FIG00939023 FIG00939024: hypothetical protein +FIG00939028 FIG00939029: hypothetical protein +FIG00939029 FIG00939030: hypothetical protein +FIG00939030 FIG00939032: hypothetical protein +FIG00939034 FIG00939035: hypothetical protein +FIG00939037 FIG00939038: hypothetical protein +FIG00939041 FIG00407620: hypothetical protein +FIG00939043 FIG00939044: hypothetical protein +FIG00939046 FIG00939048: hypothetical protein +FIG00939048 FIG00939049: hypothetical protein +FIG00939052 FIG00939053: hypothetical protein +FIG00939053 FIG00939054: hypothetical protein +FIG00939056 FIG00939057: hypothetical protein +FIG00939062 FIG00939063: hypothetical protein +FIG00939066 CHU large protein; uncharacterized +FIG00939067 FIG00939068: hypothetical protein +FIG00939068 FIG00939069: hypothetical protein +FIG00939072 glycosyl transferase, family 11 +FIG00939074 FIG00939075: hypothetical protein +FIG00939076 FIG00939077: hypothetical protein +FIG00939078 FIG00939079: hypothetical protein +FIG00939080 FIG00939081: hypothetical protein +FIG00939084 FIG00939085: hypothetical protein +FIG00939085 FIG00939086: hypothetical protein +FIG00939086 putative capsular polysaccharide biosynthesis glycosyltransferase +FIG00939089 FIG00939092: hypothetical protein +FIG00939095 site-specific DNA-methyltransferase +FIG00939098 FIG00939099: hypothetical protein +FIG00939103 FIG00939105: hypothetical protein +FIG00939120 FIG00939121: hypothetical protein +FIG00939123 Major outer membrane protein OmpA +FIG00939125 FIG00939126: hypothetical protein +FIG00939126 FIG00939127: hypothetical protein +FIG00939127 FIG00939128: hypothetical protein +FIG00939133 FIG00939134: hypothetical protein +FIG00939137 FIG00939138: hypothetical protein +FIG00939138 FIG00939139: hypothetical protein +FIG00939140 FIG00937426: hypothetical protein +FIG00939144 FIG00939145: hypothetical protein +FIG00939157 FIG00939158: hypothetical protein +FIG00939158 FIG00939159: hypothetical protein +FIG00939159 FIG00939160: hypothetical protein +FIG00939162 FIG00939163: hypothetical protein +FIG00939174 FIG00939175: hypothetical protein +FIG00939175 FIG00939176: hypothetical protein +FIG00939176 FIG00939177: hypothetical protein +FIG00939177 FIG00939179: hypothetical protein +FIG00939182 FIG00939183: hypothetical protein +FIG00939183 FIG00939184: hypothetical protein +FIG00939191 FIG00939192: hypothetical protein +FIG00939195 FIG00939196: hypothetical protein +FIG00939206 FIG00939207: hypothetical protein +FIG00939209 FIG00939210: hypothetical protein +FIG00939213 FIG00939214: hypothetical protein +FIG00939214 FIG00939215: hypothetical protein +FIG00939220 FIG00939221: hypothetical protein +FIG00939223 FIG00939225: hypothetical protein +FIG00939226 FIG00939227: hypothetical protein +FIG00939227 FIG00939228: hypothetical protein +FIG00939229 FIG00939230: hypothetical protein +FIG00939234 FIG00939236: hypothetical protein +FIG00939239 FIG00939241: hypothetical protein +FIG00939242 FIG00939243: hypothetical protein +FIG00939245 FIG00939246: hypothetical protein +FIG00939249 protein containing nucleotide-diphospho-sugar transferase domain +FIG00939257 FIG00939260: hypothetical protein +FIG00939260 FIG00939262: hypothetical protein +FIG00939265 FIG00939266: hypothetical protein +FIG00939271 FIG00939273: hypothetical protein +FIG00939275 FIG00939278: hypothetical protein +FIG00939283 FIG00939284: hypothetical protein +FIG00939284 FIG00939285: hypothetical protein +FIG00939286 similar to SP|P41819 Dimethyladenosine transferase (EC 2.1.1.-) (S-adenosylmethionine-6-N', N'-adenosyl(rRNA) dimethyltransferase) {Saccharomyces cerevisiae}; contains Pfam profile PF00398: ribosomal RNA adenine dimethylase family protein; go_function: rRNA (adenine-N6,N6-)-dimethyltransferase activity [goid 0000179]; go_function: rRNA methyltransferase activity [goid 0008649]; go_process: rRNA modification [goid 0000154] / ribosomal RNA adenine dimethylase family protein +FIG00939287 FIG00939288: hypothetical protein +FIG00939289 FIG00939291: hypothetical protein +FIG00939292 FIG00939293: hypothetical protein +FIG00939300 FIG00939304: hypothetical protein +FIG00939315 FIG00939317: hypothetical protein +FIG00939326 FIG00939328: hypothetical protein +FIG00939329 putative integration host factor IHF alpha subunit +FIG00939330 FIG00939331: hypothetical protein +FIG00939334 FIG00406495: hypothetical protein +FIG00939337 FIG00939338: hypothetical protein +FIG00939342 FIG00939343: hypothetical protein +FIG00939343 FIG00939344: hypothetical protein +FIG00939345 FIG00939346: hypothetical protein +FIG00939346 FIG00939349: hypothetical protein +FIG00939349 FIG00939351: hypothetical protein +FIG00939360 FIG00939361: hypothetical protein +FIG00939361 FIG00939362: hypothetical protein +FIG00939362 FIG00939363: hypothetical protein +FIG00939364 Glycosyl hydrolase, family 88 +FIG00939367 FIG00939369: hypothetical protein +FIG00939370 FIG00939373: hypothetical protein +FIG00939373 FIG00939374: hypothetical protein +FIG00939374 FIG00939376: hypothetical protein +FIG00939377 FIG00939378: hypothetical protein +FIG00939378 FIG00939379: hypothetical protein +FIG00939379 FIG00939381: hypothetical protein +FIG00939396 FIG00939397: hypothetical protein +FIG00939404 FIG00939405: hypothetical protein +FIG00939406 AsnC family transcriptional regulator +FIG00939407 FIG00939408: hypothetical protein +FIG00939417 FIG00939418: hypothetical protein +FIG00939421 FIG00939422: hypothetical protein +FIG00939423 FIG00939424: hypothetical protein +FIG00939426 FIG00939427: hypothetical protein +FIG00939427 Eps6I +FIG00939428 FIG00939429: hypothetical protein +FIG00939438 FIG00939439: hypothetical protein +FIG00939451 FIG00939452: hypothetical protein +FIG00939461 FIG00939463: hypothetical protein +FIG00939464 FIG00939466: hypothetical protein +FIG00939469 Subtilisin-like serine proteases +FIG00939470 FIG00939471: hypothetical protein +FIG00939471 FIG00939472: hypothetical protein +FIG00939473 FIG00939475: hypothetical protein +FIG00939478 FIG00408262: hypothetical protein +FIG00939479 FIG00939480: hypothetical protein +FIG00939491 probable endo-beta-N-acetylglucosaminidase; di-N-acetylchitobiosyl beta-N-acetylglucosaminidase +FIG00939502 FIG00939505: hypothetical protein +FIG00939508 FIG00939509: hypothetical protein +FIG00939510 FIG00939511: hypothetical protein +FIG00939511 FIG00939514: hypothetical protein +FIG00939521 FIG00939522: hypothetical protein +FIG00939522 FIG00939523: hypothetical protein +FIG00939523 FIG00939524: hypothetical protein +FIG00939525 FIG00939527: hypothetical protein +FIG00939530 FIG00939531: hypothetical protein +FIG00939536 FIG00939537: hypothetical protein +FIG00939537 FIG00939538: hypothetical protein +FIG00939538 FIG00939540: hypothetical protein +FIG00939542 FIG00939544: hypothetical protein +FIG00939548 FIG00939549: hypothetical protein +FIG00939557 FIG00939558: hypothetical protein +FIG00939561 FIG00939562: hypothetical protein +FIG00939564 FIG00939565: hypothetical protein +FIG00939568 FIG00939569: hypothetical protein +FIG00939570 FIG00939571: hypothetical protein +FIG00939578 FIG00939579: hypothetical protein +FIG00939579 FIG00939581: hypothetical protein +FIG00939581 FIG00939582: hypothetical protein +FIG00939582 FIG00939584: hypothetical protein +FIG00939600 NAD-utilizing dehydrogenases +FIG00939602 FIG00939603: hypothetical protein +FIG00939603 FIG00939606: hypothetical protein +FIG00939611 FIG00939615: hypothetical protein +FIG00939621 FIG00939624: hypothetical protein +FIG00939624 mannosyl-glycoprotein endo-beta-N-acetylglucosamidase +FIG00939627 FIG00939628: hypothetical protein +FIG00939630 FIG00939631: hypothetical protein +FIG00939637 FIG00939638: hypothetical protein +FIG00939640 FIG00939641: hypothetical protein +FIG00939645 FIG00939646: hypothetical protein +FIG00939647 FIG00939648: hypothetical protein +FIG00939650 FIG00939651: hypothetical protein +FIG00939651 FIG00939652: hypothetical protein +FIG00939652 FIG00939653: hypothetical protein +FIG00939653 FIG00939654: hypothetical protein +FIG00939659 FIG00939662: hypothetical protein +FIG00939662 FIG00939663: hypothetical protein +FIG00939668 FIG00939669: hypothetical protein +FIG00939670 FIG00939671: hypothetical protein +FIG00939678 FIG00939679: hypothetical protein +FIG00939681 FIG00939682: hypothetical protein +FIG00939692 FIG00939693: hypothetical protein +FIG00939693 FIG00939694: hypothetical protein +FIG00939695 FIG00939696: hypothetical protein +FIG00939696 FIG00939697: hypothetical protein +FIG00939700 FIG00939702: hypothetical protein +FIG00939702 TnpC +FIG00939707 FIG00939708: hypothetical protein +FIG00939720 FIG00406375: hypothetical protein +FIG00939730 FIG00939731: hypothetical protein +FIG00939736 FIG00939737: hypothetical protein +FIG00939737 FIG00939738: hypothetical protein +FIG00939738 FIG00939739: hypothetical protein +FIG00939740 FIG00939741: hypothetical protein +FIG00939746 FIG00939747: hypothetical protein +FIG00939747 FIG00939748: hypothetical protein +FIG00939750 FIG00939751: hypothetical protein +FIG00939761 FIG00939762: hypothetical protein +FIG00939764 FIG00939765: hypothetical protein +FIG00939766 FIG00939770: hypothetical protein +FIG00939777 Amidase enhancer +FIG00939790 FIG00939791: hypothetical protein +FIG00939799 FIG00939801: hypothetical protein +FIG00939801 FIG00939806: hypothetical protein +FIG00939806 FIG00939808: hypothetical protein +FIG00939820 Aldose 1-epimerase( EC:5.1.3.3 ) +FIG00939826 Glucan 1,6-alpha-isomaltosidase( EC:3.2.1.94 ) +FIG00939827 FIG00939828: hypothetical protein +FIG00939830 FIG00939831: hypothetical protein +FIG00939832 FIG00939833: hypothetical protein +FIG00939833 FIG00939834: hypothetical protein +FIG00939834 FIG00939835: hypothetical protein +FIG00939835 FIG00939837: hypothetical protein +FIG00939837 FIG00939838: hypothetical protein +FIG00939842 FIG00939843: hypothetical protein +FIG00939845 FIG00939846: hypothetical protein +FIG00939855 FIG00939856: hypothetical protein +FIG00939856 FIG00939857: hypothetical protein +FIG00939872 FIG00939874: hypothetical protein +FIG00939876 FIG00939877: hypothetical protein +FIG00939879 methyltransferase (ssoIM) +FIG00939887 FIG00939888: hypothetical protein +FIG00939917 FIG00939918: hypothetical protein +FIG00939918 FIG00939919: hypothetical protein +FIG00939922 FIG00939923: hypothetical protein +FIG00939931 FIG00939932: hypothetical protein +FIG00939933 FIG00939934: hypothetical protein +FIG00939936 FIG00939937: hypothetical protein +FIG00939947 FIG00939948: hypothetical protein +FIG00939957 FIG00939958: hypothetical protein +FIG00939959 FIG00939960: hypothetical protein +FIG00939962 FIG00405262: hypothetical protein +FIG00939969 FIG00939970: hypothetical protein +FIG00939982 FIG00939983: hypothetical protein +FIG00939987 FIG00939988: hypothetical protein +FIG00939996 FIG00939997: hypothetical protein +FIG00940008 FIG00940009: hypothetical protein +FIG00940013 Thiol:disulfide interchange protein +FIG00940015 FIG00940016: hypothetical protein +FIG00940024 FIG00940025: hypothetical protein +FIG00940037 FIG00940038: hypothetical protein +FIG00940045 FIG00940047: hypothetical protein +FIG00940051 FIG00940052: hypothetical protein +FIG00940054 FIG00940055: hypothetical protein +FIG00940055 FIG00940056: hypothetical protein +FIG00940056 FIG00940057: hypothetical protein +FIG00940057 Periplasmic protease +FIG00940058 FIG00940061: hypothetical protein +FIG00940061 possible transcription regulator +FIG00940063 FIG00940064: hypothetical protein +FIG00940064 FIG00940066: hypothetical protein +FIG00940066 FIG00940068: hypothetical protein +FIG00940068 FIG00940071: hypothetical protein +FIG00940071 FIG00940073: hypothetical protein +FIG00940073 Diflavin flavoprotein SYNW2368 +FIG00940076 possible Pollen allergen +FIG00940077 FIG00940078: hypothetical protein +FIG00940079 FIG00940080: hypothetical protein +FIG00940080 FIG00940081: hypothetical protein +FIG00940081 FIG00940082: hypothetical protein +FIG00940082 FIG00940083: hypothetical protein +FIG00940083 Fatty acid desaturase, type 2 (EC 1.14.99.-) +FIG00940084 FIG00940085: hypothetical protein +FIG00940085 FIG00940086: hypothetical protein +FIG00940086 ABC transporter, substrate binding protein, possibly oligopeptides +FIG00940089 FIG00940092: hypothetical protein +FIG00940092 FIG00940093: hypothetical protein +FIG00940096 FIG00940097: hypothetical protein +FIG00940097 FIG00940099: hypothetical protein +FIG00940102 FIG00940105: hypothetical protein +FIG00940105 FIG00940106: hypothetical protein +FIG00940107 FIG00940108: hypothetical protein +FIG00940109 possible ABC transporter component +FIG00940110 FIG00940112: hypothetical protein +FIG00940113 Possible Viral (Superfamily 1) RNA helicase +FIG00940116 NADH-plastoquinone oxidoreductase chain 5-like protein +FIG00940117 DNA repair enzyme, contains HhH domain and nuclease of RecB family +FIG00940118 FIG00940120: hypothetical protein +FIG00940120 FIG00940122: hypothetical protein +FIG00940122 FIG00940123: hypothetical protein +FIG00940123 FIG00940124: hypothetical protein +FIG00940124 FIG00940127: hypothetical protein +FIG00940127 FIG00940130: hypothetical protein +FIG00940130 FIG00940131: hypothetical protein +FIG00940131 FIG00940133: hypothetical protein +FIG00940133 FIG00940134: hypothetical protein +FIG00940135 FIG00940136: hypothetical protein +FIG00940136 FIG00940137: hypothetical protein +FIG00940137 FIG00940138: hypothetical protein +FIG00940139 possible Influenza RNA-dependent RNA polymeras +FIG00940143 FIG00940145: hypothetical protein +FIG00940145 FIG00940146: hypothetical protein +FIG00940146 FIG00940147: hypothetical protein +FIG00940149 FIG00940150: hypothetical protein +FIG00940150 FIG00940153: hypothetical protein +FIG00940153 FIG00940154: hypothetical protein +FIG00940156 Cyanobacteria-specific protein containing UvrC-like endonuclease domain +FIG00940158 FIG00940159: hypothetical protein +FIG00940159 FIG00940160: hypothetical protein +FIG00940160 Glucosylglycerol 3-phosphatase (EC 3.1.3.69) +FIG00940161 FIG00940162: hypothetical protein +FIG00940162 FIG00940164: hypothetical protein +FIG00940165 FIG00940166: hypothetical protein +FIG00940166 FIG00940167: hypothetical protein +FIG00940167 possible Nucleoside diphosphate kinase +FIG00940169 FIG00940173: hypothetical protein +FIG00940175 FIG00940177: hypothetical protein +FIG00940177 FIG00940178: hypothetical protein +FIG00940178 FIG00940179: hypothetical protein +FIG00940179 FIG00940180: hypothetical protein +FIG00940180 Vng0271c-like protein +FIG00940182 FIG00940183: hypothetical protein +FIG00940183 FIG00940184: hypothetical protein +FIG00940184 FIG00940185: hypothetical protein +FIG00940185 FIG00940186: hypothetical protein +FIG00940186 FIG00940187: hypothetical protein +FIG00940187 FIG00940188: hypothetical protein +FIG00940190 FIG00940192: hypothetical protein +FIG00940195 FIG00940197: hypothetical protein +FIG00940197 FAD/FMN-containing dehydrogenase +FIG00940198 FIG00940200: hypothetical protein +FIG00940200 Alpha/beta superfamily hydrolase +FIG00940202 FIG00940203: hypothetical protein +FIG00940203 FIG00940204: hypothetical protein +FIG00940204 FIG00940206: hypothetical protein +FIG00940206 FIG00940208: hypothetical protein +FIG00940208 FIG00940211: hypothetical protein +FIG00940211 possible secreted protein MPB70 precursor +FIG00940212 FIG00940214: hypothetical protein +FIG00940214 FIG00940215: hypothetical protein +FIG00940215 FIG00940216: hypothetical protein +FIG00940221 ABC transporter, substrate binding protein for amino acids precursor +FIG00940222 FIG00940223: hypothetical protein +FIG00940223 FIG00940224: hypothetical protein +FIG00940224 FIG00940226: hypothetical protein +FIG00940226 FIG00940227: hypothetical protein +FIG00940228 FIG00940229: hypothetical protein +FIG00940229 FIG00940230: hypothetical protein +FIG00940230 FIG00940231: hypothetical protein +FIG00940231 Possible high light inducible protein +FIG00940232 FIG00940233: hypothetical protein +FIG00940233 FIG00940235: hypothetical protein +FIG00940237 possible DNA polymerase III, epsilon subunit +FIG00940241 FIG00940242: hypothetical protein +FIG00940242 FIG00940245: hypothetical protein +FIG00940245 FIG00940247: hypothetical protein +FIG00940248 FIG00940249: hypothetical protein +FIG00940249 FIG00940250: hypothetical protein +FIG00940250 FIG00940251: hypothetical protein +FIG00940252 FIG00940253: hypothetical protein +FIG00940253 FIG00940256: hypothetical protein +FIG00940261 S-isoprenylcysteine O-methyltransferase related enzyme +FIG00940262 FIG00940263: hypothetical protein +FIG00940263 FIG00940264: hypothetical protein +FIG00940264 FIG00940265: hypothetical protein +FIG00940265 FIG00940267: hypothetical protein +FIG00940267 FIG00940268: hypothetical protein +FIG00940268 possible Villin headpiece domain +FIG00940270 FIG00940271: hypothetical protein +FIG00940271 FIG00940272: hypothetical protein +FIG00940272 predicted membrane protein (COG2259) +FIG00940273 FIG00940274: hypothetical protein +FIG00940274 FIG00940275: hypothetical protein +FIG00940279 Myosin heavy chain, clone 203 +FIG00940281 FIG00940284: hypothetical protein +FIG00940287 FIG00940288: hypothetical protein +FIG00940290 FIG00940291: hypothetical protein +FIG00940291 FIG00940295: hypothetical protein +FIG00940295 FIG00940299: hypothetical protein +FIG00940299 FIG00940302: hypothetical protein +FIG00940303 FIG00940304: hypothetical protein +FIG00940304 FIG00940305: hypothetical protein +FIG00940305 FIG00940306: hypothetical protein +FIG00940306 FIG00940307: hypothetical protein +FIG00940307 FIG00940310: hypothetical protein +FIG00940310 FIG00940311: hypothetical protein +FIG00940313 FIG00940314: hypothetical protein +FIG00940315 FIG00940319: hypothetical protein +FIG00940320 FIG00940321: hypothetical protein +FIG00940321 FIG00940322: hypothetical protein +FIG00940323 FIG00940325: hypothetical protein +FIG00940329 Hypothetical protein CbbY +FIG00940333 FIG00940334: hypothetical protein +FIG00940334 FIG00940336: hypothetical protein +FIG00940336 FIG00940338: hypothetical protein +FIG00940338 Cyanobacteria-specific chaperone containing DNAJ domain fused to a membrane domain +FIG00940343 possible RNA recognition motif. (a.k.a. RRM, R +FIG00940347 FIG00940348: hypothetical protein +FIG00940348 FIG00940349: hypothetical protein +FIG00940349 FIG00940350: hypothetical protein +FIG00940350 FIG00940351: hypothetical protein +FIG00940351 Possible ABC transporter precursor +FIG00940352 possible multidrug efflux transporter, MFS family +FIG00940355 FIG00940357: hypothetical protein +FIG00940359 FIG00940360: hypothetical protein +FIG00940360 FIG00940361: hypothetical protein +FIG00940362 FIG00940364: hypothetical protein +FIG00940364 FIG00940366: hypothetical protein +FIG00940366 FIG00940369: hypothetical protein +FIG00940375 possible high light inducible protein +FIG00940378 FIG00940379: hypothetical protein +FIG00940379 FIG00940380: hypothetical protein +FIG00940380 FIG00940381: hypothetical protein +FIG00940381 FIG00940382: hypothetical protein +FIG00940382 FIG00940386: hypothetical protein +FIG00940386 Zn-dependent hydrolase of the beta-lactamase fold, partial +FIG00940388 putative chromate transporter, CHR family +FIG00940395 FIG00940396: hypothetical protein +FIG00940396 FIG00940400: hypothetical protein +FIG00940400 FIG00940402: hypothetical protein +FIG00940402 FIG00940404: hypothetical protein +FIG00940405 FIG00940407: hypothetical protein +FIG00940407 FIG00940411: hypothetical protein +FIG00940411 FIG00940412: hypothetical protein +FIG00940412 possible SMC domain N terminal domain +FIG00940413 FIG00940414: hypothetical protein +FIG00940417 putative RIKEN cDNA 1200003J11; EST AA930106 [Mus muscu... +FIG00940418 FIG00940419: hypothetical protein +FIG00940419 FIG00940421: hypothetical protein +FIG00940421 FIG00940422: hypothetical protein +FIG00940423 FIG00940424: hypothetical protein +FIG00940424 FIG00940426: hypothetical protein +FIG00940426 Phycoerythrin beta chain; Phycobilisome protein +FIG00940427 Glutathione S-transferase C terminus +FIG00940428 FIG00940429: hypothetical protein +FIG00940429 FIG00940431: hypothetical protein +FIG00940433 FIG00940435: hypothetical protein +FIG00940435 Bll0289 protein +FIG00940437 FIG00940439: hypothetical protein +FIG00940442 Domain of unknown function DUF1537 +FIG00940443 FIG00940444: hypothetical protein +FIG00940444 FIG00940445: hypothetical protein +FIG00940445 FIG00940447: hypothetical protein +FIG00940447 FIG00940448: hypothetical protein +FIG00940449 FIG00940450: hypothetical protein +FIG00940450 FIG00940453: hypothetical protein +FIG00940453 FIG00940454: hypothetical protein +FIG00940454 UDP-galactopyranose mutase +FIG00940455 FIG00940456: hypothetical protein +FIG00940457 FIG00940458: hypothetical protein +FIG00940459 FIG00940460: hypothetical protein +FIG00940462 FIG00940463: hypothetical protein +FIG00940463 FIG00940464: hypothetical protein +FIG00940464 FIG00940466: hypothetical protein +FIG00940469 FIG00940470: hypothetical protein +FIG00940470 FIG00940472: hypothetical protein +FIG00940472 FIG00940474: hypothetical protein +FIG00940474 FIG00940477: hypothetical protein +FIG00940477 FIG00940478: hypothetical protein +FIG00940478 possible Bacterial type II secretion system pr +FIG00940479 possible GRAM domain +FIG00940484 FIG00940485: hypothetical protein +FIG00940485 FIG00940487: hypothetical protein +FIG00940487 FIG00940488: hypothetical protein +FIG00940488 FIG00940489: hypothetical protein +FIG00940489 FIG00940490: hypothetical protein +FIG00940490 FIG00940492: hypothetical protein +FIG00940492 FIG00940495: hypothetical protein +FIG00940495 FIG00940496: hypothetical protein +FIG00940496 FIG00940497: hypothetical protein +FIG00940499 FIG00940500: hypothetical protein +FIG00940500 FIG00940501: hypothetical protein +FIG00940501 FIG00940502: hypothetical protein +FIG00940502 FIG00940504: hypothetical protein +FIG00940505 FIG00940506: hypothetical protein +FIG00940506 FIG00940507: hypothetical protein +FIG00940507 FIG00940508: hypothetical protein +FIG00940508 FIG00940510: hypothetical protein +FIG00940510 FIG00940511: hypothetical protein +FIG00940511 FIG00940513: hypothetical protein +FIG00940513 FIG00940514: hypothetical protein +FIG00940514 NADH dehydrogenase subunit; NdhL +FIG00940520 FIG00940521: hypothetical protein +FIG00940521 FIG00940522: hypothetical protein +FIG00940525 FIG00940526: hypothetical protein +FIG00940526 FIG00940531: hypothetical protein +FIG00940533 FIG00940534: hypothetical protein +FIG00940534 FIG00940535: hypothetical protein +FIG00940535 FIG00940540: hypothetical protein +FIG00940540 FIG00940546: hypothetical protein +FIG00940548 FIG00940552: hypothetical protein +FIG00940552 FIG00940553: hypothetical protein +FIG00940553 FIG00940555: hypothetical protein +FIG00940555 FIG00940556: hypothetical protein +FIG00940559 FIG00940560: hypothetical protein +FIG00940561 FIG00940562: hypothetical protein +FIG00940562 possible Arenavirus glycoprotein +FIG00940565 FIG00940566: hypothetical protein +FIG00940566 FIG00940567: hypothetical protein +FIG00940567 FIG00940568: hypothetical protein +FIG00940568 FIG00940569: hypothetical protein +FIG00940569 FIG00940570: hypothetical protein +FIG00940570 FIG00940571: hypothetical protein +FIG00940576 FIG00940579: hypothetical protein +FIG00940580 FIG00940581: hypothetical protein +FIG00940581 FIG00940582: hypothetical protein +FIG00940582 FIG00940583: hypothetical protein +FIG00940583 possible Protein of unknown function DUF67 +FIG00940584 FIG00940587: hypothetical protein +FIG00940587 FIG00940588: hypothetical protein +FIG00940596 FIG01150414: hypothetical protein +FIG00940597 FIG00940599: hypothetical protein +FIG00940599 FIG00940600: hypothetical protein +FIG00940601 FIG00940602: hypothetical protein +FIG00940602 FIG00940603: hypothetical protein +FIG00940603 FIG00940605: hypothetical protein +FIG00940607 Possible Adenoviral fiber protein +FIG00940608 FIG00940610: hypothetical protein +FIG00940610 FIG00940611: hypothetical protein +FIG00940611 FIG00940612: hypothetical protein +FIG00940612 FIG00940613: hypothetical protein +FIG00940613 FIG00940616: hypothetical protein +FIG00940616 FIG00940617: hypothetical protein +FIG00940617 FIG00940619: hypothetical protein +FIG00940619 FIG00940620: hypothetical protein +FIG00940620 FIG00940621: hypothetical protein +FIG00940621 FIG00940622: hypothetical protein +FIG00940622 FIG00940624: hypothetical protein +FIG00940624 FIG00940626: hypothetical protein +FIG00940626 hypothetical protein +FIG00940628 FIG00940630: hypothetical protein +FIG00940630 FIG00940631: hypothetical protein +FIG00940631 FIG00940632: hypothetical protein +FIG00940632 FIG00940634: hypothetical protein +FIG00940634 FIG00940636: hypothetical protein +FIG00940637 FIG00940639: hypothetical protein +FIG00940639 FIG00940640: hypothetical protein +FIG00940640 FIG00940645: hypothetical protein +FIG00940649 FIG00940651: hypothetical protein +FIG00940651 FIG00940652: hypothetical protein +FIG00940652 FIG00940653: hypothetical protein +FIG00940653 FIG00940654: hypothetical protein +FIG00940654 FIG00940655: hypothetical protein +FIG00940655 FIG00940656: hypothetical protein +FIG00940656 FIG00940657: hypothetical protein +FIG00940657 FIG00940658: hypothetical protein +FIG00940658 FIG00940660: hypothetical protein +FIG00940660 putative signal peptidase +FIG00940664 FIG00940668: hypothetical protein +FIG00940668 Membrane associated SBC domains +FIG00940669 FIG00940670: hypothetical protein +FIG00940670 FIG00940671: hypothetical protein +FIG00940671 FIG00940674: hypothetical protein +FIG00940674 FIG00940675: hypothetical protein +FIG00940675 FIG00940676: hypothetical protein +FIG00940679 FIG00940681: hypothetical protein +FIG00940681 FIG00940682: hypothetical protein +FIG00940682 FIG00940683: hypothetical protein +FIG00940683 FIG00940685: hypothetical protein +FIG00940685 FIG00940686: hypothetical protein +FIG00940686 FIG00940687: hypothetical protein +FIG00940687 FIG00940691: hypothetical protein +FIG00940691 FIG00940693: hypothetical protein +FIG00940695 FIG00940697: hypothetical protein +FIG00940697 FIG00940698: hypothetical protein +FIG00940698 FIG00940700: hypothetical protein +FIG00940700 FIG00940702: hypothetical protein +FIG00940702 FIG00940703: hypothetical protein +FIG00940703 FIG00940705: hypothetical protein +FIG00940705 FIG00940706: hypothetical protein +FIG00940706 FIG00940708: hypothetical protein +FIG00940708 FIG00940709: hypothetical protein +FIG00940710 possible Helix-turn-helix +FIG00940716 Possible ABC transporter, ATP-binding component +FIG00940717 FIG00940719: hypothetical protein +FIG00940719 DDT domain-containing protein +FIG00940720 FIG00940721: hypothetical protein +FIG00940721 FIG00940724: hypothetical protein +FIG00940724 FIG00940726: hypothetical protein +FIG00940726 putative PURINE PHOSPHORIBOSYLTRANSFERASE related protein +FIG00940728 FIG00940730: hypothetical protein +FIG00940732 FIG00940734: hypothetical protein +FIG00940734 FIG00940737: hypothetical protein +FIG00940737 FIG00940739: hypothetical protein +FIG00940739 FIG00940740: hypothetical protein +FIG00940741 FIG00940744: hypothetical protein +FIG00940744 FIG00940745: hypothetical protein +FIG00940746 possible Beta-lactamase +FIG00940747 FIG00940748: hypothetical protein +FIG00940750 FIG00940753: hypothetical protein +FIG00940753 FIG00940755: hypothetical protein +FIG00940755 FIG00940756: hypothetical protein +FIG00940756 FIG00940758: hypothetical protein +FIG00940758 FIG00940759: hypothetical protein +FIG00940765 FIG00940766: hypothetical protein +FIG00940766 FIG00940767: hypothetical protein +FIG00940767 FIG00940768: hypothetical protein +FIG00940768 FIG00940769: hypothetical protein +FIG00940769 FIG00940770: hypothetical protein +FIG00940770 FIG00940771: hypothetical protein +FIG00940772 FIG00940774: hypothetical protein +FIG00940774 FIG00940776: hypothetical protein +FIG00940776 FIG00940777: hypothetical protein +FIG00940777 FIG00940779: hypothetical protein +FIG00940779 FIG00940782: hypothetical protein +FIG00940782 protein family PM-24 +FIG00940784 FIG00940786: hypothetical protein +FIG00940786 FIG00940788: hypothetical protein +FIG00940788 FIG00940789: hypothetical protein +FIG00940790 possible Adenylate cyclase +FIG00940792 FAD linked oxidase, N-terminal +FIG00940793 FIG00940794: hypothetical protein +FIG00940794 FIG00940796: hypothetical protein +FIG00940796 FIG00940797: hypothetical protein +FIG00940797 FIG00940799: hypothetical protein +FIG00940799 FIG00940800: hypothetical protein +FIG00940801 FIG00940802: hypothetical protein +FIG00940802 FIG00940803: hypothetical protein +FIG00940805 FIG00940810: hypothetical protein +FIG00940810 FIG00940812: hypothetical protein +FIG00940817 FIG00940818: hypothetical protein +FIG00940818 FIG00940819: hypothetical protein +FIG00940819 FIG00940821: hypothetical protein +FIG00940821 FIG00940822: hypothetical protein +FIG00940822 FIG00940823: hypothetical protein +FIG00940823 FIG00940824: hypothetical protein +FIG00940824 FIG00940825: hypothetical protein +FIG00940825 Possible conserved carboxylase domain +FIG00940826 FIG00940827: hypothetical protein +FIG00940827 FIG00940828: hypothetical protein +FIG00940828 Type II secretory pathway, pseudopilin PulG +FIG00940830 FIG00940831: hypothetical protein +FIG00940831 Possible 7kD DNA-binding domain +FIG00940832 FIG00940836: hypothetical protein +FIG00940836 FIG00940837: hypothetical protein +FIG00940837 CsoS1D +FIG00940841 FIG00940844: hypothetical protein +FIG00940844 FIG00940849: hypothetical protein +FIG00940849 FIG00940850: hypothetical protein +FIG00940850 FIG00940850: hypothetical protein +FIG00940855 FIG00940856: hypothetical protein +FIG00940866 FIG00940868: hypothetical protein +FIG00940868 FIG00940869: hypothetical protein +FIG00940869 FIG00940871: hypothetical protein +FIG00940872 FIG00940873: hypothetical protein +FIG00940873 FIG00940874: hypothetical protein +FIG00940874 FIG00940875: hypothetical protein +FIG00940875 FIG00940876: hypothetical protein +FIG00940877 FIG00940880: hypothetical protein +FIG00940880 FIG00940881: hypothetical protein +FIG00940881 FIG00940883: hypothetical protein +FIG00940883 possible Annexin +FIG00940884 FIG00940886: hypothetical protein +FIG00940886 possible Spectrin repeat +FIG00940887 FIG00940888: hypothetical protein +FIG00940888 FIG00940890: hypothetical protein +FIG00940890 FIG00940892: hypothetical protein +FIG00940892 FIG00940893: hypothetical protein +FIG00940893 FIG00940894: hypothetical protein +FIG00940894 Possible NADH-ubiquinone/plastoquinone +FIG00940900 FIG00940902: hypothetical protein +FIG00940902 FIG00940903: hypothetical protein +FIG00940903 FIG00940904: hypothetical protein +FIG00940904 Possible sodium:solute symporter, ESS family +FIG00940906 FIG00940909: hypothetical protein +FIG00940910 FIG00940912: hypothetical protein +FIG00940912 FIG00940914: hypothetical protein +FIG00940914 FIG00940915: hypothetical protein +FIG00940916 FIG00940917: hypothetical protein +FIG00940917 FIG00940919: hypothetical protein +FIG00940925 FIG00940926: hypothetical protein +FIG00940926 FIG00940927: hypothetical protein +FIG00940927 FIG00940928: hypothetical protein +FIG00940929 FIG00940930: hypothetical protein +FIG00940931 FIG00940932: hypothetical protein +FIG00940932 FIG00940933: hypothetical protein +FIG00940933 FIG00940934: hypothetical protein +FIG00940934 FIG00940935: hypothetical protein +FIG00940935 possible Uncharacterized secreted proteins, Ya +FIG00940941 FIG00940942: hypothetical protein +FIG00940942 FIG00940945: hypothetical protein +FIG00940945 FIG00940946: hypothetical protein +FIG00940946 FIG00940947: hypothetical protein +FIG00940947 FIG00940949: hypothetical protein +FIG00940949 possible serine protease +FIG00940950 FIG00940951: hypothetical protein +FIG00940951 FIG00940952: hypothetical protein +FIG00940952 FIG00940954: hypothetical protein +FIG00940954 Peptidyl-prolyl cis-trans isomerase +FIG00940955 FIG00940957: hypothetical protein +FIG00940957 FIG00940960: hypothetical protein +FIG00940960 FIG00940961: hypothetical protein +FIG00940961 FIG00940962: hypothetical protein +FIG00940962 FIG00940963: hypothetical protein +FIG00940963 FIG00940965: hypothetical protein +FIG00940965 FIG00940966: hypothetical protein +FIG00940966 FIG00940967: hypothetical protein +FIG00940968 FIG00940969: hypothetical protein +FIG00940970 FIG00940973: hypothetical protein +FIG00940974 possible DUP family +FIG00940975 FIG00940976: hypothetical protein +FIG00940979 possible Transthyretin precursor (formerly preal +FIG00940981 FIG00940982: hypothetical protein +FIG00940982 FIG00940985: hypothetical protein +FIG00940985 FIG00940986: hypothetical protein +FIG00940986 FIG00940987: hypothetical protein +FIG00940987 FIG00940989: hypothetical protein +FIG00940989 FIG00940990: hypothetical protein +FIG00940990 FIG00940991: hypothetical protein +FIG00940991 FIG00940992: hypothetical protein +FIG00940992 FIG00940993: hypothetical protein +FIG00940993 FIG00940995: hypothetical protein +FIG00940998 FIG00940999: hypothetical protein +FIG00940999 FIG00941001: hypothetical protein +FIG00941001 FIG00941003: hypothetical protein +FIG00941003 FIG00941006: hypothetical protein +FIG00941006 possible Peptidase family M20/M25/M40 +FIG00941007 FIG00941009: hypothetical protein +FIG00941012 FIG00941013: hypothetical protein +FIG00941013 FIG00941014: hypothetical protein +FIG00941014 FIG00941015: hypothetical protein +FIG00941015 FIG00941018: hypothetical protein +FIG00941018 FIG00941019: hypothetical protein +FIG00941019 FIG00941020: hypothetical protein +FIG00941023 FIG00941024: hypothetical protein +FIG00941024 FIG00941025: hypothetical protein +FIG00941025 FIG00941026: hypothetical protein +FIG00941026 FIG00941027: hypothetical protein +FIG00941031 FIG00941032: hypothetical protein +FIG00941034 FIG00941035: hypothetical protein +FIG00941035 FIG00941038: hypothetical protein +FIG00941038 FIG00941040: hypothetical protein +FIG00941042 possible Bacterial regulatory proteins, crp fa +FIG00941044 FIG00941049: hypothetical protein +FIG00941051 possible Serine hydroxymethyltransferase +FIG00941057 FIG00941058: hypothetical protein +FIG00941058 FIG00941059: hypothetical protein +FIG00941059 FIG00941060: hypothetical protein +FIG00941060 FIG00941061: hypothetical protein +FIG00941061 FIG00941062: hypothetical protein +FIG00941066 FIG00941067: hypothetical protein +FIG00941067 FIG00941069: hypothetical protein +FIG00941069 FIG00941072: hypothetical protein +FIG00941076 FIG00941079: hypothetical protein +FIG00941080 FIG00941083: hypothetical protein +FIG00941083 FIG00941084: hypothetical protein +FIG00941084 FIG00941086: hypothetical protein +FIG00941086 FIG00941087: hypothetical protein +FIG00941088 FIG00941090: hypothetical protein +FIG00941090 FIG00941092: hypothetical protein +FIG00941094 FIG00941095: hypothetical protein +FIG00941095 FIG00941096: hypothetical protein +FIG00941096 FIG00941097: hypothetical protein +FIG00941097 possible S1 RNA binding domain-containing protein +FIG00941099 FIG00941101: hypothetical protein +FIG00941101 FIG00941103: hypothetical protein +FIG00941103 FIG00941104: hypothetical protein +FIG00941104 FIG00941109: hypothetical protein +FIG00941110 Low molecular weight phosphotyrosine protein phosphatase +FIG00941113 FIG00941114: hypothetical protein +FIG00941114 FIG00941115: hypothetical protein +FIG00941121 FIG00941123: hypothetical protein +FIG00941123 FIG00941124: hypothetical protein +FIG00941129 possible 4'-phosphopantetheinyl transferase family protein +FIG00941130 Fatty acid desaturase, type 2 +FIG00941131 FIG00941134: hypothetical protein +FIG00941134 possible heat shock protein DnaJ +FIG00941138 FIG00941139: hypothetical protein +FIG00941139 FIG00941143: hypothetical protein +FIG00941143 FIG00941144: hypothetical protein +FIG00941144 FIG00941145: hypothetical protein +FIG00941145 FIG00941146: hypothetical protein +FIG00941146 FIG00941148: hypothetical protein +FIG00941152 FIG00941153: hypothetical protein +FIG00941153 possible protein of unknown function DUF67 +FIG00941156 FIG00941157: hypothetical protein +FIG00941158 FIG00941159: hypothetical protein +FIG00941159 FIG00941160: hypothetical protein +FIG00941163 FIG00941164: hypothetical protein +FIG00941164 FIG00941165: hypothetical protein +FIG00941165 FIG00941167: hypothetical protein +FIG00941167 FIG00941168: hypothetical protein +FIG00941168 Possible transporter, membrane component +FIG00941175 FIG00941176: hypothetical protein +FIG00941176 FIG00941177: hypothetical protein +FIG00941177 possible Carbamoyl-phosphate synthase L chain +FIG00941179 FIG00941180: hypothetical protein +FIG00941180 FIG00941181: hypothetical protein +FIG00941181 FIG00941183: hypothetical protein +FIG00941183 FIG00941184: hypothetical protein +FIG00941185 FIG00941186: hypothetical protein +FIG00941187 FIG00941191: hypothetical protein +FIG00941191 FIG00941193: hypothetical protein +FIG00941193 FIG00941196: hypothetical protein +FIG00941196 FIG00941197: hypothetical protein +FIG00941197 FIG00941198: hypothetical protein +FIG00941198 FIG00941199: hypothetical protein +FIG00941199 FIG00941201: hypothetical protein +FIG00941201 FIG00941203: hypothetical protein +FIG00941203 FIG00941205: hypothetical protein +FIG00941205 FIG00941207: hypothetical protein +FIG00941208 FIG00941210: hypothetical protein +FIG00941210 FIG00941217: hypothetical protein +FIG00941219 FIG00941220: hypothetical protein +FIG00941220 FIG00941221: hypothetical protein +FIG00941221 Predicted protein family PM-5 +FIG00941227 FIG00941228: hypothetical protein +FIG00941228 FIG00941229: hypothetical protein +FIG00941229 FIG00941230: hypothetical protein +FIG00941230 FIG00941231: hypothetical protein +FIG00941232 FIG00941233: hypothetical protein +FIG00941233 FIG00941235: hypothetical protein +FIG00941235 FIG00941237: hypothetical protein +FIG00941237 FIG00941238: hypothetical protein +FIG00941238 possible Copper binding proteins, plastocyanin +FIG00941244 FIG00941245: hypothetical protein +FIG00941248 FIG00941249: hypothetical protein +FIG00941249 Helix-turn-helix protein, CopG family-like +FIG00941251 FIG00941252: hypothetical protein +FIG00941252 FIG00941253: hypothetical protein +FIG00941253 FIG00941256: hypothetical protein +FIG00941257 FIG00941259: hypothetical protein +FIG00941259 Possible porin precursor +FIG00941266 FIG00941268: hypothetical protein +FIG00941272 FIG00941273: hypothetical protein +FIG00941273 FIG00941275: hypothetical protein +FIG00941275 FIG01151690: hypothetical protein +FIG00941277 FIG00941278: hypothetical protein +FIG00941278 Possible cAMP phosphodiesterases class-II precursor +FIG00941281 FIG00941283: hypothetical protein +FIG00941283 FIG00941284: hypothetical protein +FIG00941284 FIG00941285: hypothetical protein +FIG00941285 FIG00941286: hypothetical protein +FIG00941286 FIG00941289: hypothetical protein +FIG00941289 FIG00941290: hypothetical protein +FIG00941290 FIG00941292: hypothetical protein +FIG00941292 FIG00941293: hypothetical protein +FIG00941293 FIG00941294: hypothetical protein +FIG00941295 FIG00941296: hypothetical protein +FIG00941296 FIG00941297: hypothetical protein +FIG00941297 FIG00941298: hypothetical protein +FIG00941299 FIG00941301: hypothetical protein +FIG00941301 FIG00941302: hypothetical protein +FIG00941304 FIG00941305: hypothetical protein +FIG00941305 FIG00941306: hypothetical protein +FIG00941306 FIG00941307: hypothetical protein +FIG00941307 FIG00941308: hypothetical protein +FIG00941308 FIG00941310: hypothetical protein +FIG00941310 FIG00941311: hypothetical protein +FIG00941311 FIG00941312: hypothetical protein +FIG00941312 FIG00941313: hypothetical protein +FIG00941313 Insulinase family (Peptidase family M16) +FIG00941316 FIG00941317: hypothetical protein +FIG00941318 FIG00941319: hypothetical protein +FIG00941325 FIG00941327: hypothetical protein +FIG00941327 Uncharacterised protein family UPF0102 +FIG00941328 FIG00941329: hypothetical protein +FIG00941329 FIG00941330: hypothetical protein +FIG00941330 FIG00941331: hypothetical protein +FIG00941331 FIG00941332: hypothetical protein +FIG00941332 FIG00941336: hypothetical protein +FIG00941336 NAD(P)H-quinone oxidoreductase NdhF subunit, fragment +FIG00941344 FIG00941346: hypothetical protein +FIG00941346 FIG00941349: hypothetical protein +FIG00941350 FIG019731: Sugar transporter +FIG00941351 FIG00941352: hypothetical protein +FIG00941362 FIG00941363: hypothetical protein +FIG00941363 FIG00941364: hypothetical protein +FIG00941364 FIG00941365: hypothetical protein +FIG00941365 FIG00941366: hypothetical protein +FIG00941368 putative Hantavirus glycoprotein G1 +FIG00941369 FIG00941370: hypothetical protein +FIG00941370 Possible reductase +FIG00941371 FIG00941373: hypothetical protein +FIG00941373 possible Fibronectin type I domain +FIG00941375 FIG00941379: hypothetical protein +FIG00941381 FIG00941382: hypothetical protein +FIG00941382 FIG00941384: hypothetical protein +FIG00941384 Metal-binding cluster containing protein +FIG00941388 Domain of unknown function DUF1537 +FIG00941390 FIG00941391: hypothetical protein +FIG00941392 FIG00941393: hypothetical protein +FIG00941393 FIG00941394: hypothetical protein +FIG00941394 FIG00941396: hypothetical protein +FIG00941401 FIG00941402: hypothetical protein +FIG00941402 FIG00941403: hypothetical protein +FIG00941403 protein family PM-1 +FIG00941406 FIG00941407: hypothetical protein +FIG00941407 FIG00941408: hypothetical protein +FIG00941408 FIG00941409: hypothetical protein +FIG00941411 FIG00941413: hypothetical protein +FIG00941413 FIG00941415: hypothetical protein +FIG00941415 FIG00941416: hypothetical protein +FIG00941416 FIG00941418: hypothetical protein +FIG00941418 FIG00941419: hypothetical protein +FIG00941419 FIG00941423: hypothetical protein +FIG00941423 FIG00941425: hypothetical protein +FIG00941430 FIG00941432: hypothetical protein +FIG00941432 FIG00941436: hypothetical protein +FIG00941436 FIG00941437: hypothetical protein +FIG00941437 FIG00941443: hypothetical protein +FIG00941443 FIG00941444: hypothetical protein +FIG00941444 FIG00941445: hypothetical protein +FIG00941445 FIG00941446: hypothetical protein +FIG00941449 FIG00941450: hypothetical protein +FIG00941450 FIG00941452: hypothetical protein +FIG00941454 FIG00941457: hypothetical protein +FIG00941457 FIG00941458: hypothetical protein +FIG00941458 possible TIR domain +FIG00941459 possible copper binding proteins, plastocyanin +FIG00941463 FIG00941464: hypothetical protein +FIG00941467 FIG00941469: hypothetical protein +FIG00941469 FIG00941471: hypothetical protein +FIG00941471 FIG00941473: hypothetical protein +FIG00941473 FIG00941478: hypothetical protein +FIG00941478 FIG00941479: hypothetical protein +FIG00941479 polysaccharide export-related periplasmic protein +FIG00941482 FIG00941483: hypothetical protein +FIG00941483 FIG00941484: hypothetical protein +FIG00941484 FIG00941485: hypothetical protein +FIG00941487 FIG00941489: hypothetical protein +FIG00941489 FIG00941490: hypothetical protein +FIG00941490 FIG00941493: hypothetical protein +FIG00941498 FIG00941500: hypothetical protein +FIG00941500 FIG00941501: hypothetical protein +FIG00941501 FIG00941503: hypothetical protein +FIG00941504 FIG00941506: hypothetical protein +FIG00941506 Possible Fe-S oxidoreductase +FIG00941511 FIG00941514: hypothetical protein +FIG00941514 possible AIR synthase related protein, C-termi +FIG00941516 FIG00941517: hypothetical protein +FIG00941518 FIG00941520: hypothetical protein +FIG00941526 FIG00941527: hypothetical protein +FIG00941527 FIG00941528: hypothetical protein +FIG00941529 FIG00941530: hypothetical protein +FIG00941530 FIG00941533: hypothetical protein +FIG00941536 FIG00941538: hypothetical protein +FIG00941538 FIG00941539: hypothetical protein +FIG00941539 FIG00941540: hypothetical protein +FIG00941540 FIG00941542: hypothetical protein +FIG00941544 FIG00941545: hypothetical protein +FIG00941545 FIG00941546: hypothetical protein +FIG00941554 FIG00941555: hypothetical protein +FIG00941557 possible Phosphofructokinase +FIG00941563 FIG00941564: hypothetical protein +FIG00941564 FIG00941567: hypothetical protein +FIG00941570 conserved hypothetical protein (ORFG Synechococcus sp.) +FIG00941572 FIG00941574: hypothetical protein +FIG00941575 FIG00941577: hypothetical protein +FIG00941577 FIG00941579: hypothetical protein +FIG00941579 FIG00941583: hypothetical protein +FIG00941583 FIG00941585: hypothetical protein +FIG00941585 Possible DDT domain +FIG00941593 Possible MATH domain +FIG00941596 FIG00941597: hypothetical protein +FIG00941597 FIG00941601: hypothetical protein +FIG00941601 Glucosyl-3-phosphoglycerate phosphatase (EC 3.1.3.85) @ Mannosyl-3-phosphoglycerate phosphatase (EC 3.1.3.70) +FIG00941603 FIG00941605: hypothetical protein +FIG00941605 FIG00941606: hypothetical protein +FIG00941606 FIG00941607: hypothetical protein +FIG00941607 FIG00941608: hypothetical protein +FIG00941609 FIG00941610: hypothetical protein +FIG00941610 FIG00941611: hypothetical protein +FIG00941611 possible Transcription factor TFIID (or TATA-b +FIG00941612 FIG00941613: hypothetical protein +FIG00941613 FIG00941614: hypothetical protein +FIG00941614 FIG00941615: hypothetical protein +FIG00941616 FIG00941617: hypothetical protein +FIG00941618 FIG00941621: hypothetical protein +FIG00941623 FIG00941624: hypothetical protein +FIG00941624 FIG00941625: hypothetical protein +FIG00941625 FIG00941626: hypothetical protein +FIG00941626 FIG00941629: hypothetical protein +FIG00941629 FIG00941631: hypothetical protein +FIG00941633 FIG00941634: hypothetical protein +FIG00941634 FIG00941637: hypothetical protein +FIG00941638 FIG00941639: hypothetical protein +FIG00941639 FIG00941640: hypothetical protein +FIG00941640 FIG00941641: hypothetical protein +FIG00941643 FIG00941644: hypothetical protein +FIG00941644 FIG00941645: hypothetical protein +FIG00941645 FIG00941646: hypothetical protein +FIG00941646 FIG00941647: hypothetical protein +FIG00941647 FIG00941649: hypothetical protein +FIG00941649 FIG00941650: hypothetical protein +FIG00941650 FIG00941651: hypothetical protein +FIG00941655 FIG00941656: hypothetical protein +FIG00941656 FIG00941657: hypothetical protein +FIG00941657 FIG00941658: hypothetical protein +FIG00941658 FIG00941659: hypothetical protein +FIG00941659 FIG00941660: hypothetical protein +FIG00941660 FIG00941665: hypothetical protein +FIG00941666 FIG00941667: hypothetical protein +FIG00941667 FIG00941668: hypothetical protein +FIG00941675 FIG00941676: hypothetical protein +FIG00941679 NUDIX family protein +FIG00941683 FIG00941684: hypothetical protein +FIG00941687 FIG00941688: hypothetical protein +FIG00941695 FIG00941696: hypothetical protein +FIG00941696 FIG00941698: hypothetical protein +FIG00941698 Small mechanosensitive ion channel, MscS family +FIG00941699 FIG00941701: hypothetical protein +FIG00941701 FIG00941705: hypothetical protein +FIG00941708 FIG00941709: hypothetical protein +FIG00941709 Possible Lipoprotein precursor +FIG00941710 FIG00941711: hypothetical protein +FIG00941711 FIG00941713: hypothetical protein +FIG00941713 possible LysM domain +FIG00941714 FIG00941715: hypothetical protein +FIG00941715 FIG00941719: hypothetical protein +FIG00941719 FIG00941720: hypothetical protein +FIG00941720 FIG00941721: hypothetical protein +FIG00941721 16S rRNA pseudouridylate synthase +FIG00941725 High light inducible protein hli8 +FIG00941726 FIG00941728: hypothetical protein +FIG00941728 possible Kinesin motor domain +FIG00941729 FIG00941730: hypothetical protein +FIG00941730 FIG00941731: hypothetical protein +FIG00941731 FIG00941734: hypothetical protein +FIG00941734 FIG00941736: hypothetical protein +FIG00941736 DedA family protein, putative +FIG00941737 FIG00941739: hypothetical protein +FIG00941739 possible amidase enhancer +FIG00941740 FIG00941742: hypothetical protein +FIG00941742 Zn-ribbon protein +FIG00941744 FIG00941746: hypothetical protein +FIG00941746 FIG00941748: hypothetical protein +FIG00941751 FIG00941753: hypothetical protein +FIG00941753 FIG00941755: hypothetical protein +FIG00941755 FIG00941758: hypothetical protein +FIG00941763 FIG00941765: hypothetical protein +FIG00941766 FIG00941767: hypothetical protein +FIG00941771 FIG00941772: hypothetical protein +FIG00941772 possible Hantavirus glycoprotein G2 +FIG00941774 FIG00941775: hypothetical protein +FIG00941776 possible Peptidase family M1 +FIG00941778 FIG00941782: hypothetical protein +FIG00941782 FIG00941784: hypothetical protein +FIG00941784 FIG00941785: hypothetical protein +FIG00941790 FIG00941791: hypothetical protein +FIG00941791 FIG00941792: hypothetical protein +FIG00941792 FIG00941793: hypothetical protein +FIG00941793 FIG00941798: hypothetical protein +FIG00941798 FIG00941800: hypothetical protein +FIG00941801 FIG00941803: hypothetical protein +FIG00941803 FIG00941805: hypothetical protein +FIG00941805 FIG00941806: hypothetical protein +FIG00941806 FIG00941808: hypothetical protein +FIG00941809 FIG00941811: hypothetical protein +FIG00941812 FIG00941814: hypothetical protein +FIG00941814 FIG00941815: hypothetical protein +FIG00941815 FIG00941816: hypothetical protein +FIG00941816 FIG00941817: hypothetical protein +FIG00941817 FIG00941818: hypothetical protein +FIG00941818 FIG00941819: hypothetical protein +FIG00941821 FIG00941822: hypothetical protein +FIG00941822 FIG00941825: hypothetical protein +FIG00941825 FIG00941826: hypothetical protein +FIG00941827 FIG00941828: hypothetical protein +FIG00941829 FIG00941830: hypothetical protein +FIG00941830 FIG00941832: hypothetical protein +FIG00941832 FIG00941834: hypothetical protein +FIG00941834 FIG00941836: hypothetical protein +FIG00941836 FIG00941837: hypothetical protein +FIG00941837 FIG00941839: hypothetical protein +FIG00941839 FIG00941841: hypothetical protein +FIG00941846 FIG00941847: hypothetical protein +FIG00941847 FIG00941851: hypothetical protein +FIG00941853 FIG00941860: hypothetical protein +FIG00941860 FIG00941861: hypothetical protein +FIG00941861 FIG00941862: hypothetical protein +FIG00941864 Possible Protein phosphatase 2C precursor +FIG00941867 FIG00941868: hypothetical protein +FIG00941868 FIG00941870: hypothetical protein +FIG00941870 FIG00941872: hypothetical protein +FIG00941872 FIG00941874: hypothetical protein +FIG00941877 FIG00941879: hypothetical protein +FIG00941881 hypothetical protein +FIG00941883 FIG00941885: hypothetical protein +FIG00941885 FIG00941893: hypothetical protein +FIG00941893 FIG00941900: hypothetical protein +FIG00941900 FIG00941903: hypothetical protein +FIG00941903 FIG00941905: hypothetical protein +FIG00941914 FIG00941915: hypothetical protein +FIG00941915 FIG00941916: hypothetical protein +FIG00941917 FIG00941919: hypothetical protein +FIG00941920 probable periplasmic protein +FIG00941921 FIG00941922: hypothetical protein +FIG00941922 FIG00941923: hypothetical protein +FIG00941923 Possible Pollen allergen +FIG00941925 FIG00941927: hypothetical protein +FIG00941927 FIG00941931: hypothetical protein +FIG00941931 FIG00941933: hypothetical protein +FIG00941933 Possible POLO box duplicated region +FIG00941934 FIG00941935: hypothetical protein +FIG00941935 FIG00941936: hypothetical protein +FIG00941936 FIG00941938: hypothetical protein +FIG00941942 FIG00941943: hypothetical protein +FIG00941945 FIG00941947: hypothetical protein +FIG00941947 possible Vinculin family +FIG00941949 FIG00941953: hypothetical protein +FIG00941953 FIG00941954: hypothetical protein +FIG00941954 FIG00941955: hypothetical protein +FIG00941955 FIG00941959: hypothetical protein +FIG00941959 FIG00941960: hypothetical protein +FIG00941960 FIG00941961: hypothetical protein +FIG00941961 FIG00941963: hypothetical protein +FIG00941963 FIG00941964: hypothetical protein +FIG00941965 FIG00941967: hypothetical protein +FIG00941967 FIG00941974: hypothetical protein +FIG00941974 FIG00941977: hypothetical protein +FIG00941977 FIG00941978: hypothetical protein +FIG00941978 FIG00941980: hypothetical protein +FIG00941980 FIG00941981: hypothetical protein +FIG00941981 FIG00941982: hypothetical protein +FIG00941986 FIG00941987: hypothetical protein +FIG00941987 FIG00941988: hypothetical protein +FIG00941988 FIG00941992: hypothetical protein +FIG00941992 SAM-dependent methyltransferase sll0829 (UbiE paralog) +FIG00941994 FIG00941997: hypothetical protein +FIG00941997 FIG00941999: hypothetical protein +FIG00942003 FIG00942004: hypothetical protein +FIG00942007 FIG00942010: hypothetical protein +FIG00942012 FIG00942013: hypothetical protein +FIG00942013 FIG00942017: hypothetical protein +FIG00942017 FIG00942018: hypothetical protein +FIG00942018 FIG00942019: hypothetical protein +FIG00942019 FIG00942020: hypothetical protein +FIG00942020 FIG00942021: hypothetical protein +FIG00942022 FIG00942023: hypothetical protein +FIG00942023 hypothetical protein +FIG00942029 FIG00942030: hypothetical protein +FIG00942030 FIG00942032: hypothetical protein +FIG00942034 FIG00942035: hypothetical protein +FIG00942037 FIG00942038: hypothetical protein +FIG00942038 FIG00942040: hypothetical protein +FIG00942040 FIG00942041: hypothetical protein +FIG00942041 Possible N-acetylmuramoyl-L-alanine amidase +FIG00942045 FIG00942046: hypothetical protein +FIG00942048 FIG00942054: hypothetical protein +FIG00942054 FIG00942056: hypothetical protein +FIG00942056 FIG00942057: hypothetical protein +FIG00942057 putative site-specific integrase/recombinase +FIG00942058 FIG00942060: hypothetical protein +FIG00942060 FIG00942061: hypothetical protein +FIG00942061 FIG00942067: hypothetical protein +FIG00942067 FIG00942068: hypothetical protein +FIG00942068 FIG00942069: hypothetical protein +FIG00942069 FIG00942070: hypothetical protein +FIG00942070 FIG00942072: hypothetical protein +FIG00942072 FIG00942075: hypothetical protein +FIG00942075 FIG00942078: hypothetical protein +FIG00942078 FIG00942080: hypothetical protein +FIG00942080 FIG00942081: hypothetical protein +FIG00942081 FIG00942083: hypothetical protein +FIG00942083 FIG00942087: hypothetical protein +FIG00942087 FIG00942089: hypothetical protein +FIG00942089 FIG00942090: hypothetical protein +FIG00942090 FIG00942095: hypothetical protein +FIG00942095 FIG00942096: hypothetical protein +FIG00942096 FIG00942098: hypothetical protein +FIG00942100 Possible helix-turn-helix protein, CopG family +FIG00942105 possible LEM domain +FIG00942107 possible Ribosomal L29e protein family +FIG00942115 FIG00942116: hypothetical protein +FIG00942118 FIG00942120: hypothetical protein +FIG00942121 FIG00942122: hypothetical protein +FIG00942122 Glutaredoxin-like domain/phycoerythrin related domain fusion +FIG00942124 FIG00942125: hypothetical protein +FIG00942125 FIG00942127: hypothetical protein +FIG00942127 FIG00942132: hypothetical protein +FIG00942132 FIG00942133: hypothetical protein +FIG00942133 FIG00942135: hypothetical protein +FIG00942135 FIG00942137: hypothetical protein +FIG00942137 FIG00942139: hypothetical protein +FIG00942139 FIG00942141: hypothetical protein +FIG00942141 FIG00942144: hypothetical protein +FIG00942145 FIG00942147: hypothetical protein +FIG00942147 FIG00942148: hypothetical protein +FIG00942153 FIG00942155: hypothetical protein +FIG00942157 FIG00942162: hypothetical protein +FIG00942165 FIG00942178: hypothetical protein +FIG00942184 FIG00942185: hypothetical protein +FIG00942185 FIG00942190: hypothetical protein +FIG00942190 FIG00942191: hypothetical protein +FIG00942191 FIG00942196: hypothetical protein +FIG00942197 FIG00942199: hypothetical protein +FIG00942199 FIG00942202: hypothetical protein +FIG00942205 FIG00942206: hypothetical protein +FIG00942206 FIG00942212: hypothetical protein +FIG00942213 FIG00942219: hypothetical protein +FIG00942219 FIG00942220: hypothetical protein +FIG00942220 FIG00942222: hypothetical protein +FIG00942225 FIG00942226: hypothetical protein +FIG00942226 FIG00942228: hypothetical protein +FIG00942228 possible Heat-labile enterotoxin alpha chain +FIG00942231 FIG00942232: hypothetical protein +FIG00942232 FIG00942234: hypothetical protein +FIG00942234 FIG00942235: hypothetical protein +FIG00942235 FIG00942236: hypothetical protein +FIG00942236 FIG00942237: hypothetical protein +FIG00942242 Short-chain dehydrogenase/reductase (SDR) superfamily:Glucose... +FIG00942243 FIG00942244: hypothetical protein +FIG00942244 FIG00942245: hypothetical protein +FIG00942246 FIG00942247: hypothetical protein +FIG00942247 FIG00942248: hypothetical protein +FIG00942249 FIG00942252: hypothetical protein +FIG00942252 FIG00942256: hypothetical protein +FIG00942257 FIG00942258: hypothetical protein +FIG00942258 FIG00942263: hypothetical protein +FIG00942270 FIG00942271: hypothetical protein +FIG00942274 FIG00942275: hypothetical protein +FIG00942275 FIG00942276: hypothetical protein +FIG00942276 FIG00942279: hypothetical protein +FIG00942280 FIG00942282: hypothetical protein +FIG00942282 putative ATP-dependent Clp protease, Hsp 100, ATP-binding subunit ClpB +FIG00942286 FIG00942287: hypothetical protein +FIG00942287 FIG00942289: hypothetical protein +FIG00942289 FIG00942291: hypothetical protein +FIG00942291 FIG00942292: hypothetical protein +FIG00942292 FIG00942293: hypothetical protein +FIG00942293 FIG00942296: hypothetical protein +FIG00942296 possible Dockerin type I repeat +FIG00942298 FIG00942299: hypothetical protein +FIG00942299 FIG00942300: hypothetical protein +FIG00942304 FIG00942306: hypothetical protein +FIG00942306 FIG00942307: hypothetical protein +FIG00942307 FIG00942308: hypothetical protein +FIG00942308 FIG00942309: hypothetical protein +FIG00942309 FIG00942310: hypothetical protein +FIG00942310 FIG00942315: hypothetical protein +FIG00942316 FIG00942317: hypothetical protein +FIG00942317 FIG00942322: hypothetical protein +FIG00942323 FIG00942324: hypothetical protein +FIG00942325 FIG00942327: hypothetical protein +FIG00942328 FIG00942330: hypothetical protein +FIG00942330 FIG00942331: hypothetical protein +FIG00942331 FIG00942332: hypothetical protein +FIG00942332 FIG00942333: hypothetical protein +FIG00942333 FIG00942340: hypothetical protein +FIG00942340 FIG00942343: hypothetical protein +FIG00942344 FIG00942349: hypothetical protein +FIG00942349 FIG00942353: hypothetical protein +FIG00942353 FIG00942354: hypothetical protein +FIG00942354 FIG00942356: hypothetical protein +FIG00942356 FIG00942357: hypothetical protein +FIG00942357 FIG00942359: hypothetical protein +FIG00942359 FIG00942360: hypothetical protein +FIG00942360 FIG00942362: hypothetical protein +FIG00942380 FIG00942381: hypothetical protein +FIG00942381 FIG00942382: hypothetical protein +FIG00942382 FIG00942384: hypothetical protein +FIG00942387 possible Fusion glycoprotein F0 +FIG00942389 FIG00942390: hypothetical protein +FIG00942390 FIG00942398: hypothetical protein +FIG00942399 FIG00942400: hypothetical protein +FIG00942400 FIG00942403: hypothetical protein +FIG00942403 FIG00942405: hypothetical protein +FIG00942405 FIG00942406: hypothetical protein +FIG00942406 FIG00942407: hypothetical protein +FIG00942408 FIG00942411: hypothetical protein +FIG00942411 FIG00942412: hypothetical protein +FIG00942412 FIG00942414: hypothetical protein +FIG00942414 FIG00942416: hypothetical protein +FIG00942420 FIG00942424: hypothetical protein +FIG00942424 FIG00942425: hypothetical protein +FIG00942425 FIG01153218: hypothetical protein +FIG00942431 FIG00942432: hypothetical protein +FIG00942432 FIG00942435: hypothetical protein +FIG00942438 FIG00942441: hypothetical protein +FIG00942441 FIG00942442: hypothetical protein +FIG00942444 FIG00942445: hypothetical protein +FIG00942445 Phosphonate dehydrogenase (EC 1.20.1.1) (NAD-dependent phosphite dehydrogenase) +FIG00942452 FIG00942454: hypothetical protein +FIG00942454 FIG00942456: hypothetical protein +FIG00942456 FIG00942457: hypothetical protein +FIG00942457 FIG00942460: hypothetical protein +FIG00942461 protein family PM-12 +FIG00942465 FIG00942471: hypothetical protein +FIG00942471 FIG00942472: hypothetical protein +FIG00942476 FIG00942482: hypothetical protein +FIG00942482 FIG00942484: hypothetical protein +FIG00942484 FIG00942486: hypothetical protein +FIG00942487 FIG00942488: hypothetical protein +FIG00942490 FIG00942491: hypothetical protein +FIG00942491 FIG00942492: hypothetical protein +FIG00942492 FIG00942495: hypothetical protein +FIG00942495 FIG00942498: hypothetical protein +FIG00942498 possible chorismate binding enzyme +FIG00942503 FIG00942513: hypothetical protein +FIG00942513 NADPH-dependent reductase +FIG00942518 FIG00942519: hypothetical protein +FIG00942527 FIG00942530: hypothetical protein +FIG00942530 FIG00942532: hypothetical protein +FIG00942538 FIG00942539: hypothetical protein +FIG00942539 FIG00942542: hypothetical protein +FIG00942542 hypothetical protein +FIG00942554 FIG00942555: hypothetical protein +FIG00942558 FIG00942559: hypothetical protein +FIG00942564 possible Myosin N-terminal SH3-like domain +FIG00942570 FIG00942572: hypothetical protein +FIG00942576 FIG00942577: hypothetical protein +FIG00942577 FIG00942578: hypothetical protein +FIG00942578 FIG00942579: hypothetical protein +FIG00942579 FIG00942580: hypothetical protein +FIG00942587 FIG00942589: hypothetical protein +FIG00942589 FIG00942590: hypothetical protein +FIG00942590 FIG00942591: hypothetical protein +FIG00942594 FIG00942595: hypothetical protein +FIG00942595 FIG00942596: hypothetical protein +FIG00942596 FIG00942597: hypothetical protein +FIG00942601 FIG00942602: hypothetical protein +FIG00942603 FIG00942605: hypothetical protein +FIG00942605 FIG00942606: hypothetical protein +FIG00942607 FIG00942612: hypothetical protein +FIG00942612 FIG00942613: hypothetical protein +FIG00942613 FIG00942614: hypothetical protein +FIG00942617 FIG00942618: hypothetical protein +FIG00942618 FIG00942619: hypothetical protein +FIG00942625 FIG00942626: hypothetical protein +FIG00942626 FIG00942628: hypothetical protein +FIG00942628 FIG00942629: hypothetical protein +FIG00942629 FIG00942630: hypothetical protein +FIG00942632 FIG00942636: hypothetical protein +FIG00942636 FIG00942639: hypothetical protein +FIG00942639 FIG00942641: hypothetical protein +FIG00942641 FIG00942643: hypothetical protein +FIG00942646 FIG00942650: hypothetical protein +FIG00942651 FIG00942652: hypothetical protein +FIG00942652 FIG00942655: hypothetical protein +FIG00942658 FIG00942659: hypothetical protein +FIG00942659 FIG00942663: hypothetical protein +FIG00942663 FIG00942664: hypothetical protein +FIG00942664 FIG00942665: hypothetical protein +FIG00942675 FIG00942680: hypothetical protein +FIG00942680 FIG00942682: hypothetical protein +FIG00942683 FIG00942684: hypothetical protein +FIG00942691 FIG00942693: hypothetical protein +FIG00942693 FIG00942694: hypothetical protein +FIG00942695 FIG00942696: hypothetical protein +FIG00942699 FIG00942701: hypothetical protein +FIG00942706 FIG00942708: hypothetical protein +FIG00942710 FIG00942712: hypothetical protein +FIG00942712 FIG00942715: hypothetical protein +FIG00942715 FIG00942716: hypothetical protein +FIG00942729 FIG00942731: hypothetical protein +FIG00942731 FIG00942733: hypothetical protein +FIG00942735 FIG00942736: hypothetical protein +FIG00942736 FIG00942739: hypothetical protein +FIG00942739 FIG00942748: hypothetical protein +FIG00942752 FIG00942753: hypothetical protein +FIG00942757 FIG00942759: hypothetical protein +FIG00942759 FIG00942760: hypothetical protein +FIG00942760 FIG00942761: hypothetical protein +FIG00942761 FIG00942767: hypothetical protein +FIG00942775 FIG00942776: hypothetical protein +FIG00942783 FIG00942784: hypothetical protein +FIG00942784 FIG00942785: hypothetical protein +FIG00942789 FIG00942793: hypothetical protein +FIG00942793 FIG00942800: hypothetical protein +FIG00942804 FIG00942805: hypothetical protein +FIG00942809 FIG00942811: hypothetical protein +FIG00942811 FIG00942813: hypothetical protein +FIG00942818 FIG00942822: hypothetical protein +FIG00942822 FIG00942823: hypothetical protein +FIG00942823 FIG00942825: hypothetical protein +FIG00942828 FIG00942830: hypothetical protein +FIG00942830 FIG00942835: hypothetical protein +FIG00942837 FIG00942838: hypothetical protein +FIG00942838 FIG00942841: hypothetical protein +FIG00942841 FIG00942845: hypothetical protein +FIG00942845 FIG00942852: hypothetical protein +FIG00942852 acid phosphatase( EC:3.1.3.2 ) +FIG00942856 FIG00942859: hypothetical protein +FIG00942859 FIG00942863: hypothetical protein +FIG00942863 FIG00942864: hypothetical protein +FIG00942864 FIG00942872: hypothetical protein +FIG00942874 FIG00942881: hypothetical protein +FIG00942881 FIG00942882: hypothetical protein +FIG00942882 FIG00942883: hypothetical protein +FIG00942885 FIG00942887: hypothetical protein +FIG00942890 FIG00942895: hypothetical protein +FIG00942895 possible Gibberellin regulated protein +FIG00942896 FIG00942898: hypothetical protein +FIG00942898 FIG00942899: hypothetical protein +FIG00942900 Predicted protein family PM-19 +FIG00942909 FIG00942912: hypothetical protein +FIG00942912 FIG00942914: hypothetical protein +FIG00942914 FIG00942915: hypothetical protein +FIG00942915 FIG00942917: hypothetical protein +FIG00942917 FIG00942918: hypothetical protein +FIG00942918 FIG00942922: hypothetical protein +FIG00942922 FIG00942924: hypothetical protein +FIG00942924 FIG00942926: hypothetical protein +FIG00942926 FIG00942927: hypothetical protein +FIG00942927 FIG00942931: hypothetical protein +FIG00942935 FIG00942938: hypothetical protein +FIG00942938 FIG00942941: hypothetical protein +FIG00942941 FIG00942944: hypothetical protein +FIG00942944 FIG00942945: hypothetical protein +FIG00942945 FIG00942946: hypothetical protein +FIG00942949 FIG00942950: hypothetical protein +FIG00942950 hypothetical protein +FIG00942954 FIG00942955: hypothetical protein +FIG00942960 possible Inward rectifier potassium channel +FIG00942962 FIG00942963: hypothetical protein +FIG00942963 FIG00942965: hypothetical protein +FIG00942971 FIG00942973: hypothetical protein +FIG00942975 FIG00942977: hypothetical protein +FIG00942977 FIG00942978: hypothetical protein +FIG00942978 FIG00942988: hypothetical protein +FIG00942988 FIG00942990: hypothetical protein +FIG00942990 FIG00942991: hypothetical protein +FIG00942991 Esterase/lipase/thioesterase family active site:Prolyl aminop... +FIG00942993 FIG00942995: hypothetical protein +FIG00942999 Chalcone synthase +FIG00943002 FIG00943005: hypothetical protein +FIG00943005 possible S1 RNA binding domain-containing protein +FIG00943006 FIG00943009: hypothetical protein +FIG00943011 FIG00943014: hypothetical protein +FIG00943015 FIG00943017: hypothetical protein +FIG00943018 FIG00943023: hypothetical protein +FIG00943023 FIG00943025: hypothetical protein +FIG00943025 FIG00943028: hypothetical protein +FIG00943028 protein family PM-14 +FIG00943030 FIG00943031: hypothetical protein +FIG00943032 FIG00943033: hypothetical protein +FIG00943033 FIG00943034: hypothetical protein +FIG00943034 FIG00943036: hypothetical protein +FIG00943036 Type IV pilin PilA +FIG00943041 FIG00943047: hypothetical protein +FIG00943047 FIG00943050: hypothetical protein +FIG00943050 trigger factor +FIG00943057 FIG00943061: hypothetical protein +FIG00943062 FIG00943063: hypothetical protein +FIG00943064 FIG00943066: hypothetical protein +FIG00943066 FIG00942683: hypothetical protein +FIG00943071 FIG00943072: hypothetical protein +FIG00943072 FIG00943073: hypothetical protein +FIG00943073 Porin homolog precursor +FIG00943078 FIG00943080: hypothetical protein +FIG00943083 FIG00943084: hypothetical protein +FIG00943084 FIG00943089: hypothetical protein +FIG00943094 FIG00943095: hypothetical protein +FIG00943095 FIG00943097: hypothetical protein +FIG00943097 FIG00943098: hypothetical protein +FIG00943099 FIG00943100: hypothetical protein +FIG00943105 FIG00943106: hypothetical protein +FIG00943106 N-methyl-L-tryptophan oxidase (EC 1.5.3.-) +FIG00943107 FIG00943108: hypothetical protein +FIG00943110 FIG00943113: hypothetical protein +FIG00943113 FIG00943114: hypothetical protein +FIG00943114 FIG00943115: hypothetical protein +FIG00943122 FIG00943123: hypothetical protein +FIG00943123 FIG00943129: hypothetical protein +FIG00943129 FIG00943131: hypothetical protein +FIG00943131 FIG00943134: hypothetical protein +FIG00943138 FIG00943144: hypothetical protein +FIG00943144 FIG00943146: hypothetical protein +FIG00943146 FIG00943148: hypothetical protein +FIG00943150 FIG00943153: hypothetical protein +FIG00943153 FIG00943156: hypothetical protein +FIG00943157 Possible transporter component +FIG00943158 FIG00943160: hypothetical protein +FIG00943163 FIG00943164: hypothetical protein +FIG00943164 FIG00943168: hypothetical protein +FIG00943168 FIG00943169: hypothetical protein +FIG00943169 FIG00943174: hypothetical protein +FIG00943174 possible Kelch motif +FIG00943185 FIG00943188: hypothetical protein +FIG00943188 FIG00943190: hypothetical protein +FIG00943190 FIG00943194: hypothetical protein +FIG00943198 FIG00943199: hypothetical protein +FIG00943199 FIG00943205: hypothetical protein +FIG00943205 FIG00943206: hypothetical protein +FIG00943206 FIG00943211: hypothetical protein +FIG00943214 FIG00943218: hypothetical protein +FIG00943218 FIG00943220: hypothetical protein +FIG00943220 FIG00943221: hypothetical protein +FIG00943221 FIG00943222: hypothetical protein +FIG00943222 FIG00943225: hypothetical protein +FIG00943225 FIG00943226: hypothetical protein +FIG00943226 GtrC +FIG00943227 FIG00943228: hypothetical protein +FIG00943228 FIG00943230: hypothetical protein +FIG00943230 FIG00943231: hypothetical protein +FIG00943236 FIG00943239: hypothetical protein +FIG00943251 FIG01150135: hypothetical protein +FIG00943253 FIG00943258: hypothetical protein +FIG00943259 FIG00943264: hypothetical protein +FIG00943264 FIG00943266: hypothetical protein +FIG00943266 FIG00943267: hypothetical protein +FIG00943267 FIG00943274: hypothetical protein +FIG00943276 porin homolog +FIG00943278 FIG00943280: hypothetical protein +FIG00943286 FIG00943291: hypothetical protein +FIG00943291 FIG00943299: hypothetical protein +FIG00943299 FIG00943300: hypothetical protein +FIG00943312 FIG00943314: hypothetical protein +FIG00943316 FIG00943318: hypothetical protein +FIG00943318 Predicted protein family PM-12 +FIG00943323 FIG00943325: hypothetical protein +FIG00943328 FIG00943332: hypothetical protein +FIG00943342 FIG00943345: hypothetical protein +FIG00943347 FIG00943349: hypothetical protein +FIG00943349 FIG00943350: hypothetical protein +FIG00943350 FIG00943351: hypothetical protein +FIG00943353 FIG00943355: hypothetical protein +FIG00943355 FIG00943357: hypothetical protein +FIG00943357 FIG00943358: hypothetical protein +FIG00943361 FIG00943362: hypothetical protein +FIG00943365 FIG00943366: hypothetical protein +FIG00943366 FIG00943368: hypothetical protein +FIG00943368 Hypothetical protein, AT1G64980 homolog +FIG00943372 FIG00943374: hypothetical protein +FIG00943378 possible DsrE-like protein +FIG00943381 FIG00943386: hypothetical protein +FIG00943388 FIG00943390: hypothetical protein +FIG00943390 FIG00943396: hypothetical protein +FIG00943401 FIG00943404: hypothetical protein +FIG00943404 possible DNA polymerase III, epsilon subunit( EC:2.7.7.7 ) +FIG00943405 FIG00943406: hypothetical protein +FIG00943406 Similar to ribosomal large subunit pseudouridine synthase D, group RluD11 +FIG00943408 FIG00943414: hypothetical protein +FIG00943414 FIG00943415: hypothetical protein +FIG00943415 FIG00943420: hypothetical protein +FIG00943420 FIG00943423: hypothetical protein +FIG00943424 FIG00943425: hypothetical protein +FIG00943425 Membrane serine protease of rhomboid family +FIG00943429 FIG00943431: hypothetical protein +FIG00943439 FIG00943443: hypothetical protein +FIG00943443 FIG00943445: hypothetical protein +FIG00943445 FIG00943446: hypothetical protein +FIG00943446 FIG00943449: hypothetical protein +FIG00943456 FIG00943460: hypothetical protein +FIG00943460 FIG00943461: hypothetical protein +FIG00943462 FIG00943464: hypothetical protein +FIG00943464 FIG00943465: hypothetical protein +FIG00943469 FIG00943470: hypothetical protein +FIG00943475 FIG00943476: hypothetical protein +FIG00943481 FIG00943487: hypothetical protein +FIG00943487 FIG00943488: hypothetical protein +FIG00943493 FIG00943495: hypothetical protein +FIG00943500 FIG00943501: hypothetical protein +FIG00943504 FIG00943506: hypothetical protein +FIG00943507 FIG00943508: hypothetical protein +FIG00943508 FIG00943509: hypothetical protein +FIG00943513 FIG00943515: hypothetical protein +FIG00943515 FIG00943518: hypothetical protein +FIG00943521 FIG00943525: hypothetical protein +FIG00943526 FIG00943527: hypothetical protein +FIG00943531 FIG00943534: hypothetical protein +FIG00943534 FIG00943535: hypothetical protein +FIG00943535 FIG00943538: hypothetical protein +FIG00943538 FIG00943540: hypothetical protein +FIG00943560 FIG00943564: hypothetical protein +FIG00943564 FIG00943567: hypothetical protein +FIG00943567 FIG01149309: hypothetical protein +FIG00943575 FIG00943576: hypothetical protein +FIG00943576 pyridoxal-phosphate-dependent aminotransferase +FIG00943581 FIG00943582: hypothetical protein +FIG00943582 FIG00943583: hypothetical protein +FIG00943583 FIG00943585: hypothetical protein +FIG00943585 FIG00943589: hypothetical protein +FIG00943589 FIG00943592: hypothetical protein +FIG00943592 possible AEC transporter family +FIG00943596 FIG00943597: hypothetical protein +FIG00943599 FIG00943600: hypothetical protein +FIG00943604 FIG00943610: hypothetical protein +FIG00943612 FIG00943613: hypothetical protein +FIG00943613 FIG00943618: hypothetical protein +FIG00943618 FIG00943624: hypothetical protein +FIG00943624 FIG00943629: hypothetical protein +FIG00943629 FIG00943631: hypothetical protein +FIG00943632 FIG00943635: hypothetical protein +FIG00943635 FIG00943636: hypothetical protein +FIG00943638 FIG00943640: hypothetical protein +FIG00943643 FIG00943645: hypothetical protein +FIG00943645 FIG00943652: hypothetical protein +FIG00943652 FIG00943653: hypothetical protein +FIG00943658 Sulfatase precursor (EC 3.1.6.1) +FIG00943659 FIG00943660: hypothetical protein +FIG00943663 FIG00943665: hypothetical protein +FIG00943667 predicted protein +FIG00943671 FIG00943674: hypothetical protein +FIG00943691 FIG00943694: hypothetical protein +FIG00943696 FIG00943697: hypothetical protein +FIG00943698 FIG00943701: hypothetical protein +FIG00943707 FIG00943708: hypothetical protein +FIG00943718 FIG00943719: hypothetical protein +FIG00943732 FIG00943744: hypothetical protein +FIG00943744 FIG00943747: hypothetical protein +FIG00943747 FIG00943748: hypothetical protein +FIG00943750 FIG00943756: hypothetical protein +FIG00943757 possible Fungal Zn(2)-Cys(6) binuclear cluster +FIG00943758 FIG00943760: hypothetical protein +FIG00943763 FIG00943766: hypothetical protein +FIG00943769 FIG00943770: hypothetical protein +FIG00943772 FIG00943774: hypothetical protein +FIG00943774 FIG00943783: hypothetical protein +FIG00943783 FIG00943785: hypothetical protein +FIG00943789 FIG00943792: hypothetical protein +FIG00943792 FIG00943795: hypothetical protein +FIG00943801 FIG00943804: hypothetical protein +FIG00943804 FIG00943805: hypothetical protein +FIG00943805 FIG00943806: hypothetical protein +FIG00943806 FIG00943809: hypothetical protein +FIG00943811 FIG00943812: hypothetical protein +FIG00943824 FIG00943829: hypothetical protein +FIG00943832 FIG00943836: hypothetical protein +FIG00943836 FIG00943839: hypothetical protein +FIG00943839 Pyrimidine dimer DNA glycosylase +FIG00943841 Possible dihydroflavonol-4-reductase( EC:1.1.1.219 ) +FIG00943859 FIG00943862: hypothetical protein +FIG00943862 FIG00943867: hypothetical protein +FIG00943867 Predicted protein family PM-16 +FIG00943884 FIG00943888: hypothetical protein +FIG00943889 FIG00943890: hypothetical protein +FIG00943890 FIG00943892: hypothetical protein +FIG00943892 FIG00943896: hypothetical protein +FIG00943896 FIG00943899: hypothetical protein +FIG00943901 putative ABC-type polysaccharide/polyol phosphate transport system ATPase component +FIG00943916 FIG00943918: hypothetical protein +FIG00943922 FIG00943923: hypothetical protein +FIG00943923 FIG00943924: hypothetical protein +FIG00943944 FIG00943946: hypothetical protein +FIG00943948 FIG00943952: hypothetical protein +FIG00943959 FIG00943960: hypothetical protein +FIG00943960 FIG00943961: hypothetical protein +FIG00943968 FIG00943974: hypothetical protein +FIG00943974 FIG00943979: hypothetical protein +FIG00943982 FIG00943983: hypothetical protein +FIG00943983 FIG00943988: hypothetical protein +FIG00943990 FIG00943999: hypothetical protein +FIG00944009 FIG00944010: hypothetical protein +FIG00944010 FIG00944011: hypothetical protein +FIG00944011 FIG00944013: hypothetical protein +FIG00944016 FIG00944017: hypothetical protein +FIG00944017 FIG00944018: hypothetical protein +FIG00944018 FIG00944019: hypothetical protein +FIG00944021 FIG00944027: hypothetical protein +FIG00944030 FIG00944032: hypothetical protein +FIG00944036 FIG00944040: hypothetical protein +FIG00944040 FIG00944041: hypothetical protein +FIG00944042 FIG00944045: hypothetical protein +FIG00944048 FIG00944052: hypothetical protein +FIG00944055 FIG00944057: hypothetical protein +FIG00944070 Potassium channel +FIG00944077 FIG00944079: hypothetical protein +FIG00944079 FIG00944081: hypothetical protein +FIG00944081 FIG00944084: hypothetical protein +FIG00944085 FIG00944087: hypothetical protein +FIG00944087 FIG00944093: hypothetical protein +FIG00944093 FIG00944094: hypothetical protein +FIG00944097 FIG00944098: hypothetical protein +FIG00944098 FIG00944100: hypothetical protein +FIG00944112 FIG00944113: hypothetical protein +FIG00944114 FIG00944115: hypothetical protein +FIG00944115 FIG00944118: hypothetical protein +FIG00944118 FIG00944120: hypothetical protein +FIG00944120 FIG00944122: hypothetical protein +FIG00944126 FIG00944127: hypothetical protein +FIG00944127 FIG00944128: hypothetical protein +FIG00944128 FIG00944130: hypothetical protein +FIG00944155 FIG00944164: hypothetical protein +FIG00944166 FIG00944170: hypothetical protein +FIG00944170 FIG00944175: hypothetical protein +FIG00944182 FIG00944183: hypothetical protein +FIG00944183 FIG00944186: hypothetical protein +FIG00944191 FIG00944192: hypothetical protein +FIG00944201 possible high light inducible protein +FIG00944208 FIG00944210: hypothetical protein +FIG00944226 FIG00944228: hypothetical protein +FIG00944258 FIG00944261: hypothetical protein +FIG00944287 FIG00944289: hypothetical protein +FIG00944289 FIG00944299: hypothetical protein +FIG00944300 FIG00944301: hypothetical protein +FIG00944302 Predicted hydrolase, HAD superfamily +FIG00944307 FIG00944309: hypothetical protein +FIG00944317 FIG00944328: hypothetical protein +FIG00944329 FIG00944334: hypothetical protein +FIG00944340 FIG00944343: hypothetical protein +FIG00944352 FIG00944360: hypothetical protein +FIG00944367 FIG00944368: hypothetical protein +FIG00944368 FIG00944376: hypothetical protein +FIG00944392 FIG00944394: hypothetical protein +FIG00944394 FIG00944399: hypothetical protein +FIG00944412 FIG00944414: hypothetical protein +FIG00944414 FIG00944417: hypothetical protein +FIG00944417 FIG00944420: hypothetical protein +FIG00944420 possible NADH-Ubiquinone/plastoquinone +FIG00944429 FIG00944435: hypothetical protein +FIG00944442 FIG00944443: hypothetical protein +FIG00944448 FIG00944450: hypothetical protein +FIG00944453 FIG00944454: hypothetical protein +FIG00944461 Possible Ribosomal protein L36 +FIG00944490 FIG00944491: hypothetical protein +FIG00944492 FIG00944496: hypothetical protein +FIG00944496 FIG00944500: hypothetical protein +FIG00944500 FIG00944501: hypothetical protein +FIG00944501 FIG00944504: hypothetical protein +FIG00944512 FIG00944513: hypothetical protein +FIG00944513 possible Sema domain +FIG00944524 FIG00944531: hypothetical protein +FIG00944537 FIG00944544: hypothetical protein +FIG00944544 FIG00944546: hypothetical protein +FIG00944546 FIG00944547: hypothetical protein +FIG00944548 FIG00944551: hypothetical protein +FIG00944551 FIG00944554: hypothetical protein +FIG00944554 Glycosyltransferase +FIG00944555 FIG00944560: hypothetical protein +FIG00944560 FIG00944562: hypothetical protein +FIG00944566 FIG00944569: hypothetical protein +FIG00944588 FIG00944593: hypothetical protein +FIG00944598 FIG00944602: hypothetical protein +FIG00944609 FIG00944614: hypothetical protein +FIG00944614 FIG00944616: hypothetical protein +FIG00944618 FIG00944623: hypothetical protein +FIG00944628 possible SAP domain +FIG00944637 FIG00944641: hypothetical protein +FIG00944646 FIG00944648: hypothetical protein +FIG00944657 FIG00944664: hypothetical protein +FIG00944665 FIG00944666: hypothetical protein +FIG00944667 FIG00944668: hypothetical protein +FIG00944668 FIG00944670: hypothetical protein +FIG00944670 FIG00944673: hypothetical protein +FIG00944673 manganese/zinc/iron chelate ABC transporter (MZT) family, permease protein +FIG00944675 Staphylococcus nuclease (SNase) homologues +FIG00944690 FIG00944693: hypothetical protein +FIG00944694 FIG00944695: hypothetical protein +FIG00944700 FIG00944703: hypothetical protein +FIG00944706 Methyltransferase (EC 2.1.1.-), possibly involved in O-methyl phosphoramidate capsule modification +FIG00944708 FIG00944709: hypothetical protein +FIG00944717 FIG00944719: hypothetical protein +FIG00944734 high light inducible protein hli11 +FIG00944746 FIG00944748: hypothetical protein +FIG00944769 FIG00944778: hypothetical protein +FIG00944791 FIG00944792: hypothetical protein +FIG00944792 DNA double-strand break repair Rad50 ATPase +FIG00944796 FIG00944799: hypothetical protein +FIG00944799 FIG00944801: hypothetical protein +FIG00944801 FIG00944807: hypothetical protein +FIG00944830 FIG00944833: hypothetical protein +FIG00944836 FIG00944855: hypothetical protein +FIG00944874 FIG00944881: hypothetical protein +FIG00944888 Acid phosphatase( EC:3.1.3.2 ) +FIG00944904 Predicted protein family PM-27 +FIG00944907 FIG00944908: hypothetical protein +FIG00944909 PTS cellobiose-specific component IIA +FIG00944911 FIG00944912: hypothetical protein +FIG00944917 FIG00944919: hypothetical protein +FIG00944919 FIG00944921: hypothetical protein +FIG00944921 FIG00944922: hypothetical protein +FIG00944926 FIG00945952: hypothetical protein +FIG00944929 FIG00944930: hypothetical protein +FIG00944930 lipase/esterase +FIG00944931 ABC transporter-associated permease +FIG00944933 FIG00944934: hypothetical protein +FIG00944934 bifunctional protein (ATP/GTP binding protein/MutT-like) +FIG00944935 8-amino-7-oxononanoate synthase( EC:2.3.1.47 ) +FIG00944938 FIG00944939: hypothetical protein +FIG00944939 FIG00944940: hypothetical protein +FIG00944942 FIG00944943: hypothetical protein +FIG00944943 FIG00944945: hypothetical protein +FIG00944945 FIG00944946: hypothetical protein +FIG00944946 conserved protein, putative metallo-beta-lactamase +FIG00944947 protease +FIG00944951 FIG00944953: hypothetical protein +FIG00944953 extracellular solute-binding transport protein, putative oligopeptide-binding protein +FIG00944958 FIG00944959: hypothetical protein +FIG00944961 conserved membrane spanning protein +FIG00944962 FIG00944964: hypothetical protein +FIG00944964 FIG00944965: hypothetical protein +FIG00944965 FIG00944966: hypothetical protein +FIG00944966 FIG00944967: hypothetical protein +FIG00944967 FIG00944968: hypothetical protein +FIG00944968 FIG00944971: hypothetical protein +FIG00944973 putative MarR-family transcriptional regulator +FIG00944976 FIG00944977: hypothetical protein +FIG00944977 FIG00944979: hypothetical protein +FIG00944979 FIG00944980: hypothetical protein +FIG00944980 FIG00944983: hypothetical protein +FIG00944983 FIG00944984: hypothetical protein +FIG00944984 FIG00944986: hypothetical protein +FIG00944987 hypothetical protein, RDD family +FIG00944988 FIG00944990: hypothetical protein +FIG00944990 UDP-N-acetyl-D-mannosaminuronic acid dehydrogenase +FIG00944991 FIG01121526: hypothetical protein +FIG00944993 FIG00944994: hypothetical protein +FIG00944994 COG0628: Predicted permease +FIG00944997 FIG00944998: hypothetical protein +FIG00944998 FIG00945002: hypothetical protein +FIG00945003 FIG00945004: hypothetical protein +FIG00945006 FIG00945007: hypothetical protein +FIG00945010 two component system response regulator +FIG00945012 4-hydroxybutyrate coenzyme A transferase +FIG00945013 FIG00945015: hypothetical protein +FIG00945015 FIG00945017: hypothetical protein +FIG00945017 siderophore-interacting protein +FIG00945018 hypothetical membane-associated protein +FIG00945021 NLP/P60-family secreted protein +FIG00945022 ComE operon protein 1 +FIG00945026 FIG00945029: hypothetical protein +FIG00945029 FIG00945030: hypothetical protein +FIG00945030 RfbX family protein involved in the export of O-antigen and teichoic acid +FIG00945032 conserved protein, putative acyltransferase +FIG00945034 FIG00945035: hypothetical protein +FIG00945037 putative helicase protein +FIG00945039 ATP-binding protein Irp6C +FIG00945042 FIG00945043: hypothetical protein +FIG00945043 citrate lyase beta chain +FIG00945045 FIG00945046: hypothetical protein +FIG00945046 FIG00821051: hypothetical protein +FIG00945049 hypothetical protein +FIG00945050 FIG01125565: hypothetical protein +FIG00945053 similar to Zn-dependent hydrolases of the beta-lactamase fold +FIG00945054 conserved protein (aldose 1-epimerase family protein) +FIG00945062 FIG00945063: hypothetical protein +FIG00945063 FIG00945065: hypothetical protein +FIG00945065 FIG00945066: hypothetical protein +FIG00945066 FIG00945068: hypothetical protein +FIG00945069 FIG00945070: hypothetical protein +FIG00945071 FIG00945072: hypothetical protein +FIG00945072 conserved protein, putative hydrolase +FIG00945075 FIG00945076: hypothetical protein +FIG00945078 acetyltransferase( EC:2.3.1.- ) +FIG00945079 FIG00945080: hypothetical protein +FIG00945080 FIG00945082: hypothetical protein +FIG00945082 FIG00945082: possible membrane protein +FIG00945084 FIG00945086: hypothetical protein +FIG00945086 FIG00945087: hypothetical protein +FIG00945087 FIG00945088: hypothetical protein +FIG00945088 FIG00945090: hypothetical protein +FIG00945090 FIG00945091: hypothetical protein +FIG00945091 conserved protein, putative sugar binding protein +FIG00945092 beta-galactosidase fused to beta-N-acetylhexosaminidase +FIG00945093 FIG00945094: hypothetical protein +FIG00945095 FIG00945096: hypothetical protein +FIG00945098 FIG00945099: hypothetical protein +FIG00945103 FIG00945105: hypothetical protein +FIG00945106 FIG00945107: hypothetical protein +FIG00945107 LacI-family transcriptional regulator +FIG00945108 putative glycosyl hydrolase +FIG00945111 conserved protein, putative BatA (bacteroides aerotolerance operon) +FIG00945114 FIG00945116: hypothetical protein +FIG00945116 FIG00945117: hypothetical protein +FIG00945117 translocase subunit +FIG00945118 FIG00945119: hypothetical protein +FIG00945121 FIG00945122: hypothetical protein +FIG00945122 FIG00945123: hypothetical protein +FIG00945125 FIG00945126: hypothetical protein +FIG00945126 FIG00945127: hypothetical protein +FIG00945127 COG1528: Ferritin-like protein +FIG00945129 FIG00945130: hypothetical protein +FIG00945131 FIG00945133: hypothetical protein +FIG00945133 FIG00945134: hypothetical protein +FIG00945135 Putative phosphotransferase system protein +FIG00945136 Protein-L-isoaspartate methyltransferase (EC 2.1.1.77) +FIG00945138 FIG00945139: hypothetical protein +FIG00945143 FIG00945144: hypothetical protein +FIG00945144 alpha/beta hydrolase fold +FIG00945146 hypothetical protein, putative carotenoid dehydrogenase +FIG00945149 FIG00945150: hypothetical protein +FIG00945152 FIG00945154: hypothetical protein +FIG00945154 FIG00945155: hypothetical protein +FIG00945157 FIG00945158: hypothetical protein +FIG00945160 FIG00945161: hypothetical protein +FIG00945166 FIG00945168: hypothetical protein +FIG00945172 FIG00945173: hypothetical protein +FIG00945173 FIG00945174: hypothetical protein +FIG00945174 FIG00945175: hypothetical protein +FIG00945175 Esterase/lipase/thioesterase +FIG00945177 conserved GtrA-like protein +FIG00945181 FIG00945182: hypothetical protein +FIG00945182 FIG00945183: hypothetical protein +FIG00945183 acetyltransferase +FIG00945184 sugar ABC transporter permease protein +FIG00945185 FIG00945186: hypothetical protein +FIG00945186 putative TetR-family transcriptional regulator +FIG00945190 FIG00945191: hypothetical protein +FIG00945192 FIG00945194: hypothetical protein +FIG00945195 FIG00945196: hypothetical protein +FIG00945196 FIG00945197: hypothetical protein +FIG00945197 transporter, putative fucose permease +FIG00945198 FIG00945199: hypothetical protein +FIG00945199 Lantibiotic biosynthesis dihydropyridine synthase, TsrD family +FIG00945201 FIG01000629: hypothetical protein +FIG00945208 putative oxalate/formate-specific permease +FIG00945212 transporter permease +FIG00945213 FIG00945214: hypothetical protein +FIG00945214 FIG00945215: hypothetical protein +FIG00945215 conserved protein YyaK +FIG00945216 FIG01105974: Probable conserved alanine rich transmembrane protein +FIG00945220 FIG00945221: hypothetical protein +FIG00945221 FIG00945222: hypothetical protein +FIG00945222 FIG00945223: hypothetical protein +FIG00945223 FIG00945225: hypothetical protein +FIG00945225 hypothetical protein, putative ABC transporter-asscoiated permease +FIG00945227 FIG00945229: hypothetical protein +FIG00945229 FIG00945230: hypothetical protein +FIG00945230 FIG00945231: hypothetical protein +FIG00945233 FIG00945234: hypothetical protein +FIG00945235 FIG00945236: hypothetical protein +FIG00945236 FIG00945238: hypothetical protein +FIG00945239 similar to thioesterase +FIG00945240 cytochrome oxidase assembly protein +FIG00945244 rare lipoprotein A, RlpA family +FIG00945245 FIG00945246: hypothetical protein +FIG00945246 trypsin-like serine protease +FIG00945247 FIG00945249: hypothetical protein +FIG00945249 putative ATP-binding protein +FIG00945252 FIG00945254: hypothetical protein +FIG00945254 FIG00945255: hypothetical protein +FIG00945255 transcriptional regulator, ROK family +FIG00945257 FIG00945258: hypothetical protein +FIG00945260 FIG00945261: hypothetical protein +FIG00945261 MerR-family transcriptional regulator +FIG00945262 FIG00945263: hypothetical protein +FIG00945264 FIG00945265: hypothetical protein +FIG00945265 FIG00945267: hypothetical protein +FIG00945267 FIG00945268: hypothetical protein +FIG00945268 FIG00945269: hypothetical protein +FIG00945273 putative NPL/P60 family secreted protein +FIG00945276 PROBABLE CONSERVED INTEGRAL MEMBRANE ALANINE AND VALINE AND LEUCINE RICH PROTEIN +FIG00945277 FIG00945278: hypothetical protein +FIG00945278 FIG00945279: hypothetical protein +FIG00945280 Guanyl-specific ribonuclease Sa3 precursor (EC 3.1.27.3) (RNase Sa3) +FIG00945281 FIG00945282: hypothetical protein +FIG00945282 putative iron sulphur protein +FIG00945283 FIG00945284: hypothetical protein +FIG00945284 FIG00945285: putative DNA-binding protein +FIG00945285 putative coenzyme A transferase +FIG00945287 FIG00945288: hypothetical protein +FIG00945296 FIG00945297: hypothetical protein +FIG00945298 FIG00945299: hypothetical protein +FIG00945299 FIG00945301: hypothetical protein +FIG00945301 FIG00945302: hypothetical protein +FIG00945303 FIG00945304: hypothetical protein +FIG00945304 FIG00945305: hypothetical protein +FIG00945305 hypothetical protein, putative molybdopterin-guanine dinucleotide biosynthesis protein +FIG00945306 FIG00945307: hypothetical protein +FIG00945307 FIG00945309: hypothetical protein +FIG00945309 FIG00945310: hypothetical protein +FIG00945311 FIG00945312: hypothetical protein +FIG00945312 hypothetical protein, putative serine esterase cutinase +FIG00945313 FIG00945314: hypothetical protein +FIG00945315 FIG00945316: hypothetical protein +FIG00945316 FIG00945317: hypothetical protein +FIG00945317 FIG00945318: hypothetical protein +FIG00945318 hypothetical protein, putative adhesion or S-layer protein +FIG00945320 FIG00945322: hypothetical protein +FIG00945322 FIG01120800: hypothetical protein +FIG00945323 putative glucosidase +FIG00945324 transfer protein homolog TraA +FIG00945325 conserved membrane protein, putative permease +FIG00945326 FIG00945327: hypothetical protein +FIG00945327 FIG00945328: hypothetical protein +FIG00945329 FIG00945330: hypothetical protein +FIG00945334 FIG00945336: hypothetical protein +FIG00945338 FIG00945339: hypothetical protein +FIG00945339 oligopeptide transporter +FIG00945342 FIG00945344: hypothetical protein +FIG00945344 FIG00945345: hypothetical protein +FIG00945349 FIG00945350: hypothetical protein +FIG00945350 putative 6-aminohexanoate-dimer hydrolase +FIG00945351 type II secretion system F domain protein +FIG00945352 FIG00945353: hypothetical protein +FIG00945353 FIG00945354: hypothetical protein +FIG00945354 class II aldolase/adducin family protein +FIG00945357 FIG00945358: hypothetical protein +FIG00945359 FIG00945360: hypothetical protein +FIG00945360 hypothetical protein; putative signal peptide +FIG00945361 FIG01121520: hypothetical protein +FIG00945365 FIG00945366: hypothetical protein +FIG00945367 FIG00945368: hypothetical protein +FIG00945369 putative ABC-type transporter, periplasmic component +FIG00945370 FIG00945371: hypothetical protein +FIG00945371 L-carnitine dehydratase/bile acid-inducible protein F +FIG00945373 substrate binding component of glycine/betaine transport system +FIG00945378 FIG00945379: hypothetical protein +FIG00945379 FIG00945380: hypothetical protein +FIG00945381 FIG00945382: hypothetical protein +FIG00945383 ABC transporter, nucleotide binding/ATPase protein +FIG00945384 Oligopeptide transport system permease protein OppB (TC 3.A.1.5.1) +FIG00945385 FIG00945387: hypothetical protein +FIG00945387 oxidoreductase with transcriptional repressor domain +FIG00945388 regulatory protein, ArsR +FIG00945389 FIG00945391: hypothetical protein +FIG00945391 FIG00945392: hypothetical protein +FIG00945392 conserved domain protein +FIG00945399 FIG00945400: hypothetical protein +FIG00945403 Glucosyl-3-phosphoglycerate phosphatase (EC 3.1.3.85) +FIG00945404 iron(III) dicitrate transport system permease protein +FIG00945407 FIG00945411: hypothetical protein +FIG00945413 FIG00945414: hypothetical protein +FIG00945416 putative ABC transporter-associated permease +FIG00945419 MoxR-like ATPase +FIG00945423 FIG00945424: hypothetical protein +FIG00945424 FIG00945425: hypothetical protein +FIG00945425 FIG00945426: hypothetical protein +FIG00945429 FIG00945430: hypothetical protein +FIG00945430 FIG00945431: hypothetical protein +FIG00945431 FIG00945432: hypothetical protein +FIG00945437 FIG00945440: hypothetical protein +FIG00945440 FIG00945441: hypothetical protein +FIG00945441 FIG00945442: hypothetical protein +FIG00945442 COG1302: Uncharacterized protein conserved in bacteria +FIG00945443 FIG00945444: hypothetical protein +FIG00945444 FIG00945447: hypothetical protein +FIG00945447 hypothetical protein, putative membrane efflux protein +FIG00945448 FIG00945449: hypothetical protein +FIG00945451 putative enzyme of poly-gamma-glutamate biosynthesis (capsule formation) +FIG00945452 FIG00945453: hypothetical protein +FIG00945455 hypothetical protein +FIG00945456 FIG00945457: hypothetical protein +FIG00945458 two-component system response regulator MtrA +FIG00945459 FIG00945463: hypothetical protein +FIG00945463 FIG00945464: hypothetical protein +FIG00945464 CAMP factor +FIG00945466 FIG00945467: hypothetical protein +FIG00945467 FIG00945468: hypothetical protein +FIG00945468 conserved protein with diacylglycerol kinase catalytic domain +FIG00945470 FIG00945471: hypothetical protein +FIG00945472 FIG00945473: hypothetical protein +FIG00945473 putative phosphoenolpyruvate-dependent sugar phosphotransferase +FIG00945474 FIG00945475: hypothetical protein +FIG00945475 conserved protein, phosphoglycerate mutase family protein +FIG00945476 FIG00945477: hypothetical protein +FIG00945479 FIG00945480: hypothetical protein +FIG00945480 putative two-component system, response regulator +FIG00945483 FIG00945484: hypothetical protein +FIG00945484 RidA/YER057c/UK114 superfamily, group 1 +FIG00945488 FHA domain containing protein +FIG00945489 FIG00945490: hypothetical protein +FIG00945490 FIG00945491: hypothetical protein +FIG00945492 transcriptional regulator, RpiR family +FIG00945494 FIG00945495: hypothetical protein +FIG00945495 FIG00945497: hypothetical protein +FIG00945497 FIG00945498: hypothetical protein +FIG00945498 FIG00945500: hypothetical protein +FIG00945500 FIG00945501: hypothetical protein +FIG00945501 FIG00996186: hypothetical protein +FIG00945504 Predicted rhamnose oligosaccharide ABC transport system, permease component 2 +FIG00945505 FIG00945506: hypothetical protein +FIG00945506 FIG00945507: hypothetical protein +FIG00945507 FIG00945509: hypothetical protein +FIG00945509 Copper resistance protein CopD / Cytochrome c oxidase caa3-type, assembly factor CtaG-related protein +FIG00945511 FIG00945512: hypothetical protein +FIG00945512 FIG00945513: hypothetical protein +FIG00945513 FIG00945514: hypothetical protein +FIG00945514 FIG00945515: hypothetical protein +FIG00945515 conserved protein, DUF885 +FIG00945516 FIG00945518: hypothetical protein +FIG00945519 FIG00945520: hypothetical protein +FIG00945520 Methyltransferase type 11 +FIG00945521 FIG00945522: hypothetical protein +FIG00945522 hypothetical prophage protein +FIG00945526 FIG00945527: hypothetical protein +FIG00945532 FIG00945533: hypothetical protein +FIG00945534 FIG00945535: hypothetical protein +FIG00945536 carboxypeptidase-related protein +FIG00945537 FIG00945538: hypothetical protein +FIG00945543 FIG00945545: hypothetical protein +FIG00945546 FIG00945547: hypothetical protein +FIG00945547 FIG00945548: hypothetical protein +FIG00945550 FIG00945551: hypothetical protein +FIG00945551 FIG00945552: hypothetical protein +FIG00945552 SpoU rRNA methylase family protein +FIG00945553 FIG00945554: hypothetical protein +FIG00945554 putative two component sensor kinase +FIG00945555 FIG00945557: hypothetical protein +FIG00945557 endo-beta-N-acetylglucosaminidase H( EC:3.2.1.96 ) +FIG00945558 FIG00945559: hypothetical protein +FIG00945559 FIG00945560: hypothetical protein +FIG00945562 putative secreted lipoprotein +FIG00945564 FIG00945565: hypothetical protein +FIG00945565 ABC transporter, ATP-binding +FIG00945571 FIG00945572: hypothetical protein +FIG00945572 FIG00945575: hypothetical protein +FIG00945575 hypothetical protein, putative ABC transporter associated permease +FIG00945577 FIG00945578: hypothetical protein +FIG00945579 FIG00945580: hypothetical protein +FIG00945580 FIG00945581: hypothetical protein +FIG00945581 putative methyltransferase( EC:2.1.1.- ) +FIG00945590 FIG00945592: hypothetical protein +FIG00945592 FIG00945594: hypothetical protein +FIG00945594 FIG00945595: hypothetical protein +FIG00945595 FIG00945599: hypothetical protein +FIG00945599 FIG00945601: hypothetical protein +FIG00945602 FIG00945603: hypothetical protein +FIG00945603 FIG00945604: hypothetical protein +FIG00945605 extracellular solute-binding protein, family 1 +FIG00945608 FIG00945609: hypothetical protein +FIG00945609 FIG00945610: hypothetical protein +FIG00945610 FIG00945611: hypothetical protein +FIG00945612 acetyltransferase family protein +FIG00945613 FIG00945614: hypothetical protein +FIG00945615 conserved protein, putative protease +FIG00945616 FIG00945619: hypothetical protein +FIG00945620 RHS-family protein +FIG00945623 patatin-like phospholipase +FIG00945627 FIG00945628: hypothetical protein +FIG00945628 putative conserved transmembrane protein +FIG00945629 ABC transporter, ATP-binding protein +FIG00945630 FIG00945631: hypothetical protein +FIG00945631 FIG00945632: hypothetical protein +FIG00945634 Hypothetical transporter +FIG00945637 FIG00945638: hypothetical protein +FIG00945641 FIG00945642: hypothetical protein +FIG00945642 putative B12 independent methionine synthase +FIG00945645 conserved hypothetical protein +FIG00945646 putative phosphoglycerate mutase/fructose-2,6-bisphosphatase( EC:5.4.2.1 ) +FIG00945647 FIG00945648: hypothetical protein +FIG00945651 FIG00945652: hypothetical protein +FIG00945652 FIG00945653: hypothetical protein +FIG00945653 putative oxidoreductase +FIG00945657 Dicarboxylate carrier MatC-like +FIG00945660 FIG00945661: hypothetical protein +FIG00945662 Putative chloride channel related membrane protein +FIG00945663 putative fructosamine kinase +FIG00945665 FIG00945667: hypothetical protein +FIG00945667 FIG00945668: hypothetical protein +FIG00945668 FIG00945670: hypothetical protein +FIG00945671 FIG00945672: hypothetical protein +FIG00945673 FIG00945675: hypothetical protein +FIG00945676 FIG00945678: hypothetical protein +FIG00945679 FIG00945682: hypothetical protein +FIG00945682 haloacid dehalogenase-like hydrolase +FIG00945683 FIG01131316: hypothetical protein +FIG00945684 FIG00945685: hypothetical protein +FIG00945685 heat shock protein, HSP20 family +FIG00945692 Signal transduction histidine kinase, subgroup 2 +FIG00945694 FIG00945695: hypothetical protein +FIG00945695 FIG00945696: hypothetical protein +FIG00945696 FIG00945697: hypothetical protein +FIG00945699 FIG01055294: hypothetical protein +FIG00945700 FIG01124490: hypothetical protein +FIG00945707 hypothetical protein +FIG00945708 FIG01131983: hypothetical protein +FIG00945709 FIG00945710: hypothetical protein +FIG00945710 FIG00945711: hypothetical protein +FIG00945711 putative permease +FIG00945712 FIG00945713: hypothetical protein +FIG00945713 glutamine amidotransferase / GMP synthase +FIG00945718 alcohol dehydrogenase +FIG00945719 FIG00945723: hypothetical protein +FIG00945726 hypothetical protein +FIG00945727 FIG00945729: hypothetical protein +FIG00945730 FIG00945731: hypothetical protein +FIG00945734 FIG00945736: hypothetical protein +FIG00945737 FIG00945738: hypothetical protein +FIG00945742 hypothetical protein, putative glucoamylase S1/S2 precursor +FIG00945745 putative sugar ABC transporter, permease component +FIG00945762 protein of unknown function DUF75 +FIG00945763 putative MutT family protein +FIG00945765 rare lipoprotein A +FIG00945767 FIG00945769: hypothetical protein +FIG00945769 FIG00945771: hypothetical protein +FIG00945771 FIG00945772: hypothetical protein +FIG00945772 transcriptional regulator, SorC family +FIG00945777 FIG00945778: hypothetical protein +FIG00945778 FIG00945779: hypothetical protein +FIG00945779 FIG00945780: hypothetical protein +FIG00945780 Putative 2Fe-2S ferredoxin CbiW involved in B12 biosynthesis +FIG00945781 conserved protein, MaoC like domain +FIG00945782 FIG00945785: hypothetical protein +FIG00945785 FIG00945786: hypothetical protein +FIG00945786 FIG00945787: hypothetical protein +FIG00945787 FIG00945788: hypothetical protein +FIG00945788 putative AsnC-family transcriptional regulatory protein +FIG00945790 FIG00945791: hypothetical protein +FIG00945793 FIG00945794: hypothetical protein +FIG00945794 protein associated to putative adhesion protein +FIG00945795 FIG00945796: hypothetical protein +FIG00945796 FIG00945798: hypothetical protein +FIG00945798 FIG00945799: hypothetical protein +FIG00945800 FIG027937: secreted protein +FIG00945803 Transcriptional regulator, DeoR family precursor +FIG00945805 FIG00945806: hypothetical protein +FIG00945807 FIG00945808: hypothetical protein +FIG00945808 FIG00945809: hypothetical protein +FIG00945810 putative carbohydrate kinase +FIG00945813 ATPase involved in DNA repair +FIG00945816 periplasmic-binding protein of ABC transporter +FIG00945817 FIG00945818: hypothetical protein +FIG00945818 FIG00945820: hypothetical protein +FIG00945821 FIG01121432: hypothetical protein +FIG00945822 FIG00945823: hypothetical protein +FIG00945823 ABC transporter ATP-binding protein fragment +FIG00945824 triacylglycerol lipase precursor( EC:3.1.1.3 ) +FIG00945825 sodium:alanine symporter family protein +FIG00945826 putative outer membrane protein A +FIG00945828 FIG00945829: hypothetical protein +FIG00945829 FIG00945831: hypothetical protein +FIG00945831 FIG00945834: hypothetical protein +FIG00945834 FIG00945835: hypothetical protein +FIG00945835 FIG00945836: hypothetical protein +FIG00945836 FIG00945837: hypothetical protein +FIG00945838 FIG00945839: hypothetical protein +FIG00945839 predicted hydrolase of the HAD superfamily +FIG00945841 possible oxidoreductase of the aldo/keto reductase family +FIG00945843 putative sucrose symporter +FIG00945848 FIG00945849: hypothetical protein +FIG00945849 FIG00945850: hypothetical protein +FIG00945851 FIG00945852: hypothetical protein +FIG00945852 FIG00945853: hypothetical protein +FIG00945853 FIG00945854: hypothetical protein +FIG00945854 phosphinothricin N-acetyltransferase, putative +FIG00945857 FIG00945858: hypothetical protein +FIG00945858 endo-beta-N-acetylglucosaminidase family protein +FIG00945862 FIG00945863: hypothetical protein +FIG00945863 FIG00945867: hypothetical protein +FIG00945867 FIG00945870: hypothetical protein +FIG00945872 FIG00945873: hypothetical protein +FIG00945873 FIG00945875: hypothetical protein +FIG00945875 FIG00945876: hypothetical protein +FIG00945877 FIG00945878: hypothetical protein +FIG00945879 FIG00945882: hypothetical protein +FIG00945882 FIG00945883: hypothetical protein +FIG00945883 FIG00945884: hypothetical protein +FIG00945885 ABC transporter +FIG00945888 putative poly(3-hydroxyalkanoate) depolymerase( EC:3.1.1.- ) +FIG00945889 FIG00945890: hypothetical protein +FIG00945890 sugar-binding protein +FIG00945893 FIG00945894: hypothetical protein +FIG00945894 FIG00945898: hypothetical protein +FIG00945900 FIG01124115: hypothetical protein +FIG00945903 FIG00945904: hypothetical protein +FIG00945909 UPF0301 protein YqgE +FIG00945911 FIG00945912: hypothetical protein +FIG00945914 FIG00945915: hypothetical protein +FIG00945915 FIG00945916: hypothetical protein +FIG00945916 FIG00945919: hypothetical protein +FIG00945919 FIG00945920: hypothetical protein +FIG00945920 putative two-component response regulator +FIG00945921 FIG00945924: hypothetical protein +FIG00945930 FIG00945932: hypothetical protein +FIG00945932 NAD-dependent dehydrogenase (EC 1.1.1.18) +FIG00945934 hypothetical protein, putative molybdopterin-guanine dinucleotide biosynthesis protein A +FIG00945938 hydrolase, putative isochorismatase +FIG00945939 FIG00945940: hypothetical protein +FIG00945946 FIG00945947: hypothetical protein +FIG00945948 FIG00945950: hypothetical protein +FIG00945950 FIG00945951: hypothetical protein +FIG00945952 putative Beta-N-acetylhexosaminidase( EC:3.2.1.52 ) +FIG00945953 FIG00945954: hypothetical protein +FIG00945954 FIG00945956: hypothetical protein +FIG00945958 FIG00945960: hypothetical protein +FIG00945960 FIG00945963: hypothetical protein +FIG00945964 FIG00945965: hypothetical protein +FIG00945966 hypothetical protein, +FIG00945968 FIG00945969: hypothetical protein +FIG00945969 FIG00945970: hypothetical protein +FIG00945970 FIG00945972: hypothetical protein +FIG00945972 HAD-superfamily hydrolase +FIG00945975 FIG00945977: hypothetical protein +FIG00945978 FIG00945979: hypothetical protein +FIG00945980 Phosphomannomutase (EC 5.4.2.8) +FIG00945983 FIG00945984: hypothetical protein +FIG00945987 FIG00945989: hypothetical protein +FIG00945991 FIG00945994: hypothetical protein +FIG00945994 FIG00945996: hypothetical protein +FIG00945996 FIG00945998: hypothetical protein +FIG00946000 FIG00946001: hypothetical protein +FIG00946008 FIG00946009: hypothetical protein +FIG00946010 hypothetical membrane-spanning protein +FIG00946011 FIG00946015: hypothetical protein +FIG00946018 FIG00946019: hypothetical protein +FIG00946022 putative DNA polymerase III epsilon subunit (exonuclease) +FIG00946023 FIG00946024: hypothetical protein +FIG00946025 FIG01121484: hypothetical protein +FIG00946030 FIG00946031: hypothetical protein +FIG00946031 FIG00946033: hypothetical protein +FIG00946034 FIG00946035: hypothetical protein +FIG00946039 FIG00946040: hypothetical protein +FIG00946040 putative anti-sigma factor +FIG00946041 FIG00946042: hypothetical protein +FIG00946044 FIG00946045: hypothetical protein +FIG00946050 FIG00946053: hypothetical protein +FIG00946059 phosphotransferase system PTS, EIIB protein +FIG00946060 FIG00946062: hypothetical protein +FIG00946062 FIG00946063: hypothetical protein +FIG00946066 FIG00946067: hypothetical protein +FIG00946067 FIG00946068: hypothetical protein +FIG00946073 iron transport system substrate-binding protein +FIG00946077 FIG00946078: hypothetical protein +FIG00946078 FIG00946079: hypothetical protein +FIG00946079 FIG01121646: hypothetical protein +FIG00946081 endoglycoceramidase( EC:3.2.1.123 ) +FIG00946086 FIG00946089: hypothetical protein +FIG00946089 FIG00946091: hypothetical protein +FIG00946091 FIG00946092: hypothetical protein +FIG00946092 FIG00946093: hypothetical protein +FIG00946093 FIG00946094: hypothetical protein +FIG00946094 FIG00946095: hypothetical protein +FIG00946095 FIG00946096: hypothetical protein +FIG00946096 putative rRNA methylase +FIG00946098 FIG00946099: hypothetical protein +FIG00946099 FIG00946102: hypothetical protein +FIG00946105 FIG00946106: hypothetical protein +FIG00946107 putative glycosyl transferase group 1 +FIG00946108 FIG00946110: hypothetical protein +FIG00946111 conserved protein (DUF174) +FIG00946112 hypothetical protein, contains similarity to K+ channel, beta subunit +FIG00946117 FIG00946118: hypothetical protein +FIG00946120 FIG00946121: hypothetical protein +FIG00946121 probable peptidyl-prolyl cis-trans isomerase B( EC:5.2.1.8 ) +FIG00946122 FIG00946125: hypothetical protein +FIG00946125 transcriptional regulatory protein, TetR family +FIG00946127 FIG00946128: hypothetical protein +FIG00946128 Septum formation initiator +FIG00946132 FIG00946133: hypothetical protein +FIG00946133 FIG00946135: hypothetical protein +FIG00946135 FIG00946137: hypothetical protein +FIG00946137 putative ATP-binding membrane protein +FIG00946139 FIG00946140: hypothetical protein +FIG00946142 putative Na+ efflux ABC transporter, permease component +FIG00946143 FIG00946145: hypothetical protein +FIG00946146 FIG00946147: hypothetical protein +FIG00946148 FIG00946150: hypothetical protein +FIG00946152 FIG00946154: hypothetical protein +FIG00946155 putative helicase +FIG00946160 FIG00946163: hypothetical protein +FIG00946163 putative GntR-family transcriptional regulator +FIG00946167 Helicase, C-terminal:DEAD/DEAH box helicase, N-terminal +FIG00946170 FIG00946172: hypothetical protein +FIG00946172 plasmid partition protein ParA +FIG00946174 FIG00946175: hypothetical protein +FIG00946177 FIG00946181: hypothetical protein +FIG00946182 FIG00946184: hypothetical protein +FIG00946186 FIG00946187: hypothetical protein +FIG00946189 conserved membrane-associated protein (OmpA family) +FIG00946190 FIG00946191: hypothetical protein +FIG00946193 protein of unknown function DUF1469 +FIG00946194 FKBP-type peptidyl-prolyl cis-trans isomerase +FIG00946197 FIG00946199: hypothetical protein +FIG00946199 FIG00946200: hypothetical protein +FIG00946203 FIG00946204: hypothetical protein +FIG00946205 FIG00946206: hypothetical protein +FIG00946206 hypothetical membrane protein +FIG00946207 conserved hypothetical protein +FIG00946211 FIG00946212: hypothetical protein +FIG00946214 FIG00946218: hypothetical protein +FIG00946220 FIG00946221: hypothetical protein +FIG00946221 FIG00946223: hypothetical protein +FIG00946223 FIG00946225: hypothetical protein +FIG00946225 FIG00946226: hypothetical protein +FIG00946227 FIG00946228: hypothetical protein +FIG00946228 FIG00946231: hypothetical protein +FIG00946233 PTS system, galactitol-specific IIC component( EC:2.7.1.69 ) +FIG00946243 FIG00946244: hypothetical protein +FIG00946244 Putative ABC iron siderophore transporter, fused permease and ATPase domains +FIG00946245 FIG00946247: hypothetical protein +FIG00946247 hypothetical protein, putative universal stress protein UspA +FIG00946251 regulator putative TetR-family +FIG00946259 FIG00946262: hypothetical protein +FIG00946265 l-arginine:glycine amidinotransferase +FIG00946270 hydrolase (HAD superfamily) +FIG00946271 FIG00946272: hypothetical protein +FIG00946274 FIG00946275: hypothetical protein +FIG00946280 FIG00946282: hypothetical protein +FIG00946288 FIG00946290: hypothetical protein +FIG00946293 FIG00946297: hypothetical protein +FIG00946297 Amine oxidase [flavin-containing] (EC 1.4.3.4) +FIG00946308 FIG00946310: hypothetical protein +FIG00946310 FIG00946311: hypothetical protein +FIG00946315 FIG00946317: hypothetical protein +FIG00946319 FIG00946321: hypothetical protein +FIG00946323 FIG00946324: hypothetical protein +FIG00946329 FIG00946330: hypothetical protein +FIG00946330 FIG00946332: hypothetical protein +FIG00946333 FIG00946334: hypothetical protein +FIG00946336 Permease +FIG00946337 FIG00946338: hypothetical protein +FIG00946338 membrane spanning protein, GtrA-family +FIG00946340 FIG00946342: hypothetical protein +FIG00946344 transcriptional regulator, LacI family +FIG00946360 hypothetical phage-associated protein +FIG00946361 FIG00946362: hypothetical protein +FIG00946364 hypothetical protein +FIG00946367 FIG00946369: hypothetical protein +FIG00946374 FIG00946377: hypothetical protein +FIG00946381 FIG00946384: hypothetical protein +FIG00946396 conserved membrane spanning protein, DUF6 family +FIG00946404 FIG00946406: hypothetical protein +FIG00946406 FIG00946409: hypothetical protein +FIG00946416 FIG00946419: hypothetical protein +FIG00946419 RDD domain containing protein +FIG00946420 DNA repair exonuclease +FIG00946426 FIG00946427: hypothetical protein +FIG00946427 FIG00946428: hypothetical protein +FIG00946436 Gluconate transporter family protein +FIG00946444 FIG00946448: hypothetical protein +FIG00946453 FIG00946454: hypothetical protein +FIG00946462 FIG00946463: hypothetical protein +FIG00946475 iron ABC transporter, ATP-binding protein +FIG00946486 FIG00946490: hypothetical protein +FIG00946551 FIG00946563: hypothetical protein +FIG00946610 membrane fusion protein, putative +FIG00946646 Membrane protein involved in aromatic hydrocarbon degradation precursor +FIG00946710 FIG00946713: hypothetical protein +FIG00946739 putative anti-sigma regulatory factor, serine/threonine protein kinase +FIG00946763 SAM-dependent methyltransferase BT3209 +FIG00946777 FIG00946778: hypothetical protein +FIG00946779 FIG00946780: hypothetical protein +FIG00946780 hypothetical protein; Some similarities with enterochelin esterase Fes (ferric enterobactin esterase). Putative secreted protein +FIG00946783 FIG00946785: hypothetical protein +FIG00946786 FIG00946787: hypothetical protein +FIG00946788 FIG00946789: hypothetical protein +FIG00946790 probable tyrosine phosphatase +FIG00946792 FIG00946794: hypothetical protein +FIG00946794 FIG00946795: hypothetical protein +FIG00946795 FIG00946799: hypothetical protein +FIG00946801 FIG00946802: hypothetical protein +FIG00946804 FIG00946805: hypothetical protein +FIG00946805 FIG00946806: hypothetical protein +FIG00946809 FIG00946811: hypothetical protein +FIG00946812 FIG00946815: hypothetical protein +FIG00946815 FIG00946816: hypothetical protein +FIG00946827 FIG00946828: hypothetical protein +FIG00946829 FIG00946830: hypothetical protein +FIG00946831 putative prophage regulatory protein +FIG00946839 FIG00946840: hypothetical protein +FIG00946849 FIG00946851: hypothetical protein +FIG00946851 FIG00946852: hypothetical protein +FIG00946857 UmoC +FIG00946858 FIG00946860: hypothetical protein +FIG00946861 FIG00946862: hypothetical protein +FIG00946863 FIG00946864: hypothetical protein +FIG00946875 FIG00946876: hypothetical protein +FIG00946876 FIG00946877: hypothetical protein +FIG00946878 FloA +FIG00946879 FIG00946880: hypothetical protein +FIG00946883 FIG00946885: hypothetical protein +FIG00946885 FIG00946886: hypothetical protein +FIG00946888 FIG00946893: hypothetical protein +FIG00946895 UmoA +FIG00946896 probable exported protein STY0748 +FIG00946897 FIG00946899: hypothetical protein +FIG00946899 FIG00946902: hypothetical protein +FIG00946902 FIG00946905: hypothetical protein +FIG00946906 FIG00946907: hypothetical protein +FIG00946912 FIG00946916: hypothetical protein +FIG00946916 FIG00946917: hypothetical protein +FIG00946919 Protein of unknown function DUF1311 +FIG00946927 FIG00946928: hypothetical protein +FIG00946928 FIG00946929: hypothetical protein +FIG00946930 FIG00946931: hypothetical protein +FIG00946932 FIG00946933: hypothetical protein +FIG00946934 FIG00946937: hypothetical protein +FIG00946938 FIG00946940: hypothetical protein +FIG00946940 FIG00946943: hypothetical protein +FIG00946943 FIG00946944: hypothetical protein +FIG00946944 FIG00946945: hypothetical protein +FIG00946945 Regulatory protein recX (oraA protein) +FIG00946947 FIG00946950: hypothetical protein +FIG00946950 FIG00946951: hypothetical protein +FIG00946951 FIG00946954: hypothetical protein +FIG00946955 FIG00946959: hypothetical protein +FIG00946959 FIG00946964: hypothetical protein +FIG00946964 FIG00946965: hypothetical protein +FIG00946968 FIG00946969: hypothetical protein +FIG00946969 FIG00946970: hypothetical protein +FIG00946985 FIG00946987: hypothetical protein +FIG00946988 CCM1 protein (CCM2 protein) +FIG00946990 STEC autoagglutinating adhesin +FIG00946991 FIG00946992: hypothetical protein +FIG00946992 FIG00946993: hypothetical protein +FIG00946993 FIG00946994: hypothetical protein +FIG00946996 FIG00946998: hypothetical protein +FIG00947007 FIG00947009: hypothetical protein +FIG00947009 FIG00947011: hypothetical protein +FIG00947011 FIG00947012: hypothetical protein +FIG00947012 FIG00947014: hypothetical protein +FIG00947019 FIG00947022: hypothetical protein +FIG00947022 FIG00947024: hypothetical protein +FIG00947027 FIG00947028: hypothetical protein +FIG00947033 FIG00947036: hypothetical protein +FIG00947036 FIG00947038: hypothetical protein +FIG00947038 FIG00947040: hypothetical protein +FIG00947045 FIG00947047: hypothetical protein +FIG00947055 Putative minor fimbrial subunit pmfE precursor +FIG00947056 FIG00947059: hypothetical protein +FIG00947067 FIG00947068: hypothetical protein +FIG00947070 FIG00947071: hypothetical protein +FIG00947071 FIG01201561: hypothetical protein +FIG00947079 CpmK protein +FIG00947090 FIG00947092: hypothetical protein +FIG00947092 FIG00947093: hypothetical protein +FIG00947093 FIG00947095: hypothetical protein +FIG00947100 FIG00947103: hypothetical protein +FIG00947106 FIG00947110: hypothetical protein +FIG00947116 FIG00947117: hypothetical protein +FIG00947117 FIG00947118: hypothetical protein +FIG00947120 FIG00947122: hypothetical protein +FIG00947124 FIG00947125: hypothetical protein +FIG00947125 FIG00947126: hypothetical protein +FIG00947126 FIG00947127: hypothetical protein +FIG00947136 probable membrane protein YPO0177 +FIG00947138 FIG00947139: hypothetical protein +FIG00947139 Type IV secretory pathway, VirD4 components +FIG00947140 FIG00947141: hypothetical protein +FIG00947142 FIG00947144: hypothetical protein +FIG00947144 FIG00947145: hypothetical protein +FIG00947151 Putative iron compound ABC transporter permease protein +FIG00947154 FIG00947156: hypothetical protein +FIG00947158 FIG00947159: hypothetical protein +FIG00947172 Putative GTP-binding protein YdgA +FIG00947177 cytotoxic outer-membrane protein +FIG00947179 FIG00947180: hypothetical protein +FIG00947180 FIG00947181: hypothetical protein +FIG00947183 FIG00947185: hypothetical protein +FIG00947185 FIG00947186: hypothetical protein +FIG00947186 Hemolysin secretion protein D, plasmid +FIG00947195 FIG00947197: hypothetical protein +FIG00947197 FIG00947200: hypothetical protein +FIG00947200 FIG00947201: hypothetical protein +FIG00947201 FIG00947202: hypothetical protein +FIG00947202 FIG00947203: hypothetical protein +FIG00947208 FIG00947210: hypothetical protein +FIG00947210 FIG00947211: hypothetical protein +FIG00947212 Glutamate decarboxylase, 67 kDa isoform (EC 4.1.1.15) +FIG00947215 Protein of unknown function DUF924 +FIG00947219 FIG00947221: hypothetical protein +FIG00947223 FIG00947224: hypothetical protein +FIG00947224 FIG00947225: hypothetical protein +FIG00947226 FIG00947230: hypothetical protein +FIG00947232 FIG00947233: hypothetical protein +FIG00947234 FIG00947235: hypothetical protein +FIG00947235 FIG00947236: hypothetical protein +FIG00947236 FIG00947237: hypothetical protein +FIG00947237 FIG00947238: hypothetical protein +FIG00947238 FIG00947240: hypothetical protein +FIG00947240 FIG00947242: hypothetical protein +FIG00947242 FIG00947243: hypothetical protein +FIG00947243 FIG00947244: hypothetical protein +FIG00947248 FIG00947249: hypothetical protein +FIG00947249 FIG00947250: hypothetical protein +FIG00947250 FIG00947251: hypothetical protein +FIG00947255 FIG00947256: hypothetical protein +FIG00947256 FIG00947257: hypothetical protein +FIG00947266 FIG00947267: hypothetical protein +FIG00947267 FIG00947272: hypothetical protein +FIG00947273 FIG00947276: hypothetical protein +FIG00947276 FIG00947277: hypothetical protein +FIG00947280 FIG00947281: hypothetical protein +FIG00947281 FIG00947283: hypothetical protein +FIG00947283 FIG00947284: hypothetical protein +FIG00947284 SmtA protein +FIG00947287 FIG00947288: hypothetical protein +FIG00947289 FIG00947290: hypothetical protein +FIG00947290 FIG00947291: hypothetical protein +FIG00947291 FIG00947293: hypothetical protein +FIG00947295 probable exported protein YPO0620 +FIG00947298 FIG00947299: hypothetical protein +FIG00947299 FIG00947300: hypothetical protein +FIG00947300 probable tail length tape measure protein +FIG00947301 Hypothetical fimbrial chaperone YfcS precusor +FIG00947308 C-compound and carbohydrate metabolism +FIG00947317 FIG00947318: hypothetical protein +FIG00947320 FIG00947321: hypothetical protein +FIG00947323 FIG00947324: hypothetical protein +FIG00947324 Aminomethyltransferase (EC 2.1.2.10) +FIG00947332 FIG00947333: hypothetical protein +FIG00947343 FIG00947344: hypothetical protein +FIG00947344 FIG00947346: hypothetical protein +FIG00947352 FIG00947353: hypothetical protein +FIG00947353 FIG00947354: hypothetical protein +FIG00947355 FIG00947358: hypothetical protein +FIG00947358 FIG00947360: hypothetical protein +FIG00947360 FIG00947361: hypothetical protein +FIG00947361 FIG00947364: hypothetical protein +FIG00947369 FIG00947372: hypothetical protein +FIG00947373 FIG00947377: hypothetical protein +FIG00947380 FIG00947381: hypothetical protein +FIG00947391 FIG00947392: hypothetical protein +FIG00947393 CpmJ protein +FIG00947394 tetracycline resistance regulatory protein TetR +FIG00947395 FIG00947396: hypothetical protein +FIG00947396 Putative signal transducer +FIG00947401 FIG00947402: hypothetical protein +FIG00947402 FIG00947404: hypothetical protein +FIG00947404 FIG00947407: hypothetical protein +FIG00947407 FIG00947408: hypothetical protein +FIG00947408 FIG00947410: hypothetical protein +FIG00947410 Succinate-semialdehyde dehydrogenase [NAD(P)+] (EC 1.2.1.16) +FIG00947411 FIG00947413: hypothetical protein +FIG00947413 FIG00947414: hypothetical protein +FIG00947414 FIG00947416: hypothetical protein +FIG00947419 FIG00947420: hypothetical protein +FIG00947423 Putative minor fimbrial subunit pmfF precursor +FIG00947429 FIG00947430: hypothetical protein +FIG00947430 FIG00947431: hypothetical protein +FIG00947431 FIG00947432: hypothetical protein +FIG00947433 FIG00947434: hypothetical protein +FIG00947445 FIG00947447: hypothetical protein +FIG00947449 FIG00947452: hypothetical protein +FIG00947452 FIG00947454: hypothetical protein +FIG00947455 FIG00947456: hypothetical protein +FIG00947457 FIG00947458: hypothetical protein +FIG00947463 FIG00947465: hypothetical protein +FIG00947465 FIG00947466: hypothetical protein +FIG00947466 FIG00947471: hypothetical protein +FIG00947476 FIG00947477: hypothetical protein +FIG00947477 FIG00947478: hypothetical protein +FIG00947478 FIG00947484: hypothetical protein +FIG00947484 FIG00947485: hypothetical protein +FIG00947486 FIG00947488: hypothetical protein +FIG00947488 FIG00947491: hypothetical protein +FIG00947494 FIG00947495: hypothetical protein +FIG00947496 FIG00947497: hypothetical protein +FIG00947497 FIG00947498: hypothetical protein +FIG00947501 FIG00947503: hypothetical protein +FIG00947507 FIG00947509: hypothetical protein +FIG00947510 FIG00947512: hypothetical protein +FIG00947519 FIG00947520: hypothetical protein +FIG00947520 PixG protein +FIG00947524 FIG00947525: hypothetical protein +FIG00947525 FIG00947526: hypothetical protein +FIG00947527 FIG00947528: hypothetical protein +FIG00947530 FIG00947531: hypothetical protein +FIG00947531 FIG00947535: hypothetical protein +FIG00947538 FIG00947540: hypothetical protein +FIG00947551 FIG00947552: hypothetical protein +FIG00947552 FIG00947553: hypothetical protein +FIG00947553 FIG00947554: hypothetical protein +FIG00947555 FIG00947557: hypothetical protein +FIG00947557 FIG00947563: hypothetical protein +FIG00947566 FIG00947567: hypothetical protein +FIG00947569 PixF protein +FIG00947572 FIG00947574: hypothetical protein +FIG00947574 FIG00947577: hypothetical protein +FIG00947577 FIG00947579: hypothetical protein +FIG00947582 FIG00947584: hypothetical protein +FIG00947584 FIG00947585: hypothetical protein +FIG00947587 FIG00947589: hypothetical protein +FIG00947589 FIG00947591: hypothetical protein +FIG00947602 Putative TonB dependent outer membrane receptor +FIG00947603 FIG00947604: hypothetical protein +FIG00947606 FIG00947608: hypothetical protein +FIG00947608 FIG00947609: hypothetical protein +FIG00947609 FIG00947612: hypothetical protein +FIG00947612 Leader peptidase (Prepilin peptidase) (EC 3.4.23.43) / N-methyltransferase (EC 2.1.1.-) +FIG00947613 FIG00947614: hypothetical protein +FIG00947614 FIG00947615: hypothetical protein +FIG00947615 FIG00613694: hypothetical protein +FIG00947620 FIG00947624: hypothetical protein +FIG00947624 FIG00947625: hypothetical protein +FIG00947625 FIG00947629: hypothetical protein +FIG00947629 FIG00947630: hypothetical protein +FIG00947630 FIG00947631: hypothetical protein +FIG00947631 FIG00947633: hypothetical protein +FIG00947642 probable outer membrane fimbrial usher protein YPO0302 +FIG00947648 FIG00947653: hypothetical protein +FIG00947654 FIG00947655: hypothetical protein +FIG00947656 FIG00947661: hypothetical protein +FIG00947665 FIG00947666: hypothetical protein +FIG00947666 FIG00947668: hypothetical protein +FIG00947670 FIG00947672: hypothetical protein +FIG00947672 FIG00947673: hypothetical protein +FIG00947673 FIG00947674: hypothetical protein +FIG00947675 Hydrolase, HAD-superfamily, subfamily IB +FIG00947676 FIG00947680: hypothetical protein +FIG00947680 FIG00947682: hypothetical protein +FIG00947688 FIG00947689: hypothetical protein +FIG00947690 FIG00947692: hypothetical protein +FIG00947692 FIG00947693: hypothetical protein +FIG00947696 FIG00947697: hypothetical protein +FIG00947697 Type III secretion system protein BsaR +FIG00947699 FIG00949355: hypothetical protein +FIG00947702 FIG00947703: hypothetical protein +FIG00947703 Tyrosine decarboxylase +FIG00947706 FIG00947707: hypothetical protein +FIG00947707 FIG00947710: hypothetical protein +FIG00947710 FIG00947715: hypothetical protein +FIG00947715 Outer membrane usher protein htrE precursor +FIG00947719 Urease operon transcriptional activator +FIG00947720 FIG00947726: hypothetical protein +FIG00947727 FIG00947728: hypothetical protein +FIG00947733 Permease component of transport system for ferric iron, AfuB protein +FIG00947735 FIG00947736: hypothetical protein +FIG00947736 FIG00947737: hypothetical protein +FIG00947740 FIG00947742: hypothetical protein +FIG00947753 FIG00947754: hypothetical protein +FIG00947754 FIG00947756: hypothetical protein +FIG00947756 FIG00947758: hypothetical protein +FIG00947758 FIG00947759: hypothetical protein +FIG00947760 FIG00947763: hypothetical protein +FIG00947770 FIG00947772: hypothetical protein +FIG00947772 FIG00947776: hypothetical protein +FIG00947781 FIG00947782: hypothetical protein +FIG00947782 FIG00947785: hypothetical protein +FIG00947786 FIG00947788: hypothetical protein +FIG00947794 FIG00947798: hypothetical protein +FIG00947798 FIG00947800: hypothetical protein +FIG00947800 FIG00947802: hypothetical protein +FIG00947803 Lipoprotein LprO +FIG00947805 Proline-specific permease +FIG00947807 FIG00947810: hypothetical protein +FIG00947810 FIG00947812: hypothetical protein +FIG00947816 FIG00947818: hypothetical protein +FIG00947821 FIG00947823: hypothetical protein +FIG00947832 Pi-fimbriae major subunit +FIG00947834 FIG00947837: hypothetical protein +FIG00947841 FIG00947842: hypothetical protein +FIG00947852 FIG00947853: hypothetical protein +FIG00947858 FIG00947863: hypothetical protein +FIG00947863 FIG00947869: hypothetical protein +FIG00947871 FIG00947872: hypothetical protein +FIG00947873 FIG00947878: hypothetical protein +FIG00947885 FIG00947886: hypothetical protein +FIG00947886 FIG00947889: hypothetical protein +FIG00947895 FIG00947896: hypothetical protein +FIG00947904 long-chain acyl-CoA thioester hydrolase family protein +FIG00947911 lipoprotein, putative +FIG00947920 FIG00947921: hypothetical protein +FIG00947922 FIG00947923: hypothetical protein +FIG00947926 FIG00947928: hypothetical protein +FIG00947931 FIG00947932: hypothetical protein +FIG00947945 FIG00947946: hypothetical protein +FIG00947946 transcriptional repressor, MarR family +FIG00947948 FIG00947949: hypothetical protein +FIG00947961 LscZ +FIG00947963 Autotransporter beta-domain protein +FIG00947969 FIG00947972: hypothetical protein +FIG00947972 putative acyl carrier protein +FIG00947993 FIG00947994: hypothetical protein +FIG00947995 FIG00947997: hypothetical protein +FIG00948001 FIG00948003: hypothetical protein +FIG00948019 Probable apo-citrate lyase phosphoribosyl-dephospho-CoA transferase (EC 2.7.7.61) +FIG00948028 FIG00948030: hypothetical protein +FIG00948030 FIG00948031: hypothetical protein +FIG00948031 FIG00948034: hypothetical protein +FIG00948034 FIG00948036: hypothetical protein +FIG00948037 FIG00948038: hypothetical protein +FIG00948041 FIG00948043: hypothetical protein +FIG00948045 FIG00948047: hypothetical protein +FIG00948049 FIG00948050: hypothetical protein +FIG00948052 FIG00948053: hypothetical protein +FIG00948053 FIG00948054: hypothetical protein +FIG00948054 FIG00948057: hypothetical protein +FIG00948057 FIG00948059: hypothetical protein +FIG00948059 putative phage protein +FIG00948063 FIG00948064: hypothetical protein +FIG00948077 FIG00948080: hypothetical protein +FIG00948083 Integral membrane protein TerC +FIG00948084 FIG00948087: hypothetical protein +FIG00948087 FIG00948088: hypothetical protein +FIG00948088 FIG00948089: hypothetical protein +FIG00948091 FIG00948092: hypothetical protein +FIG00948095 FIG00948097: hypothetical protein +FIG00948097 Putative LysR-family transcriptional regulatory protein +FIG00948101 FIG00948103: hypothetical protein +FIG00948108 FIG00948110: hypothetical protein +FIG00948110 FIG00948111: hypothetical protein +FIG00948113 4-alpha-L-fucosyltransferase (EC 2.4.1.-) +FIG00948117 FIG00948118: hypothetical protein +FIG00948124 FIG00948129: hypothetical protein +FIG00948132 Prepilin peptidase dependent protein B precursor +FIG00948133 FIG00948134: hypothetical protein +FIG00948134 FIG00948135: hypothetical protein +FIG00948135 FIG00948137: hypothetical protein +FIG00948137 FIG00948846: hypothetical protein +FIG00948138 FIG00948141: hypothetical protein +FIG00948141 FIG00948144: hypothetical protein +FIG00948148 FIG00948149: hypothetical protein +FIG00948151 Cyd operon protein YbgE +FIG00948152 TIM-barrel signal transduction protein +FIG00948155 FIG00948157: hypothetical protein +FIG00948157 FIG00948158: hypothetical protein +FIG00948158 YheO-like PAS domain +FIG00948159 FIG00948161: hypothetical protein +FIG00948162 FIG00948163: hypothetical protein +FIG00948165 FIG00948167: hypothetical protein +FIG00948169 FIG00948170: hypothetical protein +FIG00948172 FIG00948175: hypothetical protein +FIG00948178 FIG00948179: hypothetical protein +FIG00948183 FIG00948185: hypothetical protein +FIG00948185 FIG00948186: hypothetical protein +FIG00948190 FIG00948192: hypothetical protein +FIG00948200 FIG00948202: hypothetical protein +FIG00948202 Tail completion protein S +FIG00948203 FIG00948204: hypothetical protein +FIG00948207 FIG00948208: hypothetical protein +FIG00948217 FIG00948219: hypothetical protein +FIG00948219 FIG00948221: hypothetical protein +FIG00948221 FIG00948222: hypothetical protein +FIG00948224 FIG00948225: hypothetical protein +FIG00948225 Inner membrane protein yciS +FIG00948227 FIG00948229: hypothetical protein +FIG00948230 FIG00948231: hypothetical protein +FIG00948231 Predicted glutamine amidotransferase +FIG00948232 Adhesion protein PapA +FIG00948241 TRANSCRIPTION REGULATOR PROTEIN +FIG00948242 FIG00948243: hypothetical protein +FIG00948245 FIG00948246: hypothetical protein +FIG00948247 FIG00948248: hypothetical protein +FIG00948248 FIG00350115: hypothetical protein +FIG00948249 Unknown, probable amino acid transporter +FIG00948250 FIG00948254: hypothetical protein +FIG00948254 FIG00948255: hypothetical protein +FIG00948268 14 +FIG00948270 Predicted regulator of STY3230 transporter operon +FIG00948273 FIG00948274: hypothetical protein +FIG00948274 FIG00948275: hypothetical protein +FIG00948275 FIG00948276: hypothetical protein +FIG00948277 Puative phophotriesterase +FIG00948278 FIG00948279: hypothetical protein +FIG00948279 Fimbrial subunit type 3 precursor +FIG00948284 FIG00948285: hypothetical protein +FIG00948285 FIG00948286: hypothetical protein +FIG00948286 FIG00948288: hypothetical protein +FIG00948289 FIG00948290: hypothetical protein +FIG00948290 FIG00948293: hypothetical protein +FIG00948293 FIG00948295: hypothetical protein +FIG00948297 FIG00948298: hypothetical protein +FIG00948300 FIG00948301: hypothetical protein +FIG00948301 FIG00948302: hypothetical protein +FIG00948306 FIG00948307: hypothetical protein +FIG00948309 FIG00948310: hypothetical protein +FIG00948310 FIG00948311: hypothetical protein +FIG00948315 FIG00948316: hypothetical protein +FIG00948316 FIG00948317: hypothetical protein +FIG00948317 Orf2 +FIG00948320 HTH-type transcriptional regulator cueR +FIG00948325 FIG00948326: hypothetical protein +FIG00948327 FIG00948328: hypothetical protein +FIG00948330 FIG00948332: hypothetical protein +FIG00948333 FIG00948334: hypothetical protein +FIG00948336 FIG00948337: hypothetical protein +FIG00948337 FIG00948338: hypothetical protein +FIG00948345 FIG00948346: hypothetical protein +FIG00948346 FIG00948348: hypothetical protein +FIG00948349 FIG00948351: hypothetical protein +FIG00948352 FIG00948353: hypothetical protein +FIG00948356 FIG00948357: hypothetical protein +FIG00948362 FIG00948363: hypothetical protein +FIG00948363 FIG00948366: hypothetical protein +FIG00948366 FIG00948368: hypothetical protein +FIG00948368 FIG00948370: hypothetical protein +FIG00948370 FIG00948371: hypothetical protein +FIG00948372 FIG00948373: hypothetical protein +FIG00948375 mut/nudix family protein +FIG00948378 FIG00948380: hypothetical protein +FIG00948383 FIG00948388: hypothetical protein +FIG00948390 FIG00948391: hypothetical protein +FIG00948391 FIG00948392: hypothetical protein +FIG00948393 FIG00948395: hypothetical protein +FIG00948395 FIG00948399: hypothetical protein +FIG00948401 FIG00948403: hypothetical protein +FIG00948404 FIG00948405: hypothetical protein +FIG00948406 FIG00948411: hypothetical protein +FIG00948416 FIG00948418: hypothetical protein +FIG00948418 FIG00948419: hypothetical protein +FIG00948422 FIG00948423: hypothetical protein +FIG00948426 putative membrane anion transport protein +FIG00948429 FIG00948430: hypothetical protein +FIG00948433 FIG00948434: hypothetical protein +FIG00948441 FIG00948442: hypothetical protein +FIG00948442 FIG00948445: hypothetical protein +FIG00948454 FIG00948457: hypothetical protein +FIG00948458 FIG00948461: hypothetical protein +FIG00948469 FIG00948470: hypothetical protein +FIG00948470 FIG00948471: hypothetical protein +FIG00948473 FIG00948474: hypothetical protein +FIG00948477 Putative cytochrome d ubiquinol oxidase subunit III (EC 1.10.3.-) (Cytochrome bd-I oxidase subunit III) +FIG00948480 FIG00948482: hypothetical protein +FIG00948482 FIG00948485: hypothetical protein +FIG00948485 FIG00948486: hypothetical protein +FIG00948486 putative tail protein +FIG00948491 FIG00948494: hypothetical protein +FIG00948494 Type III secretion outermembrane contact sensing protein( yopN,Yop4b,LcrE) +FIG00948496 FIG00948497: hypothetical protein +FIG00948497 FIG00948498: hypothetical protein +FIG00948498 FIG00948499: hypothetical protein +FIG00948502 FIG00948504: hypothetical protein +FIG00948504 Aerobic-type carbon monoxide dehydrogenase, small subunit CoxS/CutS homologs +FIG00948509 FIG00948510: hypothetical protein +FIG00948512 FIG00948514: hypothetical protein +FIG00948514 FIG00948515: hypothetical protein +FIG00948517 Putative ribokinase +FIG00948522 Putative permease +FIG00948524 FIG00948527: hypothetical protein +FIG00948527 12 +FIG00948528 FIG00948529: hypothetical protein +FIG00948532 FIG00948535: hypothetical protein +FIG00948535 Ferrous iron transport periplasmic protein EfeO +FIG00948536 probable exported protein YPO1779 +FIG00948539 Extracellular metalloprotease precursor (EC 3.4.24.-) +FIG00948541 Protein yceI precursor +FIG00948547 FIG00948548: hypothetical protein +FIG00948548 FIG00948551: hypothetical protein +FIG00948554 FIG00948555: hypothetical protein +FIG00948555 Gene D protein +FIG00948562 corresponds to STY3950 from Accession AL513382: Salmonella typhi CT18 +FIG00948577 FIG00948578: hypothetical protein +FIG00948578 FIG00948579: hypothetical protein +FIG00948579 Acetate operon repressor +FIG00948585 FIG00948586: hypothetical protein +FIG00948589 type III secretion sytem protein +FIG00948593 ABC transporter permease protein yhhJ +FIG00948595 Putative anti-sigma B factor antagonist +FIG00948598 heat resistant agglutinin 1 +FIG00948605 FIG00948606: hypothetical protein +FIG00948608 FIG00948609: hypothetical protein +FIG00948612 OsmC/Ohr family protein +FIG00948620 FIG00948621: hypothetical protein +FIG00948621 FIG00948625: hypothetical protein +FIG00948626 FIG00948631: hypothetical protein +FIG00948632 FIG00948633: hypothetical protein +FIG00948639 putative sensory transduction regulator +FIG00948642 FIG00948643: hypothetical protein +FIG00948645 FIG00948646: hypothetical protein +FIG00948652 FIG00948653: hypothetical protein +FIG00948653 FIG00948654: hypothetical protein +FIG00948658 FIG00948659: hypothetical protein +FIG00948662 putative protein PaaI, possibly involved in aromatic compounds catabolism +FIG00948664 RTX toxin transporter +FIG00948667 FIG00948671: hypothetical protein +FIG00948671 FIG00948672: hypothetical protein +FIG00948675 FIG00948676: hypothetical protein +FIG00948686 FIG00948688: hypothetical protein +FIG00948692 FIG00948693: hypothetical protein +FIG00948693 short-chain dehydrogenase/reductase SDR clustered with dienelactone hydrolase +FIG00948694 FIG00948695: hypothetical protein +FIG00948702 UmoD +FIG00948709 FIG00948711: hypothetical protein +FIG00948711 FIG00948712: hypothetical protein +FIG00948712 FIG00948713: hypothetical protein +FIG00948713 FIG00948714: hypothetical protein +FIG00948714 FIG00948715: hypothetical protein +FIG00948715 FIG00948716: hypothetical protein +FIG00948718 FIG00948720: hypothetical protein +FIG00948724 FIG00948726: hypothetical protein +FIG00948735 FIG00948737: hypothetical protein +FIG00948742 FIG00948743: hypothetical protein +FIG00948746 SefH +FIG00948748 FIG00948749: hypothetical protein +FIG00948754 Cupin 2 protein +FIG00948759 FIG00948760: hypothetical protein +FIG00948766 Exported zinc metalloprotease YfgC precursor +FIG00948768 FIG00948769: hypothetical protein +FIG00948769 FIG00948772: hypothetical protein +FIG00948778 FIG00948779: hypothetical protein +FIG00948780 FIG00948781: hypothetical protein +FIG00948781 FIG00948782: hypothetical protein +FIG00948783 FIG00948790: hypothetical protein +FIG00948790 COG3188: P pilus assembly protein, porin PapC +FIG00948793 Mg/Co/Ni transporter MgtE / CBS domain +FIG00948803 FIG00948804: hypothetical protein +FIG00948804 Protein ygiW precursor +FIG00948806 FIG00948807: hypothetical protein +FIG00948812 Probable transport protein YifK +FIG00948813 FIG00948814: hypothetical protein +FIG00948816 FIG00948817: hypothetical protein +FIG00948818 FIG00948819: hypothetical protein +FIG00948824 FIG00948825: hypothetical protein +FIG00948827 FIG00948828: hypothetical protein +FIG00948829 FIG00948833: hypothetical protein +FIG00948833 FIG00948834: hypothetical protein +FIG00948851 putative L-xylulose kinase +FIG00948853 FIG00948854: hypothetical protein +FIG00948854 FIG00948855: hypothetical protein +FIG00948856 Long-chain fatty acid transport protein +FIG00948863 FIG00948866: hypothetical protein +FIG00948869 FIG00948871: hypothetical protein +FIG00948871 FIG00948872: hypothetical protein +FIG00948872 carboxylesterase( EC:3.1.1.1 ) +FIG00948874 FIG00948875: hypothetical protein +FIG00948876 FIG00948877: hypothetical protein +FIG00948877 putative oxygenase subunit +FIG00948878 FIG00948879: hypothetical protein +FIG00948879 FIG00948881: hypothetical protein +FIG00948881 Heat shock protein hslJ +FIG00948882 FIG00948883: hypothetical protein +FIG00948883 probable exported protein YPO0301 +FIG00948884 O-methyltransferase, family 2 +FIG00948886 FIG00948887: hypothetical protein +FIG00948887 FIG00948889: hypothetical protein +FIG00948889 FIG00948891: hypothetical protein +FIG00948891 FIG00948892: hypothetical protein +FIG00948892 FIG00948894: hypothetical protein +FIG00948896 FIG00948897: hypothetical protein +FIG00948897 FIG00948898: hypothetical protein +FIG00948898 FIG00948899: hypothetical protein +FIG00948899 Transcriptional repressor for pyruvate dehydrogenase complex +FIG00948902 FIG00948903: hypothetical protein +FIG00948907 FIG00948910: hypothetical protein +FIG00948911 putative fimbrial chaperone protein +FIG00948913 FIG00948914: hypothetical protein +FIG00948922 Quaternary ammonium compound-resistance protein SugE +FIG00948928 FIG00948930: hypothetical protein +FIG00948930 FIG00948932: hypothetical protein +FIG00948938 FIG00948940: hypothetical protein +FIG00948940 FIG00948941: hypothetical protein +FIG00948946 FIG00948947: hypothetical protein +FIG00948954 FIG00948954: hypothetical protein YciN +FIG00948959 FIG00948961: hypothetical protein +FIG00948961 FIG00948962: hypothetical protein +FIG00948962 Unknown, probable transporter +FIG00948970 1,4-dihydroxy-2-naphthoyl-CoA hydrolase (EC 3.1.2.28) in menaquinone biosynthesis +FIG00948977 FIG00948978: hypothetical protein +FIG00948978 FIG00948979: hypothetical protein +FIG00948980 FIG00948981: hypothetical protein +FIG00948984 FIG00948985: hypothetical protein +FIG00948986 FIG00948987: hypothetical protein +FIG00948988 FIG00948990: hypothetical protein +FIG00948990 FIG00948992: hypothetical protein +FIG00948992 11 +FIG00948993 FIG00948994: hypothetical protein +FIG00948994 FIG00948997: hypothetical protein +FIG00948997 Putative ribonuclease inhibitor +FIG00949018 FIG00949019: hypothetical protein +FIG00949021 FIG00949022: hypothetical protein +FIG00949022 FIG00949023: hypothetical protein +FIG00949027 FIG00949033: hypothetical protein +FIG00949041 FIG00949044: hypothetical protein +FIG00949044 FIG00949045: hypothetical protein +FIG00949045 FIG00949046: hypothetical protein +FIG00949046 FIG00949047: hypothetical protein +FIG00949047 FIG00949049: hypothetical protein +FIG00949052 FIG00949053: hypothetical protein +FIG00949053 UPF0325 protein YaeH +FIG00949054 FIG00949057: hypothetical protein +FIG00949058 Type III secretion inner membrane protein (YscR,SpaR,HrcR,EscR,homologous to flagellar export components); Surface presentation of antigens protein SpaP +FIG00949063 FIG00949064: hypothetical protein +FIG00949064 FIG00949067: hypothetical protein +FIG00949067 FIG00949068: hypothetical protein +FIG00949068 FIG00949069: hypothetical protein +FIG00949071 FIG00949072: hypothetical protein +FIG00949072 COG1757: Na+/H+ antiporter +FIG00949079 GENE II AND X PROTEINS +FIG00949080 FIG00949084: hypothetical protein +FIG00949089 FIG00949090: hypothetical protein +FIG00949092 FIG00949094: hypothetical protein +FIG00949097 COG1555: DNA uptake protein and related DNA-binding proteins +FIG00949098 FIG00949099: hypothetical protein +FIG00949099 FIG00949101: hypothetical protein +FIG00949104 Putative sugar phosphotransferase component II B +FIG00949107 FIG00949111: hypothetical protein +FIG00949119 FIG00949120: hypothetical protein +FIG00949121 Macrodomain Ter protein YcbG +FIG00949123 FIG00949124: hypothetical protein +FIG00949126 FIG00949127: hypothetical protein +FIG00949128 FIG00949129: hypothetical protein +FIG00949129 FIG00949131: hypothetical protein +FIG00949131 FIG00949133: hypothetical protein +FIG00949133 FIG00949134: hypothetical protein +FIG00949135 FIG00949136: hypothetical protein +FIG00949136 MrpJ protein +FIG00949142 Putative protease +FIG00949145 FIG00949147: hypothetical protein +FIG00949147 FIG00949150: hypothetical protein +FIG00949153 FIG00949154: hypothetical protein +FIG00949155 FIG00949156: hypothetical protein +FIG00949156 FIG00949157: hypothetical protein +FIG00949162 Putative transcription factor +FIG00949169 FIG00949170: hypothetical protein +FIG00949170 FIG00949172: hypothetical protein +FIG00949178 Invasion protein invF +FIG00949183 FIG00949185: hypothetical protein +FIG00949185 FIG00949186: hypothetical protein +FIG00949188 FIG00949189: hypothetical protein +FIG00949190 FIG00949192: hypothetical protein +FIG00949193 alginate biosynthetic membrane +FIG00949194 FIG00949195: hypothetical protein +FIG00949196 FIG00949198: hypothetical protein +FIG00949204 Negative regulator of flagellin synthesis flgM +FIG00949205 FIG00949206: hypothetical protein +FIG00949208 FIG00949209: hypothetical protein +FIG00949221 FIG00949222: hypothetical protein +FIG00949240 FIG00949244: hypothetical protein +FIG00949252 Putative response regulator +FIG00949264 FIG00949265: hypothetical protein +FIG00949265 FIG00949267: hypothetical protein +FIG00949274 FIG00949275: hypothetical protein +FIG00949275 FIG00949277: hypothetical protein +FIG00949277 FIG00949278: hypothetical protein +FIG00949290 FIG00949291: hypothetical protein +FIG00949291 COG0100: Ribosomal protein S11 +FIG00949297 FIG00949300: hypothetical protein +FIG00949308 FIG00949309: hypothetical protein +FIG00949310 Orf42 +FIG00949311 FIG00949312: hypothetical protein +FIG00949313 putative hexulose-6-phosphate isomerase +FIG00949315 FIG00949317: hypothetical protein +FIG00949321 FIG00949322: hypothetical protein +FIG00949322 FIG00949323: hypothetical protein +FIG00949323 FIG00949325: hypothetical protein +FIG00949325 FIG00949326: hypothetical protein +FIG00949329 13 +FIG00949333 FIG00949334: hypothetical protein +FIG00949335 FIG00949336: hypothetical protein +FIG00949336 FIG00949337: hypothetical protein +FIG00949338 FIG00949340: hypothetical protein +FIG00949340 FIG00949341: hypothetical protein +FIG00949342 FIG00949343: hypothetical protein +FIG00949344 FIG00949347: hypothetical protein +FIG00949350 putative receptor protein +FIG00949351 FIG00949354: hypothetical protein +FIG00949356 Fimbrial chaperone protein precursor +FIG00949363 FIG00949364: hypothetical protein +FIG00949364 FIG00949365: hypothetical protein +FIG00949365 FIG00949366: hypothetical protein +FIG00949366 MrfB +FIG00949373 FIG00949376: hypothetical protein +FIG00949376 FIG00949378: hypothetical protein +FIG00949378 putative orphan protein; putative beta-lactamase-like domain; putative signal peptide +FIG00949399 FIG00949403: hypothetical protein +FIG00949419 FIG00949423: hypothetical protein +FIG00949433 FIG00949435: hypothetical protein +FIG00949457 FIG00949458: hypothetical protein +FIG00949460 FIG00949461: hypothetical protein +FIG00949471 FIG00949473: hypothetical protein +FIG00949478 Chloride channel protein EriC +FIG00949517 FIG00949519: hypothetical protein +FIG00949531 FIG00949534: hypothetical protein +FIG00949541 FIG00949548: hypothetical protein +FIG00949564 FIG00949568: hypothetical protein +FIG00949579 FIG00949581: hypothetical protein +FIG00949582 FIG00949583: hypothetical protein +FIG00949586 FIG00949588: hypothetical protein +FIG00949590 putative Glutamate carboxypeptidase II +FIG00949656 FIG00949658: hypothetical protein +FIG00949658 FIG00949669: hypothetical protein +FIG00949693 conserved protein of unknown function; putative thioesterase superfamily +FIG00949696 FIG00949703: hypothetical protein +FIG00949710 FIG00949717: hypothetical protein +FIG00949728 FIG00949734: hypothetical protein +FIG00949749 FIG00949750: hypothetical protein +FIG00949770 FIG00949772: hypothetical protein +FIG00949803 FIG00949804: hypothetical protein +FIG00949808 FIG00949823: hypothetical protein +FIG00949826 FIG00949827: hypothetical protein +FIG00949832 FIG00949836: hypothetical protein +FIG00949856 FIG00949857: hypothetical protein +FIG00949857 putative orphan protein; putative signal peptide +FIG00949874 FIG00949877: hypothetical protein +FIG00949896 protein of unknown function DUF1272 +FIG00949962 protein of unknown function DUF490 +FIG00949965 FIG00949969: hypothetical protein +FIG00949975 FIG00949978: hypothetical protein +FIG00949978 FIG00949980: hypothetical protein +FIG00949995 protein of unknown function DUF1566 +FIG00950006 Rhombosortase +FIG00950017 FIG00950018: hypothetical protein +FIG00950053 FIG00950058: hypothetical protein +FIG00950058 Tryptophan 2-monooxygenase VioA in violacein biosynthesis (EC 1.13.12.3) +FIG00950091 FIG00950097: hypothetical protein +FIG00950097 FIG00950104: hypothetical protein +FIG00950105 FIG00950107: hypothetical protein +FIG00950124 FIG00950135: hypothetical protein +FIG00950165 Cold-active aminopeptidase (Neutral zinc metallopeptidase, M1 family) (EC 3.4.11.-) +FIG00950227 GreA/GreB family elongation factor +FIG00950230 FIG00950240: hypothetical protein +FIG00950261 Inter-alpha-trypsin inhibitor domain protein +FIG00950300 FIG00950313: hypothetical protein +FIG00950326 Dipeptidyl-peptidase IV +FIG00950355 FIG00950362: hypothetical protein +FIG00950379 FIG00950380: hypothetical protein +FIG00950380 Alginate biosynthesis regulatory protein AlgR +FIG00950386 FIG023103: Predicted transmembrane protein +FIG00950415 FIG00950425: hypothetical protein +FIG00950432 FIG00950436: hypothetical protein +FIG00950440 putative phage shock protein C +FIG00950457 putative flagellar biosynthesis chaperone +FIG00950486 FIG00950489: hypothetical protein +FIG00950489 FIG00950503: hypothetical protein +FIG00950504 uncharacterized conserved secreted protein +FIG00950514 conserved protein of unknown function; putative competence protein +FIG00950533 FIG00950535: hypothetical protein +FIG00950581 FIG00950584: hypothetical protein +FIG00950695 FIG00950698: hypothetical protein +FIG00950698 Probable capsid portal protein +FIG00950710 putative ATP-binding component of ABC transport system +FIG00950732 FIG00950733: hypothetical protein +FIG00950751 putative Sensory box protein +FIG00950772 FIG00950774: hypothetical protein +FIG00950805 FIG00950806: hypothetical protein +FIG00950808 FIG00950809: hypothetical protein +FIG00950824 pantothenate permease (panF-2) +FIG00950825 FIG00950834: hypothetical protein +FIG00950834 FIG00950837: hypothetical protein +FIG00950837 FIG00950839: hypothetical protein +FIG00950845 FIG00950851: hypothetical protein +FIG00950870 FIG00950874: hypothetical protein +FIG00950902 FIG00950903: hypothetical protein +FIG00950903 FIG00950909: hypothetical protein +FIG00950909 predicted S-adenosylmethionine-dependent tRNA (guanine-N(7)-)-methyltransferase +FIG00950936 fusaric acid resistance domain protein +FIG00950937 FIG00950939: hypothetical protein +FIG00951064 putative ABC-type Na+ efflux pump, permease component +FIG00951080 FIG00951087: hypothetical protein +FIG00951194 FIG00951196: hypothetical protein +FIG00951216 FIG00951217: hypothetical protein +FIG00951262 FIG00951267: hypothetical protein +FIG00951303 FIG00951305: hypothetical protein +FIG00951305 Protease, insulinase family +FIG00951329 Aminopeptidase N family protein, contains PDZ domain +FIG00951376 Ser/Thr protein phosphatase family protein, calcineurin-like superfamily +FIG00951388 Acetylspermidine deacetylase (EC 3.5.1.48) +FIG00951402 conserved protein of unknown function; putative SpoOM-related protein +FIG00951414 FIG00951417: hypothetical protein +FIG00951423 FIG00951427: hypothetical protein +FIG00951430 FIG00951432: hypothetical protein +FIG00951462 Flavin monoamine oxidase-related protein +FIG00951489 FIG00640421: hypothetical protein +FIG00951499 FIG00951502: hypothetical protein +FIG00951538 FIG00951543: hypothetical protein +FIG00951549 FIG00951553: hypothetical protein +FIG00951568 FIG00951569: hypothetical protein +FIG00951582 FIG00951586: hypothetical protein +FIG00951636 FIG00951646: hypothetical protein +FIG00951677 putative metal-dependent phosphohydrolase, HD region +FIG00951681 FIG00951686: hypothetical protein +FIG00951686 putative membrane protein with ankyrin repeat +FIG00951692 FIG00951695: hypothetical protein +FIG00951756 FIG00951757: hypothetical protein +FIG00951788 FIG00951794: hypothetical protein +FIG00951796 predicted flavoprotein +FIG00951804 FIG00951809: hypothetical protein +FIG00951835 putative transcriptional regulator LysR family +FIG00951857 FIG00951861: hypothetical protein +FIG00951863 FIG00951866: hypothetical protein +FIG00951869 FIG00951871: hypothetical protein +FIG00951887 putative transcriptional regulator arsR family +FIG00951894 FIG00951899: hypothetical protein +FIG00951924 FIG00951925: hypothetical protein +FIG00951976 FIG00951979: hypothetical protein +FIG00952049 Gll4071 protein +FIG00952062 putative metal-dependent dipeptidase +FIG00952097 Extracellular matrix protein PelF, glycosyltransferase, group 1 +FIG00952102 FIG00952117: hypothetical protein +FIG00952169 putative potassium channel +FIG00952173 FIG00952179: hypothetical protein +FIG00952210 FIG00952219: hypothetical protein +FIG00952219 Glyoxalase/bleomycin resistance protein/dioxygenase precursor +FIG00952222 GGDEF FAMILY PROTEIN +FIG00952240 putative transport protein (MFS family) +FIG00952247 Predicted hydrolase/acyltransferase +FIG00952260 FIG00952262: hypothetical protein +FIG00952262 FIG00952265: hypothetical protein +FIG00952269 FIG00952272: hypothetical protein +FIG00952295 FIG00952298: hypothetical protein +FIG00952298 FIG00952301: hypothetical protein +FIG00952318 FIG00952325: hypothetical protein +FIG00952343 FIG00952345: hypothetical protein +FIG00952390 FIG00952397: hypothetical protein +FIG00952403 FIG00952406: hypothetical protein +FIG00952435 FIG00952436: hypothetical protein +FIG00952490 FIG00952493: hypothetical protein +FIG00952543 FIG00952544: hypothetical protein +FIG00952548 FIG00952551: hypothetical protein +FIG00952585 spermine/spermidine synthase family protein +FIG00952593 conserved protein of unknown function; putative inner membrane protein +FIG00952595 FIG00952605: hypothetical protein +FIG00952620 FIG00952622: hypothetical protein +FIG00952633 FIG00952634: hypothetical protein +FIG00952654 putative ThiS protein +FIG00952705 FIG00952727: hypothetical protein +FIG00952733 hypothetical protein; membrane protein +FIG00952763 Zn-dependent dipeptidase +FIG00952839 RNA polymerase sigma-70 factor, ECF subfamily +FIG00952868 FIG00952874: hypothetical protein +FIG00952911 Sensory box sensor/GGDEF/EAL domain protein +FIG00952966 FIG00952967: hypothetical protein +FIG00953059 FIG00953060: hypothetical protein +FIG00953060 FIG00953062: hypothetical protein +FIG00953062 FIG00953063: hypothetical protein +FIG00953063 FIG00953066: hypothetical protein +FIG00953068 Tannase +FIG00953073 FIG00953078: hypothetical protein +FIG00953078 FIG00953081: hypothetical protein +FIG00953081 O-acetylserine synthase +FIG00953086 polyamine ABC transporter, permease protein +FIG00953089 FIG00953091: hypothetical protein +FIG00953091 FIG00953092: hypothetical protein +FIG00953094 FIG00953095: hypothetical protein +FIG00953095 Cytochrome c556 +FIG00953096 FIG00953097: hypothetical protein +FIG00953097 Membrane proteins related to metalloendopeptidases +FIG00953100 FIG00953102: hypothetical protein +FIG00953106 FIG00953107: hypothetical protein +FIG00953107 FIG00953108: hypothetical protein +FIG00953109 FIG00953110: hypothetical protein +FIG00953110 FIG00953113: hypothetical protein +FIG00953113 FIG00953115: hypothetical protein +FIG00953118 FIG00953119: hypothetical protein +FIG00953119 FIG00953120: hypothetical protein +FIG00953124 FIG00953125: hypothetical protein +FIG00953125 FIG00953126: hypothetical protein +FIG00953131 FIG00953132: hypothetical protein +FIG00953133 FIG00953134: hypothetical protein +FIG00953134 sarcosine oxidase +FIG00953135 FIG00953137: hypothetical protein +FIG00953137 FIG00953138: hypothetical protein +FIG00953138 Aerotaxis receptor Aer +FIG00953139 Dodecin (COG3360) Flavin-binding +FIG00953140 FIG00953141: hypothetical protein +FIG00953143 Metal-dependent amidase/aminoacylase/carboxypeptidase +FIG00953144 FIG00953145: hypothetical protein +FIG00953150 FIG00953153: hypothetical protein +FIG00953156 Amino-acid ABC transporter +FIG00953161 FIG00953163: hypothetical protein +FIG00953166 FIG00953167: hypothetical protein +FIG00953167 FIG00953170: hypothetical protein +FIG00953170 FIG00953172: hypothetical protein +FIG00953172 FIG00953175: hypothetical protein +FIG00953182 FIG00953183: hypothetical protein +FIG00953184 FIG00953185: hypothetical protein +FIG00953191 FIG00953192: hypothetical protein +FIG00953192 FIG00953193: hypothetical protein +FIG00953194 Cell morphology protein +FIG00953195 FIG00953197: hypothetical protein +FIG00953197 FIG00953199: hypothetical protein +FIG00953199 FIG00953200: hypothetical protein +FIG00953200 FIG00953202: hypothetical protein +FIG00953204 FIG00953205: hypothetical protein +FIG00953206 FIG00953208: hypothetical protein +FIG00953208 FIG00953209: hypothetical protein +FIG00953209 FIG00953210: hypothetical protein +FIG00953210 FIG00953211: hypothetical protein +FIG00953215 negative regulator of hrp expression HrpV +FIG00953222 fimbrial protein, putative +FIG00953223 FIG00953225: hypothetical protein +FIG00953229 OmpA family protein +FIG00953230 FIG00953231: hypothetical protein +FIG00953232 cytochrome c-type protein +FIG00953233 FIG00953237: hypothetical protein +FIG00953237 Outer membrane usher protein FIMD +FIG00953239 FIG00953240: hypothetical protein +FIG00953240 FIG00953241: hypothetical protein +FIG00953241 FIG00953242: hypothetical protein +FIG00953242 FIG00953243: hypothetical protein +FIG00953243 elements of external origin; phage-related functions and prophages +FIG00953244 FIG00953246: hypothetical protein +FIG00953246 FIG00953247: hypothetical protein +FIG00953247 FIG00953248: hypothetical protein +FIG00953248 FIG00953249: hypothetical protein +FIG00953254 FIG00953257: hypothetical protein +FIG00953257 cis/trans isomerase +FIG00953269 FIG00953270: hypothetical protein +FIG00953272 FIG00953273: hypothetical protein +FIG00953273 FIG00953380: hypothetical protein +FIG00953280 Regulator of sigma D +FIG00953281 FIG00953282: hypothetical protein +FIG00953284 FIG00953286: hypothetical protein +FIG00953286 FIG00953287: hypothetical protein +FIG00953287 FIG00953288: hypothetical protein +FIG00953290 FIG00953292: hypothetical protein +FIG00953292 FIG00953296: hypothetical protein +FIG00953296 FIG00953298: hypothetical protein +FIG00953298 FIG00953300: hypothetical protein +FIG00953301 CHASE domain/PAS domain protein +FIG00953302 FIG00953303: hypothetical protein +FIG00953303 FIG00953307: hypothetical protein +FIG00953308 FIG00953309: hypothetical protein +FIG00953311 FIG00953314: hypothetical protein +FIG00953314 FIG00953317: hypothetical protein +FIG00953319 FIG00953321: hypothetical protein +FIG00953321 FIG00953322: hypothetical protein +FIG00953322 FIG00953323: hypothetical protein +FIG00953323 FIG00953324: hypothetical protein +FIG00953328 FIG00953329: hypothetical protein +FIG00953331 FIG00953333: hypothetical protein +FIG00953333 FIG00953334: hypothetical protein +FIG00953334 FIG00953335: hypothetical protein +FIG00953335 FIG00953337: hypothetical protein +FIG00953337 FIG00953340: hypothetical protein +FIG00953340 FIG00953341: hypothetical protein +FIG00953341 FIG00953342: hypothetical protein +FIG00953346 FIG00953347: hypothetical protein +FIG00953347 FIG00953348: hypothetical protein +FIG00953348 FIG00953349: hypothetical protein +FIG00953355 FIG00953356: hypothetical protein +FIG00953356 FIG032563: Phage tail protein D +FIG00953358 FIG00953360: hypothetical protein +FIG00953360 FIG00953361: hypothetical protein +FIG00953361 FIG00953362: hypothetical protein +FIG00953362 FIG00953365: hypothetical protein +FIG00953366 FIG00953367: hypothetical protein +FIG00953367 FIG00953368: hypothetical protein +FIG00953368 nikkomycin biosynthesis domain protein +FIG00953370 FIG00953371: hypothetical protein +FIG00953373 FIG00953374: hypothetical protein +FIG00953375 FIG00953377: hypothetical protein +FIG00953380 Cyanide insensitive terminal oxidase, putative subunit III +FIG00953384 FIG00953386: hypothetical protein +FIG00953389 FIG00953390: hypothetical protein +FIG00953393 FIG00953394: hypothetical protein +FIG00953394 FIG00953395: hypothetical protein +FIG00953398 Endonuclease I precursor (EC 3.1.21.1) +FIG00953400 FIG00953403: hypothetical protein +FIG00953403 FIG00953404: hypothetical protein +FIG00953404 FIG00953405: hypothetical protein +FIG00953406 FIG00953407: hypothetical protein +FIG00953407 MvaT-like transcriptional regulator +FIG00953408 FIG00953409: hypothetical protein +FIG00953410 FIG00953411: hypothetical protein +FIG00953415 FIG00953416: hypothetical protein +FIG00953416 GntR-family regulatory protein +FIG00953418 FIG00953419: hypothetical protein +FIG00953420 FIG00953421: hypothetical protein +FIG00953421 FIG00953422: hypothetical protein +FIG00953422 FIG00953423: hypothetical protein +FIG00953423 FIG00953424: hypothetical protein +FIG00953424 probable protein methyltransferase +FIG00953425 FIG00953426: hypothetical protein +FIG00953426 FIG00953428: hypothetical protein +FIG00953429 probable fimbrial protein +FIG00953431 FIG00953432: hypothetical protein +FIG00953436 FIG00953437: hypothetical protein +FIG00953438 FIG00953439: hypothetical protein +FIG00953439 FIG00953440: hypothetical protein +FIG00953444 FIG00953445: hypothetical protein +FIG00953447 Cointegrate resolution protein T +FIG00953453 FIG00953454: hypothetical protein +FIG00953454 FIG00953456: hypothetical protein +FIG00953456 FIG00953460: hypothetical protein +FIG00953466 FIG00953467: hypothetical protein +FIG00953467 Rhs family protein +FIG00953470 FIG00953472: hypothetical protein +FIG00953472 FIG00953473: hypothetical protein +FIG00953473 FIG00953474: hypothetical protein +FIG00953474 FIG00953475: hypothetical protein +FIG00953479 FIG00953480: hypothetical protein +FIG00953480 FIG00953482: hypothetical protein +FIG00953482 FIG00953485: hypothetical protein +FIG00953485 FIG00953486: hypothetical protein +FIG00953486 FIG00953487: hypothetical protein +FIG00953487 FIG00953488: hypothetical protein +FIG00953488 FIG00953489: hypothetical protein +FIG00953498 FIG00953500: hypothetical protein +FIG00953500 FIG00953501: hypothetical protein +FIG00953501 type III effector HopT1-1 +FIG00953504 FIG00953505: hypothetical protein +FIG00953506 FIG00953508: hypothetical protein +FIG00953508 FIG00953509: hypothetical protein +FIG00953509 transcriptional regulator PrtN, putative +FIG00953511 FIG00953512: hypothetical protein +FIG00953512 FIG00953513: hypothetical protein +FIG00953514 FIG00953517: hypothetical protein +FIG00953519 FIG00953520: hypothetical protein +FIG00953520 Extracellular Matrix protein PslA +FIG00953521 Probable hydrolase +FIG00953522 FIG00953523: hypothetical protein +FIG00953524 FIG00953525: hypothetical protein +FIG00953527 FIG00953528: hypothetical protein +FIG00953528 possible FusE-MFP/HlyD family membrane fusion protein +FIG00953531 FIG00953532: hypothetical protein +FIG00953532 Fap amyloid fiber secretin +FIG00953536 FIG00953537: hypothetical protein +FIG00953538 FIG00953539: hypothetical protein +FIG00953539 FIG00953540: hypothetical protein +FIG00953540 FIG00953542: hypothetical protein +FIG00953542 FIG00953543: hypothetical protein +FIG00953543 Antisigma transmembrane sensor FpvR +FIG00953544 FIG00953545: hypothetical protein +FIG00953545 FIG00953546: hypothetical protein +FIG00953546 Sensory box sensor histidine kinase/response regulator (EC 2.7.3.-) +FIG00953547 FIG00953549: hypothetical protein +FIG00953549 FIG00953551: hypothetical protein +FIG00953553 FIG00953562: hypothetical protein +FIG00953562 FIG00953563: hypothetical protein +FIG00953563 FIG00953564: hypothetical protein +FIG00953564 FIG00953566: hypothetical protein +FIG00953566 FIG00953567: hypothetical protein +FIG00953567 FIG00953568: hypothetical protein +FIG00953568 FIG00953569: hypothetical protein +FIG00953572 FIG00953574: hypothetical protein +FIG00953574 FIG00953575: hypothetical protein +FIG00953576 FIG00953578: hypothetical protein +FIG00953578 FIG00953579: hypothetical protein +FIG00953579 FIG00953580: hypothetical protein +FIG00953580 FIG00953582: hypothetical protein +FIG00953586 FIG00953587: hypothetical protein +FIG00953587 FIG00953588: hypothetical protein +FIG00953592 FIG00953594: hypothetical protein +FIG00953594 FIG00953595: hypothetical protein +FIG00953595 probable transmembrane sensor +FIG00953599 FIG00953600: hypothetical protein +FIG00953604 FIG00953606: hypothetical protein +FIG00953607 FIG00953609: hypothetical protein +FIG00953609 FIG01210404: hypothetical protein +FIG00953618 FIG00953621: hypothetical protein +FIG00953621 FIG00953627: hypothetical protein +FIG00953627 FIG00953628: hypothetical protein +FIG00953629 FIG00953630: hypothetical protein +FIG00953634 FIG00953635: hypothetical protein +FIG00953638 FIG00953641: hypothetical protein +FIG00953643 FIG00953646: hypothetical protein +FIG00953646 FIG00953647: hypothetical protein +FIG00953647 FIG00953648: hypothetical protein +FIG00953654 FIG00953656: hypothetical protein +FIG00953656 FIG00953657: hypothetical protein +FIG00953660 FIG00953661: hypothetical protein +FIG00953661 FIG00953662: hypothetical protein +FIG00953662 FIG00953664: hypothetical protein +FIG00953669 FIG00953670: hypothetical protein +FIG00953671 FIG00953674: hypothetical protein +FIG00953677 FIG00953680: hypothetical protein +FIG00953681 Efflux transporter, RND family, MFP subunit +FIG00953684 FIG01248689: hypothetical protein +FIG00953686 FIG00953687: hypothetical protein +FIG00953690 FIG00953691: hypothetical protein +FIG00953691 HAMP domain protein +FIG00953693 FIG00953695: hypothetical protein +FIG00953696 FIG00953697: hypothetical protein +FIG00953699 FIG00953701: hypothetical protein +FIG00953701 Signal transduction histidine kinase regulating C4-dicarboxylate transport system +FIG00953702 FIG00953703: hypothetical protein +FIG00953708 FIG00953710: hypothetical protein +FIG00953710 OXIDOREDUCTASE, ALDO/KETO REDUCTASE FAMILY +FIG00953715 FIG00953716: hypothetical protein +FIG00953716 glycosidase, putative +FIG00953717 FIG00953718: hypothetical protein +FIG00953721 FIG00953722: hypothetical protein +FIG00953722 D-isomer specific 2-hydroxyacid dehydrogenase family protein +FIG00953724 FIG00953725: hypothetical protein +FIG00953728 FIG00953729: hypothetical protein +FIG00953736 FIG00953737: hypothetical protein +FIG00953737 FIG00953738: hypothetical protein +FIG00953738 FIG00953739: hypothetical protein +FIG00953740 FIG00953743: hypothetical protein +FIG00953745 FIG00953747: hypothetical protein +FIG00953747 FIG00953750: hypothetical protein +FIG00953751 transcriptional regulator MvaT, P16 subunit +FIG00953756 FIG00953757: hypothetical protein +FIG00953757 Endonuclease/exonuclease/phosphatase family protein +FIG00953764 FIG00953767: hypothetical protein +FIG00953767 FIG00953768: hypothetical protein +FIG00953768 glycosyl hydrolase, family 15 +FIG00953773 FIG00953774: hypothetical protein +FIG00953774 FIG00953775: hypothetical protein +FIG00953776 FIG00953777: hypothetical protein +FIG00953778 FIG00953779: hypothetical protein +FIG00953779 FIG00953780: hypothetical protein +FIG00953781 FIG00953784: hypothetical protein +FIG00953789 FIG00953791: hypothetical protein +FIG00953793 FIG00953795: hypothetical protein +FIG00953796 FIG00953797: hypothetical protein +FIG00953798 FIG00953799: hypothetical protein +FIG00953799 FIG00953800: hypothetical protein +FIG00953800 FIG00953806: hypothetical protein +FIG00953807 FIG00953808: hypothetical protein +FIG00953811 FIG00953813: hypothetical protein +FIG00953816 FIG00953817: hypothetical protein +FIG00953817 FIG00953818: hypothetical protein +FIG00953818 FIG00953820: hypothetical protein +FIG00953822 FIG00953823: hypothetical protein +FIG00953823 FIG00953824: hypothetical protein +FIG00953826 FIG00953827: hypothetical protein +FIG00953827 FIG00953828: hypothetical protein +FIG00953838 FIG00953839: hypothetical protein +FIG00953839 FIG00953847: hypothetical protein +FIG00953849 Transcriptional regulator ahyR/asaR family +FIG00953852 FIG00953853: hypothetical protein +FIG00953853 FIG00953855: hypothetical protein +FIG00953855 FIG00953856: hypothetical protein +FIG00953856 UPF0076 protein slr0709 +FIG00953859 FIG00953860: hypothetical protein +FIG00953860 FIG00953861: hypothetical protein +FIG00953862 putative exoenzyme T +FIG00953863 FIG00953866: hypothetical protein +FIG00953866 FIG00953867: hypothetical protein +FIG00953867 type III effector HopAH1 +FIG00953873 FIG00953874: hypothetical protein +FIG00953874 FIG00953875: hypothetical protein +FIG00953882 FIG00953885: hypothetical protein +FIG00953885 FIG00953886: hypothetical protein +FIG00953886 Protein SlyX +FIG00953887 FIG00953889: hypothetical protein +FIG00953889 FIG00953890: hypothetical protein +FIG00953896 FIG00953897: hypothetical protein +FIG00953897 Sensory box histidine kinase +FIG00953904 FIG00953906: hypothetical protein +FIG00953906 FIG00953907: hypothetical protein +FIG00953907 FIG00953908: hypothetical protein +FIG00953912 FIG00953913: hypothetical protein +FIG00953914 UPF0033 protein YedF +FIG00953921 C4-dicarboxylate transport sensor protein +FIG00953922 FIG00953924: hypothetical protein +FIG00953924 FIG00953926: hypothetical protein +FIG00953926 FIG00953927: hypothetical protein +FIG00953927 FIG00953928: hypothetical protein +FIG00953928 FIG00953931: hypothetical protein +FIG00953931 FIG00953933: hypothetical protein +FIG00953933 FIG00953934: hypothetical protein +FIG00953934 FIG00953935: hypothetical protein +FIG00953938 FIG00953939: hypothetical protein +FIG00953939 FIG00953943: hypothetical protein +FIG00953943 Colicin immunity protein +FIG00953944 FIG00953945: hypothetical protein +FIG00953945 FIG00953946: hypothetical protein +FIG00953949 FIG00953950: hypothetical protein +FIG00953951 FIG00953952: hypothetical protein +FIG00953952 FIG00953953: hypothetical protein +FIG00953956 FIG00953957: hypothetical protein +FIG00953959 FIG00953960: hypothetical protein +FIG00953960 FIG00953961: hypothetical protein +FIG00953961 MadN protein +FIG00953964 FIG00953965: hypothetical protein +FIG00953965 FIG00953966: hypothetical protein +FIG00953970 FIG00958649: hypothetical protein +FIG00953974 FIG00953975: hypothetical protein +FIG00953975 Non-ribosomal peptide synthetase modules and related proteins +FIG00953979 FIG00953980: hypothetical protein +FIG00953986 putative secretion protein +FIG00953987 FIG00953991: hypothetical protein +FIG00953993 Type III effector HrpW, hairpin with pectate lyase domain +FIG00953995 FIG00953996: hypothetical protein +FIG00953999 Putative fimbrial chaperone +FIG00954001 FIG00954006: hypothetical protein +FIG00954023 FIG00954024: hypothetical protein +FIG00954024 FIG00954026: hypothetical protein +FIG00954026 FIG00954029: hypothetical protein +FIG00954029 FIG00954030: hypothetical protein +FIG00954030 FIG00954031: hypothetical protein +FIG00954031 Periplasmic protease +FIG00954033 Probable two-component response regulator +FIG00954035 Anti-sigma F factor antagonist (spoIIAA-2); Anti-sigma B factor antagonist RsbV +FIG00954039 MaoC-like domain protein +FIG00954042 probable exported protein YPO0432 +FIG00954043 FIG00954044: hypothetical protein +FIG00954044 FIG00954045: hypothetical protein +FIG00954045 FIG00954047: hypothetical protein +FIG00954050 FIG00954052: hypothetical protein +FIG00954052 MORN repeat family protein +FIG00954054 FIG00954056: hypothetical protein +FIG00954056 FIG00954057: hypothetical protein +FIG00954057 FIG00954061: hypothetical protein +FIG00954064 Transmembrane sensor +FIG00954067 Extracellular Matrix protein PslE +FIG00954069 FIG00954070: hypothetical protein +FIG00954070 FIG00954071: hypothetical protein +FIG00954072 FIG00954073: hypothetical protein +FIG00954073 FIG00954074: hypothetical protein +FIG00954078 FIG00954079: hypothetical protein +FIG00954081 FIG00954082: hypothetical protein +FIG00954082 FIG00954083: hypothetical protein +FIG00954083 FIG00954084: hypothetical protein +FIG00954087 probable sodium:sulfate symporter +FIG00954092 FIG00954093: hypothetical protein +FIG00954093 FIG00954094: hypothetical protein +FIG00954094 FIG00954095: hypothetical protein +FIG00954095 FIG00954096: hypothetical protein +FIG00954096 FIG00954097: hypothetical protein +FIG00954097 FIG00954098: hypothetical protein +FIG00954098 FIG00954099: hypothetical protein +FIG00954099 FIG00954105: hypothetical protein +FIG00954105 FIG00954106: hypothetical protein +FIG00954108 FIG00954109: hypothetical protein +FIG00954110 FIG00954111: hypothetical protein +FIG00954111 FIG00954112: hypothetical protein +FIG00954112 amino acid ABC transporter, periplasmic substrate-binding protein +FIG00954115 FIG00954117: hypothetical protein +FIG00954119 FIG00954121: hypothetical protein +FIG00954121 FIG00954130: hypothetical protein +FIG00954130 FIG00954133: hypothetical protein +FIG00954133 glycosyl transferase, group 1 family protein +FIG00954134 FIG00956655: hypothetical protein +FIG00954135 FIG00954136: hypothetical protein +FIG00954136 FIG00954138: hypothetical protein +FIG00954138 FIG00954142: hypothetical protein +FIG00954142 leucine-rich repeat domain protein +FIG00954144 FIG00954147: hypothetical protein +FIG00954147 FIG00954150: hypothetical protein +FIG00954151 FIG00954152: hypothetical protein +FIG00954152 FIG00954153: hypothetical protein +FIG00954153 FIG00954155: hypothetical protein +FIG00954156 Cold-shock DNA-binding domain +FIG00954158 FIG00954159: hypothetical protein +FIG00954160 FIG00954161: hypothetical protein +FIG00954161 FIG00954164: hypothetical protein +FIG00954167 FIG00954170: hypothetical protein +FIG00954172 FIG00954173: hypothetical protein +FIG00954176 Fap unknown function protein +FIG00954180 FIG00954181: hypothetical protein +FIG00954186 FIG00954187: hypothetical protein +FIG00954187 FIG00954188: hypothetical protein +FIG00954188 outer membrane porin OprE +FIG00954190 putative fimbrial major protein precursor +FIG00954194 FIG00954198: hypothetical protein +FIG00954199 Autotransporter +FIG00954206 FIG00954209: hypothetical protein +FIG00954209 FIG00954210: hypothetical protein +FIG00954210 FIG00954212: hypothetical protein +FIG00954212 FIG00954213: hypothetical protein +FIG00954213 FIG00954215: hypothetical protein +FIG00954215 FIG00954216: hypothetical protein +FIG00954222 FIG00954225: hypothetical protein +FIG00954225 FIG00954227: hypothetical protein +FIG00954228 FIG00954229: hypothetical protein +FIG00954237 FIG00954238: hypothetical protein +FIG00954240 FIG00954242: hypothetical protein +FIG00954242 Predicted protein-tyrosine phosphatase +FIG00954243 FIG00954244: hypothetical protein +FIG00954247 glycosyl hydrolase, family 3 +FIG00954252 FIG00954255: hypothetical protein +FIG00954260 FIG00954263: hypothetical protein +FIG00954263 FIG00954264: hypothetical protein +FIG00954264 FIG00954271: hypothetical protein +FIG00954271 FIG00954272: hypothetical protein +FIG00954272 FIG00954274: hypothetical protein +FIG00954274 Extracellular Matrix protein PslG +FIG00954287 FIG00954289: hypothetical protein +FIG00954290 FIG00954291: hypothetical protein +FIG00954291 FIG00954293: hypothetical protein +FIG00954294 FIG00954296: hypothetical protein +FIG00954296 FIG00954300: hypothetical protein +FIG00954300 FIG00954302: hypothetical protein +FIG00954310 FIG00954311: hypothetical protein +FIG00954311 FIG00954317: hypothetical protein +FIG00954319 FIG00954320: hypothetical protein +FIG00954323 FIG00954325: hypothetical protein +FIG00954327 FIG00954329: hypothetical protein +FIG00954332 FIG00954333: hypothetical protein +FIG00954333 FIG00954335: hypothetical protein +FIG00954335 FIG00954336: hypothetical protein +FIG00954341 FIG00954344: hypothetical protein +FIG00954345 FIG00954348: hypothetical protein +FIG00954348 PilL protein +FIG00954352 two-component system sensor protein +FIG00954353 pyocin R2_PP, tail fiber protein, putative +FIG00954355 FIG00954356: hypothetical protein +FIG00954358 FIG00954361: hypothetical protein +FIG00954361 FIG00954362: hypothetical protein +FIG00954362 FIG00954364: hypothetical protein +FIG00954366 FIG00954367: hypothetical protein +FIG00954367 3-oxoacyl-[acyl-carrier protein] reductase( EC:1.- ) +FIG00954368 FIG00954373: hypothetical protein +FIG00954375 FIG00954377: hypothetical protein +FIG00954381 FIG00954383: hypothetical protein +FIG00954383 FIG00954384: hypothetical protein +FIG00954387 FIG00954390: hypothetical protein +FIG00954392 FIG00954395: hypothetical protein +FIG00954400 FIG00954404: hypothetical protein +FIG00954404 FIG00954405: hypothetical protein +FIG00954405 Fap system putative outer membrane protein +FIG00954411 FIG00954412: hypothetical protein +FIG00954412 ABC-type protease exporter, outer membrane component PrtF/AprF +FIG00954413 FIG00954415: hypothetical protein +FIG00954415 FIG00954416: hypothetical protein +FIG00954416 FIG00954417: hypothetical protein +FIG00954417 FIG00954420: hypothetical protein +FIG00954420 FIG00954421: hypothetical protein +FIG00954421 FIG00954422: hypothetical protein +FIG00954428 FIG00954429: hypothetical protein +FIG00954429 FIG00954430: hypothetical protein +FIG00954430 FIG00954433: hypothetical protein +FIG00954433 FIG00954434: hypothetical protein +FIG00954436 FIG00954439: hypothetical protein +FIG00954440 Extracellular Matrix protein PslK +FIG00954445 FIG00954446: hypothetical protein +FIG00954446 FIG00954449: hypothetical protein +FIG00954450 FIG00954451: hypothetical protein +FIG00954454 FIG00954455: hypothetical protein +FIG00954455 FIG00954456: hypothetical protein +FIG00954457 FIG00954458: hypothetical protein +FIG00954459 FIG00954460: hypothetical protein +FIG00954460 FIG00954461: hypothetical protein +FIG00954463 FIG00954464: hypothetical protein +FIG00954464 FIG00954465: hypothetical protein +FIG00954465 diguanylate cyclase/phosphodiesterase (GGDEF & EAL domains) with PAS/PAC sensor(s) +FIG00954466 FIG00954467: hypothetical protein +FIG00954467 FIG00954469: hypothetical protein +FIG00954470 FIG00954474: hypothetical protein +FIG00954477 FIG00954480: hypothetical protein +FIG00954490 FIG00954491: hypothetical protein +FIG00954491 bmp family protein +FIG00954493 FIG00954495: hypothetical protein +FIG00954495 FIG00954496: hypothetical protein +FIG00954496 Domain of unknown function DUF1537 +FIG00954498 FIG00954501: hypothetical protein +FIG00954503 FIG00954504: hypothetical protein +FIG00954509 FIG00954510: hypothetical protein +FIG00954510 Nucleoid-associated protein +FIG00954514 FIG00954516: hypothetical protein +FIG00954527 FIG00954529: hypothetical protein +FIG00954530 FIG00954531: hypothetical protein +FIG00954531 FIG00954535: hypothetical protein +FIG00954535 FIG00954537: hypothetical protein +FIG00954539 probable glucosyl transferase +FIG00954543 probable permease of ABC transporter +FIG00954546 FIG00954548: hypothetical protein +FIG00954548 FIG00954549: hypothetical protein +FIG00954549 FIG003551: hypothetical protein +FIG00954551 FIG00954552: hypothetical protein +FIG00954554 FIG00954555: hypothetical protein +FIG00954555 FIG00954557: hypothetical protein +FIG00954557 FIG00954558: hypothetical protein +FIG00954558 FIG00954559: hypothetical protein +FIG00954559 FIG00954561: hypothetical protein +FIG00954561 FIG00954562: hypothetical protein +FIG00954562 FIG00954563: hypothetical protein +FIG00954563 FIG00954566: hypothetical protein +FIG00954570 FIG00954572: hypothetical protein +FIG00954572 Glycine betaine/L-proline ABC transporter, periplasmic substrate- binding protein +FIG00954578 FIG00954580: hypothetical protein +FIG00954580 FIG00954581: hypothetical protein +FIG00954582 Bll7991 protein +FIG00954584 FIG00954585: hypothetical protein +FIG00954585 FIG00954587: hypothetical protein +FIG00954587 FIG00954589: hypothetical protein +FIG00954589 Transcriptional regulator MexR +FIG00954594 FIG00954596: hypothetical protein +FIG00954606 FIG00954608: hypothetical protein +FIG00954608 Oxidoreductase, 2-nitropropane dioxygenase family +FIG00954612 FIG00857858: hypothetical protein +FIG00954613 FIG00954614: hypothetical protein +FIG00954614 FIG00954616: hypothetical protein +FIG00954616 FIG00954617: hypothetical protein +FIG00954618 TonB-dependent receptor, in a cluster with 3-phytase +FIG00954621 FIG00954624: hypothetical protein +FIG00954624 FIG00954626: hypothetical protein +FIG00954626 FIG00954627: hypothetical protein +FIG00954627 Coproporphyrinogen III oxidase and related Fe-S oxidoreductases +FIG00954628 FIG00954630: hypothetical protein +FIG00954630 FIG00954631: hypothetical protein +FIG00954632 FIG00954633: hypothetical protein +FIG00954633 FIG00954634: hypothetical protein +FIG00954634 FIG00954636: hypothetical protein +FIG00954636 FIG00954638: hypothetical protein +FIG00954638 probable transcriptional regulator +FIG00954639 Cytochrome c Snr1 +FIG00954640 FIG00954641: hypothetical protein +FIG00954642 FIG00954648: hypothetical protein +FIG00954648 FIG00954652: hypothetical protein +FIG00954654 FIG00954655: hypothetical protein +FIG00954655 FIG00954657: hypothetical protein +FIG00954660 FIG00954661: hypothetical protein +FIG00954661 FIG00954662: hypothetical protein +FIG00954664 FIG00954665: hypothetical protein +FIG00954667 FIG00954670: hypothetical protein +FIG00954670 FIG00954671: hypothetical protein +FIG00954673 FIG00954674: hypothetical protein +FIG00954678 FIG00954680: hypothetical protein +FIG00954680 FIG00954682: hypothetical protein +FIG00954682 Putative pilus chaperone, PapD family +FIG00954686 FIG00954687: hypothetical protein +FIG00954687 FIG00954689: hypothetical protein +FIG00954689 FIG00954690: hypothetical protein +FIG00954693 FIG00954694: hypothetical protein +FIG00954696 FIG00954698: hypothetical protein +FIG00954698 FIG00954700: hypothetical protein +FIG00954705 FIG00954706: hypothetical protein +FIG00954707 FIG00954708: hypothetical protein +FIG00954708 polyketide synthase +FIG00954711 FIG00954712: hypothetical protein +FIG00954712 FIG00954714: hypothetical protein +FIG00954722 FIG00954723: hypothetical protein +FIG00954724 Thermonuclease family protein +FIG00954732 FIG00954733: hypothetical protein +FIG00954733 FIG00954739: hypothetical protein +FIG00954739 FIG00954746: hypothetical protein +FIG00954751 FIG00954754: hypothetical protein +FIG00954754 FIG00954755: hypothetical protein +FIG00954756 FIG00954758: hypothetical protein +FIG00954759 FIG00954760: hypothetical protein +FIG00954761 FIG00954766: hypothetical protein +FIG00954766 FIG00954767: hypothetical protein +FIG00954767 FIG00954771: hypothetical protein +FIG00954771 FIG00954773: hypothetical protein +FIG00954773 FIG014328: hypothetical protein +FIG00954775 Two-component response regulator PfeR, enterobactin +FIG00954777 Aconitase B +FIG00954783 FIG00954784: hypothetical protein +FIG00954785 FIG00954787: hypothetical protein +FIG00954792 FIG00954793: hypothetical protein +FIG00954793 FIG00954794: hypothetical protein +FIG00954794 FIG00954795: hypothetical protein +FIG00954795 FIG00954796: hypothetical protein +FIG00954796 FIG00954798: hypothetical protein +FIG00954798 FIG00954800: hypothetical protein +FIG00954800 FIG00954803: hypothetical protein +FIG00954803 Signal transduction histidine kinase regulating C4-dicarboxylate transport system (EC 2.7.13.3) +FIG00954806 FIG00954807: hypothetical protein +FIG00954809 Efflux protein, LysE family +FIG00954812 FIG00954813: hypothetical protein +FIG00954813 FIG00954814: hypothetical protein +FIG00954818 FIG00954819: hypothetical protein +FIG00954820 FIG00954821: hypothetical protein +FIG00954837 FIG00954838: hypothetical protein +FIG00954841 FIG00954843: hypothetical protein +FIG00954843 FIG00954844: hypothetical protein +FIG00954844 FIG00954845: hypothetical protein +FIG00954845 mannuronan C-5-epimerase, putative +FIG00954847 FIG00954850: hypothetical protein +FIG00954850 FIG00954852: hypothetical protein +FIG00954852 FIG00954854: hypothetical protein +FIG00954854 Succinate dehydrogenase cytochrome b subunit family protein +FIG00954856 FIG00954859: hypothetical protein +FIG00954866 FIG00954868: hypothetical protein +FIG00954869 FIG00954870: hypothetical protein +FIG00954870 FIG00954871: hypothetical protein +FIG00954875 FIG00954876: hypothetical protein +FIG00954876 FIG00954877: hypothetical protein +FIG00954877 FIG00954878: hypothetical protein +FIG00954878 FIG00954879: hypothetical protein +FIG00954881 FIG00954882: hypothetical protein +FIG00954882 FIG00954883: hypothetical protein +FIG00954883 FIG00954888: hypothetical protein +FIG00954888 FIG00954889: hypothetical protein +FIG00954891 FIG00955494: hypothetical protein +FIG00954892 FIG00954893: hypothetical protein +FIG00954893 FIG00954896: hypothetical protein +FIG00954896 FIG00954899: hypothetical protein +FIG00954899 Phosphopantetheinyl transferase +FIG00954902 FIG00954903: hypothetical protein +FIG00954911 FIG00954912: hypothetical protein +FIG00954914 FIG00954916: hypothetical protein +FIG00954916 FIG00954920: hypothetical protein +FIG00954920 FIG00956018: hypothetical protein +FIG00954921 Imidazoleglycerol-phosphate synthase +FIG00954926 FIG00954929: hypothetical protein +FIG00954929 FIG00954931: hypothetical protein +FIG00954931 FIG00954934: hypothetical protein +FIG00954934 FIG00954937: hypothetical protein +FIG00954943 FIG00954945: hypothetical protein +FIG00954945 FIG00954947: hypothetical protein +FIG00954947 UDP-N-acetylmuramic acid hydroxylase +FIG00954949 FIG00954951: hypothetical protein +FIG00954952 FIG00954953: hypothetical protein +FIG00954956 FIG00954959: hypothetical protein +FIG00954959 S-methylmethionine permease +FIG00954961 FIG00954962: hypothetical protein +FIG00954962 FIG00954963: hypothetical protein +FIG00954963 FIG00954964: hypothetical protein +FIG00954964 cmaU protein, putative +FIG00954971 FIG00954972: hypothetical protein +FIG00954972 FIG00954977: hypothetical protein +FIG00954977 FIG00954979: hypothetical protein +FIG00954980 FIG00954981: hypothetical protein +FIG00954982 Phospholipase C +FIG00954985 Penicillin amidase (EC 3.5.1.11) +FIG00954986 Gamma-aminobutyrate permease +FIG00954987 FIG00954991: hypothetical protein +FIG00954993 Major tail subunit +FIG00954996 FIG00954999: hypothetical protein +FIG00955001 Tabtoxin resistance protein +FIG00955002 FIG00955003: hypothetical protein +FIG00955004 FIG00955006: hypothetical protein +FIG00955009 FIG00955010: hypothetical protein +FIG00955010 FIG00986085: hypothetical protein +FIG00955013 FIG00955015: hypothetical protein +FIG00955015 FIG00955016: hypothetical protein +FIG00955021 FIG00955022: hypothetical protein +FIG00955026 DGPFAETKE +FIG00955028 FIG00955029: hypothetical protein +FIG00955029 FIG00955030: hypothetical protein +FIG00955030 FIG00955031: hypothetical protein +FIG00955031 FIG00955034: hypothetical protein +FIG00955036 FIG00955037: hypothetical protein +FIG00955037 FIG00955039: hypothetical protein +FIG00955041 FIG00955042: hypothetical protein +FIG00955046 Polysaccharide biosynthesis domain protein +FIG00955048 FIG00955049: hypothetical protein +FIG00955049 FIG00955051: hypothetical protein +FIG00955051 membrane protein, MarC family +FIG00955057 FIG00955058: hypothetical protein +FIG00955059 FIG00955061: hypothetical protein +FIG00955061 FIG00956241: hypothetical protein +FIG00955064 dienelactone hydrolase family protein +FIG00955069 FIG00955073: hypothetical protein +FIG00955074 FIG00955077: hypothetical protein +FIG00955078 FIG00955080: hypothetical protein +FIG00955080 Sodium-type flagellar protein motY precursor +FIG00955083 FIG00955086: hypothetical protein +FIG00955087 FIG00955090: hypothetical protein +FIG00955091 FIG00955094: hypothetical protein +FIG00955096 FIG00955097: hypothetical protein +FIG00955098 FIG00955101: hypothetical protein +FIG00955101 FIG00955103: hypothetical protein +FIG00955103 FIG00955104: hypothetical protein +FIG00955104 Major outer membrane lipoprotein I +FIG00955105 FIG00955110: hypothetical protein +FIG00955111 FIG00955112: hypothetical protein +FIG00955115 FIG00955116: hypothetical protein +FIG00955116 PAP2 superfamily protein +FIG00955118 acetyltransferase, CysE/LacA/LpxA/NodL family +FIG00955122 FIG00955126: hypothetical protein +FIG00955126 FIG00955129: hypothetical protein +FIG00955129 FIG00955130: hypothetical protein +FIG00955130 FIG00955131: hypothetical protein +FIG00955143 Extracellular Matrix protein PslD +FIG00955144 FIG00955145: hypothetical protein +FIG00955145 Phosphate starvation-inducible protein psiF precursor +FIG00955146 FIG00955147: hypothetical protein +FIG00955147 FIG00955149: hypothetical protein +FIG00955149 FIG00955152: hypothetical protein +FIG00955152 FIG00955154: hypothetical protein +FIG00955154 DNA/RNA endonuclease G, NUC1 +FIG00955157 FIG00955159: hypothetical protein +FIG00955159 FIG00955160: hypothetical protein +FIG00955160 FIG00955169: hypothetical protein +FIG00955174 FIG00955176: hypothetical protein +FIG00955179 FIG00955181: hypothetical protein +FIG00955183 FIG00955186: hypothetical protein +FIG00955186 Transporter, Drug/Metabolite Exporter family +FIG00955187 FIG00955189: hypothetical protein +FIG00955189 FIG00955190: hypothetical protein +FIG00955193 FIG00955197: hypothetical protein +FIG00955199 FIG00955200: hypothetical protein +FIG00955203 transport permease protein of gamma-aminobutyrate +FIG00955207 FIG00955208: hypothetical protein +FIG00955208 FIG00956879: hypothetical protein +FIG00955211 CrfX protein +FIG00955214 FIG00955215: hypothetical protein +FIG00955215 FIG00955216: hypothetical protein +FIG00955216 Flp pilus assembly protein CpaE +FIG00955218 probable polyketide synthase type I +FIG00955224 FIG00955226: hypothetical protein +FIG00955229 hypothetical protein +FIG00955238 FIG00955239: hypothetical protein +FIG00955239 FIG00955242: hypothetical protein +FIG00955244 FIG00955247: hypothetical protein +FIG00955247 FIG00955248: hypothetical protein +FIG00955248 FIG00955249: hypothetical protein +FIG00955250 FIG00955253: hypothetical protein +FIG00955253 Conjugative transfer protein PilS in PFGI-1-like cluster +FIG00955255 Metalloprotease, insulinase family +FIG00955260 FIG00955262: hypothetical protein +FIG00955266 FIG00955268: hypothetical protein +FIG00955273 FIG00955278: hypothetical protein +FIG00955278 FIG00955280: hypothetical protein +FIG00955280 FIG00955281: hypothetical protein +FIG00955282 FIG00955283: hypothetical protein +FIG00955283 FIG00955285: hypothetical protein +FIG00955286 FIG003461: hypothetical protein +FIG00955289 FIG00955290: hypothetical protein +FIG00955292 FIG00955294: hypothetical protein +FIG00955294 FIG00955297: hypothetical protein +FIG00955297 FIG00955298: hypothetical protein +FIG00955298 probable ATP-binding/permease fusion ABC transporter +FIG00955299 FIG00955300: hypothetical protein +FIG00955300 FIG00955302: hypothetical protein +FIG00955303 FIG00955305: hypothetical protein +FIG00955305 FIG00955306: hypothetical protein +FIG00955306 FIG00955308: hypothetical protein +FIG00955315 FIG00955320: hypothetical protein +FIG00955320 FIG00955321: hypothetical protein +FIG00955321 FIG00955324: hypothetical protein +FIG00955324 FIG00955325: hypothetical protein +FIG00955325 FIG00955328: hypothetical protein +FIG00955328 FIG00955330: hypothetical protein +FIG00955332 FIG00955333: hypothetical protein +FIG00955333 FIG00955334: hypothetical protein +FIG00955334 FIG00955335: hypothetical protein +FIG00955337 FIG00955339: hypothetical protein +FIG00955339 FIG00955340: hypothetical protein +FIG00955340 FIG00955341: hypothetical protein +FIG00955341 FIG00955342: hypothetical protein +FIG00955344 FIG00955346: hypothetical protein +FIG00955356 FIG00955358: hypothetical protein +FIG00955358 FIG00955360: hypothetical protein +FIG00955360 FIG00955362: hypothetical protein +FIG00955362 FIG00955363: hypothetical protein +FIG00955363 FIG00955364: hypothetical protein +FIG00955364 FIG00955366: hypothetical protein +FIG00955370 FIG00955372: hypothetical protein +FIG00955372 FIG00955373: hypothetical protein +FIG00955374 FIG00955375: hypothetical protein +FIG00955375 Type II and III secretion system family protein +FIG00955376 Nucleoside ABC transporter, periplasmic nucleoside-binding protein +FIG00955382 FIG00955385: hypothetical protein +FIG00955385 FIG00955390: hypothetical protein +FIG00955401 FIG00955403: hypothetical protein +FIG00955407 probable haloacid dehalogenase +FIG00955411 Response regulator/EAL domain protein +FIG00955415 FIG00955416: hypothetical protein +FIG00955416 probable dehydrogenase +FIG00955421 FIG00955422: hypothetical protein +FIG00955422 FIG00955424: hypothetical protein +FIG00955425 FIG00955428: hypothetical protein +FIG00955428 FIG00955429: hypothetical protein +FIG00955430 FIG00955434: hypothetical protein +FIG00955434 FIG00955435: hypothetical protein +FIG00955436 Nitric oxide reductase activation protein NorF +FIG00955445 FIG00955447: hypothetical protein +FIG00955447 FIG00955449: hypothetical protein +FIG00955449 FIG00955450: hypothetical protein +FIG00955450 hypothetical protein +FIG00955454 FIG00955455: hypothetical protein +FIG00955457 FIG00955458: hypothetical protein +FIG00955464 FIG00955467: hypothetical protein +FIG00955467 Arc-like DNA binding +FIG00955468 coronafacic acid synthetase, acyl carrier protein component, putative +FIG00955471 FIG00955472: hypothetical protein +FIG00955472 GGDEF domain/EAL domain protein +FIG00955473 FIG00955476: hypothetical protein +FIG00955476 FIG00955478: hypothetical protein +FIG00955479 FIG00955481: hypothetical protein +FIG00955481 FIG00955483: hypothetical protein +FIG00955483 FIG00955484: hypothetical protein +FIG00955484 FIG00955486: hypothetical protein +FIG00955488 Histidine ABC transporter, histidine-binding protein (TC 3.A.1) +FIG00955489 FIG00955492: hypothetical protein +FIG00955492 FIG00955493: hypothetical protein +FIG00955494 FIG00955495: hypothetical protein +FIG00955496 3-oxoacyl-(acyl-carrier-protein) synthase III, putative +FIG00955498 FIG00955499: hypothetical protein +FIG00955502 putative unknown enzyme +FIG00955504 FIG00955505: hypothetical protein +FIG00955507 FIG00955509: hypothetical protein +FIG00955509 Protein yqjC precursor +FIG00955511 FIG00955514: hypothetical protein +FIG00955514 FIG00955515: hypothetical protein +FIG00955515 FIG00955518: hypothetical protein +FIG00955518 FIG00955519: hypothetical protein +FIG00955529 FIG00955530: hypothetical protein +FIG00955530 Antibiotic biosynthesis monooxygenase domain protein +FIG00955531 Histidine ABC transporter, ATP-binding protein (TC 3.A.1) +FIG00955535 FIG00955538: hypothetical protein +FIG00955538 probable response regulator +FIG00955540 (R)-3-hydroxydecanoyl-ACP:CoA transacylase PhaG (3-hydroxyacyl-CoA-acyl carrier protein transferase) (EC 2.4.1.-) +FIG00955546 Acetyltransferase, including N-acetylases of ribosomal protein +FIG00955548 FIG00955550: hypothetical protein +FIG00955560 FIG00955561: hypothetical protein +FIG00955563 FIG00955564: hypothetical protein +FIG00955564 FIG00955567: hypothetical protein +FIG00955567 Probable AGCS sodium/alanine/glycine symporter +FIG00955570 FIG00955571: hypothetical protein +FIG00955572 FIG00955573: hypothetical protein +FIG00955573 FIG00955574: hypothetical protein +FIG00955574 Lipoprotein LppL-related protein +FIG00955581 FIG00955584: hypothetical protein +FIG00955584 FIG00955586: hypothetical protein +FIG00955586 FIG00955588: hypothetical protein +FIG00955588 FIG00955589: hypothetical protein +FIG00955589 FIG00955590: hypothetical protein +FIG00955592 Sodium-dependent transporter family protein +FIG00955593 FIG00955595: hypothetical protein +FIG00955595 FIG00955597: hypothetical protein +FIG00955597 Histidine ABC transporter, permease protein (TC 3.A.1) +FIG00955599 FIG00955600: hypothetical protein +FIG00955601 FIG00955602: hypothetical protein +FIG00955602 FIG00955605: hypothetical protein +FIG00955605 transcriptional regulator PcaQ +FIG00955607 FIG00955608: hypothetical protein +FIG00955608 FIG00955609: hypothetical protein +FIG00955609 FIG00955611: hypothetical protein +FIG00955611 FIG00955612: hypothetical protein +FIG00955612 FIG00955615: hypothetical protein +FIG00955616 FIG00955622: hypothetical protein +FIG00955622 FIG00955623: hypothetical protein +FIG00955626 Flp pilus assembly protein CpaA +FIG00955630 FIG00955631: hypothetical protein +FIG00955631 Outer membrane autotransporter barrel +FIG00955634 FIG00955635: hypothetical protein +FIG00955635 FIG00955636: hypothetical protein +FIG00955639 FIG00955642: hypothetical protein +FIG00955644 FIG00955646: hypothetical protein +FIG00955646 FIG00955647: hypothetical protein +FIG00955647 FIG00955648: hypothetical protein +FIG00955649 FIG00955657: hypothetical protein +FIG00955658 FIG00955661: hypothetical protein +FIG00955662 CinA domain protein +FIG00955664 Pyruvate:ferredoxin oxidoreductase and related 2-oxoacid:ferredoxin oxidoreductases, alpha subunit +FIG00955665 FIG00955667: hypothetical protein +FIG00955667 FIG00955668: hypothetical protein +FIG00955675 FIG00955680: hypothetical protein +FIG00955680 FIG00955682: hypothetical protein +FIG00955682 FIG00955684: hypothetical protein +FIG00955686 FIG00955688: hypothetical protein +FIG00955689 FIG00955690: hypothetical protein +FIG00955690 FIG00955691: hypothetical protein +FIG00955691 FIG00955692: hypothetical protein +FIG00955692 FIG00955694: hypothetical protein +FIG00955694 FIG00955695: hypothetical protein +FIG00955695 FIG00955696: hypothetical protein +FIG00955696 Uncharacterized protein, possibly involved in aromatic compounds catabolism +FIG00955698 FIG00955700: hypothetical protein +FIG00955701 Putative amino acid ABC transporter, permease protein +FIG00955705 CmpX +FIG00955707 FIG00955711: hypothetical protein +FIG00955711 FIG00955712: hypothetical protein +FIG00955712 FIG00955714: hypothetical protein +FIG00955714 FIG00955717: hypothetical protein +FIG00955717 FIG00955719: hypothetical protein +FIG00955719 FIG00955722: hypothetical protein +FIG00955722 FIG00955727: hypothetical protein +FIG00955728 FIG00955735: hypothetical protein +FIG00955735 FIG00964302: hypothetical protein +FIG00955742 FIG00955748: hypothetical protein +FIG00955749 FIG00955751: hypothetical protein +FIG00955754 FIG00955756: hypothetical protein +FIG00955756 FIG00955757: hypothetical protein +FIG00955760 FIG00955761: hypothetical protein +FIG00955761 integrative genetic element Ppu40, integrase +FIG00955763 FIG00955764: hypothetical protein +FIG00955764 FIG00955766: hypothetical protein +FIG00955766 FIG00955767: hypothetical protein +FIG00955772 FIG00955773: hypothetical protein +FIG00955773 fatty acid desaturase, putative +FIG00955774 FIG00955776: hypothetical protein +FIG00955777 FIG00955778: hypothetical protein +FIG00955780 FIG00955784: hypothetical protein +FIG00955784 FIG00955785: hypothetical protein +FIG00955796 FIG00955799: hypothetical protein +FIG00955807 Aminoglycoside 3'-phosphotransferase (EC 2.7.1.95) +FIG00955813 FIG00955814: hypothetical protein +FIG00955814 Plasmid conjugative transfer endonuclease +FIG00955816 FIG00955818: hypothetical protein +FIG00955818 CFA/I fimbrial subunit C precursor +FIG00955825 FIG00955827: hypothetical protein +FIG00955828 FIG00955829: hypothetical protein +FIG00955829 FIG00955830: hypothetical protein +FIG00955831 FIG00955832: hypothetical protein +FIG00955833 FIG00955836: hypothetical protein +FIG00955836 FIG00955837: hypothetical protein +FIG00955837 FIG00955840: hypothetical protein +FIG00955844 FIG00955845: hypothetical protein +FIG00955845 FIG00955846: hypothetical protein +FIG00955847 FIG00955848: hypothetical protein +FIG00955848 FIG00955849: hypothetical protein +FIG00955849 ABC-type protease/lipase transport system, ATPase and permease components +FIG00955854 FIG00955855: hypothetical protein +FIG00955855 FIG00955856: hypothetical protein +FIG00955856 FIG00955857: hypothetical protein +FIG00955857 FIG00955858: hypothetical protein +FIG00955858 FIG00955859: hypothetical protein +FIG00955859 FIG00955860: hypothetical protein +FIG00955868 General secretion pathway protein L (Pullulanase secretion protein pulL) +FIG00955870 FIG00955871: hypothetical protein +FIG00955871 FIG00955873: hypothetical protein +FIG00955873 FIG00955875: hypothetical protein +FIG00955875 FIG00955877: hypothetical protein +FIG00955877 FIG00955878: hypothetical protein +FIG00955880 FIG00955883: hypothetical protein +FIG00955883 FIG00955885: hypothetical protein +FIG00955885 FIG00955888: hypothetical protein +FIG00955896 Urea amidohydrolase (urease) alpha subunit +FIG00955898 FIG00955899: hypothetical protein +FIG00955899 glyoxalase, putative +FIG00955901 FIG00955907: hypothetical protein +FIG00955908 FIG00955909: hypothetical protein +FIG00955909 XcpP protein +FIG00955912 FIG00955915: hypothetical protein +FIG00955915 FIG00955916: hypothetical protein +FIG00955918 Chemotactic transducer +FIG00955920 probable two-component response regulator +FIG00955928 FIG00955932: hypothetical protein +FIG00955937 FIG00955938: hypothetical protein +FIG00955941 FIG00955942: hypothetical protein +FIG00955942 FIG00955944: hypothetical protein +FIG00955944 FIG00955946: hypothetical protein +FIG00955946 FIG00955947: hypothetical protein +FIG00955947 FIG00955948: hypothetical protein +FIG00955953 putative enzyme; Integration, recombination (Phage or Prophage Related) +FIG00955954 FIG00955955: hypothetical protein +FIG00955955 FIG00955959: hypothetical protein +FIG00955959 putative phosphohistidine phosphatase, SixA +FIG00955963 aerotaxis receptor, putative +FIG00955967 FIG00955969: hypothetical protein +FIG00955974 FIG00955975: hypothetical protein +FIG00955975 FIG00955976: hypothetical protein +FIG00955976 FIG00955977: hypothetical protein +FIG00955983 FIG00955984: hypothetical protein +FIG00955988 FIG00955989: hypothetical protein +FIG00955991 FIG00955994: hypothetical protein +FIG00955994 FIG00955995: hypothetical protein +FIG00955998 FIG00956000: hypothetical protein +FIG00956003 FIG00956004: hypothetical protein +FIG00956004 FIG00956005: hypothetical protein +FIG00956005 FIG00956006: hypothetical protein +FIG00956006 FIG00956008: hypothetical protein +FIG00956008 FIG00956013: hypothetical protein +FIG00956013 FIG00956017: hypothetical protein +FIG00956019 FIG00956024: hypothetical protein +FIG00956027 Amino acid ABC transporter permease protein +FIG00956032 Probable permease of ABC transporter +FIG00956035 FIG00956036: hypothetical protein +FIG00956037 FIG00956038: hypothetical protein +FIG00956038 FIG00956040: hypothetical protein +FIG00956040 FIG00956041: hypothetical protein +FIG00956041 FIG00956044: hypothetical protein +FIG00956046 FIG00956049: hypothetical protein +FIG00956055 FIG00956056: hypothetical protein +FIG00956056 Mlr3950 protein +FIG00956059 D-erythrose-4-phosphate dehydrogenase +FIG00956062 FIG00956064: hypothetical protein +FIG00956064 FIG00956066: hypothetical protein +FIG00956066 FIG00956068: hypothetical protein +FIG00956070 FIG00956071: hypothetical protein +FIG00956076 FIG00956077: hypothetical protein +FIG00956077 FIG00956078: hypothetical protein +FIG00956078 FIG00956079: hypothetical protein +FIG00956079 FIG00956080: hypothetical protein +FIG00956081 FIG00956082: hypothetical protein +FIG00956082 FIG00956083: hypothetical protein +FIG00956083 FIG00956084: hypothetical protein +FIG00956084 FIG00956085: hypothetical protein +FIG00956086 FIG00956088: hypothetical protein +FIG00956088 FIG00956089: hypothetical protein +FIG00956089 FIG00956090: hypothetical protein +FIG00956090 FIG00956092: hypothetical protein +FIG00956100 FIG00956101: hypothetical protein +FIG00956110 FIG00956113: hypothetical protein +FIG00956113 FIG00956115: hypothetical protein +FIG00956116 FIG00956119: hypothetical protein +FIG00956125 FIG00956127: hypothetical protein +FIG00956127 FIG00956128: hypothetical protein +FIG00956128 FIG00956129: hypothetical protein +FIG00956130 FIG00956135: hypothetical protein +FIG00956135 FIG00956137: hypothetical protein +FIG00956137 Stress induced hydrophobic peptide +FIG00956140 FIG00956141: hypothetical protein +FIG00956150 N-6 DNA methylase +FIG00956151 FIG00956152: hypothetical protein +FIG00956152 FIG00956153: hypothetical protein +FIG00956153 FIG00956154: hypothetical protein +FIG00956159 FIG00956160: hypothetical protein +FIG00956160 FIG00956165: hypothetical protein +FIG00956167 FIG00956169: hypothetical protein +FIG00956169 FIG00956170: hypothetical protein +FIG00956170 FIG00956173: hypothetical protein +FIG00956173 FIG00956174: hypothetical protein +FIG00956174 3-oxoacyl-[acyl-carrier-protein] synthase, KASII (EC 2.3.1.179) +FIG00956183 Pili assembly chaperone +FIG00956187 FIG00956188: hypothetical protein +FIG00956188 FIG00956189: hypothetical protein +FIG00956189 FIG00956193: hypothetical protein +FIG00956193 FIG00956194: hypothetical protein +FIG00956197 FIG00956198: hypothetical protein +FIG00956198 FIG00956200: hypothetical protein +FIG00956200 FIG00956201: hypothetical protein +FIG00956201 Amine oxidase, flavin-containing +FIG00956203 FIG00956204: hypothetical protein +FIG00956210 FIG00956216: hypothetical protein +FIG00956216 FIG00956217: hypothetical protein +FIG00956217 FIG00956218: hypothetical protein +FIG00956218 FIG00956220: hypothetical protein +FIG00956220 FIG00956223: hypothetical protein +FIG00956223 FIG00956224: hypothetical protein +FIG00956224 FIG00956225: hypothetical protein +FIG00956225 FIG00956226: hypothetical protein +FIG00956226 FIG00956228: hypothetical protein +FIG00956229 FIG00956230: hypothetical protein +FIG00956230 FIG00956234: hypothetical protein +FIG00956241 FIG00956245: hypothetical protein +FIG00956245 FIG00956248: hypothetical protein +FIG00956250 FIG00956253: hypothetical protein +FIG00956253 FIG00956254: hypothetical protein +FIG00956254 Mll2356 protein +FIG00956260 FIG00956261: hypothetical protein +FIG00956261 FIG00956262: hypothetical protein +FIG00956265 FIG00956267: hypothetical protein +FIG00956269 FIG00956273: hypothetical protein +FIG00956277 FIG00956279: hypothetical protein +FIG00956279 FIG00956280: hypothetical protein +FIG00956280 CsgG family protein +FIG00956286 FIG00956289: hypothetical protein +FIG00956289 FIG00956290: hypothetical protein +FIG00956294 FIG00956297: hypothetical protein +FIG00956297 FIG00956298: hypothetical protein +FIG00956300 Conserved domain protein precursor +FIG00956305 FIG00956306: hypothetical protein +FIG00956309 FIG00956312: hypothetical protein +FIG00956314 DNA-binding HTH domain-containing proteins +FIG00956315 FIG00956316: hypothetical protein +FIG00956316 FIG00956317: hypothetical protein +FIG00956317 FIG00956318: hypothetical protein +FIG00956318 FIG00956319: hypothetical protein +FIG00956320 FIG00956322: hypothetical protein +FIG00956330 FIG00956333: hypothetical protein +FIG00956338 FIG00956341: hypothetical protein +FIG00956343 FIG00956346: hypothetical protein +FIG00956346 FIG00956349: hypothetical protein +FIG00956350 FIG00956351: hypothetical protein +FIG00956352 FIG00956356: hypothetical protein +FIG00956356 FIG00956357: hypothetical protein +FIG00956358 FIG00956360: hypothetical protein +FIG00956360 FIG00956361: hypothetical protein +FIG00956361 FIG00956362: hypothetical protein +FIG00956365 FIG00956371: hypothetical protein +FIG00956373 FIG00956375: hypothetical protein +FIG00956378 Drug resistance transporter, EmrB/QacA family +FIG00956379 FIG00956380: hypothetical protein +FIG00956380 Membrane protein glpM +FIG00956382 FIG00956383: hypothetical protein +FIG00956391 FIG00956392: hypothetical protein +FIG00956392 FIG00956396: hypothetical protein +FIG00956397 FIG00956403: hypothetical protein +FIG00956404 FIG00956405: hypothetical protein +FIG00956406 FIG00956407: hypothetical protein +FIG00956407 cytochrome b(561) +FIG00956412 FIG00956413: hypothetical protein +FIG00956413 FIG00956414: hypothetical protein +FIG00956428 Alcohol dehydrogenase +FIG00956432 Type-1 fimbrial protein, A chain precursor +FIG00956434 FIG00956435: hypothetical protein +FIG00956435 FIG00956436: hypothetical protein +FIG00956436 FIG00956437: hypothetical protein +FIG00956437 Probable DNA invertase +FIG00956443 FIG00956444: hypothetical protein +FIG00956447 FIG00956448: hypothetical protein +FIG00956448 FIG00956450: hypothetical protein +FIG00956450 FIG00956456: hypothetical protein +FIG00956459 HemK family modification methylase PA2179 +FIG00956460 FIG00956463: hypothetical protein +FIG00956466 FIG00956468: hypothetical protein +FIG00956470 FIG00956471: hypothetical protein +FIG00956471 FIG00956472: hypothetical protein +FIG00956473 FIG00956478: hypothetical protein +FIG00956478 FIG00956479: hypothetical protein +FIG00956479 FIG00956482: hypothetical protein +FIG00956485 FIG00956487: hypothetical protein +FIG00956488 FIG00956489: hypothetical protein +FIG00956489 FIG00956490: hypothetical protein +FIG00956491 hypothetical protein +FIG00956493 FIG00956494: hypothetical protein +FIG00956498 FIG00956499: hypothetical protein +FIG00956501 FIG00956502: hypothetical protein +FIG00956502 probable polysaccharide biosynthesis protein +FIG00956503 FIG00956504: hypothetical protein +FIG00956505 FIG00956508: hypothetical protein +FIG00956511 hypothetical protein in PFGI-1-like cluster +FIG00956512 FIG00956513: hypothetical protein +FIG00956515 Membrane protease subunits, stomatin/prohibitin homologs +FIG00956518 ABC-type oligopeptide transport system, ATPase component +FIG00956526 FIG00956527: hypothetical protein +FIG00956528 FIG00956529: hypothetical protein +FIG00956532 FIG00956533: hypothetical protein +FIG00956539 FIG00956540: hypothetical protein +FIG00956541 topoisomerase domain protein +FIG00956545 FIG00956548: hypothetical protein +FIG00956548 FIG00956549: hypothetical protein +FIG00956551 FIG00956552: hypothetical protein +FIG00956552 FIG00956556: hypothetical protein +FIG00956558 FIG00956559: hypothetical protein +FIG00956559 FIG00956561: hypothetical protein +FIG00956564 FIG00956570: hypothetical protein +FIG00956572 FIG00956575: hypothetical protein +FIG00956575 FIG00956581: hypothetical protein +FIG00956581 FIG00956583: hypothetical protein +FIG00956585 FIG00956587: hypothetical protein +FIG00956587 FIG00956588: hypothetical protein +FIG00956588 FIG00956589: hypothetical protein +FIG00956593 Lysine N6-hydroxylase/L-ornithine N5-oxygenase family protein +FIG00956596 FIG00956598: hypothetical protein +FIG00956598 FIG00956599: hypothetical protein +FIG00956601 FIG00956602: hypothetical protein +FIG00956602 FIG00956603: hypothetical protein +FIG00956608 FIG00956610: hypothetical protein +FIG00956610 FIG00956611: hypothetical protein +FIG00956612 Ankyrin +FIG00956615 ABC transporter, inner membrane subunit precursor +FIG00956616 FIG00956617: hypothetical protein +FIG00956622 FIG00956623: hypothetical protein +FIG00956625 FIG00956627: hypothetical protein +FIG00956627 FIG00956628: hypothetical protein +FIG00956630 FIG00965952: hypothetical protein +FIG00956632 FIG00956634: hypothetical protein +FIG00956635 FIG00956640: hypothetical protein +FIG00956643 HigB toxin protein +FIG00956644 FIG00956648: hypothetical protein +FIG00956648 FIG00956649: hypothetical protein +FIG00956649 FIG00956650: hypothetical protein +FIG00956650 FIG00956652: hypothetical protein +FIG00956652 FIG00956653: hypothetical protein +FIG00956656 FIG00956657: hypothetical protein +FIG00956659 FIG00956660: hypothetical protein +FIG00956662 FIG00956663: hypothetical protein +FIG00956667 FIG01056096: hypothetical protein +FIG00956670 FIG00956671: hypothetical protein +FIG00956674 FIG00956675: hypothetical protein +FIG00956675 FIG00956676: hypothetical protein +FIG00956679 FIG00956680: hypothetical protein +FIG00956680 Ribose transport ATP-binding protein rbsA +FIG00956688 FIG00956689: hypothetical protein +FIG00956694 FIG00956698: hypothetical protein +FIG00956698 FIG00956700: hypothetical protein +FIG00956700 RND efflux transporter +FIG00956701 Protein-glutamate methylesterase (EC 3.1.1.61) +FIG00956703 FIG00956704: hypothetical protein +FIG00956708 hypothetical protein in cluster with VreARI signaling system +FIG00956710 FIG00956711: hypothetical protein +FIG00956711 FIG00956712: hypothetical protein +FIG00956712 FIG00956715: hypothetical protein +FIG00956716 FIG00956719: hypothetical protein +FIG00956719 FIG00956721: hypothetical protein +FIG00956721 FIG00956722: hypothetical protein +FIG00956725 FIG00956726: hypothetical protein +FIG00956728 FIG00956729: hypothetical protein +FIG00956732 FIG00956734: hypothetical protein +FIG00956735 FIG00956736: hypothetical protein +FIG00956740 FIG00956741: hypothetical protein +FIG00956742 FIG00956743: hypothetical protein +FIG00956743 FIG00956744: hypothetical protein +FIG00956744 FIG00956745: hypothetical protein +FIG00956745 FIG00956746: hypothetical protein +FIG00956746 FIG00956747: hypothetical protein +FIG00956749 FIG00956751: hypothetical protein +FIG00956751 FIG00956752: hypothetical protein +FIG00956757 FIG00956760: hypothetical protein +FIG00956765 FIG00956767: hypothetical protein +FIG00956767 FIG00956770: hypothetical protein +FIG00956770 Two-component sensor histidine kinase PfeS, enterobactin +FIG00956779 FIG00956780: hypothetical protein +FIG00956786 FIG00956788: hypothetical protein +FIG00956790 FIG00956791: hypothetical protein +FIG00956791 FIG00956795: hypothetical protein +FIG00956802 Dodecin (COG3360) Flavin-binding +FIG00956807 FIG00956808: hypothetical protein +FIG00956808 UvrD/REP helicase family protein +FIG00956814 FIG00956815: hypothetical protein +FIG00956822 FIG00956824: hypothetical protein +FIG00956826 FIG00956828: hypothetical protein +FIG00956835 FIG00956836: hypothetical protein +FIG00956837 FIG00956838: hypothetical protein +FIG00956839 FIG00956841: hypothetical protein +FIG00956842 Virulence factors putative positive transcription regulator bvgA +FIG00956845 FIG00956846: hypothetical protein +FIG00956846 FIG00956847: hypothetical protein +FIG00956847 FIG00956848: hypothetical protein +FIG00956848 Histidine transporter, periplasmic histidine-binding protein +FIG00956851 FIG00956854: hypothetical protein +FIG00956854 FIG00956856: hypothetical protein +FIG00956856 FIG00956858: hypothetical protein +FIG00956864 Pathogenicity locus probable regulatory protein hrpR +FIG00956866 FIG00956868: hypothetical protein +FIG00956868 FIG00956870: hypothetical protein +FIG00956874 FIG00956875: hypothetical protein +FIG00956875 FIG00956876: hypothetical protein +FIG00956876 FIG00956877: hypothetical protein +FIG00956881 FIG00956882: hypothetical protein +FIG00956882 probable nonribosomal peptide synthetase +FIG00956887 FIG00956889: hypothetical protein +FIG00956896 FIG00956897: hypothetical protein +FIG00956897 FIG00956898: hypothetical protein +FIG00956900 FIG00956901: hypothetical protein +FIG00956902 FIG00956904: hypothetical protein +FIG00956904 FIG00956905: hypothetical protein +FIG00956909 FIG00956910: hypothetical protein +FIG00956918 recombinase, putative +FIG00956925 FIG00956928: hypothetical protein +FIG00956928 Phage protein U +FIG00956930 FIG00956931: hypothetical protein +FIG00956936 FIG00956937: hypothetical protein +FIG00956937 FIG066100: Diguanylate cyclase (GGDEF domain) with PAS/PAC sensor +FIG00956939 FIG00956941: hypothetical protein +FIG00956941 FIG00956944: hypothetical protein +FIG00956947 FIG00956950: hypothetical protein +FIG00956957 FIG00956959: hypothetical protein +FIG00956959 FIG00956960: hypothetical protein +FIG00956965 FIG00956967: hypothetical protein +FIG00956967 FIG00956968: hypothetical protein +FIG00956972 chemotaxis protein MotB-related protein +FIG00956974 COG3706: Response regulator containing a CheY-like receiver domain and a GGDEF domain +FIG00956982 FIG00956983: hypothetical protein +FIG00956983 FIG00956986: hypothetical protein +FIG00956992 Phage-related minor tail protein +FIG00956996 FIG00956998: hypothetical protein +FIG00956998 FIG00956999: hypothetical protein +FIG00957004 FIG00957005: hypothetical protein +FIG00957005 FIG00957006: hypothetical protein +FIG00957006 FIG00957007: hypothetical protein +FIG00957007 FIG00957008: hypothetical protein +FIG00957008 FIG00957009: hypothetical protein +FIG00957009 FIG00957011: hypothetical protein +FIG00957011 FIG00957018: hypothetical protein +FIG00957020 FIG00957022: hypothetical protein +FIG00957022 outer membrane autotransporter +FIG00957028 FIG00957031: hypothetical protein +FIG00957031 FIG00957032: hypothetical protein +FIG00957032 FIG00957033: hypothetical protein +FIG00957033 FIG00957035: hypothetical protein +FIG00957035 FIG00957037: hypothetical protein +FIG00957037 Prevent host death protein, Phd antitoxin +FIG00957042 Fe2+/Zn2+ uptake regulation proteins +FIG00957046 FIG00957049: hypothetical protein +FIG00957049 Ribosomal protein S8 +FIG00957050 FIG00957052: hypothetical protein +FIG00957054 SelT/selW/selH selenoprotein domain +FIG00957059 FIG00957062: hypothetical protein +FIG00957062 FIG00957064: hypothetical protein +FIG00957064 FIG00957068: hypothetical protein +FIG00957070 Transferase hexapeptide repeat +FIG00957072 FIG00957075: hypothetical protein +FIG00957079 FIG00957080: hypothetical protein +FIG00957086 FIG00957087: hypothetical protein +FIG00957088 FIG00957090: hypothetical protein +FIG00957097 FIG00957098: hypothetical protein +FIG00957099 FIG00957103: hypothetical protein +FIG00957104 FIG00957107: hypothetical protein +FIG00957107 traX protein +FIG00957114 FIG00957117: hypothetical protein +FIG00957120 Thiamine pyrophosphate-requiring protein PA2108 +FIG00957121 FIG00957122: hypothetical protein +FIG00957122 FIG00957123: hypothetical protein +FIG00957127 FIG00957129: hypothetical protein +FIG00957130 FIG00957132: hypothetical protein +FIG00957139 FIG00957142: hypothetical protein +FIG00957142 FIG00957146: hypothetical protein +FIG00957151 FIG00957153: hypothetical protein +FIG00957153 FIG00957154: hypothetical protein +FIG00957154 FIG00957155: hypothetical protein +FIG00957156 FIG00957157: hypothetical protein +FIG00957166 Probable taurine catabolism dioxygenase +FIG00957169 ABC transporter, substrate binding protein +FIG00957170 probable pili asembly chaperone +FIG00957174 FIG00957175: hypothetical protein +FIG00957175 FIG00957176: hypothetical protein +FIG00957176 FIG00957179: hypothetical protein +FIG00957179 FIG00957180: hypothetical protein +FIG00957184 FIG00957186: hypothetical protein +FIG00957188 FIG00963715: hypothetical protein +FIG00957189 FIG00957191: hypothetical protein +FIG00957199 FIG00957200: hypothetical protein +FIG00957202 outer membrane porin OprE precursor +FIG00957213 FIG00957214: hypothetical protein +FIG00957215 FIG00957218: hypothetical protein +FIG00957223 FIG00957227: hypothetical protein +FIG00957227 FIG00957228: hypothetical protein +FIG00957229 FIG00957232: hypothetical protein +FIG00957232 Stability protein +FIG00957237 FIG00957240: hypothetical protein +FIG00957240 FIG00957243: hypothetical protein +FIG00957243 FIG00957245: hypothetical protein +FIG00957251 FIG00957252: hypothetical protein +FIG00957252 FIG00957257: hypothetical protein +FIG00957257 FIG00957260: hypothetical protein +FIG00957262 FIG00957263: hypothetical protein +FIG00957263 FIG00957264: hypothetical protein +FIG00957269 FIG00957280: hypothetical protein +FIG00957280 FIG00957284: hypothetical protein +FIG00957284 FIG00957285: hypothetical protein +FIG00957301 FIG00957302: hypothetical protein +FIG00957302 FIG00957304: hypothetical protein +FIG00957305 Oxidoreductase, FAD-binding +FIG00957310 FIG00957314: hypothetical protein +FIG00957314 FIG00957315: hypothetical protein +FIG00957318 FIG00957319: hypothetical protein +FIG00957319 FIG00957322: hypothetical protein +FIG00957330 FIG00957331: hypothetical protein +FIG00957331 FIG00957333: hypothetical protein +FIG00957333 FIG00957335: hypothetical protein +FIG00957338 FIG00957339: hypothetical protein +FIG00957351 FIG00957354: hypothetical protein +FIG00957361 FIG00957363: hypothetical protein +FIG00957363 Type II secretory pathway, component ExeA (predicted ATPase) +FIG00957364 FIG00957365: hypothetical protein +FIG00957365 coronamic acid synthetase, thioesterase component +FIG00957366 FIG00957368: hypothetical protein +FIG00957372 Alkyl sulfatase and related hydrolases +FIG00957374 FIG00957378: hypothetical protein +FIG00957378 FIG00957379: hypothetical protein +FIG00957382 FIG00957387: hypothetical protein +FIG00957388 Hydrolase, carbon-nitrogen family +FIG00957389 FIG00957390: hypothetical protein +FIG00957390 FIG00957393: hypothetical protein +FIG00957393 FIG00957397: hypothetical protein +FIG00957399 FIG00957400: hypothetical protein +FIG00957400 FIG00957401: hypothetical protein +FIG00957402 FIG00957404: hypothetical protein +FIG00957406 Cationic amino acid transporter +FIG00957409 FIG00957412: hypothetical protein +FIG00957412 Sigma factor regulatory protein, FecR/PupR family +FIG00957415 FIG00957416: hypothetical protein +FIG00957417 FIG00957419: hypothetical protein +FIG00957420 FIG00957426: hypothetical protein +FIG00957429 FIG00957431: hypothetical protein +FIG00957431 FIG00957432: hypothetical protein +FIG00957435 FIG00957438: hypothetical protein +FIG00957442 FIG00957443: hypothetical protein +FIG00957443 FIG00957444: hypothetical protein +FIG00957444 FIG00957445: hypothetical protein +FIG00957453 FIG00957455: hypothetical protein +FIG00957455 FIG00957462: hypothetical protein +FIG00957462 FIG00957463: hypothetical protein +FIG00957465 FIG00957466: hypothetical protein +FIG00957466 FIG00957468: hypothetical protein +FIG00957469 FIG00957470: hypothetical protein +FIG00957470 conserved effector locus protein +FIG00957474 FIG00957476: hypothetical protein +FIG00957476 FIG00957480: hypothetical protein +FIG00957481 FIG00957482: hypothetical protein +FIG00957482 FIG00957486: hypothetical protein +FIG00957489 FIG00957490: hypothetical protein +FIG00957490 FIG00957491: hypothetical protein +FIG00957491 FIG00957493: hypothetical protein +FIG00957494 FIG00957496: hypothetical protein +FIG00957496 FIG00957497: hypothetical protein +FIG00957500 FIG00957501: hypothetical protein +FIG00957501 FIG00957502: hypothetical protein +FIG00957506 FIG00957507: hypothetical protein +FIG00957508 FIG00957512: hypothetical protein +FIG00957516 FIG00957517: hypothetical protein +FIG00957522 FIG00957523: hypothetical protein +FIG00957523 FIG00957524: hypothetical protein +FIG00957530 FIG00957531: hypothetical protein +FIG00957531 FIG00957532: hypothetical protein +FIG00957533 FIG00957534: hypothetical protein +FIG00957535 FIG00957537: hypothetical protein +FIG00957539 Inner membrane protein YbhQ +FIG00957543 FIG00957548: hypothetical protein +FIG00957548 FIG00957549: hypothetical protein +FIG00957549 Efflux membrane fusion protein, RND family +FIG00957550 FIG00957554: hypothetical protein +FIG00957557 Peptidase propeptide and YPEB domain protein +FIG00957568 FIG00957570: hypothetical protein +FIG00957570 FIG00957574: hypothetical protein +FIG00957574 FIG00957579: hypothetical protein +FIG00957579 FIG00957581: hypothetical protein +FIG00957586 FIG00957587: hypothetical protein +FIG00957588 FIG00957589: hypothetical protein +FIG00957589 FIG00957590: hypothetical protein +FIG00957590 FIG00957593: hypothetical protein +FIG00957596 FIG00957597: hypothetical protein +FIG00957598 FIG00957600: hypothetical protein +FIG00957603 FIG00957609: hypothetical protein +FIG00957610 FIG00957611: hypothetical protein +FIG00957615 FIG00957616: hypothetical protein +FIG00957616 FIG00957617: hypothetical protein +FIG00957617 FIG00957620: hypothetical protein +FIG00957620 FIG00957623: hypothetical protein +FIG00957629 FIG00957630: hypothetical protein +FIG00957633 FIG00957636: hypothetical protein +FIG00957641 FIG00957643: hypothetical protein +FIG00957644 O-antigen biosynthesis protein +FIG00957647 FIG00957649: hypothetical protein +FIG00957654 FIG00957655: hypothetical protein +FIG00957655 type III chaperone ShcV +FIG00957659 FIG00957661: hypothetical protein +FIG00957661 FIG00957662: hypothetical protein +FIG00957662 FIG00957665: hypothetical protein +FIG00957665 FIG00957668: hypothetical protein +FIG00957675 FIG00957676: hypothetical protein +FIG00957676 Substrate-binding periplasmic component of uncharacterized ABC transporter +FIG00957678 FIG00957682: hypothetical protein +FIG00957682 FIG00957687: hypothetical protein +FIG00957692 FIG00957700: hypothetical protein +FIG00957700 FIG00957702: hypothetical protein +FIG00957706 FIG00957707: hypothetical protein +FIG00957707 FIG00957710: hypothetical protein +FIG00957713 FIG00957719: hypothetical protein +FIG00957719 FIG00957722: hypothetical protein +FIG00957722 FIG00957725: hypothetical protein +FIG00957725 FIG00957726: hypothetical protein +FIG00957730 FIG00957731: hypothetical protein +FIG00957732 FIG00957735: hypothetical protein +FIG00957740 FIG00957742: hypothetical protein +FIG00957742 FIG00957746: hypothetical protein +FIG00957746 FIG00957747: hypothetical protein +FIG00957747 FIG00957748: hypothetical protein +FIG00957751 FIG00957753: hypothetical protein +FIG00957755 FIG00957763: hypothetical protein +FIG00957763 FIG00957767: hypothetical protein +FIG00957768 FIG00957770: hypothetical protein +FIG00957777 FIG00957779: hypothetical protein +FIG00957779 FIG00957783: hypothetical protein +FIG00957786 FIG00957787: hypothetical protein +FIG00957787 FIG00957788: hypothetical protein +FIG00957791 FIG00957792: hypothetical protein +FIG00957792 FIG00957793: hypothetical protein +FIG00957793 transcriptional regulator PrtR +FIG00957794 FIG00957800: hypothetical protein +FIG00957800 FIG00957803: hypothetical protein +FIG00957803 FIG00957806: hypothetical protein +FIG00957812 FIG00957818: hypothetical protein +FIG00957818 FIG00957829: hypothetical protein +FIG00957833 FIG00957834: hypothetical protein +FIG00957837 FIG00957838: hypothetical protein +FIG00957839 Ethanol dehydrogenase, PQQ-dependent (EC 1.1.99.-) +FIG00957843 FIG00957845: hypothetical protein +FIG00957845 FIG00957847: hypothetical protein +FIG00957847 FIG00957849: hypothetical protein +FIG00957849 FIG00957850: hypothetical protein +FIG00957859 Predicted transcription regulator, contains HTH domain (MarR family) +FIG00957860 probable peptidyl-prolyl cis-trans isomerase, FkbP-type +FIG00957867 Thiopurine S-methyltransferase (EC 2.1.1.67) (Thiopurine methyltransferase) +FIG00957870 FIG00957871: hypothetical protein +FIG00957880 FIG00957881: hypothetical protein +FIG00957881 FIG00957882: hypothetical protein +FIG00957882 FIG00959401: hypothetical protein +FIG00957884 FIG00957886: hypothetical protein +FIG00957892 Glutaminase +FIG00957893 Penicillin acylase (EC 3.5.1.11) +FIG00957900 FIG00957901: hypothetical protein +FIG00957902 FIG00957903: hypothetical protein +FIG00957903 FIG00957905: hypothetical protein +FIG00957905 FIG00957910: hypothetical protein +FIG00957910 FIG00957911: hypothetical protein +FIG00957911 FIG00957912: hypothetical protein +FIG00957913 FIG00957914: hypothetical protein +FIG00957918 FIG00957919: hypothetical protein +FIG00957919 FIG00957921: hypothetical protein +FIG00957921 FIG00957922: hypothetical protein +FIG00957922 FIG00957925: hypothetical protein +FIG00957925 FIG00957927: hypothetical protein +FIG00957929 FIG00957931: hypothetical protein +FIG00957932 FIG00957933: hypothetical protein +FIG00957936 FIG00957938: hypothetical protein +FIG00957941 FIG00957942: hypothetical protein +FIG00957943 FIG00957944: hypothetical protein +FIG00957944 FIG00957947: hypothetical protein +FIG00957947 FIG00957948: hypothetical protein +FIG00957948 fatty acid desaturase family protein, putative +FIG00957954 FIG00957957: hypothetical protein +FIG00957957 FIG00957958: hypothetical protein +FIG00957958 FIG00957959: hypothetical protein +FIG00957963 FIG00957966: hypothetical protein +FIG00957966 Probable pilin chaperone +FIG00957967 FIG00957969: hypothetical protein +FIG00957969 FIG00957971: hypothetical protein +FIG00957973 FIG00957974: hypothetical protein +FIG00957975 type II secretion pathway protein XcpU +FIG00957976 FIG00957977: hypothetical protein +FIG00957984 FIG00957985: hypothetical protein +FIG00957988 FIG00957989: hypothetical protein +FIG00957989 FIG00957990: hypothetical protein +FIG00957990 FIG00957991: hypothetical protein +FIG00957991 FIG00957993: hypothetical protein +FIG00957994 Type III secretion HrpA pilin +FIG00957995 bacterial transferase, hexapeptide repeat protein +FIG00958001 FOG: GAF domain +FIG00958010 FIG00958011: hypothetical protein +FIG00958011 FIG038418: hypothetical protein clustering with LamB +FIG00958013 FIG00958014: hypothetical protein +FIG00958016 FIG00958024: hypothetical protein +FIG00958024 FIG00958026: hypothetical protein +FIG00958033 FIG00958034: hypothetical protein +FIG00958036 Dihydrodipicolinate synthase/N-acetylneuraminate lyase +FIG00958037 Conserved putative membrane protein +FIG00958041 FIG00958048: hypothetical protein +FIG00958050 Regulatory protein, MerR +FIG00958051 FIG00958059: hypothetical protein +FIG00958060 FIG00958061: hypothetical protein +FIG00958061 traK protein +FIG00958062 FIG00958063: hypothetical protein +FIG00958065 similar to Probable taurine catabolism dioxygenase +FIG00958068 FIG00958071: hypothetical protein +FIG00958071 probable thioredoxin +FIG00958081 FIG00958084: hypothetical protein +FIG00958084 FIG00958085: hypothetical protein +FIG00958085 Bacteriophage N4 adsorption protein B +FIG00958089 phage integrase, putative +FIG00958090 FIG00958091: hypothetical protein +FIG00958093 FIG00958097: hypothetical protein +FIG00958097 FIG00958099: hypothetical protein +FIG00958099 FIG00958100: hypothetical protein +FIG00958101 Putative copper export protein +FIG00958104 Predicted sugar nucleotidyltransferases +FIG00958106 Bll1207 protein +FIG00958114 FIG00958115: hypothetical protein +FIG00958115 FIG034647: hypothetical protein in PFGI-1-like cluster +FIG00958123 FIG00958124: hypothetical protein +FIG00958124 FIG00958125: hypothetical protein +FIG00958126 FIG00958127: hypothetical protein +FIG00958128 Nucleoid-associated protein ndpA +FIG00958130 FIG00958131: hypothetical protein +FIG00958131 FIG00958132: hypothetical protein +FIG00958136 FIG00958137: hypothetical protein +FIG00958137 ATPase components of various ABC-type transport systems, contain duplicated ATPase +FIG00958147 FIG00958148: hypothetical protein +FIG00958149 copper resistance protein B precursor +FIG00958152 FIG00958153: hypothetical protein +FIG00958153 RarD protein +FIG00958155 FIG00958158: hypothetical protein +FIG00958159 FIG00958166: hypothetical protein +FIG00958166 FIG00958173: hypothetical protein +FIG00958173 FIG00958177: hypothetical protein +FIG00958177 FIG00958178: hypothetical protein +FIG00958184 FIG00958185: hypothetical protein +FIG00958185 FIG00958186: hypothetical protein +FIG00958186 FIG00958187: hypothetical protein +FIG00958189 Non-hemolytic phospholipase C precursor (EC 3.1.4.3) +FIG00958197 FIG00958198: hypothetical protein +FIG00958199 FIG00958200: hypothetical protein +FIG00958200 FIG00958202: hypothetical protein +FIG00958202 FIG00958205: hypothetical protein +FIG00958205 FIG00958208: hypothetical protein +FIG00958208 FIG00958211: hypothetical protein +FIG00958211 FIG00958213: hypothetical protein +FIG00958213 FIG00958214: hypothetical protein +FIG00958214 Extracellular protease +FIG00958215 CigR (Putative inner membrane protein) +FIG00958216 FIG00958218: hypothetical protein +FIG00958223 FIG00958224: hypothetical protein +FIG00958228 FIG00958233: hypothetical protein +FIG00958233 FIG00958234: hypothetical protein +FIG00958234 FIG00958235: hypothetical protein +FIG00958235 FIG00958237: hypothetical protein +FIG00958237 FIG00958240: hypothetical protein +FIG00958240 FIG00958242: hypothetical protein +FIG00958242 FIG00966085: hypothetical protein +FIG00958246 FIG00958247: hypothetical protein +FIG00958250 FIG00958252: hypothetical protein +FIG00958252 FIG00958255: hypothetical protein +FIG00958255 FIG00958260: hypothetical protein +FIG00958260 FIG00958261: hypothetical protein +FIG00958261 FIG00958262: hypothetical protein +FIG00958262 FIG00958264: hypothetical protein +FIG00958267 FIG00958268: hypothetical protein +FIG00958268 L-Carnitine transporter +FIG00958271 FIG00958272: hypothetical protein +FIG00958277 FIG00958279: hypothetical protein +FIG00958279 Collagen triple helix repeat domain protein +FIG00958284 FIG00958286: hypothetical protein +FIG00958287 Esterase/lipase in siderophore cluster +FIG00958292 putative tRNA ligase +FIG00958299 FIG00958300: hypothetical protein +FIG00958300 probable RebB like protein +FIG00958301 immunity protein, putative +FIG00958303 FIG00958304: hypothetical protein +FIG00958305 Metalloprotease (EC 3.4.24.-) +FIG00958308 FIG00958311: hypothetical protein +FIG00958311 FIG00958313: hypothetical protein +FIG00958313 FIG00958314: hypothetical protein +FIG00958320 sodium/alanine transporter +FIG00958324 FIG00958325: hypothetical protein +FIG00958325 FIG00958326: hypothetical protein +FIG00958328 FIG00958330: hypothetical protein +FIG00958330 FIG00958334: hypothetical protein +FIG00958335 FIG00958338: hypothetical protein +FIG00958338 FIG00958340: hypothetical protein +FIG00958344 FIG00958345: hypothetical protein +FIG00958345 FIG00958347: hypothetical protein +FIG00958354 FIG00958355: hypothetical protein +FIG00958355 FIG00958356: hypothetical protein +FIG00958359 ABC spermidine/putrescine transporter, inner membrane subunit +FIG00958360 FIG00958363: hypothetical protein +FIG00958375 FIG00958379: hypothetical protein +FIG00958379 gamma-aminobutyrate (GABA) permease +FIG00958381 FIG00958382: hypothetical protein +FIG00958382 FIG00958383: hypothetical protein +FIG00958385 FIG00958388: hypothetical protein +FIG00958393 Hpt domain protein +FIG00958396 FIG00958400: hypothetical protein +FIG00958405 FIG00958406: hypothetical protein +FIG00958407 FIG00958408: hypothetical protein +FIG00958408 FIG00958411: hypothetical protein +FIG00958418 FIG00958420: hypothetical protein +FIG00958421 FIG00958425: hypothetical protein +FIG00958430 FIG00958431: hypothetical protein +FIG00958431 Unknown, probable amidinotransferase +FIG00958435 ring-cleaving dioxygenase, putative +FIG00958437 FIG00958440: hypothetical protein +FIG00958440 FIG00958443: hypothetical protein +FIG00958443 FIG00958447: hypothetical protein +FIG00958448 COG1551: Carbon storage regulator (could also regulate swarming and quorum sensing) +FIG00958455 FIG00958458: hypothetical protein +FIG00958458 FIG00958462: hypothetical protein +FIG00958462 FIG00958463: hypothetical protein +FIG00958463 FIG00958464: hypothetical protein +FIG00958464 FIG00958465: hypothetical protein +FIG00958465 probable binding protein component of ABC transporter +FIG00958469 FIG00958470: hypothetical protein +FIG00958470 FIG00958473: hypothetical protein +FIG00958473 FIG00958475: hypothetical protein +FIG00958476 virulence-associated protein, putative +FIG00958479 FIG00958480: hypothetical protein +FIG00958485 FIG00958486: hypothetical protein +FIG00958486 FIG00958488: hypothetical protein +FIG00958492 FIG00958501: hypothetical protein +FIG00958501 FIG00958502: hypothetical protein +FIG00958502 FIG00958504: hypothetical protein +FIG00958504 FIG00958506: hypothetical protein +FIG00958510 FIG00958511: hypothetical protein +FIG00958538 FIG00958540: hypothetical protein +FIG00958540 FIG00958542: hypothetical protein +FIG00958542 FIG00958543: hypothetical protein +FIG00958548 FIG00958550: hypothetical protein +FIG00958551 FIG00958553: hypothetical protein +FIG00958553 FIG00958554: hypothetical protein +FIG00958558 FIG00958560: hypothetical protein +FIG00958567 FIG00958574: hypothetical protein +FIG00958574 FIG00958577: hypothetical protein +FIG00958577 FIG00958579: hypothetical protein +FIG00958579 FIG00958580: hypothetical protein +FIG00958581 FIG00958582: hypothetical protein +FIG00958582 FIG00958584: hypothetical protein +FIG00958584 FIG00958585: hypothetical protein +FIG00958588 FIG00958592: hypothetical protein +FIG00958601 FIG00958604: hypothetical protein +FIG00958607 FIG00958611: hypothetical protein +FIG00958611 FIG00958613: hypothetical protein +FIG00958617 FIG00958619: hypothetical protein +FIG00958628 FIG00958630: hypothetical protein +FIG00958631 FIG00958637: hypothetical protein +FIG00958638 FIG00958640: hypothetical protein +FIG00958658 FIG00958659: hypothetical protein +FIG00958665 FIG00958666: hypothetical protein +FIG00958670 FIG00958671: hypothetical protein +FIG00958687 FIG00958688: hypothetical protein +FIG00958694 pyocin protein +FIG00958696 FIG00958697: hypothetical protein +FIG00958697 FIG00958699: hypothetical protein +FIG00958700 FIG00958701: hypothetical protein +FIG00958704 Baseplate assembly protein W +FIG00958708 FIG00958709: hypothetical protein +FIG00958715 FIG00958716: hypothetical protein +FIG00958716 FIG00958717: hypothetical protein +FIG00958717 COG4339 +FIG00958718 FIG00958720: hypothetical protein +FIG00958720 FIG00958722: hypothetical protein +FIG00958723 FIG00958724: hypothetical protein +FIG00958728 FIG00958730: hypothetical protein +FIG00958730 type III transcriptional regulator HrpS +FIG00958732 FIG00958735: hypothetical protein +FIG00958739 FIG00958742: hypothetical protein +FIG00958749 FIG00958752: hypothetical protein +FIG00958753 FIG033889: YebC paralog in Betaproteobacteria +FIG00958754 Na+/H+ antiporter +FIG00958756 FIG00958758: hypothetical protein +FIG00958758 FIG00958760: hypothetical protein +FIG00958767 FIG00958769: hypothetical protein +FIG00958770 FIG00958771: hypothetical protein +FIG00958772 FIG00958773: hypothetical protein +FIG00958775 FIG00958777: hypothetical protein +FIG00958777 peptide ABC transporter, periplasmic peptide-binding protein +FIG00958781 FIG00958782: hypothetical protein +FIG00958782 FIG00958783: hypothetical protein +FIG00958793 FIG00958794: hypothetical protein +FIG00958799 FIG00958801: hypothetical protein +FIG00958805 FIG00958806: hypothetical protein +FIG00958812 Glyoxalase family protein superfamily +FIG00958815 FIG00958817: hypothetical protein +FIG00958820 hypothetical protein +FIG00958821 FIG00958824: hypothetical protein +FIG00958824 FIG00958825: hypothetical protein +FIG00958825 RidA/YER057c/UK114 superfamily, group 3 +FIG00958828 FIG00958830: hypothetical protein +FIG00958843 FIG00958844: hypothetical protein +FIG00958848 FIG00958850: hypothetical protein +FIG00958850 FIG00958851: hypothetical protein +FIG00958854 putative plasmid stablization protein +FIG00958857 FIG00958859: hypothetical protein +FIG00958859 FIG00958862: hypothetical protein +FIG00958862 FIG00958864: hypothetical protein +FIG00958864 FIG00958868: hypothetical protein +FIG00958873 FIG00958874: hypothetical protein +FIG00958874 Carboxyphosphonoenolpyruvate phosphonomutase (EC 2.7.8.23) +FIG00958875 FIG00958876: hypothetical protein +FIG00958879 FIG00958880: hypothetical protein +FIG00958894 FIG00958895: hypothetical protein +FIG00958898 FIG00958899: hypothetical protein +FIG00958899 FIG00958900: hypothetical protein +FIG00958900 FIG00958903: hypothetical protein +FIG00958908 FIG00958912: hypothetical protein +FIG00958913 FIG00958915: hypothetical protein +FIG00958915 FIG00958920: hypothetical protein +FIG00958920 FIG00958921: hypothetical protein +FIG00958923 Outer membrane porin, coexpressed with pyoverdine biosynthesis regulon +FIG00958927 Putative potassium channel protein +FIG00958931 FIG00958932: hypothetical protein +FIG00958934 FIG00958938: hypothetical protein +FIG00958948 FIG00958953: hypothetical protein +FIG00958957 FIG00958964: hypothetical protein +FIG00958969 FIG00958971: hypothetical protein +FIG00958971 FIG00958973: hypothetical protein +FIG00958974 FIG00958976: hypothetical protein +FIG00958978 FIG00958979: hypothetical protein +FIG00958982 FIG00958987: hypothetical protein +FIG00958987 putative Transcriptional regulatory protein, AraC/XylS family +FIG00958995 FIG00989155: hypothetical protein +FIG00959003 EXOU +FIG00959007 probable amino acid permease +FIG00959018 FIG00959020: hypothetical protein +FIG00959021 FIG00959023: hypothetical protein +FIG00959041 Transcription factor jumonji +FIG00959047 FIG00959048: hypothetical protein +FIG00959051 FIG00959052: hypothetical protein +FIG00959058 FIG00959061: hypothetical protein +FIG00959061 FIG00959064: hypothetical protein +FIG00959064 FIG00959074: hypothetical protein +FIG00959075 FIG00959076: hypothetical protein +FIG00959078 FIG00959083: hypothetical protein +FIG00959084 FIG00959086: hypothetical protein +FIG00959089 FIG00959090: hypothetical protein +FIG00959090 Bll4964 protein +FIG00959091 FIG00959092: hypothetical protein +FIG00959092 Outer membrane protein precursor GNA2001 +FIG00959100 FIG00959101: hypothetical protein +FIG00959107 FIG00959109: hypothetical protein +FIG00959109 FIG00959112: hypothetical protein +FIG00959113 FIG00959115: hypothetical protein +FIG00959116 FIG00959117: hypothetical protein +FIG00959124 FIG00959125: hypothetical protein +FIG00959125 putative thioredoxin +FIG00959131 FIG00959132: hypothetical protein +FIG00959132 FIG00959133: hypothetical protein +FIG00959152 FIG00959153: hypothetical protein +FIG00959153 FIG00959155: hypothetical protein +FIG00959155 FIG00959156: hypothetical protein +FIG00959157 FIG00959158: hypothetical protein +FIG00959164 FIG00959165: hypothetical protein +FIG00959167 FIG00959172: hypothetical protein +FIG00959178 FIG00959181: hypothetical protein +FIG00959183 FIG00959189: hypothetical protein +FIG00959202 FIG00959203: hypothetical protein +FIG00959204 FIG00959207: hypothetical protein +FIG00959210 FIG00959212: hypothetical protein +FIG00959215 FIG00959217: hypothetical protein +FIG00959217 FIG00959221: hypothetical protein +FIG00959226 FIG00959227: hypothetical protein +FIG00959227 FIG00959231: hypothetical protein +FIG00959231 Possible Glycerol-3-phosphate dehydrogenase (EC 1.1.5.3) +FIG00959235 FIG00959238: hypothetical protein +FIG00959238 FIG00959244: hypothetical protein +FIG00959244 FIG00959245: hypothetical protein +FIG00959245 FIG00959248: hypothetical protein +FIG00959248 FIG00959249: hypothetical protein +FIG00959256 FIG00959257: hypothetical protein +FIG00959257 FIG00959267: hypothetical protein +FIG00959270 probable amidase +FIG00959273 FIG00959274: hypothetical protein +FIG00959283 type I toxin efflux outer membrane protein, TolC family +FIG00959286 FIG00959288: hypothetical protein +FIG00959291 FIG00959294: hypothetical protein +FIG00959294 FIG00959295: hypothetical protein +FIG00959300 FIG00985226: hypothetical protein +FIG00959302 FIG00959303: hypothetical protein +FIG00959303 FIG00959308: hypothetical protein +FIG00959315 FIG00959318: hypothetical protein +FIG00959323 Probable aminotransferase PA4088 +FIG00959324 FIG00959326: hypothetical protein +FIG00959326 FIG00959330: hypothetical protein +FIG00959332 FIG00959333: hypothetical protein +FIG00959337 addiction module toxin, RelE/StbE family protein +FIG00959338 FIG00959341: hypothetical protein +FIG00959341 FIG00959345: hypothetical protein +FIG00959345 FIG00959348: hypothetical protein +FIG00959349 FIG00959350: hypothetical protein +FIG00959351 FIG00959354: hypothetical protein +FIG00959354 FIG00959357: hypothetical protein +FIG00959362 FIG00959363: hypothetical protein +FIG00959364 FIG00959371: hypothetical protein +FIG00959371 FIG00959374: hypothetical protein +FIG00959376 FIG00959377: hypothetical protein +FIG00959377 FIG00959382: hypothetical protein +FIG00959382 FIG00959384: hypothetical protein +FIG00959386 FIG00959387: hypothetical protein +FIG00959390 FIG00959392: hypothetical protein +FIG00959392 FIG00959393: hypothetical protein +FIG00959393 FIG00959395: hypothetical protein +FIG00959401 FIG00959402: hypothetical protein +FIG00959402 FIG00959406: hypothetical protein +FIG00959406 FIG00959407: hypothetical protein +FIG00959407 FIG00959409: hypothetical protein +FIG00959409 FIG00959410: hypothetical protein +FIG00959410 FIG00959412: hypothetical protein +FIG00959415 FIG00959417: hypothetical protein +FIG00959427 FIG00959428: hypothetical protein +FIG00959428 FIG00959431: hypothetical protein +FIG00959431 FIG00959432: hypothetical protein +FIG00959432 N-acetylmuramoyl-L-alanine amidase, putative +FIG00959436 FIG00959437: hypothetical protein +FIG00959437 FIG00959438: hypothetical protein +FIG00959442 FIG00959443: hypothetical protein +FIG00959443 FIG00959446: hypothetical protein +FIG00959446 DNA-binding protein Roi-related protein +FIG00959448 FIG00959449: hypothetical protein +FIG00959449 FIG00959450: hypothetical protein +FIG00959456 FIG00959457: hypothetical protein +FIG00959462 FIG00959463: hypothetical protein +FIG00959463 FIG00959464: hypothetical protein +FIG00959464 FIG00959466: hypothetical protein +FIG00959466 FIG00959468: hypothetical protein +FIG00959468 FIG00959469: hypothetical protein +FIG00959469 Mll4293 protein +FIG00959471 hypothetical protein +FIG00959487 FIG00959488: hypothetical protein +FIG00959499 FIG00959500: hypothetical protein +FIG00959500 probable pili assembly chaperone +FIG00959507 FIG00959508: hypothetical protein +FIG00959514 FIG00959516: hypothetical protein +FIG00959519 FIG00959520: hypothetical protein +FIG00959520 FIG00959521: hypothetical protein +FIG00959521 Type III effector protein AvrE1 +FIG00959533 FIG00959535: hypothetical protein +FIG00959535 FIG00959540: hypothetical protein +FIG00959540 FIG00959542: hypothetical protein +FIG00959542 FIG00959545: hypothetical protein +FIG00959548 FIG00959549: hypothetical protein +FIG00959549 FIG00959550: hypothetical protein +FIG00959550 FIG00959552: hypothetical protein +FIG00959558 FIG00959560: hypothetical protein +FIG00959560 FIG00959563: hypothetical protein +FIG00959563 FIG00959565: hypothetical protein +FIG00959565 FIG00959566: hypothetical protein +FIG00959575 FIG00959580: hypothetical protein +FIG00959581 FIG00959582: hypothetical protein +FIG00959582 FIG00959584: hypothetical protein +FIG00959588 FIG00959590: hypothetical protein +FIG00959594 FIG00959595: hypothetical protein +FIG00959609 FIG00959611: hypothetical protein +FIG00959619 FIG00959622: hypothetical protein +FIG00959622 FIG00959623: hypothetical protein +FIG00959623 FIG00959624: hypothetical protein +FIG00959626 FIG00959628: hypothetical protein +FIG00959628 Cinnamyl-alcohol dehydrogenase-like protein (EC 1.1.1.195) +FIG00959629 FIG00959630: hypothetical protein +FIG00959630 FIG00959634: hypothetical protein +FIG00959653 FIG00959654: hypothetical protein +FIG00959676 Endonuclease/Exonuclease/phosphatase family protein +FIG00959689 FIG00959693: hypothetical protein +FIG00959694 FIG00959695: hypothetical protein +FIG00959695 FIG00959696: hypothetical protein +FIG00959700 FIG00959701: hypothetical protein +FIG00959701 FIG00959703: hypothetical protein +FIG00959718 KaiC +FIG00959720 FIG00959721: hypothetical protein +FIG00959721 Probable deaminase +FIG00959723 probable sigma-70 factor, ECF subfamily +FIG00959742 FIG00959750: hypothetical protein +FIG00959750 FIG00959753: hypothetical protein +FIG00959753 FIG00959755: hypothetical protein +FIG00959755 FIG00959757: hypothetical protein +FIG00959758 FIG00959759: hypothetical protein +FIG00959759 FIG00959760: hypothetical protein +FIG00959766 FIG00959768: hypothetical protein +FIG00959768 FIG00959769: hypothetical protein +FIG00959769 protein activator of alkane oxidation PraA +FIG00959778 Purine-cytosine permease +FIG00959787 FIG00959788: hypothetical protein +FIG00959788 FIG00959791: hypothetical protein +FIG00959793 FIG00959795: hypothetical protein +FIG00959795 FIG00959796: hypothetical protein +FIG00959797 FIG00959799: hypothetical protein +FIG00959801 4-oxalmesaconate hydratase (EC 4.2.1.83) +FIG00959803 FIG00959804: hypothetical protein +FIG00959804 Bll1128 protein +FIG00959805 FIG00959806: hypothetical protein +FIG00959809 FIG00959811: hypothetical protein +FIG00959816 FIG00959817: hypothetical protein +FIG00959820 FIG00959827: hypothetical protein +FIG00959830 FIG00959831: hypothetical protein +FIG00959834 transferase, putative +FIG00959840 FIG00959843: hypothetical protein +FIG00959843 FIG00959844: hypothetical protein +FIG00959844 FIG00959849: hypothetical protein +FIG00959849 FIG00959850: hypothetical protein +FIG00959850 FIG00959851: hypothetical protein +FIG00959855 FIG00959859: hypothetical protein +FIG00959862 FIG00959863: hypothetical protein +FIG00959863 FIG00959864: hypothetical protein +FIG00959872 FIG00959873: hypothetical protein +FIG00959874 FIG00959876: hypothetical protein +FIG00959876 FIG00959883: hypothetical protein +FIG00959883 FIG00959885: hypothetical protein +FIG00959885 FIG00959886: hypothetical protein +FIG00959896 Leucine-rich repeat (LRR) protein +FIG00959901 FIG00959904: hypothetical protein +FIG00959904 FIG00959905: hypothetical protein +FIG00959908 Extracellular Matrix protein PelC +FIG00959921 FIG00959928: hypothetical protein +FIG00959930 FIG00959931: hypothetical protein +FIG00959932 Predicted acetyltransferases and hydrolases with the alpha/beta hydrolase fold +FIG00959935 FIG00959937: hypothetical protein +FIG00959937 FIG00959942: hypothetical protein +FIG00959945 type III helper protein HrpZ(Pto) +FIG00959963 FIG00959964: hypothetical protein +FIG00959964 FIG00959965: hypothetical protein +FIG00959965 lectin repeat domain protein +FIG00959971 FIG00959974: hypothetical protein +FIG00959974 FIG00959976: hypothetical protein +FIG00959976 trbA protein +FIG00959990 FIG00959991: hypothetical protein +FIG00960002 autotransporter, putative +FIG00960010 FIG00960013: hypothetical protein +FIG00960021 FIG00960022: hypothetical protein +FIG00960023 FIG00960025: hypothetical protein +FIG00960025 FIG00960035: hypothetical protein +FIG00960036 FIG00960037: hypothetical protein +FIG00960043 FIG00960046: hypothetical protein +FIG00960054 FIG00960055: hypothetical protein +FIG00960057 FIG00960065: hypothetical protein +FIG00960072 COG3182: Uncharacterized iron-regulated membrane protein +FIG00960074 FIG00960076: hypothetical protein +FIG00960076 FIG00960078: hypothetical protein +FIG00960078 FIG00960080: hypothetical protein +FIG00960080 FIG00960081: hypothetical protein +FIG00960085 FIG00960086: hypothetical protein +FIG00960088 FIG00960090: hypothetical protein +FIG00960090 FIG00960094: hypothetical protein +FIG00960094 FIG00960096: hypothetical protein +FIG00960103 FIG00960104: hypothetical protein +FIG00960104 FIG00960106: hypothetical protein +FIG00960106 AvrPphE +FIG00960108 FIG00960109: hypothetical protein +FIG00960115 FIG00960119: hypothetical protein +FIG00960119 FIG00960122: hypothetical protein +FIG00960122 UDP-2,3-diacetamido-2,3-dideoxy-D-mannuronic acid transferase +FIG00960123 FIG00960127: hypothetical protein +FIG00960129 FIG00960133: hypothetical protein +FIG00960133 FIG00960134: hypothetical protein +FIG00960141 FIG00960143: hypothetical protein +FIG00960143 FIG00960144: hypothetical protein +FIG00960147 FIG00960148: hypothetical protein +FIG00960152 FIG00960153: hypothetical protein +FIG00960153 FIG00960156: hypothetical protein +FIG00960159 FIG00960160: hypothetical protein +FIG00960164 FIG00960169: hypothetical protein +FIG00960175 FIG00960176: hypothetical protein +FIG00960178 FIG00960180: hypothetical protein +FIG00960180 FIG00960181: hypothetical protein +FIG00960181 FIG00960182: hypothetical protein +FIG00960184 FIG00960186: hypothetical protein +FIG00960193 FIG00960195: hypothetical protein +FIG00960196 ABC transporter, permease/ATP-binding protein, putative +FIG00960202 FIG00960203: hypothetical protein +FIG00960203 plasmid stabilization system family protein +FIG00960217 FIG00960221: hypothetical protein +FIG00960221 FIG00960224: hypothetical protein +FIG00960224 Disease resistance protein / Tetratricopeptide repeat-containing protein +FIG00960237 Capsule polysaccharide modification protein lipB +FIG00960276 FIG00960278: hypothetical protein +FIG00960278 FIG00960279: hypothetical protein +FIG00960282 FIG00960291: hypothetical protein +FIG00960291 FIG00960294: hypothetical protein +FIG00960294 FIG00960298: hypothetical protein +FIG00960312 FIG00960314: hypothetical protein +FIG00960314 FIG00960315: hypothetical protein +FIG00960315 FIG00960316: hypothetical protein +FIG00960328 possible ribonuclease inhibitor +FIG00960359 FIG00960364: hypothetical protein +FIG00960367 FIG00960376: hypothetical protein +FIG00960377 FIG00960378: hypothetical protein +FIG00960378 FIG00960379: hypothetical protein +FIG00960384 FIG00960388: hypothetical protein +FIG00960389 FIG00960393: hypothetical protein +FIG00960397 FIG00960399: hypothetical protein +FIG00960399 FIG00960402: hypothetical protein +FIG00960403 auxin-binding protein, putative +FIG00960406 FIG00960409: hypothetical protein +FIG00960409 FIG00960412: hypothetical protein +FIG00960413 FIG00960414: hypothetical protein +FIG00960421 FIG00960423: hypothetical protein +FIG00960426 FIG00960428: hypothetical protein +FIG00960441 Integral membrane protein +FIG00960454 FIG00960455: hypothetical protein +FIG00960459 FIG00960460: hypothetical protein +FIG00960461 mobilization protein MobB, putative +FIG00960462 FIG00960465: hypothetical protein +FIG00960467 FIG00960468: hypothetical protein +FIG00960469 FIG00960470: hypothetical protein +FIG00960480 FIG00960482: hypothetical protein +FIG00960482 FIG00960484: hypothetical protein +FIG00960485 FIG00960489: hypothetical protein +FIG00960489 carbon storage regulator, putative +FIG00960493 FIG00960494: hypothetical protein +FIG00960494 FIG00960498: hypothetical protein +FIG00960501 FIG00960504: hypothetical protein +FIG00960504 FIG00960508: hypothetical protein +FIG00960508 FIG00960510: hypothetical protein +FIG00960510 FIG00960512: hypothetical protein +FIG00960517 FIG00960520: hypothetical protein +FIG00960522 FIG00960523: hypothetical protein +FIG00960525 FIG00960527: hypothetical protein +FIG00960527 FIG00960528: hypothetical protein +FIG00960541 FIG00960543: hypothetical protein +FIG00960543 FIG00960545: hypothetical protein +FIG00960545 HigA protein (antitoxin to HigB) +FIG00960550 FIG00960554: hypothetical protein +FIG00960554 (R)-3-hydroxydecanoyl-ACP:CoA transacylase (EC 2.4.1.-) +FIG00960559 FIG00960566: hypothetical protein +FIG00960571 FIG00960578: hypothetical protein +FIG00960585 FIG00960586: hypothetical protein +FIG00960589 FIG00960590: hypothetical protein +FIG00960594 Acyl-CoA dehydrogenase( EC:1.3.99.3 ) +FIG00960595 FIG00960598: hypothetical protein +FIG00960598 probable auxin-responsive-like protein +FIG00960605 FIG00960608: hypothetical protein +FIG00960610 COG1156: Archaeal/vacuolar-type H+-ATPase subunit B +FIG00960612 FIG00960616: hypothetical protein +FIG00960616 FIG00960617: hypothetical protein +FIG00960617 FIG00960618: hypothetical protein +FIG00960618 FIG00960622: hypothetical protein +FIG00960642 FIG00960645: hypothetical protein +FIG00960645 FIG00960646: hypothetical protein +FIG00960646 FIG00960647: hypothetical protein +FIG00960651 FIG00960652: hypothetical protein +FIG00960662 FIG00960665: hypothetical protein +FIG00960668 FIG00960671: hypothetical protein +FIG00960674 FIG00960679: hypothetical protein +FIG00960680 FIG00960681: hypothetical protein +FIG00960681 Phosphopantothenoylcysteine synthetase/decarboxylase +FIG00960684 His-Xaa-Ser repeat protein +FIG00960685 FIG00960688: hypothetical protein +FIG00960688 FIG00960689: hypothetical protein +FIG00960689 Isoflavone reductase +FIG00960693 FIG00960698: hypothetical protein +FIG00960709 Inhibitor of the KinA pathway to sporulation, predicted exonuclease +FIG00960715 FIG00960717: hypothetical protein +FIG00960719 FIG00960722: hypothetical protein +FIG00960722 FIG00960725: hypothetical protein +FIG00960725 FIG00960726: hypothetical protein +FIG00960726 3-oxoacyl-(acyl-carrier-protein) synthase II, putative +FIG00960740 FIG00960741: hypothetical protein +FIG00960749 FIG00960753: hypothetical protein +FIG00960753 FIG00960755: hypothetical protein +FIG00960761 FIG00960762: hypothetical protein +FIG00960766 FIG00960770: hypothetical protein +FIG00960773 FIG00960774: hypothetical protein +FIG00960774 Conjugative transfer protein PilP in PFGI-1-like cluster +FIG00960778 FIG00960779: hypothetical protein +FIG00960779 FIG00960780: hypothetical protein +FIG00960780 FIG00960783: hypothetical protein +FIG00960783 FIG00960787: hypothetical protein +FIG00960787 FIG00960788: hypothetical protein +FIG00960788 FIG00960789: hypothetical protein +FIG00960796 FIG00960798: hypothetical protein +FIG00960800 COG3646: Uncharacterized phage-encoded protein +FIG00960813 FIG00960817: hypothetical protein +FIG00960820 FIG00960825: hypothetical protein +FIG00960826 FIG00960829: hypothetical protein +FIG00960834 FIG00960837: hypothetical protein +FIG00960837 FIG00960839: hypothetical protein +FIG00960844 FIG00960845: hypothetical protein +FIG00960849 FIG00960851: hypothetical protein +FIG00960851 FIG00960854: hypothetical protein +FIG00960857 FIG00960858: hypothetical protein +FIG00960858 FIG00960860: hypothetical protein +FIG00960860 FIG00960861: hypothetical protein +FIG00960863 FIG00960864: hypothetical protein +FIG00960864 FIG00960866: hypothetical protein +FIG00960866 FIG00960876: hypothetical protein +FIG00960877 FIG00960878: hypothetical protein +FIG00960878 FIG00960879: hypothetical protein +FIG00960879 O-acyltransferase, putative +FIG00960882 FIG00960888: hypothetical protein +FIG00960888 FIG00960890: hypothetical protein +FIG00960890 FIG00960892: hypothetical protein +FIG00960892 FIG00960896: hypothetical protein +FIG00960902 sodium:solute symporter family protein +FIG00960905 FIG00960906: hypothetical protein +FIG00960907 antitermination protein Q, putative +FIG00960910 FIG00960913: hypothetical protein +FIG00960913 FIG00960914: hypothetical protein +FIG00960915 FIG00960921: hypothetical protein +FIG00960929 FIG00960930: hypothetical protein +FIG00960936 FIG00960941: hypothetical protein +FIG00960941 FIG00960943: hypothetical protein +FIG00960945 FIG00960947: hypothetical protein +FIG00960947 FIG00960948: hypothetical protein +FIG00960958 FIG00960959: hypothetical protein +FIG00960959 FIG00960960: hypothetical protein +FIG00960963 FIG00960964: hypothetical protein +FIG00960968 FIG00960973: hypothetical protein +FIG00960973 FIG00960974: hypothetical protein +FIG00960990 multidrug resistance transporter, Bcr/CflA family +FIG00960994 FIG00960995: hypothetical protein +FIG00961002 FIG00961010: hypothetical protein +FIG00961011 FIG00961012: hypothetical protein +FIG00961013 FIG00961015: hypothetical protein +FIG00961015 FIG00961017: hypothetical protein +FIG00961023 FIG00961024: hypothetical protein +FIG00961024 pyocin/colicin protein, putative +FIG00961030 FIG00961031: hypothetical protein +FIG00961031 MFS sugar transporter +FIG00961032 FIG00961033: hypothetical protein +FIG00961045 resiniferatoxin-binding, phosphotriesterase-related protein +FIG00961051 FIG00961053: hypothetical protein +FIG00961066 FIG00961069: hypothetical protein +FIG00961069 Myosin heavy chain B (MHC B) +FIG00961085 exclusion-determining protein, putative +FIG00961087 FIG00961088: hypothetical protein +FIG00961088 putative two-component system sensor histidine kinase, putative heat shock protein +FIG00961091 FIG00961099: hypothetical protein +FIG00961109 FIG00961112: hypothetical protein +FIG00961112 FIG00961116: hypothetical protein +FIG00961116 FIG00961121: hypothetical protein +FIG00961122 FIG00961123: hypothetical protein +FIG00961124 FIG00961128: hypothetical protein +FIG00961134 FIG00961140: hypothetical protein +FIG00961140 FIG00961141: hypothetical protein +FIG00961141 FIG00961145: hypothetical protein +FIG00961146 FIG00961147: hypothetical protein +FIG00961148 FIG00961153: hypothetical protein +FIG00961161 FIG00961164: hypothetical protein +FIG00961166 FIG00961167: hypothetical protein +FIG00961167 FIG00961168: hypothetical protein +FIG00961172 FIG00961768: hypothetical protein +FIG00961183 FIG00961187: hypothetical protein +FIG00961190 FIG00961192: hypothetical protein +FIG00961192 FIG00961195: hypothetical protein +FIG00961195 FIG00961199: hypothetical protein +FIG00961201 FIG00961202: hypothetical protein +FIG00961203 FIG00961210: hypothetical protein +FIG00961224 Arginine transport system permease protein ArtQ +FIG00961226 FIG00961229: hypothetical protein +FIG00961232 FIG00961233: hypothetical protein +FIG00961240 FIG00961247: hypothetical protein +FIG00961249 FIG00961250: hypothetical protein +FIG00961261 ORF_12 +FIG00961273 FIG00965327: hypothetical protein +FIG00961292 FIG00961293: hypothetical protein +FIG00961305 FIG00961306: hypothetical protein +FIG00961306 FIG00961308: hypothetical protein +FIG00961308 probable membrane protein STY3606 +FIG00961315 probable transcription regulator PA3771 +FIG00961323 Type III effector Hrp-dependent outers +FIG00961325 FIG00961328: hypothetical protein +FIG00961334 FIG00961335: hypothetical protein +FIG00961335 FIG00961338: hypothetical protein +FIG00961341 probable chemotaxis protein +FIG00961343 FIG00961348: hypothetical protein +FIG00961353 FIG00961355: hypothetical protein +FIG00961356 FIG00961357: hypothetical protein +FIG00961357 mutT/nudix family protein( EC:3.6.1.- ) +FIG00961363 FIG00961366: hypothetical protein +FIG00961368 FIG00961371: hypothetical protein +FIG00961371 FIG00961372: hypothetical protein +FIG00961373 glyoxalase family protein family +FIG00961376 FIG00961385: hypothetical protein +FIG00961385 FIG00961388: hypothetical protein +FIG00961393 FIG00961396: hypothetical protein +FIG00961396 FIG00961397: hypothetical protein +FIG00961416 FIG00961417: hypothetical protein +FIG00961419 FIG00961420: hypothetical protein +FIG00961420 FIG00961421: hypothetical protein +FIG00961429 FIG00961430: hypothetical protein +FIG00961434 FIG00961435: hypothetical protein +FIG00961435 isomerase, putative +FIG00961436 FIG00961438: hypothetical protein +FIG00961439 FIG00961441: hypothetical protein +FIG00961443 FIG00961448: hypothetical protein +FIG00961465 FIG00961472: hypothetical protein +FIG00961472 FIG00961475: hypothetical protein +FIG00961478 COG1232: Protoporphyrinogen oxidase +FIG00961483 FIG00961484: hypothetical protein +FIG00961484 FIG00961493: hypothetical protein +FIG00961515 FIG00961516: hypothetical protein +FIG00961516 FIG00961517: hypothetical protein +FIG00961519 FIG00961522: hypothetical protein +FIG00961522 FIG00961523: hypothetical protein +FIG00961525 UvrD/REP helicase family protein +FIG00961528 FIG00961530: hypothetical protein +FIG00961530 Serine protease homologue +FIG00961537 FIG00961543: hypothetical protein +FIG00961550 FIG00961553: hypothetical protein +FIG00961558 FIG00961559: hypothetical protein +FIG00961561 FIG00961566: hypothetical protein +FIG00961566 FIG00961567: hypothetical protein +FIG00961567 5-methylcytosine-specific restriction enzyme McrB related protein +FIG00961579 FIG00961583: hypothetical protein +FIG00961584 FIG00961586: hypothetical protein +FIG00961590 FIG00961592: hypothetical protein +FIG00961594 FIG00961595: hypothetical protein +FIG00961596 FIG00961597: hypothetical protein +FIG00961607 FIG00961613: hypothetical protein +FIG00961613 FIG00961614: hypothetical protein +FIG00961614 FIG00961617: hypothetical protein +FIG00961617 FIG00961627: hypothetical protein +FIG00961631 FIG00961634: hypothetical protein +FIG00961651 FIG00961652: hypothetical protein +FIG00961652 FIG00961656: hypothetical protein +FIG00961656 FIG00961661: hypothetical protein +FIG00961678 FIG00961680: hypothetical protein +FIG00961680 FIG00961682: hypothetical protein +FIG00961703 FIG00961704: hypothetical protein +FIG00961704 FIG00961706: hypothetical protein +FIG00961706 FIG00961707: hypothetical protein +FIG00961707 Sensor histidine kinase/GAF domain hybrid protein (EC 2.7.3.-) +FIG00961710 Probable porin +FIG00961743 FIG00961747: hypothetical protein +FIG00961747 COG4341: Predicted HD phosphohydrolase +FIG00961752 FIG00961753: hypothetical protein +FIG00961772 FIG00961773: hypothetical protein +FIG00961774 FIG00961775: hypothetical protein +FIG00961775 type III chaperone ShcS2 +FIG00961782 Probable head completion/stabilization protein +FIG00961785 FIG00961787: hypothetical protein +FIG00961790 FIG00961793: hypothetical protein +FIG00961794 FIG00961795: hypothetical protein +FIG00961798 opine ABC transporter, permease protein, putative +FIG00961799 FIG00961805: hypothetical protein +FIG00961805 FIG00961806: hypothetical protein +FIG00961822 FIG00961823: hypothetical protein +FIG00961824 FIG00961828: hypothetical protein +FIG00961828 FIG00961830: hypothetical protein +FIG00961856 FIG00961857: hypothetical protein +FIG00961857 FIG00961859: hypothetical protein +FIG00961863 FIG00961864: hypothetical protein +FIG00961864 FIG00961868: hypothetical protein +FIG00961880 FIG00961884: hypothetical protein +FIG00961888 FIG00961889: hypothetical protein +FIG00961889 FIG00961894: hypothetical protein +FIG00961898 FIG00961902: hypothetical protein +FIG00961909 Mutator MutT protein +FIG00961913 FIG00961914: hypothetical protein +FIG00961915 FIG00961917: hypothetical protein +FIG00961919 FIG00961921: hypothetical protein +FIG00961938 FIG00961940: hypothetical protein +FIG00961941 type III chaperone protein ShcA +FIG00961944 FIG00961945: hypothetical protein +FIG00961965 FIG00961966: hypothetical protein +FIG00961989 TRAG protein +FIG00961990 FIG00961991: hypothetical protein +FIG00961992 FIG00961993: hypothetical protein +FIG00962009 FIG00962011: hypothetical protein +FIG00962025 FIG00962026: hypothetical protein +FIG00962053 FIG00962054: hypothetical protein +FIG00962054 FIG00962058: hypothetical protein +FIG00962062 Membrane protein, TerC family +FIG00962066 FIG00962067: hypothetical protein +FIG00962072 hypothetical protein +FIG00962074 avirulence protein AvrF +FIG00962076 FIG00962078: hypothetical protein +FIG00962078 FIG00962079: hypothetical protein +FIG00962114 FIG00962118: hypothetical protein +FIG00962119 FIG00962120: hypothetical protein +FIG00962120 FIG00962123: hypothetical protein +FIG00962123 FIG00962125: hypothetical protein +FIG00962127 Adenylate kinase and related kinases +FIG00962129 FIG00962130: hypothetical protein +FIG00962135 FIG00962137: hypothetical protein +FIG00962138 FIG00962140: hypothetical protein +FIG00962140 FIG00962145: hypothetical protein +FIG00962147 FIG00962150: hypothetical protein +FIG00962158 FIG00962160: hypothetical protein +FIG00962173 FIG00962175: hypothetical protein +FIG00962181 FIG00962184: hypothetical protein +FIG00962188 FIG00962190: hypothetical protein +FIG00962190 FIG00962194: hypothetical protein +FIG00962201 FIG00962202: hypothetical protein +FIG00962205 FIG00962212: hypothetical protein +FIG00962212 Transcriptional activator protein lasR +FIG00962218 FIG00962219: hypothetical protein +FIG00962220 Glycosyltransferase, group 2 family protein +FIG00962226 FIG00962234: hypothetical protein +FIG00962234 FIG00962236: hypothetical protein +FIG00962250 FIG00962252: hypothetical protein +FIG00962267 FIG00962276: hypothetical protein +FIG00962276 FIG00962279: hypothetical protein +FIG00962284 FIG00962285: hypothetical protein +FIG00962286 FIG00962287: hypothetical protein +FIG00962289 Cytochrome c +FIG00962311 FIG00962312: hypothetical protein +FIG00962312 hypothetical protein, INTERPRO-suggestion: probable ferritin-like +FIG00962314 predicted by FrameD +FIG00962321 FIG00962323: hypothetical protein +FIG00962323 probable O-methyltransferase +FIG00962325 FIG00962329: hypothetical protein +FIG00962343 FIG00962345: hypothetical protein +FIG00962347 FIG00962350: hypothetical protein +FIG00962354 FIG00962356: hypothetical protein +FIG00962369 FIG00962371: hypothetical protein +FIG00962372 FIG00962374: hypothetical protein +FIG00962374 FIG00962376: hypothetical protein +FIG00962377 FIG00962378: hypothetical protein +FIG00962393 FIG00962394: hypothetical protein +FIG00962394 FIG00962395: hypothetical protein +FIG00962397 FIG00962398: hypothetical protein +FIG00962398 FIG00962406: hypothetical protein +FIG00962414 FIG00962417: hypothetical protein +FIG00962418 FIG00962419: hypothetical protein +FIG00962421 FIG00962423: hypothetical protein +FIG00962443 cell morphology protein +FIG00962457 FIG00962459: hypothetical protein +FIG00962459 FIG00962464: hypothetical protein +FIG00962465 FIG00962473: hypothetical protein +FIG00962517 FIG00962518: hypothetical protein +FIG00962522 FIG00962526: hypothetical protein +FIG00962528 FIG00962529: hypothetical protein +FIG00962529 FIG00962532: hypothetical protein +FIG00962555 FIG00962561: hypothetical protein +FIG00962561 FIG00962566: hypothetical protein +FIG00962566 FIG00962567: hypothetical protein +FIG00962583 FIG00962584: hypothetical protein +FIG00962587 D-nopaline/octopine oxidase subunit B @ Opine oxidase subunit B +FIG00962599 FIG00962602: hypothetical protein +FIG00962602 FIG00962604: hypothetical protein +FIG00962609 FIG00962610: hypothetical protein +FIG00962611 Putrescine ABC transporter, periplasmic putrescine-binding protein +FIG00962613 FIG00962617: hypothetical protein +FIG00962618 FIG00962620: hypothetical protein +FIG00962624 FIG00962626: hypothetical protein +FIG00962626 FIG00962627: hypothetical protein +FIG00962627 FIG00962631: hypothetical protein +FIG00962644 FIG00955760: hypothetical protein +FIG00962647 FIG00962652: hypothetical protein +FIG00962658 FIG00962659: hypothetical protein +FIG00962663 FIG00962667: hypothetical protein +FIG00962680 FIG00962684: hypothetical protein +FIG00962697 FIG00962702: hypothetical protein +FIG00962702 FIG00962703: hypothetical protein +FIG00962706 Major pilus subunit of type IV secretion complex, VirB2 +FIG00962718 FIG00962723: hypothetical protein +FIG00962723 FIG00962724: hypothetical protein +FIG00962727 FIG00962730: hypothetical protein +FIG00962752 FIG00962753: hypothetical protein +FIG00962757 Protein of unknown function (DUF636) family +FIG00962764 FIG00962766: hypothetical protein +FIG00962766 peptide ABC transporter, ATP-binding protein +FIG00962775 FIG00962778: hypothetical protein +FIG00962784 FIG00962786: hypothetical protein +FIG00962799 FIG00962800: hypothetical protein +FIG00962800 FIG00962802: hypothetical protein +FIG00962807 FIG00962810: hypothetical protein +FIG00962816 FIG00962823: hypothetical protein +FIG00962823 FIG00962831: hypothetical protein +FIG00962844 FIG00962845: hypothetical protein +FIG00962846 FIG00962849: hypothetical protein +FIG00962866 FIG00962867: hypothetical protein +FIG00962867 FIG00962868: hypothetical protein +FIG00962868 FIG00962871: hypothetical protein +FIG00962871 Peptidyl-Asp metalloendopeptidase +FIG00962884 FIG00962885: hypothetical protein +FIG00962885 FIG00962886: hypothetical protein +FIG00962891 Transposon Tn7 transposition protein tnsA +FIG00962895 FIG00962896: hypothetical protein +FIG00962896 FIG00962898: hypothetical protein +FIG00962908 FIG00962909: hypothetical protein +FIG00962912 phage holin, lambda family +FIG00962931 regulatory protein, DeoR +FIG00962940 FIG00962941: hypothetical protein +FIG00962943 FIG00962948: hypothetical protein +FIG00962949 FIG00962954: hypothetical protein +FIG00962963 FIG00962965: hypothetical protein +FIG00962991 FIG00962992: hypothetical protein +FIG00962993 FIG00963000: hypothetical protein +FIG00963007 FIG00963008: hypothetical protein +FIG00963009 FIG00963011: hypothetical protein +FIG00963012 FIG00963014: hypothetical protein +FIG00963014 FIG00963018: hypothetical protein +FIG00963019 FIG00963021: hypothetical protein +FIG00963029 FIG00963036: hypothetical protein +FIG00963036 FIG00963037: hypothetical protein +FIG00963044 FIG00963046: hypothetical protein +FIG00963047 FIG00963049: hypothetical protein +FIG00963049 FIG00963050: hypothetical protein +FIG00963050 FIG00963053: hypothetical protein +FIG00963063 FIG00963068: hypothetical protein +FIG00963068 Chromosome segregation ATPases +FIG00963069 FIG00963072: hypothetical protein +FIG00963072 FIG00963075: hypothetical protein +FIG00963076 deoxynucleotide monophosphate kinase, putative +FIG00963078 FIG00963084: hypothetical protein +FIG00963085 FIG00963086: hypothetical protein +FIG00963091 hypothetical protein +FIG00963095 FIG00963097: hypothetical protein +FIG00963097 FIG00963100: hypothetical protein +FIG00963100 FIG00963107: hypothetical protein +FIG00963141 FIG00963143: hypothetical protein +FIG00963156 FIG00963160: hypothetical protein +FIG00963163 O-acetylhomoserine sulfhydrylase (EC 2.5.1.49) +FIG00963164 FIG00963175: hypothetical protein +FIG00963175 FIG00963183: hypothetical protein +FIG00963191 FIG00963196: hypothetical protein +FIG00963206 Putative dehydrogenase domain of multifunctional non-ribosomal peptide synthetases and related enzymes +FIG00963212 FIG00963213: hypothetical protein +FIG00963213 FIG00963215: hypothetical protein +FIG00963215 FIG00963216: hypothetical protein +FIG00963223 FIG00963224: hypothetical protein +FIG00963235 FIG00963237: hypothetical protein +FIG00963254 FIG00963256: hypothetical protein +FIG00963265 FIG00963268: hypothetical protein +FIG00963273 FIG00963275: hypothetical protein +FIG00963275 FIG00963276: hypothetical protein +FIG00963285 FIG00963293: hypothetical protein +FIG00963313 FIG00963314: hypothetical protein +FIG00963334 FIG00963335: hypothetical protein +FIG00963335 phage minor capsid protein C, putative +FIG00963351 FIG00963354: hypothetical protein +FIG00963357 FIG00963359: hypothetical protein +FIG00963364 FIG00963370: hypothetical protein +FIG00963370 FIG00963378: hypothetical protein +FIG00963378 FIG00963381: hypothetical protein +FIG00963386 FIG00963389: hypothetical protein +FIG00963389 transcriptional repressor, LacI family +FIG00963404 FIG00963405: hypothetical protein +FIG00963427 FIG00963428: hypothetical protein +FIG00963429 FIG00963434: hypothetical protein +FIG00963434 FIG00963436: hypothetical protein +FIG00963440 DNA cytosine methyltransferase family protein +FIG00963441 FIG00963442: hypothetical protein +FIG00963456 type III effector HopPsyA(Pto) +FIG00963484 FIG00963485: hypothetical protein +FIG00963497 FIG00963501: hypothetical protein +FIG00963507 FIG00963508: hypothetical protein +FIG00963510 FIG00963512: hypothetical protein +FIG00963541 FIG00963542: hypothetical protein +FIG00963550 Putative 2-component regulator +FIG00963561 structural protein P5, putative +FIG00963562 pyocin S2 immunity protein +FIG00963563 probable phospholipase +FIG00963568 Competence protein ComEA helix-hairpin-helix region precursor +FIG00963585 MocE +FIG00963587 FIG00963589: hypothetical protein +FIG00963593 hypothetical protein +FIG00963640 FIG00963642: hypothetical protein +FIG00963655 Phage DNA packaging protein, Nu1 subunit of terminase +FIG00963697 FIG00963705: hypothetical protein +FIG00963705 FIG00963706: hypothetical protein +FIG00963708 FIG00963712: hypothetical protein +FIG00963715 FIG00963717: hypothetical protein +FIG00963717 FIG00963718: hypothetical protein +FIG00963722 FIG00963724: hypothetical protein +FIG00963724 FIG00963725: hypothetical protein +FIG00963728 coronatine biosynthesis protein, putative +FIG00963732 FIG00963733: hypothetical protein +FIG00963752 Histidine decarboxylase (EC 4.1.1.22) +FIG00963782 type I secretion outer membrane protein +FIG00963783 FIG00963784: hypothetical protein +FIG00963784 FIG00963788: hypothetical protein +FIG00963789 Complete genome; segment 11/17 +FIG00963793 Putidacin L1 +FIG00963802 FIG00963807: hypothetical protein +FIG00963839 FIG00963840: hypothetical protein +FIG00963846 FIG00963848: hypothetical protein +FIG00963855 FIG00963861: hypothetical protein +FIG00963863 FIG00963865: hypothetical protein +FIG00963869 FIG00963888: hypothetical protein +FIG00963896 FIG00963899: hypothetical protein +FIG00963899 FIG00963905: hypothetical protein +FIG00963911 FIG00963912: hypothetical protein +FIG00963915 FIG00963917: hypothetical protein +FIG00963921 Excisionase domain protein +FIG00963925 FIG00963935: hypothetical protein +FIG00963935 dipeptidase, putative +FIG00963946 FIG00963947: hypothetical protein +FIG00963950 FIG00963952: hypothetical protein +FIG00963968 FIG00963969: hypothetical protein +FIG00963998 FIG00964003: hypothetical protein +FIG00964010 FIG00964014: hypothetical protein +FIG00964014 FIG00964015: hypothetical protein +FIG00964026 FIG00964029: hypothetical protein +FIG00964033 FIG00964034: hypothetical protein +FIG00964049 FIG00964051: hypothetical protein +FIG00964051 FIG00964053: hypothetical protein +FIG00964055 FIG00964056: hypothetical protein +FIG00964064 FIG00964066: hypothetical protein +FIG00964089 FIG00964095: hypothetical protein +FIG00964104 coronafacic acid synthetase component +FIG00964130 FIG00964132: hypothetical protein +FIG00964168 Putative large exoprotein involved in heme utilization or adhesion of ShlA/HecA/FhaA family +FIG00964181 FIG00964183: hypothetical protein +FIG00964183 FIG00964184: hypothetical protein +FIG00964184 FIG00964185: hypothetical protein +FIG00964201 FIG00964203: hypothetical protein +FIG00964211 FIG00964214: hypothetical protein +FIG00964220 FIG00964223: hypothetical protein +FIG00964234 FIG00964238: hypothetical protein +FIG00964240 FIG00964242: hypothetical protein +FIG00964273 FIG00964275: hypothetical protein +FIG00964275 FIG00964277: hypothetical protein +FIG00964277 FIG00964279: hypothetical protein +FIG00964283 FIG00964284: hypothetical protein +FIG00964302 FIG00964303: hypothetical protein +FIG00964303 Tn4652, cointegrate resolution protein S +FIG00964306 FIG00964308: hypothetical protein +FIG00964326 AvrD protein +FIG00964333 FIG00964338: hypothetical protein +FIG00964342 FIG00964350: hypothetical protein +FIG00964360 FIG00964362: hypothetical protein +FIG00964363 FIG00964366: hypothetical protein +FIG00964379 FIG00964382: hypothetical protein +FIG00964382 FIG00964385: hypothetical protein +FIG00964385 FIG00964388: hypothetical protein +FIG00964421 FIG00964427: hypothetical protein +FIG00964452 FIG00964453: hypothetical protein +FIG00964457 FIG00964459: hypothetical protein +FIG00964468 FIG00964469: hypothetical protein +FIG00964478 FIG00964480: hypothetical protein +FIG00964480 FIG00964487: hypothetical protein +FIG00964487 FIG00964489: hypothetical protein +FIG00964489 FIG00964490: hypothetical protein +FIG00964515 FIG00964518: hypothetical protein +FIG00964518 FIG00964523: hypothetical protein +FIG00964523 FIG00964529: hypothetical protein +FIG00964537 FIG00964538: hypothetical protein +FIG00964559 FIG00964560: hypothetical protein +FIG00964564 FIG00964565: hypothetical protein +FIG00964570 capsid assembly protein, putative +FIG00964573 FIG00964575: hypothetical protein +FIG00964575 FIG00964577: hypothetical protein +FIG00964599 Protein of unknown function DUF159 +FIG00964619 FIG00964620: hypothetical protein +FIG00964620 FIG00964622: hypothetical protein +FIG00964622 FIG00964623: hypothetical protein +FIG00964634 FIG00964635: hypothetical protein +FIG00964636 FIG00964642: hypothetical protein +FIG00964642 FIG00964649: hypothetical protein +FIG00964651 FIG00964654: hypothetical protein +FIG00964659 FIG00964666: hypothetical protein +FIG00964666 FIG00964671: hypothetical protein +FIG00964683 FIG00964687: hypothetical protein +FIG00964687 FIG00964692: hypothetical protein +FIG00964700 FIG00964703: hypothetical protein +FIG00964709 FIG00964711: hypothetical protein +FIG00964717 FIG00964718: hypothetical protein +FIG00964733 FIG00964734: hypothetical protein +FIG00964734 FIG00964735: hypothetical protein +FIG00964740 FIG00964744: hypothetical protein +FIG00964750 FIG00964752: hypothetical protein +FIG00964752 FIG00964753: hypothetical protein +FIG00964756 FIG00964757: hypothetical protein +FIG00964764 FIG00964765: hypothetical protein +FIG00964788 tail fiber assembly domain protein +FIG00964796 FIG00964798: hypothetical protein +FIG00964804 FIG00964806: hypothetical protein +FIG00964818 FIG00964821: hypothetical protein +FIG00964845 FIG00964846: hypothetical protein +FIG00964846 FIG00964855: hypothetical protein +FIG00964862 LysR family transcriptional regulator HdfR +FIG00964869 FIG00964870: hypothetical protein +FIG00964870 FIG00964873: hypothetical protein +FIG00964880 FIG00964884: hypothetical protein +FIG00964888 FIG00964893: hypothetical protein +FIG00964908 FIG00964909: hypothetical protein +FIG00964914 FIG00964915: hypothetical protein +FIG00964919 FIG00964920: hypothetical protein +FIG00964920 FIG00964922: hypothetical protein +FIG00964945 FIG00964947: hypothetical protein +FIG00964952 FIG00964957: hypothetical protein +FIG00964957 FIG00964959: hypothetical protein +FIG00964967 FIG00964971: hypothetical protein +FIG00964977 FIG00964980: hypothetical protein +FIG00965039 FIG00965045: hypothetical protein +FIG00965048 FIG00965052: hypothetical protein +FIG00965058 FIG00965060: hypothetical protein +FIG00965060 FIG00965062: hypothetical protein +FIG00965069 FIG00965070: hypothetical protein +FIG00965087 FIG00965089: hypothetical protein +FIG00965093 FIG00965100: hypothetical protein +FIG00965120 Pathogenesis-related protein +FIG00965150 FIG00965152: hypothetical protein +FIG00965152 FIG00965155: hypothetical protein +FIG00965155 FIG00965156: hypothetical protein +FIG00965164 FIG00965165: hypothetical protein +FIG00965191 type III effector HopV1 +FIG00965195 FIG00965198: hypothetical protein +FIG00965204 FIG00965215: hypothetical protein +FIG00965225 FIG00965227: hypothetical protein +FIG00965232 FIG00965233: hypothetical protein +FIG00965277 kinase sensor protein +FIG00965282 FIG00965290: hypothetical protein +FIG00965294 FIG00965302: hypothetical protein +FIG00965302 FIG00965308: hypothetical protein +FIG00965308 FIG00965313: hypothetical protein +FIG00965337 FIG00965338: hypothetical protein +FIG00965341 FIG00965345: hypothetical protein +FIG00965367 FIG00965370: hypothetical protein +FIG00965397 FIG00965400: hypothetical protein +FIG00965411 FIG00965415: hypothetical protein +FIG00965415 FIG00965417: hypothetical protein +FIG00965435 FIG00965438: hypothetical protein +FIG00965438 FIG00965439: hypothetical protein +FIG00965449 FIG00965450: hypothetical protein +FIG00965467 BRO family, N-terminal domain protein +FIG00965469 FIG00965470: hypothetical protein +FIG00965471 FIG00965478: hypothetical protein +FIG00965485 FIG00965489: hypothetical protein +FIG00965491 FIG00965493: hypothetical protein +FIG00965500 FIG00965501: hypothetical protein +FIG00965501 Arginase/agmatinase/formiminoglutamase +FIG00965502 FIG00965503: hypothetical protein +FIG00965503 Probable periplasmic spermidine/putrescine-binding protein +FIG00965505 FIG00965507: hypothetical protein +FIG00965507 FIG00965512: hypothetical protein +FIG00965512 Nitrite extrusion protein +FIG00965522 FIG00965524: hypothetical protein +FIG00965560 FIG00965561: hypothetical protein +FIG00965561 FIG00965563: hypothetical protein +FIG00965574 FIG00965575: hypothetical protein +FIG00965592 FIG00965596: hypothetical protein +FIG00965596 FIG00965602: hypothetical protein +FIG00965611 FIG00965615: hypothetical protein +FIG00965643 FIG00965644: hypothetical protein +FIG00965651 FIG00965652: hypothetical protein +FIG00965676 FIG00965686: hypothetical protein +FIG00965700 FIG00965705: hypothetical protein +FIG00965719 Short-chain dehydrogenases of various substrate specificities +FIG00965741 Transcriptional regulator, LuxR family +FIG00965742 protein activator of alkane oxidation PraB +FIG00965743 FIG00965744: hypothetical protein +FIG00965751 FIG00965752: hypothetical protein +FIG00965773 FIG00965780: hypothetical protein +FIG00965781 FIG00965785: hypothetical protein +FIG00965785 FIG00965789: hypothetical protein +FIG00965790 ring-cleaving dioxygenase +FIG00965799 FIG00965800: hypothetical protein +FIG00965800 FIG00965801: hypothetical protein +FIG00965807 FIG00965810: hypothetical protein +FIG00965823 FIG00965827: hypothetical protein +FIG00965831 FIG00965832: hypothetical protein +FIG00965837 FIG00965838: hypothetical protein +FIG00965877 FIG00965878: hypothetical protein +FIG00965887 FIG00965890: hypothetical protein +FIG00965890 FIG00965895: hypothetical protein +FIG00965915 FIG00965925: hypothetical protein +FIG00965933 FIG00965943: hypothetical protein +FIG00965990 methyl-accepting chemotaxis transducer +FIG00965997 FIG00966001: hypothetical protein +FIG00966015 FIG00966019: hypothetical protein +FIG00966028 FIG00966030: hypothetical protein +FIG00966030 repressor protein c2 +FIG00966050 FIG00966052: hypothetical protein +FIG00966070 FIG00966075: hypothetical protein +FIG00966091 FIG00966094: hypothetical protein +FIG00966095 FIG00966100: hypothetical protein +FIG00966154 FIG00966163: hypothetical protein +FIG00966184 FIG00966187: hypothetical protein +FIG00966204 FIG00966205: hypothetical protein +FIG00966212 FIG00966215: hypothetical protein +FIG00966215 FIG00966216: hypothetical protein +FIG00966216 FIG00966217: hypothetical protein +FIG00966223 FIG00966229: hypothetical protein +FIG00966240 FIG00966242: hypothetical protein +FIG00966249 FIG00966252: hypothetical protein +FIG00966308 FIG00966309: hypothetical protein +FIG00966403 FIG00966404: hypothetical protein +FIG00966416 FIG00966422: hypothetical protein +FIG00966426 FIG00966430: hypothetical protein +FIG00966438 FIG00966441: hypothetical protein +FIG00966489 cmaU protein +FIG00966494 4-oxalocrotonate tautomerase family protein +FIG00966540 FIG00966542: hypothetical protein +FIG00966542 FIG00966546: hypothetical protein +FIG00966554 FIG00966557: hypothetical protein +FIG00966557 FIG00966559: hypothetical protein +FIG00966573 Type III effector protein AvrE1 +FIG00966595 type III effector HopAG1 +FIG00966597 FIG00966599: hypothetical protein +FIG00966633 FIG00966635: hypothetical protein +FIG00966663 FIG00966665: hypothetical protein +FIG00966687 FIG00966688: hypothetical protein +FIG00966688 FIG00966692: hypothetical protein +FIG00966700 FIG00966703: hypothetical protein +FIG00966704 terminase B protein, putative +FIG00966705 Proton/glutamate symport protein @ Proton/aspartate symport protein +FIG00966816 FIG00966827: hypothetical protein +FIG00966884 FIG00966885: hypothetical protein +FIG00966890 FIG00966894: hypothetical protein +FIG00966896 FIG00966904: hypothetical protein +FIG00966914 FIG00966917: hypothetical protein +FIG00966929 FIG00966933: hypothetical protein +FIG00966976 Integral membrane protein +FIG00967029 FIG00967038: hypothetical protein +FIG00967041 FIG00967047: hypothetical protein +FIG00967052 FIG00967053: hypothetical protein +FIG00967073 FIG00967075: hypothetical protein +FIG00967087 thioredoxin domain protein +FIG00967128 FIG00967137: hypothetical protein +FIG00967142 Porin, Gram-negative type +FIG00967145 FIG00967149: hypothetical protein +FIG00967199 FIG00967200: hypothetical protein +FIG00967209 FIG00967210: hypothetical protein +FIG00967246 Putative exported protein precursor +FIG00967250 FIG00967252: hypothetical protein +FIG00967252 FIG00967256: hypothetical protein +FIG00967309 FIG00967311: hypothetical protein +FIG00967326 mobilization protein MobC, putative +FIG00967327 FIG00967334: hypothetical protein +FIG00967336 FIG00967337: hypothetical protein +FIG00967395 FIG00967398: hypothetical protein +FIG00967461 FIG00967463: hypothetical protein +FIG00967472 FIG00967474: hypothetical protein +FIG00967499 phage tail tape meausure protein, lambda family +FIG00967529 FIG00955024: hypothetical protein +FIG00967532 FIG00967533: hypothetical protein +FIG00967533 putative ABC transporter, periplasmic substrate-binding protein +FIG00967558 FIG00967561: hypothetical protein +FIG00967569 Transcriptional regulators +FIG00967579 FIG00967585: hypothetical protein +FIG00967610 Cytochrome c, class I precursor +FIG00967635 coronamic acid synthetase, cyclase component, putative +FIG00967636 FIG00967637: hypothetical protein +FIG00967673 FIG00967674: hypothetical protein +FIG00967674 FIG00954701: hypothetical protein +FIG00967782 FIG00967787: hypothetical protein +FIG00967798 FIG00967803: hypothetical protein +FIG00967883 FIG00967887: hypothetical protein +FIG00967887 FIG00967896: hypothetical protein +FIG00967982 GepA protein +FIG00967992 FIG00967995: hypothetical protein +FIG00968068 hypothetical protein +FIG00968084 FIG00968087: hypothetical protein +FIG00968222 FIG00968225: hypothetical protein +FIG00968254 FIG00968255: hypothetical protein +FIG00968263 FIG00968264: hypothetical protein +FIG00968269 FIG00968277: hypothetical protein +FIG00968278 K+-transporting ATPase, F subunit (EC 3.6.3.12) +FIG00968307 cAMP-binding protein +FIG00968368 FIG00968377: hypothetical protein +FIG00968377 FIG00968378: hypothetical protein +FIG00968381 FIG00968383: hypothetical protein +FIG00968383 cytochrome c, class II +FIG00968392 UDP-2-acetamido-2-deoxy-D-glucuronic acid dehydrogenase (NAD+ cofactor) +FIG00968397 FIG00968399: hypothetical protein +FIG00968402 hypothetical protein Psyc020223 +FIG00968405 FIG00968406: hypothetical protein +FIG00968406 FIG00968409: hypothetical protein +FIG00968410 FIG00968412: hypothetical protein +FIG00968421 hypothetical protein Psyc020096 +FIG00968422 FIG00968423: hypothetical protein +FIG00968423 FIG00968424: hypothetical protein +FIG00968425 Cell division protein FtsL +FIG00968427 FIG00968428: hypothetical protein +FIG00968434 FIG00968439: hypothetical protein +FIG00968439 FIG00968444: hypothetical protein +FIG00968444 FIG00968446: hypothetical protein +FIG00968446 FIG00968447: hypothetical protein +FIG00968448 FIG00968449: hypothetical protein +FIG00968451 5-valerolactone hydrolase +FIG00968456 FIG00968457: hypothetical protein +FIG00968459 FIG00968463: hypothetical protein +FIG00968463 CcsA-related protein +FIG00968467 FIG00968473: hypothetical protein +FIG00968473 FIG00968474: hypothetical protein +FIG00968474 FIG00968475: hypothetical protein +FIG00968475 FIG00968480: hypothetical protein +FIG00968491 FIG00968492: hypothetical protein +FIG00968494 FIG00968496: hypothetical protein +FIG00968500 FIG00968501: hypothetical protein +FIG00968501 FIG00968503: hypothetical protein +FIG00968504 FIG00968505: hypothetical protein +FIG00968505 FIG00968513: hypothetical protein +FIG00968513 FIG00968514: hypothetical protein +FIG00968515 FIG00968519: hypothetical protein +FIG00968519 FIG00968525: hypothetical protein +FIG00968539 hypothetical protein Psyc020527 +FIG00968545 FIG00350225: hypothetical protein +FIG00968553 FIG00968556: hypothetical protein +FIG00968569 FIG00968570: hypothetical protein +FIG00968570 FIG00968571: hypothetical protein +FIG00968571 FIG00968575: hypothetical protein +FIG00968575 Probable alpha/beta hydrolase fold family esterase +FIG00968583 FIG00968585: hypothetical protein +FIG00968591 FIG00968592: hypothetical protein +FIG00968594 FIG00968595: hypothetical protein +FIG00968595 FIG00968598: hypothetical protein +FIG00968600 FIG00968601: hypothetical protein +FIG00968601 FIG00968602: hypothetical protein +FIG00968602 FIG00968605: hypothetical protein +FIG00968607 FIG00968608: hypothetical protein +FIG00968609 FIG00968610: hypothetical protein +FIG00968612 FIG00968613: hypothetical protein +FIG00968613 FIG00968614: hypothetical protein +FIG00968614 FIG00968617: hypothetical protein +FIG00968617 FIG00968618: hypothetical protein +FIG00968619 FIG00968620: hypothetical protein +FIG00968625 FIG00968626: hypothetical protein +FIG00968626 FIG00968627: hypothetical protein +FIG00968635 FIG00968640: hypothetical protein +FIG00968640 FIG00968644: hypothetical protein +FIG00968649 FIG00968650: hypothetical protein +FIG00968652 Porin, Gram-negative type precursor +FIG00968654 hypothetical protein Psyc136401 +FIG00968661 FIG00968662: hypothetical protein +FIG00968662 FIG00968664: hypothetical protein +FIG00968665 FIG00968666: hypothetical protein +FIG00968666 FIG00968667: hypothetical protein +FIG00968668 FIG00351543: hypothetical protein +FIG00968670 FIG00968671: hypothetical protein +FIG00968673 FIG00968678: hypothetical protein +FIG00968694 FIG00968700: hypothetical protein +FIG00968703 hypothetical protein Psyc020181 +FIG00968709 FIG00968712: hypothetical protein +FIG00968718 FIG00968720: hypothetical protein +FIG00968729 FIG00968730: hypothetical protein +FIG00968735 FIG00968736: hypothetical protein +FIG00968753 FIG00968754: hypothetical protein +FIG00968754 hypothetical protein Psyc124501 +FIG00968759 FIG00968764: hypothetical protein +FIG00968764 FIG00968765: hypothetical protein +FIG00968781 putative esterase A +FIG00968783 FIG00968784: hypothetical protein +FIG00968786 FIG00968789: hypothetical protein +FIG00968789 FIG00968790: hypothetical protein +FIG00968790 thiol methyltransferase +FIG00968792 FIG00968794: hypothetical protein +FIG00968802 hypothetical protein Psyc105701 +FIG00968807 Probable peptidase +FIG00968809 FIG00968813: hypothetical protein +FIG00968814 FIG00968816: hypothetical protein +FIG00968823 FIG00968825: hypothetical protein +FIG00968826 FIG00968827: hypothetical protein +FIG00968835 FIG00968836: hypothetical protein +FIG00968836 FIG00968837: hypothetical protein +FIG00968840 FIG00968842: hypothetical protein +FIG00968842 FIG00968844: hypothetical protein +FIG00968845 FIG00968846: hypothetical protein +FIG00968853 FIG00968854: hypothetical protein +FIG00968855 FIG00968856: hypothetical protein +FIG00968856 FIG00968858: hypothetical protein +FIG00968858 FIG00968863: hypothetical protein +FIG00968864 FIG00968865: hypothetical protein +FIG00968868 Uroporphyrinogen-III synthase (UROS) (Uroporphyrinogen-III cosynthetase) (Hydroxymethylbilane hydrolyase [cyclizing]) (EC 4.2.1.75) +FIG00968874 hypothetical protein Psyc020726 +FIG00968876 FIG00968877: hypothetical protein +FIG00968885 FIG00968887: hypothetical protein +FIG00968892 FIG00968893: hypothetical protein +FIG00968894 FIG00968898: hypothetical protein +FIG00968898 FIG00968899: hypothetical protein +FIG00968906 putative periplasmic protease +FIG00968908 FIG00968909: hypothetical protein +FIG00968909 FIG00968910: hypothetical protein +FIG00968915 Entericidin A lipoprotein +FIG00968919 FIG00968921: hypothetical protein +FIG00968928 FIG00968933: hypothetical protein +FIG00968939 C-terminal processing peptidase precursor (EC 3.4.21.102) +FIG00968963 FIG00968966: hypothetical protein +FIG00968971 FIG00968973: hypothetical protein +FIG00968975 FIG00968976: hypothetical protein +FIG00968976 FIG00968977: hypothetical protein +FIG00968977 FIG00968981: hypothetical protein +FIG00968988 FIG00968990: hypothetical protein +FIG00968991 FIG00968992: hypothetical protein +FIG00968998 FIG00969013: hypothetical protein +FIG00969016 Probable glutamine amidotransferase, class-II protein +FIG00969027 FIG00969031: hypothetical protein +FIG00969033 FIG00969035: hypothetical protein +FIG00969038 FIG00969040: hypothetical protein +FIG00969040 FIG00969041: hypothetical protein +FIG00969046 FIG00969049: hypothetical protein +FIG00969061 FIG00969063: hypothetical protein +FIG00969065 FIG00969066: hypothetical protein +FIG00969066 FIG00969068: hypothetical protein +FIG00969082 FIG00969083: hypothetical protein +FIG00969083 FIG00969086: hypothetical protein +FIG00969107 FIG00969108: hypothetical protein +FIG00969114 FIG00969122: hypothetical protein +FIG00969126 FIG00969130: hypothetical protein +FIG00969130 FIG00969133: hypothetical protein +FIG00969133 FIG00969135: hypothetical protein +FIG00969135 FIG00969136: hypothetical protein +FIG00969136 FIG00969137: hypothetical protein +FIG00969139 FIG00969144: hypothetical protein +FIG00969149 FIG00969150: hypothetical protein +FIG00969150 outer membrane usher protein precursor +FIG00969153 FIG00969155: hypothetical protein +FIG00969161 FIG00969163: hypothetical protein +FIG00969167 FIG00969170: hypothetical protein +FIG00969177 outer membrane protein G1b +FIG00969182 Possible outer membrane protein, OmpA family +FIG00969189 OprF +FIG00969196 hypothetical protein Psyc020783 +FIG00969198 Homoserine/homoserine lactone efflux pump, RhtB family +FIG00969201 Protein yjjB +FIG00969202 FIG00969206: hypothetical protein +FIG00969206 FIG00969207: hypothetical protein +FIG00969214 FIG00969215: hypothetical protein +FIG00969233 calcineurin-like phosphoesterase +FIG00969244 FIG00969245: hypothetical protein +FIG00969246 FIG00969247: hypothetical protein +FIG00969247 FIG00969264: hypothetical protein +FIG00969264 FIG00969265: hypothetical protein +FIG00969265 FIG00969279: hypothetical protein +FIG00969279 FIG00969282: hypothetical protein +FIG00969282 FIG00969288: hypothetical protein +FIG00969288 FIG00969290: hypothetical protein +FIG00969290 FIG00969293: hypothetical protein +FIG00969293 Phosphopantethiene-protein transferase domain family protein +FIG00969295 FIG00969296: hypothetical protein +FIG00969296 FIG00969300: hypothetical protein +FIG00969300 FIG00969304: hypothetical protein +FIG00969314 FIG00969323: hypothetical protein +FIG00969325 FIG00969327: hypothetical protein +FIG00969329 Lipooligosaccharide biosynthesis protein lpsA (EC 2.-.-.-) +FIG00969331 FIG00969332: hypothetical protein +FIG00969332 FIG00969333: hypothetical protein +FIG00969333 FIG00969336: hypothetical protein +FIG00969336 Bacterial transferase family protein +FIG00969340 FIG00969342: hypothetical protein +FIG00969346 FIG00969349: hypothetical protein +FIG00969365 serine-pyruvate aminotransferase +FIG00969366 hypothetical protein Psyc020609 +FIG00969371 FIG00969372: hypothetical protein +FIG00969379 FIG00969383: hypothetical protein +FIG00969383 FIG00969385: hypothetical protein +FIG00969408 FIG00969410: hypothetical protein +FIG00969425 hypothetical protein Psyc020118 +FIG00969427 FIG00969428: hypothetical protein +FIG00969432 FIG00969436: hypothetical protein +FIG00969450 hypothetical protein Psyc020332 +FIG00969454 FIG00969456: hypothetical protein +FIG00969456 FIG00969459: hypothetical protein +FIG00969459 hypothetical protein Psyc020728 +FIG00969467 FIG00969471: hypothetical protein +FIG00969471 FIG00969474: hypothetical protein +FIG00969486 FIG00969488: hypothetical protein +FIG00969491 hypothetical protein Psyc020706 +FIG00969502 FIG00969505: hypothetical protein +FIG00969547 FIG00969551: hypothetical protein +FIG00969565 FIG00969569: hypothetical protein +FIG00969583 FIG00969584: hypothetical protein +FIG00969584 Tfp pilus assembly protein, ATPase PilU +FIG00969604 FIG00969606: hypothetical protein +FIG00969608 DNA/RNA non-specific endonuclease precursor +FIG00969610 Possible multiple antibiotic resistance (MarC) -related proteins +FIG00969618 FIG00969620: hypothetical protein +FIG00969622 FIG00969625: hypothetical protein +FIG00969625 FIG00969627: hypothetical protein +FIG00969634 FIG00969637: hypothetical protein +FIG00969665 FIG00969666: hypothetical protein +FIG00969677 FIG00969683: hypothetical protein +FIG00969683 COG2885: Outer membrane protein and related peptidoglycan-associated (lipo)proteins +FIG00969687 FIG00969688: hypothetical protein +FIG00969700 FIG00969703: hypothetical protein +FIG00969720 FIG00969723: hypothetical protein +FIG00969736 FIG00969737: hypothetical protein +FIG00969742 FIG00969743: hypothetical protein +FIG00969755 FIG00969756: hypothetical protein +FIG00969756 FIG00969761: hypothetical protein +FIG00969766 FIG00969768: hypothetical protein +FIG00969768 FIG00969771: hypothetical protein +FIG00969779 FIG00969783: hypothetical protein +FIG00969786 FIG00969788: hypothetical protein +FIG00969788 hypothetical protein Psyc114301 +FIG00969801 hypothetical protein Psyc184501 +FIG00969807 Uncharacterized methyltransferase Pcryo_1403 +FIG00969811 extracellular solute-binding protein family 3 +FIG00969814 FIG00969815: hypothetical protein +FIG00969816 FIG00969820: hypothetical protein +FIG00969921 FIG00969925: hypothetical protein +FIG00969930 FIG00969941: hypothetical protein +FIG00969950 FIG00969957: hypothetical protein +FIG00969957 FIG00969964: hypothetical protein +FIG00970023 FIG00970031: hypothetical protein +FIG00970049 FIG00970051: hypothetical protein +FIG00970183 FIG00970184: hypothetical protein +FIG00970217 FIG00970218: hypothetical protein +FIG00970238 FIG00970239: hypothetical protein +FIG00970272 FIG00970279: hypothetical protein +FIG00970311 FIG00970315: hypothetical protein +FIG00970316 ABC transporter of unknown compound (not Fe3+), periplasmic substrate-binding protein +FIG00970341 FIG00970342: hypothetical protein +FIG00970346 FIG00970363: hypothetical protein +FIG00970392 FIG00970395: hypothetical protein +FIG00970401 FIG00970402: hypothetical protein +FIG00970402 FIG00970413: hypothetical protein +FIG00970420 FIG00970424: hypothetical protein +FIG00970442 FIG00970443: hypothetical protein +FIG00970443 Glutathione S-transferase related protein +FIG00970449 FIG00970450: hypothetical protein +FIG00970470 FIG00970471: hypothetical protein +FIG00970473 FIG00970474: hypothetical protein +FIG00970491 FIG00970494: hypothetical protein +FIG00970503 FIG00970506: hypothetical protein +FIG00970529 FIG00970530: hypothetical protein +FIG00970537 FIG00970538: hypothetical protein +FIG00970549 FIG00970555: hypothetical protein +FIG00970575 FIG00970583: hypothetical protein +FIG00970601 FIG00970613: hypothetical protein +FIG00970613 Efflux transporter, RND family, MFP subunit, AcrA/E family +FIG00970655 FIG00970678: hypothetical protein +FIG00970755 FIG00970759: hypothetical protein +FIG00970761 FIG00970762: hypothetical protein +FIG00970811 FIG00970819: hypothetical protein +FIG00970832 FIG00970833: hypothetical protein +FIG00970858 FIG00970864: hypothetical protein +FIG00970864 FIG00971859: hypothetical protein +FIG00970884 FIG00970906: hypothetical protein +FIG00970942 FIG00970943: hypothetical protein +FIG00970965 FIG00970966: hypothetical protein +FIG00970966 FIG00970967: hypothetical protein +FIG00970967 FIG021625: hypothetical protein +FIG00970969 FIG00970970: hypothetical protein +FIG00970970 FIG00970972: hypothetical protein +FIG00970972 FIG00970973: hypothetical protein +FIG00970981 FIG00970989: hypothetical protein +FIG00970989 FIG00970990: hypothetical protein +FIG00970990 FIG00971011: hypothetical protein +FIG00971011 FIG00971012: hypothetical protein +FIG00971036 FIG00971038: hypothetical protein +FIG00971104 Polysaccharide export protein precursor +FIG00971124 FIG00971136: hypothetical protein +FIG00971136 FIG00971137: hypothetical protein +FIG00971147 Sensory box/response regulator +FIG00971199 FIG00971201: hypothetical protein +FIG00971266 FIG00971270: hypothetical protein +FIG00971285 FIG00971287: hypothetical protein +FIG00971338 FIG00971339: hypothetical protein +FIG00971339 FIG00971340: hypothetical protein +FIG00971340 FIG00971347: hypothetical protein +FIG00971418 FIG00971421: hypothetical protein +FIG00971439 FIG00971442: hypothetical protein +FIG00971455 FIG00971463: hypothetical protein +FIG00971481 FIG00971488: hypothetical protein +FIG00971488 FIG00971501: hypothetical protein +FIG00971509 FIG00971517: hypothetical protein +FIG00971612 Fermentation/respiration switch protein +FIG00971651 FIG00971669: hypothetical protein +FIG00971711 FIG00971721: hypothetical protein +FIG00971797 Phospholipid methyltransferase +FIG00971820 FIG00971829: hypothetical protein +FIG00971906 FIG00971908: hypothetical protein +FIG00971920 FIG00971923: hypothetical protein +FIG00972069 UPF0056 membrane protein bbp_248 +FIG00972070 Uncharacterized protein MJ1650 +FIG00972081 Sugar-binding periplasmic protein +FIG00972089 hypothetical protein +FIG00972093 Uncharacterized protein PH1209 +FIG00972101 Potassium transport membrane protein, conjectural +FIG00972103 Conserved +FIG00972113 Geranylgeranyl hydrogenase BchP +FIG00972114 P. aerophilum family 453, possible regulatory protein +FIG00972115 transcription factor homologous to NACalpha-BTF3 +FIG00972123 P. aerophilum family 322 protein part 2, authentic frameshift +FIG00972127 DNA polymerase II (EC 2.7.7.7) +FIG00972148 Conserved alcohol dehydrogenase (EC 1.1.1.1) +FIG00972150 Phosphoesterase, RecJ domain protein +FIG00972157 Putative aldolase class 2 protein MJ1418 +FIG00972188 PTPS-V +FIG00972198 Putative HTH-type transcriptional regulatory protein AF_1787 +FIG00972203 Geranylgeranyl pyrophosphate synthase +FIG00972218 CRISPR-associated protein, Csa1 family +FIG00972268 Protease IV, conjectural +FIG00972304 putative cytochrome c biogenesis protein, transmembrane region +FIG00972312 ATP-dependent RNA helicase, putative +FIG00972328 Aldo-keto reductase family protein +FIG00972332 Arabinose ABC transporter, permease +FIG00972334 UPF0237 protein PAE3582 +FIG00972350 Conserved NAD/P oxidoreductase +FIG00972357 mRNA 3-end processing exonuclease +FIG00972362 Hypothetical protein in aromatic cluster +FIG00972372 Glutamate synthase [NADPH] large chain II (EC 1.4.1.13) +FIG00972388 hypothetical protein, related to A1pp domain +FIG00972404 Uroporphyrinogen-III synthase (HemD) , conjectural +FIG00972408 Actin-like protein +FIG00972409 Heat shock protein, HtpX homolog +FIG00972410 Serine/threonine phosphatase type 1 (EC 3.1.3.16) +FIG00972426 Signal transduction ATPase +FIG00972441 Cytochrome similar to cd1 +FIG00972466 P. aerophilum family 417, putative ATP binding +FIG00972473 UPF0215 protein TK2033 +FIG00972479 acetylpolyamine aminohydrolase, putative +FIG00972495 8-oxoguanine DNA glycosylase, archaeal type +FIG00972498 Respiratory arsenate reductase subunit B +FIG00972517 acetyl/acyl transferase related protein +FIG00972520 type III restriction enzyme, res subunit +FIG00972549 MoaA/NifB/PqqE family protein MJ0619 +FIG00972561 Small nuclear ribonucleoprotein homolog +FIG00972571 Pullulanase +FIG00972595 P. aerophilum family 562 protein +FIG00972596 cofactor modifying protein (cmo) +FIG00972610 "Serine/threonine-protein kinase RIO2 " +FIG00972627 Conserved protein with 2 CBS domains +FIG00972628 Metalloendopeptidase, M50 family, containing pdz domain +FIG00972633 Membrane-bound NiFe hydrogenase +FIG00972642 conserved within P. aerophilum +FIG00972644 Sugar phosphate nucleotidyl transferase (EC 2.7.7.-) +FIG00972647 Gll3175 protein +FIG00972656 Probable phosphomannomutase (PMM) +FIG00972678 Uroporphyrin-III C-methyltransferase +FIG00972680 4-alpha-glucanotransferase (malQ) +FIG00972699 Uncharacterized protein MJ0967 +FIG00972705 Probable protease HtpX homolog (EC 3.4.24.-) +FIG00972717 Transcription initiation factor IIB, conjectural +FIG00972722 DNA-cytosine modification methylase MJ0563 (EC 2.1.1.37) +FIG00972727 P. aerophilum family 3 protein +FIG00972729 Uncharacterized transporter AF_1533 +FIG00972732 Signal recognition particle 19 kDa protein (SRP19) +FIG00972734 Metal ion binding transcriptional regulator, conjectural +FIG00972744 tRNA/RNA cytosine-C5-methylase (EC 2.1.1.-) +FIG00972765 Transport protein, conjectural +FIG00972772 MTHFR (MetF)-like +FIG00972776 Conserved within P. aerophilum +FIG00972807 Respiratory arsenate reductase subunit C +FIG00972812 Ribose ABC transporter, permease protein +FIG00972821 Regulatory protein, luxR family, conjectural +FIG00972847 P.aerophilum family 417, putative ATP binding +FIG00972849 carbon nitrogen hydrolase, conjectural +FIG00972870 Phosphate uptake regulator, phoU family +FIG00972871 glycosyltransferase (type 1) +FIG00972882 UPF0204 protein ST2121 +FIG00972885 P. aerophilum family 59 protein +FIG00972897 putative D-lactate dehydrogenase (cytochrome) [EC:1.1.2.4] +FIG00972905 Microsomal dipeptidase +FIG00972940 putative multisubunit Na+/H+ antiporter +FIG00972941 motif=EF-hand calcium-binding domain +FIG00972955 putative ABC transport ATP binding protein +FIG00972958 hypothetical mrp protein +FIG00972974 Similar to intein-encoded homing endonucleases +FIG00972975 purine phosphoribosyltransferase +FIG00972977 Membrane protein NOSY precursor +FIG00972987 RNA-binding protein, containing S1 domain +FIG00973003 DNA damage-inducible protein +FIG00973009 hypothetical ABC transporter +FIG00973043 putative Na(+) H(+) antiporter subunit C +FIG00973058 transcriptional regulatory protein, putative +FIG00973062 RNA-binding protein, containing THUMP domain +FIG00973065 CRISPR-associated protein, AF1875 family +FIG00973067 iron (III) ABC transporter +FIG00973070 UDP-N-acetylglucosamine-dolichyl-phosphate N-AceGluNH-phosphotransferase +FIG00973086 2-phosphoglycerate kinase +FIG00973106 F420-nonreducing hydrogenase +FIG00973110 putative Na(+) H(+) antiporter subunit D +FIG00973111 Sarcosine oxidase, alpha subunit +FIG00973121 Adenine phosphoribosyltransferase, fused to N-terminal DNA-binding domain +FIG00973129 putative glutamate aminotransferase +FIG00973143 CRISPR-associated protein, Csa5 family +FIG00973144 methylated-DNA-protein-cysteine methyltransferase +FIG00973145 putative polyferredoxin +FIG00973150 hypothetical protein AF0375 +FIG00973161 transport protein, permease +FIG00973162 Function Code: 16.1 Conserved Hypothetical +FIG00973172 putative small multidrug export protein +FIG00973180 Uncharacterized protein PF0367 +FIG00973182 exonuclease sbcd related +FIG00973206 Biotin synthase-related protein, radical SAM superfamily +FIG00973207 membrane dipeptidase +FIG00973215 Membrane bound hydrogenase, MbhD subunit +FIG00973220 Potassium channel related protein +FIG00973222 Type II phosphatidic acid phosphatase +FIG00973225 nadh-dependent dehydrogenase - like. +FIG00973227 oligosaccharyl transferase +FIG00973234 phosphomannomutase related protein +FIG00973245 metal dependent hydrolase +FIG00973253 Phosphate uptake regulator PhoU +FIG00973277 iron (III) ABC transporter, permease protein +FIG00973281 aminopeptidase from family M42 +FIG00973286 putative sugar transporter protein +FIG00973288 hydrogenase, gamma chain (hydg). +FIG00973306 aspartate/serine transaminase +FIG00973312 Transcription regulator, ArsR family +FIG00973317 Function Code: 16.4 Hypothetical +FIG00973318 CRISPR-associated protein, Cas5a family +FIG00973360 iron (iii) abc transporter, atp-binding protein +FIG00973371 putative Na(+) H(+) antiporter subunit B +FIG00973374 dolichol-phosphate mannose synthase +FIG00973377 putative carbamoyl transferase +FIG00973398 CRISPR-associated protein, Csa3 family +FIG00973399 motif=prenyl group binding site (CAAX box) +FIG00973416 Cyclic 2,3-diphosphoglycerate synthase +FIG00973417 serine protease htra related protein +FIG00973420 UDP-N-acetyl-D-mannosaminuronic acid dehydrogenase +FIG00973421 putative perplasmic sugar binding protein +FIG00973431 related to bacterial autolysins +FIG00973442 lacZ expression regulatory protein +FIG00973475 hypothetical 4Fe-4S ferredoxin +FIG00973488 ferrichrome transport ATP-binding protein +FIG00973489 oligopeptide transport permease protein appb +FIG00973490 putative HTH transcription regulator +FIG00973509 hexuronate transporter related protein +FIG00973512 dipeptide ABC transporter, ATP-binding protein +FIG00973572 DNA repair protein RAD25 +FIG00973589 signal peptidase related +FIG00973612 abc transporter, atp-binding protein +FIG00973639 macromolecule metabolism; macromolecule synthesis, modification +FIG00973641 FIG00973643: hypothetical protein +FIG00973646 FIG00973647: hypothetical protein +FIG00973655 FIG00973656: hypothetical protein +FIG00973656 FIG00973657: hypothetical protein +FIG00973665 FIG00973666: hypothetical protein +FIG00973667 FIG00973668: hypothetical protein +FIG00973668 FIG00973670: hypothetical protein +FIG00973672 FIG00973673: hypothetical protein +FIG00973675 FIG00973677: hypothetical protein +FIG00973677 FIG00973679: hypothetical protein +FIG00973679 FIG00973680: hypothetical protein +FIG00973680 FIG00431662: hypothetical protein +FIG00973684 FIG00973686: hypothetical protein +FIG00973695 FIG00973696: hypothetical protein +FIG00973713 FIG00973714: hypothetical protein +FIG00973717 FIG00973718: hypothetical protein +FIG00973721 FIG00973722: hypothetical protein +FIG00973722 FIG00973724: hypothetical protein +FIG00973725 FIG00973726: hypothetical protein +FIG00973726 putative transcription regulator transcription regulator protein +FIG00973732 FIG00973733: hypothetical protein +FIG00973738 FIG00973740: hypothetical protein +FIG00973743 PROBABLE ALANIN-RICH SIGNAL PEPTIDE PROTEIN +FIG00973750 FIG00973751: hypothetical protein +FIG00973751 FIG00973752: hypothetical protein +FIG00973754 FIG00973757: hypothetical protein +FIG00973759 Cobalt-zinc-cadmium resistance protein czcI precursor +FIG00973760 Conjugative transfer protein TraI +FIG00973771 FIG00973772: hypothetical protein +FIG00973775 FIG00973779: hypothetical protein +FIG00973779 FIG00973780: hypothetical protein +FIG00973786 FIG00973787: hypothetical protein +FIG00973793 FIG00973795: hypothetical protein +FIG00973796 FIG00973797: hypothetical protein +FIG00973797 FIG00973798: hypothetical protein +FIG00973805 FIG00973806: hypothetical protein +FIG00973812 FIG00973813: hypothetical protein +FIG00973821 PUTATIVE OUTER MEMBRANE CHANEL LIPOPROTEIN +FIG00973822 FIG00973823: hypothetical protein +FIG00973824 FIG00973826: hypothetical protein +FIG00973827 probable integrase/recombinase protein +FIG00973830 FIG00973831: hypothetical protein +FIG00973831 FIG00973832: hypothetical protein +FIG00973832 FIG00973834: hypothetical protein +FIG00973834 FIG00973837: hypothetical protein +FIG00973842 FIG00973845: hypothetical protein +FIG00973845 FIG00973848: hypothetical protein +FIG00973855 FIG00973857: hypothetical protein +FIG00973857 FIG00973861: hypothetical protein +FIG00973867 GALA PROTEIN 1 +FIG00973877 C4-dicarboxylate-binding protein +FIG00973881 FIG00973882: hypothetical protein +FIG00973885 HRPD PROTEIN +FIG00973888 FIG00973891: hypothetical protein +FIG00973893 Nitrogen assimilation regulatory protein ntrX +FIG00973912 FIG00973913: hypothetical protein +FIG00973913 FIG00973914: hypothetical protein +FIG00973914 conserved hypothetical transmembrane protein +FIG00973920 FIG00973921: hypothetical protein +FIG00973921 FIG00973924: hypothetical protein +FIG00973925 FIG00973926: hypothetical protein +FIG00973927 FIG00973928: hypothetical protein +FIG00973934 FIG00973937: hypothetical protein +FIG00973938 Hypothetical Protein +FIG00973944 FIG00973945: hypothetical protein +FIG00973945 GlnQ +FIG00973947 FIG00973952: hypothetical protein +FIG00973952 FIG00973953: hypothetical protein +FIG00973953 FIG00973957: hypothetical protein +FIG00973961 FIG00973963: hypothetical protein +FIG00973963 FIG00973964: hypothetical protein +FIG00973965 FIG00973967: hypothetical protein +FIG00973967 FIG00973968: hypothetical protein +FIG00973968 FIG00973969: hypothetical protein +FIG00973969 FIG00973975: hypothetical protein +FIG00973975 FIG00973976: hypothetical protein +FIG00973988 FIG00973990: hypothetical protein +FIG00973990 FIG00973991: hypothetical protein +FIG00973993 Oligopeptide transport system permease protein OppB (TC 3.A.1.5.1) +FIG00974000 FIG00974001: hypothetical protein +FIG00974002 FIG00974003: hypothetical protein +FIG00974003 FIG00974004: hypothetical protein +FIG00974008 putative 4-methylmuconolactone methylisomerase +FIG00974017 FIG00974020: hypothetical protein +FIG00974021 PROBABLE HEMAGGLUTININ-RELATED TRANSMEMBRANE PROTEIN +FIG00974022 FIG00974024: hypothetical protein +FIG00974026 FIG00974027: hypothetical protein +FIG00974028 FIG00974029: hypothetical protein +FIG00974031 FIG00974034: hypothetical protein +FIG00974034 FIG00974036: hypothetical protein +FIG00974038 FIG00974039: hypothetical protein +FIG00974040 Hydrogenase maturation factor HoxO/HyaE +FIG00974050 FIG00974051: hypothetical protein +FIG00974055 FIG00974056: hypothetical protein +FIG00974062 FIG00974063: hypothetical protein +FIG00974063 FIG00974065: hypothetical protein +FIG00974065 FIG00974068: hypothetical protein +FIG00974081 FIG00974082: hypothetical protein +FIG00974084 FIG00974085: hypothetical protein +FIG00974088 PaaI +FIG00974093 FIG00974095: hypothetical protein +FIG00974095 FIG00974100: hypothetical protein +FIG00974123 FIG00974124: hypothetical protein +FIG00974124 FIG00974126: hypothetical protein +FIG00974126 FIG00974128: hypothetical protein +FIG00974133 FIG00974134: hypothetical protein +FIG00974139 FIG00974140: hypothetical protein +FIG00974140 FIG00974141: hypothetical protein +FIG00974142 FIG00974143: hypothetical protein +FIG00974156 FIG00974158: hypothetical protein +FIG00974158 FIG00974159: hypothetical protein +FIG00974169 Protein phosphatase 2C-like +FIG00974176 FIG00974177: hypothetical protein +FIG00974177 FIG00974182: hypothetical protein +FIG00974189 FIG00974190: hypothetical protein +FIG00974190 FIG00974193: hypothetical protein +FIG00974199 FIG00974200: hypothetical protein +FIG00974200 FIG00974202: hypothetical protein +FIG00974209 FIG00974210: hypothetical protein +FIG00974211 FIG00974212: hypothetical protein +FIG00974212 FIG00974214: hypothetical protein +FIG00974215 FIG00974220: hypothetical protein +FIG00974223 Lysophospholipid transporter LplT / 2-acylglycerophosphoethanolamine acyltransferase (EC 2.3.1.40) / Acyl-[acyl-carrier-protein] synthetase (EC 6.2.1.20) +FIG00974239 FIG00974240: hypothetical protein +FIG00974241 FIG00974242: hypothetical protein +FIG00974242 FIG00974243: hypothetical protein +FIG00974245 FIG00974249: hypothetical protein +FIG00974253 FIG00974254: hypothetical protein +FIG00974254 FIG00974255: hypothetical protein +FIG00974255 FIG00974256: hypothetical protein +FIG00974256 FIG00974257: hypothetical protein +FIG00974257 FIG01270238: hypothetical protein +FIG00974260 PROBABLE AMINO-ACID-BINDING PERIPLASMIC (PBP) ABC TRANSPORTER PROTEIN +FIG00974262 FIG00974264: hypothetical protein +FIG00974264 FIG00974267: hypothetical protein +FIG00974270 FIG00974271: hypothetical protein +FIG00974271 FIG00974272: hypothetical protein +FIG00974272 FIG00974273: hypothetical protein +FIG00974274 FIG00974275: hypothetical protein +FIG00974276 FIG00974279: hypothetical protein +FIG00974279 FIG00974280: hypothetical protein +FIG00974280 FIG00974282: hypothetical protein +FIG00974282 FIG00974284: hypothetical protein +FIG00974284 FIG00974285: hypothetical protein +FIG00974285 FIG00974286: hypothetical protein +FIG00974286 FIG00974287: hypothetical protein +FIG00974288 FIG00974294: hypothetical protein +FIG00974296 FIG00974299: hypothetical protein +FIG00974299 FIG00974300: hypothetical protein +FIG00974300 FIG00974301: hypothetical protein +FIG00974301 stress response +FIG00974306 FIG00974308: hypothetical protein +FIG00974308 FIG00974312: hypothetical protein +FIG00974312 FIG00974314: hypothetical protein +FIG00974314 FIG00974315: hypothetical protein +FIG00974329 Transport-associated +FIG00974333 FIG00974334: hypothetical protein +FIG00974334 FIG00974336: hypothetical protein +FIG00974337 Hydrolase, UxaA family +FIG00974344 FIG00974345: hypothetical protein +FIG00974345 FIG00974346: hypothetical protein +FIG00974348 FIG00974352: hypothetical protein +FIG00974355 transcriptional regulator, LytR/AlgR family +FIG00974359 FIG00974360: hypothetical protein +FIG00974360 FIG00974361: hypothetical protein +FIG00974361 FIG00974363: hypothetical protein +FIG00974363 FIG00974365: hypothetical protein +FIG00974370 Lactone-specific esterase +FIG00974372 FIG00974373: hypothetical protein +FIG00974376 Two component transcriptional regulator, LuxR family +FIG00974384 FIG00974385: hypothetical protein +FIG00974388 Amidase, hydantoinase/carbamoylase (EC 3.5.1.87) +FIG00974390 FIG00974393: hypothetical protein +FIG00974393 FIG00974396: hypothetical protein +FIG00974400 FIG00974401: hypothetical protein +FIG00974402 FIG00974403: hypothetical protein +FIG00974403 small molecule metabolism; global functions; global regulatory functions +FIG00974404 FIG00974405: hypothetical protein +FIG00974409 FIG00974413: hypothetical protein +FIG00974413 FIG00974417: hypothetical protein +FIG00974420 FIG00974422: hypothetical protein +FIG00974422 FIG00974423: hypothetical protein +FIG00974423 LysR-family transcriptional regulator +FIG00974427 FIG00974429: hypothetical protein +FIG00974429 FIG00974430: hypothetical protein +FIG00974436 FIG00974438: hypothetical protein +FIG00974440 Cadmium resistance regulatory protein +FIG00974445 FIG00974448: hypothetical protein +FIG00974448 FIG00974451: hypothetical protein +FIG00974451 FIG00974452: hypothetical protein +FIG00974452 FIG00974455: hypothetical protein +FIG00974457 FIG00974458: hypothetical protein +FIG00974459 FIG00974461: hypothetical protein +FIG00974461 PUTATIVE PORIN B PRECURSOR OUTER (GLUCOSE PORIN) TRANSMEMBRANE PROTEIN +FIG00974464 FIG00974465: hypothetical protein +FIG00974472 FIG00974474: hypothetical protein +FIG00974476 FIG00974478: hypothetical protein +FIG00974478 FIG00974481: hypothetical protein +FIG00974485 FIG00974486: hypothetical protein +FIG00974488 FIG00974489: hypothetical protein +FIG00974491 FIG00974492: hypothetical protein +FIG00974497 FIG00974498: hypothetical protein +FIG00974503 FIG00974507: hypothetical protein +FIG00974509 FIG00974512: hypothetical protein +FIG00974514 FIG00974517: hypothetical protein +FIG00974518 FIG00974519: hypothetical protein +FIG00974519 FIG00974520: hypothetical protein +FIG00974531 Proteins containing SET domain +FIG00974533 FIG00974536: hypothetical protein +FIG00974538 FIG00974540: hypothetical protein +FIG00974540 FIG00974543: hypothetical protein +FIG00974543 FIG00974545: hypothetical protein +FIG00974545 FIG00974548: hypothetical protein +FIG00974548 FIG00974550: hypothetical protein +FIG00974550 Sel1 +FIG00974551 FIG00974553: hypothetical protein +FIG00974553 FIG00974555: hypothetical protein +FIG00974555 FIG00974556: hypothetical protein +FIG00974556 FIG00974558: hypothetical protein +FIG00974568 FIG00974569: hypothetical protein +FIG00974569 FIG00974571: hypothetical protein +FIG00974571 FIG00974572: hypothetical protein +FIG00974572 FIG00974573: hypothetical protein +FIG00974578 FIG00974580: hypothetical protein +FIG00974593 FIG00974595: hypothetical protein +FIG00974600 FIG00974602: hypothetical protein +FIG00974602 TWO COMPONENT RESPONSE REGULATOR TRANSCRIPTION REGULATOR PROTEIN +FIG00974610 FIG00974611: hypothetical protein +FIG00974611 FIG00974612: hypothetical protein +FIG00974612 PROBABLE AMINO-ACID TRANSMEMBRANE ABC TRANSPORTER PROTEIN +FIG00974613 FIG00974614: hypothetical protein +FIG00974614 FIG00974615: hypothetical protein +FIG00974616 FIG00974617: hypothetical protein +FIG00974620 FIG00974621: hypothetical protein +FIG00974627 FIG00974629: hypothetical protein +FIG00974629 Pyridoxine 4-oxidase (EC 1.1.3.12) +FIG00974630 FIG00974632: hypothetical protein +FIG00974635 Operon 2450 Gene 2 signal peptide protein Nitrosomon as europaea ATCC 19718 gi +FIG00974640 Alginate regulatory protein AlgP +FIG00974643 Alkylhydroperoxidase AhpD domain protein +FIG00974644 FIG00974650: hypothetical protein +FIG00974650 FIG00974652: hypothetical protein +FIG00974652 response regulator, NarL-family +FIG00974659 small molecule metabolism; degradation; amines +FIG00974661 Periplasmic iron-binding protein +FIG00974663 FIG00974664: hypothetical protein +FIG00974665 FIG00974666: hypothetical protein +FIG00974667 FIG00974668: hypothetical protein +FIG00974668 FIG00974669: hypothetical protein +FIG00974674 cell processes; mobility chemotaxis +FIG00974676 FIG00974677: hypothetical protein +FIG00974677 FIG00974678: hypothetical protein +FIG00974678 PROBABLE SIGMA-54 INTERACTING TRANSCRIPTION REGULATOR PROTEIN +FIG00974680 FIG00974684: hypothetical protein +FIG00974685 FIG00974687: hypothetical protein +FIG00974687 FIG00974690: hypothetical protein +FIG00974690 FIG00974691: hypothetical protein +FIG00974691 FIG00538108: hypothetical protein +FIG00974692 Translation-disabling ACNase RloC +FIG00974703 FIG00974705: hypothetical protein +FIG00974705 FIG00974706: hypothetical protein +FIG00974707 FIG00974708: hypothetical protein +FIG00974708 FIG00974709: hypothetical protein +FIG00974719 FIG00974720: hypothetical protein +FIG00974725 FIG00974726: hypothetical protein +FIG00974727 FIG00974728: hypothetical protein +FIG00974736 FIG00974738: hypothetical protein +FIG00974738 FIG00974740: hypothetical protein +FIG00974743 FIG00974744: hypothetical protein +FIG00974744 FIG00974745: hypothetical protein +FIG00974745 FIG00974746: hypothetical protein +FIG00974746 FIG00974749: hypothetical protein +FIG00974749 FIG00974750: hypothetical protein +FIG00974750 FIG00974751: hypothetical protein +FIG00974751 FIG00974752: hypothetical protein +FIG00974752 ABC-type Fe3+-siderophore transport system permease component +FIG00974756 FIG00974761: hypothetical protein +FIG00974762 FIG00974764: hypothetical protein +FIG00974767 FIG00974768: hypothetical protein +FIG00974770 FIG00974775: hypothetical protein +FIG00974775 FIG00974777: hypothetical protein +FIG00974777 FIG00974781: hypothetical protein +FIG00974781 FIG00974782: hypothetical protein +FIG00974783 FIG00974787: hypothetical protein +FIG00974802 FIG00974803: hypothetical protein +FIG00974808 Leucyl aminopeptidase (aminopeptidase T) +FIG00974814 FIG00974815: hypothetical protein +FIG00974815 FIG00974820: hypothetical protein +FIG00974820 FIG00974822: hypothetical protein +FIG00974823 FIG00974824: hypothetical protein +FIG00974831 FIG00974833: hypothetical protein +FIG00974840 FIG00974841: hypothetical protein +FIG00974844 FIG00974845: hypothetical protein +FIG00974847 FIG00974849: hypothetical protein +FIG00974851 FIG00974852: hypothetical protein +FIG00974852 FIG00974853: hypothetical protein +FIG00974860 FIG00974863: hypothetical protein +FIG00974867 FIG00974868: hypothetical protein +FIG00974870 FIG00974871: hypothetical protein +FIG00974873 FIG00974874: hypothetical protein +FIG00974882 FIG00974886: hypothetical protein +FIG00974891 FIG00974896: hypothetical protein +FIG00974896 FIG00974897: hypothetical protein +FIG00974900 FIG00974902: hypothetical protein +FIG00974902 PUTATIVE SIGNAL PEPTIDE PROTEIN +FIG00974903 Siderophore biosynthesis protein +FIG00974907 FIG00974908: hypothetical protein +FIG00974912 FIG00974913: hypothetical protein +FIG00974913 putative prolin-rich exported protein +FIG00974919 FIG00974923: hypothetical protein +FIG00974923 FIG00974924: hypothetical protein +FIG00974925 FIG00974928: hypothetical protein +FIG00974929 FIG00974930: hypothetical protein +FIG00974930 FIG00433900: hypothetical protein +FIG00974941 FIG00974943: hypothetical protein +FIG00974943 FIG00974944: hypothetical protein +FIG00974944 FIG00974946: hypothetical protein +FIG00974946 PUTATIVE ARYLESTERASE PROTEIN +FIG00974947 FIG00974952: hypothetical protein +FIG00974959 FIG00974960: hypothetical protein +FIG00974960 FIG00974963: hypothetical protein +FIG00974972 Probable FERULIC acid hydratase protein +FIG00974981 FIG00974982: hypothetical protein +FIG00974983 EPS I polysaccharide export inner membrane protein epsE +FIG00974988 FIG00974989: hypothetical protein +FIG00974991 ABC-type molybdate transport system, permease component +FIG00974999 FIG00975002: hypothetical protein +FIG00975003 FIG00975006: hypothetical protein +FIG00975006 FIG00975007: hypothetical protein +FIG00975012 FIG00975013: hypothetical protein +FIG00975017 FIG00975018: hypothetical protein +FIG00975018 FIG00975019: hypothetical protein +FIG00975023 FIG00975026: hypothetical protein +FIG00975026 FIG00975028: hypothetical protein +FIG00975028 Transcriptional regulator, luxR family +FIG00975045 FIG00975047: hypothetical protein +FIG00975047 FIG00975049: hypothetical protein +FIG00975049 FIG00975051: hypothetical protein +FIG00975062 FIG00975066: hypothetical protein +FIG00975069 FIG00975070: hypothetical protein +FIG00975078 FIG00975082: hypothetical protein +FIG00975082 FIG00975083: hypothetical protein +FIG00975084 FIG00975087: hypothetical protein +FIG00975092 FIG00975093: hypothetical protein +FIG00975093 FIG00975095: hypothetical protein +FIG00975100 FIG00975101: hypothetical protein +FIG00975109 FIG00975110: hypothetical protein +FIG00975110 FIG00975114: hypothetical protein +FIG00975114 FIG00975115: hypothetical protein +FIG00975115 PUTATIVE TRANSMEMBRANE SENSOR HISTIDINE KINASE TRANSCRIPTION REGULATOR PROTEIN( EC:2.7.3.- ) +FIG00975117 FIG00975122: hypothetical protein +FIG00975122 FIG00975123: hypothetical protein +FIG00975123 FIG00975124: hypothetical protein +FIG00975125 FIG00975126: hypothetical protein +FIG00975128 FIG00975130: hypothetical protein +FIG00975131 Putative HNS-like transcription regulator protein +FIG00975135 FIG00975136: hypothetical protein +FIG00975137 Cytochrome c oxidase, subunit II +FIG00975140 FIG00975141: hypothetical protein +FIG00975144 FIG00975145: hypothetical protein +FIG00975149 FIG00975150: hypothetical protein +FIG00975150 FIG00975152: hypothetical protein +FIG00975154 FIG00975157: hypothetical protein +FIG00975175 FIG00975176: hypothetical protein +FIG00975176 FIG00450095: hypothetical protein +FIG00975178 PROBABLE ESTERASE/LIPASE PROTEIN( EC:3.1.- ) +FIG00975182 FIG00975183: hypothetical protein +FIG00975187 FIG00975188: hypothetical protein +FIG00975190 FIG00975192: hypothetical protein +FIG00975206 Membrane protein involved in colicin uptake +FIG00975207 FIG00975208: hypothetical protein +FIG00975216 FIG00975217: hypothetical protein +FIG00975217 FIG00975218: hypothetical protein +FIG00975218 FIG00975219: hypothetical protein +FIG00975219 cell processes; transport of small molecules; amino acids, amines +FIG00975220 FIG00975224: hypothetical protein +FIG00975240 FIG00975241: hypothetical protein +FIG00975242 FIG00975243: hypothetical protein +FIG00975244 FIG00975245: hypothetical protein +FIG00975245 Dehydrogenases with different specificities (related to short-chain alcohol dehydrogenases) +FIG00975261 FIG00975262: hypothetical protein +FIG00975265 FIG00975267: hypothetical protein +FIG00975270 FIG00975271: hypothetical protein +FIG00975274 FIG00975275: hypothetical protein +FIG00975277 FIG00975282: hypothetical protein +FIG00975289 FIG00975290: hypothetical protein +FIG00975296 FIG00975298: hypothetical protein +FIG00975299 FIG00975300: hypothetical protein +FIG00975303 FIG00975311: hypothetical protein +FIG00975311 FIG00975313: hypothetical protein +FIG00975317 FIG00975318: hypothetical protein +FIG00975318 FIG00975319: hypothetical protein +FIG00975320 FIG00975322: hypothetical protein +FIG00975323 FIG00975325: hypothetical protein +FIG00975327 FIG00975328: hypothetical protein +FIG00975328 FIG00975329: hypothetical protein +FIG00975333 FIG00975335: hypothetical protein +FIG00975350 FIG00975351: hypothetical protein +FIG00975359 FIG00975360: hypothetical protein +FIG00975366 FIG00975370: hypothetical protein +FIG00975373 miscellaneous; virulence +FIG00975384 FIG00975386: hypothetical protein +FIG00975389 FIG00975390: hypothetical protein +FIG00975392 FIG00975394: hypothetical protein +FIG00975394 FIG00975395: hypothetical protein +FIG00975396 FIG00975397: hypothetical protein +FIG00975398 FIG00975399: hypothetical protein +FIG00975399 FIG00975400: hypothetical protein +FIG00975403 FIG00975404: hypothetical protein +FIG00975404 FIG00975406: hypothetical protein +FIG00975406 FIG00975407: hypothetical protein +FIG00975408 FIG00975411: hypothetical protein +FIG00975413 FIG00975415: hypothetical protein +FIG00975427 FIG00975428: hypothetical protein +FIG00975428 FIG00975429: hypothetical protein +FIG00975429 aryldialkylphosphatase related protein +FIG00975439 FIG00975441: hypothetical protein +FIG00975441 FIG00975449: hypothetical protein +FIG00975451 FIG00975452: hypothetical protein +FIG00975457 FIG00975458: hypothetical protein +FIG00975458 FIG00975460: hypothetical protein +FIG00975465 FIG00975466: hypothetical protein +FIG00975475 FIG00975476: hypothetical protein +FIG00975480 FIG00975482: hypothetical protein +FIG00975484 FIG028593: membrane protein +FIG00975493 FIG00975494: hypothetical protein +FIG00975498 FIG00975499: hypothetical protein +FIG00975503 FIG00975505: hypothetical protein +FIG00975508 FIG00975509: hypothetical protein +FIG00975514 FIG00975517: hypothetical protein +FIG00975517 FIG00975518: hypothetical protein +FIG00975530 FIG00975531: hypothetical protein +FIG00975532 nitrogen regulatory protein P-II (GlnB, GlnK) +FIG00975534 FIG00975535: hypothetical protein +FIG00975535 FIG00975537: hypothetical protein +FIG00975537 PUTATIVE HNS-LIKE TRANSCRIPTION REGULATOR PROTEIN +FIG00975545 FIG00975547: hypothetical protein +FIG00975557 FIG00975558: hypothetical protein +FIG00975561 FIG00975562: hypothetical protein +FIG00975562 FIG00975563: hypothetical protein +FIG00975568 FIG00975570: hypothetical protein +FIG00975570 FIG00975571: hypothetical protein +FIG00975571 Flagellar transcriptional activator flhD +FIG00975573 FIG00975574: hypothetical protein +FIG00975574 FIG00975575: hypothetical protein +FIG00975581 FIG00975583: hypothetical protein +FIG00975588 FIG00975592: hypothetical protein +FIG00975595 DNA uptake protein and related DNA-binding proteins +FIG00975603 Transcriptional regulator, PbsX family +FIG00975604 FIG00975611: hypothetical protein +FIG00975611 FIG00975614: hypothetical protein +FIG00975618 FIG00975620: hypothetical protein +FIG00975623 FIG00975625: hypothetical protein +FIG00975632 PUTATIVE ATP-BINDING ABC TRANSPORTER PROTEIN +FIG00975634 FIG00975636: hypothetical protein +FIG00975637 Uncharacterized membrane-anchored protein +FIG00975640 FIG00975641: hypothetical protein +FIG00975641 FIG00975643: hypothetical protein +FIG00975643 FIG00975644: hypothetical protein +FIG00975649 FIG00975654: hypothetical protein +FIG00975654 FIG00975655: hypothetical protein +FIG00975657 FIG00975658: hypothetical protein +FIG00975662 FIG00975664: hypothetical protein +FIG00975665 FIG00975666: hypothetical protein +FIG00975671 FIG00975674: hypothetical protein +FIG00975674 FIG00975676: hypothetical protein +FIG00975678 FIG00975683: hypothetical protein +FIG00975685 FIG00975687: hypothetical protein +FIG00975687 FIG00975688: hypothetical protein +FIG00975688 FIG00975689: hypothetical protein +FIG00975690 FIG00975693: hypothetical protein +FIG00975702 FIG00975703: hypothetical protein +FIG00975703 FIG00975704: hypothetical protein +FIG00975705 FIG00975706: hypothetical protein +FIG00975706 FIG00975711: hypothetical protein +FIG00975717 FIG00975718: hypothetical protein +FIG00975718 FIG00975719: hypothetical protein +FIG00975728 FIG00975731: hypothetical protein +FIG00975735 FIG00975736: hypothetical protein +FIG00975737 FIG00975739: hypothetical protein +FIG00975743 FIG00975747: hypothetical protein +FIG00975750 PUTATIVE LIPOPROTEIN TRANSMEMBRANE +FIG00975755 FIG00975756: hypothetical protein +FIG00975757 FIG00975759: hypothetical protein +FIG00975768 FIG00975772: hypothetical protein +FIG00975772 FIG00975774: hypothetical protein +FIG00975774 Cyclohexanone monooxygenase (EC 1.14.13.22) +FIG00975781 FIG00975782: hypothetical protein +FIG00975783 FIG00975784: hypothetical protein +FIG00975784 FIG00975785: hypothetical protein +FIG00975786 FIG00975789: hypothetical protein +FIG00975795 FIG00975797: hypothetical protein +FIG00975797 FIG00975799: hypothetical protein +FIG00975799 FIG00975800: hypothetical protein +FIG00975809 FIG00975810: hypothetical protein +FIG00975812 FIG00975814: hypothetical protein +FIG00975816 FIG00975821: hypothetical protein +FIG00975821 FIG00975822: hypothetical protein +FIG00975822 Phytanoyl-CoA dioxygenase +FIG00975827 FIG00975830: hypothetical protein +FIG00975833 FIG00975834: hypothetical protein +FIG00975839 FIG00975842: hypothetical protein +FIG00975844 alcohol dehydrogenase, class IV( EC:1.1.1.- ) +FIG00975851 FIG00975852: hypothetical protein +FIG00975857 FIG00975860: hypothetical protein +FIG00975860 FIG00975861: hypothetical protein +FIG00975865 FIG00975867: hypothetical protein +FIG00975867 FIG00975868: hypothetical protein +FIG00975868 FIG00975869: hypothetical protein +FIG00975869 FIG00975871: hypothetical protein +FIG00975883 FIG00975889: hypothetical protein +FIG00975889 FIG00975890: hypothetical protein +FIG00975891 FIG00975894: hypothetical protein +FIG00975894 FIG00975895: hypothetical protein +FIG00975901 FIG00975905: hypothetical protein +FIG00975905 PUTATIVE SMALL HEAT SHOCK PROTEIN +FIG00975913 FIG00975919: hypothetical protein +FIG00975919 FIG00975920: hypothetical protein +FIG00975928 FIG00975929: hypothetical protein +FIG00975932 FIG00975936: hypothetical protein +FIG00975936 FIG00975943: hypothetical protein +FIG00975945 FIG00975947: hypothetical protein +FIG00975953 FIG00975954: hypothetical protein +FIG00975956 FIG00975962: hypothetical protein +FIG00975974 FIG00975976: hypothetical protein +FIG00975976 FIG00975977: hypothetical protein +FIG00975979 FIG00975980: hypothetical protein +FIG00975980 FIG00975981: hypothetical protein +FIG00975981 FIG00975982: hypothetical protein +FIG00975986 PUTATIVE PHASIN PROTEIN +FIG00975990 FIG00975993: hypothetical protein +FIG00976008 FIG00976009: hypothetical protein +FIG00976013 FIG00976015: hypothetical protein +FIG00976016 FIG00976020: hypothetical protein +FIG00976022 FIG00976024: hypothetical protein +FIG00976032 FIG00976034: hypothetical protein +FIG00976034 Regulatory protein, LuxR:Tetratricopeptide TPR_4 +FIG00976042 FIG00976048: hypothetical protein +FIG00976049 FIG00976050: hypothetical protein +FIG00976054 FIG00976055: hypothetical protein +FIG00976055 FIG00976059: hypothetical protein +FIG00976072 FIG00976074: hypothetical protein +FIG00976076 FIG00976078: hypothetical protein +FIG00976078 FIG00976082: hypothetical protein +FIG00976082 FIG00976084: hypothetical protein +FIG00976086 FIG00976088: hypothetical protein +FIG00976097 FIG00976098: hypothetical protein +FIG00976099 FIG00976102: hypothetical protein +FIG00976113 PROBABLE OUTER MEMBRANE LIPOPROTEIN TRANSMEMBRANE +FIG00976115 FIG00976116: hypothetical protein +FIG00976122 FIG00976123: hypothetical protein +FIG00976128 FIG00976129: hypothetical protein +FIG00976129 FIG00976130: hypothetical protein +FIG00976135 FIG00976137: hypothetical protein +FIG00976144 FIG00976145: hypothetical protein +FIG00976145 FIG00976146: hypothetical protein +FIG00976146 FIG00976154: hypothetical protein +FIG00976155 FIG00976157: hypothetical protein +FIG00976161 FIG00976165: hypothetical protein +FIG00976166 KleF protein +FIG00976178 Iron(III) dicitrate transport ATP-binding protein fecE +FIG00976182 FIG00976184: hypothetical protein +FIG00976190 FIG00976191: hypothetical protein +FIG00976191 PROBABLE LIPOPROTEIN SIGNAL PEPTIDE +FIG00976195 FIG00976196: hypothetical protein +FIG00976196 transcriptional regulator, MarR-family +FIG00976200 universal stress protein, UspA family +FIG00976206 FIG00976208: hypothetical protein +FIG00976223 FIG00976224: hypothetical protein +FIG00976228 FIG00976229: hypothetical protein +FIG00976230 FIG00976233: hypothetical protein +FIG00976237 FIG00976240: hypothetical protein +FIG00976240 FIG00976241: hypothetical protein +FIG00976241 FIG00976243: hypothetical protein +FIG00976248 FIG00976250: hypothetical protein +FIG00976250 FIG00976251: hypothetical protein +FIG00976262 FIG00976264: hypothetical protein +FIG00976279 FIG00976285: hypothetical protein +FIG00976285 FIG00976286: hypothetical protein +FIG00976288 FIG00976289: hypothetical protein +FIG00976289 Panthothenate synthetase +FIG00976291 FIG00976298: hypothetical protein +FIG00976298 PROBABLE ENTERICIDIN PRECURSOR LIPOPROTEIN +FIG00976300 FIG00976301: hypothetical protein +FIG00976304 signal transduction histidine kinase( EC:2.7.3.- ) +FIG00976313 protein of unknown function DUF21 +FIG00976323 FIG00976327: hypothetical protein +FIG00976328 FIG00976329: hypothetical protein +FIG00976334 transcriptional regulator, AraC-family +FIG00976343 FIG00976346: hypothetical protein +FIG00976346 FIG00976349: hypothetical protein +FIG00976354 PUTATIVE DIAMINOPIMELATE DECARBOXYLASE PROTEIN +FIG00976361 FIG00976362: hypothetical protein +FIG00976367 putative glucose-fructose oxidoreductase oxidoreductase protein +FIG00976370 FIG00976371: hypothetical protein +FIG00976380 FIG00976383: hypothetical protein +FIG00976383 FIG00976384: hypothetical protein +FIG00976384 FIG00976385: hypothetical protein +FIG00976386 FIG00976387: hypothetical protein +FIG00976387 FIG00976388: hypothetical protein +FIG00976392 Hydrolase, isochorismatase family +FIG00976395 FIG00976396: hypothetical protein +FIG00976397 FIG00976398: hypothetical protein +FIG00976400 FIG00976401: hypothetical protein +FIG00976403 HrpX +FIG00976407 FIG00976409: hypothetical protein +FIG00976415 FIG00976416: hypothetical protein +FIG00976422 FIG00976424: hypothetical protein +FIG00976427 FIG00976432: hypothetical protein +FIG00976443 FIG00976444: hypothetical protein +FIG00976454 FIG00976456: hypothetical protein +FIG00976460 Phospholipase/lecithinase/hemolysin +FIG00976462 FIG00976465: hypothetical protein +FIG00976473 Hypothetical transcriptional regulator ydcI +FIG00976479 FIG00976480: hypothetical protein +FIG00976480 Molybdopterin-guanine dinucleotide biosynthesis MobB region +FIG00976499 FIG00976502: hypothetical protein +FIG00976510 FIG00976511: hypothetical protein +FIG00976511 Superfamily I DNA and RNA helicases +FIG00976512 FIG00976513: hypothetical protein +FIG00976515 FIG00976516: hypothetical protein +FIG00976518 FIG00976520: hypothetical protein +FIG00976523 FIG00976525: hypothetical protein +FIG00976525 FIG00976526: hypothetical protein +FIG00976535 FIG00976536: hypothetical protein +FIG00976536 FIG00976537: hypothetical protein +FIG00976555 FIG00976556: hypothetical protein +FIG00976556 FIG00976558: hypothetical protein +FIG00976561 major intrinsic protein +FIG00976562 FIG00976564: hypothetical protein +FIG00976565 FIG00976570: hypothetical protein +FIG00976570 response regulator-like protein +FIG00976575 PROBABLE LIPOPROTEIN TRANSMEMBRANE +FIG00976582 FIG00976583: hypothetical protein +FIG00976586 PUTATIVE TRANSFERASE PROTEIN( EC:2.- ) +FIG00976601 FIG00976602: hypothetical protein +FIG00976602 FIG00976604: hypothetical protein +FIG00976604 probable sterol methyltransferase +FIG00976608 FIG00976609: hypothetical protein +FIG00976609 FIG00976610: hypothetical protein +FIG00976610 FIG00976611: hypothetical protein +FIG00976611 cell processes; transport of small molecules; incorporation metal ions +FIG00976619 FIG00976620: hypothetical protein +FIG00976636 FIG00976637: hypothetical protein +FIG00976646 FIG00976653: hypothetical protein +FIG00976662 FIG00976663: hypothetical protein +FIG00976663 FIG00976664: hypothetical protein +FIG00976664 PUTATIVE PILIN TRANSMEMBRANE PROTEIN +FIG00976671 FIG00976673: hypothetical protein +FIG00976674 FIG00976675: hypothetical protein +FIG00976675 FIG00976678: hypothetical protein +FIG00976678 FIG00976681: hypothetical protein +FIG00976690 FIG00976691: hypothetical protein +FIG00976691 HRP PILUS SUBUNIT HRPY PROTEIN +FIG00976697 FIG00976700: hypothetical protein +FIG00976711 FIG00976713: hypothetical protein +FIG00976722 FIG00976724: hypothetical protein +FIG00976725 FIG00976726: hypothetical protein +FIG00976731 FIG00976732: hypothetical protein +FIG00976735 FIG00976738: hypothetical protein +FIG00976775 putative component of type II secretion apparatus +FIG00976783 FIG00976785: hypothetical protein +FIG00976787 FIG00976790: hypothetical protein +FIG00976791 FIG00976792: hypothetical protein +FIG00976797 FIG00976799: hypothetical protein +FIG00976800 FIG00976801: hypothetical protein +FIG00976809 FIG00976810: hypothetical protein +FIG00976810 FIG00976811: hypothetical protein +FIG00976819 FIG00450070: hypothetical protein +FIG00976825 FIG00976827: hypothetical protein +FIG00976836 FIG00976839: hypothetical protein +FIG00976842 FIG00976843: hypothetical protein +FIG00976847 response regulator, OmpR-family +FIG00976853 FIG00976854: hypothetical protein +FIG00976860 FIG00976864: hypothetical protein +FIG00976868 Dioxygenases related to 2-nitropropane dioxygenase +FIG00976871 FIG00976873: hypothetical protein +FIG00976873 FIG00976874: hypothetical protein +FIG00976874 Steroid delta-isomerase +FIG00976877 FIG00976881: hypothetical protein +FIG00976882 FIG00976887: hypothetical protein +FIG00976887 FIG00976890: hypothetical protein +FIG00976894 FIG00976895: hypothetical protein +FIG00976896 FIG00976899: hypothetical protein +FIG00976907 FIG00976908: hypothetical protein +FIG00976908 FIG00976912: hypothetical protein +FIG00976912 acid sphingomyelinase-like phosphodiesterase 3B +FIG00976915 FIG00976916: hypothetical protein +FIG00976920 FIG00976924: hypothetical protein +FIG00976924 FIG00976926: hypothetical protein +FIG00976934 FIG00976935: hypothetical protein +FIG00976958 FIG00976961: hypothetical protein +FIG00976968 putative signal peptide protein +FIG00976986 FIG00976987: hypothetical protein +FIG00976987 FIG00976989: hypothetical protein +FIG00976997 FIG00976999: hypothetical protein +FIG00977014 FIG00977015: hypothetical protein +FIG00977021 FIG00977024: hypothetical protein +FIG00977031 regulatory protein, LysR:LysR, substrate-binding +FIG00977032 FIG00975564: hypothetical protein +FIG00977033 FIG00977037: hypothetical protein +FIG00977038 FIG00977039: hypothetical protein +FIG00977043 FIG00977045: hypothetical protein +FIG00977045 FIG00977050: hypothetical protein +FIG00977051 FIG00977054: hypothetical protein +FIG00977054 FIG00977060: hypothetical protein +FIG00977060 FIG00977061: hypothetical protein +FIG00977061 FIG00977062: hypothetical protein +FIG00977063 FIG00977066: hypothetical protein +FIG00977076 FIG00977078: hypothetical protein +FIG00977084 FIG00977087: hypothetical protein +FIG00977087 FIG00977091: hypothetical protein +FIG00977100 FIG00977101: hypothetical protein +FIG00977107 FIG00977111: hypothetical protein +FIG00977113 FIG00977115: hypothetical protein +FIG00977115 FIG00977117: hypothetical protein +FIG00977117 FIG00977120: hypothetical protein +FIG00977120 FIG00977121: hypothetical protein +FIG00977121 FIG00977122: hypothetical protein +FIG00977141 putatve zinc-binding dehydrogenase +FIG00977154 FIG00977155: hypothetical protein +FIG00977173 Biotin carboxylase (EC 6.3.4.14) +FIG00977176 FIG00977177: hypothetical protein +FIG00977200 FIG00977202: hypothetical protein +FIG00977202 FIG00977205: hypothetical protein +FIG00977218 FIG00977219: hypothetical protein +FIG00977219 Bona fide RidA/YjgF/TdcF/RutC subgroup +FIG00977226 Spherulin 4 precursor +FIG00977231 FIG00977232: hypothetical protein +FIG00977233 Type III secretion possible injected virulence protein (YopM) / internalin, putative +FIG00977241 FIG00977246: hypothetical protein +FIG00977251 FIG00977253: hypothetical protein +FIG00977253 FIG00977256: hypothetical protein +FIG00977257 FIG00977258: hypothetical protein +FIG00977259 FIG00977264: hypothetical protein +FIG00977266 PROBABLE COMPOSITE TWO-COMPONENT TRANSCRIPTIONAL REGULATORY (SENSOR HISTIDINE KINASE AND RESPONSE REGULATOR HYBRID) TRANSCRIPTION REGULATOR PROTEIN( EC:2.7.3.- ) +FIG00977286 FIG00977287: hypothetical protein +FIG00977287 FIG00977288: hypothetical protein +FIG00977288 FIG00977290: hypothetical protein +FIG00977297 FIG00977298: hypothetical protein +FIG00977316 Nuclear export factor GLE1 +FIG00977318 FIG00977319: hypothetical protein +FIG00977330 FIG00977333: hypothetical protein +FIG00977343 FIG00977344: hypothetical protein +FIG00977354 FIG00977355: hypothetical protein +FIG00977358 PROBABLE INTEGRAL MEMBRANE TRANSMEMBRANE PROTEIN +FIG00977365 FIG00977368: hypothetical protein +FIG00977368 PROBABLE COMPOSITE TWO COMPONENT REGULATORY (SENSOR HISTIDINE KINASE AND RESPONSE REGULATOR HYBRID) TRANSCRIPTION REGULATOR PROTEIN( EC:2.7.3.- ) +FIG00977369 FIG00977371: hypothetical protein +FIG00977378 FIG00977382: hypothetical protein +FIG00977382 FIG00977383: hypothetical protein +FIG00977409 FIG00977411: hypothetical protein +FIG00977411 putative acyl transferase protein +FIG00977412 PUTATIVE TRANSMEMBRANE ACYL-COA DESATURASE (FATTY ACID DESATURASE) OXIDOREDUCTASE PROTEIN( EC:1.14.99.5 ) +FIG00977416 FIG00977418: hypothetical protein +FIG00977418 FIG00977419: hypothetical protein +FIG00977423 FIG00977424: hypothetical protein +FIG00977430 FIG00977431: hypothetical protein +FIG00977437 FIG00977438: hypothetical protein +FIG00977438 FIG00977439: hypothetical protein +FIG00977443 putative Sterol desaturase +FIG00977452 FIG00977453: hypothetical protein +FIG00977461 FIG00977462: hypothetical protein +FIG00977462 FIG00977464: hypothetical protein +FIG00977466 FIG00977469: hypothetical protein +FIG00977469 Putative acyl coenzyme A thioester hydrolase protein (EC 3.1.2.2) +FIG00977472 FIG00977474: hypothetical protein +FIG00977476 FIG00977479: hypothetical protein +FIG00977479 FIG00977480: hypothetical protein +FIG00977482 FIG00977486: hypothetical protein +FIG00977489 FIG00977493: hypothetical protein +FIG00977493 FIG00977494: hypothetical protein +FIG00977494 FIG00977496: hypothetical protein +FIG00977504 FIG00977507: hypothetical protein +FIG00977507 FIG00977508: hypothetical protein +FIG00977508 FIG00977510: hypothetical protein +FIG00977511 PROBABLE EXTRACYTOPLASMIC FUNCTION SIGMA FACTOR TRANSCRIPTION REGULATOR PROTEIN +FIG00977513 FIG00977514: hypothetical protein +FIG00977514 FIG00977515: hypothetical protein +FIG00977518 FIG00977520: hypothetical protein +FIG00977526 FIG00977527: hypothetical protein +FIG00977527 FIG00977528: hypothetical protein +FIG00977528 FIG00977529: hypothetical protein +FIG00977531 FIG00977532: hypothetical protein +FIG00977538 FIG00977539: hypothetical protein +FIG00977539 PUTATIVE EXTRACYTOPLASMIC FUNCTION SIGMA FACTOR (IRON-REGULATED) TRANSCRIPTION REGULATOR PROTEIN +FIG00977540 FIG00977541: hypothetical protein +FIG00977543 FIG00977544: hypothetical protein +FIG00977544 FIG00977550: hypothetical protein +FIG00977550 FIG00977553: hypothetical protein +FIG00977554 FIG00977555: hypothetical protein +FIG00977566 FIG00977568: hypothetical protein +FIG00977570 FIG00977571: hypothetical protein +FIG00977574 FIG00977576: hypothetical protein +FIG00977583 FIG00977584: hypothetical protein +FIG00977585 probable lipoprotein transmembrane +FIG00977591 FIG00977592: hypothetical protein +FIG00977595 IncW-like replication protein +FIG00977599 FIG00977601: hypothetical protein +FIG00977601 FIG00977605: hypothetical protein +FIG00977605 FIG00977607: hypothetical protein +FIG00977607 FIG00977609: hypothetical protein +FIG00977627 FIG00977628: hypothetical protein +FIG00977629 FIG00977631: hypothetical protein +FIG00977633 FIG00977635: hypothetical protein +FIG00977643 FIG00977644: hypothetical protein +FIG00977648 FIG00977649: hypothetical protein +FIG00977656 FIG00977659: hypothetical protein +FIG00977670 FIG00977674: hypothetical protein +FIG00977684 FIG00977685: hypothetical protein +FIG00977686 FIG00977689: hypothetical protein +FIG00977689 FIG00977690: hypothetical protein +FIG00977694 FIG00977701: hypothetical protein +FIG00977701 FIG00977702: hypothetical protein +FIG00977706 Type II secretory pathway, component PulD +FIG00977713 FIG00977718: hypothetical protein +FIG00977718 FIG00977719: hypothetical protein +FIG00977721 FIG00977723: hypothetical protein +FIG00977743 FIG00977744: hypothetical protein +FIG00977750 FIG00977751: hypothetical protein +FIG00977753 PROBABLE HIGH POTENTIAL IRON-SULFUR (HIPIP) SIGNAL PEPTIDE PROTEIN +FIG00977756 FIG00977758: hypothetical protein +FIG00977771 FIG00977772: hypothetical protein +FIG00977772 FIG00977773: hypothetical protein +FIG00977780 Phospholipase/Carboxylesterase +FIG00977782 FIG00977783: hypothetical protein +FIG00977785 Single-stranded DNA-binding protein in PFGI-1-like cluster +FIG00977804 Outer membrane protein V +FIG00977807 FIG00977811: hypothetical protein +FIG00977811 TRANSCRIPTION REGULATOR PRHJ TRANSCRIPTION REGULATOR PROTEIN +FIG00977813 small molecule metabolism; degradation +FIG00977815 FIG00977816: hypothetical protein +FIG00977821 FIG00977830: hypothetical protein +FIG00977837 Magnesium and cobalt transport protein CorA +FIG00977838 FIG00977839: hypothetical protein +FIG00977840 FIG00977841: hypothetical protein +FIG00977841 FIG00977846: hypothetical protein +FIG00977846 FIG00977848: hypothetical protein +FIG00977848 FIG00977849: hypothetical protein +FIG00977857 FIG00977858: hypothetical protein +FIG00977858 ISOPENTENYL TRANSFERASE PROTEIN +FIG00977863 FIG00977866: hypothetical protein +FIG00977868 FIG00977870: hypothetical protein +FIG00977872 FIG00977876: hypothetical protein +FIG00977878 FIG00977879: hypothetical protein +FIG00977880 FIG00977881: hypothetical protein +FIG00977881 FIG00977882: hypothetical protein +FIG00977884 FIG00977885: hypothetical protein +FIG00977891 PROBABLE TRANSCRIPTION REGULATOR TRANSCRIPTION REGULATOR PROTEIN +FIG00977896 FIG00977897: hypothetical protein +FIG00977897 FIG00977899: hypothetical protein +FIG00977906 FIG00977912: hypothetical protein +FIG00977923 FIG00977926: hypothetical protein +FIG00977927 FIG00977929: hypothetical protein +FIG00977939 FIG00977943: hypothetical protein +FIG00977950 FIG00977951: hypothetical protein +FIG00977951 FIG00977955: hypothetical protein +FIG00977955 FIG00977956: hypothetical protein +FIG00977956 FIG00977958: hypothetical protein +FIG00977962 FIG00977963: hypothetical protein +FIG00977967 contains partial similarity to sensory box/GGDEF family protein(transmembrane protein) +FIG00977970 FIG00977976: hypothetical protein +FIG00977978 FIG00977980: hypothetical protein +FIG00977993 FIG00977997: hypothetical protein +FIG00978001 FIG00978002: hypothetical protein +FIG00978017 FIG00978018: hypothetical protein +FIG00978018 FIG00978020: hypothetical protein +FIG00978031 PUTATIVE AMINO ACIDS-BINDING TRANSMEMBRANE PROTEIN +FIG00978042 FIG00978043: hypothetical protein +FIG00978043 FIG00978047: hypothetical protein +FIG00978051 FIG00978052: hypothetical protein +FIG00978052 P pilus assembly protein, pilin FimA +FIG00978053 EPS I polysaccharide export inner membrane protein epsF +FIG00978063 AvrA homolog +FIG00978071 FIG00978074: hypothetical protein +FIG00978074 FIG00978077: hypothetical protein +FIG00978077 Type IV secretory pathway, VirB4 components +FIG00978081 FIG00978082: hypothetical protein +FIG00978082 FIG00978084: hypothetical protein +FIG00978094 FIG00978095: hypothetical protein +FIG00978095 FIG00978101: hypothetical protein +FIG00978103 FIG00978105: hypothetical protein +FIG00978118 FIG00978122: hypothetical protein +FIG00978122 FIG00978123: hypothetical protein +FIG00978129 FIG00978132: hypothetical protein +FIG00978138 FIG00978141: hypothetical protein +FIG00978170 FIG00978176: hypothetical protein +FIG00978180 FIG00978184: hypothetical protein +FIG00978186 FIG00978191: hypothetical protein +FIG00978193 FIG00978194: hypothetical protein +FIG00978200 FIG00978201: hypothetical protein +FIG00978215 FIG00978216: hypothetical protein +FIG00978225 FIG00978227: hypothetical protein +FIG00978228 Dimethylmenaquinone methyltransferase +FIG00978247 FIG00978248: hypothetical protein +FIG00978249 FIG00978250: hypothetical protein +FIG00978251 FIG00978253: hypothetical protein +FIG00978253 FIG00978254: hypothetical protein +FIG00978263 FIG00978264: hypothetical protein +FIG00978267 FIG00978269: hypothetical protein +FIG00978272 FIG026997: Hypothetical protein +FIG00978276 FIG00978282: hypothetical protein +FIG00978283 FIG00978287: hypothetical protein +FIG00978299 Zn-dependent protease with chaperone function +FIG00978302 FIG00978305: hypothetical protein +FIG00978305 FIG00978306: hypothetical protein +FIG00978306 FIG00978307: hypothetical protein +FIG00978307 FIG00978313: hypothetical protein +FIG00978316 FIG00978317: hypothetical protein +FIG00978317 FIG00978320: hypothetical protein +FIG00978320 FIG00978324: hypothetical protein +FIG00978325 FIG00978327: hypothetical protein +FIG00978333 putative histone-like protein +FIG00978343 FIG00978344: hypothetical protein +FIG00978344 FIG00978345: hypothetical protein +FIG00978346 FIG00978351: hypothetical protein +FIG00978351 glyoxylate induced protein +FIG00978353 FIG00978360: hypothetical protein +FIG00978365 FIG00978366: hypothetical protein +FIG00978367 FIG00978376: hypothetical protein +FIG00978418 FIG00978419: hypothetical protein +FIG00978419 structural elements; cell exterior; surface polysaccharides/antigens +FIG00978423 FIG00978426: hypothetical protein +FIG00978431 Conjugative transfer protein TraD +FIG00978432 FIG00978435: hypothetical protein +FIG00978440 FIG00978442: hypothetical protein +FIG00978442 FIG00978446: hypothetical protein +FIG00978451 FIG00978452: hypothetical protein +FIG00978452 FIG00978455: hypothetical protein +FIG00978455 FIG00978456: hypothetical protein +FIG00978456 FIG00978462: hypothetical protein +FIG00978464 putative PilL-like protein +FIG00978467 PROBABLE OXIDOREDUCTASE PROTEIN( EC:1.- ) +FIG00978484 FIG00978485: hypothetical protein +FIG00978486 FIG00978487: hypothetical protein +FIG00978488 FIG00978490: hypothetical protein +FIG00978496 FIG00978498: hypothetical protein +FIG00978499 FIG00978505: hypothetical protein +FIG00978505 FIG00978506: hypothetical protein +FIG00978517 FIG00978518: hypothetical protein +FIG00978518 FIG00978522: hypothetical protein +FIG00978522 FIG00978524: hypothetical protein +FIG00978526 FIG00978528: hypothetical protein +FIG00978532 FIG00978533: hypothetical protein +FIG00978533 FIG00978535: hypothetical protein +FIG00978537 FIG00978539: hypothetical protein +FIG00978539 FIG00978541: hypothetical protein +FIG00978544 FIG00978546: hypothetical protein +FIG00978548 FIG00978553: hypothetical protein +FIG00978565 FIG00978567: hypothetical protein +FIG00978567 FIG00978571: hypothetical protein +FIG00978571 FIG00978574: hypothetical protein +FIG00978582 FIG00978586: hypothetical protein +FIG00978603 FIG00978609: hypothetical protein +FIG00978613 FIG00978614: hypothetical protein +FIG00978614 FIG00978616: hypothetical protein +FIG00978623 FIG00978624: hypothetical protein +FIG00978633 FIG00978635: hypothetical protein +FIG00978652 Triacylglycerol lipase( EC:3.1.1.3 ) +FIG00978660 FIG00978662: hypothetical protein +FIG00978662 Glutathione S-transferase N terminus +FIG00978672 FIG00978679: hypothetical protein +FIG00978679 FIG00978688: hypothetical protein +FIG00978697 FIG00978699: hypothetical protein +FIG00978699 FIG00978706: hypothetical protein +FIG00978707 FIG00978708: hypothetical protein +FIG00978708 Metallo-beta-lactamase +FIG00978712 FIG00978715: hypothetical protein +FIG00978717 FIG00978726: hypothetical protein +FIG00978735 FIG00978738: hypothetical protein +FIG00978741 FIG00978744: hypothetical protein +FIG00978744 transcriptional regulator RhlR +FIG00978745 FIG00978748: hypothetical protein +FIG00978758 FIG00978759: hypothetical protein +FIG00978759 GerE family regulatory protein +FIG00978771 Protein SlyX +FIG00978782 FIG00978789: hypothetical protein +FIG00978793 FIG00978794: hypothetical protein +FIG00978794 Methyl-accepting chemotaxis protein +FIG00978796 Cytochrome c, mono- and diheme variants +FIG00978806 FIG00978812: hypothetical protein +FIG00978813 FIG00978815: hypothetical protein +FIG00978817 FIG00978819: hypothetical protein +FIG00978819 putative transglycosylase +FIG00978824 FIG00978825: hypothetical protein +FIG00978828 FIG00978830: hypothetical protein +FIG00978843 FIG00978844: hypothetical protein +FIG00978859 FIG00978860: hypothetical protein +FIG00978875 PROBABLE TWO-COMPONENT SYSTEM RESPONSE REGULATOR TRANSCRIPTION REGULATOR PROTEIN +FIG00978879 FIG00978881: hypothetical protein +FIG00978892 FIG00978894: hypothetical protein +FIG00978896 PROBABLE SULFITE:CYTOCHROME C OXIDOREDUCTASE (SUBUNIT B) OXIDOREDUCTASE PROTEIN( EC:1.8.2.1 ) +FIG00978926 PUTATIVE AVRPPHE AVIRULENCE PROTEIN-HOMOLOG +FIG00978938 RESPONSE REGULATOR TRANSCRIPTION REGULATOR PROTEIN +FIG00978950 FIG00978951: hypothetical protein +FIG00979015 FIG00979016: hypothetical protein +FIG00979025 FIG00979028: hypothetical protein +FIG00979028 FIG00979031: hypothetical protein +FIG00979039 FIG00979040: hypothetical protein +FIG00979044 FIG00979045: hypothetical protein +FIG00979045 FIG00979048: hypothetical protein +FIG00979091 Mll8287 protein +FIG00979299 replication P family protein +FIG00980400 Phopholipase D domain protein +FIG00980629 FIG00980636: hypothetical protein +FIG00980708 FIG00980710: hypothetical protein +FIG00980781 Bll7580 protein +FIG00980834 Endoglucanase E-4 precursor (EC 3.2.1.4) +FIG00981077 iron transport protein +FIG00981083 FIG021574: Possible membrane protein related to de Novo purine biosynthesis +FIG00981490 FIG00733361: hypothetical protein +FIG00981615 FIG00981618: hypothetical protein +FIG00981733 FIG00981735: hypothetical protein +FIG00981758 FIG00733599: hypothetical protein +FIG00981843 araC family transcriptional regulator +FIG00981899 fatty acid-CoA racemase +FIG00982104 N-acyl-D-amino acid deacylase family protein +FIG00982297 FIG00982327: hypothetical protein +FIG00982370 FIG00734369: hypothetical protein +FIG00982416 FIG00734363: hypothetical protein +FIG00982437 FIG00982447: hypothetical protein +FIG00982515 conjugative transfer gene complex protein +FIG00982561 predicted molybdopterin-guanine dinucleotide biosynthesis protein A +FIG00982571 putative acetyltransferase( EC:2.3.1.- ) +FIG00982736 COG0607: Rhodanese-related sulfurtransferase +FIG00982862 FIG01028857: hypothetical protein +FIG00982878 FIG00982881: hypothetical protein +FIG00982987 putative ABC transporter, sugar permease protein +FIG00983012 FIG00983014: hypothetical protein +FIG00983034 FIG00733227: hypothetical protein +FIG00983163 carboxypeptidase G2 precursor( EC:3.4.17.11 ) +FIG00983349 FIG00983350: hypothetical protein +FIG00983350 FIG00983351: hypothetical protein +FIG00983352 FIG00983353: hypothetical protein +FIG00983357 FIG00983358: hypothetical protein +FIG00983358 Nodulation ABC transporter, NodI +FIG00983359 putative transmembrane exopolysaccharide biosynthesis protein +FIG00983360 FIG00983361: hypothetical protein +FIG00983362 FIG00983363: hypothetical protein +FIG00983364 FIG00983365: hypothetical protein +FIG00983365 FIG00983366: hypothetical protein +FIG00983367 FIG00983368: hypothetical protein +FIG00983368 FIG00983369: hypothetical protein +FIG00983374 FIG00983375: hypothetical protein +FIG00983376 FIG00983378: hypothetical protein +FIG00983378 FIG00983379: hypothetical protein +FIG00983380 FIG00983381: hypothetical protein +FIG00983382 FIG00983383: hypothetical protein +FIG00983384 FIG00983385: hypothetical protein +FIG00983385 FIG00983391: hypothetical protein +FIG00983391 FIG00983392: hypothetical protein +FIG00983392 FIG00983393: hypothetical protein +FIG00983393 FIG00983394: hypothetical protein +FIG00983394 FIG00450046: hypothetical protein +FIG00983396 FIG00983397: hypothetical protein +FIG00983397 FIG00983398: hypothetical protein +FIG00983399 FIG00983401: hypothetical protein +FIG00983405 FIG00983406: hypothetical protein +FIG00983406 FIG00983407: hypothetical protein +FIG00983407 putative permease component of ABC transporter +FIG00983408 FIG00983409: hypothetical protein +FIG00983410 FIG00983411: hypothetical protein +FIG00983414 FIG00983415: hypothetical protein +FIG00983416 FIG00983417: hypothetical protein +FIG00983418 FIG00983419: hypothetical protein +FIG00983420 FIG00983423: hypothetical protein +FIG00983424 FIG00983425: hypothetical protein +FIG00983425 FIG00983426: hypothetical protein +FIG00983433 FIG00983435: hypothetical protein +FIG00983435 FIG00983437: hypothetical protein +FIG00983437 FIG00983438: hypothetical protein +FIG00983438 FIG00983439: hypothetical protein +FIG00983440 FIG00983441: hypothetical protein +FIG00983443 FIG00983444: hypothetical protein +FIG00983446 FIG00983448: hypothetical protein +FIG00983449 FIG01073876: hypothetical protein +FIG00983456 FIG00983457: hypothetical protein +FIG00983457 Mlr7795 protein +FIG00983461 FIG00983462: hypothetical protein +FIG00983462 COG1872 +FIG00983463 Trehalose utilization protein ThuA +FIG00983464 transcriptional regulator GntR +FIG00983465 FIG00983466: hypothetical protein +FIG00983467 FIG00983468: hypothetical protein +FIG00983469 FIG00983470: hypothetical protein +FIG00983470 FIG00983471: hypothetical protein +FIG00983472 putative MarR family transcriptional regulator +FIG00983476 FIG00983477: hypothetical protein +FIG00983479 putative DNA alkylation repair protein +FIG00983480 FIG00983482: hypothetical protein +FIG00983482 FIG01076037: hypothetical protein +FIG00983484 cell processes; transport of small molecules; amino acids, amines, peptides +FIG00983488 FIG00983489: hypothetical protein +FIG00983489 FIG00983492: hypothetical protein +FIG00983492 Mll3219 protein +FIG00983493 FIG00983494: hypothetical protein +FIG00983495 FIG00983496: hypothetical protein +FIG00983496 FIG00983498: hypothetical protein +FIG00983498 FIG00983500: hypothetical protein +FIG00983501 putative glutathione-dependent formaldehyde-activating enzyme +FIG00983502 putative GerE/LuxR family transcriptional regulator +FIG00983503 FIG00983504: hypothetical protein +FIG00983504 putative Rhizobium adhering protein +FIG00983505 FIG00983506: hypothetical protein +FIG00983507 FIG00983508: hypothetical protein +FIG00983508 FIG00983509: hypothetical protein +FIG00983514 FIG00992926: hypothetical protein +FIG00983516 FIG00983517: hypothetical protein +FIG00983517 FIG00983518: hypothetical protein +FIG00983519 FIG00983520: hypothetical protein +FIG00983520 putative transmembrane polysaccharide synthesis protein +FIG00983526 FIG00983529: hypothetical protein +FIG00983531 FIG00983532: hypothetical protein +FIG00983532 putative transmembrane permease component of ABC transporter +FIG00983533 putative FMN reductase +FIG00983536 putative two-component sensor histidine kinase +FIG00983537 putative exported peptidase +FIG00983539 FIG00983540: hypothetical protein +FIG00983540 putative transmembrane component of ABC transporter +FIG00983541 FIG00983542: hypothetical protein +FIG00983542 FIG00983544: hypothetical protein +FIG00983544 Uncharacterised protein family UPF0157 (COG2320) +FIG00983545 FIG00983546: hypothetical protein +FIG00983548 bll3975; hypothetical protein +FIG00983549 FIG00983890: hypothetical protein +FIG00983551 FIG00983552: hypothetical protein +FIG00983552 FIG00983553: hypothetical protein +FIG00983555 FIG00983556: hypothetical protein +FIG00983557 Mlr1575 protein +FIG00983558 FIG00983562: hypothetical protein +FIG00983563 FIG00983565: hypothetical protein +FIG00983565 MISCELLANEOUS; Not classified regulator +FIG00983570 FIG00983571: hypothetical protein +FIG00983573 FIG00983574: hypothetical protein +FIG00983574 FIG00983575: hypothetical protein +FIG00983576 putative LysR family transcriptional regulator +FIG00983580 FIG00983581: hypothetical protein +FIG00983582 FIG00983583: hypothetical protein +FIG00983587 Oligopeptide ABC transporter, permease protein +FIG00983590 FIG00983591: hypothetical protein +FIG00983591 putative trifolitoxin related protein +FIG00983592 FIG00983594: hypothetical protein +FIG00983594 FIG00983597: hypothetical protein +FIG00983597 FIG00983599: hypothetical protein +FIG00983602 FIG00983603: hypothetical protein +FIG00983603 FIG00983604: hypothetical protein +FIG00983604 FIG00983605: hypothetical protein +FIG00983605 FIG00983607: hypothetical protein +FIG00983609 FIG00983610: hypothetical protein +FIG00983610 FIG00983611: hypothetical protein +FIG00983611 FIG00983613: hypothetical protein +FIG00983617 FIG00983618: hypothetical protein +FIG00983619 ABC transporter sugar permease protein ycjO +FIG00983623 putative LuxR/GerE family transcriptional regulatory protein +FIG00983624 FIG00983625: hypothetical protein +FIG00983629 Atypical L-asparaginase (EC 3.5.1.1), Rhizobium type +FIG00983631 FIG00983632: hypothetical protein +FIG00983632 FIG00983634: hypothetical protein +FIG00983634 FIG00983635: hypothetical protein +FIG00983635 FIG00983636: hypothetical protein +FIG00983637 FIG00983638: hypothetical protein +FIG00983638 FIG00983639: hypothetical protein +FIG00983640 FIG00983641: hypothetical protein +FIG00983644 FIG00418427: hypothetical protein +FIG00983647 FIG00983648: hypothetical protein +FIG00983649 FIG00983650: hypothetical protein +FIG00983650 putative two-component response regulator protein +FIG00983651 FIG00983652: hypothetical protein +FIG00983653 FIG00983654: hypothetical protein +FIG00983654 Conjugal transfer protein TraH +FIG00983656 FIG00983657: hypothetical protein +FIG00983658 FIG00983661: hypothetical protein +FIG00983663 FIG00983665: hypothetical protein +FIG00983665 probable two-component response regulator protein +FIG00983671 FIG00983674: hypothetical protein +FIG00983674 FIG00983675: hypothetical protein +FIG00983675 FIG00794796: hypothetical protein +FIG00983676 FIG00983677: hypothetical protein +FIG00983677 FIG00983678: hypothetical protein +FIG00983678 FIG00983679: hypothetical protein +FIG00983679 FIG00983681: hypothetical protein +FIG00983681 putative ROK family transcriptional regulator +FIG00983682 FIG00983683: hypothetical protein +FIG00983683 FIG00983684: hypothetical protein +FIG00983685 putative two component response regulator transcriptional regulatory protein +FIG00983689 FIG00983690: hypothetical protein +FIG00983692 putative ABC transporter (fused ATP-binding and permease components) +FIG00983697 putative GerE family transcriptional regulator +FIG00983698 FIG00983699: hypothetical protein +FIG00983704 FIG00983706: hypothetical protein +FIG00983706 FIG00983707: hypothetical protein +FIG00983707 FIG00983708: hypothetical protein +FIG00983709 FIG00983710: hypothetical protein +FIG00983711 FIG00983712: hypothetical protein +FIG00983712 FIG00983714: hypothetical protein +FIG00983714 FIG00983715: hypothetical protein +FIG00983715 hypothetical transcription regulator +FIG00983722 FIG00983724: hypothetical protein +FIG00983724 Small Molecule Metabolism +FIG00983725 FIG01075721: hypothetical protein +FIG00983728 FIG00983729: hypothetical protein +FIG00983732 FIG00983733: hypothetical protein +FIG00983733 FIG00983734: hypothetical protein +FIG00983734 putative homocysteine S-methyltransferase( EC:2.1.1.10 ) +FIG00983737 FIG00983738: hypothetical protein +FIG00983738 FIG00983740: hypothetical protein +FIG00983740 FIG00983742: hypothetical protein +FIG00983743 gluconolactonase family protein +FIG00983744 FIG00983745: hypothetical protein +FIG00983749 FIG00983750: hypothetical protein +FIG00983750 putative haloacid dehydrogenase hydrolase +FIG00983752 FIG00983753: hypothetical protein +FIG00983753 FIG00983754: hypothetical protein +FIG00983755 FIG00983757: hypothetical protein +FIG00983759 FIG00983761: hypothetical protein +FIG00983761 Mlr7408 protein +FIG00983763 FIG00983764: hypothetical protein +FIG00983764 FIG00983765: hypothetical protein +FIG00983765 FIG00983767: hypothetical protein +FIG00983767 FIG00983769: hypothetical protein +FIG00983769 FIG00983770: hypothetical protein +FIG00983775 FIG00983777: hypothetical protein +FIG00983777 FIG00983778: hypothetical protein +FIG00983778 FIG00983779: hypothetical protein +FIG00983779 FIG00983780: hypothetical protein +FIG00983783 FIG00983784: hypothetical protein +FIG00983784 FIG00983785: hypothetical protein +FIG00983785 FIG00983787: hypothetical protein +FIG00983789 perosamine synthetase +FIG00983792 FIG00983793: hypothetical protein +FIG00983794 putative HlyD family secretion protein +FIG00983796 FIG00983797: hypothetical protein +FIG00983797 FIG00983798: hypothetical protein +FIG00983804 FIG00983806: hypothetical protein +FIG00983808 putative thioesterase protein +FIG00983809 FIG00983810: hypothetical protein +FIG00983812 FIG00983813: hypothetical protein +FIG00983815 glutaryl 7-ACA acylase precursor - Bacillus laterosporus +FIG00983816 FIG00983817: hypothetical protein +FIG00983817 FIG00983818: hypothetical protein +FIG00983819 putative antibiotic resistance protein +FIG00983821 FIG00983822: hypothetical protein +FIG00983826 FIG01076045: hypothetical protein +FIG00983827 FIG00983828: hypothetical protein +FIG00983828 TrbK +FIG00983829 FIG00983830: hypothetical protein +FIG00983834 FIG00983836: hypothetical protein +FIG00983836 FIG00983837: hypothetical protein +FIG00983837 FIG00983838: hypothetical protein +FIG00983839 putative cation/proton antiporter +FIG00983843 FIG00983844: hypothetical protein +FIG00983844 DinB superfamily +FIG00983845 FIG00983846: hypothetical protein +FIG00983846 AttS protein +FIG00983850 FIG00983851: hypothetical protein +FIG00983851 FIG00983852: hypothetical protein +FIG00983853 FIG00983854: hypothetical protein +FIG00983856 putative TetR family transcriptional regulator +FIG00983858 FIG00983859: hypothetical protein +FIG00983859 FIG00983861: hypothetical protein +FIG00983862 FIG00983863: hypothetical protein +FIG00983866 putative MarR family transcriptional regulatory protein +FIG00983870 FIG00983871: hypothetical protein +FIG00983871 FIG00983872: hypothetical protein +FIG00983872 Two-component system, response regulator +FIG00983891 FIG00983892: hypothetical protein +FIG00983894 FIG00450516: Zinc-finger domain protein +FIG00983899 FIG00983900: hypothetical protein +FIG00983902 FIG00983903: hypothetical protein +FIG00983904 N-acetyltransferase +FIG00983908 FIG00983909: hypothetical protein +FIG00983913 FIG00983914: hypothetical protein +FIG00983923 FIG00983924: hypothetical protein +FIG00983928 FIG00983930: hypothetical protein +FIG00983930 FIG00983931: hypothetical protein +FIG00983933 FIG00983934: hypothetical protein +FIG00983936 FIG00983937: hypothetical protein +FIG00983940 FIG00983942: hypothetical protein +FIG00983942 FIG00983945: hypothetical protein +FIG00983949 amino acid ABC transporter protein, permease protein +FIG00983950 FIG00983951: hypothetical protein +FIG00983951 FIG00983952: hypothetical protein +FIG00983954 FIG00983955: hypothetical protein +FIG00983956 FIG00983957: hypothetical protein +FIG00983958 putative oxidoreductase protein +FIG00983959 FIG00983960: hypothetical protein +FIG00983965 FIG00983966: hypothetical protein +FIG00983966 Ferric cations import ATP-binding protein fbpC (EC 3.6.3.30) +FIG00983967 FIG00363170: hypothetical protein +FIG00983973 FIG00983974: hypothetical protein +FIG00983974 FIG00983975: hypothetical protein +FIG00983975 probable transcriptional regulator protein +FIG00983983 putative two component sensor histidine kinase transcriptional regulatory protein +FIG00983990 FIG00983992: hypothetical protein +FIG00983994 FIG00983996: hypothetical protein +FIG00983996 putative exopolysaccharide biosynthesis protein +FIG00983998 FIG00983999: hypothetical protein +FIG00984000 FIG00984003: hypothetical protein +FIG00984003 FIG00984004: hypothetical protein +FIG00984005 FIG00984006: hypothetical protein +FIG00984006 probable oxidoreductase protein +FIG00984009 FIG00986617: hypothetical protein +FIG00984013 FIG00984014: hypothetical protein +FIG00984015 FIG00984016: hypothetical protein +FIG00984018 putative oligopeptide ABC transporter, permease protein +FIG00984019 FIG00984020: hypothetical protein +FIG00984020 FIG00984021: hypothetical protein +FIG00984022 FIG00984024: hypothetical protein +FIG00984024 FIG00984025: hypothetical protein +FIG00984029 FIG00984030: hypothetical protein +FIG00984031 FIG00984032: hypothetical protein +FIG00984033 FIG00984034: hypothetical protein +FIG00984034 FIG00984035: hypothetical protein +FIG00984035 probable transcriptional regulator protein, TetR family +FIG00984037 FIG00984038: hypothetical protein +FIG00984039 FIG00984040: hypothetical protein +FIG00984040 MocE-like protein +FIG00984045 FIG00984046: hypothetical protein +FIG00984047 FIG00984049: hypothetical protein +FIG00984049 FIG00984050: hypothetical protein +FIG00984054 Miscellaneous; Not classified regulator +FIG00984055 CONSERVED HYPOTHETICAL TRANSMEMBRANE PROTEIN +FIG00984056 FIG00984057: hypothetical protein +FIG00984057 FIG00984058: hypothetical protein +FIG00984059 FIG00984060: hypothetical protein +FIG00984061 FIG00984062: hypothetical protein +FIG00984062 FIG00984063: hypothetical protein +FIG00984064 putative MutT/NUDIX family ADP compounds hydrolase +FIG00984069 FIG00984070: hypothetical protein +FIG00984070 putative transmembrane exo/endo phosphatase protein +FIG00984071 FIG00984072: hypothetical protein +FIG00984076 FIG00984077: hypothetical protein +FIG00984078 FIG00984079: hypothetical protein +FIG00984079 FIG00984080: hypothetical protein +FIG00984086 FIG00984087: hypothetical protein +FIG00984091 FIG00984092: hypothetical protein +FIG00984092 FIG00984093: hypothetical protein +FIG00984093 putative transcriptional regulator protein +FIG00984094 FIG00984095: hypothetical protein +FIG00984098 FIG00984099: hypothetical protein +FIG00984099 FIG00984101: hypothetical protein +FIG00984101 FIG00984102: hypothetical protein +FIG00984102 FIG00984103: hypothetical protein +FIG00984103 FIG00984104: hypothetical protein +FIG00984104 FIG00984105: hypothetical protein +FIG00984108 FIG00984110: hypothetical protein +FIG00984110 FIG00984111: hypothetical protein +FIG00984111 Dihydroxyacetone ABC transport system, permease protein +FIG00984114 FIG00984115: hypothetical protein +FIG00984115 FIG00984117: hypothetical protein +FIG00984117 FIG00984118: hypothetical protein +FIG00984120 FIG00984121: hypothetical protein +FIG00984123 FIG00984124: hypothetical protein +FIG00984126 FIG00984127: hypothetical protein +FIG00984128 FIG00984129: hypothetical protein +FIG00984132 FIG00984133: hypothetical protein +FIG00984135 FIG00984136: hypothetical protein +FIG00984136 Msl4947 protein +FIG00984140 FIG00984141: hypothetical protein +FIG00984141 FIG00984142: hypothetical protein +FIG00984143 FIG00984144: hypothetical protein +FIG00984144 FIG00984145: hypothetical protein +FIG00984146 FIG00984147: hypothetical protein +FIG00984150 FIG00984151: hypothetical protein +FIG00984151 ABC transport system, sugar-binding protein +FIG00984153 FIG00984154: hypothetical protein +FIG00984155 FIG00984156: hypothetical protein +FIG00984156 Hydrolase, haloacid dehalogenase-like family +FIG00984163 FIG00984164: hypothetical protein +FIG00984165 probable transcriptional regulator protein, LuxR family +FIG00984168 periplasmic ribose-binding protein, sugar ABC transporter +FIG00984172 FIG00984173: hypothetical protein +FIG00984173 FIG00984174: hypothetical protein +FIG00984174 FIG00984176: hypothetical protein +FIG00984177 Mlr7505 protein +FIG00984178 putative transmembrane transglycosylase-associated protein +FIG00984179 Uncharacterised protein family UPF0157 (COG2320) +FIG00984180 FIG00984181: hypothetical protein +FIG00984181 ABC branched-chain amino acid transporter, permease component +FIG00984186 FIG00984188: hypothetical protein +FIG00984189 FIG00984190: hypothetical protein +FIG00984190 FIG00984191: hypothetical protein +FIG00984192 FIG00984193: hypothetical protein +FIG00984193 FIG00984194: hypothetical protein +FIG00984194 FIG00984195: hypothetical protein +FIG00984195 Dihydroxyacetone ABC transport system, substrate-binding protein +FIG00984201 3-DEMETHYLUBIQUINONE-9 3-METHYLTRANSFERASE +FIG00984202 FIG00984203: hypothetical protein +FIG00984206 FIG00984207: hypothetical protein +FIG00984209 putative ATP-binding ABC transporter component +FIG00984210 FIG00984211: hypothetical protein +FIG00984219 FIG00984220: hypothetical protein +FIG00984222 FIG00984223: hypothetical protein +FIG00984223 FIG00984225: hypothetical protein +FIG00984225 FIG00984226: hypothetical protein +FIG00984226 FIG00984227: hypothetical protein +FIG00984227 putative sugar ABC transporter, permease protein +FIG00984230 FIG00984231: hypothetical protein +FIG00984231 FIG00984232: hypothetical protein +FIG00984232 putative molecular chaperone, DnaJ family +FIG00984237 FIG00984238: hypothetical protein +FIG00984238 FIG00984239: hypothetical protein +FIG00984239 FIG00984240: hypothetical protein +FIG00984241 FIG00984242: hypothetical protein +FIG00984242 FIG00984243: hypothetical protein +FIG00984245 FIG00984246: hypothetical protein +FIG00984247 probable octopine ABC transporter, substrate-binding protein +FIG00984248 FIG00984249: hypothetical protein +FIG00984250 FIG00984251: hypothetical protein +FIG00984251 putative sugar ABC transporter, substrate-binding protein +FIG00984252 FIG00984253: hypothetical protein +FIG00984253 FIG00984254: hypothetical protein +FIG00984254 FIG00984255: hypothetical protein +FIG00984256 FIG00984257: hypothetical protein +FIG00984257 FIG00984258: hypothetical protein +FIG00984260 FIG00984261: hypothetical protein +FIG00984261 FIG00984262: hypothetical protein +FIG00984263 ABC transport system, sugar-binding protein +FIG00984265 FIG00984266: hypothetical protein +FIG00984266 Protease inhibitor Inh +FIG00984268 FIG00984270: hypothetical protein +FIG00984272 FIG00984275: hypothetical protein +FIG00984275 FIG00984276: hypothetical protein +FIG00984276 FIG00984278: hypothetical protein +FIG00984280 FIG00984281: hypothetical protein +FIG00984281 FIG00984282: hypothetical protein +FIG00984282 FIG00984286: hypothetical protein +FIG00984286 probable chloranphenicol phosphotransferase protein +FIG00984289 FIG00984290: hypothetical protein +FIG00984290 FIG00984293: hypothetical protein +FIG00984293 Multidrug efflux transcriptional regulator protein, TetR family +FIG00984295 FIG00984296: hypothetical protein +FIG00984296 probable sugar transporter, permease protein +FIG00984297 FIG00984298: hypothetical protein +FIG00984301 FIG00984302: hypothetical protein +FIG00984302 FIG00984303: hypothetical protein +FIG00984304 FIG00984305: hypothetical protein +FIG00984307 PHOSPHOGLYCOLATE PHOSPHATASE (EC 3.1.3.18) +FIG00984308 FIG00984310: hypothetical protein +FIG00984311 FIG00984312: hypothetical protein +FIG00984314 putative ABC transporter oligopeptide-binding protein +FIG00984317 FIG00984318: hypothetical protein +FIG00984318 FIG00984319: hypothetical protein +FIG00984319 FIG00984320: hypothetical protein +FIG00984320 FIG00984321: hypothetical protein +FIG00984321 FIG00984322: hypothetical protein +FIG00984323 FIG00984325: hypothetical protein +FIG00984325 FIG00984326: hypothetical protein +FIG00984327 Putrescine transport system permease protein potI +FIG00984330 FIG00984331: hypothetical protein +FIG00984332 FIG00984333: hypothetical protein +FIG00984335 putative pilus assembly protein +FIG00984336 FIG00984338: hypothetical protein +FIG00984338 FIG00984339: hypothetical protein +FIG00984339 FIG00984340: hypothetical protein +FIG00984340 FIG00984342: hypothetical protein +FIG00984342 putative transmembrane component of transporter +FIG00984347 FIG00984348: hypothetical protein +FIG00984352 PssV +FIG00984355 PUTATIVE OXIDOREDUCTASE PROTEIN +FIG00984356 FIG00984357: hypothetical protein +FIG00984357 FIG00984358: hypothetical protein +FIG00984359 putative transcriptional regulator, araC family protein +FIG00984361 putative stress-induced protein +FIG00984362 probable translocation protein involved in type-III secretion process; HrcQ homolog +FIG00984364 FIG00984365: hypothetical protein +FIG00984367 FIG00450953: hypothetical protein +FIG00984372 Glycoside Hydrolase family 5 +FIG00984374 FIG00984375: hypothetical protein +FIG00984376 FIG00984377: hypothetical protein +FIG00984379 FIG00984380: hypothetical protein +FIG00984380 FIG00984381: hypothetical protein +FIG00984381 Uncharacterized siderophore transporter, substrate-binding protein +FIG00984385 FIG00984386: hypothetical protein +FIG00984386 FIG00984387: hypothetical protein +FIG00984388 FIG00984389: hypothetical protein +FIG00984391 FIG00984392: hypothetical protein +FIG00984395 FIG00027233: possible membrane protein +FIG00984396 FIG00984399: hypothetical protein +FIG00984403 FIG00984405: hypothetical protein +FIG00984406 FIG00984407: hypothetical protein +FIG00984408 FIG00984409: hypothetical protein +FIG00984410 FIG00984411: hypothetical protein +FIG00984412 Cytochrome c-556 +FIG00984416 FIG00984417: hypothetical protein +FIG00984418 FIG00984420: hypothetical protein +FIG00984420 FIG00984421: hypothetical protein +FIG00984423 Mll7507 protein +FIG00984429 FIG00984430: hypothetical protein +FIG00984430 FIG00984431: hypothetical protein +FIG00984431 FIG00984432: hypothetical protein +FIG00984432 FIG00984433: hypothetical protein +FIG00984433 FIG00984434: hypothetical protein +FIG00984435 FIG00984438: hypothetical protein +FIG00984440 FIG00984441: hypothetical protein +FIG00984441 FIG00984442: hypothetical protein +FIG00984442 FIG00984443: hypothetical protein +FIG00984445 FIG00984446: hypothetical protein +FIG00984446 FIG00984447: hypothetical protein +FIG00984447 FIG00984449: hypothetical protein +FIG00984451 FIG00984452: hypothetical protein +FIG00984457 FIG00984459: hypothetical protein +FIG00984461 FIG00984462: hypothetical protein +FIG00984462 FIG00984463: hypothetical protein +FIG00984463 FIG00984464: hypothetical protein +FIG00984464 FIG00984465: hypothetical protein +FIG00984465 FIG00984470: hypothetical protein +FIG00984470 FIG00984471: hypothetical protein +FIG00984471 Miscellaneous; Unknown +FIG00984472 FIG00984473: hypothetical protein +FIG00984473 FIG00984475: hypothetical protein +FIG00984475 FIG00984476: hypothetical protein +FIG00984476 probable amino acid ABC transporter, permease protein +FIG00984479 SUCCINOGLYCAN BIOSYNTHESIS PROTEIN EXOI +FIG00984481 putative FNR family transcriptional regulator +FIG00984482 FIG00984483: hypothetical protein +FIG00984483 FIG00984484: hypothetical protein +FIG00984486 putative helix-turn-helix transcriptional regulatory protein +FIG00984488 FIG00984489: hypothetical protein +FIG00984492 FIG00984493: hypothetical protein +FIG00984496 FIG00984497: hypothetical protein +FIG00984497 FIG00984498: hypothetical protein +FIG00984498 FIG00984500: hypothetical protein +FIG00984500 vicibactin acetylase protein +FIG00984501 FIG00984502: hypothetical protein +FIG00984504 putative acyltransferase protein +FIG00984505 probable ferrichrome ABC transporter, substrate-binding protein +FIG00984506 FIG00984507: hypothetical protein +FIG00984510 radical SAM/B12 binding domain protein +FIG00984512 FIG00450156: hypothetical protein +FIG00984517 FIG00984518: hypothetical protein +FIG00984518 FIG00984519: hypothetical protein +FIG00984519 FIG00984521: hypothetical protein +FIG00984522 FIG00984523: hypothetical protein +FIG00984525 FIG00984527: hypothetical protein +FIG00984527 FIG00984528: hypothetical protein +FIG00984528 FIG00984529: hypothetical protein +FIG00984529 FIG00984530: hypothetical protein +FIG00984530 FIG00984531: hypothetical protein +FIG00984531 ABC transport system, sugar-binding protein +FIG00984534 FIG00984536: hypothetical protein +FIG00984536 FIG00984537: hypothetical protein +FIG00984537 probable transcriptional regulator protein, MarR family +FIG00984539 Glutamine amidotransferase class-I +FIG00984540 FIG00984541: hypothetical protein +FIG00984541 FIG00984543: hypothetical protein +FIG00984543 ABC-type arginine/histidine transport system, permease component +FIG00984546 FIG00984547: hypothetical protein +FIG00984550 FIG00984551: hypothetical protein +FIG00984552 FIG00984553: hypothetical protein +FIG00984557 FIG00984559: hypothetical protein +FIG00984559 FIG00984560: hypothetical protein +FIG00984560 FIG00984561: hypothetical protein +FIG00984562 FIG00984563: hypothetical protein +FIG00984563 FIG00984564: hypothetical protein +FIG00984564 FIG00984565: hypothetical protein +FIG00984565 GLYCINE BETAINE-BINDING PROTEIN +FIG00984567 putative transmembrane succinoglycan biosynthesis transport protein +FIG00984572 FIG00984574: hypothetical protein +FIG00984574 conujugal transfer protein TraA +FIG00984576 FIG00984577: hypothetical protein +FIG00984578 FIG00984579: hypothetical protein +FIG00984579 FIG00984580: hypothetical protein +FIG00984581 FIG00984582: hypothetical protein +FIG00984582 FIG00984583: hypothetical protein +FIG00984586 FIG00984587: hypothetical protein +FIG00984587 FIG00984588: hypothetical protein +FIG00984589 FIG00984590: hypothetical protein +FIG00984590 FIG01075524: hypothetical protein +FIG00984593 FIG00984594: hypothetical protein +FIG00984595 FIG00984596: hypothetical protein +FIG00984597 FIG00984598: hypothetical protein +FIG00984598 FIG00984599: hypothetical protein +FIG00984599 FIG00984600: hypothetical protein +FIG00984600 FIG00984601: hypothetical protein +FIG00984601 FIG00984603: hypothetical protein +FIG00984603 FIG00984604: hypothetical protein +FIG00984604 Putative reductase +FIG00984606 FIG00984608: hypothetical protein +FIG00984608 FIG00984609: hypothetical protein +FIG00984609 FIG00984610: hypothetical protein +FIG00984610 FIG00984612: hypothetical protein +FIG00984613 LacI-type transcriptional regulator +FIG00984614 FIG00984615: hypothetical protein +FIG00984616 FIG00984617: hypothetical protein +FIG00984617 FIG00984618: hypothetical protein +FIG00984619 FIG00984620: hypothetical protein +FIG00984620 putative methyltransferase protein +FIG00984625 FIG00984626: hypothetical protein +FIG00984626 FIG00984627: hypothetical protein +FIG00984628 FIG00984631: hypothetical protein +FIG00984631 two-component response regulator protein +FIG00984632 FIG00984633: hypothetical protein +FIG00984633 conserved hypothetical ErfK/YbiS/YhnG family protein +FIG00984634 FIG00984635: hypothetical protein +FIG00984636 FIG00984637: hypothetical protein +FIG00984638 FIG00984639: hypothetical protein +FIG00984639 FIG00984640: hypothetical protein +FIG00984640 FIG00984641: hypothetical protein +FIG00984641 FIG00984643: hypothetical protein +FIG00984647 FIG00984648: hypothetical protein +FIG00984648 FIG00984649: hypothetical protein +FIG00984650 TRANSPORTER, MFS superfamily +FIG00984651 FIG00984653: hypothetical protein +FIG00984653 FIG006231: RNA-binding protein +FIG00984654 FIG00984656: hypothetical protein +FIG00984662 Conjugal transfer protein TraF +FIG00984663 FIG00984665: hypothetical protein +FIG00984667 FIG00984671: hypothetical protein +FIG00984675 FIG00450700: hypothetical protein +FIG00984687 FIG00984688: hypothetical protein +FIG00984688 FIG00984690: hypothetical protein +FIG00984696 FIG01075715: hypothetical protein +FIG00984697 putative LacI family transcriptional regulator +FIG00984698 FIG00984699: hypothetical protein +FIG00984699 FIG00984701: hypothetical protein +FIG00984708 FIG00984710: hypothetical protein +FIG00984710 FIG00984711: hypothetical protein +FIG00984712 FIG00984713: hypothetical protein +FIG00984716 FIG00984719: hypothetical protein +FIG00984719 FIG00984720: hypothetical protein +FIG00984721 FIG00984722: hypothetical protein +FIG00984722 C4-dicarboxylate transport transcriptional regulatory protein dctD +FIG00984723 FIG00984727: hypothetical protein +FIG00984727 FIG00984731: hypothetical protein +FIG00984732 FIG00984733: hypothetical protein +FIG00984733 FIG00984734: hypothetical protein +FIG00984736 Conjugal transfer protein traG +FIG00984737 FIG00984738: hypothetical protein +FIG00984740 FIG00984741: hypothetical protein +FIG00984741 FIG00984742: hypothetical protein +FIG00984742 FIG00984743: hypothetical protein +FIG00984743 putative cell wall-associated hydrolase protein +FIG00984744 FIG00984746: hypothetical protein +FIG00984746 FIG00984748: hypothetical protein +FIG00984759 acetyltransferase protein +FIG00984763 FIG00984765: hypothetical protein +FIG00984765 MFS permease +FIG00984766 FIG00984767: hypothetical protein +FIG00984770 FIG00984772: hypothetical protein +FIG00984775 FIG00984777: hypothetical protein +FIG00984780 FIG00984782: hypothetical protein +FIG00984782 FIG00984783: hypothetical protein +FIG00984783 FIG00984784: hypothetical protein +FIG00984784 FIG00984785: hypothetical protein +FIG00984785 FIG00984786: hypothetical protein +FIG00984786 FIG00984787: hypothetical protein +FIG00984787 FIG00984789: hypothetical protein +FIG00984789 FIG00984790: hypothetical protein +FIG00984792 PssE +FIG00984793 FIG00984794: hypothetical protein +FIG00984798 FIG00984799: hypothetical protein +FIG00984799 FIG00984800: hypothetical protein +FIG00984800 FIG00984803: hypothetical protein +FIG00984803 FIG00984805: hypothetical protein +FIG00984806 FIG00984807: hypothetical protein +FIG00984809 FIG00984810: hypothetical protein +FIG00984811 FIG00984812: hypothetical protein +FIG00984815 FIG00984816: hypothetical protein +FIG00984816 FIG00984817: hypothetical protein +FIG00984819 putative HTH-type transcriptional regulator +FIG00984822 FIG00984823: hypothetical protein +FIG00984823 FIG00984824: hypothetical protein +FIG00984824 FIG00984825: hypothetical protein +FIG00984825 TRANSCRIPTIONAL REGULATOR +FIG00984827 FIG00984829: hypothetical protein +FIG00984830 FIG00984831: hypothetical protein +FIG00984832 VapC toxin protein antagonist +FIG00984833 FIG00984834: hypothetical protein +FIG00984836 FIG00984837: hypothetical protein +FIG00984837 putative GntR family transcriptional regulator +FIG00984841 putative phosphatase protein +FIG00984844 FIG00984845: hypothetical protein +FIG00984847 glutamine amidotransferase (GATase1) domain / RidA/YER057c/UK114 superfamily, group 1 +FIG00984848 FIG00984849: hypothetical protein +FIG00984849 FIG00984851: hypothetical protein +FIG00984853 FIG00984854: hypothetical protein +FIG00984854 FIG00984855: hypothetical protein +FIG00984858 FIG00984859: hypothetical protein +FIG00984861 probable aliphatic sulphonate ABC transporter, substrate-binding protein +FIG00984862 FIG00984865: hypothetical protein +FIG00984865 FIG00984868: hypothetical protein +FIG00984872 FIG00984873: hypothetical protein +FIG00984873 FIG00984875: hypothetical protein +FIG00984883 FIG00984884: hypothetical protein +FIG00984884 FIG00984885: hypothetical protein +FIG00984885 Erwinia chrysanthemi phospholipase C (plcA) +FIG00984887 Mlr0671 protein +FIG00984890 ABC transporter, periplasmic spermidine putrescine-binding protein potD +FIG00984892 FIG00984893: hypothetical protein +FIG00984894 FIG00984897: hypothetical protein +FIG00984901 FIG00984902: hypothetical protein +FIG00984904 sugar ABC transporter, permease protein +FIG00984905 FIG00984906: hypothetical protein +FIG00984908 putative HlyD family transmembrane efflux protein +FIG00984909 FIG00984910: hypothetical protein +FIG00984912 putative transmembrane sortase-like protein +FIG00984913 FIG00984914: hypothetical protein +FIG00984914 FIG00984916: hypothetical protein +FIG00984916 FIG00984917: hypothetical protein +FIG00984920 FIG00984921: hypothetical protein +FIG00984927 FIG00984928: hypothetical protein +FIG00984928 FIG00984929: hypothetical protein +FIG00984929 probable amino acid ABC transporter, substrate-binding protein +FIG00984931 FIG00984932: hypothetical protein +FIG00984938 FIG00984939: hypothetical protein +FIG00984939 NAD(P)H dehydrogenase [quinone] 1 (EC 1.6.5.2) +FIG00984940 FIG00984941: hypothetical protein +FIG00984943 FIG00984945: hypothetical protein +FIG00984945 FIG00984946: hypothetical protein +FIG00984948 FIG00984951: hypothetical protein +FIG00984951 FIG00984953: hypothetical protein +FIG00984954 putative pilus component protein +FIG00984956 FIG00984957: hypothetical protein +FIG00984957 FIG00984959: hypothetical protein +FIG00984959 FIG00984960: hypothetical protein +FIG00984960 putative transmembrane nitrile hydratase +FIG00984961 putative polysaccharide transport outer membrane protein +FIG00984964 FIG00984966: hypothetical protein +FIG00984966 putative dehydrogenase/oxidoreductase +FIG00984968 FIG00984969: hypothetical protein +FIG00984969 FIG00984970: hypothetical protein +FIG00984970 Magnesium and cobalt transport protein CorA +FIG00984972 FIG00984973: hypothetical protein +FIG00984973 FIG00984976: hypothetical protein +FIG00984976 FIG00984978: hypothetical protein +FIG00984978 FIG00984980: hypothetical protein +FIG00984980 Tellurium resistance protein terC +FIG00984985 putative PspA family regulator +FIG00984987 FIG00984989: hypothetical protein +FIG00984989 FIG00984990: hypothetical protein +FIG00984990 putative AHL-dependent transcriptional regulator +FIG00984992 FIG00986070: hypothetical protein +FIG00984994 FIG00984995: hypothetical protein +FIG00984995 FIG00984997: hypothetical protein +FIG00984997 FIG00984998: hypothetical protein +FIG00985009 FIG00985010: hypothetical protein +FIG00985010 FIG00985011: hypothetical protein +FIG00985013 FIG00985014: hypothetical protein +FIG00985014 N-acyl-L-homoserine lactone (AHL) synthase protein +FIG00985016 putative MipA family outer membrane scaffold protein +FIG00985019 FIG00985020: hypothetical protein +FIG00985024 FIG00985025: hypothetical protein +FIG00985025 FIG00985026: hypothetical protein +FIG00985026 FIG00985027: hypothetical protein +FIG00985027 FIG00985030: hypothetical protein +FIG00985030 FIG00985031: hypothetical protein +FIG00985031 FIG00985033: hypothetical protein +FIG00985033 FIG00985034: hypothetical protein +FIG00985034 FIG00985035: hypothetical protein +FIG00985036 FIG00985037: hypothetical protein +FIG00985037 BICYCLOMYCIN RESISTANCE PROTEIN +FIG00985038 FIG00985039: hypothetical protein +FIG00985041 FIG00985042: hypothetical protein +FIG00985047 putative enoyl-CoA hydratase protein +FIG00985050 FIG00985051: hypothetical protein +FIG00985062 FIG00985064: hypothetical protein +FIG00985064 FIG00985065: hypothetical protein +FIG00985066 FIG00985069: hypothetical protein +FIG00985070 FIG00985072: hypothetical protein +FIG00985072 FIG00985073: hypothetical protein +FIG00985075 FIG00985076: hypothetical protein +FIG00985076 FIG00985077: hypothetical protein +FIG00985077 FIG00985080: hypothetical protein +FIG00985082 FIG00985083: hypothetical protein +FIG00985083 FIG00985085: hypothetical protein +FIG00985089 FIG00985090: hypothetical protein +FIG00985090 FIG00985091: hypothetical protein +FIG00985091 FIG00985092: hypothetical protein +FIG00985092 FIG00985093: hypothetical protein +FIG00985093 FIG00985095: hypothetical protein +FIG00985095 FIG00985096: hypothetical protein +FIG00985097 major virion structural protein +FIG00985098 FIG00985099: hypothetical protein +FIG00985102 FIG00985104: hypothetical protein +FIG00985104 FIG00985106: hypothetical protein +FIG00985106 FIG00985107: hypothetical protein +FIG00985107 FIG00985108: hypothetical protein +FIG00985108 FIG00985109: hypothetical protein +FIG00985109 FIG00985110: hypothetical protein +FIG00985110 FIG00985112: hypothetical protein +FIG00985112 probable tautomerase +FIG00985113 FIG00985114: hypothetical protein +FIG00985115 FIG00985116: hypothetical protein +FIG00985116 FIG00985117: hypothetical protein +FIG00985117 FIG00985118: hypothetical protein +FIG00985125 FIG00985126: hypothetical protein +FIG00985126 Maleylacetate reductase (EC 1.3.1.32) +FIG00985127 FIG00985128: hypothetical protein +FIG00985130 FIG00985131: hypothetical protein +FIG00985131 FIG00985132: hypothetical protein +FIG00985134 FIG00985137: hypothetical protein +FIG00985137 FIG00985138: hypothetical protein +FIG00985138 putative GFO/IDH/MocA family oxidoreductase +FIG00985139 FIG00985140: hypothetical protein +FIG00985142 FIG00985144: hypothetical protein +FIG00985144 FIG00985145: hypothetical protein +FIG00985148 putative cytochrome c oxidase, subunit I +FIG00985152 FIG00985153: hypothetical protein +FIG00985153 FIG00985154: hypothetical protein +FIG00985154 FIG00985155: hypothetical protein +FIG00985155 Macromolecule metabolism; Macromolecule degradation +FIG00985157 probable molecular chaperone small heat shock protein, hsp20 family +FIG00985164 fucose dissimilation pathway protein +FIG00985168 FIG00985169: hypothetical protein +FIG00985169 putative glucoamylase protein( EC:3.2.1.3 ) +FIG00985172 FIG00985173: hypothetical protein +FIG00985183 FIG00985184: hypothetical protein +FIG00985188 FIG00985189: hypothetical protein +FIG00985189 FIG00985190: hypothetical protein +FIG00985192 FIG00985195: hypothetical protein +FIG00985195 FIG00985196: hypothetical protein +FIG00985196 FIG00985200: hypothetical protein +FIG00985201 FIG00985202: hypothetical protein +FIG00985202 FIG00985203: hypothetical protein +FIG00985211 FIG00985212: hypothetical protein +FIG00985212 Lipid A glucosamine oxidase +FIG00985215 putative AraC/XylS family transcriptional regulator +FIG00985217 FIG00985218: hypothetical protein +FIG00985221 FIG00985222: hypothetical protein +FIG00985223 Acetylornithine deacetylase/Succinyl-diaminopimelate desuccinylase and related deacylases +FIG00985228 FIG00985229: hypothetical protein +FIG00985230 FIG00985232: hypothetical protein +FIG00985232 protocatechuate 3,4-dioxygenase beta chain (3,4-pcd)( EC:1.13.11.3 ) +FIG00985233 FIG00985234: hypothetical protein +FIG00985235 putative metalloprotease inhibitor (transcriptional regulator) protein +FIG00985236 FIG00985237: hypothetical protein +FIG00985239 FIG00985240: hypothetical protein +FIG00985242 FIG00985243: hypothetical protein +FIG00985243 FIG00985244: hypothetical protein +FIG00985244 FIG00985245: hypothetical protein +FIG00985246 FIG00985247: hypothetical protein +FIG00985247 FIG00985249: hypothetical protein +FIG00985249 FIG00985250: hypothetical protein +FIG00985250 FIG00985251: hypothetical protein +FIG00985252 FIG00985254: hypothetical protein +FIG00985254 FIG00985255: hypothetical protein +FIG00985257 FIG00985258: hypothetical protein +FIG00985258 Mll2569 protein +FIG00985259 FIG00985260: hypothetical protein +FIG00985260 FIG00985261: hypothetical protein +FIG00985264 D-serine deaminase (EC 4.3.1.18) +FIG00985266 putative nodulation protein X (probable sugar acetylase) +FIG00985269 FIG00985270: hypothetical protein +FIG00985273 FIG00985275: hypothetical protein +FIG00985277 FIG00985278: hypothetical protein +FIG00985280 HSCARG protein +FIG00985282 FIG00985283: hypothetical protein +FIG00985284 FIG00985286: hypothetical protein +FIG00985286 FIG00985288: hypothetical protein +FIG00985289 putative ABC transporter substrate-binding protein +FIG00985293 FIG01073998: hypothetical protein +FIG00985294 FIG00985296: hypothetical protein +FIG00985296 FIG00985298: hypothetical protein +FIG00985298 FIG00985299: hypothetical protein +FIG00985299 FIG00985300: hypothetical protein +FIG00985300 FIG00985301: hypothetical protein +FIG00985306 CheX protein +FIG00985308 hypothetical conserved membrane protein +FIG00985309 N-methyl transferase nodS +FIG00985312 probable acetyltransferase protein +FIG00985315 FIG00985316: hypothetical protein +FIG00985319 FIG00985320: hypothetical protein +FIG00985323 FIG00985324: hypothetical protein +FIG00985324 FIG00985325: hypothetical protein +FIG00985327 FIG00985329: hypothetical protein +FIG00985329 FIG00985330: hypothetical protein +FIG00985332 FIG00985335: hypothetical protein +FIG00985336 FIG00985337: hypothetical protein +FIG00985337 glycosyltransferase protein +FIG00985348 FIG00985349: hypothetical protein +FIG00985351 FIG00985352: hypothetical protein +FIG00985352 FIG00985354: hypothetical protein +FIG00985354 FIG00985355: hypothetical protein +FIG00985357 FIG00985358: hypothetical protein +FIG00985358 FIG00985359: hypothetical protein +FIG00985359 FIG00985360: hypothetical protein +FIG00985362 FIG00985363: hypothetical protein +FIG00985363 FIG00985364: hypothetical protein +FIG00985364 FIG00985365: hypothetical protein +FIG00985365 FIG00985368: hypothetical protein +FIG00985368 alanine-rich protein SCI7.12c +FIG00985369 FIG00985370: hypothetical protein +FIG00985371 FIG00985372: hypothetical protein +FIG00985372 FIG00985373: hypothetical protein +FIG00985375 FIG00985377: hypothetical protein +FIG00985377 FIG00985381: hypothetical protein +FIG00985383 FIG00985384: hypothetical protein +FIG00985387 putative polysaccharidase +FIG00985389 Phosphotriesterase related protein +FIG00985394 FIG00985395: hypothetical protein +FIG00985396 FIG00985398: hypothetical protein +FIG00985399 FIG00985400: hypothetical protein +FIG00985400 FIG00985401: hypothetical protein +FIG00985404 FIG00985405: hypothetical protein +FIG00985405 FIG00985406: hypothetical protein +FIG00985410 FIG00985411: hypothetical protein +FIG00985414 FIG00792295: hypothetical protein +FIG00985416 FIG00985417: hypothetical protein +FIG00985417 RidA/YER057c/UK114 superfamily, group 7, YjgH-like protein +FIG00985418 Bona fide RidA/YjgF/TdcF/RutC subgroup +FIG00985420 FIG00985421: hypothetical protein +FIG00985425 FIG00985426: hypothetical protein +FIG00985426 FIG00985427: hypothetical protein +FIG00985428 FIG00985430: hypothetical protein +FIG00985430 FIG00985431: hypothetical protein +FIG00985431 Fucose operon fucU protein +FIG00985432 FIG00985436: hypothetical protein +FIG00985438 putative acetyltransferase protein +FIG00985439 FIG00985440: hypothetical protein +FIG00985441 FIG00985442: hypothetical protein +FIG00985442 FIG00985443: hypothetical protein +FIG00985443 FIG00985444: hypothetical protein +FIG00985445 FIG00985446: hypothetical protein +FIG00985446 FIG00985447: hypothetical protein +FIG00985447 FIG00985449: hypothetical protein +FIG00985449 allophanate hydrolase +FIG00985450 FIG00985453: hypothetical protein +FIG00985456 FIG00985457: hypothetical protein +FIG00985457 FIG00985458: hypothetical protein +FIG00985458 FIG00985459: hypothetical protein +FIG00985460 Bacterial regulatory protein LysR, HTH motif:LysR substrate binding domain +FIG00985461 FIG00985462: hypothetical protein +FIG00985462 FIG00985463: hypothetical protein +FIG00985465 FIG00985467: hypothetical protein +FIG00985467 FIG00985468: hypothetical protein +FIG00985468 FIG00985469: hypothetical protein +FIG00985469 HYPOTHETICAL TRANSMEMBRANE SIGNAL PEPTIDE PROTEIN +FIG00985474 FIG00985475: hypothetical protein +FIG00985475 probable alkaline protease secretion ATP-binding protein +FIG00985478 FIG00985479: hypothetical protein +FIG00985479 FIG00985480: hypothetical protein +FIG00985483 FIG00985486: hypothetical protein +FIG00985498 FIG00985499: hypothetical protein +FIG00985501 FIG00985502: hypothetical protein +FIG00985502 FIG00985503: hypothetical protein +FIG00985503 FIG00985505: hypothetical protein +FIG00985505 FIG00985506: hypothetical protein +FIG00985506 FIG00985507: hypothetical protein +FIG00985508 FIG00985509: hypothetical protein +FIG00985512 FIG00985513: hypothetical protein +FIG00985513 endo-1,3-1,4-beta-glycanase protein +FIG00985514 FIG00985515: hypothetical protein +FIG00985515 FIG00985516: hypothetical protein +FIG00985516 Bsr8028 protein +FIG00985525 FIG00985526: hypothetical protein +FIG00985526 FIG00985527: hypothetical protein +FIG00985527 FIG00985528: hypothetical protein +FIG00985528 sugar binding protein of sugar ABC transporter +FIG00985529 FIG00985530: hypothetical protein +FIG00985533 Glutamine transport system permease protein glnP +FIG00985535 Flavin dependant oxidoreductase +FIG00985536 FIG00985537: hypothetical protein +FIG00985537 sugar ABC transporter, permease protein +FIG00985540 FIG00985541: hypothetical protein +FIG00985541 FIG00985542: hypothetical protein +FIG00985545 FIG00985546: hypothetical protein +FIG00985550 FIG00985551: hypothetical protein +FIG00985551 FIG00985553: hypothetical protein +FIG00985553 FIG00985554: hypothetical protein +FIG00985556 FIG00985559: hypothetical protein +FIG00985563 FIG00985564: hypothetical protein +FIG00985565 FIG00985566: hypothetical protein +FIG00985566 FIG00985568: hypothetical protein +FIG00985568 FIG00985569: hypothetical protein +FIG00985569 FIG00985571: hypothetical protein +FIG00985573 FIG00985574: hypothetical protein +FIG00985574 putative amicyanin protein +FIG00985576 FIG00985578: hypothetical protein +FIG00985580 FIG00985581: hypothetical protein +FIG00985582 FIG00985583: hypothetical protein +FIG00985583 FIG00985584: hypothetical protein +FIG00985585 FIG00985587: hypothetical protein +FIG00985587 FIG00985588: hypothetical protein +FIG00985589 FIG00985590: hypothetical protein +FIG00985590 FIG00985591: hypothetical protein +FIG00985591 FIG00985592: hypothetical protein +FIG00985592 FIG00985593: hypothetical protein +FIG00985595 FIG00985596: hypothetical protein +FIG00985601 FIG00985602: hypothetical protein +FIG00985603 UPF0391 membrane protein Atu4467 1 +FIG00985605 Autoaggregation protein Rap1A +FIG00985607 putative response regulator protein +FIG00985613 FIG00985616: hypothetical protein +FIG00985620 FIG00985622: hypothetical protein +FIG00985622 FIG00985623: hypothetical protein +FIG00985623 FIG00985625: hypothetical protein +FIG00985625 FIG00985627: hypothetical protein +FIG00985627 FIG00985629: hypothetical protein +FIG00985629 probable transcriptional regulator protein, LacI family +FIG00985635 putative solute-binding component of ABC transporter +FIG00985644 probable oxidoreducatse protein +FIG00985645 FIG00985646: hypothetical protein +FIG00985652 putative arginase family protein( EC:3.5.3.22 ) +FIG00985654 putative RNA binding protein +FIG00985655 FIG00985656: hypothetical protein +FIG00985659 FIG00985660: hypothetical protein +FIG00985661 FIG00985662: hypothetical protein +FIG00985662 FIG00985663: hypothetical protein +FIG00985665 FIG00985666: hypothetical protein +FIG00985666 putative symbiosis-related calsymin +FIG00985667 FIG00985668: hypothetical protein +FIG00985671 FIG00985672: hypothetical protein +FIG00985675 FIG00985677: hypothetical protein +FIG00985679 FIG00985680: hypothetical protein +FIG00985682 FIG00795113: hypothetical protein +FIG00985684 FIG00985685: hypothetical protein +FIG00985685 putative phosphotransferase protein +FIG00985689 FIG00985690: hypothetical protein +FIG00985690 FIG00985693: hypothetical protein +FIG00985694 FIG00985695: hypothetical protein +FIG00985695 FIG00985696: hypothetical protein +FIG00985701 FIG00985703: hypothetical protein +FIG00985703 FIG00985704: hypothetical protein +FIG00985705 FIG00985706: hypothetical protein +FIG00985706 PssD +FIG00985707 FIG00791874: hypothetical protein +FIG00985715 tRNA proofreading protein STM4549 +FIG00985716 FIG00451006: hypothetical protein +FIG00985723 FIG00985724: hypothetical protein +FIG00985725 FIG00985728: hypothetical protein +FIG00985730 FIG00985732: hypothetical protein +FIG00985732 Ubiquinone/menaquinone biosynthesis methyltransferase +FIG00985736 FIG00985737: hypothetical protein +FIG00985738 FIG00985739: hypothetical protein +FIG00985743 FIG00985744: hypothetical protein +FIG00985744 Peptidoglycan-binding protein +FIG00985745 FIG00985748: hypothetical protein +FIG00985748 hypothetical protein +FIG00985750 conjugal transfer transcriptional regulator (repressor) protein +FIG00985753 probable transcriptional regulator protein, AraC family +FIG00985757 FIG00985758: hypothetical protein +FIG00985758 FIG00450254: hypothetical protein +FIG00985765 FIG00985767: hypothetical protein +FIG00985767 FIG00985769: hypothetical protein +FIG00985773 FIG00985774: hypothetical protein +FIG00985777 FIG00985778: hypothetical protein +FIG00985778 putative plasmid stabilisation protein +FIG00985781 FIG00985782: hypothetical protein +FIG00985783 FIG00985784: hypothetical protein +FIG00985784 FIG00985785: hypothetical protein +FIG00985787 FIG00985790: hypothetical protein +FIG00985790 FIG00985792: hypothetical protein +FIG00985792 FIG00985795: hypothetical protein +FIG00985795 FIG00985796: hypothetical protein +FIG00985796 FIG00985798: hypothetical protein +FIG00985798 FIG00985799: hypothetical protein +FIG00985799 FIG00985800: hypothetical protein +FIG00985805 FIG00985806: hypothetical protein +FIG00985807 FIG00985808: hypothetical protein +FIG00985812 FIG00985813: hypothetical protein +FIG00985816 FIG00985817: hypothetical protein +FIG00985818 FIG00985819: hypothetical protein +FIG00985819 FIG00985820: hypothetical protein +FIG00985823 FIG00985826: hypothetical protein +FIG00985826 FIG00985827: hypothetical protein +FIG00985827 FIG00985828: hypothetical protein +FIG00985828 FIG00985829: hypothetical protein +FIG00985829 putative AraC family transcriptional regulator for P-hydroxybenzoate hydroxylase +FIG00985830 putative transmembrane transporter permease component +FIG00985837 FIG00985838: hypothetical protein +FIG00985838 probable two-component sensor histidine kinase/response regulator hybrid protein +FIG00985844 putative two component regulator sensor histidine kinase transcriptional regulatory protein +FIG00985846 FIG00985847: hypothetical protein +FIG00985849 PUTATIVE GLYCOSYLTRANSFERASE TRANSMEMBRANE PROTEIN +FIG00985850 Adenylyl cyclase CyaC (EC 4.6.1.1) +FIG00985858 FIG00985859: hypothetical protein +FIG00985862 FIG00985864: hypothetical protein +FIG00985865 FIG00985866: hypothetical protein +FIG00985867 HYPOTHETICAL SIGNAL PEPTIDE PROTEIN +FIG00985878 chromosome partitioning protein +FIG00985891 FIG00985893: hypothetical protein +FIG00985897 FIG00985898: hypothetical protein +FIG00985898 FIG00985899: hypothetical protein +FIG00985906 transcriptional regulator, AraC type; possible DNA gyrase inhibitor +FIG00985907 FIG00985908: hypothetical protein +FIG00985908 putative transmembrane GGDEF/EAL domain protein +FIG00985909 FIG01074887: hypothetical protein +FIG00985910 FIG00985911: hypothetical protein +FIG00985912 Mll2788 protein +FIG00985913 putative nucleoside 2-deoxyribosyltransferase +FIG00985921 putative glyoxylase +FIG00985922 FIG00985925: hypothetical protein +FIG00985925 FIG00985928: hypothetical protein +FIG00985929 FIG00985930: hypothetical protein +FIG00985930 Cell processes; Transport of small molecules +FIG00985933 FIG00985934: hypothetical protein +FIG00985934 FIG00985935: hypothetical protein +FIG00985935 FIG00985936: hypothetical protein +FIG00985938 FIG00985939: hypothetical protein +FIG00985940 molybdenum transport system permease protein +FIG00985942 FIG00985943: hypothetical protein +FIG00985948 FIG00985949: hypothetical protein +FIG00985950 FIG00985951: hypothetical protein +FIG00985954 FIG00985955: hypothetical protein +FIG00985955 Dihydroxyacetone ABC transport system, permease protein 2 +FIG00985956 FIG00985957: hypothetical protein +FIG00985959 FIG00985960: hypothetical protein +FIG00985960 FIG00985961: hypothetical protein +FIG00985961 Glucose-methanol-choline oxidoreductase +FIG00985963 putative class II aminoacyl t-RNA synthetase domain protein +FIG00985964 small molecule metabolism +FIG00985967 putative LacI family transcriptional regulatory protein +FIG00985970 FIG00985972: hypothetical protein +FIG00985978 FIG00985979: hypothetical protein +FIG00985979 FIG00985981: hypothetical protein +FIG00985984 FIG00985986: hypothetical protein +FIG00985987 miscellaneous; hypothetical/partial homology +FIG00985989 FIG00985990: hypothetical protein +FIG00985994 FIG00985995: hypothetical protein +FIG00985995 FIG00985996: hypothetical protein +FIG00985997 FIG00985998: hypothetical protein +FIG00986001 FIG00986002: hypothetical protein +FIG00986003 FIG00986004: hypothetical protein +FIG00986006 NADH-UBIQUINONE OXIDOREDUCTASE 39 KD SUBUNIT (EC 1.6.5.3) +FIG00986009 FIG00986011: hypothetical protein +FIG00986013 FIG00986014: hypothetical protein +FIG00986017 FIG00986019: hypothetical protein +FIG00986019 putative dehydrogenases +FIG00986022 FIG00986023: hypothetical protein +FIG00986024 sugar ABC transporter, substrate-binding protein +FIG00986026 FIG00986027: hypothetical protein +FIG00986028 FIG00986029: hypothetical protein +FIG00986035 putative DoxD family transmembrane protein +FIG00986036 FIG00986037: hypothetical protein +FIG00986039 FIG00986041: hypothetical protein +FIG00986041 FIG00986042: hypothetical protein +FIG00986043 FIG00986047: hypothetical protein +FIG00986047 Exopolysaccharide production negative regulator precursor +FIG00986049 FIG00986050: hypothetical protein +FIG00986050 FIG00986051: hypothetical protein +FIG00986052 FIG00986053: hypothetical protein +FIG00986053 putative LacI family HTH-type transcriptional regulator +FIG00986060 FIG00986061: hypothetical protein +FIG00986061 tRNA (5-methylaminomethyl-2-thiouridylate)-methyltransferase (EC 2.1.1.61) / FAD-dependent cmnm(5)s(2)U34 oxidoreductase +FIG00986065 PobR regulator +FIG00986067 FIG00986068: hypothetical protein +FIG00986070 putative transmembrane exo/endo phosphatase family protein +FIG00986074 FIG00986075: hypothetical protein +FIG00986075 FIG00986076: hypothetical protein +FIG00986079 putative component of ABC transporter +FIG00986080 FIG00986081: hypothetical protein +FIG00986081 FIG00986082: hypothetical protein +FIG00986083 FIG00986084: hypothetical protein +FIG00986085 FIG00986087: hypothetical protein +FIG00986087 FIG00986091: hypothetical protein +FIG00986091 MYG1 protein +FIG00986094 cytoplasmic protein +FIG00986096 FIG00986097: hypothetical protein +FIG00986099 FIG00986102: hypothetical protein +FIG00986104 FIG00986105: hypothetical protein +FIG00986106 FIG00986107: hypothetical protein +FIG00986109 FIG00986112: hypothetical protein +FIG00986112 putative transmembrane acid phosphatase +FIG00986113 FIG00986114: hypothetical protein +FIG00986114 FIG00986116: hypothetical protein +FIG00986117 Bona fide RidA/YjgF/TdcF/RutC subgroup +FIG00986120 FIG00986121: hypothetical protein +FIG00986125 FIG00986126: hypothetical protein +FIG00986131 FIG00986133: hypothetical protein +FIG00986134 FIG00986135: hypothetical protein +FIG00986135 FIG00986136: hypothetical protein +FIG00986136 FIG00986137: hypothetical protein +FIG00986139 FIG00986140: hypothetical protein +FIG00986141 FIG00986143: hypothetical protein +FIG00986143 FIG00986144: hypothetical protein +FIG00986144 FIG00986145: hypothetical protein +FIG00986146 FIG00986147: hypothetical protein +FIG00986154 FIG00986155: hypothetical protein +FIG00986155 FIG00986156: hypothetical protein +FIG00986159 FIG00986160: hypothetical protein +FIG00986161 FIG00986162: hypothetical protein +FIG00986165 putative HTH transcriptional regulator +FIG00986166 FIG00986167: hypothetical protein +FIG00986167 FIG00986168: hypothetical protein +FIG00986171 FIG00986173: hypothetical protein +FIG00986175 FIG00986177: hypothetical protein +FIG00986177 FIG00986178: hypothetical protein +FIG00986181 FIG00986182: hypothetical protein +FIG00986184 putative transporter, permease protein +FIG00986188 FIG00986189: hypothetical protein +FIG00986189 FIG00986190: hypothetical protein +FIG00986192 FIG00986193: hypothetical protein +FIG00986193 FIG00986194: hypothetical protein +FIG00986194 FIG00986198: hypothetical protein +FIG00986198 Dihydroxyacetone ABC transport system, ATP-binding protein +FIG00986204 FIG00986205: hypothetical protein +FIG00986208 FIG00986209: hypothetical protein +FIG00986215 FIG00986216: hypothetical protein +FIG00986217 FIG00986219: hypothetical protein +FIG00986220 FIG00986222: hypothetical protein +FIG00986222 miscellaneous; not classified regulator +FIG00986225 FIG00986226: hypothetical protein +FIG00986227 amino acid ABC transporter, periplasmic amino acid-binding protein +FIG00986228 D-Tagatose 3-epimerase +FIG00986229 FIG00986231: hypothetical protein +FIG00986235 FIG00986237: hypothetical protein +FIG00986242 FIG00986243: hypothetical protein +FIG00986243 FIG00986244: hypothetical protein +FIG00986246 FIG00986247: hypothetical protein +FIG00986247 FIG00986248: hypothetical protein +FIG00986248 FIG00986249: hypothetical protein +FIG00986249 FIG00986254: hypothetical protein +FIG00986258 FIG00986260: hypothetical protein +FIG00986265 FIG00986266: hypothetical protein +FIG00986268 FIG00986269: hypothetical protein +FIG00986269 FIG00986270: hypothetical protein +FIG00986272 D-threo-aldose 1-dehydrogenase +FIG00986274 FIG00986277: hypothetical protein +FIG00986284 FIG00986286: hypothetical protein +FIG00986287 FIG00986289: hypothetical protein +FIG00986289 FIG00986290: hypothetical protein +FIG00986290 FIG00986291: hypothetical protein +FIG00986294 FIG00986295: hypothetical protein +FIG00986295 oligopeptide ABC transporter, ATP-binding protein +FIG00986301 DNA-binding heavy metal response regulator +FIG00986307 FIG00986310: hypothetical protein +FIG00986317 FIG00986318: hypothetical protein +FIG00986318 FIG00986319: hypothetical protein +FIG00986319 Multi-sensor hybrid histidine kinase +FIG00986320 FIG00986323: hypothetical protein +FIG00986325 Bll7529 protein +FIG00986326 FIG00986327: hypothetical protein +FIG00986328 FIG00986329: hypothetical protein +FIG00986336 FIG00986338: hypothetical protein +FIG00986342 putative isochorismatase family protein +FIG00986343 FIG00986345: hypothetical protein +FIG00986347 FIG00986349: hypothetical protein +FIG00986351 FIG00986352: hypothetical protein +FIG00986358 FIG00986359: hypothetical protein +FIG00986359 putative perosamine synthetase +FIG00986365 FIG00986366: hypothetical protein +FIG00986369 FIG00986371: hypothetical protein +FIG00986374 FIG00986375: hypothetical protein +FIG00986377 putative O-acetyl transferase +FIG00986380 FIG00986381: hypothetical protein +FIG00986383 FIG00986384: hypothetical protein +FIG00986384 FIG00986385: hypothetical protein +FIG00986386 FIG00986388: hypothetical protein +FIG00986391 FIG00986392: hypothetical protein +FIG00986393 FIG00986395: hypothetical protein +FIG00986395 FIG00986396: hypothetical protein +FIG00986405 FIG00986406: hypothetical protein +FIG00986406 FIG00986407: hypothetical protein +FIG00986408 FIG00986411: hypothetical protein +FIG00986411 FIG00986413: hypothetical protein +FIG00986414 Putative transcription regulator protein +FIG00986417 FIG00986418: hypothetical protein +FIG00986421 FIG00986422: hypothetical protein +FIG00986429 FIG00986430: hypothetical protein +FIG00986440 putative HTH family transcriptional regulator +FIG00986447 FIG00986448: hypothetical protein +FIG00986451 Glutamine synthetase translation inhibitor +FIG00986452 FIG00986453: hypothetical protein +FIG00986455 FIG00986456: hypothetical protein +FIG00986463 ABC-type oligopeptide transporter, ATP binding protein +FIG00986464 FIG00986465: hypothetical protein +FIG00986467 FIG00986468: hypothetical protein +FIG00986476 FIG00986477: hypothetical protein +FIG00986477 FIG00986480: hypothetical protein +FIG00986487 FIG00986488: hypothetical protein +FIG00986495 oligopeptide/dipeptide ABC transporter, periplasmic substrate-binding protein +FIG00986499 putative transferase involved in exopolysaccharide biosynthesis +FIG00986501 FIG00986502: hypothetical protein +FIG00986502 FIG00986503: hypothetical protein +FIG00986503 FIG00986505: hypothetical protein +FIG00986505 FIG00986506: hypothetical protein +FIG00986508 putative integral membrane protein TIGR02587 +FIG00986509 FIG00986511: hypothetical protein +FIG00986513 FIG00986515: hypothetical protein +FIG00986524 FIG00986525: hypothetical protein +FIG00986526 Mlr7321 protein +FIG00986527 FIG00986529: hypothetical protein +FIG00986529 FIG00986530: hypothetical protein +FIG00986530 FIG00986531: hypothetical protein +FIG00986536 FIG00986537: hypothetical protein +FIG00986540 FIG00986541: hypothetical protein +FIG00986547 FIG00986548: hypothetical protein +FIG00986556 FIG00986557: hypothetical protein +FIG00986557 FIG00986558: hypothetical protein +FIG00986558 FIG00986559: hypothetical protein +FIG00986561 FIG00450271: hypothetical protein +FIG00986565 FIG00986566: hypothetical protein +FIG00986567 FIG00986568: hypothetical protein +FIG00986569 FIG00986571: hypothetical protein +FIG00986576 FIG00986577: hypothetical protein +FIG00986577 putative aldolase +FIG00986578 putative MmgE/PrpD family protein +FIG00986580 FIG00986581: hypothetical protein +FIG00986582 putative O antigen biosynthesis protein +FIG00986585 FIG00986586: hypothetical protein +FIG00986589 putative substrate-binding component of ABC transporter +FIG00986591 FIG00986593: hypothetical protein +FIG00986594 FIG00986595: hypothetical protein +FIG00986596 FIG00986599: hypothetical protein +FIG00986608 FIG00986609: hypothetical protein +FIG00986610 FIG00986611: hypothetical protein +FIG00986617 FIG00986619: hypothetical protein +FIG00986623 FIG00986625: hypothetical protein +FIG00986625 FIG00986626: hypothetical protein +FIG00986627 FIG00986628: hypothetical protein +FIG00986628 FIG00986629: hypothetical protein +FIG00986634 nodulation protein F +FIG00986645 putative sensory box GGDEF/EAL domain protein +FIG00986646 FIG00986648: hypothetical protein +FIG00986648 FIG00986649: hypothetical protein +FIG00986649 FIG00986651: hypothetical protein +FIG00986659 FIG00986661: hypothetical protein +FIG00986669 arginine/ornithine transport ATP-binding protein +FIG00986679 FIG00986680: hypothetical protein +FIG00986681 FIG00986683: hypothetical protein +FIG00986683 FIG00986684: hypothetical protein +FIG00986684 FIG00986685: hypothetical protein +FIG00986698 FIG00986700: hypothetical protein +FIG00986708 FIG00986710: hypothetical protein +FIG00986715 FIG00986717: hypothetical protein +FIG00986717 FIG00986718: hypothetical protein +FIG00986718 FIG00986720: hypothetical protein +FIG00986721 FIG00986722: hypothetical protein +FIG00986729 CMP KDO transferase +FIG00986731 FIG00986732: hypothetical protein +FIG00986733 FIG00986735: hypothetical protein +FIG00986743 FIG00986744: hypothetical protein +FIG00986749 FIG00986750: hypothetical protein +FIG00986753 Intracellular septation protein +FIG00986759 FIG00986760: hypothetical protein +FIG00986762 cystathionine gamma-synthase protein( EC:2.5.1.48 ) +FIG00986764 FIG00986765: hypothetical protein +FIG00986767 FIG00986768: hypothetical protein +FIG00986768 FIG00986769: hypothetical protein +FIG00986772 FIG00986773: hypothetical protein +FIG00986773 FIG00986776: hypothetical protein +FIG00986780 FIG00986781: hypothetical protein +FIG00986786 FIG00986788: hypothetical protein +FIG00986788 FIG00986789: hypothetical protein +FIG00986790 cell processes; cell division +FIG00986793 Small Molecule Metabolism; Biosynthesis of cofactors, carriers; menaquinone, ubiquinone +FIG00986814 FIG00986816: hypothetical protein +FIG00986817 FIG00986819: hypothetical protein +FIG00986821 FIG00986822: hypothetical protein +FIG00986822 probable serine/threonine specific protein phosphatase protein( EC:3.1.3.16 ) +FIG00986823 FIG00986824: hypothetical protein +FIG00986827 FIG00986828: hypothetical protein +FIG00986833 possible periplasmic iron siderophore binding protein of ABC transporter +FIG00986836 transcriptional regulator, LacI (ribose operon repressor) family +FIG00986838 probable sucrose ABC transporter, substrate-binding protein +FIG00986840 FIG00986842: hypothetical protein +FIG00986842 FIG00986844: hypothetical protein +FIG00986848 putative CRP/FNR family transcriptional regulator +FIG00986849 FIG00986851: hypothetical protein +FIG00986851 FIG00986852: hypothetical protein +FIG00986858 FIG00986861: hypothetical protein +FIG00986862 FIG00986864: hypothetical protein +FIG00986866 putative AsnC family transcriptional regulator +FIG00986868 FIG00986869: hypothetical protein +FIG00986872 FIG00986873: hypothetical protein +FIG00986880 putative DNA stabilisation protein +FIG00986884 FIG00986885: hypothetical protein +FIG00986885 FIG00986886: hypothetical protein +FIG00986886 FIG045684: hypothetical protein +FIG00986887 FIG00986888: hypothetical protein +FIG00986889 FIG00986892: hypothetical protein +FIG00986893 COG0346: Lactoylglutathione lyase and related lyases +FIG00986894 FIG00986895: hypothetical protein +FIG00986897 putative desulfurization protein +FIG00986905 FIG00986909: hypothetical protein +FIG00986909 FIG00986910: hypothetical protein +FIG00986912 Protein +FIG00986913 FIG00986915: hypothetical protein +FIG00986918 FIG00986919: hypothetical protein +FIG00986924 FIG00986925: hypothetical protein +FIG00986926 FIG00986929: hypothetical protein +FIG00986929 FIG00986931: hypothetical protein +FIG00986931 FIG00986936: hypothetical protein +FIG00986936 FIG00986938: hypothetical protein +FIG00986938 FIG00986940: hypothetical protein +FIG00986940 FIG00986941: hypothetical protein +FIG00986950 FIG00986951: hypothetical protein +FIG00986956 FIG00986957: hypothetical protein +FIG00986957 polyketide synthase protein +FIG00986958 bacteroid protein S +FIG00986962 FIG00986963: hypothetical protein +FIG00986977 FIG00986978: hypothetical protein +FIG00986988 FIG00986991: hypothetical protein +FIG00987008 probable UDP-glucose 4-epimerase protein +FIG00987015 putative two-component sensor histidine kinase transcriptional regulatory protein +FIG00987018 FIG00987019: hypothetical protein +FIG00987020 putative nodulation protein +FIG00987022 FIG00987023: hypothetical protein +FIG00987027 probable ring-cleaving dioxygenase protein +FIG00987034 two component response regulator +FIG00987038 FIG00987039: hypothetical protein +FIG00987041 probable aryl-alcohol dehydrogenase protein( EC:1.1.1.90 ) +FIG00987044 FIG00987045: hypothetical protein +FIG00987051 FIG00987052: hypothetical protein +FIG00987052 FIG00987057: hypothetical protein +FIG00987062 FIG00987064: hypothetical protein +FIG00987067 FIG00987068: hypothetical protein +FIG00987068 FIG00987069: hypothetical protein +FIG00987070 FIG00987071: hypothetical protein +FIG00987074 FIG00987079: hypothetical protein +FIG00987079 FIG00987082: hypothetical protein +FIG00987085 FIG00987087: hypothetical protein +FIG00987090 FIG00987091: hypothetical protein +FIG00987096 putative MFS family transporter protein +FIG00987098 autoaggregation protein +FIG00987112 FIG00987113: hypothetical protein +FIG00987113 probable acetamidase/formamidase protein +FIG00987120 FIG00987121: hypothetical protein +FIG00987128 FIG00987129: hypothetical protein +FIG00987129 FIG00987130: hypothetical protein +FIG00987140 FIG00987141: hypothetical protein +FIG00987152 FIG00987153: hypothetical protein +FIG00987157 FIG00987160: hypothetical protein +FIG00987164 FIG00987167: hypothetical protein +FIG00987168 FIG00987169: hypothetical protein +FIG00987172 FIG00987173: hypothetical protein +FIG00987180 FIG00987182: hypothetical protein +FIG00987187 FIG00987188: hypothetical protein +FIG00987191 FIG00987192: hypothetical protein +FIG00987192 FIG00987193: hypothetical protein +FIG00987194 putative exported surface protein +FIG00987202 FIG00987203: hypothetical protein +FIG00987204 FIG00987206: hypothetical protein +FIG00987206 FIG00987208: hypothetical protein +FIG00987209 FIG00987210: hypothetical protein +FIG00987219 FIG00363986: hypothetical protein +FIG00987220 FIG00987221: hypothetical protein +FIG00987242 FIG00987243: hypothetical protein +FIG00987243 FIG00987244: hypothetical protein +FIG00987252 putative exopolysaccharide synthesis protein +FIG00987258 FIG00986154: hypothetical protein +FIG00987286 FIG00987288: hypothetical protein +FIG00987296 FIG00987298: hypothetical protein +FIG00987312 FIG00987315: hypothetical protein +FIG00987315 FIG00987316: hypothetical protein +FIG00987316 putative transcriptional regulators, CopG/Arc/MetJ family +FIG00987319 putative gluconate 5-dehydrogenase( EC:1.1.1.69 ) +FIG00987320 FIG00987322: hypothetical protein +FIG00987332 FIG00987336: hypothetical protein +FIG00987340 FIG00987341: hypothetical protein +FIG00987346 FIG00987347: hypothetical protein +FIG00987360 FIG00987361: hypothetical protein +FIG00987361 FIG00987362: hypothetical protein +FIG00987365 FIG00987367: hypothetical protein +FIG00987368 FIG00987371: hypothetical protein +FIG00987391 FIG00987393: hypothetical protein +FIG00987403 2,4-dichlorophenol 6-monooxygenase (EC 1.14.13.20) +FIG00987410 FIG00987411: hypothetical protein +FIG00987414 FIG00987416: hypothetical protein +FIG00987416 octopine ABC transporter, permease protein +FIG00987434 FIG00987435: hypothetical protein +FIG00987435 FIG00987439: hypothetical protein +FIG00987504 FIG00987505: hypothetical protein +FIG00987507 FIG00987508: hypothetical protein +FIG00987508 FIG00987509: hypothetical protein +FIG00987511 FIG00987517: hypothetical protein +FIG00987517 FIG00987518: hypothetical protein +FIG00987518 FIG00987521: hypothetical protein +FIG00987521 FIG00987523: hypothetical protein +FIG00987523 FIG00987524: hypothetical protein +FIG00987524 FIG00987525: hypothetical protein +FIG00987530 FIG00987531: hypothetical protein +FIG00987531 FIG00987534: hypothetical protein +FIG00987535 FIG00987536: hypothetical protein +FIG00987540 Demethylmenaquinone methyltransferase( EC:2.- ) +FIG00987544 FIG00987547: hypothetical protein +FIG00987550 FIG00987552: hypothetical protein +FIG00987553 FIG01030681: hypothetical protein +FIG00987554 DNA-binding response regulator CtrA +FIG00987555 peptidase U35, phage prohead HK97 +FIG00987560 Branched-chain amino acid ABC transporter, ATP-binding protein +FIG00987564 FIG086212: Putative lipoprotein +FIG00987565 FIG00987566: hypothetical protein +FIG00987566 Cobalamin biosynthesis protein CobE +FIG00987569 FIG00987571: hypothetical protein +FIG00987571 FIG00987572: hypothetical protein +FIG00987575 FIG00987577: hypothetical protein +FIG00987577 FIG00987579: hypothetical protein +FIG00987579 GAF sensor diguanylate cyclase (GGDEF) +FIG00987582 FIG00987583: hypothetical protein +FIG00987583 FIG00987585: hypothetical protein +FIG00987586 FIG01075668: hypothetical protein +FIG00987597 FIG00987600: hypothetical protein +FIG00987601 FIG00987605: hypothetical protein +FIG00987608 FIG00987609: hypothetical protein +FIG00987609 FIG00987613: hypothetical protein +FIG00987616 FIG00987617: hypothetical protein +FIG00987617 FIG00987618: hypothetical protein +FIG00987618 FIG00987619: hypothetical protein +FIG00987619 FIG00987620: hypothetical protein +FIG00987620 Response regulator receiver protein +FIG00987621 FIG00987622: hypothetical protein +FIG00987622 FIG00987627: hypothetical protein +FIG00987627 FIG00987628: hypothetical protein +FIG00987628 FIG094713: hypothetical protein +FIG00987630 FIG00987634: hypothetical protein +FIG00987635 ABC glutamate/glutamine/aspartate/asparagine transporter, inner membrane subunit BztB +FIG00987639 FIG00987641: hypothetical protein +FIG00987647 integral membrane protein, putative +FIG00987655 FIG00987656: hypothetical protein +FIG00987658 FIG00987659: hypothetical protein +FIG00987660 FIG00987662: hypothetical protein +FIG00987662 FIG00987663: hypothetical protein +FIG00987663 FIG00987668: hypothetical protein +FIG00987668 FIG00987674: hypothetical protein +FIG00987679 FIG00987683: hypothetical protein +FIG00987683 FIG00987684: hypothetical protein +FIG00987686 FIG00987687: hypothetical protein +FIG00987687 FIG00992253: hypothetical protein +FIG00987689 FIG00987691: hypothetical protein +FIG00987691 FIG00987692: hypothetical protein +FIG00987692 FIG00987695: hypothetical protein +FIG00987696 Conserved hypothetical protein, gene in Ubiquinol-cytochrome C chaperone locus +FIG00987697 Bll4998 protein +FIG00987699 FIG00987700: hypothetical protein +FIG00987702 FIG00987703: hypothetical protein +FIG00987703 FIG00987706: hypothetical protein +FIG00987706 FIG00987708: hypothetical protein +FIG00987708 FIG00987709: hypothetical protein +FIG00987714 FIG00987716: hypothetical protein +FIG00987723 FIG00987724: hypothetical protein +FIG00987724 tRNA dihydrouridine synthase A +FIG00987734 FIG00987735: hypothetical protein +FIG00987735 FIG00987739: hypothetical protein +FIG00987740 FIG00987741: hypothetical protein +FIG00987741 FIG00987747: hypothetical protein +FIG00987747 FIG00987748: hypothetical protein +FIG00987748 FIG00987749: hypothetical protein +FIG00987749 FIG00987750: hypothetical protein +FIG00987750 FIG00987751: hypothetical protein +FIG00987757 FIG00987759: hypothetical protein +FIG00987759 FIG00987760: hypothetical protein +FIG00987760 FIG00987761: hypothetical protein +FIG00987762 FIG00987763: hypothetical protein +FIG00987763 Peptide/nickel/opine uptake family ABC transporter, permease protein +FIG00987769 FIG00987772: hypothetical protein +FIG00987772 Uncharacterized glutathione S-transferase-like protein +FIG00987773 FIG00987775: hypothetical protein +FIG00987776 FIG00987782: hypothetical protein +FIG00987783 FIG00987785: hypothetical protein +FIG00987785 Phage Host Specificity Protein +FIG00987788 FIG00987790: hypothetical protein +FIG00987791 FIG00987792: hypothetical protein +FIG00987792 FIG00987793: hypothetical protein +FIG00987793 FIG00987794: hypothetical protein +FIG00987794 FIG00987796: hypothetical protein +FIG00987804 FIG00987805: hypothetical protein +FIG00987805 FIG00987806: hypothetical protein +FIG00987806 FIG00987810: hypothetical protein +FIG00987810 FIG00987811: hypothetical protein +FIG00987811 FIG00987812: hypothetical protein +FIG00987812 FIG00987817: hypothetical protein +FIG00987817 FIG00987818: hypothetical protein +FIG00987822 FIG00987823: hypothetical protein +FIG00987823 FIG00987828: hypothetical protein +FIG00987828 FIG00987832: hypothetical protein +FIG00987832 FIG00987833: hypothetical protein +FIG00987834 FIG00987837: hypothetical protein +FIG00987837 Cytochrome c-554 precursor (Cytochrome c554) (High-potential cytochrome c) +FIG00987845 FIG00987846: hypothetical protein +FIG00987846 Esterase/lipase/thioesterase( EC:3.1.1.- ) +FIG00987847 ABC Fe+3 siderophore transporter, periplasmic substrate-binding protein +FIG00987851 FIG00987854: hypothetical protein +FIG00987854 FIG00987856: hypothetical protein +FIG00987859 FIG00987865: hypothetical protein +FIG00987865 FIG00987866: hypothetical protein +FIG00987866 FIG00987867: hypothetical protein +FIG00987867 FIG00987868: hypothetical protein +FIG00987868 FIG00987871: hypothetical protein +FIG00987872 Lipoprotein, VirB7-like +FIG00987875 FIG00987884: hypothetical protein +FIG00987887 FIG00987891: hypothetical protein +FIG00987891 FIG00987894: hypothetical protein +FIG00987894 FIG00987898: hypothetical protein +FIG00987898 FIG00987901: hypothetical protein +FIG00987923 FIG00987925: hypothetical protein +FIG00987932 FIG00987935: hypothetical protein +FIG00987936 FIG00987940: hypothetical protein +FIG00987940 Cytochrome P450 family protein +FIG00987942 Type II secretory pathway, component PulF +FIG00987945 FIG00987947: hypothetical protein +FIG00987947 FIG00987950: hypothetical protein +FIG00987961 FIG00987967: hypothetical protein +FIG00987967 FIG00987969: hypothetical protein +FIG00987972 FIG00987975: hypothetical protein +FIG00987975 FIG00987978: hypothetical protein +FIG00987978 FIG00987981: hypothetical protein +FIG00987981 FIG00987986: hypothetical protein +FIG00987986 FIG00987988: hypothetical protein +FIG00987988 FIG00987989: hypothetical protein +FIG00987989 FIG00987990: hypothetical protein +FIG00987991 FIG00987995: hypothetical protein +FIG00987997 FIG00987998: hypothetical protein +FIG00987998 FIG00988001: hypothetical protein +FIG00988008 FIG00988009: hypothetical protein +FIG00988014 Aa3-type cytochrome c oxidase subunit IV +FIG00988018 FIG00988020: hypothetical protein +FIG00988021 FIG00988022: hypothetical protein +FIG00988022 FIG00988023: hypothetical protein +FIG00988023 FIG00988024: hypothetical protein +FIG00988036 FIG00988039: hypothetical protein +FIG00988039 FIG00988040: hypothetical protein +FIG00988042 FIG00988043: hypothetical protein +FIG00988048 FIG00988052: hypothetical protein +FIG00988060 FIG00988063: hypothetical protein +FIG00988067 FIG00988068: hypothetical protein +FIG00988069 FIG00988072: hypothetical protein +FIG00988073 arsenate reductase and related +FIG00988083 FIG00988090: hypothetical protein +FIG00988101 FIG00988102: hypothetical protein +FIG00988102 FIG00988106: hypothetical protein +FIG00988106 FIG00988107: hypothetical protein +FIG00988107 FIG00988111: hypothetical protein +FIG00988111 FIG00988112: hypothetical protein +FIG00988112 FIG00988115: hypothetical protein +FIG00988115 FIG00988117: hypothetical protein +FIG00988117 FIG00988119: hypothetical protein +FIG00988119 FIG00988120: hypothetical protein +FIG00988120 FIG00988121: hypothetical protein +FIG00988121 trp repressor binding protein WrbA, putative +FIG00988128 Periplasmic serine protease, DO/DeqQ family +FIG00988129 FIG00988134: hypothetical protein +FIG00988134 FIG00988138: hypothetical protein +FIG00988138 FIG00988139: hypothetical protein +FIG00988140 FIG00988141: hypothetical protein +FIG00988141 FIG00988144: hypothetical protein +FIG00988144 FIG00988150: hypothetical protein +FIG00988150 FIG00988151: hypothetical protein +FIG00988151 FIG00988155: hypothetical protein +FIG00988156 FIG00988159: hypothetical protein +FIG00988163 FIG00988169: hypothetical protein +FIG00988174 FIG00988175: hypothetical protein +FIG00988175 FIG00988176: hypothetical protein +FIG00988179 FIG00988181: hypothetical protein +FIG00988181 FIG00988182: hypothetical protein +FIG00988188 FIG00988195: hypothetical protein +FIG00988197 FIG00988198: hypothetical protein +FIG00988198 FIG00988199: hypothetical protein +FIG00988199 ABC amino acid transporter, inner membrane subunit +FIG00988200 FIG00988201: hypothetical protein +FIG00988203 FIG00988207: hypothetical protein +FIG00988209 FIG00988211: hypothetical protein +FIG00988211 FIG00988212: hypothetical protein +FIG00988212 FIG00988213: hypothetical protein +FIG00988216 FIG00988217: hypothetical protein +FIG00988217 FIG00988218: hypothetical protein +FIG00988225 FIG00988226: hypothetical protein +FIG00988226 FIG00988227: hypothetical protein +FIG00988227 FIG00988228: hypothetical protein +FIG00988228 Hydrogenase maturation protein HupF/HypC/HoxL +FIG00988233 FIG00988234: hypothetical protein +FIG00988237 FIG00988239: hypothetical protein +FIG00988240 FIG00988241: hypothetical protein +FIG00988241 FIG00988246: hypothetical protein +FIG00988248 FIG00988251: hypothetical protein +FIG00988251 FIG00988253: hypothetical protein +FIG00988253 ABC polyamine transporter, periplasmic substrate-binding protein +FIG00988256 FIG00988257: hypothetical protein +FIG00988273 FIG00988277: hypothetical protein +FIG00988278 twin-arginine translocation pathway signal sequence domain protein +FIG00988285 Protein PufQ, involved in assembly of B875 and B800-850 pigment-protein complexes +FIG00988286 Entericidin EcnAB +FIG00988289 FIG00988290: hypothetical protein +FIG00988290 FIG00988291: hypothetical protein +FIG00988291 Outer membrane transporter, OMPP1/FadL/TodX family +FIG00988296 FIG00988297: hypothetical protein +FIG00988300 protein of unknown function DUF333 +FIG00988305 Pseudoazurin +FIG00988309 Flavin-containing monooxygenase +FIG00988320 Peptidase, family S49 +FIG00988326 FIG00988328: hypothetical protein +FIG00988330 FIG00988331: hypothetical protein +FIG00988333 FIG00988334: hypothetical protein +FIG00988334 FIG00988335: hypothetical protein +FIG00988335 FIG00988337: hypothetical protein +FIG00988337 FIG00988338: hypothetical protein +FIG00988338 FIG00988339: hypothetical protein +FIG00988348 FIG00988349: hypothetical protein +FIG00988361 FIG00988363: hypothetical protein +FIG00988363 FIG00988365: hypothetical protein +FIG00988372 FIG00988375: hypothetical protein +FIG00988375 Gene Transfer Agent (GTA) ORFG01 +FIG00988376 FIG00988377: hypothetical protein +FIG00988377 FIG00988378: hypothetical protein +FIG00988378 FIG00988379: hypothetical protein +FIG00988381 FIG00988382: hypothetical protein +FIG00988382 FIG00988383: hypothetical protein +FIG00988390 FIG01026105: hypothetical protein +FIG00988395 FIG00988396: hypothetical protein +FIG00988396 FIG00988398: hypothetical protein +FIG00988398 Chromosomal replication initiator, DnaA C-terminal domain +FIG00988405 Dihydroorotate dehydrogenase +FIG00988408 FIG00988410: hypothetical protein +FIG00988410 FIG00988412: hypothetical protein +FIG00988412 FIG00988413: hypothetical protein +FIG00988421 FIG00988426: hypothetical protein +FIG00988426 FIG00988427: hypothetical protein +FIG00988428 flagellar protein FliO +FIG00988429 FIG00988432: hypothetical protein +FIG00988443 FIG00988444: hypothetical protein +FIG00988444 FIG00988446: hypothetical protein +FIG00988446 FIG00989534: hypothetical protein +FIG00988454 Glycoside hydrolase, family 24 +FIG00988455 FIG00988460: hypothetical protein +FIG00988461 FIG00988463: hypothetical protein +FIG00988463 FIG00988465: hypothetical protein +FIG00988465 Calphotin +FIG00988472 FIG00988474: hypothetical protein +FIG00988475 Cys/Met metabolism pyridoxal-phosphate-dependent enzyme +FIG00988482 FIG00988487: hypothetical protein +FIG00988490 FIG00988492: hypothetical protein +FIG00988494 FIG00988495: hypothetical protein +FIG00988496 FIG00988497: hypothetical protein +FIG00988499 FIG00988500: hypothetical protein +FIG00988500 FIG00988501: hypothetical protein +FIG00988503 PA-phosphatase related phosphoesterase +FIG00988504 FIG00988505: hypothetical protein +FIG00988505 Glycogenin-1 (EC 2.4.1.186) +FIG00988507 FIG00988508: hypothetical protein +FIG00988508 FIG00988509: hypothetical protein +FIG00988509 FIG00988511: hypothetical protein +FIG00988517 putative hypothetical Gifsy-1 prophage protein +FIG00988518 FIG00988521: hypothetical protein +FIG00988521 NAD-dependent epimerase/dehydratase +FIG00988524 FIG00988525: hypothetical protein +FIG00988525 FIG00988527: hypothetical protein +FIG00988530 FIG00988532: hypothetical protein +FIG00988532 FIG00988536: hypothetical protein +FIG00988543 FIG00988545: hypothetical protein +FIG00988545 FIG00988547: hypothetical protein +FIG00988552 Cytochrome b561 +FIG00988557 FIG00988558: hypothetical protein +FIG00988565 Possible integrase/recombinase +FIG00988572 FIG00988575: hypothetical protein +FIG00988580 FIG00988583: hypothetical protein +FIG00988584 Trimethylamine methyltransferase family protein +FIG00988595 FIG00988596: hypothetical protein +FIG00988596 FIG00988597: hypothetical protein +FIG00988597 glycoside hydrolase, family 16 +FIG00988607 FIG00988610: hypothetical protein +FIG00988616 FIG00988619: hypothetical protein +FIG00988619 FIG00988620: hypothetical protein +FIG00988620 FIG00988622: hypothetical protein +FIG00988622 FIG00988626: hypothetical protein +FIG00988632 FIG00988633: hypothetical protein +FIG00988633 FIG00988634: hypothetical protein +FIG00988640 FIG00988644: hypothetical protein +FIG00988645 FIG00988647: hypothetical protein +FIG00988647 FIG00988648: hypothetical protein +FIG00988655 FIG00988657: hypothetical protein +FIG00988658 gas vesicle synthesis protein +FIG00988662 FIG00988664: hypothetical protein +FIG00988665 FIG00988666: hypothetical protein +FIG00988666 FIG00988672: hypothetical protein +FIG00988673 FIG00988674: hypothetical protein +FIG00988674 FIG00988678: hypothetical protein +FIG00988678 FIG00988679: hypothetical protein +FIG00988679 FIG00988681: hypothetical protein +FIG00988681 FIG00988685: hypothetical protein +FIG00988685 FIG00988687: hypothetical protein +FIG00988687 Protein-tyrosine kinase +FIG00988696 FIG00988702: hypothetical protein +FIG00988702 FIG00988704: hypothetical protein +FIG00988704 FIG00988706: hypothetical protein +FIG00988706 FIG00988707: hypothetical protein +FIG00988707 FIG00988708: hypothetical protein +FIG00988708 FIG01075023: hypothetical protein +FIG00988712 flagellar protein FlgJ, putative +FIG00988718 FIG00988719: hypothetical protein +FIG00988723 FIG00988724: hypothetical protein +FIG00988724 FIG00988727: hypothetical protein +FIG00988732 FIG00988735: hypothetical protein +FIG00988740 FIG00988741: hypothetical protein +FIG00988751 FIG00988754: hypothetical protein +FIG00988758 FIG00988759: hypothetical protein +FIG00988759 FIG00988760: hypothetical protein +FIG00988760 FIG00988761: hypothetical protein +FIG00988762 FIG00988764: hypothetical protein +FIG00988764 FIG00988765: hypothetical protein +FIG00988765 FIG00988773: hypothetical protein +FIG00988773 FIG00988774: hypothetical protein +FIG00988774 FIG00988775: hypothetical protein +FIG00988775 FIG00988776: hypothetical protein +FIG00988776 Transmembrane protein involved in DMSP breakdown +FIG00988777 DegT/DnrJ/EryC1/StrS aminotransferase family enzyme +FIG00988779 FIG00988780: hypothetical protein +FIG00988789 Response regulator receiver domain protein +FIG00988790 FIG00988791: hypothetical protein +FIG00988791 FIG00988792: hypothetical protein +FIG00988798 OmpA/MotB domain protein +FIG00988804 FIG00988806: hypothetical protein +FIG00988806 FIG00988808: hypothetical protein +FIG00988811 glycosyltransferase, succinoglycan biosynthesis protein ExoL +FIG00988815 FIG00988816: hypothetical protein +FIG00988816 FIG00988817: hypothetical protein +FIG00988819 Chemotaxis protein histidine kinase and related kinases +FIG00988821 FIG00988824: hypothetical protein +FIG00988824 FIG00988825: hypothetical protein +FIG00988835 FIG00988836: hypothetical protein +FIG00988836 FIG00988840: hypothetical protein +FIG00988844 FIG00988845: hypothetical protein +FIG00988845 FIG00988846: hypothetical protein +FIG00988851 FIG00988855: hypothetical protein +FIG00988860 FIG00988861: hypothetical protein +FIG00988861 ABC transporter, ATP-binding protein, flagellar +FIG00988862 FIG00988863: hypothetical protein +FIG00988864 FIG00988865: hypothetical protein +FIG00988875 FIG00988876: hypothetical protein +FIG00988884 FIG00988889: hypothetical protein +FIG00988889 FIG00988894: hypothetical protein +FIG00988894 FIG00988896: hypothetical protein +FIG00988896 FIG00988899: hypothetical protein +FIG00988899 FIG00988902: hypothetical protein +FIG00988902 FIG00988903: hypothetical protein +FIG00988906 FIG00988907: hypothetical protein +FIG00988912 FIG00988918: hypothetical protein +FIG00988921 FIG00988924: hypothetical protein +FIG00988924 FIG00988925: hypothetical protein +FIG00988932 FIG00989837: hypothetical protein +FIG00988940 FIG00988941: hypothetical protein +FIG00988942 FIG00988943: hypothetical protein +FIG00988943 FIG00988946: hypothetical protein +FIG00988950 Similar to N-terminal domain of competence/damage-inducible protein CinA, molybdopterin binding motif +FIG00988954 FIG00988955: hypothetical protein +FIG00988956 FIG00988957: hypothetical protein +FIG00988959 FIG00988960: hypothetical protein +FIG00988960 FIG00988966: hypothetical protein +FIG00988969 FIG00988970: hypothetical protein +FIG00988972 FIG00988973: hypothetical protein +FIG00988973 blr6566; probable dehydrogenase +FIG00988978 FIG00988979: hypothetical protein +FIG00988984 FIG00988986: hypothetical protein +FIG00988986 Phosphoglycerate mutase family protein +FIG00988987 FIG00988989: hypothetical protein +FIG00988989 FIG00988990: hypothetical protein +FIG00989001 Phage terminase-like protein, large subunit +FIG00989005 FIG00989006: hypothetical protein +FIG00989006 ABC-type transport system involved in Fe-S cluster assembly, permease and ATPase components +FIG00989007 FIG00989010: hypothetical protein +FIG00989010 FIG00989011: hypothetical protein +FIG00989011 FIG00450070: hypothetical protein +FIG00989012 FIG00989014: hypothetical protein +FIG00989014 probable inner membrane component of binding-protein-dependent transport system +FIG00989015 FIG00989016: hypothetical protein +FIG00989026 FIG00989034: hypothetical protein +FIG00989034 FIG00989036: hypothetical protein +FIG00989038 FIG00989039: hypothetical protein +FIG00989055 FIG00989058: hypothetical protein +FIG00989058 FIG00989059: hypothetical protein +FIG00989060 FIG00989061: hypothetical protein +FIG00989061 FIG00989065: hypothetical protein +FIG00989073 FIG00989074: hypothetical protein +FIG00989074 FIG00989077: hypothetical protein +FIG00989082 Acetyltransferase, GNAT family +FIG00989085 FIG00989086: hypothetical protein +FIG00989086 FIG00989091: hypothetical protein +FIG00989092 FIG00989096: hypothetical protein +FIG00989097 FIG00989098: hypothetical protein +FIG00989098 FIG00989099: hypothetical protein +FIG00989101 PAS sensor diguanylatecyclase/phosphodiesterase +FIG00989102 FIG00989105: hypothetical protein +FIG00989105 FIG00989106: hypothetical protein +FIG00989106 FIG00989107: hypothetical protein +FIG00989109 FIG00989112: hypothetical protein +FIG00989123 TRAP-type C4-dicarboxylate transport system, small permease component +FIG00989124 FIG00989125: hypothetical protein +FIG00989125 FIG00989131: hypothetical protein +FIG00989133 FIG00989134: hypothetical protein +FIG00989134 Gram-negative bacterial RTX secretion protein D:Secretion protein HlyD +FIG00989137 Bll7960 protein +FIG00989138 probable transcriptional regulator lacI family +FIG00989142 FIG00989144: hypothetical protein +FIG00989144 Cytochrome b562 +FIG00989147 Bona fide RidA/YjgF/TdcF/RutC subgroup +FIG00989152 FIG00989153: hypothetical protein +FIG00989153 FIG00989154: hypothetical protein +FIG00989155 FIG00989156: hypothetical protein +FIG00989165 threonine efflux protein, putative +FIG00989170 FIG00989174: hypothetical protein +FIG00989174 FIG00989176: hypothetical protein +FIG00989176 FIG00989178: hypothetical protein +FIG00989178 FIG00989179: hypothetical protein +FIG00989181 FIG00989183: hypothetical protein +FIG00989183 FIG00989185: hypothetical protein +FIG00989186 EF hand domain protein +FIG00989187 FIG00989188: hypothetical protein +FIG00989188 FIG00989192: hypothetical protein +FIG00989197 FIG00989198: hypothetical protein +FIG00989198 FIG00989200: hypothetical protein +FIG00989200 FIG00989201: hypothetical protein +FIG00989206 FIG00989210: hypothetical protein +FIG00989210 FIG00989215: hypothetical protein +FIG00989234 FIG00989235: hypothetical protein +FIG00989235 FIG00989238: hypothetical protein +FIG00989238 FIG00989241: hypothetical protein +FIG00989255 FIG00989259: hypothetical protein +FIG00989269 FIG00989270: hypothetical protein +FIG00989270 FIG00989271: hypothetical protein +FIG00989271 FIG00989273: hypothetical protein +FIG00989273 FIG00989274: hypothetical protein +FIG00989274 putative glucose/sorbosone dehydrogenase +FIG00989278 FIG00989280: hypothetical protein +FIG00989284 Invasion associated family protein +FIG00989299 FIG00989302: hypothetical protein +FIG00989302 FIG00989310: hypothetical protein +FIG00989310 ParD protein (antitoxin to ParE) +FIG00989324 FIG00989327: hypothetical protein +FIG00989327 FIG00989328: hypothetical protein +FIG00989334 Neutral zinc metallopeptidase( EC:3.4.24.- ) +FIG00989337 FIG00989339: hypothetical protein +FIG00989348 FIG00989349: hypothetical protein +FIG00989349 FIG00989354: hypothetical protein +FIG00989356 SH3, type 3 domain protein +FIG00989359 ABC amino acid transporter, periplasmic ligand binding protein +FIG00989360 FIG00989363: hypothetical protein +FIG00989364 hypothetical protein AF1210 +FIG00989368 FIG00989373: hypothetical protein +FIG00989378 FIG00989382: hypothetical protein +FIG00989382 FIG00989386: hypothetical protein +FIG00989389 FIG00989392: hypothetical protein +FIG00989392 FIG00989394: hypothetical protein +FIG00989401 FIG00989403: hypothetical protein +FIG00989403 FIG00989404: hypothetical protein +FIG00989404 chain length determinant protein +FIG00989420 FIG00989424: hypothetical protein +FIG00989440 FIG00989441: hypothetical protein +FIG00989441 FIG00989449: hypothetical protein +FIG00989452 FIG00989456: hypothetical protein +FIG00989456 Haloacid dehalogenase, type II (EC 3.8.1.2) +FIG00989458 FIG00989459: hypothetical protein +FIG00989461 FIG00989468: hypothetical protein +FIG00989474 FIG00989476: hypothetical protein +FIG00989476 FIG00989477: hypothetical protein +FIG00989477 FIG00989479: hypothetical protein +FIG00989479 FIG00989481: hypothetical protein +FIG00989485 FIG00989487: hypothetical protein +FIG00989487 FIG00989489: hypothetical protein +FIG00989495 FIG00989496: hypothetical protein +FIG00989496 FIG00989497: hypothetical protein +FIG00989498 FIG00989504: hypothetical protein +FIG00989506 FIG00989507: hypothetical protein +FIG00989518 FIG01027884: hypothetical protein +FIG00989520 FIG00989523: hypothetical protein +FIG00989530 FIG00989533: hypothetical protein +FIG00989534 FIG00989535: hypothetical protein +FIG00989538 FIG00989539: hypothetical protein +FIG00989539 FIG00989541: hypothetical protein +FIG00989550 FIG00989552: hypothetical protein +FIG00989553 FIG00989555: hypothetical protein +FIG00989555 FIG00989556: hypothetical protein +FIG00989556 FIG00989557: hypothetical protein +FIG00989557 FIG00989558: hypothetical protein +FIG00989559 FIG00989561: hypothetical protein +FIG00989561 FIG00989566: hypothetical protein +FIG00989568 FIG00989580: hypothetical protein +FIG00989582 FIG00989584: hypothetical protein +FIG00989592 FIG00989598: hypothetical protein +FIG00989598 Pirin domain protein +FIG00989605 FIG00989609: hypothetical protein +FIG00989618 FIG00989619: hypothetical protein +FIG00989620 FIG00989624: hypothetical protein +FIG00989624 FIG00989629: hypothetical protein +FIG00989637 FIG00989639: hypothetical protein +FIG00989639 FIG00989643: hypothetical protein +FIG00989646 FIG00989648: hypothetical protein +FIG00989651 FIG00989653: hypothetical protein +FIG00989655 FIG01024363: hypothetical protein +FIG00989659 methyl accepting chemotaxis protein +FIG00989663 FIG00989664: hypothetical protein +FIG00989671 FIG00989673: hypothetical protein +FIG00989679 FIG00989681: hypothetical protein +FIG00989681 FIG00989688: hypothetical protein +FIG00989688 FIG00989689: hypothetical protein +FIG00989689 FIG00989696: hypothetical protein +FIG00989704 FIG00989705: hypothetical protein +FIG00989705 FIG00989707: hypothetical protein +FIG00989707 FIG00989708: hypothetical protein +FIG00989708 FIG00989711: hypothetical protein +FIG00989722 FIG00989723: hypothetical protein +FIG00989724 Xaa-Pro aminopeptidase (EC 3.4.13.9) +FIG00989725 FIG00989727: hypothetical protein +FIG00989728 Putative glutathione transporter, ATP-binding component +FIG00989733 FIG00989734: hypothetical protein +FIG00989737 FIG00989738: hypothetical protein +FIG00989738 FIG00989743: hypothetical protein +FIG00989743 FIG00989746: hypothetical protein +FIG00989754 FIG00989756: hypothetical protein +FIG00989756 FIG00989761: hypothetical protein +FIG00989761 FIG00989762: hypothetical protein +FIG00989764 FIG00989765: hypothetical protein +FIG00989765 FIG00989766: hypothetical protein +FIG00989768 FIG00989770: hypothetical protein +FIG00989774 FIG00989777: hypothetical protein +FIG00989777 Hydrogenase maturation factor HoxV/HupK +FIG00989779 FIG00989786: hypothetical protein +FIG00989795 hypothetical protein +FIG00989796 FIG00989799: hypothetical protein +FIG00989800 FIG00989801: hypothetical protein +FIG00989801 FIG00989805: hypothetical protein +FIG00989809 FIG00989813: hypothetical protein +FIG00989817 FIG00989823: hypothetical protein +FIG00989823 FIG00989824: hypothetical protein +FIG00989829 FIG00989832: hypothetical protein +FIG00989832 FIG00989834: hypothetical protein +FIG00989837 FIG00989841: hypothetical protein +FIG00989842 FIG00989843: hypothetical protein +FIG00989847 FIG00989848: hypothetical protein +FIG00989851 FIG00989855: hypothetical protein +FIG00989855 FIG00989856: hypothetical protein +FIG00989863 FIG00989865: hypothetical protein +FIG00989870 FIG00989872: hypothetical protein +FIG00989889 FIG00989898: hypothetical protein +FIG00989909 FIG00989912: hypothetical protein +FIG00989913 FIG00989917: hypothetical protein +FIG00989928 Type I secretion target repeat protein +FIG00989941 Putative glucosamine-fructose-6-phosphate aminotransferase +FIG00989946 Parallel beta-helix repeat protein +FIG00989947 FIG00989948: hypothetical protein +FIG00989948 FIG00989958: hypothetical protein +FIG00989958 FIG00989959: hypothetical protein +FIG00989963 FIG00989965: hypothetical protein +FIG00989965 FIG00989968: hypothetical protein +FIG00989972 FIG00989973: hypothetical protein +FIG00989973 Putative Glutathione S-transferase( EC:2.5.1.18 ) +FIG00989979 FIG00989990: hypothetical protein +FIG00989992 FIG00989995: hypothetical protein +FIG00989999 FIG00990001: hypothetical protein +FIG00990001 FIG00990002: hypothetical protein +FIG00990002 FIG00990003: hypothetical protein +FIG00990004 Putative signal peptide protein +FIG00990005 FIG00990014: hypothetical protein +FIG00990014 FIG00990015: hypothetical protein +FIG00990016 FIG00990020: hypothetical protein +FIG00990030 FIG00990037: hypothetical protein +FIG00990037 FIG00990038: hypothetical protein +FIG00990042 Salt-stress induced outer membrane protein +FIG00990051 FIG00990053: hypothetical protein +FIG00990053 FIG00990056: hypothetical protein +FIG00990057 FIG00990059: hypothetical protein +FIG00990061 FIG00990063: hypothetical protein +FIG00990063 Putative glutathionylspermidine synthase +FIG00990070 malonate transporter +FIG00990083 FIG00990084: hypothetical protein +FIG00990084 FIG00990085: hypothetical protein +FIG00990087 FIG00990089: hypothetical protein +FIG00990089 Probable permease of ABC sugar transporter +FIG00990090 FIG00990095: hypothetical protein +FIG00990101 FIG00990103: hypothetical protein +FIG00990107 FIG00990109: hypothetical protein +FIG00990114 FIG00990115: hypothetical protein +FIG00990115 FIG00990125: hypothetical protein +FIG00990125 FIG00990127: hypothetical protein +FIG00990127 FIG00990129: hypothetical protein +FIG00990133 FIG00990134: hypothetical protein +FIG00990134 Putative lipase/esterase +FIG00990138 S-adenosylmethionine:2-demethylmenaquinone methyltransferase (EC 2.1.-.-) +FIG00990141 FIG00990145: hypothetical protein +FIG00990147 FIG00990148: hypothetical protein +FIG00990148 FIG00990149: hypothetical protein +FIG00990150 (acyl-carrier-protein) S-malonyltransferase +FIG00990151 FIG00990152: hypothetical protein +FIG00990158 conserved hypothetical outer membrane protein +FIG00990178 FIG00990179: hypothetical protein +FIG00990179 FIG00990180: hypothetical protein +FIG00990181 FIG00990185: hypothetical protein +FIG00990187 FIG00990188: hypothetical protein +FIG00990201 FIG00990204: hypothetical protein +FIG00990213 Endoglucanase H (EC 3.2.1.4) +FIG00990246 Short-chain dehydrogenase/reductase (EC 1.1.1.69) +FIG00990248 FIG00990251: hypothetical protein +FIG00990252 FIG00990256: hypothetical protein +FIG00990263 FIG00990266: hypothetical protein +FIG00990266 FIG00990267: hypothetical protein +FIG00990276 Putative FlgM, negative regulator of flagellin synthesis +FIG00990279 FIG00990283: hypothetical protein +FIG00990290 FIG00990291: hypothetical protein +FIG00990291 NAD synthetase (EC 6.3.1.5) homolohg with insertion +FIG00990295 FIG00990297: hypothetical protein +FIG00990312 FIG00990314: hypothetical protein +FIG00990334 Soluble lytic murein transglycosylase and related regulatory proteins (some contain LysM/invasin domains) +FIG00990341 FIG00990344: hypothetical protein +FIG00990357 FIG00990358: hypothetical protein +FIG00990370 MT-A70 family protein +FIG00990374 4-carboxy-4-hydroxy-2-oxoadipate aldolase (EC 4.1.3.17) +FIG00990376 FIG00990378: hypothetical protein +FIG00990390 FIG00990392: hypothetical protein +FIG00990393 FIG00990396: hypothetical protein +FIG00990398 FIG00990407: hypothetical protein +FIG00990412 FIG00990413: hypothetical protein +FIG00990419 FIG00990420: hypothetical protein +FIG00990430 FIG00990432: hypothetical protein +FIG00990438 FIG00990439: hypothetical protein +FIG00990450 FIG00990459: hypothetical protein +FIG00990459 ABC peptide transporter, periplasmic binding protein +FIG00990465 PRC-barrel domain protein +FIG00990467 FIG00990472: hypothetical protein +FIG00990472 FIG00990474: hypothetical protein +FIG00990474 FIG00990477: hypothetical protein +FIG00990481 gas vesicle synthesis GvpLGvpF +FIG00990503 Glutamate/glutamine/aspartate/asparagine ABC transporter, ATP-binding protein +FIG00990508 Putative transporter, major facilitator superfamily (MFS) +FIG00990517 FIG00990519: hypothetical protein +FIG00990543 FliK, flagellar hook-length control protein +FIG00990556 FIG00990557: hypothetical protein +FIG00990563 GLUCOSE ABC TRANSPORTER ATPASE +FIG00990571 FIG00990572: hypothetical protein +FIG00990586 FIG00990588: hypothetical protein +FIG00990588 FIG00990592: hypothetical protein +FIG00990598 putative serine/alanine racemase VanTc3 +FIG00990609 FIG00990610: hypothetical protein +FIG00990617 Immune-responsive protein 1 +FIG00990632 FIG00990633: hypothetical protein +FIG00990633 FIG00990636: hypothetical protein +FIG00990641 FIG00990642: hypothetical protein +FIG00990644 FIG00990645: hypothetical protein +FIG00990653 FIG00990654: hypothetical protein +FIG00990654 FIG00990655: hypothetical protein +FIG00990656 FIG00990662: hypothetical protein +FIG00990663 FIG00990665: hypothetical protein +FIG00990685 FIG00990686: hypothetical protein +FIG00990689 FIG00990691: hypothetical protein +FIG00990692 FIG00990695: hypothetical protein +FIG00990699 FIG00990701: hypothetical protein +FIG00990701 FIG00990706: hypothetical protein +FIG00990706 FIG00990707: hypothetical protein +FIG00990707 FIG00990709: hypothetical protein +FIG00990730 Autoinducer-binding transcriptional regulator, LuxR family +FIG00990740 FIG00990744: hypothetical protein +FIG00990751 FIG00990753: hypothetical protein +FIG00990765 Type I site-specific restriction-modification system, R (restriction) subunit and related helicases +FIG00990773 putative RhtB family transporter +FIG00990797 FIG00990803: hypothetical protein +FIG00990805 Ribosomal protein L2 +FIG00990808 FIG00990809: hypothetical protein +FIG00990810 FIG00990813: hypothetical protein +FIG00990813 FIG00990814: hypothetical protein +FIG00990814 FIG00990816: hypothetical protein +FIG00990828 FIG00990834: hypothetical protein +FIG00990841 Photoactive yellow protein (PYP) +FIG00990846 FIG00990847: hypothetical protein +FIG00990847 FIG00990849: hypothetical protein +FIG00990853 FIG00990854: hypothetical protein +FIG00990854 Ceramide glucosyltransferase +FIG00990863 phage related lysozyme +FIG00990866 FIG00990867: hypothetical protein +FIG00990867 FIG00990870: hypothetical protein +FIG00990870 FIG00991545: hypothetical protein +FIG00990886 FIG00990891: hypothetical protein +FIG00990894 Peptide/opine/nickel uptake family ABC transporter, ATP-binding protein +FIG00990899 FIG00990902: hypothetical protein +FIG00990902 FIG00990903: hypothetical protein +FIG00990906 FIG00990910: hypothetical protein +FIG00990910 FIG00990912: hypothetical protein +FIG00990912 FIG00990916: hypothetical protein +FIG00990918 FIG00990926: hypothetical protein +FIG00990934 FIG00990937: hypothetical protein +FIG00990937 putative ceramide glucosyltransferase +FIG00990949 EpsK domain protein +FIG00990951 FIG00990954: hypothetical protein +FIG00990954 FIG00990956: hypothetical protein +FIG00990956 FIG00990961: hypothetical protein +FIG00990963 FIG00990964: hypothetical protein +FIG00990964 FIG00990970: hypothetical protein +FIG00990970 FIG00990972: hypothetical protein +FIG00990973 glycosyltransferase, group 1 +FIG00991018 Phospholipase D/Transphosphatidylase (EC 3.1.4.4) +FIG00991022 FIG00991023: hypothetical protein +FIG00991028 FIG00991034: hypothetical protein +FIG00991034 FIG00991035: hypothetical protein +FIG00991051 FIG00991052: hypothetical protein +FIG00991052 flagellar protein FlaF, putative +FIG00991057 FIG00991064: hypothetical protein +FIG00991064 ABC transporter, inner membrane subunit +FIG00991078 FIG00991081: hypothetical protein +FIG00991091 FIG00991092: hypothetical protein +FIG00991092 hypothetical protein +FIG00991095 FIG00991100: hypothetical protein +FIG00991104 FIG00991105: hypothetical protein +FIG00991124 FIG00991127: hypothetical protein +FIG00991127 FIG00991129: hypothetical protein +FIG00991137 Peptide methionine sulfoxide reductase msrA 2 (EC 1.8.4.11) (Protein-methionine-S-oxide reductase 2) (Peptide-methionine (S)-S-oxide reductase 2) (Peptide Met(O) reductase 2) +FIG00991148 FIG00991150: hypothetical protein +FIG00991192 FIG00991193: hypothetical protein +FIG00991199 Nitrogenase subunit NifH paralog, type 1 +FIG00991200 FIG00991202: hypothetical protein +FIG00991252 FIG00991253: hypothetical protein +FIG00991264 FIG00991265: hypothetical protein +FIG00991274 FIG00991275: hypothetical protein +FIG00991293 FIG00991295: hypothetical protein +FIG00991311 FIG00991313: hypothetical protein +FIG00991330 COG1872 +FIG00991342 FIG00991344: hypothetical protein +FIG00991358 FIG00991360: hypothetical protein +FIG00991360 FIG00991378: hypothetical protein +FIG00991388 1,4-lactonase (EC 3.1.1.25) +FIG00991392 FIG00991394: hypothetical protein +FIG00991404 FIG00991406: hypothetical protein +FIG00991407 FIG00991409: hypothetical protein +FIG00991448 FIG00991449: hypothetical protein +FIG00991483 FIG00991484: hypothetical protein +FIG00991488 FIG00991490: hypothetical protein +FIG00991491 FIG00991504: hypothetical protein +FIG00991504 FIG00991506: hypothetical protein +FIG00991506 FIG00991512: hypothetical protein +FIG00991516 FIG00991518: hypothetical protein +FIG00991519 FIG00991524: hypothetical protein +FIG00991527 ADP-ribosyl-[dinitrogen reductase] glycohydrolase (EC 3.2.2.24) (ADP-ribosylglycohydrolase) (Dinitrogenase reductase-activating glycohydrolase) +FIG00991529 FIG00991532: hypothetical protein +FIG00991555 FIG00991558: hypothetical protein +FIG00991566 FIG00991567: hypothetical protein +FIG00991567 COG1853: Conserved protein/domain typically associated with flavoprotein oxygenases, DIM6/NTAB family +FIG00991568 FIG00991575: hypothetical protein +FIG00991599 FIG00991600: hypothetical protein +FIG00991612 FIG00991624: hypothetical protein +FIG00991629 FIG00991632: hypothetical protein +FIG00991673 FIG00991675: hypothetical protein +FIG00991690 putative ATP-binding protein of a transporter +FIG00991696 antibiotic biosynthesis monooxygenase domain protein +FIG00991735 FIG00991744: hypothetical protein +FIG00991744 TRAP dicarboxylate family transporter, DctQ subunit +FIG00991761 FIG00991762: hypothetical protein +FIG00991762 FIG00991763: hypothetical protein +FIG00991763 FIG00991764: hypothetical protein +FIG00991766 FIG00991770: hypothetical protein +FIG00991788 FIG00991789: hypothetical protein +FIG00991818 FIG00991819: hypothetical protein +FIG00991820 Site-specific DNA methylase +FIG00991841 Acyltransferase 3 family +FIG00991844 Aldehyde dehydrogenase +FIG00991857 Acyl transferase +FIG00991903 FIG00991905: hypothetical protein +FIG00991931 FIG00991934: hypothetical protein +FIG00991937 FIG00991938: hypothetical protein +FIG00991938 protein of unknown function DUF1593 +FIG00991940 FIG00991943: hypothetical protein +FIG00991943 FIG00991951: hypothetical protein +FIG00991975 FIG00991982: hypothetical protein +FIG00992056 Bifunctional acetyltransferase +FIG00992086 FIG00992087: hypothetical protein +FIG00992095 putative tyrosine recombinase +FIG00992105 FIG00992109: hypothetical protein +FIG00992117 FIG00992131: hypothetical protein +FIG00992142 FIG00992147: hypothetical protein +FIG00992147 FIG00992151: hypothetical protein +FIG00992201 Glutamate/glutamine/aspartate/asparagine transport system permease protein bztC +FIG00992211 FIG00992212: hypothetical protein +FIG00992222 FIG00992224: hypothetical protein +FIG00992244 FIG01073358: hypothetical protein +FIG00992253 FIG00992259: hypothetical protein +FIG00992262 Aminotransferase family protein +FIG00992265 FIG00992266: hypothetical protein +FIG00992277 FIG01024218: hypothetical protein +FIG00992289 FIG00992296: hypothetical protein +FIG00992299 FIG00992300: hypothetical protein +FIG00992300 FIG00992302: hypothetical protein +FIG00992302 FIG00992304: hypothetical protein +FIG00992316 FIG00992319: hypothetical protein +FIG00992319 FIG00992330: hypothetical protein +FIG00992347 FIG00992349: hypothetical protein +FIG00992349 FIG00992350: hypothetical protein +FIG00992351 FIG00992352: hypothetical protein +FIG00992365 FIG00992374: hypothetical protein +FIG00992374 Acetolactate synthase +FIG00992384 Methionine synthase II (Cobalamin-independent) (EC 2.1.1.14) +FIG00992385 PPIC-type PPIASE domain protein +FIG00992391 FIG00992397: hypothetical protein +FIG00992399 FIG01024105: hypothetical protein +FIG00992426 FIG00992427: hypothetical protein +FIG00992428 FIG00992429: hypothetical protein +FIG00992429 FIG00992432: hypothetical protein +FIG00992460 FIG00992470: hypothetical protein +FIG00992477 Glycine/D-amino acid oxidases (deaminating) +FIG00992484 COG1872 +FIG00992494 FIG118788: Signal transduction histidine kinase +FIG00992524 FIG00992525: hypothetical protein +FIG00992537 FIG00992540: hypothetical protein +FIG00992583 FIG00992588: hypothetical protein +FIG00992588 FIG00992590: hypothetical protein +FIG00992593 FIG00992595: hypothetical protein +FIG00992599 FIG00992601: hypothetical protein +FIG00992605 FIG01027518: hypothetical protein +FIG00992612 FIG00988203: hypothetical protein +FIG00992618 FIG00992620: hypothetical protein +FIG00992620 Toluene tolerance family protein +FIG00992636 FIG00992637: hypothetical protein +FIG00992653 FIG00992658: hypothetical protein +FIG00992659 FIG00992660: hypothetical protein +FIG00992668 FIG00992672: hypothetical protein +FIG00992672 Beta-ketoacyl synthase family protein +FIG00992681 D-beta-hydroxybutyrate dehydrogenase +FIG00992687 FIG235292: hypothetical protein +FIG00992697 Similar to hypothetical protein DUF454 +FIG00992699 Regulatory protein, MarR +FIG00992705 FIG00992706: hypothetical protein +FIG00992706 FIG00992709: hypothetical protein +FIG00992716 Ethidium bromide-methyl viologen resistance protein EmrE +FIG00992728 Bll0704 protein +FIG00992755 Integrins alpha chain:ASPIC/UnbV +FIG00992778 FIG00992779: hypothetical protein +FIG00992799 FIG00992800: hypothetical protein +FIG00992849 FIG00992850: hypothetical protein +FIG00992900 FIG01143313: hypothetical protein +FIG00992905 FIG00992912: hypothetical protein +FIG00992922 GLYCOSYL TRANSFERASE (EC 2.4.1.-) +FIG00992935 FIG00992937: hypothetical protein +FIG00992944 FIG00992947: hypothetical protein +FIG00992948 FIG00992950: hypothetical protein +FIG00992960 FIG00992962: hypothetical protein +FIG00992969 FIG00992970: hypothetical protein +FIG00992970 FIG00992971: hypothetical protein +FIG00992983 Protein-glutamate methylesterase family protein +FIG00993007 FIG00993009: hypothetical protein +FIG00993009 FIG00993012: hypothetical protein +FIG00993013 FIG00993016: hypothetical protein +FIG00993018 nitrile hydratase beta subunit protein +FIG00993022 FIG00993025: hypothetical protein +FIG00993044 yibQ protein +FIG00993085 FIG00993087: hypothetical protein +FIG00993087 FIG00993088: hypothetical protein +FIG00993088 FIG00993092: hypothetical protein +FIG00993092 FIG00993093: hypothetical protein +FIG00993093 FIG00993095: hypothetical protein +FIG00993113 FIG00993116: hypothetical protein +FIG00993140 FIG00993145: hypothetical protein +FIG00993161 FIG01030975: hypothetical protein +FIG00993170 FIG00993172: hypothetical protein +FIG00993203 FIG00993208: hypothetical protein +FIG00993213 FIG00993214: hypothetical protein +FIG00993214 FIG01073484: hypothetical protein +FIG00993216 FIG00993220: hypothetical protein +FIG00993242 Oxidoreductase, short-chain dehydrogenase/reductase family +FIG00993275 FIG00993277: hypothetical protein +FIG00993297 FIG00993298: hypothetical protein +FIG00993310 FIG00993311: hypothetical protein +FIG00993326 FIG00993335: hypothetical protein +FIG00993342 FIG00993348: hypothetical protein +FIG00993360 FIG00993363: hypothetical protein +FIG00993384 FIG00993386: hypothetical protein +FIG00993396 FIG00993397: hypothetical protein +FIG00993410 COG3393: Predicted acetyltransferase +FIG00993412 FIG00993413: hypothetical protein +FIG00993424 Peptidase M24 +FIG00993425 FIG00993426: hypothetical protein +FIG00993433 FIG00993440: hypothetical protein +FIG00993444 FIG01073555: hypothetical protein +FIG00993450 FIG00993454: hypothetical protein +FIG00993478 Mucoidy inhibitor A +FIG00993496 FIG00993499: hypothetical protein +FIG00993499 FIG01073756: hypothetical protein +FIG00993502 FIG00993503: hypothetical protein +FIG00993545 FIG00993547: hypothetical protein +FIG00993549 FIG00993551: hypothetical protein +FIG00993554 FIG00993560: hypothetical protein +FIG00993568 FIG00993569: hypothetical protein +FIG00993583 putative alpha/beta hydrolase +FIG00993603 FIG01030774: hypothetical protein +FIG00993608 FIG00993610: hypothetical protein +FIG00993617 2-polyprenyl-6-methoxyphenol hydroxylase and related FAD-dependent oxidoreductases +FIG00993669 cytochrome c-554 +FIG00993693 FIG01024266: hypothetical protein +FIG00993718 FIG00993730: hypothetical protein +FIG00993735 FIG00993742: hypothetical protein +FIG00993742 FIG00993744: hypothetical protein +FIG00993806 FIG00993807: hypothetical protein +FIG00993815 FIG00993819: hypothetical protein +FIG00993847 FIG00993852: hypothetical protein +FIG00993855 FIG00993863: hypothetical protein +FIG00993880 FIG00993888: hypothetical protein +FIG00993899 FIG01073443: hypothetical protein +FIG00993939 FIG00993940: hypothetical protein +FIG00993940 FIG00993941: hypothetical protein +FIG00993942 FIG00993947: hypothetical protein +FIG00993950 FIG00993951: hypothetical protein +FIG00993961 FIG00993963: hypothetical protein +FIG00993963 FIG00993970: hypothetical protein +FIG00993971 FIG00993972: hypothetical protein +FIG00993975 FIG00993977: hypothetical protein +FIG00993982 FIG00993983: hypothetical protein +FIG00993991 FIG00993992: hypothetical protein +FIG00993992 FIG00993995: hypothetical protein +FIG00994000 FIG00994001: hypothetical protein +FIG00994001 FIG00994002: hypothetical protein +FIG00994002 FIG00994004: hypothetical protein +FIG00994004 FIG00994006: hypothetical protein +FIG00994017 FIG00994018: hypothetical protein +FIG00994025 FIG00994026: hypothetical protein +FIG00994027 FIG00994028: hypothetical protein +FIG00994034 FIG00994037: hypothetical protein +FIG00994037 FIG00994038: hypothetical protein +FIG00994038 possible ABC Fe(3+) transporter, periplasmic binding protein +FIG00994041 FIG00994042: hypothetical protein +FIG00994042 probable triacylglycerol lipase( EC:3.1.1.3 ) +FIG00994051 FIG00994054: hypothetical protein +FIG00994060 FIG00994061: hypothetical protein +FIG00994061 FIG00994067: hypothetical protein +FIG00994067 FIG00994069: hypothetical protein +FIG00994071 metabolite-proton symporter +FIG00994072 FIG00994073: hypothetical protein +FIG00994073 FIG00994075: hypothetical protein +FIG00994075 FIG00994076: hypothetical protein +FIG00994079 FIG00994083: hypothetical protein +FIG00994083 FIG00994086: hypothetical protein +FIG00994089 FIG00994095: hypothetical protein +FIG00994097 FIG00994098: hypothetical protein +FIG00994100 5-Hydroxyisourate Hydrolase (HIUase) (EC 3.5.2.17) +FIG00994103 FIG00994105: hypothetical protein +FIG00994110 FIG00994111: hypothetical protein +FIG00994111 FIG00994112: hypothetical protein +FIG00994112 FIG00994115: hypothetical protein +FIG00994115 possible universal stress protein +FIG00994119 putative transcriptional regulator family +FIG00994122 FIG00994123: hypothetical protein +FIG00994123 FIG00994690: hypothetical protein +FIG00994128 probable antigen 85 complex protein +FIG00994129 FIG00994131: hypothetical protein +FIG00994134 FIG00994135: hypothetical protein +FIG00994145 FIG00994146: hypothetical protein +FIG00994157 FIG01121868: Possible membrane protein +FIG00994158 FIG00994159: hypothetical protein +FIG00994159 FIG00994160: hypothetical protein +FIG00994160 FIG00994161: hypothetical protein +FIG00994166 FIG00994167: hypothetical protein +FIG00994167 Probable endopeptidase Rv2190c (EC 3.4.-.-) +FIG00994179 FIG00994184: hypothetical protein +FIG00994184 FIG00994185: hypothetical protein +FIG00994187 FIG00994188: hypothetical protein +FIG00994191 FIG00994192: hypothetical protein +FIG00994192 FIG00994193: hypothetical protein +FIG00994194 probable short-chain dehydrogenase/reductase +FIG00994196 FIG00994200: hypothetical protein +FIG00994201 FIG00994202: hypothetical protein +FIG00994203 FIG00994206: hypothetical protein +FIG00994207 possible ABC sulfonate transporter, substrate binding component +FIG00994210 FIG00994212: hypothetical protein +FIG00994214 FIG00994215: hypothetical protein +FIG00994218 FIG00994221: hypothetical protein +FIG00994233 FIG00994234: hypothetical protein +FIG00994235 FIG00994237: hypothetical protein +FIG00994239 FIG00994240: hypothetical protein +FIG00994241 possible peptidase of M23/37 family +FIG00994246 FIG00994247: hypothetical protein +FIG00994256 FIG00994259: hypothetical protein +FIG00994265 FIG00994266: hypothetical protein +FIG00994278 FIG00994280: hypothetical protein +FIG00994280 possible amino acid export carrier protein +FIG00994284 Hypothetical isochorismatase hydrolase +FIG00994287 FIG00994288: hypothetical protein +FIG00994291 FIG00994292: hypothetical protein +FIG00994294 FIG00994295: hypothetical protein +FIG00994296 FIG00994298: hypothetical protein +FIG00994302 FIG00994303: hypothetical protein +FIG00994303 FIG00994304: hypothetical protein +FIG00994309 possible acyltransferase +FIG00994311 FIG00994312: hypothetical protein +FIG00994315 possible transcriptional regulator, AsnC family +FIG00994316 probable siderophore interacting protein +FIG00994319 FIG00999229: probable secreted protein +FIG00994331 lycopene beta cyclase +FIG00994338 FIG00994339: hypothetical protein +FIG00994340 FIG00994341: hypothetical protein +FIG00994358 FIG00994361: hypothetical protein +FIG00994361 possible glutathione transferase +FIG00994371 ABC bifunctional lipid A exporter +FIG00994383 FIG00994384: hypothetical protein +FIG00994384 FIG00994385: hypothetical protein +FIG00994386 FIG00994388: hypothetical protein +FIG00994388 DUF2236 +FIG00994398 FIG00994399: hypothetical protein +FIG00994407 putative ABC transporter ATP-binding protein( EC:3.6.3.34 ) +FIG00994408 FIG00994409: hypothetical protein +FIG00994410 FIG00994412: hypothetical protein +FIG00994412 FIG00994414: hypothetical protein +FIG00994415 FIG00994416: hypothetical protein +FIG00994416 FIG00994419: hypothetical protein +FIG00994419 FIG00994420: hypothetical protein +FIG00994422 FIG00994424: hypothetical protein +FIG00994429 FIG00994430: hypothetical protein +FIG00994433 FIG00994434: hypothetical protein +FIG00994437 FIG00994438: hypothetical protein +FIG00994438 FIG00994439: hypothetical protein +FIG00994439 FIG00994444: hypothetical protein +FIG00994451 FIG00994452: hypothetical protein +FIG00994453 possible protein-tyrosine phosphatase +FIG00994456 FIG00994459: hypothetical protein +FIG00994460 FIG00994462: hypothetical protein +FIG00994462 FIG00994466: hypothetical protein +FIG00994466 FIG00994467: hypothetical protein +FIG00994467 FIG00994468: hypothetical protein +FIG00994468 FIG00994470: hypothetical protein +FIG00994471 FIG00994474: hypothetical protein +FIG00994474 FIG00994475: hypothetical protein +FIG00994475 probable catechol 1,2-dioxygenase +FIG00994477 FIG00994479: hypothetical protein +FIG00994484 FIG00994486: hypothetical protein +FIG00994490 FIG00994491: hypothetical protein +FIG00994492 FIG00994493: hypothetical protein +FIG00994502 FIG00994503: hypothetical protein +FIG00994505 FIG00994507: hypothetical protein +FIG00994507 FIG00994508: hypothetical protein +FIG00994515 FIG00994516: hypothetical protein +FIG00994529 FIG00994530: hypothetical protein +FIG00994531 FIG00994532: hypothetical protein +FIG00994537 FIG00994539: hypothetical protein +FIG00994542 Possible mutator protein MutT3 (7,8-dihydro-8-oxoguanine-triphosphatase) +FIG00994549 3-oxoacyl-(acyl-carrier-protein) synthase III( EC:2.3.1.41 ) +FIG00994557 FIG00994558: hypothetical protein +FIG00994558 fumarate reductase flavoprotein subunit precursor +FIG00994572 FIG00994573: hypothetical protein +FIG00994577 N-acetylmuramoyl-L-alanine amidase +FIG00994583 FIG00994584: hypothetical protein +FIG00994592 FIG00994593: hypothetical protein +FIG00994597 FIG00994598: hypothetical protein +FIG00994606 FIG00994607: hypothetical protein +FIG00994607 FIG00994608: hypothetical protein +FIG00994614 FIG00994615: hypothetical protein +FIG00994618 FIG00994620: hypothetical protein +FIG00994625 FIG00994626: hypothetical protein +FIG00994627 FIG00994629: hypothetical protein +FIG00994636 FIG00994637: hypothetical protein +FIG00994637 FIG00994638: hypothetical protein +FIG00994640 FIG00994642: hypothetical protein +FIG00994644 FIG00994645: hypothetical protein +FIG00994645 FIG00994646: hypothetical protein +FIG00994646 possible secreted copper binding protein +FIG00994651 FIG00994654: hypothetical protein +FIG00994654 FIG00994655: hypothetical protein +FIG00994657 limonene-1,2-epoxide hydrolase( EC:3.3.2.8 ) +FIG00994662 FIG00994664: hypothetical protein +FIG00994665 FIG00994669: hypothetical protein +FIG00994669 FIG00994670: hypothetical protein +FIG00994682 FIG00994683: hypothetical protein +FIG00994683 HIT family protein +FIG00994685 FIG00994687: hypothetical protein +FIG00994687 FIG00994689: hypothetical protein +FIG00994704 predicted endonuclease +FIG00994713 FIG00994714: hypothetical protein +FIG00994717 FIG00994718: hypothetical protein +FIG00994723 FIG00994725: hypothetical protein +FIG00994725 FIG00994726: hypothetical protein +FIG00994727 FIG00994730: hypothetical protein +FIG00994736 FIG00525068: membrane protein +FIG00994739 FIG00994741: hypothetical protein +FIG00994741 FIG00994742: hypothetical protein +FIG00994745 possible ethyl tert-butyl ether degradation protein EthD +FIG00994749 FIG00994752: hypothetical protein +FIG00994760 FIG00994761: hypothetical protein +FIG00994761 FIG00994763: hypothetical protein +FIG00994763 FIG00994764: hypothetical protein +FIG00994764 FIG00994766: hypothetical protein +FIG00994766 FIG00994767: hypothetical protein +FIG00994768 FIG00994769: hypothetical protein +FIG00994771 FIG00994772: hypothetical protein +FIG00994772 possible antigenic 85 complex protein +FIG00994775 FIG00994776: hypothetical protein +FIG00994779 FIG00994782: hypothetical protein +FIG00994788 FIG00994790: hypothetical protein +FIG00994790 Hypothetical protein YgaF +FIG00994794 TrkA-N domain protein +FIG00994808 FIG00994809: hypothetical protein +FIG00994813 FIG00994814: hypothetical protein +FIG00994819 possible amino acid permease +FIG00994823 probable carbohydrate diacid regulator +FIG00994828 putative hydroxyacid aldolase +FIG00994840 FIG00994841: hypothetical protein +FIG00994841 FIG00994842: hypothetical protein +FIG00994842 FIG00994845: hypothetical protein +FIG00994853 Thiocyanate hydrolase beta subunit (EC 3.5.5.8) +FIG00994858 FIG00994859: hypothetical protein +FIG00994860 probable aromatic ring hydroxylase +FIG00994863 FIG00994864: hypothetical protein +FIG00994866 probable flavohemoprotein +FIG00994869 FIG00994871: hypothetical protein +FIG00994875 FIG00994876: hypothetical protein +FIG00994876 FIG00994878: hypothetical protein +FIG00994894 FIG00994896: hypothetical protein +FIG00994896 FIG00994898: hypothetical protein +FIG00994899 FIG00994902: hypothetical protein +FIG00994907 FIG00994909: hypothetical protein +FIG00994917 FIG00994918: hypothetical protein +FIG00994920 FIG00994922: hypothetical protein +FIG00994928 FIG00994929: hypothetical protein +FIG00994931 FIG00994934: hypothetical protein +FIG00994934 FIG00994935: hypothetical protein +FIG00994935 FIG00994936: hypothetical protein +FIG00994937 Lipase LipV +FIG00994941 FIG00994944: hypothetical protein +FIG00994944 FIG00994947: hypothetical protein +FIG00994950 FIG00994951: hypothetical protein +FIG00994951 ABC amino acid transporter, ATPase component +FIG00994955 formamidase +FIG00994958 FIG00994959: hypothetical protein +FIG00994959 probable chloride peroxidase( EC:1.11.1.10 ) +FIG00994981 FIG00994982: hypothetical protein +FIG00994983 FIG00994984: hypothetical protein +FIG00994990 FIG00994991: hypothetical protein +FIG00994994 FIG00994996: hypothetical protein +FIG00994997 FIG00994998: hypothetical protein +FIG00994999 FIG00995003: hypothetical protein +FIG00995003 FIG00995004: hypothetical protein +FIG00995007 FIG00995008: hypothetical protein +FIG00995019 Transcriptional regulator, TetR family +FIG00995024 Probable sugar efflux transporter, MFS superfamily protein +FIG00995029 FIG00995030: hypothetical protein +FIG00995030 FIG00995032: hypothetical protein +FIG00995034 FIG00995035: hypothetical protein +FIG00995035 FIG00995036: hypothetical protein +FIG00995044 FIG00995049: hypothetical protein +FIG00995050 FIG00995052: hypothetical protein +FIG00995052 FIG00995055: hypothetical protein +FIG00995056 possible short chain dehydrogenase +FIG00995065 FIG00995068: hypothetical protein +FIG00995068 FIG00995069: hypothetical protein +FIG00995072 possible BFD-like [2Fe-2S]-binding protein +FIG00995076 FIG00995077: hypothetical protein +FIG00995084 FIG00995085: hypothetical protein +FIG00995085 FIG00995087: hypothetical protein +FIG00995087 FIG00995093: hypothetical protein +FIG00995104 FIG00995105: hypothetical protein +FIG00995107 putative glutamate transporter +FIG00995114 probable bacterial lipocalin protein +FIG00995119 putative HpcE protein +FIG00995123 FIG00995124: hypothetical protein +FIG00995133 FIG00995134: hypothetical protein +FIG00995140 FIG00995144: hypothetical protein +FIG00995144 enterochelin esterase +FIG00995145 FIG00995146: hypothetical protein +FIG00995149 FIG00995151: hypothetical protein +FIG00995161 FIG00995162: hypothetical protein +FIG00995164 probable multidrug resistance transporter, MFS superfamily +FIG00995166 FIG00995167: hypothetical protein +FIG00995172 FIG00995173: hypothetical protein +FIG00995173 FIG00995174: hypothetical protein +FIG00995174 probable ferritin +FIG00995176 FIG00995179: hypothetical protein +FIG00995197 FIG00995201: hypothetical protein +FIG00995201 FIG00995202: hypothetical protein +FIG00995206 FIG00995208: hypothetical protein +FIG00995208 possible 3-demethylubiquinone-9 3-methyltransferase +FIG00995211 FIG00995215: hypothetical protein +FIG00995215 FIG00995216: hypothetical protein +FIG00995216 FIG00995219: hypothetical protein +FIG00995219 possible enoyl-CoA hydratase +FIG00995230 drug transporter, putative +FIG00995231 FIG00995232: hypothetical protein +FIG00995232 probable 85 complex protein, A85 antigen family +FIG00995233 FIG00995236: hypothetical protein +FIG00995236 FIG00995237: hypothetical protein +FIG00995250 FIG00995251: hypothetical protein +FIG00995251 FIG022958: hypothetical protein +FIG00995255 FIG00995257: hypothetical protein +FIG00995257 FIG00995258: hypothetical protein +FIG00995258 FIG00995259: hypothetical protein +FIG00995259 FIG00995260: hypothetical protein +FIG00995260 FIG00995261: hypothetical protein +FIG00995266 FIG00995267: hypothetical protein +FIG00995267 FIG00995268: hypothetical protein +FIG00995280 FIG00995287: hypothetical protein +FIG00995287 FIG00995290: hypothetical protein +FIG00995295 FIG00995300: hypothetical protein +FIG00995300 ring hydroxylating dioxygenase, large subunit of terminal oxygenase +FIG00995305 FIG00995306: hypothetical protein +FIG00995306 FIG00995307: hypothetical protein +FIG00995307 FIG00995308: hypothetical protein +FIG00995308 FIG00995310: hypothetical protein +FIG00995316 FIG00995318: hypothetical protein +FIG00995318 FIG00995319: hypothetical protein +FIG00995319 FIG00995320: hypothetical protein +FIG00995320 FIG00995323: hypothetical protein +FIG00995323 FIG00995327: hypothetical protein +FIG00995327 FIG00995328: hypothetical protein +FIG00995328 FIG00995330: hypothetical protein +FIG00995335 FIG00995337: hypothetical protein +FIG00995340 FIG00995345: hypothetical protein +FIG00995347 putative ABC transporter ATP-binding protein +FIG00995355 FIG00995358: hypothetical protein +FIG00995359 Molybdopterin-guanine dinucleotide biosynthesis protein MobA / Molybdopterin biosynthesis protein MoeA +FIG00995362 FIG00995363: hypothetical protein +FIG00995369 probable nitrilotriacetate monooxygenase component B +FIG00995371 FIG00995375: hypothetical protein +FIG00995380 FIG00995381: hypothetical protein +FIG00995386 FIG00995391: hypothetical protein +FIG00995391 FIG00995392: hypothetical protein +FIG00995392 FIG00995396: hypothetical protein +FIG00995399 FIG00995403: hypothetical protein +FIG00995403 FIG00995404: hypothetical protein +FIG00995412 Cytochrome-C3 hydrogenase alpha chain +FIG00995418 FIG00995422: hypothetical protein +FIG00995428 FIG00995429: hypothetical protein +FIG00995429 FIG00995432: hypothetical protein +FIG00995432 FIG00995433: hypothetical protein +FIG00995438 copper-binding protein +FIG00995439 5-amino-6-(5-phosphoribosylamino)uracil reductase (EC 1.1.1.193) homolog +FIG00995445 FIG00995447: hypothetical protein +FIG00995448 FIG00995449: hypothetical protein +FIG00995449 FIG00995451: hypothetical protein +FIG00995454 FIG00995455: hypothetical protein +FIG00995456 Lipoprotein LprB +FIG00995460 FIG00995463: hypothetical protein +FIG00995463 FIG00995465: hypothetical protein +FIG00995466 FIG00995468: hypothetical protein +FIG00995468 FIG00995469: hypothetical protein +FIG00995469 FIG00995475: hypothetical protein +FIG00995477 FIG00995478: hypothetical protein +FIG00995484 FIG00995485: hypothetical protein +FIG00995493 FIG00995494: hypothetical protein +FIG00995494 FIG00995496: hypothetical protein +FIG00995502 FIG00995503: hypothetical protein +FIG00995505 ACR285Cp +FIG00995512 FIG00995514: hypothetical protein +FIG00995514 FIG00995516: hypothetical protein +FIG00995516 FIG00995521: hypothetical protein +FIG00995521 FIG00995525: hypothetical protein +FIG00995525 FIG00995527: hypothetical protein +FIG00995530 FIG00995531: hypothetical protein +FIG00995531 FIG00995532: hypothetical protein +FIG00995534 FIG00995536: hypothetical protein +FIG00995540 FIG00995542: hypothetical protein +FIG00995542 FIG00995543: hypothetical protein +FIG00995543 FIG00995544: hypothetical protein +FIG00995546 FIG00995551: hypothetical protein +FIG00995552 FIG00995557: hypothetical protein +FIG00995557 FIG00995560: hypothetical protein +FIG00995562 FIG00995564: hypothetical protein +FIG00995575 aminoglycoside 6'-N-acetyltransferase( EC:2.3.1.- ) +FIG00995579 FIG00995582: hypothetical protein +FIG00995583 FIG00995584: hypothetical protein +FIG00995586 FIG00995587: hypothetical protein +FIG00995588 FIG00995589: hypothetical protein +FIG00995599 FIG00995600: hypothetical protein +FIG00995600 FIG00995602: hypothetical protein +FIG00995603 Exonuclease RNase T and DNA polymerase III +FIG00995613 FIG00995614: hypothetical protein +FIG00995623 possible lysophospholipase +FIG00995624 FIG00995626: hypothetical protein +FIG00995627 FIG00995628: hypothetical protein +FIG00995628 FIG00995629: hypothetical protein +FIG00995629 FIG00995631: hypothetical protein +FIG00995637 FIG00995638: hypothetical protein +FIG00995638 FIG00995640: hypothetical protein +FIG00995640 FIG00995642: hypothetical protein +FIG00995651 FIG00995652: hypothetical protein +FIG00995652 FIG00995654: hypothetical protein +FIG00995654 FIG00995655: hypothetical protein +FIG00995664 type I phosphodiesterase/nucleotide pyrophosphatase +FIG00995674 FIG00995676: hypothetical protein +FIG00995680 FIG00995681: hypothetical protein +FIG00995693 FIG00995695: hypothetical protein +FIG00995695 FIG00995700: hypothetical protein +FIG00995700 FIG00995702: hypothetical protein +FIG00995702 FIG00995703: hypothetical protein +FIG00995703 FIG00995704: hypothetical protein +FIG00995709 Sulfotransferase +FIG00995710 sodium:solute symporter, SSF +FIG00995723 FIG00995724: hypothetical protein +FIG00995725 FIG00995728: hypothetical protein +FIG00995728 FIG00995729: hypothetical protein +FIG00995729 probable camphor resistance CrcB protein +FIG00995732 FIG00995734: hypothetical protein +FIG00995736 FIG00995737: hypothetical protein +FIG00995746 FIG00995748: hypothetical protein +FIG00995763 FIG00995764: hypothetical protein +FIG00995765 Ergothioneine biosynthesis protein EgtC +FIG00995768 possible transcriptional regulator, MarR family +FIG00995776 FIG00995777: hypothetical protein +FIG00995778 FIG00995779: hypothetical protein +FIG00995784 possible ferredoxin +FIG00995791 FIG00995793: hypothetical protein +FIG00995796 FIG00995797: hypothetical protein +FIG00995797 Heat shock protein 22.5 (Hsp22.5) +FIG00995798 FIG00995800: hypothetical protein +FIG00995805 FIG00995808: hypothetical protein +FIG00995810 putative acyl carrier protein phosphodiesterase 1 (ACP phosphodiesterase 1)( EC:3.1.4.14 ) +FIG00995815 FIG00995816: hypothetical protein +FIG00995816 FIG00995818: hypothetical protein +FIG00995832 FIG00995833: hypothetical protein +FIG00995839 transcriptional regulator, CarD-like regulator +FIG00995841 FIG00995842: hypothetical protein +FIG00995843 FIG00995845: hypothetical protein +FIG00995845 FIG00995846: hypothetical protein +FIG00995847 FIG00995849: hypothetical protein +FIG00995849 FIG00995850: hypothetical protein +FIG00995850 FIG00995852: hypothetical protein +FIG00995856 FIG00995857: hypothetical protein +FIG00995862 FIG00995863: hypothetical protein +FIG00995863 FIG00995864: hypothetical protein +FIG00995866 FIG00995867: hypothetical protein +FIG00995889 large subunit aromatic oxygenase +FIG00995896 FIG00995897: hypothetical protein +FIG00995900 FIG00995901: hypothetical protein +FIG00995901 FIG00995902: hypothetical protein +FIG00995902 FIG00995905: hypothetical protein +FIG00995905 FIG00995907: hypothetical protein +FIG00995908 FIG00995910: hypothetical protein +FIG00995913 FIG00995914: hypothetical protein +FIG00995919 FIG00995920: hypothetical protein +FIG00995926 oxidoreductase, 2OG-Fe(II) oxygenase family protein +FIG00995928 FIG00995930: hypothetical protein +FIG00995931 Hydrolase, alpha/beta fold family +FIG00995938 ATP-dependent helicase +FIG00995940 FIG00995941: hypothetical protein +FIG00995948 FIG00995950: hypothetical protein +FIG00995950 FIG004853: possible toxin to DivIC +FIG00995955 Methyltransferase (EC 2.1.1.-) +FIG00995960 FIG00995961: hypothetical protein +FIG00995961 FIG00995962: hypothetical protein +FIG00995963 FIG00995967: hypothetical protein +FIG00995967 FIG00995968: hypothetical protein +FIG00995968 FIG00995972: hypothetical protein +FIG00995972 acyl-[acyl-carrier protein] desaturase( EC:1.14.19.2 ) +FIG00995980 FIG00995982: hypothetical protein +FIG00995983 FIG00995984: hypothetical protein +FIG00995984 FIG00995989: hypothetical protein +FIG00995990 FIG00995995: hypothetical protein +FIG00995999 FIG00996000: hypothetical protein +FIG00996000 POSSIBLE CONSERVED SECRETED PROTEIN +FIG00996006 FIG00996007: hypothetical protein +FIG00996017 protein of unknown function DUF742 +FIG00996024 FIG00996025: hypothetical protein +FIG00996028 FIG00996032: hypothetical protein +FIG00996037 Probable acyl-ACP desaturase, Stearoyl-ACP desaturase (EC 1.14.19.2) +FIG00996038 FIG00996039: hypothetical protein +FIG00996041 FIG00996042: hypothetical protein +FIG00996042 FIG00996044: hypothetical protein +FIG00996050 FIG00996051: hypothetical protein +FIG00996051 FIG00996054: hypothetical protein +FIG00996054 FIG00996055: hypothetical protein +FIG00996067 FIG00996068: hypothetical protein +FIG00996068 possible transcriptional regulator, TetR family +FIG00996080 FIG00996084: hypothetical protein +FIG00996084 Isoniazid inductible protein IniA +FIG00996085 probable lipase +FIG00996086 FIG00996087: hypothetical protein +FIG00996092 FIG00996093: hypothetical protein +FIG00996094 probable transcriptional regulator, MarR family +FIG00996095 FIG00996096: hypothetical protein +FIG00996096 FIG00996098: hypothetical protein +FIG00996102 FIG00996104: hypothetical protein +FIG00996105 FIG00996106: hypothetical protein +FIG00996107 FIG00996109: hypothetical protein +FIG00996109 FIG00996111: hypothetical protein +FIG00996118 FIG00996121: hypothetical protein +FIG00996124 FIG00996125: hypothetical protein +FIG00996126 RarD protein +FIG00996134 FIG00996135: hypothetical protein +FIG00996135 FIG00996136: hypothetical protein +FIG00996136 FIG00996138: hypothetical protein +FIG00996138 FIG00996139: hypothetical protein +FIG00996139 FIG00996142: hypothetical protein +FIG00996143 FIG00996144: hypothetical protein +FIG00996144 FIG00996145: hypothetical protein +FIG00996145 FIG00996146: hypothetical protein +FIG00996146 FIG00996147: hypothetical protein +FIG00996147 FIG00996149: hypothetical protein +FIG00996149 FIG00996152: hypothetical protein +FIG00996172 FIG00996173: hypothetical protein +FIG00996176 FIG00996178: hypothetical protein +FIG00996178 FIG00996179: hypothetical protein +FIG00996179 FIG00996180: hypothetical protein +FIG00996180 FIG00996181: hypothetical protein +FIG00996188 FIG00996189: hypothetical protein +FIG00996189 FIG00996192: hypothetical protein +FIG00996193 FIG00996194: hypothetical protein +FIG00996199 FIG00996200: hypothetical protein +FIG00996206 FIG00996207: hypothetical protein +FIG00996207 FIG00996208: hypothetical protein +FIG00996209 FIG00996210: hypothetical protein +FIG00996211 FIG00996213: hypothetical protein +FIG00996213 FIG00996214: hypothetical protein +FIG00996215 FIG00996217: hypothetical protein +FIG00996218 FIG00996219: hypothetical protein +FIG00996219 FIG00996220: hypothetical protein +FIG00996220 FIG00996222: hypothetical protein +FIG00996245 FIG00996246: hypothetical protein +FIG00996246 FIG00996248: hypothetical protein +FIG00996256 FIG00996257: hypothetical protein +FIG00996257 FIG00996259: hypothetical protein +FIG00996260 FIG00996261: hypothetical protein +FIG00996262 FIG00996263: hypothetical protein +FIG00996263 Transcriptional regulator, BlaI family +FIG00996264 FIG00996265: hypothetical protein +FIG00996275 FIG00996276: hypothetical protein +FIG00996280 FIG00996283: hypothetical protein +FIG00996283 FIG00996285: hypothetical protein +FIG00996285 FIG00996289: hypothetical protein +FIG00996291 FIG00996292: hypothetical protein +FIG00996293 FIG00996294: hypothetical protein +FIG00996296 FIG00996297: hypothetical protein +FIG00996297 FIG00996298: hypothetical protein +FIG00996298 FIG00996299: hypothetical protein +FIG00996300 FIG00996301: hypothetical protein +FIG00996301 ABC efflux transporter, permease/ATP-binding protein, putative +FIG00996305 FIG00996309: hypothetical protein +FIG00996319 FIG00996320: hypothetical protein +FIG00996322 FIG00996323: hypothetical protein +FIG00996324 FIG00996325: hypothetical protein +FIG00996331 possible 1,4-beta-N-acetylmuramidase +FIG00996332 FIG00996334: hypothetical protein +FIG00996334 FIG00996336: hypothetical protein +FIG00996336 FIG00996340: hypothetical protein +FIG00996345 putative alpha-glucosidase +FIG00996350 FIG00996351: hypothetical protein +FIG00996351 FIG00996354: hypothetical protein +FIG00996354 FIG00996358: hypothetical protein +FIG00996358 putative integral membrane transport protein. +FIG00996359 FIG00996360: hypothetical protein +FIG00996360 FIG00996361: hypothetical protein +FIG00996361 FIG00996362: hypothetical protein +FIG00996362 FIG00996363: hypothetical protein +FIG00996379 FIG00996380: hypothetical protein +FIG00996384 FIG00996386: hypothetical protein +FIG00996392 FIG00996396: hypothetical protein +FIG00996407 FIG00996410: hypothetical protein +FIG00996420 FIG00996421: hypothetical protein +FIG00996427 FIG00996428: hypothetical protein +FIG00996428 PROBABLE LIPOPROTEIN LPPU +FIG00996446 FIG00996447: hypothetical protein +FIG00996455 FIG00996456: hypothetical protein +FIG00996461 FIG00996465: hypothetical protein +FIG00996465 FIG00996466: hypothetical protein +FIG00996471 FIG00996473: hypothetical protein +FIG00996478 FIG00996479: hypothetical protein +FIG00996488 Sensor protein FixL (EC 2.7.3.-) +FIG00996489 possible Mce family protein +FIG00996492 FIG00996495: hypothetical protein +FIG00996495 FIG00996496: hypothetical protein +FIG00996503 FIG00996504: hypothetical protein +FIG00996504 FIG00996505: hypothetical protein +FIG00996505 FIG00996507: hypothetical protein +FIG00996507 FIG00996508: hypothetical protein +FIG00996508 FIG00996509: hypothetical protein +FIG00996512 FIG00996513: hypothetical protein +FIG00996513 FIG00996515: hypothetical protein +FIG00996517 FIG00996518: hypothetical protein +FIG00996522 FIG00996524: hypothetical protein +FIG00996529 FIG00996530: hypothetical protein +FIG00996532 FIG00996533: hypothetical protein +FIG00996539 FIG00996540: hypothetical protein +FIG00996544 FIG00996545: hypothetical protein +FIG00996545 probable transcriptional regulator, LuxR family +FIG00996547 protein-tyrosine-phosphatase( EC:3.1.3.48 ) +FIG00996552 amino acid ABC transporter, permease protein (glnP) +FIG00996554 Peptidase M48, Ste24p precursor +FIG00996556 FIG00996558: hypothetical protein +FIG00996558 FIG00996559: hypothetical protein +FIG00996562 FIG00996563: hypothetical protein +FIG00996565 PROBABLE TETRONASIN-TRANSPORT INTEGRAL MEMBRANE PROTEIN ABC TRANSPORTER +FIG00996566 FIG00996569: hypothetical protein +FIG00996571 FIG00996573: hypothetical protein +FIG00996580 serine protease PepA +FIG00996586 FIG00996588: hypothetical protein +FIG00996588 amino acid transporter, APC family +FIG00996590 FIG00996591: hypothetical protein +FIG00996593 FIG00996594: hypothetical protein +FIG00996616 FIG00996618: hypothetical protein +FIG00996633 FIG00996637: hypothetical protein +FIG00996643 FIG00996647: hypothetical protein +FIG00996647 FIG00996648: hypothetical protein +FIG00996648 FIG00996650: hypothetical protein +FIG00996668 FIG00996669: hypothetical protein +FIG00996670 FIG00996672: hypothetical protein +FIG00996685 FIG00996687: hypothetical protein +FIG00996704 FIG00996707: hypothetical protein +FIG00996708 possible ethanolamine utilization protein EutQ +FIG00996709 probable esterase/ lipase +FIG00996714 FIG00996715: hypothetical protein +FIG00996715 FIG00996715: hypothetical regulatory protein +FIG00996717 FIG00996719: hypothetical protein +FIG00996719 FIG00996720: hypothetical protein +FIG00996723 FIG00996724: hypothetical protein +FIG00996725 FIG00996726: hypothetical protein +FIG00996734 FMN reductase +FIG00996736 FIG00996739: hypothetical protein +FIG00996739 FIG00996741: hypothetical protein +FIG00996741 FIG00996742: hypothetical protein +FIG00996743 comE operon protein 1, putative +FIG00996755 FIG00996757: hypothetical protein +FIG00996758 FIG00996759: hypothetical protein +FIG00996759 FIG00996760: hypothetical protein +FIG00996760 possible inner membrane protein +FIG00996761 FIG00996762: hypothetical protein +FIG00996762 FIG00996763: hypothetical protein +FIG00996763 putative enoyl-CoA hydratase/isomerase family protein +FIG00996765 FIG00996768: hypothetical protein +FIG00996768 FIG00996769: hypothetical protein +FIG00996769 probable protease +FIG00996776 FIG00996777: hypothetical protein +FIG00996787 FIG00996788: hypothetical protein +FIG00996799 FIG00996800: hypothetical protein +FIG00996809 FIG00996810: hypothetical protein +FIG00996810 FIG00996811: hypothetical protein +FIG00996820 FIG00996821: hypothetical protein +FIG00996821 FIG00996822: hypothetical protein +FIG00996822 FIG00996825: hypothetical protein +FIG00996826 FIG00996830: hypothetical protein +FIG00996831 FIG00996836: hypothetical protein +FIG00996836 FIG00996837: hypothetical protein +FIG00996839 ABC transporter, ATP-binding component +FIG00996840 FIG00996844: hypothetical protein +FIG00996844 FIG00996845: hypothetical protein +FIG00996853 FIG00996855: hypothetical protein +FIG00996856 FIG00996858: hypothetical protein +FIG00996858 FIG00996861: hypothetical protein +FIG00996863 FIG00996864: hypothetical protein +FIG00996888 FIG00996890: hypothetical protein +FIG00996890 FIG00996892: hypothetical protein +FIG00996892 FIG00996894: hypothetical protein +FIG00996895 FIG00996896: hypothetical protein +FIG00996911 FIG00996912: hypothetical protein +FIG00996912 FIG00996913: hypothetical protein +FIG00996917 Gas vesicle K +FIG00996926 FIG027937: secreted protein +FIG00996929 probable lipase( EC:3.1.1.3 ) +FIG00996930 FIG00996931: hypothetical protein +FIG00996934 FIG00996937: hypothetical protein +FIG00996939 ArsR-family protein transcriptional regulator +FIG00996940 FIG00996941: hypothetical protein +FIG00996954 FIG00996957: hypothetical protein +FIG00996957 FIG00996959: hypothetical protein +FIG00996962 FIG00996963: hypothetical protein +FIG00996963 FIG00996966: hypothetical protein +FIG00996966 FIG00996967: hypothetical protein +FIG00996967 FIG00996969: hypothetical protein +FIG00996969 FIG00996970: hypothetical protein +FIG00996970 FIG00996973: hypothetical protein +FIG00996974 FIG00996975: hypothetical protein +FIG00996975 FIG00996978: hypothetical protein +FIG00996980 FIG00996983: hypothetical protein +FIG00996983 probable gas vesicle synthesis protein +FIG00996992 FIG00996993: hypothetical protein +FIG00996993 ABC sugar transporter, ATP-binding component +FIG00996997 FIG00996998: hypothetical protein +FIG00996998 FIG00996999: hypothetical protein +FIG00997003 putative ScnA homolog +FIG00997010 probable CysQ protein +FIG00997023 putative glyoxalase family protein +FIG00997025 FIG00997027: hypothetical protein +FIG00997031 FIG00997032: hypothetical protein +FIG00997032 FIG00997034: hypothetical protein +FIG00997034 possible transcriptional regulator, AraC family +FIG00997036 FIG00997037: hypothetical protein +FIG00997037 FIG00997038: hypothetical protein +FIG00997038 FIG00997040: hypothetical protein +FIG00997042 FIG00997044: hypothetical protein +FIG00997045 probable L-gulonolactone oxidase( EC:1.1.3.- ) +FIG00997047 FIG00997049: hypothetical protein +FIG00997053 FIG00997055: hypothetical protein +FIG00997055 possible dicarboxylate carrier protein +FIG00997057 FIG00997058: hypothetical protein +FIG00997058 FIG00997059: hypothetical protein +FIG00997060 FIG00997063: hypothetical protein +FIG00997066 FIG00997067: hypothetical protein +FIG00997067 FIG00997068: hypothetical protein +FIG00997071 FIG00997075: hypothetical protein +FIG00997079 FIG00997081: hypothetical protein +FIG00997088 FIG00997089: hypothetical protein +FIG00997090 dicarboxylate carrier protein +FIG00997093 FIG00997095: hypothetical protein +FIG00997095 FIG00997096: hypothetical protein +FIG00997097 FIG00997098: hypothetical protein +FIG00997098 FIG00997099: hypothetical protein +FIG00997099 FIG00997103: hypothetical protein +FIG00997103 FIG00997105: hypothetical protein +FIG00997108 FIG00997110: hypothetical protein +FIG00997113 FIG00997115: hypothetical protein +FIG00997115 lipoprotein LppV +FIG00997116 FIG00997117: hypothetical protein +FIG00997117 FIG00820527: hypothetical protein +FIG00997123 FIG00997125: hypothetical protein +FIG00997127 FIG00997128: hypothetical protein +FIG00997129 FIG00997136: hypothetical protein +FIG00997137 FIG00997138: hypothetical protein +FIG00997142 putative phosphoglycerate mutase +FIG00997147 C4-dicarboxylate-transport transmembrane protein DctA +FIG00997157 possible chaperone protein +FIG00997164 FIG00997167: hypothetical protein +FIG00997167 FIG00997169: hypothetical protein +FIG00997173 FIG00997174: hypothetical protein +FIG00997177 FIG00997183: hypothetical protein +FIG00997186 ABC Fe(3+)-siderophore binding lipoprotein transporter, periplasmic binding component +FIG00997193 FIG00997195: hypothetical protein +FIG00997195 Lipoprotein LppM +FIG00997209 FIG00997211: hypothetical protein +FIG00997211 FIG00997213: hypothetical protein +FIG00997213 FIG00997214: hypothetical protein +FIG00997214 FIG00997216: hypothetical protein +FIG00997228 FIG00997231: hypothetical protein +FIG00997238 FIG00997240: hypothetical protein +FIG00997241 parathion hydrolase +FIG00997244 FIG00997245: hypothetical protein +FIG00997245 FIG00997246: hypothetical protein +FIG00997261 FIG00997262: hypothetical protein +FIG00997262 FIG00997263: hypothetical protein +FIG00997263 FIG00997264: hypothetical protein +FIG00997279 FIG00997281: hypothetical protein +FIG00997282 FIG00997285: hypothetical protein +FIG00997287 FIG00997288: hypothetical protein +FIG00997290 FIG00997292: hypothetical protein +FIG00997295 FIG00997297: hypothetical protein +FIG00997297 FIG00997298: hypothetical protein +FIG00997311 FIG00821723: hypothetical protein +FIG00997319 FIG00997320: hypothetical protein +FIG00997320 FIG00997321: hypothetical protein +FIG00997321 Lipoprotein LpqU +FIG00997333 FIG00997334: hypothetical protein +FIG00997334 FIG00997335: hypothetical protein +FIG00997335 FIG00997338: hypothetical protein +FIG00997350 Iron utilization protein +FIG00997351 FIG00997352: hypothetical protein +FIG00997359 FIG00997360: hypothetical protein +FIG00997368 FIG00997370: hypothetical protein +FIG00997370 FIG00997371: hypothetical protein +FIG00997371 FIG00997376: hypothetical protein +FIG00997376 FIG00997377: hypothetical protein +FIG00997377 FIG00997378: hypothetical protein +FIG00997385 FIG00997386: hypothetical protein +FIG00997386 FIG00997388: hypothetical protein +FIG00997399 FIG00997402: hypothetical protein +FIG00997402 FIG00997403: hypothetical protein +FIG00997405 Multidrug efflux pump P55 +FIG00997420 FIG00997421: hypothetical protein +FIG00997421 FIG00997422: hypothetical protein +FIG00997430 FIG00997432: hypothetical protein +FIG00997435 FIG00997436: hypothetical protein +FIG00997439 FIG00997440: hypothetical protein +FIG00997441 FIG00997443: hypothetical protein +FIG00997458 FIG00997463: hypothetical protein +FIG00997463 FIG00997465: hypothetical protein +FIG00997465 Putative aromatic-ring-hydroxylating dioxygenase, beta subunit +FIG00997467 FIG00997468: hypothetical protein +FIG00997480 FIG00997481: hypothetical protein +FIG00997481 FIG00997484: hypothetical protein +FIG00997487 FIG00997488: hypothetical protein +FIG00997496 FIG00997498: hypothetical protein +FIG00997501 FIG00997502: hypothetical protein +FIG00997508 FIG00997509: hypothetical protein +FIG00997513 glycolate oxidase, subunit GlcD (glcD) +FIG00997520 FIG00997523: hypothetical protein +FIG00997523 FIG00997525: hypothetical protein +FIG00997525 FIG00997527: hypothetical protein +FIG00997540 FIG00997541: hypothetical protein +FIG00997542 FIG00997543: hypothetical protein +FIG00997550 FIG00997551: hypothetical protein +FIG00997563 possible sugar phosphate isomerase/ epimerase +FIG00997567 FIG00997569: hypothetical protein +FIG00997578 FIG00997579: hypothetical protein +FIG00997580 FIG00997584: hypothetical protein +FIG00997593 FIG00997601: hypothetical protein +FIG00997606 FIG00997608: hypothetical protein +FIG00997614 FIG00997615: hypothetical protein +FIG00997617 FIG00997621: hypothetical protein +FIG00997627 FIG00997628: hypothetical protein +FIG00997635 Oligopeptide/dipeptide ABC transporter, ATP-binding protein, C-terminal +FIG00997640 FIG00997641: hypothetical protein +FIG00997646 FIG00997649: hypothetical protein +FIG00997649 FIG00997650: hypothetical protein +FIG00997656 5,10-methylenetetrahydromethanopterin reductase( EC:1.5.99.11 ) +FIG00997659 hypothetical protein; putative signal peptide; putative Phenylacetic acid degradation-related domain +FIG00997680 FIG00997681: hypothetical protein +FIG00997681 FIG00997682: hypothetical protein +FIG00997686 FIG00997689: hypothetical protein +FIG00997691 FIG00997692: hypothetical protein +FIG00997692 FIG00997694: hypothetical protein +FIG00997694 FIG00997696: hypothetical protein +FIG00997703 FIG00997705: hypothetical protein +FIG00997706 FIG00997707: hypothetical protein +FIG00997713 FIG00997714: hypothetical protein +FIG00997719 FIG00997720: hypothetical protein +FIG00997730 FIG00997732: hypothetical protein +FIG00997732 FIG00997733: hypothetical protein +FIG00997733 FIG00997734: hypothetical protein +FIG00997737 FIG00997738: hypothetical protein +FIG00997738 FIG00997744: hypothetical protein +FIG00997747 ABC-type nitrate/sulfonate/bicarbonate transport systems periplasmic components-like protein +FIG00997748 FIG00997749: hypothetical protein +FIG00997752 FIG00997753: hypothetical protein +FIG00997758 FIG00997761: hypothetical protein +FIG00997761 FIG00997765: hypothetical protein +FIG00997765 aromatic acid transporter protein, MFS superfamily +FIG00997781 YibE/F family membrane protein +FIG00997794 FIG00997795: hypothetical protein +FIG00997799 Anti-sigma factor +FIG00997800 FIG00997802: hypothetical protein +FIG00997810 FIG00997811: hypothetical protein +FIG00997811 FIG00997813: hypothetical protein +FIG00997816 FIG00997817: hypothetical protein +FIG00997819 FIG00997820: hypothetical protein +FIG00997822 FIG00997824: hypothetical protein +FIG00997824 FIG00997825: hypothetical protein +FIG00997836 FIG00997837: hypothetical protein +FIG00997840 FIG00997842: hypothetical protein +FIG00997844 FIG00997850: hypothetical protein +FIG00997850 FIG00997852: hypothetical protein +FIG00997857 FIG00997858: hypothetical protein +FIG00997866 FIG00997867: hypothetical protein +FIG00997870 Iron-regulated heparin binding hemagglutinin HbhA (Adhesin) +FIG00997873 FIG00997875: hypothetical protein +FIG00997876 FIG00997878: hypothetical protein +FIG00997881 FIG00997884: hypothetical protein +FIG00997884 FIG00997885: hypothetical protein +FIG00997892 FIG00997894: hypothetical protein +FIG00997901 FIG00997902: hypothetical protein +FIG00997909 FIG00997910: hypothetical protein +FIG00997915 FIG00997916: hypothetical protein +FIG00997919 FIG00997920: hypothetical protein +FIG00997924 FIG00997925: hypothetical protein +FIG00997927 FIG00997929: hypothetical protein +FIG00997929 FIG00997935: hypothetical protein +FIG00997939 FIG00997943: hypothetical protein +FIG00997951 FIG00997952: hypothetical protein +FIG00997955 FIG00997957: hypothetical protein +FIG00997962 FIG00997967: hypothetical protein +FIG00997972 FIG00997973: hypothetical protein +FIG00997975 FIG00997976: hypothetical protein +FIG00997976 FIG00997977: hypothetical protein +FIG00997981 FIG00997982: hypothetical protein +FIG00997984 FIG00997985: hypothetical protein +FIG00997985 FIG00997986: hypothetical protein +FIG00997991 FIG00997993: hypothetical protein +FIG00998005 2-hydroxycyclohexanecarboxyl-CoA dehydrogenase (EC 1.1.1.-) +FIG00998014 FIG00998020: hypothetical protein +FIG00998024 FIG00998026: hypothetical protein +FIG00998027 FIG00998029: hypothetical protein +FIG00998029 FIG00998030: hypothetical protein +FIG00998030 FIG00998036: hypothetical protein +FIG00998037 FIG00998038: hypothetical protein +FIG00998038 FIG00998039: hypothetical protein +FIG00998044 FIG00998046: hypothetical protein +FIG00998047 FIG00998049: hypothetical protein +FIG00998051 FIG00998056: hypothetical protein +FIG00998060 Protein containing domains DUF404, DUF407, DUF403 +FIG00998069 FIG00998070: hypothetical protein +FIG00998081 FIG00998083: hypothetical protein +FIG00998083 FIG00998085: hypothetical protein +FIG00998085 FIG00998086: hypothetical protein +FIG00998086 FIG00998089: hypothetical protein +FIG00998091 DUF2236 +FIG00998098 FIG00998100: hypothetical protein +FIG00998101 FIG00998105: hypothetical protein +FIG00998105 FIG00998106: hypothetical protein +FIG00998110 probable flavin oxidoreductase +FIG00998117 FIG00998122: hypothetical protein +FIG00998124 FIG00998127: hypothetical protein +FIG00998127 FIG00998130: hypothetical protein +FIG00998136 FIG00998137: hypothetical protein +FIG00998137 FIG00998140: hypothetical protein +FIG00998140 FIG00998141: hypothetical protein +FIG00998141 FIG00998142: hypothetical protein +FIG00998144 FIG00998145: hypothetical protein +FIG00998149 FIG00998150: hypothetical protein +FIG00998150 FIG00998152: hypothetical protein +FIG00998156 hypothetical short chain dehydrogenase +FIG00998166 FIG00998167: hypothetical protein +FIG00998196 FIG00998200: hypothetical protein +FIG00998200 FIG00998202: hypothetical protein +FIG00998202 FAD-binding monooxygenase, PheA/TfdB family, similarity to 2,4-dichlorophenol 6-monooxygenase +FIG00998203 possible diacylglycerol kinase, catalytic region +FIG00998212 FIG00998215: hypothetical protein +FIG00998216 FIG00998217: hypothetical protein +FIG00998225 FIG00998228: hypothetical protein +FIG00998231 FIG00998233: hypothetical protein +FIG00998234 multidrug transporter, Dha2 family of MFS superfamily +FIG00998239 FIG00998240: hypothetical protein +FIG00998243 FIG00998246: hypothetical protein +FIG00998252 FIG00998255: hypothetical protein +FIG00998256 FIG00998257: hypothetical protein +FIG00998257 FIG00998258: hypothetical protein +FIG00998261 FIG00998262: hypothetical protein +FIG00998265 possible sugar phosphate isomerase +FIG00998269 FIG00998270: hypothetical protein +FIG00998289 FIG00998290: hypothetical protein +FIG00998297 FIG00821400: hypothetical protein +FIG00998298 FIG00998299: hypothetical protein +FIG00998299 FIG00998300: hypothetical protein +FIG00998300 FIG00998302: hypothetical protein +FIG00998302 FIG00998303: hypothetical protein +FIG00998307 FIG00998308: hypothetical protein +FIG00998324 FIG00998325: hypothetical protein +FIG00998325 putative Aminoglycoside N6'-acetyltransferase( EC:2.3.1.82 ) +FIG00998326 FIG00998328: hypothetical protein +FIG00998333 FIG00998334: hypothetical protein +FIG00998338 FIG00998339: hypothetical protein +FIG00998341 FIG00998342: hypothetical protein +FIG00998343 FIG00998344: hypothetical protein +FIG00998348 FIG00998352: hypothetical protein +FIG00998353 FIG00998354: hypothetical protein +FIG00998358 possible porin protein +FIG00998363 FIG00998365: hypothetical protein +FIG00998365 FIG00998367: hypothetical protein +FIG00998367 FIG00998370: hypothetical protein +FIG00998373 FIG00998376: hypothetical protein +FIG00998377 putative ScnB homolog +FIG00998402 FIG00998405: hypothetical protein +FIG00998407 FIG00998409: hypothetical protein +FIG00998409 FIG00998410: hypothetical protein +FIG00998410 probable transcriptional regulator, GntR family +FIG00998413 FIG00998414: hypothetical protein +FIG00998414 FIG00998421: hypothetical protein +FIG00998421 FIG00998424: hypothetical protein +FIG00998427 FIG00998428: hypothetical protein +FIG00998428 FIG00998431: hypothetical protein +FIG00998435 FIG00998438: hypothetical protein +FIG00998477 FIG00998478: hypothetical protein +FIG00998479 Organosulfonate ABC transporter ATP-binding protein +FIG00998483 FIG00998484: hypothetical protein +FIG00998484 FIG00998485: hypothetical protein +FIG00998485 FIG00998487: hypothetical protein +FIG00998487 FIG00998489: hypothetical protein +FIG00998496 possible glycosyl hydrolase +FIG00998502 Putative transcription activator +FIG00998512 FIG00998513: hypothetical protein +FIG00998518 FIG00998520: hypothetical protein +FIG00998520 FIG00998521: hypothetical protein +FIG00998522 FIG00998524: hypothetical protein +FIG00998524 FIG00998525: hypothetical protein +FIG00998528 FIG01121868: Possible membrane protein +FIG00998547 FIG00998548: hypothetical protein +FIG00998548 FIG00998549: hypothetical protein +FIG00998549 FIG00998551: hypothetical protein +FIG00998553 FIG00998555: hypothetical protein +FIG00998555 FIG00998558: hypothetical protein +FIG00998561 FIG00998564: hypothetical protein +FIG00998565 putative Clp protease subunit +FIG00998566 FIG00998567: hypothetical protein +FIG00998567 FIG00998572: hypothetical protein +FIG00998572 FIG00998573: hypothetical protein +FIG00998576 FIG00998577: hypothetical protein +FIG00998593 Putative esterase +FIG00998601 FIG00998604: hypothetical protein +FIG00998605 FIG00998606: hypothetical protein +FIG00998609 FIG00998610: hypothetical protein +FIG00998610 FIG00998612: hypothetical protein +FIG00998613 FIG00998615: hypothetical protein +FIG00998615 FIG00998616: hypothetical protein +FIG00998617 FIG00998618: hypothetical protein +FIG00998618 FIG00998619: hypothetical protein +FIG00998619 carbon monoxide dehydrogenase medium subunit( EC:1.2.99.2 ) +FIG00998624 FIG00998628: hypothetical protein +FIG00998628 FIG00998629: hypothetical protein +FIG00998643 FIG00998644: hypothetical protein +FIG00998645 Probable pyruvate carboxylase +FIG00998652 FIG00998653: hypothetical protein +FIG00998653 FIG00998659: hypothetical protein +FIG00998661 FIG00998663: hypothetical protein +FIG00998687 FIG00998689: hypothetical protein +FIG00998694 FIG00820092: hypothetical protein +FIG00998717 Sugar phosphate isomerases/epimerases +FIG00998721 FIG00998723: hypothetical protein +FIG00998726 FIG00998728: hypothetical protein +FIG00998728 FIG00998729: hypothetical protein +FIG00998729 Ferritin +FIG00998748 FIG00998749: hypothetical protein +FIG00998755 probable stage II sporulation protein +FIG00998761 FIG00998764: hypothetical protein +FIG00998765 FIG00998769: hypothetical protein +FIG00998770 Methylated DNA-protein cysteine methyltransferase +FIG00998773 FIG00998774: hypothetical protein +FIG00998774 Bll2645 protein +FIG00998778 FIG00998780: hypothetical protein +FIG00998784 FIG00998787: hypothetical protein +FIG00998794 FIG00998795: hypothetical protein +FIG00998797 FIG00998800: hypothetical protein +FIG00998802 FIG00998805: hypothetical protein +FIG00998810 FIG00998811: hypothetical protein +FIG00998812 FIG00998813: hypothetical protein +FIG00998816 FIG00998822: hypothetical protein +FIG00998828 LmbE-like protein +FIG00998833 FIG00998835: hypothetical protein +FIG00998844 FIG00998845: hypothetical protein +FIG00998852 FIG00998853: hypothetical protein +FIG00998864 FIG00998865: hypothetical protein +FIG00998866 possible LMBE-related protein +FIG00998869 FIG00998871: hypothetical protein +FIG00998884 FIG00998885: hypothetical protein +FIG00998886 FIG00998888: hypothetical protein +FIG00998891 ATP-dependent efflux pump essential for phthiocerol dimycocerosates translocation, integral membrane protein DrrC-like +FIG00998893 FIG00998894: hypothetical protein +FIG00998894 FIG00998898: hypothetical protein +FIG00998906 FIG00998911: hypothetical protein +FIG00998911 FIG00998912: hypothetical protein +FIG00998915 FIG00998915: membrane protein +FIG00998919 FIG00998920: hypothetical protein +FIG00998920 FIG00998922: hypothetical protein +FIG00998922 multidrug resistance transporter, MFS superfamily +FIG00998936 FIG00998937: hypothetical protein +FIG00998953 FIG00998954: hypothetical protein +FIG00998954 possible ATP-dependent Clp protease ATP-binding subunit +FIG00998970 FIG00998972: hypothetical protein +FIG00998980 FIG00998981: hypothetical protein +FIG00998981 FIG00998986: hypothetical protein +FIG00998991 FIG00998992: hypothetical protein +FIG00998993 FIG00998994: hypothetical protein +FIG00998994 FIG00998995: hypothetical protein +FIG00998995 prolyl oligopeptidase family protein [imported], putative +FIG00999009 FIG00999010: hypothetical protein +FIG00999020 probable isochorismatase +FIG00999027 possible transcriptional regulator, MerR family +FIG00999028 FIG00999031: hypothetical protein +FIG00999055 putative adhesion lipoprotein +FIG00999073 FIG00999074: hypothetical protein +FIG00999074 FIG00999076: hypothetical protein +FIG00999076 FIG00999080: hypothetical protein +FIG00999083 FIG00999084: hypothetical protein +FIG00999086 FIG00999089: hypothetical protein +FIG00999089 possible cell wall protein +FIG00999094 FIG00999095: hypothetical protein +FIG00999102 5 nucleotidase, deoxy, cytosolic type C +FIG00999138 Daunorubicin-DIM-transport ATP-binding protein ABC transporter DrrA +FIG00999154 sodium:solute symporter protein +FIG00999157 FIG00999161: hypothetical protein +FIG00999166 FIG00999167: hypothetical protein +FIG00999181 FIG00999182: hypothetical protein +FIG00999216 FIG00999218: hypothetical protein +FIG00999218 FIG00999219: hypothetical protein +FIG00999219 FIG00999220: hypothetical protein +FIG00999228 FIG00999229: hypothetical protein +FIG00999229 FIG00999229: probable secreted protein +FIG00999243 FIG00999244: hypothetical protein +FIG00999244 FIG00999248: hypothetical protein +FIG00999248 FIG00999254: hypothetical protein +FIG00999255 FIG00999256: hypothetical protein +FIG00999261 FIG00999262: hypothetical protein +FIG00999262 FIG00999263: hypothetical protein +FIG00999264 FIG00999265: hypothetical protein +FIG00999265 UDP-N-acetylmuramic acid hydroxylase +FIG00999268 possible acetyl-CoA synthetase +FIG00999273 FIG00999274: hypothetical protein +FIG00999274 FIG00999275: hypothetical protein +FIG00999278 FIG00999279: hypothetical protein +FIG00999291 phenol hydroxylase, reductase component +FIG00999292 FIG00999293: hypothetical protein +FIG00999323 possible type II/IV secretion system protein +FIG00999325 FIG00999328: hypothetical protein +FIG00999328 ABC amino acid transporter, periplasmic binding protein +FIG00999337 Possible membrane protein +FIG00999343 FIG00999346: hypothetical protein +FIG00999347 FIG00999349: hypothetical protein +FIG00999349 peptide monooxygenase +FIG00999351 Probable sugar-transport ATP-binding protein ABC transporter +FIG00999352 FIG00999353: hypothetical protein +FIG00999369 Carboxymethylenebutenolidase +FIG00999375 FIG00999376: hypothetical protein +FIG00999376 FIG00999377: hypothetical protein +FIG00999377 FIG00999381: hypothetical protein +FIG00999386 FIG00999389: hypothetical protein +FIG00999394 FIG00999398: hypothetical protein +FIG00999398 FIG00999401: hypothetical protein +FIG00999418 FIG00999419: hypothetical protein +FIG00999419 FIG00999421: hypothetical protein +FIG00999423 FIG00999424: hypothetical protein +FIG00999429 FIG00999432: hypothetical protein +FIG00999432 putative lyase +FIG00999433 FIG00999436: hypothetical protein +FIG00999437 FIG00999439: hypothetical protein +FIG00999440 possible triacylglycerol lipase +FIG00999454 FIG00999455: hypothetical protein +FIG00999457 FIG00999460: hypothetical protein +FIG00999466 FIG00999469: hypothetical protein +FIG00999473 FIG00999474: hypothetical protein +FIG00999474 possible sulfurtransferase, rhodanese related +FIG00999482 Possible lipoprotein LprC +FIG00999496 possible membrane-associated lipoprotein +FIG00999498 FIG00999499: hypothetical protein +FIG00999502 FIG00999503: hypothetical protein +FIG00999518 FIG00999520: hypothetical protein +FIG00999520 FIG00999523: hypothetical protein +FIG00999540 aldose 1-epimerase( EC:5.1.3.3 ) +FIG00999543 FIG00999544: hypothetical protein +FIG00999548 FIG00999549: hypothetical protein +FIG00999549 FIG00999550: hypothetical protein +FIG00999555 probable gas vesicle protein +FIG00999563 FIG00999565: hypothetical protein +FIG00999577 FIG00999580: hypothetical protein +FIG00999581 FIG00999584: hypothetical protein +FIG00999584 FIG00999585: hypothetical protein +FIG00999587 FIG00999588: hypothetical protein +FIG00999588 FIG00999589: hypothetical protein +FIG00999601 sensor kinase, two-component system +FIG00999609 possible excisionase +FIG00999627 FIG00999628: hypothetical protein +FIG00999632 Mlr0593 protein +FIG00999637 FIG00999640: hypothetical protein +FIG00999650 FIG00999651: hypothetical protein +FIG00999654 Antibiotic biosynthesis monooxygenase +FIG00999659 FIG00999660: hypothetical protein +FIG00999660 FIG00999663: hypothetical protein +FIG00999665 FIG00999668: hypothetical protein +FIG00999668 FIG00999674: hypothetical protein +FIG00999677 FIG00999683: hypothetical protein +FIG00999683 FIG00999684: hypothetical protein +FIG00999684 FIG00999686: hypothetical protein +FIG00999686 FIG00999687: hypothetical protein +FIG00999687 FIG00999691: hypothetical protein +FIG00999694 FIG00999695: hypothetical protein +FIG00999697 FIG00999698: hypothetical protein +FIG00999701 FIG00999703: hypothetical protein +FIG00999707 FIG00999712: hypothetical protein +FIG00999715 FIG00999716: hypothetical protein +FIG00999720 gas vesicle structural protein +FIG00999743 FIG00999744: hypothetical protein +FIG00999759 FIG00999760: hypothetical protein +FIG00999762 FIG00999763: hypothetical protein +FIG00999779 FIG00999782: hypothetical protein +FIG00999783 probable transcriptional regulator, AsnC family +FIG00999787 FIG00999788: hypothetical protein +FIG00999789 FIG00999790: hypothetical protein +FIG00999797 FIG00999798: hypothetical protein +FIG00999807 FIG00999809: hypothetical protein +FIG00999809 FIG00999810: hypothetical protein +FIG00999816 FIG00999818: hypothetical protein +FIG00999824 FIG00999828: hypothetical protein +FIG00999828 FIG00999829: hypothetical protein +FIG00999836 FIG00999838: hypothetical protein +FIG00999839 FIG00999840: hypothetical protein +FIG00999842 FIG00999844: hypothetical protein +FIG00999847 Protocatechuate 3,4-dioxygenase beta subunit (EC 1.13.11.1) +FIG00999848 activator of HSP90 ATPase 1 family protein +FIG00999863 FIG00999865: hypothetical protein +FIG00999868 gntR-family transcriptional regulator +FIG00999871 3-oxoacyl-[acyl-carrier protein] reductase (EC 1.1.1.100) +FIG00999873 branched-chain amino acid ABC transporter ATP-binding protein +FIG00999874 Phage peptidoglycan binding endopeptidase +FIG00999877 FIG00999879: hypothetical protein +FIG00999879 glutamate permease +FIG00999882 FIG00999890: hypothetical protein +FIG00999894 FIG00999903: hypothetical protein +FIG00999910 FIG00999911: hypothetical protein +FIG00999911 possible suppressor protein DnaK +FIG00999917 Enoyl-CoA hydratase +FIG00999930 FIG00999931: hypothetical protein +FIG00999931 FIG00999932: hypothetical protein +FIG00999937 FIG00999940: hypothetical protein +FIG00999947 protein of unknown function DUF202 +FIG00999950 FIG00999951: hypothetical protein +FIG00999952 FIG00999954: hypothetical protein +FIG00999962 FIG00999964: hypothetical protein +FIG00999964 FIG00999966: hypothetical protein +FIG00999966 FIG00999967: hypothetical protein +FIG00999970 FIG00999971: hypothetical protein +FIG00999972 FIG00999973: hypothetical protein +FIG00999975 FIG00999976: hypothetical protein +FIG00999976 GTP pyrophosphokinase (EC 2.7.6.5) +FIG00999984 FIG00999988: hypothetical protein +FIG00999989 FIG00999990: hypothetical protein +FIG00999997 FIG00999999: hypothetical protein +FIG00999999 FIG01000000: hypothetical protein +FIG01000000 FIG01000001: hypothetical protein +FIG01000001 FIG01000007: hypothetical protein +FIG01000012 FIG01000012: glyoxalase family protein +FIG01000032 FIG01000035: hypothetical protein +FIG01000037 FIG01000042: hypothetical protein +FIG01000049 FIG01000052: hypothetical protein +FIG01000054 FIG01000055: hypothetical protein +FIG01000055 FIG01000056: hypothetical protein +FIG01000056 FIG01000057: hypothetical protein +FIG01000057 FIG01000060: hypothetical protein +FIG01000066 probable ABC iron transporter, substrate-binding component +FIG01000072 FIG01000073: hypothetical protein +FIG01000075 FIG01000078: hypothetical protein +FIG01000112 FIG01000113: hypothetical protein +FIG01000115 FIG01000118: hypothetical protein +FIG01000122 FIG01000125: hypothetical protein +FIG01000128 FIG01000129: hypothetical protein +FIG01000130 FIG01000131: hypothetical protein +FIG01000131 FIG01000132: hypothetical protein +FIG01000139 FIG01000140: hypothetical protein +FIG01000141 FIG01000142: hypothetical protein +FIG01000142 FIG01000143: hypothetical protein +FIG01000149 FIG01000150: hypothetical protein +FIG01000150 FIG01000151: hypothetical protein +FIG01000155 FIG01000157: hypothetical protein +FIG01000160 FIG01000164: hypothetical protein +FIG01000164 FIG01000165: hypothetical protein +FIG01000168 FIG01000169: hypothetical protein +FIG01000175 FIG01000182: hypothetical protein +FIG01000189 FIG01000192: hypothetical protein +FIG01000210 FIG01000211: hypothetical protein +FIG01000247 triacylglycerol lipase( EC:3.1.1.3 ) +FIG01000250 FIG01000252: hypothetical protein +FIG01000256 FIG01000257: hypothetical protein +FIG01000257 hydroxylase +FIG01000262 FIG01000263: hypothetical protein +FIG01000265 FIG01000267: hypothetical protein +FIG01000267 FIG01000273: hypothetical protein +FIG01000290 FIG01000293: hypothetical protein +FIG01000295 FIG01000296: hypothetical protein +FIG01000323 FIG01000324: hypothetical protein +FIG01000324 FIG01000327: hypothetical protein +FIG01000327 FIG01000329: hypothetical protein +FIG01000332 FIG01000334: hypothetical protein +FIG01000335 FIG01000339: hypothetical protein +FIG01000350 FIG01000354: hypothetical protein +FIG01000356 FIG01000360: hypothetical protein +FIG01000360 FIG01000363: hypothetical protein +FIG01000374 probable transcriptional regulator, MerR family +FIG01000375 FIG01000376: hypothetical protein +FIG01000376 FIG01000377: hypothetical protein +FIG01000377 FIG01000379: hypothetical protein +FIG01000399 FIG01000406: hypothetical protein +FIG01000408 FIG01000410: hypothetical protein +FIG01000410 FIG01000412: hypothetical protein +FIG01000412 FIG01000416: hypothetical protein +FIG01000416 FIG01000419: hypothetical protein +FIG01000424 FIG01000427: hypothetical protein +FIG01000430 probable oxidoreductase, short chain dehydrogenase/ reductase family +FIG01000436 FIG01000441: hypothetical protein +FIG01000452 FIG01000453: hypothetical protein +FIG01000456 FIG01000457: hypothetical protein +FIG01000465 FIG01000466: hypothetical protein +FIG01000468 FIG01000469: hypothetical protein +FIG01000469 FIG01000471: hypothetical protein +FIG01000477 FIG01000479: hypothetical protein +FIG01000479 FIG01000480: hypothetical protein +FIG01000490 FIG01000493: hypothetical protein +FIG01000493 FIG025441: hypothetical protein +FIG01000502 FIG01000504: hypothetical protein +FIG01000540 FIG01000541: hypothetical protein +FIG01000542 probable sulfatase +FIG01000549 FIG01000554: hypothetical protein +FIG01000559 COG1522: Transcriptional regulators +FIG01000563 FIG01000564: hypothetical protein +FIG01000565 FIG01000566: hypothetical protein +FIG01000582 FIG01000585: hypothetical protein +FIG01000585 FIG01000588: hypothetical protein +FIG01000598 FIG01000601: hypothetical protein +FIG01000607 probable dimethylaniline monooxygenase (N-oxide-forming)( EC:1.14.13.8 ) +FIG01000615 FIG01000616: hypothetical protein +FIG01000637 FIG01000640: hypothetical protein +FIG01000644 FIG01000646: hypothetical protein +FIG01000649 FIG01000654: hypothetical protein +FIG01000654 FIG01000655: hypothetical protein +FIG01000662 FIG01000667: hypothetical protein +FIG01000677 FIG01000680: hypothetical protein +FIG01000688 FIG01000689: hypothetical protein +FIG01000692 ABC amino acid transporter, substrate-binding component CamA (uptake of 1-beta(2'-propanoate)-3a-alpha-H-4-alpha(3''(R)-hydroxy-3''-propanoate)-7a-beta-methylhexahydro-5-indanone) +FIG01000693 FIG01000694: hypothetical protein +FIG01000726 FIG01000728: hypothetical protein +FIG01000728 FIG01000731: hypothetical protein +FIG01000770 FIG01000771: hypothetical protein +FIG01000771 FIG01000772: hypothetical protein +FIG01000772 FIG01000776: hypothetical protein +FIG01000792 FIG01000794: hypothetical protein +FIG01000798 FIG01000799: hypothetical protein +FIG01000811 FIG01000812: hypothetical protein +FIG01000817 FIG01000818: hypothetical protein +FIG01000818 possible protein kinase +FIG01000829 probable ABC drug resistance transporter, permease component +FIG01000831 FIG01000832: hypothetical protein +FIG01000832 FIG01000840: hypothetical protein +FIG01000840 FIG01000841: hypothetical protein +FIG01000841 FIG01000842: hypothetical protein +FIG01000845 FIG01000846: hypothetical protein +FIG01000866 probable branched-chain amino acid transporter +FIG01000877 Possible phosphinothricin N-acetyltransferase +FIG01000887 probable tetracycline repressor protein +FIG01000894 FIG01000898: hypothetical protein +FIG01000899 FIG01000906: hypothetical protein +FIG01000913 FIG01000914: hypothetical protein +FIG01000914 FIG01000915: hypothetical protein +FIG01000916 FIG01000919: hypothetical protein +FIG01000931 FIG01000935: hypothetical protein +FIG01000935 FIG01000936: hypothetical protein +FIG01000936 FIG01000937: hypothetical protein +FIG01000937 FIG01000940: hypothetical protein +FIG01000940 FIG01000942: hypothetical protein +FIG01000947 FIG01000948: hypothetical protein +FIG01000948 possible proline rich protein +FIG01000951 FIG01000952: hypothetical protein +FIG01000975 FIG01000976: hypothetical protein +FIG01000976 FIG01000979: hypothetical protein +FIG01000979 Organosulfonate ABC transporter permease protein +FIG01000983 FIG01000992: hypothetical protein +FIG01000998 FIG01000999: hypothetical protein +FIG01001007 FIG01001008: hypothetical protein +FIG01001009 FIG01001010: hypothetical protein +FIG01001011 FIG01001012: hypothetical protein +FIG01001017 FIG01001018: hypothetical protein +FIG01001019 FIG01001020: hypothetical protein +FIG01001033 FIG01001035: hypothetical protein +FIG01001040 FIG01001041: hypothetical protein +FIG01001042 possible membrane transport protein +FIG01001048 FIG01001050: hypothetical protein +FIG01001051 putative quinone binding protein +FIG01001055 Biphenyl-2,3-diol 1,2-dioxygenase 2 (EC 1.13.11.39) (Biphenyl-2,3-diol 1,2-dioxygenase II) (23OHBP oxygenase II) (2,3-dihydroxybiphenyl dioxygenase II) (DHBD II) +FIG01001056 FIG01001059: hypothetical protein +FIG01001063 FIG01001066: hypothetical protein +FIG01001069 FIG01001070: hypothetical protein +FIG01001079 COG2050: Uncharacterized protein, possibly involved in aromatic compounds catabolism +FIG01001080 FIG01001081: hypothetical protein +FIG01001091 FIG01001093: hypothetical protein +FIG01001096 FIG01001100: hypothetical protein +FIG01001104 FIG01001108: hypothetical protein +FIG01001125 FIG01001126: hypothetical protein +FIG01001126 Chloride peroxidase( EC:1.11.1.10 ) +FIG01001128 FIG01001130: hypothetical protein +FIG01001130 FIG01001132: hypothetical protein +FIG01001139 FIG020377: hypothetical protein +FIG01001148 probable formyl-CoA transferase( EC:2.8.3.16 ) +FIG01001154 FIG01001158: hypothetical protein +FIG01001161 FIG01001162: hypothetical protein +FIG01001164 FIG01001166: hypothetical protein +FIG01001179 FIG01001180: hypothetical protein +FIG01001190 FIG01001191: hypothetical protein +FIG01001202 FIG01001203: hypothetical protein +FIG01001203 FIG01001206: hypothetical protein +FIG01001210 probable ABC multidrug resistance transporter, ATP-binding component +FIG01001213 FIG01001214: hypothetical protein +FIG01001217 FIG01001222: hypothetical protein +FIG01001222 FIG01001223: hypothetical protein +FIG01001244 FIG01001250: hypothetical protein +FIG01001257 FIG01001258: hypothetical protein +FIG01001265 FIG01001266: hypothetical protein +FIG01001266 FIG01001268: hypothetical protein +FIG01001275 FIG01001277: hypothetical protein +FIG01001277 putative siderophore transport system permease protein +FIG01001284 FIG01001288: hypothetical protein +FIG01001293 FIG01001294: hypothetical protein +FIG01001295 FIG01001297: hypothetical protein +FIG01001300 FIG01001308: hypothetical protein +FIG01001308 FIG01001309: hypothetical protein +FIG01001315 FIG01001320: hypothetical protein +FIG01001322 FIG01001323: hypothetical protein +FIG01001325 FIG01001331: hypothetical protein +FIG01001373 FIG01001374: hypothetical protein +FIG01001388 possible prepilin signal peptidase +FIG01001410 Methylamine utilization protein mauD +FIG01001415 FIG01001418: hypothetical protein +FIG01001423 FIG01001424: hypothetical protein +FIG01001428 FIG01001431: hypothetical protein +FIG01001434 FIG01001435: hypothetical protein +FIG01001450 FIG01001451: hypothetical protein +FIG01001469 FIG01001471: hypothetical protein +FIG01001471 FIG01001474: hypothetical protein +FIG01001500 possible ABC transporter, permease component +FIG01001503 possible nonspecific lipid-transfer protein +FIG01001504 FIG01001508: hypothetical protein +FIG01001511 FIG01001514: hypothetical protein +FIG01001522 UBA/THIF-type NAD/FAD binding protein +FIG01001528 Lipoprotein LppL +FIG01001533 FIG01001535: hypothetical protein +FIG01001541 FIG01001542: hypothetical protein +FIG01001542 ABC amino acid transporter, permease component +FIG01001545 FIG01001547: hypothetical protein +FIG01001571 FIG01001578: hypothetical protein +FIG01001581 FIG01001582: hypothetical protein +FIG01001582 fmnh2-utilizing oxygenase +FIG01001585 FIG01001588: hypothetical protein +FIG01001590 FIG01001596: hypothetical protein +FIG01001596 possible anti-sigma factor antagonist +FIG01001605 FIG01001606: hypothetical protein +FIG01001620 F420-dependent glucose-6-phosphate dehydrogenase +FIG01001623 FIG01001626: hypothetical protein +FIG01001647 FIG01001648: hypothetical protein +FIG01001653 FIG01001659: hypothetical protein +FIG01001659 FIG01001661: hypothetical protein +FIG01001677 FIG01001681: hypothetical protein +FIG01001691 Transmembrane transport protein MmpL3 +FIG01001693 FIG01001694: hypothetical protein +FIG01001705 FIG01001706: hypothetical protein +FIG01001709 FIG01001712: hypothetical protein +FIG01001720 FIG01001721: hypothetical protein +FIG01001721 FIG01001724: hypothetical protein +FIG01001739 FIG01001740: hypothetical protein +FIG01001746 FIG01001749: hypothetical protein +FIG01001772 FIG01001774: hypothetical protein +FIG01001774 probable conserved membrane protein +FIG01001781 FIG01001783: hypothetical protein +FIG01001783 FIG01001784: hypothetical protein +FIG01001784 FIG01001785: hypothetical protein +FIG01001797 FIG01001798: hypothetical protein +FIG01001816 FIG01001817: hypothetical protein +FIG01001826 FIG01001828: hypothetical protein +FIG01001828 FIG01001832: hypothetical protein +FIG01001845 FIG01001847: hypothetical protein +FIG01001854 FIG01001855: hypothetical protein +FIG01001880 FIG01001888: hypothetical protein +FIG01001894 FIG01001900: hypothetical protein +FIG01001918 FIG01001919: hypothetical protein +FIG01001927 FIG01001932: hypothetical protein +FIG01001963 possible DNA hydrolase +FIG01001968 FIG01001969: hypothetical protein +FIG01001969 FIG01001970: hypothetical protein +FIG01001974 FIG01001976: hypothetical protein +FIG01001989 possible ethyl tert-butyl ether degradation protein +FIG01001992 Probable methanol dehydrogenase transcriptional regulatory protein MoxR3 +FIG01002008 FIG01002010: hypothetical protein +FIG01002019 FIG01002021: hypothetical protein +FIG01002021 response regulator, two-component system +FIG01002026 secretory lipase +FIG01002040 possible sigma factor, includes region 4 +FIG01002051 FIG01002058: hypothetical protein +FIG01002062 FIG01002063: hypothetical protein +FIG01002068 Aldoxime dehydratase +FIG01002078 putative metabolite transport protein YaaU +FIG01002080 nuclear receptor binding factor related protein +FIG01002088 Roadblock/LC7 domain protein +FIG01002094 FIG01002095: hypothetical protein +FIG01002117 FIG01002118: hypothetical protein +FIG01002126 FIG01002131: hypothetical protein +FIG01002158 possible NADH-ubiquinone/plastoquinone +FIG01002169 FIG01002170: hypothetical protein +FIG01002193 FIG01002194: hypothetical protein +FIG01002194 FIG01002195: hypothetical protein +FIG01002196 FIG01002203: hypothetical protein +FIG01002208 FIG01002209: hypothetical protein +FIG01002209 FIG01002213: hypothetical protein +FIG01002213 FIG01002218: hypothetical protein +FIG01002263 FIG01002265: hypothetical protein +FIG01002272 Possible pyrimidine-degrading protein DUF1688 +FIG01002290 FIG01002291: hypothetical protein +FIG01002314 FIG01002316: hypothetical protein +FIG01002412 FIG01002414: hypothetical protein +FIG01002419 FIG01002420: hypothetical protein +FIG01002420 FIG01002421: hypothetical protein +FIG01002444 probable naphthalene 1,2-dioxygenase( EC:1.14.12.12 ) +FIG01002451 FIG01002455: hypothetical protein +FIG01002482 FIG01002483: hypothetical protein +FIG01002533 putative substrate-binding transport protein +FIG01002548 osmotically inducible protein C, OsmC +FIG01002648 putative cytochrome c1 signal peptide protein +FIG01002676 FIG01002682: hypothetical protein +FIG01002780 Glycosyl transferase, family 2:Polysaccharide deacetylase +FIG01002784 ABC transporter, periplasmic substrate-binding protein yejA +FIG01002808 GntR family regulatory protein +FIG01003037 FIG01003038: hypothetical protein +FIG01003169 FIG01003171: hypothetical protein +FIG01003200 Putative ABC transport integral membrane subunit +FIG01003341 PUTATIVE METHYLTRANSFERASE +FIG01003368 PROBABLE TRANSMEMBRANE ABC TRANSPORTER PROTEIN +FIG01003421 2-oxo-4-hydroxy-4-carboxy--5-ureidoimidazoline (OHCU) decarboxylase / Allantoate amidohydrolase (EC 3.5.3.9) +FIG01003508 ABC-type transport system ipermease component +FIG01003536 protein F12M16.25 +FIG01003781 FIG01003782: hypothetical protein +FIG01003789 FIG01003792: hypothetical protein +FIG01003897 Arsenite oxidase large subunit (EC 1.20.98.1) +FIG01004061 FIG01004077: hypothetical protein +FIG01004154 Putative hemolysin +FIG01004155 FIG01004157: hypothetical protein +FIG01004157 FIG01004158: hypothetical protein +FIG01004158 FIG01004159: hypothetical protein +FIG01004167 FIG01004168: hypothetical protein +FIG01004168 FIG01004171: hypothetical protein +FIG01004171 Subtilisin DY (EC 3.4.21.62) +FIG01004173 FIG01004174: hypothetical protein +FIG01004177 FIG01004181: hypothetical protein +FIG01004182 Outer membrane protein, OmpA/MotB family +FIG01004184 FIG01004186: hypothetical protein +FIG01004186 FIG01004187: hypothetical protein +FIG01004189 Bll2613 protein +FIG01004190 FIG01004191: hypothetical protein +FIG01004192 FIG01004193: hypothetical protein +FIG01004193 FIG01004197: hypothetical protein +FIG01004197 Bll5842 protein +FIG01004199 FIG01004200: hypothetical protein +FIG01004203 FIG01004204: hypothetical protein +FIG01004204 FIG01004206: hypothetical protein +FIG01004207 FIG01004208: hypothetical protein +FIG01004208 FIG01004209: hypothetical protein +FIG01004209 FIG01004211: hypothetical protein +FIG01004211 FIG01004212: hypothetical protein +FIG01004213 FIG01004216: hypothetical protein +FIG01004216 Sporulation domain protein +FIG01004219 possible cytochrome b561 +FIG01004220 FIG01004221: hypothetical protein +FIG01004224 FIG01004226: hypothetical protein +FIG01004226 FIG01004227: hypothetical protein +FIG01004227 Transcriptional regulator associated with Tricarboxylic transport +FIG01004228 FIG01004230: hypothetical protein +FIG01004230 Transcriptional regulatory protein flbD +FIG01004231 FIG01004232: hypothetical protein +FIG01004232 FIG01004233: hypothetical protein +FIG01004233 FIG01004235: hypothetical protein +FIG01004236 FIG01004237: hypothetical protein +FIG01004237 FIG01004240: hypothetical protein +FIG01004240 FIG01004241: hypothetical protein +FIG01004241 FIG01004242: hypothetical protein +FIG01004243 Oligopeptide/dipeptide uptake family ABC transporter, permease protein +FIG01004246 FIG01008998: hypothetical protein +FIG01004247 Bsr7796 protein +FIG01004248 FIG01004249: hypothetical protein +FIG01004250 Possible multidrug efflux membrane fusion protein mexE precursor +FIG01004251 Dimethylhistidine N-methyltransferase +FIG01004254 NADH:flavin oxidoreductase / NADH oxidase family protein +FIG01004256 FIG01004257: hypothetical protein +FIG01004257 Bll5866 protein +FIG01004260 FIG01004261: hypothetical protein +FIG01004263 FIG01004264: hypothetical protein +FIG01004265 FIG01004266: hypothetical protein +FIG01004266 Bll2491 protein +FIG01004271 FIG01004275: hypothetical protein +FIG01004275 FIG01004276: hypothetical protein +FIG01004276 FIG01004277: hypothetical protein +FIG01004279 Putative NADP-dependent oxidoreductase PA1648 +FIG01004280 FIG01004281: hypothetical protein +FIG01004282 FIG01004287: hypothetical protein +FIG01004290 FIG01004292: hypothetical protein +FIG01004292 Two-component cell cycle transcriptional regulator ctrA, winged helix family +FIG01004294 FIG01004295: hypothetical protein +FIG01004300 FIG01004301: hypothetical protein +FIG01004302 FIG01004304: hypothetical protein +FIG01004309 FIG01004310: hypothetical protein +FIG01004310 FIG01004311: hypothetical protein +FIG01004311 FIG01004312: hypothetical protein +FIG01004314 FIG01004317: hypothetical protein +FIG01004317 Probable transcriptional regulator, AraC family +FIG01004322 FIG01004324: hypothetical protein +FIG01004325 FIG01004326: hypothetical protein +FIG01004328 FIG01004329: hypothetical protein +FIG01004329 FIG01004330: hypothetical protein +FIG01004330 FIG01004331: hypothetical protein +FIG01004331 FIG01004332: hypothetical protein +FIG01004332 FIG01004333: hypothetical protein +FIG01004333 FIG01004335: hypothetical protein +FIG01004335 FIG01004336: hypothetical protein +FIG01004336 Mlr2033 protein +FIG01004337 FIG01004339: hypothetical protein +FIG01004339 FIG01004340: hypothetical protein +FIG01004340 putative ORF-2 +FIG01004341 FIG01004342: hypothetical protein +FIG01004343 FIG01004345: hypothetical protein +FIG01004345 FIG01004346: hypothetical protein +FIG01004346 FIG01004347: hypothetical protein +FIG01004348 FIG01004349: hypothetical protein +FIG01004349 Bll7463 protein +FIG01004350 FIG01004351: hypothetical protein +FIG01004351 FIG01004352: hypothetical protein +FIG01004352 FIG01004353: hypothetical protein +FIG01004353 Bll5781 protein +FIG01004355 Bll8113 protein +FIG01004362 FIG01004364: hypothetical protein +FIG01004364 FIG01004365: hypothetical protein +FIG01004370 FIG01004371: hypothetical protein +FIG01004371 FIG01004372: hypothetical protein +FIG01004374 FIG01004376: hypothetical protein +FIG01004376 Mll2240 protein +FIG01004384 bll1234; putative hydolase +FIG01004386 FIG01004388: hypothetical protein +FIG01004388 FIG01004389: hypothetical protein +FIG01004389 FIG01004392: hypothetical protein +FIG01004392 COGs COG2966 +FIG01004393 FIG01004396: hypothetical protein +FIG01004396 FIG01004397: hypothetical protein +FIG01004397 Bll0313 protein +FIG01004400 FIG01004401: hypothetical protein +FIG01004401 FIG01004403: hypothetical protein +FIG01004403 FIG01004404: hypothetical protein +FIG01004404 FIG01004405: hypothetical protein +FIG01004405 possible methyltransferase +FIG01004406 FIG01004411: hypothetical protein +FIG01004411 FIG01004412: hypothetical protein +FIG01004412 FIG01004413: hypothetical protein +FIG01004414 FIG01004416: hypothetical protein +FIG01004417 Bll1313 protein +FIG01004425 FIG01004427: hypothetical protein +FIG01004434 FIG01004436: hypothetical protein +FIG01004437 FIG01004439: hypothetical protein +FIG01004439 FIG01004442: hypothetical protein +FIG01004442 FIG01004443: hypothetical protein +FIG01004443 InterPro IPR001851 COGs COG0559 +FIG01004447 FIG01004448: hypothetical protein +FIG01004448 FIG01004449: hypothetical protein +FIG01004449 FIG01004450: hypothetical protein +FIG01004450 FIG01004451: hypothetical protein +FIG01004452 YcjX +FIG01004458 FIG01004460: hypothetical protein +FIG01004460 FIG01004462: hypothetical protein +FIG01004462 FIG01004465: hypothetical protein +FIG01004472 Bll2959 protein +FIG01004477 FIG01004480: hypothetical protein +FIG01004480 FIG01004481: hypothetical protein +FIG01004481 RND efflux system, membrane fusion protein CmeA +FIG01004482 FIG01004483: hypothetical protein +FIG01004483 FIG01004485: hypothetical protein +FIG01004485 FIG01004486: hypothetical protein +FIG01004486 FIG01004488: hypothetical protein +FIG01004488 FIG01004491: hypothetical protein +FIG01004491 Bll0142 protein +FIG01004492 FIG01004495: hypothetical protein +FIG01004495 FIG01004496: hypothetical protein +FIG01004496 blr4679; hypothetical protein +FIG01004498 17 kDa antigen +FIG01004502 FIG01004505: hypothetical protein +FIG01004506 FIG01004508: hypothetical protein +FIG01004508 InterPro IPR000379 COGs COG0429 +FIG01004510 FIG01004511: hypothetical protein +FIG01004511 Glycerol-3-phosphate transport-related protein GlpU +FIG01004513 Gene Transfer Agent associated protein Nwi_1162 +FIG01004520 peptidase S10, serine carboxypeptidase +FIG01004521 FIG01004523: hypothetical protein +FIG01004523 InterPro IPR001440 COGs COG0457 +FIG01004524 FIG01004525: hypothetical protein +FIG01004525 FIG01004527: hypothetical protein +FIG01004527 FIG01004529: hypothetical protein +FIG01004530 FIG01004533: hypothetical protein +FIG01004535 FIG01004536: hypothetical protein +FIG01004536 FIG01004538: hypothetical protein +FIG01004538 FIG01004539: hypothetical protein +FIG01004539 Bll7455 protein +FIG01004551 Major facilitator superfamily transporter +FIG01004552 FIG01004553: hypothetical protein +FIG01004553 FIG01004554: hypothetical protein +FIG01004554 FIG01004555: hypothetical protein +FIG01004555 FIG01004556: hypothetical protein +FIG01004556 FIG01004557: hypothetical protein +FIG01004557 FIG01004558: hypothetical protein +FIG01004560 FIG01004561: hypothetical protein +FIG01004561 FIG01004563: hypothetical protein +FIG01004563 4-carboxy-2-hydroxymuconate-6-semialdehyde dehydrogenase +FIG01004566 FIG01004568: hypothetical protein +FIG01004568 FIG01004569: hypothetical protein +FIG01004572 YgfB and YecA +FIG01004573 FIG01004574: hypothetical protein +FIG01004574 FIG01004578: hypothetical protein +FIG01004578 Acyl-CoA dehydrogenase (EC 1.3.8.7) +FIG01004585 NAD(+)--dinitrogen-reductase ADP-D-ribosyltransferase( EC:2.4.2.37 ) +FIG01004589 FIG01004591: hypothetical protein +FIG01004593 FIG01004595: hypothetical protein +FIG01004596 FIG01004598: hypothetical protein +FIG01004599 FIG01004603: hypothetical protein +FIG01004603 FIG01004604: hypothetical protein +FIG01004604 Mll6593 protein +FIG01004609 FIG01004610: hypothetical protein +FIG01004610 FIG01004611: hypothetical protein +FIG01004618 Possible asmA protein precursor +FIG01004619 FIG01004620: hypothetical protein +FIG01004620 FIG01004621: hypothetical protein +FIG01004621 FIG01004622: hypothetical protein +FIG01004622 FIG01004623: hypothetical protein +FIG01004623 Bsl5035 protein +FIG01004627 FIG01004628: hypothetical protein +FIG01004628 Nitrate ABC transporter permease protein +FIG01004629 FIG00852261: hypothetical protein +FIG01004631 FIG01004632: hypothetical protein +FIG01004635 FIG01004636: hypothetical protein +FIG01004636 FIG01004637: hypothetical protein +FIG01004637 InterPro IPR006021 COGs COG1525 +FIG01004641 FIG01004642: hypothetical protein +FIG01004652 FIG01004653: hypothetical protein +FIG01004653 METHYLTRANSFERASE (EC 2.1.1.-) +FIG01004655 Conserved hypothetical protein, gene in Ubiquinol-cytochrome C chaperone locus +FIG01004656 FIG01004662: hypothetical protein +FIG01004662 Bacteriochlorophyll synthase 44.5 kDa chain +FIG01004663 FIG01004664: hypothetical protein +FIG01004664 FIG01004667: hypothetical protein +FIG01004667 Bll0448 protein +FIG01004668 FIG01004671: hypothetical protein +FIG01004674 FIG01004675: hypothetical protein +FIG01004676 FIG01004677: hypothetical protein +FIG01004677 FIG01004679: hypothetical protein +FIG01004682 bll1533; putative methyl accepting chemotaxis protein +FIG01004689 Uncharacterized protein family UPF0114 +FIG01004695 FIG01004697: hypothetical protein +FIG01004697 Bll5160 protein +FIG01004699 FIG01004700: hypothetical protein +FIG01004700 FIG01004701: hypothetical protein +FIG01004701 FIG01004704: hypothetical protein +FIG01004705 FIG01004707: hypothetical protein +FIG01004707 probable haloacid dehalogenase-like hydrolase STY3852 +FIG01004709 FIG01004710: hypothetical protein +FIG01004712 FIG094328: hypothetical protein +FIG01004713 FIG01004714: hypothetical protein +FIG01004714 FIG01004716: hypothetical protein +FIG01004720 BFD-like (2Fe-2S)-binding region +FIG01004721 FIG01004722: hypothetical protein +FIG01004722 Bll5850 protein +FIG01004723 Bll2461 protein +FIG01004724 FIG01004725: hypothetical protein +FIG01004725 FIG01004726: hypothetical protein +FIG01004726 6-aminohexanoate-cyclic-dimer hydrolase +FIG01004727 FIG01004728: hypothetical protein +FIG01004732 Possible activator of photopigment and puc with BLUF domain +FIG01004733 FIG01004738: hypothetical protein +FIG01004738 FIG01004739: hypothetical protein +FIG01004739 FIG01004740: hypothetical protein +FIG01004743 possible transcriptional regulator, XRE family +FIG01004745 FIG01004746: hypothetical protein +FIG01004746 blr2548; putative chemotaxis protein +FIG01004750 Ser/Thr protein phosphatase family protein, UDP-2,3-diacylglucosamine hydrolase (EC 3.6.1.54) homolog +FIG01004751 Bll7062 protein +FIG01004759 Mll7655 protein +FIG01004760 FIG01004761: hypothetical protein +FIG01004767 FIG01004768: hypothetical protein +FIG01004770 FIG01004772: hypothetical protein +FIG01004772 FIG01004773: hypothetical protein +FIG01004773 FIG01004776: hypothetical protein +FIG01004776 FIG01004777: hypothetical protein +FIG01004778 InterPro IPR001589:IPR003812 COGs COG3177 +FIG01004781 Bll4390 protein +FIG01004782 Major facilitator superfamily MFS_1 +FIG01004784 FIG01004785: hypothetical protein +FIG01004785 Mlr0010 protein +FIG01004786 FIG01004790: hypothetical protein +FIG01004790 FIG01004791: hypothetical protein +FIG01004791 bll2549; hypothetical protein +FIG01004792 bll5333; putative dehydrogenase +FIG01004793 FIG01004794: hypothetical protein +FIG01004797 FIG01004799: hypothetical protein +FIG01004801 FIG01004804: hypothetical protein +FIG01004804 FIG01004805: hypothetical protein +FIG01004807 InterPro IPR000498 +FIG01004810 FIG01004811: hypothetical protein +FIG01004811 FIG01004812: hypothetical protein +FIG01004812 FIG01004819: hypothetical protein +FIG01004819 FIG01004820: hypothetical protein +FIG01004820 Zinc metalloprotease (EC 3.4.24.-) +FIG01004822 Bll5501 protein +FIG01004824 FIG00450386: membrane protein +FIG01004827 glycosyltransferase involved in LPS biosynthesis-like protein +FIG01004828 InterPro IPR001395 COGs COG0656 +FIG01004833 InterPro IPR001789 COGs COG0784 +FIG01004834 Bsr2531 protein +FIG01004837 Bsl8023 protein +FIG01004839 FIG01004841: hypothetical protein +FIG01004842 FIG01004845: hypothetical protein +FIG01004846 FIG01004847: hypothetical protein +FIG01004847 FIG01004851: hypothetical protein +FIG01004855 FIG01004859: hypothetical protein +FIG01004859 Mlr2676 protein +FIG01004860 FIG01004861: hypothetical protein +FIG01004861 FIG01004862: hypothetical protein +FIG01004862 FIG01004863: hypothetical protein +FIG01004867 FIG01004869: hypothetical protein +FIG01004870 FIG01004871: hypothetical protein +FIG01004872 FIG01004874: hypothetical protein +FIG01004876 FIG01004877: hypothetical protein +FIG01004877 InterPro IPR001387 COGs COG3655 +FIG01004880 FIG01004883: hypothetical protein +FIG01004883 FIG01004885: hypothetical protein +FIG01004885 sensor histidine kinase with PAS/PAC and response regulator receiver domains +FIG01004887 FIG01004899: hypothetical protein +FIG01004899 COGs COG3450 +FIG01004901 FIG01004902: hypothetical protein +FIG01004902 FIG01004903: hypothetical protein +FIG01004904 FIG01004905: hypothetical protein +FIG01004905 FIG01004906: hypothetical protein +FIG01004911 FIG01004912: hypothetical protein +FIG01004912 FIG01004913: hypothetical protein +FIG01004913 Bll1341 protein +FIG01004914 Two-component transcriptional regulator, winged helix family precursor +FIG01004915 FIG01004916: hypothetical protein +FIG01004916 FIG01004919: hypothetical protein +FIG01004919 Oleate hydratase (EC 4.2.1.53) +FIG01004920 FIG01004921: hypothetical protein +FIG01004921 FIG01004922: hypothetical protein +FIG01004922 FIG01004926: hypothetical protein +FIG01004926 FIG01004929: hypothetical protein +FIG01004930 FIG01004932: hypothetical protein +FIG01004932 FIG01004933: hypothetical protein +FIG01004933 FIG01004934: hypothetical protein +FIG01004934 FIG01004935: hypothetical protein +FIG01004936 Bsr5794 protein +FIG01004937 Bll2563 protein +FIG01004940 FIG01004941: hypothetical protein +FIG01004941 FIG01004942: hypothetical protein +FIG01004942 FIG01004944: hypothetical protein +FIG01004949 FIG01004952: hypothetical protein +FIG01004958 FIG01004959: hypothetical protein +FIG01004959 FIG01004960: hypothetical protein +FIG01004962 FIG01004963: hypothetical protein +FIG01004963 FIG01004964: hypothetical protein +FIG01004964 FIG01004965: hypothetical protein +FIG01004965 FIG01004970: hypothetical protein +FIG01004971 FIG01004972: hypothetical protein +FIG01004972 Conjugal transfer protein TraC +FIG01004979 FIG01004980: hypothetical protein +FIG01004980 FIG01004981: hypothetical protein +FIG01004985 Dolichol-phosphate mannosyltransferase (EC 2.4.1.83) homolog +FIG01004991 FIG01004993: hypothetical protein +FIG01004993 FIG01004994: hypothetical protein +FIG01004994 FIG01004995: hypothetical protein +FIG01004995 FIG01004998: hypothetical protein +FIG01004998 FIG01004999: hypothetical protein +FIG01004999 FIG01005000: hypothetical protein +FIG01005000 Bll3046 protein +FIG01005002 FIG01005004: hypothetical protein +FIG01005006 bll0324; putative sugar transport protein +FIG01005007 FIG01005008: hypothetical protein +FIG01005009 FIG01005010: hypothetical protein +FIG01005010 FIG01005013: hypothetical protein +FIG01005013 putative amino acid ABC transport, permease protein +FIG01005014 InterPro IPR006202 +FIG01005020 FIG01005022: hypothetical protein +FIG01005022 FIG01005025: hypothetical protein +FIG01005031 FIG01005032: hypothetical protein +FIG01005032 InterPro IPR000160 COGs COG2199 +FIG01005033 FIG01005034: hypothetical protein +FIG01005034 Bll5176 protein +FIG01005037 Bll8033 protein +FIG01005039 FIG01005040: hypothetical protein +FIG01005046 FIG01005047: hypothetical protein +FIG01005047 FIG01005048: hypothetical protein +FIG01005050 Bsl6560 protein +FIG01005051 FIG01005052: hypothetical protein +FIG01005052 ZINC PROTEASE (EC 3.4.99.-) +FIG01005053 FIG01005054: hypothetical protein +FIG01005054 Protein tyrosine phosphatases +FIG01005056 FIG01005057: hypothetical protein +FIG01005057 FIG01005058: hypothetical protein +FIG01005058 FIG01005060: hypothetical protein +FIG01005060 FIG01005061: hypothetical protein +FIG01005064 FIG01005069: hypothetical protein +FIG01005069 FIG01005074: hypothetical protein +FIG01005075 FIG01005078: hypothetical protein +FIG01005078 FIG01005080: hypothetical protein +FIG01005080 FIG01005082: hypothetical protein +FIG01005082 FIG01005083: hypothetical protein +FIG01005089 probable transcriptional regulator, TetR family +FIG01005090 FIG01005092: hypothetical protein +FIG01005092 FIG01005094: hypothetical protein +FIG01005096 FIG01005097: hypothetical protein +FIG01005099 InterPro IPR002198:IPR002347 COGs COG1028 +FIG01005100 FIG01005101: hypothetical protein +FIG01005101 FIG01005103: hypothetical protein +FIG01005104 FIG01005105: hypothetical protein +FIG01005105 Mll0186 protein +FIG01005106 FIG01005107: hypothetical protein +FIG01005107 Succinoglycan biosynthesis transport protein +FIG01005110 FIG01005111: hypothetical protein +FIG01005112 FIG01005113: hypothetical protein +FIG01005115 FIG01005116: hypothetical protein +FIG01005116 FIG01005117: hypothetical protein +FIG01005118 FIG01005119: hypothetical protein +FIG01005119 FIG00450254: hypothetical protein +FIG01005123 FIG01005124: hypothetical protein +FIG01005124 Bll7911 protein +FIG01005126 Protein pucC +FIG01005127 FIG01005128: hypothetical protein +FIG01005128 FIG00450046: hypothetical protein +FIG01005131 FIG01005134: hypothetical protein +FIG01005134 FIG01005136: hypothetical protein +FIG01005136 FIG01005137: hypothetical protein +FIG01005137 Gene Transfer Agent associated protein Pden_3078 +FIG01005139 blr0907; hypothetical protein +FIG01005141 FIG01005147: hypothetical protein +FIG01005152 FIG01005153: hypothetical protein +FIG01005153 Probable ABC transporter, ATP-binding protein +FIG01005154 FIG01005155: hypothetical protein +FIG01005155 FIG01005156: hypothetical protein +FIG01005156 FIG01005158: hypothetical protein +FIG01005158 FIG01005161: hypothetical protein +FIG01005161 FIG01005162: hypothetical protein +FIG01005162 FIG01005165: hypothetical protein +FIG01005167 FIG01005168: hypothetical protein +FIG01005169 FIG01005170: hypothetical protein +FIG01005170 InterPro IPR006992 COGs COG2159 +FIG01005175 multi-sensor hybrid histidine kinase +FIG01005176 FIG01005177: hypothetical protein +FIG01005177 FIG01005178: hypothetical protein +FIG01005179 hypothetical protein +FIG01005180 FIG01005182: hypothetical protein +FIG01005185 FIG01005186: hypothetical protein +FIG01005186 FIG00740907: hypothetical protein +FIG01005189 FIG01005190: hypothetical protein +FIG01005194 FIG01005195: hypothetical protein +FIG01005195 FIG01005196: hypothetical protein +FIG01005196 FIG00853591: hypothetical protein +FIG01005197 FIG01005198: hypothetical protein +FIG01005205 FIG01005206: hypothetical protein +FIG01005206 FIG01005207: hypothetical protein +FIG01005207 FIG01005209: hypothetical protein +FIG01005213 FIG01005214: hypothetical protein +FIG01005214 FIG01005215: hypothetical protein +FIG01005220 protein of unknown function DUF1244 +FIG01005225 FIG01005227: hypothetical protein +FIG01005228 ABC transporter, solute-binding protein +FIG01005229 COGs COG1807 +FIG01005230 FIG01005231: hypothetical protein +FIG01005231 FIG01005232: hypothetical protein +FIG01005232 FIG01005234: hypothetical protein +FIG01005234 FIG01005235: hypothetical protein +FIG01005238 FIG01005240: hypothetical protein +FIG01005242 Lignin beta-ether hydrolase +FIG01005245 InterPro IPR000205:IPR002937 COGs COG1231 +FIG01005247 FIG01005248: hypothetical protein +FIG01005249 FIG01005251: hypothetical protein +FIG01005251 FIG01005252: hypothetical protein +FIG01005252 FIG01005254: hypothetical protein +FIG01005254 FIG01005256: hypothetical protein +FIG01005256 FIG01005259: hypothetical protein +FIG01005261 Streptomyces cyclase/dehydrase +FIG01005262 Possible NADH oxidoreductase +FIG01005263 FIG01005264: hypothetical protein +FIG01005264 FIG01005267: hypothetical protein +FIG01005274 FIG01005275: hypothetical protein +FIG01005276 FIG01005278: hypothetical protein +FIG01005278 FIG01005283: hypothetical protein +FIG01005283 FIG01005285: hypothetical protein +FIG01005287 FIG01005290: hypothetical protein +FIG01005295 FIG01005296: hypothetical protein +FIG01005296 transcriptional regulators +FIG01005298 Glutamate/glutamine/aspartate/asparagine ABC transporter, periplasmic substrate-binding protein +FIG01005299 FIG01005301: hypothetical protein +FIG01005301 FIG01005303: hypothetical protein +FIG01005311 FIG01005313: hypothetical protein +FIG01005313 High-affinity branched-chain amino acid transport, ATP-binding protein +FIG01005315 THIO:disulfide Interchange Protein +FIG01005318 FIG01005319: hypothetical protein +FIG01005320 FIG01005321: hypothetical protein +FIG01005321 FIG01005322: hypothetical protein +FIG01005322 Bsl4153 protein +FIG01005324 FIG01005328: hypothetical protein +FIG01005328 FIG01005333: hypothetical protein +FIG01005333 FIG01005334: hypothetical protein +FIG01005334 Nitrogen fixation-related protein +FIG01005341 Mlr6914 protein +FIG01005342 COGs COG0346 +FIG01005345 FIG01005346: hypothetical protein +FIG01005346 FIG01005347: hypothetical protein +FIG01005351 FIG01005353: hypothetical protein +FIG01005354 Mlr6616 protein +FIG01005356 FIG01005363: hypothetical protein +FIG01005363 Chromosome (plasmid) partitioning protein ParA / Sporulation initiation inhibitor protein Soj +FIG01005368 FIG01005370: hypothetical protein +FIG01005370 putative transcriptional regulators, CopG/Arc/MetJ DNA-binding domain +FIG01005376 FIG01005377: hypothetical protein +FIG01005381 FIG01005383: hypothetical protein +FIG01005383 FIG01005384: hypothetical protein +FIG01005384 Possible integral membrane protein precursor +FIG01005386 FIG01005387: hypothetical protein +FIG01005389 FIG01005390: hypothetical protein +FIG01005390 FIG01005391: hypothetical protein +FIG01005392 InterPro IPR001296 COGs COG0438 +FIG01005394 FIG01005395: hypothetical protein +FIG01005397 FIG01005400: hypothetical protein +FIG01005404 Biotin synthase related domain containing protein +FIG01005414 drug resistance transporter, EmrB/QacA subfamily +FIG01005415 FIG01005416: hypothetical protein +FIG01005416 FIG01005417: hypothetical protein +FIG01005417 Acetyl-CoA acetyltransferase +FIG01005420 FIG01005421: hypothetical protein +FIG01005421 FIG01005422: hypothetical protein +FIG01005423 FIG01005425: hypothetical protein +FIG01005432 FIG00687974: hypothetical protein +FIG01005437 RidA/YER057c/UK114 superfamily, group 6 +FIG01005444 FIG01005446: hypothetical protein +FIG01005446 FIG01005448: hypothetical protein +FIG01005449 ABC transporter, duplicated ATPase domains +FIG01005450 FIG01005452: hypothetical protein +FIG01005452 InterPro IPR002797 COGs COG2244 +FIG01005453 Bll6580 protein +FIG01005456 FIG01005457: hypothetical protein +FIG01005457 FIG01005458: hypothetical protein +FIG01005458 FIG01005459: hypothetical protein +FIG01005459 FIG01005461: hypothetical protein +FIG01005461 possible transglycosylase SLT domain +FIG01005462 FIG01005463: hypothetical protein +FIG01005464 FIG01005465: hypothetical protein +FIG01005466 Probable branched-chain amino acid transport protein AzlC +FIG01005470 Bll7113 protein +FIG01005471 FecR protein +FIG01005473 FIG01005474: hypothetical protein +FIG01005474 putative plasmid stabilization protein +FIG01005476 FIG01005477: hypothetical protein +FIG01005479 FIG01005480: hypothetical protein +FIG01005480 FIG01005481: hypothetical protein +FIG01005481 Possible glycohydrolase +FIG01005483 FIG01005485: hypothetical protein +FIG01005485 FIG01005486: hypothetical protein +FIG01005491 FIG01005492: hypothetical protein +FIG01005492 FIG01005493: hypothetical protein +FIG01005493 Cytochrome P450 monooxygenase +FIG01005497 FIG01005500: hypothetical protein +FIG01005500 FIG01005501: hypothetical protein +FIG01005501 FIG01005502: hypothetical protein +FIG01005502 FIG01005503: hypothetical protein +FIG01005503 FIG01005504: hypothetical protein +FIG01005517 FIG01005518: hypothetical protein +FIG01005518 FIG01005520: hypothetical protein +FIG01005520 bll5772; hypothetical protein +FIG01005524 FIG01005527: hypothetical protein +FIG01005529 FIG01005530: hypothetical protein +FIG01005533 FIG01005534: hypothetical protein +FIG01005542 FIG01005543: hypothetical protein +FIG01005543 FIG01005544: hypothetical protein +FIG01005544 FIG01005546: hypothetical protein +FIG01005549 InterPro IPR001687:IPR003439:IPR003593 COGs COG1131 +FIG01005555 FIG01005556: hypothetical protein +FIG01005558 FIG01005561: hypothetical protein +FIG01005562 HAD-superfamily hydrolase subfamily IA, variant 3 +FIG01005563 FIG01005565: hypothetical protein +FIG01005569 FIG01005570: hypothetical protein +FIG01005570 FIG01005572: hypothetical protein +FIG01005576 FIG01005578: hypothetical protein +FIG01005578 FIG01005579: hypothetical protein +FIG01005579 FIG01005581: hypothetical protein +FIG01005585 blr3921; hypothetical protein +FIG01005590 FIG01005592: hypothetical protein +FIG01005592 FIG01005593: hypothetical protein +FIG01005603 Bll8057 protein +FIG01005604 FIG01005606: hypothetical protein +FIG01005607 Possible outer membrane protein, possible porin precursor +FIG01005608 Molybdenum storage protein beta subunit +FIG01005609 FIG01005613: hypothetical protein +FIG01005613 FIG01005614: hypothetical protein +FIG01005614 COGs COG0477 +FIG01005616 FIG01005617: hypothetical protein +FIG01005617 FIG050708: hypothetical protein +FIG01005618 truncated ABC-type amino acid transport system periplasmic component +FIG01005625 FIG01005626: hypothetical protein +FIG01005626 FIG01005627: hypothetical protein +FIG01005632 FIG01005633: hypothetical protein +FIG01005633 FIG01005634: hypothetical protein +FIG01005635 FIG01005636: hypothetical protein +FIG01005636 FIG01005637: hypothetical protein +FIG01005637 FIG01005638: hypothetical protein +FIG01005638 FIG01005639: hypothetical protein +FIG01005639 FIG01005640: hypothetical protein +FIG01005640 FIG01005642: hypothetical protein +FIG01005644 FIG01005648: hypothetical protein +FIG01005652 putative periplasmic solute-binding protein +FIG01005655 FIG01005659: hypothetical protein +FIG01005659 glutamate synthase (NADPH), homotetrameric +FIG01005661 FIG01005662: hypothetical protein +FIG01005663 FIG01005664: hypothetical protein +FIG01005664 FIG01005667: hypothetical protein +FIG01005668 FIG01005669: hypothetical protein +FIG01005670 FIG01005673: hypothetical protein +FIG01005674 FIG01005675: hypothetical protein +FIG01005677 FIG01005680: hypothetical protein +FIG01005680 FIG01005681: hypothetical protein +FIG01005681 FIG01005682: hypothetical protein +FIG01005688 extracellular solute-binding protein, family 3 +FIG01005689 FIG01005690: hypothetical protein +FIG01005690 Bll3789 protein +FIG01005692 FIG01005693: hypothetical protein +FIG01005693 FIG01005695: hypothetical protein +FIG01005711 FIG01005712: hypothetical protein +FIG01005719 Bona fide RidA/YjgF/TdcF/RutC subgroup +FIG01005720 ABC transporter, periplasmic amino acid-binding protein +FIG01005721 FIG01005722: hypothetical protein +FIG01005722 FIG01005723: hypothetical protein +FIG01005723 Possible glutaconate CoA-transferase, subunit A (EC 2.8.3.12) +FIG01005730 FIG01005732: hypothetical protein +FIG01005733 FIG01005735: hypothetical protein +FIG01005735 Bsl3737 protein +FIG01005739 Bll3041 protein +FIG01005754 Acetoin(diacetyl) reductase +FIG01005757 FIG01005761: hypothetical protein +FIG01005762 FIG01005763: hypothetical protein +FIG01005763 FIG01005764: hypothetical protein +FIG01005765 FIG01005766: hypothetical protein +FIG01005769 major facilitator superfamily protein, metabolite:H+ symport subfamily +FIG01005772 FIG01005775: hypothetical protein +FIG01005777 FIG01005778: hypothetical protein +FIG01005778 bll2958; hypothetical protein +FIG01005781 Bll3040 protein +FIG01005783 InterPro IPR002716 +FIG01005788 FIG01005792: hypothetical protein +FIG01005792 InterPro IPR001179 COGs COG0683 +FIG01005796 Bll4831 protein +FIG01005800 FIG01005801: hypothetical protein +FIG01005801 FIG01005802: hypothetical protein +FIG01005804 FIG01005805: hypothetical protein +FIG01005805 FIG01005808: hypothetical protein +FIG01005808 FIG01005809: hypothetical protein +FIG01005810 FIG01005811: hypothetical protein +FIG01005818 FIG01005820: hypothetical protein +FIG01005823 FIG01005824: hypothetical protein +FIG01005826 FIG01005830: hypothetical protein +FIG01005830 FIG01005831: hypothetical protein +FIG01005833 FIG01005838: hypothetical protein +FIG01005838 Bll7535 protein +FIG01005841 FIG01005843: hypothetical protein +FIG01005847 FIG01005850: hypothetical protein +FIG01005851 InterPro IPR003829 COGs COG1741 +FIG01005852 FIG01005853: hypothetical protein +FIG01005853 FIG01005855: hypothetical protein +FIG01005855 InterPro IPR003594:IPR003661:IPR004358:IPR005467 COGs COG0642 +FIG01005857 FIG01005858: hypothetical protein +FIG01005858 FIG01005859: hypothetical protein +FIG01005859 FIG01005860: hypothetical protein +FIG01005860 Mlr6608 protein +FIG01005861 FIG01005862: hypothetical protein +FIG01005866 Bll7522 protein +FIG01005868 FIG01005870: hypothetical protein +FIG01005870 FIG01005871: hypothetical protein +FIG01005874 FIG01005877: hypothetical protein +FIG01005879 hypothetical protein +FIG01005880 ABC-type multidrug transport system, permease component +FIG01005881 FIG01005883: hypothetical protein +FIG01005883 FIG01005884: hypothetical protein +FIG01005886 FIG01005890: hypothetical protein +FIG01005890 FIG01005891: hypothetical protein +FIG01005891 FIG01005892: hypothetical protein +FIG01005893 FIG01005896: hypothetical protein +FIG01005896 FIG01005898: hypothetical protein +FIG01005898 FIG01005899: hypothetical protein +FIG01005899 Bsl7464 protein +FIG01005900 FIG01005901: hypothetical protein +FIG01005901 1TMS, 107aa hypothetical protein: FIG01005902 +FIG01005902 FIG01005904: hypothetical protein +FIG01005904 FIG01005906: hypothetical protein +FIG01005906 FIG01005907: hypothetical protein +FIG01005907 FIG01005908: hypothetical protein +FIG01005908 FIG01005910: hypothetical protein +FIG01005910 FIG01005911: hypothetical protein +FIG01005911 FIG01005913: hypothetical protein +FIG01005917 Bll7889 protein +FIG01005918 FIG01005919: hypothetical protein +FIG01005919 FIG01005920: hypothetical protein +FIG01005920 InterPro IPR002085 COGs COG0604 +FIG01005925 FIG01005926: hypothetical protein +FIG01005926 protein of unknown function DUF497 +FIG01005928 FIG01005929: hypothetical protein +FIG01005929 FIG01005930: hypothetical protein +FIG01005930 FIG01005935: hypothetical protein +FIG01005935 Bsl4913 protein +FIG01005936 FIG01005937: hypothetical protein +FIG01005937 FIG01005940: hypothetical protein +FIG01005940 FIG01005941: hypothetical protein +FIG01005941 Cytidyltransferase-related domain +FIG01005946 FIG01005948: hypothetical protein +FIG01005950 Bll6688 protein +FIG01005958 FIG01005961: hypothetical protein +FIG01005961 Possible nitrogenase molybdenum-iron protein alpha chain (Nitrogenase component I) (Dinitrogenase) (EC 1.18.6.1) +FIG01005962 FIG01005963: hypothetical protein +FIG01005963 FIG01005964: hypothetical protein +FIG01005966 FIG01005969: hypothetical protein +FIG01005969 FIG01005971: hypothetical protein +FIG01005971 FIG01005974: hypothetical protein +FIG01005976 FIG01005977: hypothetical protein +FIG01005977 FIG01005979: hypothetical protein +FIG01005979 FIG01005982: hypothetical protein +FIG01005983 FIG01005984: hypothetical protein +FIG01005990 FIG01005993: hypothetical protein +FIG01005994 FIG01005995: hypothetical protein +FIG01005995 FIG01005996: hypothetical protein +FIG01005997 thioesterase superfamily protein +FIG01005998 FIG01005999: hypothetical protein +FIG01005999 FIG01006001: hypothetical protein +FIG01006001 Bll5500 protein +FIG01006003 InterPro IPR000086 COGs COG0494 +FIG01006004 glycosyl transferase family 4 +FIG01006007 FIG01006009: hypothetical protein +FIG01006014 FIG01006016: hypothetical protein +FIG01006020 FIG01006025: hypothetical protein +FIG01006027 FIG01006031: hypothetical protein +FIG01006031 FIG01006032: hypothetical protein +FIG01006032 InterPro IPR002837 COGs COG1833 +FIG01006034 FIG01006036: hypothetical protein +FIG01006036 Bll0523 protein +FIG01006042 FIG01006043: hypothetical protein +FIG01006043 FIG01006044: hypothetical protein +FIG01006044 FIG01006045: hypothetical protein +FIG01006045 Bll4799 protein +FIG01006051 FIG01006053: hypothetical protein +FIG01006053 Bll7406 protein +FIG01006054 FIG01006060: hypothetical protein +FIG01006060 Bll5657 protein +FIG01006064 Bsl6734 protein +FIG01006065 FIG01006066: hypothetical protein +FIG01006066 FIG01006067: hypothetical protein +FIG01006067 FIG01006068: hypothetical protein +FIG01006072 FIG01006073: hypothetical protein +FIG01006075 ATPase +FIG01006076 Peptidylprolyl isomerase (EC 5.2.1.8) +FIG01006077 FIG01006078: hypothetical protein +FIG01006078 FIG01006079: hypothetical protein +FIG01006079 Bsl7903 protein +FIG01006082 FIG01006087: hypothetical protein +FIG01006092 FIG01006093: hypothetical protein +FIG01006096 FIG01006098: hypothetical protein +FIG01006098 FIG01006101: hypothetical protein +FIG01006101 FIG01006102: hypothetical protein +FIG01006102 FIG01006107: hypothetical protein +FIG01006107 FIG01006108: hypothetical protein +FIG01006108 bll5605; putative quinone oxidoreductase (EC 1.6.5.5) +FIG01006109 FIG01006111: hypothetical protein +FIG01006111 FIG01006114: hypothetical protein +FIG01006114 FIG01006115: hypothetical protein +FIG01006117 FIG01006119: hypothetical protein +FIG01006119 FIG01006124: hypothetical protein +FIG01006127 FIG01006129: hypothetical protein +FIG01006131 Bll0692 protein +FIG01006133 FIG01006134: hypothetical protein +FIG01006134 FIG01006135: hypothetical protein +FIG01006135 FIG01006137: hypothetical protein +FIG01006140 FIG01006141: hypothetical protein +FIG01006141 FIG01006142: hypothetical protein +FIG01006152 FIG01006153: hypothetical protein +FIG01006153 FIG01006154: hypothetical protein +FIG01006154 FIG01006155: hypothetical protein +FIG01006155 FIG01006156: hypothetical protein +FIG01006163 FIG01006166: hypothetical protein +FIG01006166 FIG01006168: hypothetical protein +FIG01006168 FIG01006169: hypothetical protein +FIG01006169 FIG01006170: hypothetical protein +FIG01006170 FIG01006171: hypothetical protein +FIG01006177 Extracellular ligand-binding receptor +FIG01006183 Methionyl-tRNA formyltransferase +FIG01006184 possible minor curlin subunit precursor (fimbrin sef17 minor subunit). +FIG01006185 FIG01006188: hypothetical protein +FIG01006188 FIG01006189: hypothetical protein +FIG01006189 FIG01006190: hypothetical protein +FIG01006190 FIG01006191: hypothetical protein +FIG01006191 FIG01006192: hypothetical protein +FIG01006192 FIG01006195: hypothetical protein +FIG01006206 FIG01006207: hypothetical protein +FIG01006207 Bll4985 protein +FIG01006211 FIG01006212: hypothetical protein +FIG01006212 FIG01006213: hypothetical protein +FIG01006213 FIG01006214: hypothetical protein +FIG01006214 possible cyclic nucleotide-binding domain +FIG01006217 FIG01006218: hypothetical protein +FIG01006219 FIG01006220: hypothetical protein +FIG01006222 Bll5307 protein +FIG01006225 FIG01006226: hypothetical protein +FIG01006228 FIG01006230: hypothetical protein +FIG01006232 FIG01006235: hypothetical protein +FIG01006235 FIG01006237: hypothetical protein +FIG01006237 FIG01006239: hypothetical protein +FIG01006239 FIG01006240: hypothetical protein +FIG01006240 FIG01006246: hypothetical protein +FIG01006246 FIG01006247: hypothetical protein +FIG01006247 FIG01006251: hypothetical protein +FIG01006252 FIG01006254: hypothetical protein +FIG01006254 FIG01006257: hypothetical protein +FIG01006257 protein of unknown function DUF465 +FIG01006259 FIG01006260: hypothetical protein +FIG01006260 FIG01006263: hypothetical protein +FIG01006264 FIG01006265: hypothetical protein +FIG01006265 FIG01006266: hypothetical protein +FIG01006266 Methyl-accepting chemotaxis receptor/sensory transducer +FIG01006267 FIG01006270: hypothetical protein +FIG01006271 FIG01006273: hypothetical protein +FIG01006275 Bll5764 protein +FIG01006287 FIG01006288: hypothetical protein +FIG01006290 FIG01006292: hypothetical protein +FIG01006298 FIG01006299: hypothetical protein +FIG01006300 FIG01006302: hypothetical protein +FIG01006310 FIG01006311: hypothetical protein +FIG01006311 FIG01006312: hypothetical protein +FIG01006312 FIG01006313: hypothetical protein +FIG01006313 FIG01006318: hypothetical protein +FIG01006324 FIG01006327: hypothetical protein +FIG01006327 FIG01006328: hypothetical protein +FIG01006329 FIG01006330: hypothetical protein +FIG01006330 Uroporphyrinogen III synthase HEM4 +FIG01006333 FIG01006337: hypothetical protein +FIG01006337 FIG01006338: hypothetical protein +FIG01006341 COGs COG0056 +FIG01006342 FIG01006343: hypothetical protein +FIG01006347 FIG01006349: hypothetical protein +FIG01006354 FIG01006355: hypothetical protein +FIG01006356 FIG01006358: hypothetical protein +FIG01006358 FIG01006360: hypothetical protein +FIG01006361 FIG01006362: hypothetical protein +FIG01006363 FIG01006365: hypothetical protein +FIG01006366 FIG01006367: hypothetical protein +FIG01006367 FIG01006368: hypothetical protein +FIG01006368 Bll5592 protein +FIG01006369 InterPro IPR000182 COGs COG0454 +FIG01006371 FIG01006372: hypothetical protein +FIG01006379 FIG01006380: hypothetical protein +FIG01006380 FIG01006385: hypothetical protein +FIG01006386 FIG01006389: hypothetical protein +FIG01006392 FIG01006394: hypothetical protein +FIG01006394 FIG01006397: hypothetical protein +FIG01006399 FIG062562: hypothetical protein +FIG01006403 FIG01006404: hypothetical protein +FIG01006409 FIG01006411: hypothetical protein +FIG01006411 bll2903; hypothetical protein +FIG01006415 FIG01006416: hypothetical protein +FIG01006416 FIG01006417: hypothetical protein +FIG01006422 FIG01006423: hypothetical protein +FIG01006423 Bll2590 protein +FIG01006424 FIG01006425: hypothetical protein +FIG01006425 putative short-chain dehydrogenase/oxidoreductase +FIG01006426 FIG01006427: hypothetical protein +FIG01006427 InterPro IPR005806 COGs COG2146 +FIG01006435 FIG01006436: hypothetical protein +FIG01006436 FIG01006438: hypothetical protein +FIG01006451 FIG01006453: hypothetical protein +FIG01006454 Exopolysacchride production negative regulator ExoR +FIG01006459 Bll0048 protein +FIG01006460 FIG01006461: hypothetical protein +FIG01006462 FIG01006463: hypothetical protein +FIG01006467 FIG01006469: hypothetical protein +FIG01006469 FIG01006471: hypothetical protein +FIG01006476 FIG01006479: hypothetical protein +FIG01006479 FIG01006481: hypothetical protein +FIG01006482 FIG01006485: hypothetical protein +FIG01006485 FIG01006488: hypothetical protein +FIG01006489 FIG01006491: hypothetical protein +FIG01006491 FIG01006492: hypothetical protein +FIG01006495 FIG01006496: hypothetical protein +FIG01006498 FIG01006500: hypothetical protein +FIG01006501 FIG01006502: hypothetical protein +FIG01006502 Oxidoreductase Rmd +FIG01006509 FIG01006512: hypothetical protein +FIG01006512 FIG01006515: hypothetical protein +FIG01006518 hypothetical protein +FIG01006519 FIG01006520: hypothetical protein +FIG01006520 Mlr2805 protein +FIG01006524 FIG01006526: hypothetical protein +FIG01006527 FIG01006528: hypothetical protein +FIG01006528 FIG01006530: hypothetical protein +FIG01006530 Hypothetical ABC transporter ATP-binding protein yadG +FIG01006537 FIG01006539: hypothetical protein +FIG01006539 FIG01006541: hypothetical protein +FIG01006549 FIG01006552: hypothetical protein +FIG01006554 FIG01006555: hypothetical protein +FIG01006555 FIG01006556: hypothetical protein +FIG01006557 FIG01006558: hypothetical protein +FIG01006560 FIG01006562: hypothetical protein +FIG01006566 FIG01006567: hypothetical protein +FIG01006567 FIG01006568: hypothetical protein +FIG01006585 FIG01006586: hypothetical protein +FIG01006586 FIG01006587: hypothetical protein +FIG01006587 FIG01006588: hypothetical protein +FIG01006588 FIG01006589: hypothetical protein +FIG01006591 protein of unknown function DUF1656 +FIG01006601 FIG01006602: hypothetical protein +FIG01006602 blr0722; probable ATP-binding protein +FIG01006604 FIG01006607: hypothetical protein +FIG01006607 FIG01006608: hypothetical protein +FIG01006611 FIG01006612: hypothetical protein +FIG01006612 Sensory kinase protein +FIG01006613 possible Condensation domain, peptide synthetase +FIG01006614 FIG01006616: hypothetical protein +FIG01006621 FIG01006624: hypothetical protein +FIG01006627 protein of unknown function DUF433 +FIG01006628 FIG01006637: hypothetical protein +FIG01006637 secretion protein HlyD +FIG01006638 FIG01006639: hypothetical protein +FIG01006643 FIG01006644: hypothetical protein +FIG01006648 Gll0721 protein +FIG01006649 FIG01006650: hypothetical protein +FIG01006650 FIG01006651: hypothetical protein +FIG01006652 FIG01006653: hypothetical protein +FIG01006653 FIG01006655: hypothetical protein +FIG01006660 FIG01006663: hypothetical protein +FIG01006666 FIG01006669: hypothetical protein +FIG01006669 FIG01006671: hypothetical protein +FIG01006671 FIG01006674: hypothetical protein +FIG01006674 FIG01006675: hypothetical protein +FIG01006675 FIG01006676: hypothetical protein +FIG01006676 FIG01006677: hypothetical protein +FIG01006677 FIG01006679: hypothetical protein +FIG01006679 FIG01006680: hypothetical protein +FIG01006684 InterPro IPR001853:IPR006662 COGs COG1651 +FIG01006693 FIG01006694: hypothetical protein +FIG01006698 FIG01006699: hypothetical protein +FIG01006699 Bsr6521 protein +FIG01006702 FIG01006704: hypothetical protein +FIG01006704 FIG01006708: hypothetical protein +FIG01006708 hypothetical protein +FIG01006711 FIG01006712: hypothetical protein +FIG01006712 FIG01006713: hypothetical protein +FIG01006717 FIG01006718: hypothetical protein +FIG01006718 FIG01006720: hypothetical protein +FIG01006725 FIG01006726: hypothetical protein +FIG01006727 FIG01006728: hypothetical protein +FIG01006728 InterPro IPR000727:IPR003660:IPR004089 COGs COG0840 +FIG01006731 Bll5330 protein +FIG01006733 InterPro IPR001092 +FIG01006734 FIG01006736: hypothetical protein +FIG01006736 FIG01006738: hypothetical protein +FIG01006742 RNA polymerase ECF-type sigma factor, possible FecI +FIG01006743 FIG01006745: hypothetical protein +FIG01006747 Bll0063 protein +FIG01006748 COGs COG0459 +FIG01006750 FIG01006753: hypothetical protein +FIG01006753 Bll7644 protein +FIG01006759 blr4120; hypothetical protein +FIG01006760 Bll5137 protein +FIG01006761 FIG01006762: hypothetical protein +FIG01006762 FIG01006763: hypothetical protein +FIG01006765 FIG01006766: hypothetical protein +FIG01006766 Possible P-methylase (EC 2.1.1.-) +FIG01006767 Gramicidin S synthetase 2 (Gramicidin S synthetase II) [Includes: ATP-dependent proline adenylase (ProA) (Proline activase); ATP-dependent valine adenylase (ValA) (Valine activase); ATP-dependent ornithine adenylase (OrnA) (Ornithine activase); ATP-dependent leucine adenylase (LeuA) (Leucine activase)] +FIG01006768 FIG01006771: hypothetical protein +FIG01006771 FIG01006772: hypothetical protein +FIG01006772 2 TMS putative copper chaperone +FIG01006773 Cyanobacterial phytochrome B (EC 2.7.13.3) +FIG01006775 FIG01006778: hypothetical protein +FIG01006778 FIG01006779: hypothetical protein +FIG01006781 FIG01006782: hypothetical protein +FIG01006782 FIG01006785: hypothetical protein +FIG01006785 FIG01006786: hypothetical protein +FIG01006786 FIG01006789: hypothetical protein +FIG01006795 FIG01006796: hypothetical protein +FIG01006798 FIG01006800: hypothetical protein +FIG01006800 FIG01006802: hypothetical protein +FIG01006802 FIG01006804: hypothetical protein +FIG01006804 FIG01006808: hypothetical protein +FIG01006808 FIG01006810: hypothetical protein +FIG01006814 FIG01006817: hypothetical protein +FIG01006817 Probable DEAH ATP-dependent helicase +FIG01006819 Bll5250 protein +FIG01006821 FIG01006823: hypothetical protein +FIG01006825 FIG01006826: hypothetical protein +FIG01006832 FIG01006833: hypothetical protein +FIG01006835 FIG01006837: hypothetical protein +FIG01006841 FIG01006843: hypothetical protein +FIG01006850 FIG01006853: hypothetical protein +FIG01006853 FlbE protein +FIG01006854 FIG01006855: hypothetical protein +FIG01006856 Cytochrome B561, bacterial +FIG01006857 FIG01006861: hypothetical protein +FIG01006861 FIG01006866: hypothetical protein +FIG01006866 FIG01006867: hypothetical protein +FIG01006867 FIG01006870: hypothetical protein +FIG01006870 FIG01006872: hypothetical protein +FIG01006876 FIG01006879: hypothetical protein +FIG01006881 FIG01006883: hypothetical protein +FIG01006885 FIG01006886: hypothetical protein +FIG01006888 FIG01006889: hypothetical protein +FIG01006889 Bll6205 protein +FIG01006890 FIG01006891: hypothetical protein +FIG01006901 FIG01006902: hypothetical protein +FIG01006903 FIG01006906: hypothetical protein +FIG01006909 FIG01006911: hypothetical protein +FIG01006912 FIG01006915: hypothetical protein +FIG01006915 OstA-like protein +FIG01006917 FIG01006920: hypothetical protein +FIG01006920 InterPro IPR001687 COGs COG0683 +FIG01006921 110aa hypothetical protein: FIG01006922 +FIG01006923 InterPro IPR007113 +FIG01006924 FIG01006925: hypothetical protein +FIG01006925 Transketolase +FIG01006930 FIG01006931: hypothetical protein +FIG01006938 FIG01006940: hypothetical protein +FIG01006940 HPr kinase +FIG01006945 FIG01006946: hypothetical protein +FIG01006946 FIG01006947: hypothetical protein +FIG01006947 FIG01006948: hypothetical protein +FIG01006952 FIG01006953: hypothetical protein +FIG01006954 FIG01006956: hypothetical protein +FIG01006956 FIG01006957: hypothetical protein +FIG01006957 FIG01006960: hypothetical protein +FIG01006965 FIG01006966: hypothetical protein +FIG01006968 FIG01006969: hypothetical protein +FIG01006969 FIG01006970: hypothetical protein +FIG01006972 FIG01006973: hypothetical protein +FIG01006973 FIG01006974: hypothetical protein +FIG01006974 Probable Zinc-binding dehydrogenase +FIG01006975 FIG01006976: hypothetical protein +FIG01006979 COGs COG2133 +FIG01006982 FIG01006983: hypothetical protein +FIG01006983 FIG01006986: hypothetical protein +FIG01006986 Sensory histidine kinase AtoS +FIG01006988 FIG01006989: hypothetical protein +FIG01006989 possible aliphatic sulfonate binding protein of ABC transporter system +FIG01006991 FIG01006992: hypothetical protein +FIG01006993 Isocitrate dehydrogenase phosphatase (EC 2.7.11.5)/kinase (EC 3.1.3.-) +FIG01006996 FIG01006997: hypothetical protein +FIG01006997 FIG01006998: hypothetical protein +FIG01006998 FIG01006999: hypothetical protein +FIG01007002 FIG01007005: hypothetical protein +FIG01007005 FIG01007007: hypothetical protein +FIG01007012 Bsl0168 protein +FIG01007014 FIG01007015: hypothetical protein +FIG01007015 FIG01007018: hypothetical protein +FIG01007018 possible plasmid stabilization protein +FIG01007021 FIG01007022: hypothetical protein +FIG01007024 Msl1799 protein +FIG01007026 FIG01007029: hypothetical protein +FIG01007032 FIG01007033: hypothetical protein +FIG01007033 FIG01007035: hypothetical protein +FIG01007035 FIG01007038: hypothetical protein +FIG01007038 FIG01007042: hypothetical protein +FIG01007044 FIG01007045: hypothetical protein +FIG01007052 FIG01007053: hypothetical protein +FIG01007053 FIG01007054: hypothetical protein +FIG01007056 FIG01007058: hypothetical protein +FIG01007058 COGs COG1289 +FIG01007066 FIG01007068: hypothetical protein +FIG01007086 FIG01007087: hypothetical protein +FIG01007087 FIG01007093: hypothetical protein +FIG01007095 FIG01007098: hypothetical protein +FIG01007101 FIG01007104: hypothetical protein +FIG01007104 FIG01007106: hypothetical protein +FIG01007110 FIG01007111: hypothetical protein +FIG01007114 FIG01007115: hypothetical protein +FIG01007115 FIG01007117: hypothetical protein +FIG01007117 FIG01007120: hypothetical protein +FIG01007121 FIG01007124: hypothetical protein +FIG01007127 FIG01007129: hypothetical protein +FIG01007129 InterPro IPR007114 COGs COG0477 +FIG01007131 FIG188645: PAP/25A core domain:DNA polymerase, beta-like region +FIG01007139 FIG01007141: hypothetical protein +FIG01007147 FIG01007151: hypothetical protein +FIG01007151 Bll6988 protein +FIG01007153 FIG01007154: hypothetical protein +FIG01007154 FIG01007157: hypothetical protein +FIG01007157 FIG01007161: hypothetical protein +FIG01007161 possible activator of photopigment and puc with BLUF domain +FIG01007163 phosphotransfer protein with response regulator receiver and Hpt domains +FIG01007165 FIG01007166: hypothetical protein +FIG01007177 FIG01007181: hypothetical protein +FIG01007183 Bsl5034 protein +FIG01007184 FIG01007185: hypothetical protein +FIG01007189 FIG01007194: hypothetical protein +FIG01007194 FIG01007196: hypothetical protein +FIG01007196 FIG01007199: hypothetical protein +FIG01007205 FIG01007208: hypothetical protein +FIG01007209 possible AlgJ protein, required for O-acetylation of alginate in Pseudomonas aeruginosa. +FIG01007216 FIG01007217: hypothetical protein +FIG01007217 FIG01007218: hypothetical protein +FIG01007219 FIG01007220: hypothetical protein +FIG01007220 MaoC-related protein +FIG01007221 FIG01007225: hypothetical protein +FIG01007226 FIG01007227: hypothetical protein +FIG01007227 hypothetical protein +FIG01007228 Cystathionine gamma-synthase( EC:2.5.1.48 ) +FIG01007231 FIG01007232: hypothetical protein +FIG01007235 FIG01007236: hypothetical protein +FIG01007238 FIG01007243: hypothetical protein +FIG01007252 FIG01007254: hypothetical protein +FIG01007254 Bll2296 protein +FIG01007258 FIG01007259: hypothetical protein +FIG01007265 FIG01007267: hypothetical protein +FIG01007267 InterPro IPR002528 COGs COG0534 +FIG01007269 FIG01007276: hypothetical protein +FIG01007276 possible metal-dependent hydrolase +FIG01007291 FIG01007303: hypothetical protein +FIG01007306 FIG01007307: hypothetical protein +FIG01007309 PTS system nitrogen-specific IIA component, PtsN +FIG01007312 Nitrogenase molybdenum-iron protein beta chain (EC 1.18.6.1) +FIG01007320 FIG01007324: hypothetical protein +FIG01007324 FIG01007325: hypothetical protein +FIG01007325 FIG01007326: hypothetical protein +FIG01007334 FIG01007337: hypothetical protein +FIG01007338 FIG01007339: hypothetical protein +FIG01007345 hypothetical zinc-type alcohol dehydrogenase-like protein +FIG01007348 FIG01007350: hypothetical protein +FIG01007350 Bsr1504 protein +FIG01007355 FIG01007358: hypothetical protein +FIG01007359 FIG01007360: hypothetical protein +FIG01007360 FIG01007361: hypothetical protein +FIG01007361 FIG01007362: hypothetical protein +FIG01007362 FIG01007363: hypothetical protein +FIG01007363 FIG01007366: hypothetical protein +FIG01007366 FIG01007367: hypothetical protein +FIG01007368 FIG01007369: hypothetical protein +FIG01007369 FIG01007370: hypothetical protein +FIG01007376 Bll7790 protein +FIG01007378 FIG01007379: hypothetical protein +FIG01007382 FIG01007385: hypothetical protein +FIG01007385 FIG01007392: hypothetical protein +FIG01007392 FIG01007403: hypothetical protein +FIG01007403 InterPro IPR002129 COGs COG0076 +FIG01007405 FIG01007406: hypothetical protein +FIG01007406 Bll5589 protein +FIG01007407 FIG01007409: hypothetical protein +FIG01007413 FIG01007414: hypothetical protein +FIG01007414 FIG01007415: hypothetical protein +FIG01007419 FIG01007421: hypothetical protein +FIG01007439 FIG01007443: hypothetical protein +FIG01007443 FIG01007444: hypothetical protein +FIG01007451 FIG01007452: hypothetical protein +FIG01007452 FIG01007454: hypothetical protein +FIG01007454 FIG01007455: hypothetical protein +FIG01007455 FIG01007456: hypothetical protein +FIG01007459 FIG01007460: hypothetical protein +FIG01007462 FIG01007464: hypothetical protein +FIG01007464 FIG01007466: hypothetical protein +FIG01007468 FIG01007469: hypothetical protein +FIG01007469 FIG01007471: hypothetical protein +FIG01007472 FIG01007473: hypothetical protein +FIG01007478 FIG01007479: hypothetical protein +FIG01007482 FIG01007483: hypothetical protein +FIG01007483 FIG01007484: hypothetical protein +FIG01007484 aspartate/glutamate/uridylate kinase +FIG01007502 Alcohol dehydrogenase (EC 1.1.1.1) +FIG01007503 Bll7160 protein +FIG01007509 FIG01007513: hypothetical protein +FIG01007517 FIG01007518: hypothetical protein +FIG01007518 FIG01007520: hypothetical protein +FIG01007521 FIG01007522: hypothetical protein +FIG01007525 FIG01007530: hypothetical protein +FIG01007530 Hemolysin-type calcium-binding region +FIG01007545 FIG01007547: hypothetical protein +FIG01007551 GtrA-like protein +FIG01007556 FIG01007557: hypothetical protein +FIG01007557 FIG01007558: hypothetical protein +FIG01007558 FIG01007563: hypothetical protein +FIG01007571 FIG01007572: hypothetical protein +FIG01007572 FIG01007573: hypothetical protein +FIG01007575 FIG01007577: hypothetical protein +FIG01007580 FIG01007584: hypothetical protein +FIG01007584 FIG01007585: hypothetical protein +FIG01007585 FIG01007587: hypothetical protein +FIG01007592 FIG01007593: hypothetical protein +FIG01007593 FIG01007594: hypothetical protein +FIG01007612 two-component oxygen-sensor histidine kinase +FIG01007624 conserved hypothetical protein; putative acyl carrier domain +FIG01007629 FIG01007630: hypothetical protein +FIG01007634 FIG01007635: hypothetical protein +FIG01007641 FIG01007645: hypothetical protein +FIG01007645 dehydrogenase +FIG01007661 FIG01007665: hypothetical protein +FIG01007666 FIG01007667: hypothetical protein +FIG01007670 COGs COG1814 +FIG01007672 FIG01007674: hypothetical protein +FIG01007674 FIG01007681: hypothetical protein +FIG01007681 FIG01007684: hypothetical protein +FIG01007684 FIG01007688: hypothetical protein +FIG01007703 FIG01007706: hypothetical protein +FIG01007708 FIG01007709: hypothetical protein +FIG01007709 FIG030358: hypothetical protein +FIG01007712 FIG01007713: hypothetical protein +FIG01007713 Outer membrane porin required for phototropic Fe(II) oxidation, PioB +FIG01007716 FIG01007720: hypothetical protein +FIG01007720 FIG01007722: hypothetical protein +FIG01007722 FIG01007725: hypothetical protein +FIG01007729 FIG01007731: hypothetical protein +FIG01007736 FIG01007738: hypothetical protein +FIG01007738 FIG01007739: hypothetical protein +FIG01007739 FIG01007742: hypothetical protein +FIG01007744 FIG01007745: hypothetical protein +FIG01007750 FIG01007751: hypothetical protein +FIG01007752 FIG01007753: hypothetical protein +FIG01007753 FIG01007756: hypothetical protein +FIG01007756 FIG01007757: hypothetical protein +FIG01007757 FIG01007759: hypothetical protein +FIG01007759 FIG01007763: hypothetical protein +FIG01007763 FIG01007765: hypothetical protein +FIG01007765 Bsr7111 protein +FIG01007771 FIG01007774: hypothetical protein +FIG01007774 FIG01007779: hypothetical protein +FIG01007779 FIG01007781: hypothetical protein +FIG01007782 FIG01007785: hypothetical protein +FIG01007785 FIG01007788: hypothetical protein +FIG01007788 FIG01007789: hypothetical protein +FIG01007790 FIG01007798: hypothetical protein +FIG01007798 FIG01007802: hypothetical protein +FIG01007805 FIG01007807: hypothetical protein +FIG01007813 FIG01007816: hypothetical protein +FIG01007819 Probable sulfatase +FIG01007820 Methyl-accepting chemotaxis receptor/sensory transducer precursor +FIG01007821 FIG01007826: hypothetical protein +FIG01007826 FIG01007827: hypothetical protein +FIG01007827 FIG01007829: hypothetical protein +FIG01007831 Pyridoxamine 5'-phosphate oxidase-related, FMN-binding protein +FIG01007835 FIG01007837: hypothetical protein +FIG01007837 COG1289: Predicted membrane protein +FIG01007842 FIG01007843: hypothetical protein +FIG01007843 FIG01007848: hypothetical protein +FIG01007848 FIG01007851: hypothetical protein +FIG01007851 POSSIBLE ALKYLDIHYDROXYACETONEPHOSPHATE SYNTHASE AGPS (ALKYL-DHAP SYNTHASE) (ALKYLGLYCERONE-PHOSPHATE SYNTHASE) (EC 2.5.1.26) +FIG01007854 FIG01007856: hypothetical protein +FIG01007859 FIG00441575: hypothetical protein +FIG01007866 FIG01007870: hypothetical protein +FIG01007874 FIG01007877: hypothetical protein +FIG01007877 BLUF domain protein +FIG01007889 FIG01007890: hypothetical protein +FIG01007892 FIG01007893: hypothetical protein +FIG01007893 FIG01007894: hypothetical protein +FIG01007899 diguanylate cyclase with PAS/PAC sensor +FIG01007901 FIG01007905: hypothetical protein +FIG01007909 FIG01007910: hypothetical protein +FIG01007910 FIG00344505: hypothetical protein +FIG01007916 FIG01007917: hypothetical protein +FIG01007917 Type III restriction-modification enzyme helicase subunit +FIG01007923 InterPro IPR006683 +FIG01007925 FIG01007926: hypothetical protein +FIG01007929 FIG01007930: hypothetical protein +FIG01007930 FIG01007933: hypothetical protein +FIG01007935 Bll7742 protein +FIG01007944 FIG01007947: hypothetical protein +FIG01007947 FIG01007950: hypothetical protein +FIG01007960 FIG01007961: hypothetical protein +FIG01007961 FIG01007963: hypothetical protein +FIG01007968 FIG01007969: hypothetical protein +FIG01007969 FIG01007971: hypothetical protein +FIG01007986 FIG01007988: hypothetical protein +FIG01007990 FIG01007999: hypothetical protein +FIG01007999 FIG01008001: hypothetical protein +FIG01008001 FIG01008002: hypothetical protein +FIG01008004 FIG01008007: hypothetical protein +FIG01008013 FIG01008014: hypothetical protein +FIG01008029 FIG01008031: hypothetical protein +FIG01008033 FIG01008034: hypothetical protein +FIG01008037 FIG01008041: hypothetical protein +FIG01008041 FIG01008042: hypothetical protein +FIG01008042 FIG01008043: hypothetical protein +FIG01008053 FIG01008057: hypothetical protein +FIG01008067 FIG01008072: hypothetical protein +FIG01008090 ChaB +FIG01008095 InterPro IPR005490 COGs COG1376 +FIG01008097 FIG01008098: hypothetical protein +FIG01008104 FIG01008106: hypothetical protein +FIG01008120 Cytochrome b5 precursor +FIG01008124 FIG01008127: hypothetical protein +FIG01008131 FIG01008132: hypothetical protein +FIG01008132 Amidase( EC:3.5.1.4 ) +FIG01008133 FIG01008134: hypothetical protein +FIG01008135 FIG01008138: hypothetical protein +FIG01008140 FIG01008141: hypothetical protein +FIG01008141 InterPro IPR000104 +FIG01008146 FIG01008150: hypothetical protein +FIG01008153 InterPro IPR002052 +FIG01008156 FIG01008157: hypothetical protein +FIG01008157 FIG01008158: hypothetical protein +FIG01008159 Probable dTDP-4-dehydrorhamnose reductase (EC 1.1.1.133) +FIG01008167 Protein of unknown function DUF23 +FIG01008173 response regulator receiver and ANTAR domain protein +FIG01008174 FIG01008176: hypothetical protein +FIG01008176 FIG01008178: hypothetical protein +FIG01008180 FIG01008181: hypothetical protein +FIG01008182 InterPro IPR000694 +FIG01008199 FIG01008200: hypothetical protein +FIG01008200 FIG01008201: hypothetical protein +FIG01008217 FIG01008219: hypothetical protein +FIG01008219 Hypothetical oxidoreductase, YbiC homolog +FIG01008227 FIG01008234: hypothetical protein +FIG01008244 FIG01008245: hypothetical protein +FIG01008245 FIG01008247: hypothetical protein +FIG01008247 FIG01008248: hypothetical protein +FIG01008248 FIG01008249: hypothetical protein +FIG01008259 FIG01008265: hypothetical protein +FIG01008266 FIG01008268: hypothetical protein +FIG01008268 FIG01008269: hypothetical protein +FIG01008274 FIG01008276: hypothetical protein +FIG01008283 blr2506; putative chemotaxis protein +FIG01008288 FIG01008289: hypothetical protein +FIG01008301 FIG01008305: hypothetical protein +FIG01008305 FIG01008308: hypothetical protein +FIG01008308 FIG01008311: hypothetical protein +FIG01008314 FIG01008317: hypothetical protein +FIG01008319 FIG01008322: hypothetical protein +FIG01008325 COGs COG3550 +FIG01008330 FIG01008331: hypothetical protein +FIG01008332 FIG01008337: hypothetical protein +FIG01008337 FIG01008342: hypothetical protein +FIG01008342 Bll0755 protein +FIG01008355 FIG01008356: hypothetical protein +FIG01008357 FIG01008358: hypothetical protein +FIG01008362 polar amino acid ABC transpor permease protein, aapQ-2 +FIG01008374 FIG01008375: hypothetical protein +FIG01008375 FIG01008376: hypothetical protein +FIG01008376 FIG01008377: hypothetical protein +FIG01008378 FIG01008384: hypothetical protein +FIG01008384 FIG01008386: hypothetical protein +FIG01008388 FIG01008389: hypothetical protein +FIG01008392 FIG01008397: hypothetical protein +FIG01008399 FIG01008404: hypothetical protein +FIG01008404 FIG01008410: hypothetical protein +FIG01008427 FIG01008428: hypothetical protein +FIG01008436 FIG01008441: hypothetical protein +FIG01008457 FIG01008459: hypothetical protein +FIG01008460 FIG01008463: hypothetical protein +FIG01008463 FIG01008464: hypothetical protein +FIG01008464 FIG01008465: hypothetical protein +FIG01008472 FIG01008478: hypothetical protein +FIG01008478 FIG01008479: hypothetical protein +FIG01008479 FIG01008481: hypothetical protein +FIG01008481 COGs COG0451 +FIG01008485 FIG01008486: hypothetical protein +FIG01008488 FIG01008498: hypothetical protein +FIG01008500 FIG01008501: hypothetical protein +FIG01008501 FIG01008503: hypothetical protein +FIG01008504 FIG01008508: hypothetical protein +FIG01008508 FIG01008513: hypothetical protein +FIG01008513 FIG01008514: hypothetical protein +FIG01008514 FIG01008517: hypothetical protein +FIG01008517 FIG01008522: hypothetical protein +FIG01008522 FIG01008524: hypothetical protein +FIG01008529 tRNA (cytosine34-2'-O-)-methyltransferase (EC 2.1.1.-) +FIG01008537 FIG01008541: hypothetical protein +FIG01008541 FIG01008546: hypothetical protein +FIG01008546 response regulator receiver with duplicated domains +FIG01008564 Staphylococcus nuclease (SNase-like) +FIG01008569 FIG01008570: hypothetical protein +FIG01008570 FIG01008571: hypothetical protein +FIG01008579 FIG01008580: hypothetical protein +FIG01008580 FIG01008584: hypothetical protein +FIG01008584 FIG01008588: hypothetical protein +FIG01008610 FIG01008611: hypothetical protein +FIG01008613 FIG01008614: hypothetical protein +FIG01008615 FIG01008616: hypothetical protein +FIG01008622 FIG01008623: hypothetical protein +FIG01008625 FIG01008626: hypothetical protein +FIG01008627 FIG01008628: hypothetical protein +FIG01008631 FIG01008634: hypothetical protein +FIG01008637 FIG01008639: hypothetical protein +FIG01008643 FIG01008647: hypothetical protein +FIG01008649 FIG01008651: hypothetical protein +FIG01008651 FIG01008652: hypothetical protein +FIG01008652 FIG01008657: hypothetical protein +FIG01008671 ABC transporter related( EC:3.6.3.25 ) +FIG01008678 response regulator receiver (CheY-like protein) +FIG01008686 FIG01008688: hypothetical protein +FIG01008688 FIG01008689: hypothetical protein +FIG01008700 FIG01008701: hypothetical protein +FIG01008702 FIG01008703: hypothetical protein +FIG01008703 FIG01008705: hypothetical protein +FIG01008706 FIG01008710: hypothetical protein +FIG01008712 FIG01008715: hypothetical protein +FIG01008723 FIG01008724: hypothetical protein +FIG01008724 FIG01008725: hypothetical protein +FIG01008731 FIG01008733: hypothetical protein +FIG01008733 FIG01008736: hypothetical protein +FIG01008742 FIG01008744: hypothetical protein +FIG01008756 FIG01008757: hypothetical protein +FIG01008757 FIG01008758: hypothetical protein +FIG01008758 FIG01008759: hypothetical protein +FIG01008766 FIG01008768: hypothetical protein +FIG01008768 hypothetical protein +FIG01008783 FIG01008784: hypothetical protein +FIG01008795 FIG01008796: hypothetical protein +FIG01008796 FIG01008798: hypothetical protein +FIG01008809 FIG01008811: hypothetical protein +FIG01008812 FIG01008814: hypothetical protein +FIG01008827 FIG01008829: hypothetical protein +FIG01008838 FIG01008844: hypothetical protein +FIG01008849 Conjugal transfer protein TraD +FIG01008861 ABC transporter, ATPase subunit +FIG01008864 FIG01008866: hypothetical protein +FIG01008866 Hydrogenase maturation factor HoxV/HupK +FIG01008867 putative ABC transporter, periplasmic protein +FIG01008871 FIG01008872: hypothetical protein +FIG01008876 FIG01008880: hypothetical protein +FIG01008880 FIG01008881: hypothetical protein +FIG01008886 FIG01008889: hypothetical protein +FIG01008896 FIG01008897: hypothetical protein +FIG01008902 FIG01008907: hypothetical protein +FIG01008911 FIG01008914: hypothetical protein +FIG01008941 FIG01008944: hypothetical protein +FIG01008944 putative nickel-dependent hydrogenase, b-type cytochrome subunit +FIG01008947 FIG01008949: hypothetical protein +FIG01008949 FIG01008953: hypothetical protein +FIG01008953 alginate O-acetyltransferase AlgJ +FIG01009005 FIG01009008: hypothetical protein +FIG01009008 FIG01009012: hypothetical protein +FIG01009012 FIG01009013: hypothetical protein +FIG01009015 FIG01009016: hypothetical protein +FIG01009062 FIG01009069: hypothetical protein +FIG01009083 putative oxidoreductase +FIG01009085 FIG01009092: hypothetical protein +FIG01009096 FIG01009097: hypothetical protein +FIG01009104 UPF0313 protein RPA0679 +FIG01009111 FIG01009112: hypothetical protein +FIG01009119 FIG01009120: hypothetical protein +FIG01009127 InterPro IPR004843:IPR006185:IPR006186 COGs COG0639 +FIG01009128 FIG01009132: hypothetical protein +FIG01009132 Bll2701 protein +FIG01009133 Putative transmembrane efflux protein +FIG01009153 FIG01009154: hypothetical protein +FIG01009154 FIG01009158: hypothetical protein +FIG01009172 FIG01009173: hypothetical protein +FIG01009201 FIG01009202: hypothetical protein +FIG01009216 FIG01009222: hypothetical protein +FIG01009224 FIG01009226: hypothetical protein +FIG01009241 FIG01009242: hypothetical protein +FIG01009242 FIG01009243: hypothetical protein +FIG01009243 FIG01009244: hypothetical protein +FIG01009244 FIG01009249: hypothetical protein +FIG01009270 FIG01009271: hypothetical protein +FIG01009271 FIG01009272: hypothetical protein +FIG01009283 FIG01009285: hypothetical protein +FIG01009299 FIG01009300: hypothetical protein +FIG01009317 FIG01009319: hypothetical protein +FIG01009319 FIG01009320: hypothetical protein +FIG01009328 FIG01009332: hypothetical protein +FIG01009345 FIG01009349: hypothetical protein +FIG01009373 FIG01009374: hypothetical protein +FIG01009391 putative nitroimidazole resistance protein +FIG01009415 FIG01009416: hypothetical protein +FIG01009420 Death on curing protein, Doc toxin +FIG01009440 FIG01009442: hypothetical protein +FIG01009442 ABC-type export system, outer membrane channel protein +FIG01009447 FIG01009450: hypothetical protein +FIG01009450 FIG01009451: hypothetical protein +FIG01009465 FIG01009471: hypothetical protein +FIG01009540 FIG01009545: hypothetical protein +FIG01009545 FIG01009548: hypothetical protein +FIG01009617 FIG01009620: hypothetical protein +FIG01009620 COGs COG0500 +FIG01009638 Bll4091 protein +FIG01009673 bll7835; hypothetical protein +FIG01009850 Phosphohistidine Phosphatase, SixA +FIG01009866 FIG01009868: hypothetical protein +FIG01009997 Transcriptional activator chrR +FIG01010051 FIG01010052: hypothetical protein +FIG01010354 FIG01010390: hypothetical protein +FIG01010455 proteasome-type protease +FIG01010472 Transcriptional Regulator, MucR family +FIG01010605 FIG01010611: hypothetical protein +FIG01010634 FIG01010636: hypothetical protein +FIG01010643 FIG01010650: hypothetical protein +FIG01010650 Transport ATP-binding protein CydD +FIG01010696 FIG00449860: hypothetical protein +FIG01010721 FIG01010731: hypothetical protein +FIG01010852 FIG01010853: hypothetical protein +FIG01011082 COG2119: Predicted membrane protein +FIG01011121 FIG01011124: hypothetical protein +FIG01011139 FIG01011148: hypothetical protein +FIG01011215 putative cyanate MFS transporter +FIG01011258 cytoplasmic chaperone TorD +FIG01011283 FIG01011298: hypothetical protein +FIG01011298 COG0441: Threonyl-tRNA synthetase +FIG01011729 FIG01011734: hypothetical protein +FIG01011778 COG1493: Serine kinase of the HPr protein, regulates carbohydrate metabolism +FIG01011801 FIG01011804: hypothetical protein +FIG01011895 CRISPR-associated protein, Cse3 family +FIG01012101 FIG01012107: hypothetical protein +FIG01012107 Ribosome-associated protein Y (PSrp-1) +FIG01012127 Lysyl-tRNA synthetase (EC 6.1.1.6) +FIG01012151 thiamine pyrophosphate enzyme-like TPP binding protein +FIG01012608 FIG01012612: hypothetical protein +FIG01012738 FIG01012739: hypothetical protein +FIG01013050 hypothetical protein Rrub02003212 +FIG01013099 FIG00957151: hypothetical protein +FIG01013148 protein of unknown function DUF350 +FIG01013205 Esterase/lipase/thioesterase family +FIG01013210 ATPases +FIG01013249 Glycosyl transferase WecB/TagA/CpsF +FIG01013407 hypothetical protein Rrub02001450 +FIG01013533 FIG00606349: hypothetical protein +FIG01013725 FIG01013729: hypothetical protein +FIG01014911 NADH ubiquinone oxidoreductase domain, 20 kDa subunit +FIG01015179 FIG01015206: hypothetical protein +FIG01015227 FIG01015257: hypothetical protein +FIG01015399 FIG01015461: hypothetical protein +FIG01015461 FIG01015462: hypothetical protein +FIG01015462 FIG01015463: hypothetical protein +FIG01015464 FIG01015465: hypothetical protein +FIG01015465 FIG01015467: hypothetical protein +FIG01015467 FIG01015468: hypothetical protein +FIG01015468 FIG01015469: hypothetical protein +FIG01015470 FIG01015471: hypothetical protein +FIG01015471 FIG01015474: hypothetical protein +FIG01015475 FIG01015476: hypothetical protein +FIG01015477 FIG01015478: hypothetical protein +FIG01015479 FIG01015480: hypothetical protein +FIG01015480 FIG01015481: hypothetical protein +FIG01015481 FIG01015482: hypothetical protein +FIG01015482 FIG01015483: hypothetical protein +FIG01015483 hypothetical protein +FIG01015485 FIG01015486: hypothetical protein +FIG01015486 FIG01015490: hypothetical protein +FIG01015490 FIG01015491: hypothetical protein +FIG01015492 FIG01015494: hypothetical protein +FIG01015499 tRNA nucleotidyltransferase (EC 2.7.7.25) +FIG01015500 FIG01015501: hypothetical protein +FIG01015501 FIG01015502: hypothetical protein +FIG01015504 FIG01015506: hypothetical protein +FIG01015506 FIG01015509: hypothetical protein +FIG01015509 FIG01015510: hypothetical protein +FIG01015512 FIG01015516: hypothetical protein +FIG01015516 FIG01015518: hypothetical protein +FIG01015518 FIG01015519: hypothetical protein +FIG01015519 FIG01015522: hypothetical protein +FIG01015522 FIG01015525: hypothetical protein +FIG01015528 FIG01015529: hypothetical protein +FIG01015530 FIG01015532: hypothetical protein +FIG01015534 FIG01015536: hypothetical protein +FIG01015536 FIG01015537: hypothetical protein +FIG01015537 FIG01015539: hypothetical protein +FIG01015539 FIG01015540: hypothetical protein +FIG01015540 FIG01015541: hypothetical protein +FIG01015542 FIG01015543: hypothetical protein +FIG01015543 alkaline protease secretion ATP-binding protein AprD +FIG01015544 FIG01015545: hypothetical protein +FIG01015545 FIG01015546: hypothetical protein +FIG01015546 FIG01015547: hypothetical protein +FIG01015547 FIG01015548: hypothetical protein +FIG01015548 hypothetical protein +FIG01015552 FIG01015555: hypothetical protein +FIG01015556 FIG01015557: hypothetical protein +FIG01015557 FIG01015558: hypothetical protein +FIG01015561 FIG01015563: hypothetical protein +FIG01015564 FIG01015567: hypothetical protein +FIG01015567 FIG01015568: hypothetical protein +FIG01015568 FIG01015569: hypothetical protein +FIG01015569 FIG01015570: hypothetical protein +FIG01015570 FIG01015572: hypothetical protein +FIG01015572 FIG01015573: hypothetical protein +FIG01015573 FIG01015574: hypothetical protein +FIG01015574 FIG01015575: hypothetical protein +FIG01015575 FIG01015577: hypothetical protein +FIG01015577 FIG01015578: hypothetical protein +FIG01015578 FIG01015579: hypothetical protein +FIG01015580 FIG01015582: hypothetical protein +FIG01015582 FIG01015584: hypothetical protein +FIG01015584 FIG01015585: hypothetical protein +FIG01015585 FIG01015586: hypothetical protein +FIG01015586 Protein kinase C inhibitor 1 +FIG01015587 FIG01015588: hypothetical protein +FIG01015588 FIG01015589: hypothetical protein +FIG01015589 FIG01015590: hypothetical protein +FIG01015590 FIG01015591: hypothetical protein +FIG01015591 FIG01015595: hypothetical protein +FIG01015595 ComEC/Rec2 family protein +FIG01015596 guanosine-3,5-bis(diphosphate) 3-pyrophosphohydrolase SpoTc +FIG01015598 FIG01015599: hypothetical protein +FIG01015599 FIG01015601: hypothetical protein +FIG01015601 FIG01015602: hypothetical protein +FIG01015603 FIG01015604: hypothetical protein +FIG01015604 FIG01015605: hypothetical protein +FIG01015605 FIG01015610: hypothetical protein +FIG01015610 FIG01015612: hypothetical protein +FIG01015613 FIG01015614: hypothetical protein +FIG01015614 FIG01015615: hypothetical protein +FIG01015616 FIG01015618: hypothetical protein +FIG01015618 FIG01015619: hypothetical protein +FIG01015619 FIG01015620: hypothetical protein +FIG01015620 FIG01015625: hypothetical protein +FIG01015625 FIG01015626: hypothetical protein +FIG01015626 FIG01015634: hypothetical protein +FIG01015634 FIG01015636: hypothetical protein +FIG01015636 FIG01015638: hypothetical protein +FIG01015638 FIG01015640: hypothetical protein +FIG01015642 FIG01015644: hypothetical protein +FIG01015646 FIG01015648: hypothetical protein +FIG01015649 FIG01015650: hypothetical protein +FIG01015650 FIG01015651: hypothetical protein +FIG01015651 FIG01015653: hypothetical protein +FIG01015653 FIG01015655: hypothetical protein +FIG01015655 sodium/pantothenate symporter +FIG01015658 FIG01015659: hypothetical protein +FIG01015659 FIG01015664: hypothetical protein +FIG01015666 FIG01015667: hypothetical protein +FIG01015670 FIG01015671: hypothetical protein +FIG01015673 FIG01015674: hypothetical protein +FIG01015677 FIG01015470: hypothetical protein +FIG01015679 FIG01015680: hypothetical protein +FIG01015680 FIG01015681: hypothetical protein +FIG01015686 FIG01015687: hypothetical protein +FIG01015688 FIG01015689: hypothetical protein +FIG01015690 FIG01015692: hypothetical protein +FIG01015692 Cell surface antigen-like protein Sca8 +FIG01015697 FIG01015699: hypothetical protein +FIG01015700 FIG01015701: hypothetical protein +FIG01015701 FIG01015704: hypothetical protein +FIG01015704 Putative phage terminase protein +FIG01015706 FIG01015707: hypothetical protein +FIG01015707 FIG01015708: hypothetical protein +FIG01015710 FIG01015712: hypothetical protein +FIG01015712 FIG01018371: hypothetical protein +FIG01015713 FIG01015714: hypothetical protein +FIG01015714 FIG01015718: hypothetical protein +FIG01015718 (Di)nucleoside polyphosphate hydrolase-like protein +FIG01015723 FIG01015724: hypothetical protein +FIG01015724 FIG01015725: hypothetical protein +FIG01015725 FIG01015726: hypothetical protein +FIG01015726 FIG01015727: hypothetical protein +FIG01015727 FIG01015729: hypothetical protein +FIG01015730 similarity to bicyclomycin resistance protein (Bcr1) +FIG01015735 FIG01015740: hypothetical protein +FIG01015740 FIG01015741: hypothetical protein +FIG01015741 FIG01015742: hypothetical protein +FIG01015743 FIG01015746: hypothetical protein +FIG01015746 FIG01015748: hypothetical protein +FIG01015749 FIG01015751: hypothetical protein +FIG01015751 FIG01015752: hypothetical protein +FIG01015752 FIG01015753: hypothetical protein +FIG01015753 FIG01015754: hypothetical protein +FIG01015754 FIG01015757: hypothetical protein +FIG01015761 FIG01015762: hypothetical protein +FIG01015763 FIG01015764: hypothetical protein +FIG01015764 FIG01015765: hypothetical protein +FIG01015765 FIG01015767: hypothetical protein +FIG01015767 integrase/recombinase +FIG01015771 FIG01015772: hypothetical protein +FIG01015772 FIG01015773: hypothetical protein +FIG01015773 FIG01015774: hypothetical protein +FIG01015775 Similarity to probable RND efflux transporter +FIG01015777 FIG01015778: hypothetical protein +FIG01015778 FIG01015780: hypothetical protein +FIG01015780 FIG01015781: hypothetical protein +FIG01015781 FIG01015783: hypothetical protein +FIG01015789 FIG01015790: hypothetical protein +FIG01015790 FIG01015791: hypothetical protein +FIG01015791 FIG01015793: hypothetical protein +FIG01015793 FIG01015794: hypothetical protein +FIG01015795 FIG01015796: hypothetical protein +FIG01015797 FIG01015798: hypothetical protein +FIG01015798 FIG01015800: hypothetical protein +FIG01015800 FIG01015801: hypothetical protein +FIG01015801 FIG01015802: hypothetical protein +FIG01015802 FIG01015803: hypothetical protein +FIG01015804 FIG01015805: hypothetical protein +FIG01015811 FIG01015812: hypothetical protein +FIG01015812 FIG01015813: hypothetical protein +FIG01015814 FIG01015816: hypothetical protein +FIG01015816 FIG01015821: hypothetical protein +FIG01015821 FIG01015823: hypothetical protein +FIG01015826 FIG01015828: hypothetical protein +FIG01015828 FIG01015829: hypothetical protein +FIG01015829 FIG01015831: hypothetical protein +FIG01015831 FIG01015836: hypothetical protein +FIG01015836 Erythrocyte adducin alpha subunit +FIG01015838 FIG01015840: hypothetical protein +FIG01015841 FIG01015843: hypothetical protein +FIG01015844 FIG01015846: hypothetical protein +FIG01015846 FIG01015847: hypothetical protein +FIG01015854 FIG01015855: hypothetical protein +FIG01015866 FIG01015868: hypothetical protein +FIG01015869 FIG01015870: hypothetical protein +FIG01015872 FIG01015874: hypothetical protein +FIG01015877 AtrC1-like cationic amino acid transporter protein +FIG01015878 FIG01015881: hypothetical protein +FIG01015883 similarity to beta-lactamase +FIG01015886 FIG01015887: hypothetical protein +FIG01015888 FIG01015889: hypothetical protein +FIG01015889 FIG01015892: hypothetical protein +FIG01015892 FIG01015894: hypothetical protein +FIG01015894 FIG01015895: hypothetical protein +FIG01015895 FIG01015897: hypothetical protein +FIG01015899 FIG01015901: hypothetical protein +FIG01015901 FIG01015902: hypothetical protein +FIG01015902 FIG01015904: hypothetical protein +FIG01015904 FIG01015905: hypothetical protein +FIG01015905 FIG01015907: hypothetical protein +FIG01015909 FIG01015910: hypothetical protein +FIG01015910 similarity to (p)ppGpp 3-pyrophosphohydrolase +FIG01015915 FIG01015916: hypothetical protein +FIG01015916 COG1872 +FIG01015917 FIG01015919: hypothetical protein +FIG01015921 FIG01015922: hypothetical protein +FIG01015922 FIG01015925: hypothetical protein +FIG01015928 FIG01015929: hypothetical protein +FIG01015929 FIG01015934: hypothetical protein +FIG01015934 hypothetical protein +FIG01015935 FIG01015937: hypothetical protein +FIG01015937 FIG01015938: hypothetical protein +FIG01015940 FIG01015941: hypothetical protein +FIG01015942 FIG01015943: hypothetical protein +FIG01015943 FIG01015946: hypothetical protein +FIG01015946 FIG01015947: hypothetical protein +FIG01015947 FIG01015948: hypothetical protein +FIG01015948 FIG01015949: hypothetical protein +FIG01015950 FIG01015951: hypothetical protein +FIG01015951 FIG01015953: hypothetical protein +FIG01015953 FIG01015955: hypothetical protein +FIG01015955 FIG01015956: hypothetical protein +FIG01015956 FIG01015958: hypothetical protein +FIG01015958 FIG01015959: hypothetical protein +FIG01015963 FIG01015965: hypothetical protein +FIG01015965 proline/betaine transporter +FIG01015969 FIG01015971: hypothetical protein +FIG01015971 FIG01015974: hypothetical protein +FIG01015974 FIG01015976: hypothetical protein +FIG01015976 FIG01015978: hypothetical protein +FIG01015981 FIG01015985: hypothetical protein +FIG01015985 FIG01015986: hypothetical protein +FIG01015986 FIG01015988: hypothetical protein +FIG01015993 FIG01015995: hypothetical protein +FIG01015997 FIG01015998: hypothetical protein +FIG01015999 FIG01016000: hypothetical protein +FIG01016000 FIG01016001: hypothetical protein +FIG01016002 FIG01016005: hypothetical protein +FIG01016005 FIG01016006: hypothetical protein +FIG01016009 FIG01016010: hypothetical protein +FIG01016010 FIG01016011: hypothetical protein +FIG01016016 FIG01016017: hypothetical protein +FIG01016017 FIG01016019: hypothetical protein +FIG01016019 FIG01016020: hypothetical protein +FIG01016020 FIG01016022: hypothetical protein +FIG01016029 FIG01016030: hypothetical protein +FIG01016032 FIG01016033: hypothetical protein +FIG01016033 FIG01016034: hypothetical protein +FIG01016035 FIG01016038: hypothetical protein +FIG01016039 FIG01016041: hypothetical protein +FIG01016042 FIG01016044: hypothetical protein +FIG01016044 FIG01016048: hypothetical protein +FIG01016048 FIG01016050: hypothetical protein +FIG01016054 FIG01016056: hypothetical protein +FIG01016057 FIG01016058: hypothetical protein +FIG01016058 FIG01016059: hypothetical protein +FIG01016059 FIG01016061: hypothetical protein +FIG01016061 FIG01016062: hypothetical protein +FIG01016062 FIG01016064: hypothetical protein +FIG01016064 FIG01016066: hypothetical protein +FIG01016066 FIG01016070: hypothetical protein +FIG01016074 FIG01016075: hypothetical protein +FIG01016076 FIG01016077: hypothetical protein +FIG01016077 FIG01016078: hypothetical protein +FIG01016078 FIG01016080: hypothetical protein +FIG01016084 FIG01016085: hypothetical protein +FIG01016085 FIG01016087: hypothetical protein +FIG01016093 FIG01016094: hypothetical protein +FIG01016094 FIG01016095: hypothetical protein +FIG01016095 FIG01016099: hypothetical protein +FIG01016099 FIG01016101: hypothetical protein +FIG01016101 FIG01016104: hypothetical protein +FIG01016104 FIG01016107: hypothetical protein +FIG01016107 FIG01016108: hypothetical protein +FIG01016109 FIG01016110: hypothetical protein +FIG01016110 FIG01016112: hypothetical protein +FIG01016113 FIG01016114: hypothetical protein +FIG01016114 FIG01016115: hypothetical protein +FIG01016115 FIG01016116: hypothetical protein +FIG01016117 FIG01016118: hypothetical protein +FIG01016118 FIG01016120: hypothetical protein +FIG01016122 FIG01016125: hypothetical protein +FIG01016126 FIG01016127: hypothetical protein +FIG01016127 FIG01016128: hypothetical protein +FIG01016129 FIG01016132: hypothetical protein +FIG01016136 FIG01016137: hypothetical protein +FIG01016137 FIG01016139: hypothetical protein +FIG01016139 FIG01016141: hypothetical protein +FIG01016141 FIG01016142: hypothetical protein +FIG01016142 FIG01016143: hypothetical protein +FIG01016144 FIG01016145: hypothetical protein +FIG01016145 FIG01016146: hypothetical protein +FIG01016146 FIG01016147: hypothetical protein +FIG01016147 hypothetical multidrug resistance protein +FIG01016148 FIG01016152: hypothetical protein +FIG01016152 FIG01016153: hypothetical protein +FIG01016153 FIG01016154: hypothetical protein +FIG01016154 FIG01016155: hypothetical protein +FIG01016157 FIG01016159: hypothetical protein +FIG01016161 FIG01016162: hypothetical protein +FIG01016162 FIG01016163: hypothetical protein +FIG01016166 FIG01016167: hypothetical protein +FIG01016167 FIG01016170: hypothetical protein +FIG01016170 FIG01016172: hypothetical protein +FIG01016172 FIG01016173: hypothetical protein +FIG01016173 FIG01016174: hypothetical protein +FIG01016175 FIG01016176: hypothetical protein +FIG01016180 FIG01016181: hypothetical protein +FIG01016181 FIG01016182: hypothetical protein +FIG01016182 FIG01016185: hypothetical protein +FIG01016189 FIG01016190: hypothetical protein +FIG01016190 FIG01016191: hypothetical protein +FIG01016191 FIG01016192: hypothetical protein +FIG01016192 FIG01016193: hypothetical protein +FIG01016193 FIG01016197: hypothetical protein +FIG01016198 FIG01016199: hypothetical protein +FIG01016199 FIG01016200: hypothetical protein +FIG01016201 FIG01016204: hypothetical protein +FIG01016207 FIG01016209: hypothetical protein +FIG01016209 FIG01016211: hypothetical protein +FIG01016211 FIG01016212: hypothetical protein +FIG01016212 FIG01016213: hypothetical protein +FIG01016218 FIG01016219: hypothetical protein +FIG01016219 FIG01016221: hypothetical protein +FIG01016221 FIG01016223: hypothetical protein +FIG01016223 FIG01016227: hypothetical protein +FIG01016227 FIG01016229: hypothetical protein +FIG01016229 FIG01016231: hypothetical protein +FIG01016231 similarity to alkaline phosphatase synthesis sensor protein (phoR) +FIG01016233 FIG01016234: hypothetical protein +FIG01016234 FIG01016236: hypothetical protein +FIG01016237 FIG01016239: hypothetical protein +FIG01016240 FIG01016241: hypothetical protein +FIG01016241 FIG01016243: hypothetical protein +FIG01016252 FIG01016254: hypothetical protein +FIG01016260 FIG01016261: hypothetical protein +FIG01016261 FIG01016262: hypothetical protein +FIG01016262 FIG01016264: hypothetical protein +FIG01016264 FIG01016265: hypothetical protein +FIG01016269 FIG01016270: hypothetical protein +FIG01016270 tRNA pseudouridine synthase B (EC 4.2.1.70) +FIG01016274 FIG01016275: hypothetical protein +FIG01016275 FIG01016277: hypothetical protein +FIG01016277 FIG01016280: hypothetical protein +FIG01016280 FIG01016281: hypothetical protein +FIG01016281 FIG01016282: hypothetical protein +FIG01016283 FIG01016284: hypothetical protein +FIG01016284 FIG01016286: hypothetical protein +FIG01016287 FIG01016288: hypothetical protein +FIG01016292 FIG01016295: hypothetical protein +FIG01016295 FIG01016296: hypothetical protein +FIG01016298 FIG01016301: hypothetical protein +FIG01016307 FIG01016308: hypothetical protein +FIG01016310 FIG01016311: hypothetical protein +FIG01016311 FIG01016312: hypothetical protein +FIG01016312 FIG01016314: hypothetical protein +FIG01016314 FIG01016316: hypothetical protein +FIG01016317 FIG01016318: hypothetical protein +FIG01016319 FIG01016321: hypothetical protein +FIG01016323 FIG01016326: hypothetical protein +FIG01016326 FIG01016328: hypothetical protein +FIG01016331 FIG01016333: hypothetical protein +FIG01016334 FIG01016335: hypothetical protein +FIG01016335 FIG01016339: hypothetical protein +FIG01016340 FIG01016344: hypothetical protein +FIG01016347 hypothetical proline/betaine transporter +FIG01016348 FIG01016349: hypothetical protein +FIG01016349 FIG01016352: hypothetical protein +FIG01016352 FIG01016353: hypothetical protein +FIG01016353 FIG01016354: hypothetical protein +FIG01016354 FIG01016355: hypothetical protein +FIG01016355 FIG01016356: hypothetical protein +FIG01016356 FIG01016359: hypothetical protein +FIG01016359 FIG01016360: hypothetical protein +FIG01016360 FIG01016363: hypothetical protein +FIG01016363 FIG01016366: hypothetical protein +FIG01016366 FIG01016370: hypothetical protein +FIG01016370 FIG01016371: hypothetical protein +FIG01016381 FIG01016384: hypothetical protein +FIG01016384 FIG01016385: hypothetical protein +FIG01016385 FIG01016387: hypothetical protein +FIG01016387 FIG01016391: hypothetical protein +FIG01016391 FIG01016394: hypothetical protein +FIG01016394 FIG01016395: hypothetical protein +FIG01016395 FIG01016396: hypothetical protein +FIG01016396 FIG01016397: hypothetical protein +FIG01016397 FIG01016398: hypothetical protein +FIG01016398 Putative aspartyl protease +FIG01016399 FIG01016401: hypothetical protein +FIG01016401 similarity to O-linked GlcNAc transferase +FIG01016403 FIG01016404: hypothetical protein +FIG01016404 FIG01016406: hypothetical protein +FIG01016406 FIG01016410: hypothetical protein +FIG01016411 FIG01016413: hypothetical protein +FIG01016413 FIG01016416: hypothetical protein +FIG01016416 FIG01016417: hypothetical protein +FIG01016417 FIG01016422: hypothetical protein +FIG01016422 FIG01016423: hypothetical protein +FIG01016423 FIG01016427: hypothetical protein +FIG01016429 FIG01016430: hypothetical protein +FIG01016438 Protein export protein prsA precursor +FIG01016441 patatin b1 precursor +FIG01016444 FIG01016445: hypothetical protein +FIG01016449 FIG01016450: hypothetical protein +FIG01016450 FIG01016451: hypothetical protein +FIG01016451 FIG01016454: hypothetical protein +FIG01016454 FIG01016456: hypothetical protein +FIG01016456 FIG01016458: hypothetical protein +FIG01016458 FIG01016459: hypothetical protein +FIG01016459 FIG01016462: hypothetical protein +FIG01016462 virulence factor mviN +FIG01016463 FIG01016465: hypothetical protein +FIG01016465 FIG01016466: hypothetical protein +FIG01016466 FIG01016467: hypothetical protein +FIG01016467 FIG01016468: hypothetical protein +FIG01016468 FIG01016469: hypothetical protein +FIG01016469 FIG01016471: hypothetical protein +FIG01016471 FIG01016472: hypothetical protein +FIG01016472 FIG01016476: hypothetical protein +FIG01016481 FIG01016483: hypothetical protein +FIG01016483 FIG01016484: hypothetical protein +FIG01016484 FIG01016485: hypothetical protein +FIG01016488 FIG01016490: hypothetical protein +FIG01016490 FIG01016491: hypothetical protein +FIG01016492 murein peptide permease protein AmpG +FIG01016493 FIG01016497: hypothetical protein +FIG01016498 FIG01016502: hypothetical protein +FIG01016504 FIG01016505: hypothetical protein +FIG01016505 FIG01016506: hypothetical protein +FIG01016506 FIG01016509: hypothetical protein +FIG01016509 FIG01016510: hypothetical protein +FIG01016510 FIG01016514: hypothetical protein +FIG01016516 FIG01016517: hypothetical protein +FIG01016518 FIG01016520: hypothetical protein +FIG01016526 FIG01016529: hypothetical protein +FIG01016534 FIG01016538: hypothetical protein +FIG01016542 FIG01016543: hypothetical protein +FIG01016543 FIG01016548: hypothetical protein +FIG01016548 FIG01016549: hypothetical protein +FIG01016552 FIG01016558: hypothetical protein +FIG01016558 FIG01016559: hypothetical protein +FIG01016559 FIG01016560: hypothetical protein +FIG01016560 FIG01016561: hypothetical protein +FIG01016561 Guanosine polyphosphate pyrophosphohydrolases/synthetases homolog +FIG01016562 RelE/StbE replicon stabilization toxin +FIG01016564 FIG01016565: hypothetical protein +FIG01016565 FIG01016568: hypothetical protein +FIG01016569 FIG01016572: hypothetical protein +FIG01016572 hypothetical protein +FIG01016573 FIG01016576: hypothetical protein +FIG01016576 FIG01016577: hypothetical protein +FIG01016579 FIG01016581: hypothetical protein +FIG01016581 FIG01016582: hypothetical protein +FIG01016582 FIG01016585: hypothetical protein +FIG01016585 FIG01016586: hypothetical protein +FIG01016589 FIG01016590: hypothetical protein +FIG01016590 FIG01016591: hypothetical protein +FIG01016592 FIG01016594: hypothetical protein +FIG01016594 FIG01016595: hypothetical protein +FIG01016595 FIG01016596: hypothetical protein +FIG01016598 FIG01016599: hypothetical protein +FIG01016599 FIG01016603: hypothetical protein +FIG01016603 FIG01016604: hypothetical protein +FIG01016610 FIG01016612: hypothetical protein +FIG01016612 FIG01016615: hypothetical protein +FIG01016617 FIG01016621: hypothetical protein +FIG01016622 FIG01016624: hypothetical protein +FIG01016624 FIG01016627: hypothetical protein +FIG01016627 Putative DNA alkylation repair enzyme +FIG01016629 FIG01016630: hypothetical protein +FIG01016631 FIG01016634: hypothetical protein +FIG01016643 FIG01016645: hypothetical protein +FIG01016645 FIG01016647: hypothetical protein +FIG01016647 hypothetical probable RND efflux transporter +FIG01016649 similarity to acetyltransferases +FIG01016650 FIG01016651: hypothetical protein +FIG01016651 FIG01016652: hypothetical protein +FIG01016652 FIG01016653: hypothetical protein +FIG01016653 FIG01016654: hypothetical protein +FIG01016655 FIG01016657: hypothetical protein +FIG01016657 FIG01016658: hypothetical protein +FIG01016658 FIG01016663: hypothetical protein +FIG01016663 FIG01016665: hypothetical protein +FIG01016669 Nucleotidyltransferase +FIG01016673 FIG01016675: hypothetical protein +FIG01016676 FIG01016677: hypothetical protein +FIG01016679 FIG01016680: hypothetical protein +FIG01016701 FIG01016703: hypothetical protein +FIG01016703 FIG01016705: hypothetical protein +FIG01016705 FIG01016706: hypothetical protein +FIG01016707 FIG01016709: hypothetical protein +FIG01016709 FIG01016710: hypothetical protein +FIG01016710 FIG01016711: hypothetical protein +FIG01016711 FIG01016713: hypothetical protein +FIG01016713 FIG01016714: hypothetical protein +FIG01016717 FIG01016718: hypothetical protein +FIG01016724 FIG01016725: hypothetical protein +FIG01016731 FIG01016732: hypothetical protein +FIG01016732 FIG01016733: hypothetical protein +FIG01016735 FIG01016737: hypothetical protein +FIG01016737 FIG01016740: hypothetical protein +FIG01016747 FIG01016749: hypothetical protein +FIG01016749 FIG01018249: hypothetical protein +FIG01016754 FIG01016755: hypothetical protein +FIG01016756 FIG01016757: hypothetical protein +FIG01016758 FIG01016759: hypothetical protein +FIG01016759 FIG01016761: hypothetical protein +FIG01016761 FIG01016764: hypothetical protein +FIG01016771 FIG01016772: hypothetical protein +FIG01016772 FIG01016773: hypothetical protein +FIG01016775 FIG01016776: hypothetical protein +FIG01016776 FIG01016778: hypothetical protein +FIG01016778 FIG01016779: hypothetical protein +FIG01016779 FIG01016780: hypothetical protein +FIG01016780 FIG01016782: hypothetical protein +FIG01016782 FIG01016788: hypothetical protein +FIG01016788 FIG01016789: hypothetical protein +FIG01016789 FIG01016794: hypothetical protein +FIG01016794 FIG01016798: hypothetical protein +FIG01016803 FIG01016805: hypothetical protein +FIG01016814 FIG01016822: hypothetical protein +FIG01016822 FIG01016823: hypothetical protein +FIG01016823 FIG01016825: hypothetical protein +FIG01016825 FIG01016826: hypothetical protein +FIG01016828 FIG01016830: hypothetical protein +FIG01016830 FIG01016831: hypothetical protein +FIG01016833 FIG01016834: hypothetical protein +FIG01016837 hypothetical protein +FIG01016839 FIG01016841: hypothetical protein +FIG01016847 FIG01016848: hypothetical protein +FIG01016851 FIG01016854: hypothetical protein +FIG01016854 FIG01016856: hypothetical protein +FIG01016859 FIG01016860: hypothetical protein +FIG01016861 FIG01016862: hypothetical protein +FIG01016862 FIG01016864: hypothetical protein +FIG01016868 FIG01016869: hypothetical protein +FIG01016869 FIG01016871: hypothetical protein +FIG01016871 FIG01016875: hypothetical protein +FIG01016875 FIG01016878: hypothetical protein +FIG01016881 FIG01016883: hypothetical protein +FIG01016885 FIG01016886: hypothetical protein +FIG01016886 FIG01016887: hypothetical protein +FIG01016887 FIG01016889: hypothetical protein +FIG01016901 FIG01016904: hypothetical protein +FIG01016907 FIG01016909: hypothetical protein +FIG01016909 FIG01016911: hypothetical protein +FIG01016911 FIG01016913: hypothetical protein +FIG01016913 FIG01016914: hypothetical protein +FIG01016914 FIG01016916: hypothetical protein +FIG01016918 Chitin binding domain +FIG01016921 FIG01016922: hypothetical protein +FIG01016926 FIG01016930: hypothetical protein +FIG01016930 FIG01016931: hypothetical protein +FIG01016931 FIG01016932: hypothetical protein +FIG01016932 FIG01016933: hypothetical protein +FIG01016933 FIG01016935: hypothetical protein +FIG01016935 FIG01016939: hypothetical protein +FIG01016939 FIG01016944: hypothetical protein +FIG01016951 FIG01016952: hypothetical protein +FIG01016964 FIG01016965: hypothetical protein +FIG01016965 FIG01016968: hypothetical protein +FIG01016971 FIG01016972: hypothetical protein +FIG01016972 FIG01016973: hypothetical protein +FIG01016973 FIG01016975: hypothetical protein +FIG01016975 FIG01016978: hypothetical protein +FIG01016978 FIG01016979: hypothetical protein +FIG01016979 FIG01016980: hypothetical protein +FIG01016980 FIG01016981: hypothetical protein +FIG01016981 FIG01016984: hypothetical protein +FIG01016988 FIG01016989: hypothetical protein +FIG01016989 FIG01016991: hypothetical protein +FIG01016991 FIG01016994: hypothetical protein +FIG01016994 FIG01016995: hypothetical protein +FIG01017013 FIG01017014: hypothetical protein +FIG01017018 FIG01017020: hypothetical protein +FIG01017020 hypothetical protein +FIG01017023 Probable toxin of toxin-antitoxin system +FIG01017026 FIG01017031: hypothetical protein +FIG01017037 FIG01017038: hypothetical protein +FIG01017043 FIG01017046: hypothetical protein +FIG01017047 FIG01017048: hypothetical protein +FIG01017048 FIG01017051: hypothetical protein +FIG01017051 FIG01017052: hypothetical protein +FIG01017053 FIG01017055: hypothetical protein +FIG01017057 FIG01017058: hypothetical protein +FIG01017061 FIG01017065: hypothetical protein +FIG01017065 FIG01017067: hypothetical protein +FIG01017067 FIG01017070: hypothetical protein +FIG01017073 Heat shock protease (EC 3.4.21.-) +FIG01017083 FIG01017086: hypothetical protein +FIG01017086 FIG01017087: hypothetical protein +FIG01017087 FIG01017088: hypothetical protein +FIG01017088 hypothetical tryptophan repressor binding protein +FIG01017091 FIG01017093: hypothetical protein +FIG01017093 FIG01017097: hypothetical protein +FIG01017097 FIG01017098: hypothetical protein +FIG01017099 FIG01017103: hypothetical protein +FIG01017103 FIG01017104: hypothetical protein +FIG01017104 FIG01017107: hypothetical protein +FIG01017109 FIG01017110: hypothetical protein +FIG01017110 FIG01017111: hypothetical protein +FIG01017111 FIG01017112: hypothetical protein +FIG01017112 FIG01017114: hypothetical protein +FIG01017114 FIG01017115: hypothetical protein +FIG01017118 FIG01017121: hypothetical protein +FIG01017121 FIG01017124: hypothetical protein +FIG01017131 FIG01017133: hypothetical protein +FIG01017133 FIG01017134: hypothetical protein +FIG01017135 FIG01017136: hypothetical protein +FIG01017136 FIG01017139: hypothetical protein +FIG01017153 FIG01017154: hypothetical protein +FIG01017160 FIG01017161: hypothetical protein +FIG01017164 FIG01017165: hypothetical protein +FIG01017165 FIG01017166: hypothetical protein +FIG01017168 FIG01017169: hypothetical protein +FIG01017169 FIG01017172: hypothetical protein +FIG01017175 FIG01017177: hypothetical protein +FIG01017177 FIG01017181: hypothetical protein +FIG01017183 FIG01017189: hypothetical protein +FIG01017190 FIG01017192: hypothetical protein +FIG01017192 FIG01017193: hypothetical protein +FIG01017193 FIG01017197: hypothetical protein +FIG01017198 FIG01017199: hypothetical protein +FIG01017200 FIG01017201: hypothetical protein +FIG01017201 FIG01017203: hypothetical protein +FIG01017203 FIG01017204: hypothetical protein +FIG01017204 FIG01017205: hypothetical protein +FIG01017205 FIG01017209: hypothetical protein +FIG01017209 FIG01017213: hypothetical protein +FIG01017223 FIG01017226: hypothetical protein +FIG01017229 FIG01017249: hypothetical protein +FIG01017251 FIG01017255: hypothetical protein +FIG01017256 Probable Co/Zn/Cd efflux system membrane fusion protein +FIG01017259 FIG01017263: hypothetical protein +FIG01017267 FIG01017270: hypothetical protein +FIG01017271 FIG01017273: hypothetical protein +FIG01017276 FIG01017285: hypothetical protein +FIG01017285 ALKALINE PHOSPHATASE SYNTHESIS SENSOR PROTEIN PHOR (phoR) +FIG01017307 FIG01017309: hypothetical protein +FIG01017313 FIG01017316: hypothetical protein +FIG01017319 FIG01017321: hypothetical protein +FIG01017321 FIG01017323: hypothetical protein +FIG01017323 FIG01017325: hypothetical protein +FIG01017327 FIG01017328: hypothetical protein +FIG01017328 FIG01017330: hypothetical protein +FIG01017330 FIG01017332: hypothetical protein +FIG01017335 FIG01017340: hypothetical protein +FIG01017340 FIG01017344: hypothetical protein +FIG01017344 FIG01017347: hypothetical protein +FIG01017347 FIG01017348: hypothetical protein +FIG01017352 FIG01017353: hypothetical protein +FIG01017355 hypothetical protein +FIG01017356 FIG01017359: hypothetical protein +FIG01017359 FIG01017360: hypothetical protein +FIG01017360 FIG01017363: hypothetical protein +FIG01017364 FIG01017365: hypothetical protein +FIG01017365 FIG01017366: hypothetical protein +FIG01017367 FIG01017370: hypothetical protein +FIG01017371 FIG01017372: hypothetical protein +FIG01017372 similarity to alpha-(1,3)-fucosyltransferase +FIG01017381 FIG01017383: hypothetical protein +FIG01017383 FIG01017384: hypothetical protein +FIG01017385 FIG01017388: hypothetical protein +FIG01017388 FIG01017389: hypothetical protein +FIG01017389 FIG01017390: hypothetical protein +FIG01017406 FIG01017408: hypothetical protein +FIG01017408 FIG01017409: hypothetical protein +FIG01017411 FIG01017413: hypothetical protein +FIG01017413 FIG01017415: hypothetical protein +FIG01017415 FIG01017418: hypothetical protein +FIG01017424 FIG01017429: hypothetical protein +FIG01017433 FIG01017434: hypothetical protein +FIG01017436 FIG01017441: hypothetical protein +FIG01017441 FIG01017443: hypothetical protein +FIG01017443 FIG01017444: hypothetical protein +FIG01017444 FIG01017449: hypothetical protein +FIG01017454 Conjugal transfer protein, TraA +FIG01017457 FIG01017459: hypothetical protein +FIG01017461 FIG01017462: hypothetical protein +FIG01017462 FIG01017463: hypothetical protein +FIG01017468 FIG01017470: hypothetical protein +FIG01017474 FIG01017478: hypothetical protein +FIG01017480 FIG01017481: hypothetical protein +FIG01017481 FIG01017484: hypothetical protein +FIG01017484 FIG01017488: hypothetical protein +FIG01017488 FIG01017491: hypothetical protein +FIG01017491 FIG01017498: hypothetical protein +FIG01017513 FIG01017516: hypothetical protein +FIG01017519 FIG01017520: hypothetical protein +FIG01017523 FIG01017524: hypothetical protein +FIG01017532 FIG01017533: hypothetical protein +FIG01017538 FIG01017542: hypothetical protein +FIG01017542 FIG01017543: hypothetical protein +FIG01017543 FIG01017547: hypothetical protein +FIG01017547 FIG01017549: hypothetical protein +FIG01017549 FIG01017552: hypothetical protein +FIG01017552 FIG01017555: hypothetical protein +FIG01017555 FIG01017558: hypothetical protein +FIG01017558 FIG01017559: hypothetical protein +FIG01017559 FIG01017561: hypothetical protein +FIG01017561 FIG01017564: hypothetical protein +FIG01017564 FIG01017570: hypothetical protein +FIG01017575 FIG01017577: hypothetical protein +FIG01017577 FIG01017578: hypothetical protein +FIG01017578 FIG01017580: hypothetical protein +FIG01017586 FIG01017587: hypothetical protein +FIG01017589 FIG01017591: hypothetical protein +FIG01017596 FIG01017597: hypothetical protein +FIG01017597 FIG01017599: hypothetical protein +FIG01017601 FIG01017603: hypothetical protein +FIG01017603 FIG01017605: hypothetical protein +FIG01017605 FIG01017610: hypothetical protein +FIG01017611 FIG01017612: hypothetical protein +FIG01017612 FIG01017614: hypothetical protein +FIG01017614 FIG01017621: hypothetical protein +FIG01017623 FIG01017627: hypothetical protein +FIG01017627 FIG01017631: hypothetical protein +FIG01017638 FIG01017639: hypothetical protein +FIG01017639 FIG01017644: hypothetical protein +FIG01017656 FIG01017661: hypothetical protein +FIG01017664 FIG01017666: hypothetical protein +FIG01017667 FIG01017672: hypothetical protein +FIG01017672 FIG01017681: hypothetical protein +FIG01017681 FIG01017684: hypothetical protein +FIG01017685 FIG01017688: hypothetical protein +FIG01017688 FIG01017691: hypothetical protein +FIG01017691 FIG01017693: hypothetical protein +FIG01017695 FIG01017698: hypothetical protein +FIG01017708 FIG01017709: hypothetical protein +FIG01017709 FIG01017714: hypothetical protein +FIG01017719 FIG01017721: hypothetical protein +FIG01017721 FIG01017722: hypothetical protein +FIG01017725 FIG01017728: hypothetical protein +FIG01017740 FIG01017742: hypothetical protein +FIG01017742 FIG01017749: hypothetical protein +FIG01017750 FIG01017755: hypothetical protein +FIG01017755 FIG01017758: hypothetical protein +FIG01017766 FIG01017767: hypothetical protein +FIG01017767 FIG01017774: hypothetical protein +FIG01017774 FIG01017776: hypothetical protein +FIG01017776 similarity to cation transport regulator ChaB +FIG01017779 FIG01017782: hypothetical protein +FIG01017782 FIG01017785: hypothetical protein +FIG01017785 FIG01017786: hypothetical protein +FIG01017787 FIG01017791: hypothetical protein +FIG01017792 FIG01017793: hypothetical protein +FIG01017806 FIG01017808: hypothetical protein +FIG01017808 FIG01017809: hypothetical protein +FIG01017810 FIG01017812: hypothetical protein +FIG01017822 FIG01017823: hypothetical protein +FIG01017863 FIG01017864: hypothetical protein +FIG01017902 FIG01017905: hypothetical protein +FIG01017935 FIG01017936: hypothetical protein +FIG01017941 FIG01017944: hypothetical protein +FIG01017946 FIG01017949: hypothetical protein +FIG01017954 FIG01017956: hypothetical protein +FIG01017956 FIG01017964: hypothetical protein +FIG01017970 FIG01017972: hypothetical protein +FIG01017972 outer membrane antigenic lipoprotein B precursor +FIG01017975 FIG01017976: hypothetical protein +FIG01017976 FIG01017979: hypothetical protein +FIG01017981 FIG01017983: hypothetical protein +FIG01017991 FIG01017994: hypothetical protein +FIG01017994 FIG01017995: hypothetical protein +FIG01018000 FIG01018003: hypothetical protein +FIG01018015 FIG01018018: hypothetical protein +FIG01018018 FIG01018021: hypothetical protein +FIG01018021 FIG01018027: hypothetical protein +FIG01018030 FIG01018035: hypothetical protein +FIG01018035 FIG01018037: hypothetical protein +FIG01018039 FIG01018042: hypothetical protein +FIG01018059 FIG01018062: hypothetical protein +FIG01018062 FIG01018070: hypothetical protein +FIG01018073 FIG01018076: hypothetical protein +FIG01018088 FIG01018092: hypothetical protein +FIG01018100 FIG01018111: hypothetical protein +FIG01018112 FIG01018113: hypothetical protein +FIG01018116 FIG01018117: hypothetical protein +FIG01018138 FIG01018139: hypothetical protein +FIG01018139 FIG01018143: hypothetical protein +FIG01018143 FIG01018144: hypothetical protein +FIG01018144 FIG01018148: hypothetical protein +FIG01018165 Cationic amino acid transporter-1 +FIG01018179 FIG01018181: hypothetical protein +FIG01018184 FIG01018185: hypothetical protein +FIG01018185 FIG01018186: hypothetical protein +FIG01018193 FIG01018194: hypothetical protein +FIG01018197 FIG01018199: hypothetical protein +FIG01018199 FIG01018200: hypothetical protein +FIG01018200 hypothetical protein +FIG01018217 COG2217: Cation transport ATPase +FIG01018228 FIG01018229: hypothetical protein +FIG01018231 FIG01018233: hypothetical protein +FIG01018253 FIG01018256: hypothetical protein +FIG01018288 FIG01018290: hypothetical protein +FIG01018308 FIG01018312: hypothetical protein +FIG01018312 FIG01018316: hypothetical protein +FIG01018317 FIG01018320: hypothetical protein +FIG01018324 FIG01018325: hypothetical protein +FIG01018325 FIG01018334: hypothetical protein +FIG01018353 FIG01018360: hypothetical protein +FIG01018376 FIG01018382: hypothetical protein +FIG01018396 FIG01018406: hypothetical protein +FIG01018425 FIG01018436: hypothetical protein +FIG01018438 FIG01018439: hypothetical protein +FIG01018459 FIG01018464: hypothetical protein +FIG01018467 FIG01018470: hypothetical protein +FIG01018504 FIG01018506: hypothetical protein +FIG01018506 FIG01018520: hypothetical protein +FIG01018640 FIG01018642: hypothetical protein +FIG01018672 FIG01018673: hypothetical protein +FIG01018678 FIG01018681: hypothetical protein +FIG01018681 FIG01018683: hypothetical protein +FIG01018691 FIG01018693: hypothetical protein +FIG01018717 FIG01018718: hypothetical protein +FIG01018764 FIG01018766: hypothetical protein +FIG01018786 FIG01018788: hypothetical protein +FIG01018793 FIG01018801: hypothetical protein +FIG01018830 FIG01018836: hypothetical protein +FIG01018882 FIG01018883: hypothetical protein +FIG01018952 FIG01018953: hypothetical protein +FIG01019045 FIG01019052: hypothetical protein +FIG01019064 FIG01019066: hypothetical protein +FIG01019076 FIG01019077: hypothetical protein +FIG01019121 FIG01019124: hypothetical protein +FIG01019134 FIG01019137: hypothetical protein +FIG01019157 FIG01019158: hypothetical protein +FIG01019191 FIG01019200: hypothetical protein +FIG01019209 FIG01019210: hypothetical protein +FIG01019213 FIG01019216: hypothetical protein +FIG01019230 FIG01019231: hypothetical protein +FIG01019235 FIG01019239: hypothetical protein +FIG01019241 FIG01019242: hypothetical protein +FIG01019247 FIG01019249: hypothetical protein +FIG01019291 Mlr4660 protein +FIG01019292 FIG01019293: hypothetical protein +FIG01019335 FIG01019336: hypothetical protein +FIG01019379 FIG01019380: hypothetical protein +FIG01019439 FIG01019447: hypothetical protein +FIG01019447 FIG01019449: hypothetical protein +FIG01019454 FIG01019460: hypothetical protein +FIG01019465 Peptidase M1 family protein +FIG01019485 FIG01019486: hypothetical protein +FIG01019486 FIG01019488: hypothetical protein +FIG01019522 FIG01019523: hypothetical protein +FIG01019534 FIG01019539: hypothetical protein +FIG01019596 FIG01019599: hypothetical protein +FIG01019614 FIG01019616: hypothetical protein +FIG01019655 endo-1,4-beta-xylanase B +FIG01019673 FIG01019675: hypothetical protein +FIG01019688 Putative alkaline phosphatase synthesis transcriptional regulatory protein +FIG01019709 FIG01019711: hypothetical protein +FIG01019740 FIG01019750: hypothetical protein +FIG01019781 FIG01019782: hypothetical protein +FIG01019789 FIG01019791: hypothetical protein +FIG01019797 FIG01019798: hypothetical protein +FIG01019827 FIG01019835: hypothetical protein +FIG01019912 FIG01019913: hypothetical protein +FIG01019926 tRNA and rRNA cytosine-C5-methylase +FIG01019930 Gll0560 protein +FIG01019931 FIG01019933: hypothetical protein +FIG01019933 FIG00521985: hypothetical protein +FIG01019938 rhoptry protein +FIG01019941 FIG01019942: hypothetical protein +FIG01019942 FIG01019944: hypothetical protein +FIG01019944 Flagellar biosynthesis protein fliS +FIG01019945 FIG01019947: hypothetical protein +FIG01019947 FIG01019949: hypothetical protein +FIG01019949 FIG01019950: hypothetical protein +FIG01019950 FIG01019951: hypothetical protein +FIG01019951 FIG01019952: hypothetical protein +FIG01019953 spore cortex-lytic enzyme SleC +FIG01019960 FIG01019964: hypothetical protein +FIG01019964 FIG01019966: hypothetical protein +FIG01019966 FIG01019967: hypothetical protein +FIG01019970 FIG01019974: hypothetical protein +FIG01019974 FIG01019975: hypothetical protein +FIG01019975 FIG01019976: hypothetical protein +FIG01019978 FIG01019979: hypothetical protein +FIG01019979 FIG01019980: hypothetical protein +FIG01019986 FIG01019987: hypothetical protein +FIG01019997 FIG01019998: hypothetical protein +FIG01019999 FIG01020002: hypothetical protein +FIG01020005 FIG01020006: hypothetical protein +FIG01020006 FIG00522739: hypothetical protein +FIG01020008 FIG01020010: hypothetical protein +FIG01020014 FIG01020016: hypothetical protein +FIG01020020 FIG01020022: hypothetical protein +FIG01020024 FIG01020026: hypothetical protein +FIG01020028 FIG01020029: hypothetical protein +FIG01020036 FIG01020038: hypothetical protein +FIG01020040 Acyl-acyl carrier protein thioesterase +FIG01020043 FIG01020046: hypothetical protein +FIG01020046 FIG01020048: hypothetical protein +FIG01020048 FIG01020049: hypothetical protein +FIG01020050 FIG01020051: hypothetical protein +FIG01020053 FIG01020054: hypothetical protein +FIG01020054 FIG01020055: hypothetical protein +FIG01020058 FIG01020059: hypothetical protein +FIG01020061 FIG01020066: hypothetical protein +FIG01020074 FIG01020076: hypothetical protein +FIG01020076 FIG01020077: hypothetical protein +FIG01020079 FIG01020080: hypothetical protein +FIG01020080 FIG01020081: hypothetical protein +FIG01020086 FIG01020088: hypothetical protein +FIG01020088 FIG01020089: hypothetical protein +FIG01020089 FIG01020090: hypothetical protein +FIG01020090 SpoVT/AbrB-like +FIG01020096 FIG01020097: hypothetical protein +FIG01020097 FIG01020098: hypothetical protein +FIG01020103 FIG01020104: hypothetical protein +FIG01020104 FIG01020105: hypothetical protein +FIG01020105 FIG01020106: hypothetical protein +FIG01020106 FIG01020107: hypothetical protein +FIG01020109 xanthine dehydrogenase iron-sulfur binding subunit +FIG01020111 FIG01020113: hypothetical protein +FIG01020116 FIG01020117: hypothetical protein +FIG01020117 FIG01020118: hypothetical protein +FIG01020118 FIG01020122: hypothetical protein +FIG01020122 uncharacterized protein +FIG01020127 FIG01020128: hypothetical protein +FIG01020128 FIG01020129: hypothetical protein +FIG01020133 FIG01020134: hypothetical protein +FIG01020136 FIG01020137: hypothetical protein +FIG01020137 FIG01020138: hypothetical protein +FIG01020141 FIG01020142: hypothetical protein +FIG01020145 FIG01020148: hypothetical protein +FIG01020151 FIG01020155: hypothetical protein +FIG01020156 FIG01020158: hypothetical protein +FIG01020158 FIG01020160: hypothetical protein +FIG01020163 FIG01020164: hypothetical protein +FIG01020166 FIG01020168: hypothetical protein +FIG01020168 FIG01020169: hypothetical protein +FIG01020169 FIG01020170: hypothetical protein +FIG01020170 sporulation protein +FIG01020172 FIG01020174: hypothetical protein +FIG01020174 FIG01020176: hypothetical protein +FIG01020179 FIG01020180: hypothetical protein +FIG01020186 FIG01020189: hypothetical protein +FIG01020189 FIG01020190: hypothetical protein +FIG01020190 FIG01020192: hypothetical protein +FIG01020197 FIG01020199: hypothetical protein +FIG01020199 FIG01020201: hypothetical protein +FIG01020202 FIG01020204: hypothetical protein +FIG01020204 FIG01020205: hypothetical protein +FIG01020207 FIG01020208: hypothetical protein +FIG01020210 Stage III sporulation protein AB +FIG01020215 FIG01020216: hypothetical protein +FIG01020223 LtrC +FIG01020225 FIG01020226: hypothetical protein +FIG01020234 FIG01020235: hypothetical protein +FIG01020237 FIG01020238: hypothetical protein +FIG01020241 FIG01020243: hypothetical protein +FIG01020243 FIG01020244: hypothetical protein +FIG01020246 FIG01020249: hypothetical protein +FIG01020250 FIG01020252: hypothetical protein +FIG01020252 FIG01020253: hypothetical protein +FIG01020255 FIG01020257: hypothetical protein +FIG01020258 FIG01020261: hypothetical protein +FIG01020265 Putative RNA methylase +FIG01020269 FIG01020270: hypothetical protein +FIG01020270 FIG01020271: hypothetical protein +FIG01020276 FIG01020277: hypothetical protein +FIG01020287 FIG01020288: hypothetical protein +FIG01020292 FIG01020293: hypothetical protein +FIG01020293 FIG01020295: hypothetical protein +FIG01020299 FIG01020301: hypothetical protein +FIG01020301 FIG01020303: hypothetical protein +FIG01020304 FIG01020306: hypothetical protein +FIG01020309 FIG01020311: hypothetical protein +FIG01020314 FIG01020316: hypothetical protein +FIG01020316 FIG01020317: hypothetical protein +FIG01020318 FIG01020320: hypothetical protein +FIG01020321 FIG01020322: hypothetical protein +FIG01020322 FIG01020324: hypothetical protein +FIG01020324 FIG01020325: hypothetical protein +FIG01020327 FIG01020329: hypothetical protein +FIG01020329 FIG01020332: hypothetical protein +FIG01020334 FIG01020335: hypothetical protein +FIG01020335 FIG01020336: hypothetical protein +FIG01020338 FIG01020339: hypothetical protein +FIG01020339 Protein of unknown function DUF477 +FIG01020344 FIG01020345: hypothetical protein +FIG01020353 UPF0059 membrane protein DSY1211 +FIG01020368 FIG01020372: hypothetical protein +FIG01020372 FIG01020376: hypothetical protein +FIG01020377 FIG01020378: hypothetical protein +FIG01020378 FIG01020379: hypothetical protein +FIG01020388 FIG01020390: hypothetical protein +FIG01020390 Anti-sigma-28 factor, FlgM +FIG01020396 FIG01020398: hypothetical protein +FIG01020404 FIG01020405: hypothetical protein +FIG01020405 possible microcin immunity protein +FIG01020408 FIG01020414: hypothetical protein +FIG01020416 FIG01020418: hypothetical protein +FIG01020418 FIG01020419: hypothetical protein +FIG01020419 FIG01020421: hypothetical protein +FIG01020421 FIG01020422: hypothetical protein +FIG01020424 FIG01020426: hypothetical protein +FIG01020426 FIG01020429: hypothetical protein +FIG01020429 FIG01020430: hypothetical protein +FIG01020430 FIG01020431: hypothetical protein +FIG01020431 FIG01020433: hypothetical protein +FIG01020433 FIG01020435: hypothetical protein +FIG01020435 FIG01020436: hypothetical protein +FIG01020436 FIG01020438: hypothetical protein +FIG01020438 FIG01020440: hypothetical protein +FIG01020440 Cna B domain protein +FIG01020443 FIG01020444: hypothetical protein +FIG01020444 FIG01020445: hypothetical protein +FIG01020446 FIG01020447: hypothetical protein +FIG01020447 FIG01020448: hypothetical protein +FIG01020451 FIG01020452: hypothetical protein +FIG01020452 FIG01020453: hypothetical protein +FIG01020453 FIG01020455: hypothetical protein +FIG01020455 Glucose-1-phosphate thymidylyltransferase homolog +FIG01020457 FIG01020458: hypothetical protein +FIG01020458 FIG01020459: hypothetical protein +FIG01020459 FIG01020462: hypothetical protein +FIG01020462 FIG01020463: hypothetical protein +FIG01020463 FIG01020464: hypothetical protein +FIG01020464 FIG01020465: hypothetical protein +FIG01020465 FIG01020466: hypothetical protein +FIG01020466 FIG01020467: hypothetical protein +FIG01020467 FIG01020468: hypothetical protein +FIG01020468 FIG01020469: hypothetical protein +FIG01020471 FIG01020474: hypothetical protein +FIG01020478 FIG01020481: hypothetical protein +FIG01020485 FIG01020486: hypothetical protein +FIG01020487 FIG01020489: hypothetical protein +FIG01020489 FIG01020493: hypothetical protein +FIG01020493 FIG01020496: hypothetical protein +FIG01020500 FIG01020501: hypothetical protein +FIG01020501 Erythrocyte membrane protein 1 +FIG01020502 FIG01020503: hypothetical protein +FIG01020503 FIG01020507: hypothetical protein +FIG01020508 FIG01020509: hypothetical protein +FIG01020509 FIG01020510: hypothetical protein +FIG01020513 FIG01020515: hypothetical protein +FIG01020515 FIG01020516: hypothetical protein +FIG01020518 FIG01020520: hypothetical protein +FIG01020520 FIG01020521: hypothetical protein +FIG01020522 FIG01020523: hypothetical protein +FIG01020524 FIG01020529: hypothetical protein +FIG01020529 FIG01020531: hypothetical protein +FIG01020531 FIG01020532: hypothetical protein +FIG01020532 FIG01020533: hypothetical protein +FIG01020533 FIG01020534: hypothetical protein +FIG01020534 FIG01020536: hypothetical protein +FIG01020539 FIG01020540: hypothetical protein +FIG01020540 FIG01020541: hypothetical protein +FIG01020541 Pentalenene synthase (EC 4.2.3.7) (PS) (Sesquiterpene synthase) (Sesquiterpene cyclase) +FIG01020545 FIG01020546: hypothetical protein +FIG01020547 PAS fold-4 domain protein +FIG01020550 FIG01020552: hypothetical protein +FIG01020552 FIG01020554: hypothetical protein +FIG01020555 FIG01020556: hypothetical protein +FIG01020558 FIG01020559: hypothetical protein +FIG01020560 FIG01020562: hypothetical protein +FIG01020564 Possible sugar ABC transporter, permease component 2 +FIG01020567 FIG01020568: hypothetical protein +FIG01020568 FIG01020569: hypothetical protein +FIG01020570 FIG01020575: hypothetical protein +FIG01020575 FIG01020577: hypothetical protein +FIG01020577 FIG01020578: hypothetical protein +FIG01020578 FIG01020583: hypothetical protein +FIG01020583 FIG01020584: hypothetical protein +FIG01020584 FIG01020585: hypothetical protein +FIG01020585 FIG01020586: hypothetical protein +FIG01020586 FIG00634587: hypothetical protein +FIG01020587 FIG01020589: hypothetical protein +FIG01020589 FIG01020590: hypothetical protein +FIG01020590 FIG01020591: hypothetical protein +FIG01020595 FIG01020598: hypothetical protein +FIG01020598 FIG01020601: hypothetical protein +FIG01020601 FIG01020604: hypothetical protein +FIG01020607 FIG01020608: hypothetical protein +FIG01020608 FIG01020610: hypothetical protein +FIG01020610 FIG01020617: hypothetical protein +FIG01020617 FIG01020621: hypothetical protein +FIG01020622 FIG01020623: hypothetical protein +FIG01020623 FIG01020626: hypothetical protein +FIG01020626 FIG01020627: hypothetical protein +FIG01020627 FIG01020629: hypothetical protein +FIG01020630 FIG01020631: hypothetical protein +FIG01020631 FIG01020632: hypothetical protein +FIG01020632 FIG01020634: hypothetical protein +FIG01020639 FIG01020641: hypothetical protein +FIG01020641 FIG01020643: hypothetical protein +FIG01020644 FIG01020645: hypothetical protein +FIG01020646 FIG01020650: hypothetical protein +FIG01020652 FIG01020653: hypothetical protein +FIG01020653 FIG01020654: hypothetical protein +FIG01020658 FIG01020659: hypothetical protein +FIG01020663 FIG01020664: hypothetical protein +FIG01020666 FIG01020668: hypothetical protein +FIG01020668 FIG01020671: hypothetical protein +FIG01020671 FIG01020673: hypothetical protein +FIG01020673 FIG01020675: hypothetical protein +FIG01020675 FIG01020676: hypothetical protein +FIG01020676 FIG01020678: hypothetical protein +FIG01020681 FIG01020684: hypothetical protein +FIG01020686 FIG01020687: hypothetical protein +FIG01020687 FIG01020690: hypothetical protein +FIG01020690 FIG01020691: hypothetical protein +FIG01020692 FIG01020693: hypothetical protein +FIG01020693 FIG01020696: hypothetical protein +FIG01020697 FIG01020698: hypothetical protein +FIG01020698 FIG01020699: hypothetical protein +FIG01020699 FIG01020700: hypothetical protein +FIG01020702 FIG01020705: hypothetical protein +FIG01020705 Bile-salt-activated lipase precursor (EC 3.1.1.3) (EC 3.1.1.13) +FIG01020706 FIG01020708: hypothetical protein +FIG01020708 FIG01020710: hypothetical protein +FIG01020712 FIG01020715: hypothetical protein +FIG01020715 FIG01020717: hypothetical protein +FIG01020717 FIG01020718: hypothetical protein +FIG01020720 FIG01020721: hypothetical protein +FIG01020721 FIG01020722: hypothetical protein +FIG01020726 FIG01020727: hypothetical protein +FIG01020728 FIG01020729: hypothetical protein +FIG01020729 FIG01020731: hypothetical protein +FIG01020732 FIG01020733: hypothetical protein +FIG01020733 FIG01020734: hypothetical protein +FIG01020734 FIG01020736: hypothetical protein +FIG01020736 FIG01020737: hypothetical protein +FIG01020737 FIG01020738: hypothetical protein +FIG01020738 FIG01020740: hypothetical protein +FIG01020740 FIG01020744: hypothetical protein +FIG01020744 FIG01020750: hypothetical protein +FIG01020750 FIG01020751: hypothetical protein +FIG01020751 FIG01020752: hypothetical protein +FIG01020752 FIG01020754: hypothetical protein +FIG01020757 FIG01020760: hypothetical protein +FIG01020762 FIG01020764: hypothetical protein +FIG01020764 FIG01020765: hypothetical protein +FIG01020765 FIG01020767: hypothetical protein +FIG01020768 FIG01020769: hypothetical protein +FIG01020769 FIG01020770: hypothetical protein +FIG01020771 FIG01020773: hypothetical protein +FIG01020773 FIG01020774: hypothetical protein +FIG01020774 FIG01020776: hypothetical protein +FIG01020776 FIG01020777: hypothetical protein +FIG01020777 FIG01020781: hypothetical protein +FIG01020781 FIG01020783: hypothetical protein +FIG01020783 FIG01020786: hypothetical protein +FIG01020794 FIG01020795: hypothetical protein +FIG01020795 FIG01020796: hypothetical protein +FIG01020796 FIG01020799: hypothetical protein +FIG01020799 FIG01020801: hypothetical protein +FIG01020801 FIG01020804: hypothetical protein +FIG01020807 FIG01020808: hypothetical protein +FIG01020809 FIG01020810: hypothetical protein +FIG01020810 FIG01020813: hypothetical protein +FIG01020813 FIG01020814: hypothetical protein +FIG01020819 FIG01020820: hypothetical protein +FIG01020820 FIG01020823: hypothetical protein +FIG01020823 FIG01020826: hypothetical protein +FIG01020826 FIG01020828: hypothetical protein +FIG01020828 FIG01020830: hypothetical protein +FIG01020830 FIG01020831: hypothetical protein +FIG01020832 FIG01020834: hypothetical protein +FIG01020834 FIG01020835: hypothetical protein +FIG01020835 FIG01020838: hypothetical protein +FIG01020838 FIG01020840: hypothetical protein +FIG01020840 FIG01020842: hypothetical protein +FIG01020842 FIG01020845: hypothetical protein +FIG01020845 FIG01020846: hypothetical protein +FIG01020846 FIG01020847: hypothetical protein +FIG01020847 FIG01020848: hypothetical protein +FIG01020848 FIG01020849: hypothetical protein +FIG01020849 FIG01020850: hypothetical protein +FIG01020850 FIG01020851: hypothetical protein +FIG01020851 FIG01020854: hypothetical protein +FIG01020856 FIG01020859: hypothetical protein +FIG01020859 FIG01020861: hypothetical protein +FIG01020861 FIG01020862: hypothetical protein +FIG01020864 FIG01020869: hypothetical protein +FIG01020869 FIG01020870: hypothetical protein +FIG01020870 FIG01020875: hypothetical protein +FIG01020875 CRISPR-associated protein, Cas5t family +FIG01020876 FIG01020877: hypothetical protein +FIG01020877 FIG01020878: hypothetical protein +FIG01020878 FIG01020881: hypothetical protein +FIG01020881 FIG01020882: hypothetical protein +FIG01020882 FIG01020883: hypothetical protein +FIG01020883 FIG01020884: hypothetical protein +FIG01020884 FIG01020885: hypothetical protein +FIG01020885 FIG01020889: hypothetical protein +FIG01020891 FIG01020892: hypothetical protein +FIG01020895 FIG01020896: hypothetical protein +FIG01020896 FIG01020897: hypothetical protein +FIG01020897 FIG01020901: hypothetical protein +FIG01020901 FIG01020902: hypothetical protein +FIG01020903 FIG01020904: hypothetical protein +FIG01020904 FIG01020905: hypothetical protein +FIG01020905 FIG01020906: hypothetical protein +FIG01020906 FIG01020907: hypothetical protein +FIG01020907 FIG01020910: hypothetical protein +FIG01020910 FIG01020912: hypothetical protein +FIG01020914 FIG01020916: hypothetical protein +FIG01020917 FIG01020918: hypothetical protein +FIG01020920 FIG01020921: hypothetical protein +FIG01020921 FIG01020923: hypothetical protein +FIG01020924 FIG01020930: hypothetical protein +FIG01020930 FIG01020935: hypothetical protein +FIG01020935 FIG01020936: hypothetical protein +FIG01020941 FIG01020942: hypothetical protein +FIG01020942 FIG01020944: hypothetical protein +FIG01020944 FIG01020945: hypothetical protein +FIG01020945 FIG01020947: hypothetical protein +FIG01020956 FIG01020957: hypothetical protein +FIG01020957 FIG01020958: hypothetical protein +FIG01020958 FIG01020959: hypothetical protein +FIG01020959 FIG01020960: hypothetical protein +FIG01020960 FIG01020963: hypothetical protein +FIG01020963 FIG01020964: hypothetical protein +FIG01020964 FIG01020968: hypothetical protein +FIG01020975 FIG01020978: hypothetical protein +FIG01020978 FIG01020979: hypothetical protein +FIG01020979 FIG01020982: hypothetical protein +FIG01020985 FIG01020987: hypothetical protein +FIG01020987 Aldehyde dehydrogenase family +FIG01020988 FIG01020989: hypothetical protein +FIG01020989 FIG01020990: hypothetical protein +FIG01020992 FIG01020993: hypothetical protein +FIG01020993 FIG01020994: hypothetical protein +FIG01020994 FIG01020996: hypothetical protein +FIG01020999 FIG01021000: hypothetical protein +FIG01021001 FIG01021002: hypothetical protein +FIG01021004 FIG01021006: hypothetical protein +FIG01021006 FIG01021008: hypothetical protein +FIG01021008 FIG01021009: hypothetical protein +FIG01021009 FIG01021012: hypothetical protein +FIG01021016 FIG01021017: hypothetical protein +FIG01021017 FIG01021018: hypothetical protein +FIG01021018 FIG01021019: hypothetical protein +FIG01021019 FIG01021020: hypothetical protein +FIG01021024 FIG01021025: hypothetical protein +FIG01021025 Periplasmic serine protease DO +FIG01021028 FIG01021031: hypothetical protein +FIG01021031 FIG01021032: hypothetical protein +FIG01021032 FIG01021033: hypothetical protein +FIG01021034 FIG01021036: hypothetical protein +FIG01021036 FIG01021037: hypothetical protein +FIG01021037 FIG01021040: hypothetical protein +FIG01021040 FIG01021044: hypothetical protein +FIG01021044 FIG01021046: hypothetical protein +FIG01021046 FIG01021048: hypothetical protein +FIG01021048 FIG01021050: hypothetical protein +FIG01021050 FIG01021051: hypothetical protein +FIG01021051 FIG01021054: hypothetical protein +FIG01021056 FIG01021058: hypothetical protein +FIG01021058 FIG01021059: hypothetical protein +FIG01021059 FIG01021060: hypothetical protein +FIG01021060 FIG01021062: hypothetical protein +FIG01021062 FIG01021063: hypothetical protein +FIG01021065 FIG01021066: hypothetical protein +FIG01021066 FIG01021069: hypothetical protein +FIG01021069 FIG01021072: hypothetical protein +FIG01021072 FIG01021073: hypothetical protein +FIG01021073 FIG01021074: hypothetical protein +FIG01021077 FIG01021079: hypothetical protein +FIG01021079 FIG01021083: hypothetical protein +FIG01021084 FIG01021085: hypothetical protein +FIG01021085 FIG01021086: hypothetical protein +FIG01021086 FIG01021087: hypothetical protein +FIG01021089 FIG01021092: hypothetical protein +FIG01021096 FIG01021097: hypothetical protein +FIG01021097 FIG01021100: hypothetical protein +FIG01021100 FIG01021101: hypothetical protein +FIG01021101 FIG01021103: hypothetical protein +FIG01021103 FIG01021105: hypothetical protein +FIG01021107 FIG01021109: hypothetical protein +FIG01021110 FIG01021111: hypothetical protein +FIG01021111 FIG01021114: hypothetical protein +FIG01021116 FIG01021117: hypothetical protein +FIG01021117 FIG01021118: hypothetical protein +FIG01021124 FIG01021127: hypothetical protein +FIG01021128 FIG01021130: hypothetical protein +FIG01021133 FIG01021134: hypothetical protein +FIG01021134 FIG01021135: hypothetical protein +FIG01021135 FIG01021137: hypothetical protein +FIG01021137 FIG01021139: hypothetical protein +FIG01021139 FIG01021142: hypothetical protein +FIG01021142 FIG01021144: hypothetical protein +FIG01021146 FIG01021147: hypothetical protein +FIG01021148 FIG01021149: hypothetical protein +FIG01021151 FIG01021153: hypothetical protein +FIG01021153 FIG01021154: hypothetical protein +FIG01021154 FIG01021155: hypothetical protein +FIG01021159 FIG01021160: hypothetical protein +FIG01021163 FIG01021165: hypothetical protein +FIG01021165 FIG01021168: hypothetical protein +FIG01021168 FIG01021169: hypothetical protein +FIG01021169 FIG01021170: hypothetical protein +FIG01021172 FIG01021173: hypothetical protein +FIG01021173 FIG01021174: hypothetical protein +FIG01021174 FIG01021176: hypothetical protein +FIG01021176 FIG01021177: hypothetical protein +FIG01021179 FIG01021181: hypothetical protein +FIG01021184 FIG01021186: hypothetical protein +FIG01021186 FIG01021187: hypothetical protein +FIG01021187 FIG01021188: hypothetical protein +FIG01021189 FIG01021191: hypothetical protein +FIG01021194 Peptidase M23/M37 family +FIG01021195 FIG01021197: hypothetical protein +FIG01021197 FIG01021198: hypothetical protein +FIG01021198 FIG01021199: hypothetical protein +FIG01021199 FIG01021201: hypothetical protein +FIG01021204 FIG01021206: hypothetical protein +FIG01021208 FIG01021209: hypothetical protein +FIG01021209 FIG01021210: hypothetical protein +FIG01021210 FIG01021211: hypothetical protein +FIG01021211 FIG01021212: hypothetical protein +FIG01021212 FIG01021213: hypothetical protein +FIG01021213 FIG01021214: hypothetical protein +FIG01021214 FIG01021215: hypothetical protein +FIG01021215 FIG01021218: hypothetical protein +FIG01021218 Na+ ABC transporter permease protein +FIG01021223 FIG01021224: hypothetical protein +FIG01021224 FIG01021227: hypothetical protein +FIG01021228 FIG01021231: hypothetical protein +FIG01021232 FIG01021233: hypothetical protein +FIG01021244 FIG01021248: hypothetical protein +FIG01021248 FIG01021249: hypothetical protein +FIG01021250 FIG01021252: hypothetical protein +FIG01021252 FIG01021255: hypothetical protein +FIG01021255 FIG01021257: hypothetical protein +FIG01021257 FIG01021258: hypothetical protein +FIG01021262 Gll0842 protein +FIG01021266 FIG01021267: hypothetical protein +FIG01021267 FIG01021268: hypothetical protein +FIG01021268 FIG01021269: hypothetical protein +FIG01021269 FIG01021270: hypothetical protein +FIG01021271 FIG01021275: hypothetical protein +FIG01021275 FIG01021276: hypothetical protein +FIG01021279 FIG01021280: hypothetical protein +FIG01021280 FIG01021284: hypothetical protein +FIG01021294 FIG01021295: hypothetical protein +FIG01021299 FIG01021300: hypothetical protein +FIG01021302 FIG01021303: hypothetical protein +FIG01021307 FIG01021311: hypothetical protein +FIG01021311 FIG01021313: hypothetical protein +FIG01021313 FIG01021314: hypothetical protein +FIG01021314 FIG01021315: hypothetical protein +FIG01021315 FIG01021316: hypothetical protein +FIG01021319 Transcriptional regulator, GerE family +FIG01021324 FIG01021326: hypothetical protein +FIG01021326 FIG01021328: hypothetical protein +FIG01021328 FIG01021331: hypothetical protein +FIG01021331 FIG01021334: hypothetical protein +FIG01021334 FIG01021335: hypothetical protein +FIG01021338 FIG01021339: hypothetical protein +FIG01021343 FIG01021344: hypothetical protein +FIG01021344 FIG01021345: hypothetical protein +FIG01021345 FIG01021347: hypothetical protein +FIG01021347 FIG01021348: hypothetical protein +FIG01021350 FIG01021352: hypothetical protein +FIG01021359 FIG01021361: hypothetical protein +FIG01021361 Glycoprotein X precursor +FIG01021362 FIG01021363: hypothetical protein +FIG01021367 FIG01021369: hypothetical protein +FIG01021369 FIG01021372: hypothetical protein +FIG01021372 FIG01021374: hypothetical protein +FIG01021375 FIG01021376: hypothetical protein +FIG01021376 FIG01021380: hypothetical protein +FIG01021389 FIG01021390: hypothetical protein +FIG01021390 FIG01021391: hypothetical protein +FIG01021391 FIG01021395: hypothetical protein +FIG01021395 FIG01021396: hypothetical protein +FIG01021396 FIG01021397: hypothetical protein +FIG01021397 FIG01021398: hypothetical protein +FIG01021398 Uncharacterized protein Mlr1045 +FIG01021400 FIG01021402: hypothetical protein +FIG01021402 FIG01021403: hypothetical protein +FIG01021403 FIG01021404: hypothetical protein +FIG01021406 FIG01021409: hypothetical protein +FIG01021409 FIG01021411: hypothetical protein +FIG01021411 FIG01021412: hypothetical protein +FIG01021412 FIG01021418: hypothetical protein +FIG01021419 FIG01021421: hypothetical protein +FIG01021421 FIG01021423: hypothetical protein +FIG01021423 FIG01021424: hypothetical protein +FIG01021424 FIG01021425: hypothetical protein +FIG01021425 FIG01021426: hypothetical protein +FIG01021428 FIG01021429: hypothetical protein +FIG01021430 FIG01021434: hypothetical protein +FIG01021434 FIG01021435: hypothetical protein +FIG01021435 FIG01021437: hypothetical protein +FIG01021437 FIG01021440: hypothetical protein +FIG01021440 FIG01021442: hypothetical protein +FIG01021442 FIG01021443: hypothetical protein +FIG01021446 FIG01021447: hypothetical protein +FIG01021447 integral membrane protein-like +FIG01021451 FIG01021452: hypothetical protein +FIG01021456 FIG01021457: hypothetical protein +FIG01021459 FIG01021460: hypothetical protein +FIG01021465 FIG01021467: hypothetical protein +FIG01021470 FIG01021471: hypothetical protein +FIG01021471 FIG01021473: hypothetical protein +FIG01021474 FIG01021475: hypothetical protein +FIG01021475 FIG01021476: hypothetical protein +FIG01021476 FIG01021480: hypothetical protein +FIG01021485 FIG01021486: hypothetical protein +FIG01021486 FIG01021487: hypothetical protein +FIG01021487 FIG01021490: hypothetical protein +FIG01021491 FIG01021495: hypothetical protein +FIG01021500 FIG01021503: hypothetical protein +FIG01021503 FIG01021504: hypothetical protein +FIG01021504 FIG01021505: hypothetical protein +FIG01021505 FIG01021508: hypothetical protein +FIG01021508 FIG01021509: hypothetical protein +FIG01021510 FIG01021511: hypothetical protein +FIG01021517 FIG01021521: hypothetical protein +FIG01021526 FIG01021527: hypothetical protein +FIG01021527 FIG01021528: hypothetical protein +FIG01021530 FIG01021532: hypothetical protein +FIG01021532 FIG01021533: hypothetical protein +FIG01021537 FIG01021538: hypothetical protein +FIG01021538 FIG01021539: hypothetical protein +FIG01021539 FIG01021540: hypothetical protein +FIG01021540 Iron repressor +FIG01021541 FIG01021543: hypothetical protein +FIG01021543 FIG01021545: hypothetical protein +FIG01021545 FIG01021547: hypothetical protein +FIG01021547 Sll0995 protein +FIG01021549 FIG01021550: hypothetical protein +FIG01021550 FIG01021551: hypothetical protein +FIG01021552 FIG01021553: hypothetical protein +FIG01021553 FIG01021554: hypothetical protein +FIG01021554 FIG01021557: hypothetical protein +FIG01021561 FIG01021563: hypothetical protein +FIG01021563 FIG01021564: hypothetical protein +FIG01021565 FIG01021570: hypothetical protein +FIG01021570 FIG01021571: hypothetical protein +FIG01021571 FIG01021572: hypothetical protein +FIG01021572 FIG01021573: hypothetical protein +FIG01021573 FIG01021575: hypothetical protein +FIG01021590 FIG01021592: hypothetical protein +FIG01021592 FIG01021593: hypothetical protein +FIG01021594 FIG01021597: hypothetical protein +FIG01021598 FIG01021601: hypothetical protein +FIG01021608 FIG01021609: hypothetical protein +FIG01021609 FIG01021610: hypothetical protein +FIG01021610 FIG01021612: hypothetical protein +FIG01021612 FIG01021614: hypothetical protein +FIG01021614 type III restriction system methylase +FIG01021617 FIG01021619: hypothetical protein +FIG01021619 biotin biosynthesis cytochrome P450 (EC 1.4.-.-) +FIG01021620 FIG01021622: hypothetical protein +FIG01021622 FIG01021623: hypothetical protein +FIG01021623 FIG01021624: hypothetical protein +FIG01021624 FIG01021625: hypothetical protein +FIG01021631 FIG01021632: hypothetical protein +FIG01021632 FIG01021635: hypothetical protein +FIG01021635 FIG01021636: hypothetical protein +FIG01021636 FIG01021638: hypothetical protein +FIG01021639 FIG01021641: hypothetical protein +FIG01021646 FIG01021649: hypothetical protein +FIG01021655 FIG01021658: hypothetical protein +FIG01021658 FIG01021659: hypothetical protein +FIG01021662 FIG01021664: hypothetical protein +FIG01021666 FIG01021667: hypothetical protein +FIG01021669 Molecular chaperone (small heat shock protein)-like protein +FIG01021671 FIG01021672: hypothetical protein +FIG01021672 FIG01021673: hypothetical protein +FIG01021677 FIG01021678: hypothetical protein +FIG01021678 FIG01021679: hypothetical protein +FIG01021679 FIG01021682: hypothetical protein +FIG01021682 FIG01021685: hypothetical protein +FIG01021685 FIG01021686: hypothetical protein +FIG01021686 FIG01021690: hypothetical protein +FIG01021690 FIG01021691: hypothetical protein +FIG01021691 FIG01021692: hypothetical protein +FIG01021699 FIG01021701: hypothetical protein +FIG01021703 FIG01021705: hypothetical protein +FIG01021707 FIG01021709: hypothetical protein +FIG01021709 FIG01021710: hypothetical protein +FIG01021710 FIG01021711: hypothetical protein +FIG01021712 FIG01021715: hypothetical protein +FIG01021716 FIG01021717: hypothetical protein +FIG01021717 FIG01021719: hypothetical protein +FIG01021719 FIG01021720: hypothetical protein +FIG01021723 FIG01021725: hypothetical protein +FIG01021725 FIG01021726: hypothetical protein +FIG01021734 FIG01021735: hypothetical protein +FIG01021737 FIG01021738: hypothetical protein +FIG01021739 FIG01021740: hypothetical protein +FIG01021740 FIG01021741: hypothetical protein +FIG01021741 FIG01021744: hypothetical protein +FIG01021745 FIG01021746: hypothetical protein +FIG01021747 FIG01021751: hypothetical protein +FIG01021752 FIG01021753: hypothetical protein +FIG01021753 FIG01021754: hypothetical protein +FIG01021754 FIG01021756: hypothetical protein +FIG01021758 FIG01021759: hypothetical protein +FIG01021759 FIG01021761: hypothetical protein +FIG01021761 FIG01021762: hypothetical protein +FIG01021762 FIG01021769: hypothetical protein +FIG01021775 FIG01021776: hypothetical protein +FIG01021776 FIG01021780: hypothetical protein +FIG01021781 FIG01021782: hypothetical protein +FIG01021782 FIG01021784: hypothetical protein +FIG01021784 FIG01021786: hypothetical protein +FIG01021786 FIG01021788: hypothetical protein +FIG01021788 FIG01021789: hypothetical protein +FIG01021795 FIG01021796: hypothetical protein +FIG01021798 FIG01021799: hypothetical protein +FIG01021800 FIG01021804: hypothetical protein +FIG01021804 FIG01021805: hypothetical protein +FIG01021805 FIG01021806: hypothetical protein +FIG01021806 FIG01021807: hypothetical protein +FIG01021809 FIG01021810: hypothetical protein +FIG01021815 FIG01021817: hypothetical protein +FIG01021820 FIG01021822: hypothetical protein +FIG01021822 FIG01021826: hypothetical protein +FIG01021826 FIG01021827: hypothetical protein +FIG01021831 FIG01021832: hypothetical protein +FIG01021832 FIG01021834: hypothetical protein +FIG01021835 FIG01021836: hypothetical protein +FIG01021836 FIG01021838: hypothetical protein +FIG01021838 FIG01021840: hypothetical protein +FIG01021842 FIG01021844: hypothetical protein +FIG01021847 FIG01021848: hypothetical protein +FIG01021848 FIG01021850: hypothetical protein +FIG01021850 FIG01021852: hypothetical protein +FIG01021854 FIG01021857: hypothetical protein +FIG01021861 FIG01021862: hypothetical protein +FIG01021862 FIG01021863: hypothetical protein +FIG01021863 FIG01021870: hypothetical protein +FIG01021873 FIG01021874: hypothetical protein +FIG01021874 Antimicrobial peptide ABC transporter permease +FIG01021875 FIG01021876: hypothetical protein +FIG01021878 FIG01021879: hypothetical protein +FIG01021882 FIG01021883: hypothetical protein +FIG01021884 FIG01021885: hypothetical protein +FIG01021885 FIG01021887: hypothetical protein +FIG01021892 FIG01021894: hypothetical protein +FIG01021894 RRNA methyltransferase +FIG01021895 FIG01021897: hypothetical protein +FIG01021897 FIG01021898: hypothetical protein +FIG01021900 FIG01021903: hypothetical protein +FIG01021904 CamT (EC 2.1.1.104) +FIG01021907 FIG01021908: hypothetical protein +FIG01021908 FIG01021909: hypothetical protein +FIG01021909 FIG01021910: hypothetical protein +FIG01021910 Dual specificity protein phosphatase 12 (EC 3.1.3.48) (EC 3.1.3.16) (Dual specificity tyrosine phosphatase YVH1) +FIG01021911 FIG01021919: hypothetical protein +FIG01021919 FIG01021920: hypothetical protein +FIG01021922 FIG01021925: hypothetical protein +FIG01021925 FIG01021931: hypothetical protein +FIG01021931 FIG01021936: hypothetical protein +FIG01021940 FIG01021941: hypothetical protein +FIG01021946 FIG01021947: hypothetical protein +FIG01021951 FIG01021953: hypothetical protein +FIG01021955 FIG01021957: hypothetical protein +FIG01021959 FIG01021960: hypothetical protein +FIG01021960 FIG01021962: hypothetical protein +FIG01021964 FIG01021965: hypothetical protein +FIG01021966 FIG01021967: hypothetical protein +FIG01021967 FIG01021970: hypothetical protein +FIG01021975 Possible sugar ABC transporter, ATP-binding component +FIG01021976 FIG01021977: hypothetical protein +FIG01021978 FIG01021979: hypothetical protein +FIG01021979 FIG01021980: hypothetical protein +FIG01021980 Aspartate aminotransferase (EC 2.6.1.1) / Glutamine-dependent 2-keto-4-methylthiobutyrate transaminase +FIG01021982 FIG01021983: hypothetical protein +FIG01021987 FIG01021988: hypothetical protein +FIG01021988 FIG01021989: hypothetical protein +FIG01021989 FIG01021990: hypothetical protein +FIG01021992 FIG01021994: hypothetical protein +FIG01021994 FIG01021995: hypothetical protein +FIG01021998 FIG01021999: hypothetical protein +FIG01021999 FIG01022004: hypothetical protein +FIG01022006 FIG01022007: hypothetical protein +FIG01022007 FIG01022008: hypothetical protein +FIG01022009 FIG01022014: hypothetical protein +FIG01022014 FIG01022015: hypothetical protein +FIG01022015 FIG01022016: hypothetical protein +FIG01022016 FIG01022018: hypothetical protein +FIG01022018 FIG01022021: hypothetical protein +FIG01022021 FIG01022022: hypothetical protein +FIG01022022 FIG01022024: hypothetical protein +FIG01022024 FIG01022026: hypothetical protein +FIG01022026 FIG01022027: hypothetical protein +FIG01022027 FIG01022028: hypothetical protein +FIG01022035 FIG01022036: hypothetical protein +FIG01022036 FIG01022037: hypothetical protein +FIG01022037 FIG01022039: hypothetical protein +FIG01022040 FIG01022041: hypothetical protein +FIG01022043 FIG01022044: hypothetical protein +FIG01022057 FIG01022058: hypothetical protein +FIG01022058 FIG01022059: hypothetical protein +FIG01022059 FIG01022063: hypothetical protein +FIG01022064 FIG01022066: hypothetical protein +FIG01022066 FIG01022070: hypothetical protein +FIG01022070 FIG01022073: hypothetical protein +FIG01022073 FIG01022077: hypothetical protein +FIG01022077 FIG01022081: hypothetical protein +FIG01022094 FIG01022095: hypothetical protein +FIG01022100 FIG01022101: hypothetical protein +FIG01022101 FIG01022104: hypothetical protein +FIG01022104 FIG01022106: hypothetical protein +FIG01022106 FIG01022108: hypothetical protein +FIG01022108 FIG01022109: hypothetical protein +FIG01022113 FIG01022114: hypothetical protein +FIG01022114 FIG01022116: hypothetical protein +FIG01022117 FIG01022120: hypothetical protein +FIG01022120 FIG01022122: hypothetical protein +FIG01022122 FIG01022124: hypothetical protein +FIG01022124 FIG01022125: hypothetical protein +FIG01022126 FIG01022131: hypothetical protein +FIG01022133 FIG01022134: hypothetical protein +FIG01022134 FIG01022135: hypothetical protein +FIG01022135 FIG01022136: hypothetical protein +FIG01022136 FIG01022138: hypothetical protein +FIG01022138 FIG01022139: hypothetical protein +FIG01022140 FIG01022141: hypothetical protein +FIG01022145 FIG01022148: hypothetical protein +FIG01022150 FIG01022151: hypothetical protein +FIG01022152 FIG01022157: hypothetical protein +FIG01022162 FIG01022164: hypothetical protein +FIG01022165 FIG01022167: hypothetical protein +FIG01022178 FIG01022179: hypothetical protein +FIG01022180 FIG01022182: hypothetical protein +FIG01022184 FIG01022186: hypothetical protein +FIG01022188 FIG01022189: hypothetical protein +FIG01022190 FIG01022192: hypothetical protein +FIG01022192 Cell division protein DivIC (FtsB), stabilizes FtsL against RasP cleavage +FIG01022193 FIG01022195: hypothetical protein +FIG01022195 FIG01022197: hypothetical protein +FIG01022197 FIG01022198: hypothetical protein +FIG01022198 FIG01022201: hypothetical protein +FIG01022201 FIG01022206: hypothetical protein +FIG01022206 FIG01022208: hypothetical protein +FIG01022208 FIG01022209: hypothetical protein +FIG01022209 FIG01022211: hypothetical protein +FIG01022211 FIG01022212: hypothetical protein +FIG01022212 FIG01022215: hypothetical protein +FIG01022216 FIG01022217: hypothetical protein +FIG01022217 FIG01022218: hypothetical protein +FIG01022221 FIG01022222: hypothetical protein +FIG01022222 FIG01022228: hypothetical protein +FIG01022228 FIG01022233: hypothetical protein +FIG01022233 FIG01022235: hypothetical protein +FIG01022235 FIG01022239: hypothetical protein +FIG01022239 FIG01022240: hypothetical protein +FIG01022241 FIG01022242: hypothetical protein +FIG01022242 FIG01022243: hypothetical protein +FIG01022250 FIG01022251: hypothetical protein +FIG01022254 FIG01022255: hypothetical protein +FIG01022255 FIG01022259: hypothetical protein +FIG01022264 FIG01022268: hypothetical protein +FIG01022268 FIG01022276: hypothetical protein +FIG01022277 FIG01022278: hypothetical protein +FIG01022282 FIG01022284: hypothetical protein +FIG01022285 FIG01022288: hypothetical protein +FIG01022291 FIG01022292: hypothetical protein +FIG01022292 FIG01022294: hypothetical protein +FIG01022296 FIG01022302: hypothetical protein +FIG01022302 FIG01022303: hypothetical protein +FIG01022303 FIG01022304: hypothetical protein +FIG01022304 FIG01022305: hypothetical protein +FIG01022305 Gll1843 protein +FIG01022306 FIG01022307: hypothetical protein +FIG01022307 FIG01022309: hypothetical protein +FIG01022309 FIG01022311: hypothetical protein +FIG01022319 FIG01022322: hypothetical protein +FIG01022322 Gll3226 protein +FIG01022323 FIG01022324: hypothetical protein +FIG01022332 FIG01022333: hypothetical protein +FIG01022340 UPF0331 protein MJ0127 +FIG01022345 FIG01022346: hypothetical protein +FIG01022346 FIG01022349: hypothetical protein +FIG01022349 FIG01022350: hypothetical protein +FIG01022350 FIG01022351: hypothetical protein +FIG01022351 FIG01022355: hypothetical protein +FIG01022355 FIG01022360: hypothetical protein +FIG01022366 FIG01022367: hypothetical protein +FIG01022388 FIG01022391: hypothetical protein +FIG01022398 FIG01022399: hypothetical protein +FIG01022399 FIG01022400: hypothetical protein +FIG01022400 FIG01022410: hypothetical protein +FIG01022411 FIG01022414: hypothetical protein +FIG01022414 FIG01022415: hypothetical protein +FIG01022415 FIG01022416: hypothetical protein +FIG01022418 FIG01022420: hypothetical protein +FIG01022420 FIG01022421: hypothetical protein +FIG01022422 FIG01022423: hypothetical protein +FIG01022430 FIG01022431: hypothetical protein +FIG01022434 FIG01022435: hypothetical protein +FIG01022435 FIG01022436: hypothetical protein +FIG01022436 FIG01022437: hypothetical protein +FIG01022443 FIG01022444: hypothetical protein +FIG01022444 FIG01022445: hypothetical protein +FIG01022450 FIG01022453: hypothetical protein +FIG01022454 FIG01022456: hypothetical protein +FIG01022456 FIG01022458: hypothetical protein +FIG01022458 FIG01022459: hypothetical protein +FIG01022459 FIG01022460: hypothetical protein +FIG01022460 FIG01022464: hypothetical protein +FIG01022472 FIG01022477: hypothetical protein +FIG01022480 FIG01022481: hypothetical protein +FIG01022482 CRISPR-associated protein, Cst1 family +FIG01022489 FIG01022492: hypothetical protein +FIG01022494 FIG01022496: hypothetical protein +FIG01022505 FIG01022506: hypothetical protein +FIG01022511 FIG01022526: hypothetical protein +FIG01022531 FIG01022534: hypothetical protein +FIG01022539 FIG01022541: hypothetical protein +FIG01022541 FIG01022542: hypothetical protein +FIG01022545 FIG01022547: hypothetical protein +FIG01022547 FIG01022548: hypothetical protein +FIG01022548 FIG01022549: hypothetical protein +FIG01022552 FIG01022555: hypothetical protein +FIG01022560 FIG01022562: hypothetical protein +FIG01022563 FIG01022565: hypothetical protein +FIG01022565 FIG01022566: hypothetical protein +FIG01022569 FIG01022570: hypothetical protein +FIG01022570 FIG01022571: hypothetical protein +FIG01022571 FIG01022572: hypothetical protein +FIG01022574 FIG01022575: hypothetical protein +FIG01022575 Serine/threonine-protein kinase C (EC 2.7.11.1) +FIG01022579 FIG01022583: hypothetical protein +FIG01022583 Sterol-4-alpha-carboxylate 3-dehydrogenase, decarboxylating (EC 1.1.1.170) +FIG01022584 FIG01022596: hypothetical protein +FIG01022596 FIG01022598: hypothetical protein +FIG01022608 Stage II sporulation E +FIG01022612 FIG01022613: hypothetical protein +FIG01022613 FIG01022617: hypothetical protein +FIG01022619 FIG01022627: hypothetical protein +FIG01022631 FIG01022632: hypothetical protein +FIG01022632 FIG01022634: hypothetical protein +FIG01022634 FIG01022638: hypothetical protein +FIG01022638 FIG01022640: hypothetical protein +FIG01022640 FIG01022641: hypothetical protein +FIG01022642 2-hydroxyhepta-2,4-diene-1,7-dioate isomerase +FIG01022646 FIG01022647: hypothetical protein +FIG01022647 FIG01022648: hypothetical protein +FIG01022652 Predicted SAM-dependent methyltransferases +FIG01022661 FIG01022663: hypothetical protein +FIG01022663 FIG01022664: hypothetical protein +FIG01022666 FIG01022668: hypothetical protein +FIG01022668 FIG01022669: hypothetical protein +FIG01022669 FIG01022671: hypothetical protein +FIG01022671 FIG01022676: hypothetical protein +FIG01022677 FIG01022678: hypothetical protein +FIG01022678 FIG01022684: hypothetical protein +FIG01022688 FIG01022693: hypothetical protein +FIG01022694 FIG01022695: hypothetical protein +FIG01022705 FIG01022706: hypothetical protein +FIG01022706 FIG01022709: hypothetical protein +FIG01022709 FIG01022712: hypothetical protein +FIG01022713 FIG01022718: hypothetical protein +FIG01022721 FIG01022725: hypothetical protein +FIG01022726 FIG01022729: hypothetical protein +FIG01022736 FIG01022737: hypothetical protein +FIG01022738 FIG01022741: hypothetical protein +FIG01022756 FIG01022757: hypothetical protein +FIG01022762 FIG01022771: hypothetical protein +FIG01022780 FIG01022786: hypothetical protein +FIG01022811 FIG01022812: hypothetical protein +FIG01022812 FIG01022815: hypothetical protein +FIG01022825 FIG01022828: hypothetical protein +FIG01022844 FIG01022855: hypothetical protein +FIG01022859 FIG01022860: hypothetical protein +FIG01022869 FIG01022876: hypothetical protein +FIG01022886 FIG01022890: hypothetical protein +FIG01022890 FIG01020819: hypothetical protein +FIG01022918 FIG01022921: hypothetical protein +FIG01022922 FIG01022923: hypothetical protein +FIG01022923 FIG01022927: hypothetical protein +FIG01022928 FIG01022931: hypothetical protein +FIG01022931 FIG01022936: hypothetical protein +FIG01022937 FIG01022939: hypothetical protein +FIG01022942 FIG00992715: hypothetical protein +FIG01022944 FIG01022946: hypothetical protein +FIG01022949 FIG01022950: hypothetical protein +FIG01022951 FIG01022952: hypothetical protein +FIG01022952 FIG01022955: hypothetical protein +FIG01022955 FIG01022956: hypothetical protein +FIG01022957 FIG01022959: hypothetical protein +FIG01022960 FIG01022961: hypothetical protein +FIG01022961 FIG01022962: hypothetical protein +FIG01022962 FIG01022963: hypothetical protein +FIG01022966 spermidine/putrescine ABC transporter, ATP-binding protein +FIG01022969 FIG01022971: hypothetical protein +FIG01022971 FIG01022972: hypothetical protein +FIG01022972 FIG01023995: hypothetical protein +FIG01022974 FIG01022976: hypothetical protein +FIG01022976 identified by similarity to GB:AAD29263.1 +FIG01022979 FIG00992219: hypothetical protein +FIG01022983 inner membrane protein +FIG01022984 FIG01022989: hypothetical protein +FIG01022989 FIG01022990: hypothetical protein +FIG01022994 FIG01022995: hypothetical protein +FIG01022995 FIG01022997: hypothetical protein +FIG01022998 sugar ABC transporter permease protein, putative +FIG01023000 FIG01023001: hypothetical protein +FIG01023004 FIG01023005: hypothetical protein +FIG01023006 putative reductive dehalogenase RdhA +FIG01023007 FIG01023008: hypothetical protein +FIG01023009 FIG01023010: hypothetical protein +FIG01023010 FIG01023013: hypothetical protein +FIG01023013 FIG01023014: hypothetical protein +FIG01023016 FIG01023018: hypothetical protein +FIG01023018 FIG01023019: hypothetical protein +FIG01023021 Malonyl-CoA decarboxylase (EC 4.1.1.9) +FIG01023022 FIG01023023: hypothetical protein +FIG01023023 FIG01023029: hypothetical protein +FIG01023031 FIG01023032: hypothetical protein +FIG01023032 FIG01023033: hypothetical protein +FIG01023033 FIG01023034: hypothetical protein +FIG01023041 FIG01023042: hypothetical protein +FIG01023045 FIG01023047: hypothetical protein +FIG01023047 FIG00993406: hypothetical protein +FIG01023048 FIG01023050: hypothetical protein +FIG01023050 FIG01023051: hypothetical protein +FIG01023051 FIG00987702: hypothetical protein +FIG01023058 FIG01023059: hypothetical protein +FIG01023059 FIG01023061: hypothetical protein +FIG01023061 FIG01023062: hypothetical protein +FIG01023062 FIG01023063: hypothetical protein +FIG01023063 FIG01023065: hypothetical protein +FIG01023065 FIG01023066: hypothetical protein +FIG01023066 FIG01023067: hypothetical protein +FIG01023069 FIG01023070: hypothetical protein +FIG01023082 monooxygenase family protein +FIG01023083 FIG01023084: hypothetical protein +FIG01023085 FIG01023087: hypothetical protein +FIG01023087 FIG01023090: hypothetical protein +FIG01023090 Putative DAK transcriptional regulator / Putative dihydroxyacetone kinase (EC 2.7.1.29), dihydroxyacetone binding subunit +FIG01023101 FIG01023103: hypothetical protein +FIG01023103 FIG01023105: hypothetical protein +FIG01023105 FIG01023111: hypothetical protein +FIG01023112 FIG00987841: hypothetical protein +FIG01023115 Gene Transfer Agent associated protein Pden 2900 +FIG01023117 FIG01023118: hypothetical protein +FIG01023118 nonspecific acid phosphatase +FIG01023120 FIG01023121: hypothetical protein +FIG01023121 FIG00993834: hypothetical protein +FIG01023122 FIG01023123: hypothetical protein +FIG01023123 FIG01023124: hypothetical protein +FIG01023124 FIG01023125: hypothetical protein +FIG01023125 FIG01023126: hypothetical protein +FIG01023126 FIG01023127: hypothetical protein +FIG01023127 FIG01023129: hypothetical protein +FIG01023134 FIG00784163: hypothetical protein +FIG01023136 FIG01023137: hypothetical protein +FIG01023137 FIG01023138: hypothetical protein +FIG01023141 FIG01023143: hypothetical protein +FIG01023143 FIG01023146: hypothetical protein +FIG01023146 FIG01023147: hypothetical protein +FIG01023149 FIG00989559: hypothetical protein +FIG01023158 multidrug resistance efflux pump, putative +FIG01023166 FIG01023169: hypothetical protein +FIG01023174 FIG01023175: hypothetical protein +FIG01023175 FIG01023177: hypothetical protein +FIG01023177 FIG00993010: hypothetical protein +FIG01023182 FIG01023184: hypothetical protein +FIG01023184 FIG01023186: hypothetical protein +FIG01023215 FIG01023217: hypothetical protein +FIG01023217 FIG01023220: hypothetical protein +FIG01023220 FIG01023222: hypothetical protein +FIG01023222 FIG00992552: hypothetical protein +FIG01023225 Oxidoreductase, NAD(P)-dependent, weak similarity to Myo-inositol 2-dehydrogenase +FIG01023228 FIG01023230: hypothetical protein +FIG01023230 FIG01023233: hypothetical protein +FIG01023233 FIG01023235: hypothetical protein +FIG01023235 FIG00993923: hypothetical protein +FIG01023240 FIG01023241: hypothetical protein +FIG01023241 Bona fide RidA/YjgF/TdcF/RutC subgroup +FIG01023244 FIG01023247: hypothetical protein +FIG01023247 FIG01023248: hypothetical protein +FIG01023248 FIG01023251: hypothetical protein +FIG01023251 FIG01023254: hypothetical protein +FIG01023255 FIG01023258: hypothetical protein +FIG01023261 FIG01023263: hypothetical protein +FIG01023263 FIG00992435: hypothetical protein +FIG01023265 FIG01023266: hypothetical protein +FIG01023278 FIG00613121: hypothetical protein +FIG01023282 FIG01072744: hypothetical protein +FIG01023284 possible monoamine oxidase +FIG01023285 Autoinducer synthesis protein raiI +FIG01023287 FIG01023289: hypothetical protein +FIG01023296 FIG01023300: hypothetical protein +FIG01023304 FIG01023306: hypothetical protein +FIG01023310 FIG01023311: hypothetical protein +FIG01023311 FIG01073209: hypothetical protein +FIG01023318 Type IIS restriction enzyme (EC 3.1.21.4) (EC 2.1.1.72) +FIG01023319 FIG01023320: hypothetical protein +FIG01023321 FIG01073524: hypothetical protein +FIG01023322 FIG01023323: hypothetical protein +FIG01023324 putative iron transporter +FIG01023325 FIG01023328: hypothetical protein +FIG01023330 FIG01023331: hypothetical protein +FIG01023331 Modification methylase NgoMIV (EC 2.1.1.37) +FIG01023332 FIG01023333: hypothetical protein +FIG01023333 FIG01023334: hypothetical protein +FIG01023337 FIG01073772: hypothetical protein +FIG01023339 hypothetical transmembrane protein +FIG01023342 FIG01073378: hypothetical protein +FIG01023346 FIG01023348: hypothetical protein +FIG01023349 FIG01023350: hypothetical protein +FIG01023351 FIG01023352: hypothetical protein +FIG01023354 Branched-chain-amino-acid aminotransferase-like protein 2 +FIG01023355 FIG01023356: hypothetical protein +FIG01023356 FIG01023358: hypothetical protein +FIG01023358 FIG01023359: hypothetical protein +FIG01023361 FIG01023366: hypothetical protein +FIG01023367 FIG01023368: hypothetical protein +FIG01023368 FIG01023369: hypothetical protein +FIG01023369 FIG01023370: hypothetical protein +FIG01023375 FIG01023377: hypothetical protein +FIG01023377 FIG01023382: hypothetical protein +FIG01023382 FIG01073858: hypothetical protein +FIG01023386 FIG01023388: hypothetical protein +FIG01023388 FIG01023392: hypothetical protein +FIG01023398 FIG01073719: hypothetical protein +FIG01023400 FIG01023405: hypothetical protein +FIG01023405 FIG01023407: hypothetical protein +FIG01023407 FIG01023409: hypothetical protein +FIG01023411 flagellar protein FlaF +FIG01023413 FIG01023414: hypothetical protein +FIG01023414 Lipopolysaccharide core biosynthesis mannosyltransferase lpcC (EC 2.-.-.-) +FIG01023415 FIG01023419: hypothetical protein +FIG01023420 cobalamin/Fe3+-siderophores transport systems, secreted component +FIG01023421 succinate dehydrogenase subunit +FIG01023422 FIG01023423: hypothetical protein +FIG01023423 FIG01023427: hypothetical protein +FIG01023427 TrkA-C domain protein +FIG01023430 FIG01023433: hypothetical protein +FIG01023433 FIG01023434: hypothetical protein +FIG01023435 FIG01023436: hypothetical protein +FIG01023436 FIG01023437: hypothetical protein +FIG01023440 FIG01023442: hypothetical protein +FIG01023443 FIG01023444: hypothetical protein +FIG01023445 putative sugar transport system permease ABC transporter protein +FIG01023449 InterPro IPR001687:IPR003439:IPR003593 COGs COG0411 +FIG01023450 FIG00993187: hypothetical protein +FIG01023460 FIG01023461: hypothetical protein +FIG01023461 FIG01073853: hypothetical protein +FIG01023467 FIG01023468: hypothetical protein +FIG01023469 FIG01023471: hypothetical protein +FIG01023471 FIG01023473: hypothetical protein +FIG01023473 FIG01023476: hypothetical protein +FIG01023476 FIG00992248: hypothetical protein +FIG01023477 FIG01023478: hypothetical protein +FIG01023480 FIG01023481: hypothetical protein +FIG01023481 FIG01023482: hypothetical protein +FIG01023484 FIG01023487: hypothetical protein +FIG01023487 FIG01023488: hypothetical protein +FIG01023488 FIG00992254: hypothetical protein +FIG01023490 von Willebrand factor type A domain protein +FIG01023491 FIG01023492: hypothetical protein +FIG01023493 3-hydroxyisobutyrate dehydrogenase (EC 1.1.1.31) (HIBADH) +FIG01023496 FIG01023497: hypothetical protein +FIG01023498 FIG00992668: hypothetical protein +FIG01023499 FIG01023504: hypothetical protein +FIG01023504 FIG01023506: hypothetical protein +FIG01023514 FIG01023518: hypothetical protein +FIG01023519 FIG01023521: hypothetical protein +FIG01023521 FIG01023522: hypothetical protein +FIG01023522 FIG01023524: hypothetical protein +FIG01023524 FIG01023525: hypothetical protein +FIG01023526 FIG01023530: hypothetical protein +FIG01023531 FIG01023534: hypothetical protein +FIG01023534 FIG01023535: hypothetical protein +FIG01023535 FIG01023536: hypothetical protein +FIG01023541 FIG01023542: hypothetical protein +FIG01023542 FIG01023544: hypothetical protein +FIG01023544 FIG01023545: hypothetical protein +FIG01023545 FIG01023546: hypothetical protein +FIG01023546 Riorf59 protein +FIG01023547 FIG01023548: hypothetical protein +FIG01023550 FIG01023551: hypothetical protein +FIG01023551 FIG01023552: hypothetical protein +FIG01023556 FIG01023557: hypothetical protein +FIG01023574 FIG01023576: hypothetical protein +FIG01023577 FIG00987972: hypothetical protein +FIG01023579 FIG01023580: hypothetical protein +FIG01023582 FIG01142639: hypothetical protein +FIG01023587 FIG01023588: hypothetical protein +FIG01023592 FIG01023596: hypothetical protein +FIG01023600 FIG01023601: hypothetical protein +FIG01023605 FIG01023606: hypothetical protein +FIG01023606 FIG01023608: hypothetical protein +FIG01023608 cell processes; transport of small molecules +FIG01023611 FIG01023613: hypothetical protein +FIG01023613 FIG01023614: hypothetical protein +FIG01023616 FIG01023617: hypothetical protein +FIG01023621 FIG00992653: hypothetical protein +FIG01023627 FIG01023628: hypothetical protein +FIG01023628 FIG01023632: hypothetical protein +FIG01023632 FIG01023633: hypothetical protein +FIG01023633 possible desaturase +FIG01023636 FIG01023637: hypothetical protein +FIG01023637 FIG01023639: hypothetical protein +FIG01023639 FIG01023645: hypothetical protein +FIG01023648 FIG01023652: hypothetical protein +FIG01023656 FIG01023657: hypothetical protein +FIG01023657 TRAP-type C4-dicarboxylate transport system, small permease component +FIG01023658 FIG01023659: hypothetical protein +FIG01023659 FIG01023660: hypothetical protein +FIG01023660 FIG01023663: hypothetical protein +FIG01023664 FIG01023667: hypothetical protein +FIG01023668 Protein arginine N-methyltransferase +FIG01023669 Undecaprenyl-phosphate galactosephosphotransferase( EC:2.- ) +FIG01023672 FIG00988592: hypothetical protein +FIG01023673 FIG01023674: hypothetical protein +FIG01023674 FIG01023675: hypothetical protein +FIG01023675 FIG00993836: hypothetical protein +FIG01023682 FIG01023684: hypothetical protein +FIG01023690 FIG01023692: hypothetical protein +FIG01023692 FIG01023700: hypothetical protein +FIG01023703 FIG01023707: hypothetical protein +FIG01023710 FIG01023711: hypothetical protein +FIG01023713 FIG01143270: hypothetical protein +FIG01023715 FIG01023717: hypothetical protein +FIG01023718 FIG01023720: hypothetical protein +FIG01023721 MOSC domain protein +FIG01023728 FIG01023729: hypothetical protein +FIG01023730 FIG01023731: hypothetical protein +FIG01023736 Universal stress protein UspA and related nucleotide-binding proteins +FIG01023739 FIG01023740: hypothetical protein +FIG01023743 FIG00993056: hypothetical protein +FIG01023746 FIG01023747: hypothetical protein +FIG01023750 FIG01023751: hypothetical protein +FIG01023751 FIG01023752: hypothetical protein +FIG01023753 FIG01023756: hypothetical protein +FIG01023757 FIG01023758: hypothetical protein +FIG01023762 FIG01023765: hypothetical protein +FIG01023769 FIG00992477: hypothetical protein +FIG01023779 FIG01023780: hypothetical protein +FIG01023780 FIG01023784: hypothetical protein +FIG01023786 ExoV domain protein +FIG01023787 Bll7214 protein +FIG01023793 FIG01023794: hypothetical protein +FIG01023795 FIG01023796: hypothetical protein +FIG01023796 FIG00987686: hypothetical protein +FIG01023800 FIG01023801: hypothetical protein +FIG01023802 FIG01023803: hypothetical protein +FIG01023810 FIG01028086: hypothetical protein +FIG01023812 FIG00992815: hypothetical protein +FIG01023823 Type II restriction enzyme NaeI (EC 3.1.21.4) +FIG01023830 FIG01023834: hypothetical protein +FIG01023837 FIG01023838: hypothetical protein +FIG01023838 selenium binding protein +FIG01023843 FIG01023844: hypothetical protein +FIG01023853 FIG01023855: hypothetical protein +FIG01023855 FIG01023856: hypothetical protein +FIG01023856 FIG01023857: hypothetical protein +FIG01023858 FIG01023859: hypothetical protein +FIG01023861 FIG01023862: hypothetical protein +FIG01023862 FIG01023863: hypothetical protein +FIG01023866 Gene Transfer Agent terminase protein +FIG01023868 FIG01023871: hypothetical protein +FIG01023871 FIG01023872: hypothetical protein +FIG01023872 FIG00993280: hypothetical protein +FIG01023876 FIG01023877: hypothetical protein +FIG01023877 FIG01073137: hypothetical protein +FIG01023879 FIG01023883: hypothetical protein +FIG01023887 FIG01023890: hypothetical protein +FIG01023891 FIG01023892: hypothetical protein +FIG01023892 FIG01023894: hypothetical protein +FIG01023898 ArsC family protein +FIG01023902 FIG01023906: hypothetical protein +FIG01023909 Monooxygenase family protein +FIG01023910 FIG01023912: hypothetical protein +FIG01023916 FIG01023917: hypothetical protein +FIG01023918 FIG01023919: hypothetical protein +FIG01023919 Oxidoreductase, Gfo/Idh/MocA family +FIG01023920 FIG01023921: hypothetical protein +FIG01023921 FIG00992541: hypothetical protein +FIG01023922 FIG01023924: hypothetical protein +FIG01023927 FIG01023928: hypothetical protein +FIG01023932 FIG01023933: hypothetical protein +FIG01023943 FIG01023944: hypothetical protein +FIG01023944 Glycosyltransferase, group 1 +FIG01023951 FIG01023952: hypothetical protein +FIG01023959 FIG01023961: hypothetical protein +FIG01023969 FIG01072917: hypothetical protein +FIG01023974 FIG01023976: hypothetical protein +FIG01023979 FIG01023981: hypothetical protein +FIG01023986 FIG01073106: hypothetical protein +FIG01023990 FIG01023992: hypothetical protein +FIG01023995 FIG01023996: hypothetical protein +FIG01023996 FIG01023997: hypothetical protein +FIG01024000 FIG01024002: hypothetical protein +FIG01024002 toxin secretion ABC transporter, ATP binding protein, putative +FIG01024016 FIG01024018: hypothetical protein +FIG01024018 FIG01024019: hypothetical protein +FIG01024020 FIG01024023: hypothetical protein +FIG01024026 Transmembrane amino acid efflux protein +FIG01024031 FIG01024032: hypothetical protein +FIG01024037 FIG01024038: hypothetical protein +FIG01024039 FIG01024040: hypothetical protein +FIG01024042 FIG01024043: hypothetical protein +FIG01024045 identified by similarity to GB:AAN66948.1; match to protein family HMM PF02021 +FIG01024046 FIG01024047: hypothetical protein +FIG01024053 FIG01024054: hypothetical protein +FIG01024057 FIG01024059: hypothetical protein +FIG01024062 FIG01024063: hypothetical protein +FIG01024063 FIG01024064: hypothetical protein +FIG01024064 FIG01024065: hypothetical protein +FIG01024079 FIG01143037: hypothetical protein +FIG01024083 FIG01024084: hypothetical protein +FIG01024106 FIG00993084: hypothetical protein +FIG01024109 FIG01024111: hypothetical protein +FIG01024111 FIG01024118: hypothetical protein +FIG01024118 FIG01024120: hypothetical protein +FIG01024122 FIG01024124: hypothetical protein +FIG01024128 FIG01142689: hypothetical protein +FIG01024130 head-tail adaptor, putative +FIG01024138 FIG01024139: hypothetical protein +FIG01024143 FIG01024144: hypothetical protein +FIG01024144 FIG01024145: hypothetical protein +FIG01024148 FIG01024150: hypothetical protein +FIG01024150 FIG01024154: hypothetical protein +FIG01024154 FIG01024155: hypothetical protein +FIG01024157 FIG01024159: hypothetical protein +FIG01024159 twin-arginine translocation pathway signal sequence domain protein, putative +FIG01024163 FIG01024166: hypothetical protein +FIG01024166 FIG01024167: hypothetical protein +FIG01024169 FIG01024173: hypothetical protein +FIG01024173 FIG01024174: hypothetical protein +FIG01024175 FIG01024181: hypothetical protein +FIG01024183 LysE family transport protein +FIG01024185 FIG01024186: hypothetical protein +FIG01024186 N-deacetylase/N-sulfotransferase, putative +FIG01024189 Mlr5368 protein +FIG01024195 FIG01024196: hypothetical protein +FIG01024196 probable 4-hydroxybenzoyl CoA thioesterase +FIG01024199 FIG01024201: hypothetical protein +FIG01024201 FIG01024204: hypothetical protein +FIG01024209 FIG01024211: hypothetical protein +FIG01024218 FIG00993507: hypothetical protein +FIG01024221 FIG01024225: hypothetical protein +FIG01024228 FIG01024231: hypothetical protein +FIG01024235 FIG00992965: hypothetical protein +FIG01024238 FIG01024239: hypothetical protein +FIG01024240 TRAP-type C4-dicarboxylate transport system, small permease component +FIG01024242 FIG01024243: hypothetical protein +FIG01024246 FIG01024247: hypothetical protein +FIG01024247 FIG01024248: hypothetical protein +FIG01024248 FIG01024251: hypothetical protein +FIG01024251 FIG01024252: hypothetical protein +FIG01024252 FIG01024253: hypothetical protein +FIG01024255 FIG01024258: hypothetical protein +FIG01024258 universal stress family protein, putative +FIG01024263 FIG01024264: hypothetical protein +FIG01024266 FIG00992502: hypothetical protein +FIG01024267 FIG01024268: hypothetical protein +FIG01024268 FIG01024270: hypothetical protein +FIG01024277 Related to porin +FIG01024278 FIG01024279: hypothetical protein +FIG01024283 FIG01024286: hypothetical protein +FIG01024288 FIG01024289: hypothetical protein +FIG01024290 FIG01024291: hypothetical protein +FIG01024291 FIG01024292: hypothetical protein +FIG01024295 FIG01024297: hypothetical protein +FIG01024297 Carboxyvinyl-carboxyphosphonate phosphorylmutase (EC 2.7.8.23) +FIG01024303 Glutamate/glutamine/aspartate/asparagine transport system permease protein bztB +FIG01024304 FIG00992217: hypothetical protein +FIG01024308 FIG01024311: hypothetical protein +FIG01024313 FIG01024314: hypothetical protein +FIG01024321 FIG01024324: hypothetical protein +FIG01024325 FIG01024328: hypothetical protein +FIG01024328 FIG01024329: hypothetical protein +FIG01024329 FIG01024330: hypothetical protein +FIG01024331 FIG00993465: hypothetical protein +FIG01024344 FIG01024345: hypothetical protein +FIG01024347 FIG01024348: hypothetical protein +FIG01024350 FIG01024352: hypothetical protein +FIG01024353 FIG01024354: hypothetical protein +FIG01024357 FIG01024360: hypothetical protein +FIG01024360 FIG01024361: hypothetical protein +FIG01024361 FIG01024362: hypothetical protein +FIG01024372 FIG01024373: hypothetical protein +FIG01024374 FIG01024375: hypothetical protein +FIG01024375 FIG01024376: hypothetical protein +FIG01024376 FIG01024377: hypothetical protein +FIG01024377 FIG01024380: hypothetical protein +FIG01024384 FIG01031270: hypothetical protein +FIG01024386 FIG01024387: hypothetical protein +FIG01024387 FIG01024390: hypothetical protein +FIG01024390 FIG01024391: hypothetical protein +FIG01024391 FIG01024392: hypothetical protein +FIG01024394 FIG01024396: hypothetical protein +FIG01024396 FIG00988879: hypothetical protein +FIG01024398 FIG01024399: hypothetical protein +FIG01024408 FIG00613914: hypothetical protein +FIG01024417 FIG01023515: hypothetical protein +FIG01024418 FIG01143402: hypothetical protein +FIG01024419 FIG01024420: hypothetical protein +FIG01024420 FIG01024421: hypothetical protein +FIG01024427 FIG01024431: hypothetical protein +FIG01024432 FIG01024434: hypothetical protein +FIG01024434 FIG01024435: hypothetical protein +FIG01024435 ATP-binding protein bexA +FIG01024437 FIG01024438: hypothetical protein +FIG01024438 FIG01024439: hypothetical protein +FIG01024439 FIG01024441: hypothetical protein +FIG01024441 FIG01024442: hypothetical protein +FIG01024443 FIG01024444: hypothetical protein +FIG01024445 FIG01024446: hypothetical protein +FIG01024450 Predicted hydrolase of the metallo-beta-lactamase superfamily +FIG01024451 FIG01024452: hypothetical protein +FIG01024453 FIG01024454: hypothetical protein +FIG01024454 FIG01024455: hypothetical protein +FIG01024458 FIG01024459: hypothetical protein +FIG01024459 FIG01024460: hypothetical protein +FIG01024460 FIG01024462: hypothetical protein +FIG01024465 FIG01024467: hypothetical protein +FIG01024467 ABC transporter, permease protein, putative +FIG01024474 Transcriptional activator protein raiR +FIG01024482 FIG01024486: hypothetical protein +FIG01024486 FIG01024487: hypothetical protein +FIG01024488 FIG00993398: hypothetical protein +FIG01024490 FIG01024493: hypothetical protein +FIG01024493 FIG01024494: hypothetical protein +FIG01024495 FIG01024496: hypothetical protein +FIG01024497 ATP-binding component of a ABC transport system +FIG01024500 FIG01024502: hypothetical protein +FIG01024502 FIG01024503: hypothetical protein +FIG01024520 FIG01024522: hypothetical protein +FIG01024529 FIG01024531: hypothetical protein +FIG01024531 FIG01024533: hypothetical protein +FIG01024533 FIG01024535: hypothetical protein +FIG01024535 FIG01024537: hypothetical protein +FIG01024540 CTP synthetase( EC:6.3.4.2 ) +FIG01024550 FIG01024551: hypothetical protein +FIG01024555 FIG01024559: hypothetical protein +FIG01024561 FIG01024562: hypothetical protein +FIG01024562 FIG01024564: hypothetical protein +FIG01024564 FIG01024567: hypothetical protein +FIG01024567 FIG01024568: hypothetical protein +FIG01024585 FIG01024589: hypothetical protein +FIG01024593 Mlr1156 protein +FIG01024602 FIG01024604: hypothetical protein +FIG01024604 FIG01024605: hypothetical protein +FIG01024605 Probable phosphoesterase (EC 3.1.-.-) +FIG01024608 FIG01024610: hypothetical protein +FIG01024610 Hydantoinase/oxoprolinase family protein +FIG01024615 FIG01024616: hypothetical protein +FIG01024621 identified by similarity to GB:BAB50411.1 +FIG01024622 RarD +FIG01024626 FIG01024631: hypothetical protein +FIG01024632 FIG01024633: hypothetical protein +FIG01024633 FIG01024634: hypothetical protein +FIG01024641 FIG01024642: hypothetical protein +FIG01024642 FIG01024644: hypothetical protein +FIG01024644 transcriptional regulator, ArsR family, putative +FIG01024645 FIG01024646: hypothetical protein +FIG01024651 FIG01024655: hypothetical protein +FIG01024655 FIG00991299: hypothetical protein +FIG01024656 Mlr7069 protein +FIG01024657 FIG01072633: hypothetical protein +FIG01024658 FIG01024659: hypothetical protein +FIG01024659 transcriptional regulator, LuxR family/sensory box protein +FIG01024664 FIG01024665: hypothetical protein +FIG01024665 FIG01024666: hypothetical protein +FIG01024666 FIG01024667: hypothetical protein +FIG01024667 FIG01024668: hypothetical protein +FIG01024672 FIG01073762: hypothetical protein +FIG01024673 FIG01024676: hypothetical protein +FIG01024676 FIG01024677: hypothetical protein +FIG01024677 FIG01024678: hypothetical protein +FIG01024682 FIG01024683: hypothetical protein +FIG01024683 FIG01024685: hypothetical protein +FIG01024687 FIG01024689: hypothetical protein +FIG01024689 FIG00989979: hypothetical protein +FIG01024695 FIG01024698: hypothetical protein +FIG01024699 AMP-binding protein +FIG01024705 FIG01024706: hypothetical protein +FIG01024706 FIG01024707: hypothetical protein +FIG01024707 FIG01024710: hypothetical protein +FIG01024711 FIG01024713: hypothetical protein +FIG01024721 FIG01024722: hypothetical protein +FIG01024728 FIG01024729: hypothetical protein +FIG01024734 polysaccharide biosynthesis/export protein, putative +FIG01024737 FIG01024738: hypothetical protein +FIG01024738 FIG01073400: hypothetical protein +FIG01024743 FIG01024744: hypothetical protein +FIG01024746 FIG01024747: hypothetical protein +FIG01024747 FIG01024749: hypothetical protein +FIG01024752 FIG01024753: hypothetical protein +FIG01024757 Mlr1218 protein +FIG01024759 InterPro IPR000387 COGs COG2453 +FIG01024762 Topoisomerase IA +FIG01024764 FIG01024766: hypothetical protein +FIG01024769 FIG01024771: hypothetical protein +FIG01024786 FIG01024791: hypothetical protein +FIG01024791 FIG01024794: hypothetical protein +FIG01024795 FIG00884660: hypothetical protein +FIG01024799 FIG01024804: hypothetical protein +FIG01024804 GfdT protein +FIG01024811 FIG01024812: hypothetical protein +FIG01024816 FIG01024821: hypothetical protein +FIG01024822 FIG01024823: hypothetical protein +FIG01024831 FIG01024832: hypothetical protein +FIG01024834 FIG098787: protein involved in DMSP breakdown +FIG01024835 FIG01024836: hypothetical protein +FIG01024840 FIG01024841: hypothetical protein +FIG01024844 FIG01024846: hypothetical protein +FIG01024846 FIG01024848: hypothetical protein +FIG01024855 FIG01024859: hypothetical protein +FIG01024859 FIG00993787: hypothetical protein +FIG01024860 FIG01024862: hypothetical protein +FIG01024863 possible phthalate dioxygenase +FIG01024867 Animal haem peroxidase +FIG01024877 FIG00993299: hypothetical protein +FIG01024878 FIG01024883: hypothetical protein +FIG01024884 FIG01024887: hypothetical protein +FIG01024892 FIG01024894: hypothetical protein +FIG01024894 cold shock family protein +FIG01024896 FIG01024905: hypothetical protein +FIG01024906 FIG01024907: hypothetical protein +FIG01024907 FIG01024912: hypothetical protein +FIG01024912 FIG01024913: hypothetical protein +FIG01024916 FIG01024917: hypothetical protein +FIG01024925 FIG01024927: hypothetical protein +FIG01024927 FIG01024931: hypothetical protein +FIG01024936 FIG01024937: hypothetical protein +FIG01024943 FIG01024947: hypothetical protein +FIG01024957 DOPA 4,5-dioxygenase (EC 1.14.99.-) +FIG01024959 FIG01024961: hypothetical protein +FIG01024961 FIG01024964: hypothetical protein +FIG01024967 FIG01024970: hypothetical protein +FIG01024976 FIG01024979: hypothetical protein +FIG01024979 Mll3560 protein +FIG01024982 FIG01024983: hypothetical protein +FIG01024990 FIG01024992: hypothetical protein +FIG01024992 DNA polymerase III subunit gamma/tau (EC 2.7.7.7) +FIG01024993 FIG01024994: hypothetical protein +FIG01024999 FIG01025000: hypothetical protein +FIG01025002 FIG01025003: hypothetical protein +FIG01025007 putative cyclic nucleotide-binding domain +FIG01025016 FIG01025020: hypothetical protein +FIG01025021 FIG01025022: hypothetical protein +FIG01025035 Gene Transfer Agent (GTA) ORFG10b +FIG01025038 FIG00990835: hypothetical protein +FIG01025046 FIG01025047: hypothetical protein +FIG01025051 FIG01025052: hypothetical protein +FIG01025054 FIG01025055: hypothetical protein +FIG01025057 FIG00993736: hypothetical protein +FIG01025059 FIG01025063: hypothetical protein +FIG01025072 FIG01025076: hypothetical protein +FIG01025076 FIG01073685: hypothetical protein +FIG01025079 FIG00991857: hypothetical protein +FIG01025081 FIG01025082: hypothetical protein +FIG01025082 FIG01025083: hypothetical protein +FIG01025088 FIG01025089: hypothetical protein +FIG01025093 transcriptional regulator, AraC family, putative +FIG01025094 hexosyltransferase +FIG01025097 FIG01025098: hypothetical protein +FIG01025098 FIG01072625: hypothetical protein +FIG01025100 FIG01025101: hypothetical protein +FIG01025102 FIG01025103: hypothetical protein +FIG01025110 FIG01025113: hypothetical protein +FIG01025114 FIG01025115: hypothetical protein +FIG01025132 FIG01025133: hypothetical protein +FIG01025138 FIG01025142: hypothetical protein +FIG01025147 ZIP zinc transporter family protein +FIG01025148 FIG01025149: hypothetical protein +FIG01025151 FIG01025153: hypothetical protein +FIG01025153 N-methylproline demethylase, putative +FIG01025158 Modification methylase HhaI (EC 2.1.1.37) +FIG01025159 FIG01025160: hypothetical protein +FIG01025160 FIG01025165: hypothetical protein +FIG01025171 FIG01025172: hypothetical protein +FIG01025172 FIG01025173: hypothetical protein +FIG01025173 FIG01025175: hypothetical protein +FIG01025182 FIG01025183: hypothetical protein +FIG01025193 FIG01025194: hypothetical protein +FIG01025194 FIG01025196: hypothetical protein +FIG01025196 FIG01025197: hypothetical protein +FIG01025197 FIG01025198: hypothetical protein +FIG01025199 FIG01025200: hypothetical protein +FIG01025200 Mll2374 protein +FIG01025206 FIG01025209: hypothetical protein +FIG01025220 FIG01025221: hypothetical protein +FIG01025221 FIG01025227: hypothetical protein +FIG01025228 FIG01025229: hypothetical protein +FIG01025233 MaoC-like protein, putative +FIG01025238 FIG01025239: hypothetical protein +FIG01025243 FIG01025246: hypothetical protein +FIG01025246 FIG01025247: hypothetical protein +FIG01025254 FIG01025255: hypothetical protein +FIG01025255 FIG01025257: hypothetical protein +FIG01025257 FIG01025258: hypothetical protein +FIG01025259 FIG00988926: hypothetical protein +FIG01025262 FIG01025267: hypothetical protein +FIG01025269 FIG01025270: hypothetical protein +FIG01025270 FIG01025272: hypothetical protein +FIG01025272 FIG01025275: hypothetical protein +FIG01025280 FIG01025284: hypothetical protein +FIG01025285 FIG01142530: hypothetical protein +FIG01025286 FIG01025289: hypothetical protein +FIG01025294 FIG01025295: hypothetical protein +FIG01025295 FIG01025298: hypothetical protein +FIG01025298 FIG01025302: hypothetical protein +FIG01025302 Uncharacterized 37.1 kDa protein in transposon TN4556 +FIG01025305 FIG01025306: hypothetical protein +FIG01025307 FIG01025309: hypothetical protein +FIG01025309 FIG01025310: hypothetical protein +FIG01025310 FIG01073177: hypothetical protein +FIG01025313 FIG01025315: hypothetical protein +FIG01025317 FIG01025318: hypothetical protein +FIG01025319 DNA primase/helicase, phage associated +FIG01025320 FIG01025321: hypothetical protein +FIG01025326 FIG01025329: hypothetical protein +FIG01025354 FIG01025355: hypothetical protein +FIG01025357 FIG01025358: hypothetical protein +FIG01025358 FIG01025361: hypothetical protein +FIG01025361 FIG01025362: hypothetical protein +FIG01025365 FIG01025367: hypothetical protein +FIG01025374 FIG00992460: hypothetical protein +FIG01025375 FIG00992887: hypothetical protein +FIG01025380 FIG01025382: hypothetical protein +FIG01025382 FIG01025383: hypothetical protein +FIG01025388 FIG01025391: hypothetical protein +FIG01025391 FIG01025392: hypothetical protein +FIG01025396 FIG01025398: hypothetical protein +FIG01025399 FIG01025400: hypothetical protein +FIG01025400 FIG01025401: hypothetical protein +FIG01025401 FIG01025402: hypothetical protein +FIG01025406 FIG01025407: hypothetical protein +FIG01025427 FIG01025428: hypothetical protein +FIG01025429 FIG01025430: hypothetical protein +FIG01025430 FIG01025434: hypothetical protein +FIG01025439 FIG01025440: hypothetical protein +FIG01025440 FIG01143472: hypothetical protein +FIG01025441 FIG01025443: hypothetical protein +FIG01025444 FIG01025445: hypothetical protein +FIG01025445 FIG01025446: hypothetical protein +FIG01025449 FIG01025452: hypothetical protein +FIG01025459 FIG01025460: hypothetical protein +FIG01025469 FIG01025471: hypothetical protein +FIG01025478 Probable N-methylproline demethylase (EC 1.-.-.-) +FIG01025480 FIG01025481: hypothetical protein +FIG01025484 FIG01025486: hypothetical protein +FIG01025499 FIG01025500: hypothetical protein +FIG01025502 FIG01025505: hypothetical protein +FIG01025511 FIG01025512: hypothetical protein +FIG01025516 FIG01025517: hypothetical protein +FIG01025517 FIG01142940: hypothetical protein +FIG01025519 FIG01025520: hypothetical protein +FIG01025520 FIG01025523: hypothetical protein +FIG01025525 FIG01025526: hypothetical protein +FIG01025526 FIG00992455: hypothetical protein +FIG01025528 FIG01025529: hypothetical protein +FIG01025529 transcriptional regulator of LysR family protein +FIG01025536 chemoreceptor protein, putative +FIG01025550 FIG01025551: hypothetical protein +FIG01025554 FIG01025557: hypothetical protein +FIG01025574 FIG01025575: hypothetical protein +FIG01025575 FIG01025576: hypothetical protein +FIG01025582 FIG01025583: hypothetical protein +FIG01025583 FIG01025584: hypothetical protein +FIG01025585 FIG01025591: hypothetical protein +FIG01025592 FIG01025593: hypothetical protein +FIG01025601 FIG01025602: hypothetical protein +FIG01025605 FIG01025606: hypothetical protein +FIG01025606 dihydroxyacetone regulator/kinase (DhaK subunit) +FIG01025607 FIG01025608: hypothetical protein +FIG01025613 FIG01025615: hypothetical protein +FIG01025615 FIG01025616: hypothetical protein +FIG01025616 FIG01025617: hypothetical protein +FIG01025617 enoyl-CoA hydratase/isomerase family protein +FIG01025618 FIG00613653: hypothetical protein +FIG01025632 FIG01025638: hypothetical protein +FIG01025639 FIG01025642: hypothetical protein +FIG01025643 FIG01025644: hypothetical protein +FIG01025651 FIG01025652: hypothetical protein +FIG01025652 FIG01025653: hypothetical protein +FIG01025664 FIG01025666: hypothetical protein +FIG01025666 FIG01025667: hypothetical protein +FIG01025667 FIG01025668: hypothetical protein +FIG01025674 FIG01025675: hypothetical protein +FIG01025675 FIG00885034: hypothetical protein +FIG01025679 FIG00987721: hypothetical protein +FIG01025684 FIG01025686: hypothetical protein +FIG01025686 FIG01025687: hypothetical protein +FIG01025687 FIG01025688: hypothetical protein +FIG01025693 FIG01025695: hypothetical protein +FIG01025695 FIG01025696: hypothetical protein +FIG01025696 FIG01025697: hypothetical protein +FIG01025701 FIG01025704: hypothetical protein +FIG01025710 FIG01025711: hypothetical protein +FIG01025720 FIG01025721: hypothetical protein +FIG01025721 FIG01025722: hypothetical protein +FIG01025724 Unknown pentose isomerase ECA1953 +FIG01025725 FIG01025727: hypothetical protein +FIG01025731 FIG01025732: hypothetical protein +FIG01025734 FIG01027881: hypothetical protein +FIG01025741 FIG01025742: hypothetical protein +FIG01025752 FIG01025762: hypothetical protein +FIG01025766 alkylhydroperoxidase AhpD family core domain protein +FIG01025775 FIG01025780: hypothetical protein +FIG01025809 identified by similarity to PIR:E82434 +FIG01025812 FIG01025815: hypothetical protein +FIG01025815 FIG01025816: hypothetical protein +FIG01025818 FIG01025819: hypothetical protein +FIG01025823 methyl-accepting chemotaxis protein McpI +FIG01025825 FIG01025827: hypothetical protein +FIG01025832 FIG01025833: hypothetical protein +FIG01025842 FIG01025843: hypothetical protein +FIG01025847 FIG01025852: hypothetical protein +FIG01025857 FIG01025858: hypothetical protein +FIG01025863 strictosidine synthase family protein +FIG01025869 FIG01025877: hypothetical protein +FIG01025881 FIG01025882: hypothetical protein +FIG01025886 FIG01025888: hypothetical protein +FIG01025890 FIG01023656: hypothetical protein +FIG01025900 FIG01025909: hypothetical protein +FIG01025922 FIG01025923: hypothetical protein +FIG01025928 FIG01025930: hypothetical protein +FIG01025930 1,3,4,6-tetrachloro-1,4-cyclohexadiene hydrolase( EC:3.8.1.5 ) +FIG01025938 FIG01025939: hypothetical protein +FIG01025957 FIG01025958: hypothetical protein +FIG01025960 fructosyl-amino acid oxidase, putative( EC:1.5.3.- ) +FIG01025965 FIG01025966: hypothetical protein +FIG01025968 FIG01025975: hypothetical protein +FIG01025981 putative binding-protein-dependent transport protein (periplasmic) +FIG01026022 FIG01026024: hypothetical protein +FIG01026042 FIG01026043: hypothetical protein +FIG01026045 FIG01026047: hypothetical protein +FIG01026050 FIG01026053: hypothetical protein +FIG01026053 FIG01026056: hypothetical protein +FIG01026056 FIG01026061: hypothetical protein +FIG01026061 FIG01026065: hypothetical protein +FIG01026066 FIG01026069: hypothetical protein +FIG01026074 FIG01026075: hypothetical protein +FIG01026089 FIG01026090: hypothetical protein +FIG01026090 Peroxiredoxin, AhpC/Tsa family protein +FIG01026091 FIG01026096: hypothetical protein +FIG01026096 FIG01026097: hypothetical protein +FIG01026097 Related to peptide ABC-transporter, periplasmic substrate binding protein +FIG01026099 FIG01026103: hypothetical protein +FIG01026103 FIG01026104: hypothetical protein +FIG01026108 Diaminopropionate ammonia-lyase +FIG01026111 FIG01026113: hypothetical protein +FIG01026119 FIG01026123: hypothetical protein +FIG01026124 FIG01026125: hypothetical protein +FIG01026125 FIG01026126: hypothetical protein +FIG01026131 FIG00992493: hypothetical protein +FIG01026135 FIG01026136: hypothetical protein +FIG01026136 COG1872 +FIG01026139 FIG01026140: hypothetical protein +FIG01026140 FIG01026141: hypothetical protein +FIG01026141 FIG01026142: hypothetical protein +FIG01026146 FIG01026152: hypothetical protein +FIG01026155 FIG01026156: hypothetical protein +FIG01026156 FIG01026157: hypothetical protein +FIG01026157 Thiamine biosynthesis protein ThiF +FIG01026165 Transcriptional regulator, Fis family +FIG01026169 FIG01026174: hypothetical protein +FIG01026174 FIG01026179: hypothetical protein +FIG01026179 FIG01026184: hypothetical protein +FIG01026188 FIG01026190: hypothetical protein +FIG01026194 FIG00991009: hypothetical protein +FIG01026195 FIG01026196: hypothetical protein +FIG01026203 FIG01026204: hypothetical protein +FIG01026204 DUF461 precursor +FIG01026207 FIG01026210: hypothetical protein +FIG01026212 FIG01026217: hypothetical protein +FIG01026221 FIG01026227: hypothetical protein +FIG01026229 FIG01026231: hypothetical protein +FIG01026231 FIG01026239: hypothetical protein +FIG01026239 FIG01026240: hypothetical protein +FIG01026240 FIG01026243: hypothetical protein +FIG01026245 FIG01026246: hypothetical protein +FIG01026246 FIG01026248: hypothetical protein +FIG01026248 FIG01026249: hypothetical protein +FIG01026253 FIG01026255: hypothetical protein +FIG01026257 FIG01026258: hypothetical protein +FIG01026262 protein of unknown function DUF1018 +FIG01026263 FIG01026264: hypothetical protein +FIG01026264 FIG01026266: hypothetical protein +FIG01026272 thio:disulfide interchange protein, putative +FIG01026278 FIG01026279: hypothetical protein +FIG01026279 FIG01026282: hypothetical protein +FIG01026282 OMEGA-AMINO ACID-PYRUVATE AMINOTRANSFERASE +FIG01026296 FIG01026297: hypothetical protein +FIG01026297 hypothetical protein ROS217_21197 +FIG01026301 FIG01026303: hypothetical protein +FIG01026311 FIG01026312: hypothetical protein +FIG01026322 FIG01026323: hypothetical protein +FIG01026325 Non-ribosomal peptide synthetase +FIG01026330 FIG01026332: hypothetical protein +FIG01026332 FIG01026334: hypothetical protein +FIG01026334 FIG01026335: hypothetical protein +FIG01026336 FIG01026338: hypothetical protein +FIG01026338 FIG01026340: hypothetical protein +FIG01026340 FIG01026341: hypothetical protein +FIG01026342 FIG01026344: hypothetical protein +FIG01026344 FIG01026345: hypothetical protein +FIG01026345 FIG01026346: hypothetical protein +FIG01026346 FIG01026347: hypothetical protein +FIG01026347 2-keto-3-deoxy-galactonokinase +FIG01026348 FIG01026350: hypothetical protein +FIG01026350 FIG01026354: hypothetical protein +FIG01026354 FIG01026355: hypothetical protein +FIG01026356 FIG01026357: hypothetical protein +FIG01026357 FIG01026359: hypothetical protein +FIG01026364 FIG01026366: hypothetical protein +FIG01026366 FIG01026367: hypothetical protein +FIG01026371 FIG01026375: hypothetical protein +FIG01026375 FIG01026376: hypothetical protein +FIG01026376 FIG01026377: hypothetical protein +FIG01026378 FIG01026379: hypothetical protein +FIG01026380 FIG01026381: hypothetical protein +FIG01026381 FIG01026384: hypothetical protein +FIG01026384 FIG01026386: hypothetical protein +FIG01026386 translation initiation factor IF-1 +FIG01026388 FIG01026390: hypothetical protein +FIG01026390 FIG01026391: hypothetical protein +FIG01026392 FIG01026394: hypothetical protein +FIG01026409 FIG01026415: hypothetical protein +FIG01026429 FIG01026430: hypothetical protein +FIG01026430 FIG01026432: hypothetical protein +FIG01026432 FIG01026433: hypothetical protein +FIG01026435 FIG01026442: hypothetical protein +FIG01026442 FIG01026443: hypothetical protein +FIG01026445 FIG01026448: hypothetical protein +FIG01026452 FIG01026453: hypothetical protein +FIG01026453 FIG01026454: hypothetical protein +FIG01026458 4-hydroxyphenylacetate 3-monooxygenase +FIG01026462 FIG01026463: hypothetical protein +FIG01026466 FIG01026468: hypothetical protein +FIG01026469 FIG01026470: hypothetical protein +FIG01026470 FIG01026471: hypothetical protein +FIG01026471 FIG01026474: hypothetical protein +FIG01026474 FIG01026477: hypothetical protein +FIG01026487 phage virion morphogenesis (putative tail completion) protein +FIG01026490 FIG01026492: hypothetical protein +FIG01026492 FIG01026494: hypothetical protein +FIG01026495 FIG01026496: hypothetical protein +FIG01026496 FIG01026498: hypothetical protein +FIG01026499 Hydrogenase transcriptional regulatory protein hoxA +FIG01026500 FIG01026503: hypothetical protein +FIG01026503 FIG01026504: hypothetical protein +FIG01026510 FIG01026513: hypothetical protein +FIG01026517 Mll1313 protein +FIG01026521 cobaltochelatase +FIG01026525 FIG01026527: hypothetical protein +FIG01026529 FIG01026531: hypothetical protein +FIG01026531 FIG01026534: hypothetical protein +FIG01026538 FIG01026539: hypothetical protein +FIG01026539 FIG01026540: hypothetical protein +FIG01026548 FIG01026549: hypothetical protein +FIG01026549 Conserved hypothetical protein, gene in Ubiquinol-cytochrome C chaperone locus +FIG01026555 FIG01026556: hypothetical protein +FIG01026556 FIG01026558: hypothetical protein +FIG01026561 FIG01026563: hypothetical protein +FIG01026563 Lip3/bchO family protein +FIG01026568 FIG01026570: hypothetical protein +FIG01026570 FIG01026573: hypothetical protein +FIG01026577 FIG01026578: hypothetical protein +FIG01026578 FIG01026579: hypothetical protein +FIG01026590 FIG01026593: hypothetical protein +FIG01026593 FIG01026597: hypothetical protein +FIG01026601 FIG01026602: hypothetical protein +FIG01026602 FIG01026603: hypothetical protein +FIG01026603 FIG01026607: hypothetical protein +FIG01026607 FIG01143496: hypothetical protein +FIG01026608 FIG01026609: hypothetical protein +FIG01026613 FIG01026614: hypothetical protein +FIG01026619 FIG01026620: hypothetical protein +FIG01026623 FIG01026626: hypothetical protein +FIG01026627 FIG01026628: hypothetical protein +FIG01026628 FIG01026630: hypothetical protein +FIG01026630 FIG01026631: hypothetical protein +FIG01026631 FIG01026633: hypothetical protein +FIG01026633 FIG01026635: hypothetical protein +FIG01026635 FIG01026638: hypothetical protein +FIG01026640 FIG01026641: hypothetical protein +FIG01026650 FIG01026653: hypothetical protein +FIG01026665 FIG01026666: hypothetical protein +FIG01026666 FIG01026670: hypothetical protein +FIG01026670 FIG01026671: hypothetical protein +FIG01026671 FIG01026672: hypothetical protein +FIG01026674 FIG01026675: hypothetical protein +FIG01026677 FIG01026679: hypothetical protein +FIG01026692 FIG01026693: hypothetical protein +FIG01026699 FIG01026701: hypothetical protein +FIG01026701 FIG01026703: hypothetical protein +FIG01026703 FIG01026706: hypothetical protein +FIG01026706 FIG01026708: hypothetical protein +FIG01026708 ATP-dependent RNA helicase, DEAD/DEAH box family +FIG01026710 hypothetical ABC transporter, permease protein +FIG01026713 FIG01026715: hypothetical protein +FIG01026716 FIG01026717: hypothetical protein +FIG01026717 FIG01026720: hypothetical protein +FIG01026720 Non-ribosomal peptide synthase +FIG01026724 FIG01026728: hypothetical protein +FIG01026728 FIG01026732: hypothetical protein +FIG01026732 FIG01026733: hypothetical protein +FIG01026733 FIG01026734: hypothetical protein +FIG01026734 FIG01026735: hypothetical protein +FIG01026735 FIG01026736: hypothetical protein +FIG01026738 Opine oxidase subunit C +FIG01026739 FIG01026742: hypothetical protein +FIG01026742 FIG01026745: hypothetical protein +FIG01026756 FIG01026758: hypothetical protein +FIG01026758 FIG00450070: hypothetical protein +FIG01026765 Glycosyl transferase, WecB/TagA/CpsF family +FIG01026768 FIG01026772: hypothetical protein +FIG01026782 Exoglucanase A precursor (EC 3.2.1.91) +FIG01026790 FIG01026792: hypothetical protein +FIG01026793 FIG01026794: hypothetical protein +FIG01026794 FIG01026796: hypothetical protein +FIG01026796 FIG01026798: hypothetical protein +FIG01026798 FIG01026802: hypothetical protein +FIG01026802 Outer membrane protein, OMP85 family +FIG01026808 FIG01026811: hypothetical protein +FIG01026811 FIG01026812: hypothetical protein +FIG01026812 FIG01026814: hypothetical protein +FIG01026814 FIG01026816: hypothetical protein +FIG01026816 FIG01026817: hypothetical protein +FIG01026832 FIG01026833: hypothetical protein +FIG01026833 FIG01026835: hypothetical protein +FIG01026842 FIG01026843: hypothetical protein +FIG01026843 FIG01026845: hypothetical protein +FIG01026845 FIG01026848: hypothetical protein +FIG01026848 FIG01026851: hypothetical protein +FIG01026851 FIG01026852: hypothetical protein +FIG01026852 response regulator/sensory box protein/GGDEF domain protein +FIG01026855 FIG01026857: hypothetical protein +FIG01026857 FIG01026859: hypothetical protein +FIG01026861 Universal stress protein UspA and related nucleotide-binding protein +FIG01026869 FIG01026873: hypothetical protein +FIG01026880 FIG01026881: hypothetical protein +FIG01026881 FIG01026883: hypothetical protein +FIG01026890 FIG01026892: hypothetical protein +FIG01026901 FIG01026902: hypothetical protein +FIG01026907 FIG01026909: hypothetical protein +FIG01026911 L-pipecolate oxidase (1.5.3.7) +FIG01026914 FIG01026919: hypothetical protein +FIG01026923 FIG01026924: hypothetical protein +FIG01026927 FIG01026929: hypothetical protein +FIG01026930 FIG01026935: hypothetical protein +FIG01026940 FIG01026941: hypothetical protein +FIG01026943 FIG01026945: hypothetical protein +FIG01026945 FIG01026946: hypothetical protein +FIG01026946 FIG01026947: hypothetical protein +FIG01026949 FIG01026951: hypothetical protein +FIG01026951 Metallopeptidase, family M24 +FIG01026952 FIG01026968: hypothetical protein +FIG01026972 FIG01026975: hypothetical protein +FIG01026981 FIG01026983: hypothetical protein +FIG01026984 FIG01026985: hypothetical protein +FIG01026985 FIG01026992: hypothetical protein +FIG01026992 FIG01026994: hypothetical protein +FIG01026994 FIG01026997: hypothetical protein +FIG01026998 FIG01027000: hypothetical protein +FIG01027001 Catalytic LigB subunit of aromatic ring-opening dioxygenase +FIG01027002 FIG01027003: hypothetical protein +FIG01027003 FIG01027006: hypothetical protein +FIG01027006 FIG01027008: hypothetical protein +FIG01027015 FIG01027016: hypothetical protein +FIG01027018 FIG01027019: hypothetical protein +FIG01027019 FIG01027020: hypothetical protein +FIG01027027 FIG01027028: hypothetical protein +FIG01027030 FIG01027033: hypothetical protein +FIG01027033 FIG01027035: hypothetical protein +FIG01027035 FIG01027036: hypothetical protein +FIG01027036 FIG01027039: hypothetical protein +FIG01027049 FIG01027050: hypothetical protein +FIG01027050 FIG01027051: hypothetical protein +FIG01027051 FIG01027052: hypothetical protein +FIG01027055 FIG01027056: hypothetical protein +FIG01027056 FIG01027061: hypothetical protein +FIG01027080 FIG01027083: hypothetical protein +FIG01027085 FIG01027089: hypothetical protein +FIG01027091 FIG01027093: hypothetical protein +FIG01027115 FIG01027116: hypothetical protein +FIG01027117 Phosphopantetheine-binding acyl carrier protein +FIG01027122 FIG01027123: hypothetical protein +FIG01027125 FIG01027126: hypothetical protein +FIG01027126 FIG01027128: hypothetical protein +FIG01027128 FIG01027129: hypothetical protein +FIG01027129 FIG01027136: hypothetical protein +FIG01027136 Aminotransferase, class IV +FIG01027140 FIG01027141: hypothetical protein +FIG01027142 FIG01027143: hypothetical protein +FIG01027143 FIG01027144: hypothetical protein +FIG01027144 Lipase esterase +FIG01027146 FIG01027151: hypothetical protein +FIG01027153 FIG01027155: hypothetical protein +FIG01027157 FIG01027158: hypothetical protein +FIG01027158 FIG01027160: hypothetical protein +FIG01027160 FIG01027161: hypothetical protein +FIG01027161 FIG01027163: hypothetical protein +FIG01027166 FIG01027167: hypothetical protein +FIG01027168 FIG01027169: hypothetical protein +FIG01027179 FIG01027180: hypothetical protein +FIG01027180 FIG01027186: hypothetical protein +FIG01027188 FIG01027189: hypothetical protein +FIG01027189 FIG01027190: hypothetical protein +FIG01027190 FIG01027191: hypothetical protein +FIG01027199 FIG01027200: hypothetical protein +FIG01027200 FIG01027201: hypothetical protein +FIG01027201 FIG01027204: hypothetical protein +FIG01027207 FIG01027208: hypothetical protein +FIG01027210 FIG01027211: hypothetical protein +FIG01027223 FIG01027224: hypothetical protein +FIG01027224 FIG01027225: hypothetical protein +FIG01027225 FIG01027227: hypothetical protein +FIG01027227 FIG01027229: hypothetical protein +FIG01027229 FIG01027232: hypothetical protein +FIG01027234 FIG01027236: hypothetical protein +FIG01027236 methyltransferase-like protein +FIG01027245 FIG01027246: hypothetical protein +FIG01027256 FIG01027258: hypothetical protein +FIG01027259 FIG01027260: hypothetical protein +FIG01027262 FIG01027263: hypothetical protein +FIG01027271 FIG01027272: hypothetical protein +FIG01027272 Monophosphatase-like protein +FIG01027276 FIG01027277: hypothetical protein +FIG01027277 putative Glucose/sorbosone dehydrogenase +FIG01027288 FIG01027290: hypothetical protein +FIG01027298 FIG01027301: hypothetical protein +FIG01027304 Mll6900 protein +FIG01027306 FIG01027310: hypothetical protein +FIG01027312 FIG01027315: hypothetical protein +FIG01027329 FIG01027334: hypothetical protein +FIG01027341 FIG01027343: hypothetical protein +FIG01027344 FIG01027349: hypothetical protein +FIG01027363 Trypsin 4 precursor (EC 3.4.21.4) +FIG01027365 FIG01027367: hypothetical protein +FIG01027367 FIG01027369: hypothetical protein +FIG01027369 FIG01027370: hypothetical protein +FIG01027373 FIG01027375: hypothetical protein +FIG01027375 FIG01027378: hypothetical protein +FIG01027378 FIG01027380: hypothetical protein +FIG01027380 Mll8093 protein +FIG01027386 FIG01027387: hypothetical protein +FIG01027387 FIG01027389: hypothetical protein +FIG01027391 Transcriptional regulator, LuxR family/hydrolase, alpha/beta fold family +FIG01027392 FIG01027398: hypothetical protein +FIG01027398 FIG01027399: hypothetical protein +FIG01027404 FIG01027405: hypothetical protein +FIG01027410 FIG01027413: hypothetical protein +FIG01027413 FIG01027417: hypothetical protein +FIG01027417 FIG01027419: hypothetical protein +FIG01027419 FIG01027421: hypothetical protein +FIG01027421 FIG01027426: hypothetical protein +FIG01027438 FIG01027439: hypothetical protein +FIG01027441 FIG01027443: hypothetical protein +FIG01027448 FIG01027449: hypothetical protein +FIG01027456 FIG01027458: hypothetical protein +FIG01027460 FIG01027461: hypothetical protein +FIG01027464 FIG01027470: hypothetical protein +FIG01027471 FIG01027473: hypothetical protein +FIG01027477 FIG01027480: hypothetical protein +FIG01027484 FIG01027485: hypothetical protein +FIG01027485 large subunit of N,N-dimethylformamidase +FIG01027495 FIG01027496: hypothetical protein +FIG01027498 PROBABLE NITRILE HYDRATASE SUBUNIT BETA PROTEIN (EC 4.2.1.84) +FIG01027506 FIG01027508: hypothetical protein +FIG01027509 FIG01027510: hypothetical protein +FIG01027510 FIG01027513: hypothetical protein +FIG01027513 FIG01027515: hypothetical protein +FIG01027515 FIG01027516: hypothetical protein +FIG01027518 FIG01027519: hypothetical protein +FIG01027525 FIG01027527: hypothetical protein +FIG01027530 FIG01027531: hypothetical protein +FIG01027531 FIG01027532: hypothetical protein +FIG01027540 FIG01027541: hypothetical protein +FIG01027542 FIG01027544: hypothetical protein +FIG01027547 NADH dehydrogenase subunit E( EC:1.6.5.3 ) +FIG01027568 FIG01027569: hypothetical protein +FIG01027573 FIG01027578: hypothetical protein +FIG01027589 FIG01027591: hypothetical protein +FIG01027591 FIG01027592: hypothetical protein +FIG01027595 FIG01027600: hypothetical protein +FIG01027602 FIG01027605: hypothetical protein +FIG01027606 FIG01027607: hypothetical protein +FIG01027607 ABC transporter, periplasmic protein +FIG01027609 polar amino acid uptake family ABC transporter, permease protein +FIG01027624 FIG01027630: hypothetical protein +FIG01027639 FIG01027640: hypothetical protein +FIG01027640 Sensor histidine kinase/response regulator (EC 2.7.3.-) +FIG01027648 GcrA cell cycle regulator +FIG01027650 FIG01027653: hypothetical protein +FIG01027654 methionine synthase I +FIG01027657 FIG01027663: hypothetical protein +FIG01027663 FIG01027664: hypothetical protein +FIG01027664 FIG01027665: hypothetical protein +FIG01027665 FIG01027667: hypothetical protein +FIG01027667 FIG01027670: hypothetical protein +FIG01027671 FIG01027672: hypothetical protein +FIG01027677 FIG01027678: hypothetical protein +FIG01027678 FIG01027681: hypothetical protein +FIG01027681 FIG01027683: hypothetical protein +FIG01027683 FIG01027684: hypothetical protein +FIG01027690 FIG01027691: hypothetical protein +FIG01027691 FIG01027692: hypothetical protein +FIG01027693 FIG01027696: hypothetical protein +FIG01027696 FIG01027699: hypothetical protein +FIG01027699 FIG01027701: hypothetical protein +FIG01027701 FIG01027702: hypothetical protein +FIG01027702 FIG01027703: hypothetical protein +FIG01027706 FIG01027707: hypothetical protein +FIG01027713 FIG01027714: hypothetical protein +FIG01027730 FIG01027731: hypothetical protein +FIG01027731 FIG01027734: hypothetical protein +FIG01027734 FIG01027735: hypothetical protein +FIG01027739 FIG01027741: hypothetical protein +FIG01027741 FIG01027746: hypothetical protein +FIG01027749 FIG01027751: hypothetical protein +FIG01027751 FIG00440100: hypothetical protein +FIG01027784 FIG01027786: hypothetical protein +FIG01027786 FIG01027787: hypothetical protein +FIG01027787 FIG01027794: hypothetical protein +FIG01027798 FIG01027801: hypothetical protein +FIG01027804 BNR repeat protein +FIG01027807 Permeases of the drug/metabolite transporter (DMT) superfamily precursor +FIG01027821 FIG01027830: hypothetical protein +FIG01027836 FIG01027840: hypothetical protein +FIG01027842 FIG01027843: hypothetical protein +FIG01027850 FIG01027851: hypothetical protein +FIG01027857 FIG01027858: hypothetical protein +FIG01027859 FIG01027862: hypothetical protein +FIG01027864 FIG01027866: hypothetical protein +FIG01027866 FIG01027867: hypothetical protein +FIG01027871 FIG01027874: hypothetical protein +FIG01027884 FIG01027885: hypothetical protein +FIG01027887 FIG01027888: hypothetical protein +FIG01027891 FIG01027892: hypothetical protein +FIG01027892 FIG01027895: hypothetical protein +FIG01027895 FIG01027899: hypothetical protein +FIG01027909 FIG01027910: hypothetical protein +FIG01027910 FIG01027911: hypothetical protein +FIG01027911 FIG01027915: hypothetical protein +FIG01027928 FIG01027929: hypothetical protein +FIG01027929 FIG01027930: hypothetical protein +FIG01027943 FIG01027944: hypothetical protein +FIG01027954 FIG01027955: hypothetical protein +FIG01027955 FIG01027958: hypothetical protein +FIG01027977 FIG01027979: hypothetical protein +FIG01027979 FIG01027982: hypothetical protein +FIG01027983 FIG010505: hypothetical protein +FIG01027984 FIG01027985: hypothetical protein +FIG01027995 FIG01027998: hypothetical protein +FIG01027999 FIG01028000: hypothetical protein +FIG01028001 FIG01028008: hypothetical protein +FIG01028011 FIG01028013: hypothetical protein +FIG01028013 Na+/H+ antiporter, CPA1 family +FIG01028035 FIG01028041: hypothetical protein +FIG01028041 FIG01028044: hypothetical protein +FIG01028044 FIG01028045: hypothetical protein +FIG01028049 FIG01028050: hypothetical protein +FIG01028052 FIG01028054: hypothetical protein +FIG01028054 FIG01028055: hypothetical protein +FIG01028055 FIG01028057: hypothetical protein +FIG01028060 FIG01028065: hypothetical protein +FIG01028074 FIG01028075: hypothetical protein +FIG01028075 FIG01028076: hypothetical protein +FIG01028077 Sigma-70 region 2 +FIG01028086 FIG01028090: hypothetical protein +FIG01028090 FIG01028092: hypothetical protein +FIG01028093 FIG01028095: hypothetical protein +FIG01028095 Putative epimerase/dehydratase +FIG01028098 FIG01028101: hypothetical protein +FIG01028101 FIG01028102: hypothetical protein +FIG01028103 FIG01028104: hypothetical protein +FIG01028113 FIG01028114: hypothetical protein +FIG01028120 FIG01028121: hypothetical protein +FIG01028131 FIG314152: hypothetical protein +FIG01028132 FIG01028134: hypothetical protein +FIG01028143 FIG01028144: hypothetical protein +FIG01028147 FIG01028152: hypothetical protein +FIG01028152 Protein gp27 +FIG01028160 Long-chain-fatty-acid--CoA ligase (EC 6.2.1.3) +FIG01028167 FIG01028169: hypothetical protein +FIG01028169 FIG01028173: hypothetical protein +FIG01028182 Probable acetolactate synthase large subunit +FIG01028192 FIG01028193: hypothetical protein +FIG01028199 FIG01028201: hypothetical protein +FIG01028225 pyridoxal-phosphate dependent enzyme family protein +FIG01028227 FIG01028230: hypothetical protein +FIG01028235 FIG01028237: hypothetical protein +FIG01028251 FIG01028252: hypothetical protein +FIG01028274 Leukotoxin +FIG01028287 FIG01028288: hypothetical protein +FIG01028304 FIG01028305: hypothetical protein +FIG01028312 FIG01028313: hypothetical protein +FIG01028334 Type I secretion target GGXGXDXXX repeat protein +FIG01028342 FIG01028345: hypothetical protein +FIG01028347 FIG01028348: hypothetical protein +FIG01028349 FIG01028350: hypothetical protein +FIG01028353 DDP1 homolog +FIG01028356 FIG01028360: hypothetical protein +FIG01028360 FIG01028361: hypothetical protein +FIG01028363 FIG01028365: hypothetical protein +FIG01028369 FIG01028370: hypothetical protein +FIG01028373 FIG01028375: hypothetical protein +FIG01028391 FIG01028392: hypothetical protein +FIG01028402 FIG01028404: hypothetical protein +FIG01028404 FIG01028409: hypothetical protein +FIG01028413 FIG01028417: hypothetical protein +FIG01028421 FIG01028424: hypothetical protein +FIG01028432 copper tolerance protein +FIG01028440 FIG01028441: hypothetical protein +FIG01028457 FIG01028459: hypothetical protein +FIG01028459 FIG01028461: hypothetical protein +FIG01028462 FIG01028472: hypothetical protein +FIG01028477 FIG01028484: hypothetical protein +FIG01028497 FIG01028498: hypothetical protein +FIG01028500 FIG01028501: hypothetical protein +FIG01028509 FIG01028512: hypothetical protein +FIG01028513 FIG01028516: hypothetical protein +FIG01028533 adenylosuccinate lyase( EC:4.3.2.2 ) +FIG01028535 FIG01028536: hypothetical protein +FIG01028562 FIG01028563: hypothetical protein +FIG01028563 FIG01028564: hypothetical protein +FIG01028564 FIG01028566: hypothetical protein +FIG01028571 CRISPR-associated helicase Cas3 +FIG01028573 COG1316: Transcriptional regulator +FIG01028574 FIG01028576: hypothetical protein +FIG01028578 FIG01028579: hypothetical protein +FIG01028580 FIG01028582: hypothetical protein +FIG01028582 FIG01028583: hypothetical protein +FIG01028583 HtrA protease/chaperone protein +FIG01028584 FIG01028585: hypothetical protein +FIG01028587 FIG01028589: hypothetical protein +FIG01028589 putative tetratricopeptide repeat domain protein +FIG01028590 FIG01028592: hypothetical protein +FIG01028592 FIG01028593: hypothetical protein +FIG01028601 FIG01028602: hypothetical protein +FIG01028603 FIG01028604: hypothetical protein +FIG01028604 FIG01028605: hypothetical protein +FIG01028610 FIG01028613: hypothetical protein +FIG01028614 FIG01028615: hypothetical protein +FIG01028615 FIG01028616: hypothetical protein +FIG01028616 putative FemAB family protein +FIG01028618 FIG01028619: hypothetical protein +FIG01028619 FIG01028620: hypothetical protein +FIG01028620 FIG00733451: hypothetical protein +FIG01028621 Peptidase M20D, amidohydrolase( EC:3.5.1.14 ) +FIG01028628 FIG01028631: hypothetical protein +FIG01028631 FIG01028632: hypothetical protein +FIG01028632 FIG01028633: hypothetical protein +FIG01028634 FIG01028636: hypothetical protein +FIG01028636 FIG01028638: hypothetical protein +FIG01028638 FIG01028641: hypothetical protein +FIG01028641 SNF2-related +FIG01028643 FIG01028644: hypothetical protein +FIG01028644 FIG01028645: hypothetical protein +FIG01028645 FIG01028646: hypothetical protein +FIG01028646 FIG01028647: hypothetical protein +FIG01028651 FIG01028652: hypothetical protein +FIG01028652 FIG01028653: hypothetical protein +FIG01028656 FIG01028658: hypothetical protein +FIG01028661 FIG01028662: hypothetical protein +FIG01028662 FIG01028663: hypothetical protein +FIG01028667 FIG01028668: hypothetical protein +FIG01028668 threonine dehydratase +FIG01028669 FIG01028670: hypothetical protein +FIG01028674 FIG01028675: hypothetical protein +FIG01028676 FIG01028677: hypothetical protein +FIG01028686 FIG01028688: hypothetical protein +FIG01028692 FIG01028694: hypothetical protein +FIG01028694 FIG01028695: hypothetical protein +FIG01028695 FIG01028696: hypothetical protein +FIG01028707 FIG01028708: hypothetical protein +FIG01028708 putative hydrolase protein +FIG01028709 FIG00733975: hypothetical protein +FIG01028711 FIG01028712: hypothetical protein +FIG01028714 FIG01028715: hypothetical protein +FIG01028715 Lipolytic enzyme, G-D-S-L +FIG01028718 FIG01028719: hypothetical protein +FIG01028719 FIG01028720: hypothetical protein +FIG01028720 FIG01028721: hypothetical protein +FIG01028726 FIG01028727: hypothetical protein +FIG01028727 FIG01028729: hypothetical protein +FIG01028729 mut-like protein +FIG01028730 FIG01028731: hypothetical protein +FIG01028733 FIG01028734: hypothetical protein +FIG01028734 FIG01028735: hypothetical protein +FIG01028735 FIG01028736: hypothetical protein +FIG01028736 putative maltose O-acetyltransferase +FIG01028739 FIG002595: Putative proteasome component +FIG01028745 FIG01028746: hypothetical protein +FIG01028750 FIG01028752: hypothetical protein +FIG01028752 FIG01028753: hypothetical protein +FIG01028757 putative membrane protein [KO:K01992] +FIG01028758 FIG01028759: hypothetical protein +FIG01028759 ATPases involved in chromosome partitioning-like protein +FIG01028764 FIG01028765: hypothetical protein +FIG01028768 FIG01028769: hypothetical protein +FIG01028774 FIG01028775: hypothetical protein +FIG01028775 FIG01028777: hypothetical protein +FIG01028779 FIG01028780: hypothetical protein +FIG01028781 FIG01028782: hypothetical protein +FIG01028783 FIG01028785: hypothetical protein +FIG01028786 putative glutamate transporter permease protein +FIG01028787 FIG01028789: hypothetical protein +FIG01028790 Putative NADH dehydrogenase/NAD(P)H nitroreductase SCO5049 (EC 1.-.-.-) +FIG01028792 FIG01028794: hypothetical protein +FIG01028797 FIG01028799: hypothetical protein +FIG01028799 Glutamate binding protein +FIG01028813 FIG01028814: hypothetical protein +FIG01028815 FIG01028816: hypothetical protein +FIG01028816 FIG01028817: hypothetical protein +FIG01028818 FIG01028819: hypothetical protein +FIG01028820 FIG01028821: hypothetical protein +FIG01028821 FIG01028822: hypothetical protein +FIG01028823 FIG01028824: hypothetical protein +FIG01028824 FIG01028825: hypothetical protein +FIG01028825 Exoenzymes regulatory protein AepA in lipid-linked oligosaccharide synthesis cluster +FIG01028831 FIG01028833: hypothetical protein +FIG01028833 FIG01028834: hypothetical protein +FIG01028834 FIG01028835: hypothetical protein +FIG01028835 putative DNA or RNA helicase of superfamily II +FIG01028838 FIG01028840: hypothetical protein +FIG01028840 FIG01028842: hypothetical protein +FIG01028842 FIG01028843: hypothetical protein +FIG01028843 FIG01028844: hypothetical protein +FIG01028844 FIG01028845: hypothetical protein +FIG01028845 FIG01028847: hypothetical protein +FIG01028848 FIG01028849: hypothetical protein +FIG01028849 putative rhodanese-related sulfurtransferase +FIG01028857 FIG01028858: hypothetical protein +FIG01028858 FIG01028860: hypothetical protein +FIG01028863 FIG01028864: hypothetical protein +FIG01028864 FIG01028865: hypothetical protein +FIG01028865 FIG01028866: hypothetical protein +FIG01028872 2',5' RNA ligase +FIG01028875 FIG01028877: hypothetical protein +FIG01028878 FIG01028879: hypothetical protein +FIG01028879 FIG01028880: hypothetical protein +FIG01028884 FIG01028885: hypothetical protein +FIG01028886 FIG01028887: hypothetical protein +FIG01028887 FIG01028889: hypothetical protein +FIG01028889 FIG01028890: hypothetical protein +FIG01028892 putative TadE-like family protein +FIG01028893 FIG01028894: hypothetical protein +FIG01028896 FIG01028897: hypothetical protein +FIG01028897 rRNA methyltransferase +FIG01028899 FIG01028901: hypothetical protein +FIG01028903 FIG01028904: hypothetical protein +FIG01028904 FIG01028905: hypothetical protein +FIG01028905 COG1765: Predicted redox protein, regulator of disulfide bond formation +FIG01028910 FIG01028912: hypothetical protein +FIG01028912 FIG01028913: hypothetical protein +FIG01028916 FIG01028917: hypothetical protein +FIG01028917 FIG01028918: hypothetical protein +FIG01028919 FIG01028920: hypothetical protein +FIG01028922 FIG01028923: hypothetical protein +FIG01028924 FIG01028925: hypothetical protein +FIG01028925 FIG01028926: hypothetical protein +FIG01028931 FIG01028932: hypothetical protein +FIG01028936 FIG01028937: hypothetical protein +FIG01028937 FIG01028938: hypothetical protein +FIG01028938 predicted nucleic acid-binding protein +FIG01028939 FIG01028940: hypothetical protein +FIG01028942 FIG01028943: hypothetical protein +FIG01028943 FIG01028944: hypothetical protein +FIG01028945 FIG01028946: hypothetical protein +FIG01028946 FIG01028947: hypothetical protein +FIG01028949 FIG01028952: hypothetical protein +FIG01028953 Cation transporter +FIG01028956 Branched-chain amino acid transport protein +FIG01028958 FIG01028959: hypothetical protein +FIG01028959 FIG01028960: hypothetical protein +FIG01028963 FIG01028964: hypothetical protein +FIG01028964 FIG01028966: hypothetical protein +FIG01028966 FIG01028968: hypothetical protein +FIG01028968 FIG01028969: hypothetical protein +FIG01028969 FIG01028971: hypothetical protein +FIG01028976 FIG01028978: hypothetical protein +FIG01028978 FIG01028981: hypothetical protein +FIG01028984 phage shock protein A, PspA +FIG01028985 FIG01028986: hypothetical protein +FIG01028986 FIG01028988: hypothetical protein +FIG01028988 FIG01028989: hypothetical protein +FIG01028990 FIG01028991: hypothetical protein +FIG01028991 FIG01028992: hypothetical protein +FIG01028993 FIG01028994: hypothetical protein +FIG01028995 FIG01028997: hypothetical protein +FIG01028998 FIG01028999: hypothetical protein +FIG01028999 FIG01029000: hypothetical protein +FIG01029001 FIG01029002: hypothetical protein +FIG01029002 FIG01029003: hypothetical protein +FIG01029003 FIG01029004: hypothetical protein +FIG01029005 putative integration host factor MihF +FIG01029007 FIG01029008: hypothetical protein +FIG01029012 FIG01029013: hypothetical protein +FIG01029013 FIG01029014: hypothetical protein +FIG01029018 O-antigen export system permease protein +FIG01029021 FIG01029022: hypothetical protein +FIG01029029 FIG01029030: hypothetical protein +FIG01029030 FIG01029032: hypothetical protein +FIG01029032 FIG01029033: hypothetical protein +FIG01029035 Glycosyltransferase, family 28 +FIG01029037 FIG01029040: hypothetical protein +FIG01029040 FIG01029041: hypothetical protein +FIG01029041 FIG01029042: hypothetical protein +FIG01029042 FIG01029043: hypothetical protein +FIG01029043 FIG01029044: hypothetical protein +FIG01029044 FIG01029045: hypothetical protein +FIG01029045 FIG01029046: hypothetical protein +FIG01029046 FIG01029047: hypothetical protein +FIG01029051 FIG01029052: hypothetical protein +FIG01029052 type II secretion system protein E +FIG01029054 FIG01029055: hypothetical protein +FIG01029055 FIG01029056: hypothetical protein +FIG01029056 FIG01029057: hypothetical protein +FIG01029059 FIG01029060: hypothetical protein +FIG01029061 FIG01029063: hypothetical protein +FIG01029066 FIG01029067: hypothetical protein +FIG01029070 FIG01029071: hypothetical protein +FIG01029071 FIG01029072: hypothetical protein +FIG01029073 FIG01029074: hypothetical protein +FIG01029077 FIG01029080: hypothetical protein +FIG01029087 FIG01029089: hypothetical protein +FIG01029090 FIG01029091: hypothetical protein +FIG01029091 FIG01029092: hypothetical protein +FIG01029094 FIG01029095: hypothetical protein +FIG01029097 FIG01029098: hypothetical protein +FIG01029101 COG1120: ABC-type cobalamin/Fe3+-siderophores transport systems, ATPase components +FIG01029105 FIG01029107: hypothetical protein +FIG01029108 regulatory protein, LysR +FIG01029111 FIG01029112: hypothetical protein +FIG01029114 FIG01029115: hypothetical protein +FIG01029115 FIG01029116: hypothetical protein +FIG01029118 FIG01029119: hypothetical protein +FIG01029120 FIG01029121: hypothetical protein +FIG01029122 Tat pathway signal sequence domain protein +FIG01029126 FIG01029127: hypothetical protein +FIG01029128 FIG01029129: hypothetical protein +FIG01029130 FIG01029131: hypothetical protein +FIG01029132 FIG01029133: hypothetical protein +FIG01029133 FIG01029134: hypothetical protein +FIG01029134 FIG01029135: hypothetical protein +FIG01029141 FIG01029142: hypothetical protein +FIG01029142 FIG01029143: hypothetical protein +FIG01029144 FIG01029145: hypothetical protein +FIG01029156 FIG01029157: hypothetical protein +FIG01029158 FIG01029159: hypothetical protein +FIG01029159 FIG01029160: hypothetical protein +FIG01029162 COG4420: Predicted membrane protein +FIG01029163 FIG01029164: hypothetical protein +FIG01029165 FIG01029166: hypothetical protein +FIG01029169 FIG01029170: hypothetical protein +FIG01029170 FIG01029171: hypothetical protein +FIG01029171 putative ferritin family protein +FIG01029173 FIG01029174: hypothetical protein +FIG01029174 FIG01029176: hypothetical protein +FIG01029176 FIG01029177: hypothetical protein +FIG01029177 similar to Superfamily I DNA and RNA helicases +FIG01029188 FIG01029189: hypothetical protein +FIG01029194 FIG01029195: hypothetical protein +FIG01029197 FIG01029199: hypothetical protein +FIG01029199 FIG01029201: hypothetical protein +FIG01029201 FIG01029202: hypothetical protein +FIG01029207 FIG01029208: hypothetical protein +FIG01029209 FIG01029211: hypothetical protein +FIG01029215 FIG01029216: hypothetical protein +FIG01029216 FIG01029217: hypothetical protein +FIG01029218 FIG01029219: hypothetical protein +FIG01029219 RidA/YER057c/UK114 superfamily, group 1 +FIG01029225 FIG01029226: hypothetical protein +FIG01029230 DNA binding domain, excisionase/Xis +FIG01029236 FIG01029237: hypothetical protein +FIG01029238 FIG01029239: hypothetical protein +FIG01029239 FIG01029241: hypothetical protein +FIG01029241 FIG01029242: hypothetical protein +FIG01029242 FIG01029243: hypothetical protein +FIG01029244 FIG01029245: hypothetical protein +FIG01029245 FIG01029246: hypothetical protein +FIG01029247 FIG01029249: hypothetical protein +FIG01029269 FIG01029270: hypothetical protein +FIG01029270 FIG01029271: hypothetical protein +FIG01029271 FIG01029274: hypothetical protein +FIG01029275 FIG01029277: hypothetical protein +FIG01029278 FIG01029279: hypothetical protein +FIG01029279 FIG01029280: hypothetical protein +FIG01029286 FIG01029287: hypothetical protein +FIG01029287 FIG01029288: hypothetical protein +FIG01029292 FIG01029293: hypothetical protein +FIG01029300 FIG01029304: hypothetical protein +FIG01029304 FIG01029306: hypothetical protein +FIG01029306 FIG01029307: hypothetical protein +FIG01029316 FIG01029318: hypothetical protein +FIG01029318 FIG01029319: hypothetical protein +FIG01029321 Secreted protein +FIG01029322 FIG01029323: hypothetical protein +FIG01029330 FIG01029331: hypothetical protein +FIG01029334 FIG01029335: hypothetical protein +FIG01029337 FIG01029338: hypothetical protein +FIG01029341 FIG01029342: hypothetical protein +FIG01029345 FIG01029346: hypothetical protein +FIG01029347 FIG01029350: hypothetical protein +FIG01029350 FIG01029353: hypothetical protein +FIG01029353 FIG01029354: hypothetical protein +FIG01029354 FIG01029355: hypothetical protein +FIG01029355 FIG01029357: hypothetical protein +FIG01029365 SagA protein +FIG01029367 FIG01029368: hypothetical protein +FIG01029368 FIG01029371: hypothetical protein +FIG01029376 exopolysaccharide biosynthesis protein related to N-acetylglucosamine-1-phosphodiester alpha-N-acetylglucosaminidase +FIG01029381 FIG01029383: hypothetical protein +FIG01029385 Dak phosphatase +FIG01029387 FIG01029388: hypothetical protein +FIG01029390 FIG01029391: hypothetical protein +FIG01029393 FKBP-type peptidyl-prolyl cis-trans isomerases 1 +FIG01029395 FIG01029396: hypothetical protein +FIG01029396 similar to Uncharacterized membrane-associated protein +FIG01029400 FIG01029402: hypothetical protein +FIG01029405 FIG01029406: hypothetical protein +FIG01029714 Fructose ABC transporter, ATP-binding component FrcA +FIG01029879 hypothetical protein Rxyl_2959 +FIG01029953 Electron transport complex protein rnfC homolog +FIG01030053 FIG01030056: hypothetical protein +FIG01030109 Alkylpyrone O-methyltransferase (B. subtilis BpsB) +FIG01030283 Carbamoyltransferase family protein +FIG01030403 CoA-binding protein +FIG01030435 FIG01030440: hypothetical protein +FIG01030534 RlpA-like lipoprotein precursor +FIG01030538 N5,N10-methylenetetrahydromethanopterin reductase-related protein, SCO6416-type +FIG01030543 FIG01030554: hypothetical protein +FIG01030572 Possible sulfite oxidase +FIG01030613 FIG01030615: hypothetical protein +FIG01030625 Lipoprotein VacJ +FIG01030628 Trypsin domain protein +FIG01030636 FIG00992399: hypothetical protein +FIG01030650 FIG01025121: hypothetical protein +FIG01030656 FIG01142942: hypothetical protein +FIG01030663 Mlr4354 like protein +FIG01030673 FIG01030677: hypothetical protein +FIG01030677 iron-regulated protein frpC +FIG01030678 FIG01030679: hypothetical protein +FIG01030683 FIG01030684: hypothetical protein +FIG01030688 Aminotransferase involved in DMSP breakdown +FIG01030692 ABC transporter, transmembrane ATP-binding protein +FIG01030699 ferrichrome-binding protein +FIG01030703 FIG01030706: hypothetical protein +FIG01030708 FIG01030709: hypothetical protein +FIG01030711 Type I secretion system ATPase +FIG01030720 amidohydrolase 3 +FIG01030731 FIG01030734: hypothetical protein +FIG01030734 FIG01030737: hypothetical protein +FIG01030737 similarity with cytochrome c-type biogenesis protein CcdA +FIG01030742 FIG00993632: hypothetical protein +FIG01030754 GcrA cell cycle regulator +FIG01030755 peptidoglycan binding domain protein +FIG01030758 Pyruvate/2-oxoglutarate dehydrogenase complex, dihydrolipoamide acyltransferase (E2) component, and related enzymes +FIG01030766 FIG01030767: hypothetical protein +FIG01030781 transcriptional regulator, HTH_3 family +FIG01030795 FIG01030799: hypothetical protein +FIG01030816 FIG01030818: hypothetical protein +FIG01030818 Pyruvate carboxylase +FIG01030830 FIG01030832: hypothetical protein +FIG01030833 dTDP-Rha:A-D-GlcNAc-diphosphoryl polyprenol, A-3-L-rhamnosyl transferase WbbL +FIG01030846 FIG01030848: hypothetical protein +FIG01030854 FIG01030856: hypothetical protein +FIG01030858 Conserved hypothetical protein, gene in Ubiquinol-cytochrome C chaperone locus +FIG01030859 ABC transporter, permease protein, HisMQ family +FIG01030873 Chaperonin, 33 kDa +FIG01030887 Methionine synthase I, cobalamin-binding domain +FIG01030888 FIG01030889: hypothetical protein +FIG01030893 FIG01030895: hypothetical protein +FIG01030897 Membrane protein, putative +FIG01030910 Alpha/beta hydrolase +FIG01030925 ATP-dependent transcriptional regulator +FIG01030934 K+-dependent Na+/Ca+ exchanger related-protein +FIG01030943 FIG01030948: hypothetical protein +FIG01030951 FIG01030955: hypothetical protein +FIG01030962 FIG01030963: hypothetical protein +FIG01030964 FIG00989147: hypothetical protein +FIG01030968 FIG00992599: hypothetical protein +FIG01030987 FIG01030990: hypothetical protein +FIG01030990 Transporter, Major facilitator superfamily +FIG01030996 FIG01031000: hypothetical protein +FIG01031002 ATP synthase subunits region ORF 7 +FIG01031007 FIG01031009: hypothetical protein +FIG01031023 Type II secretory pathway, pullulanase PulA and related glycosidases +FIG01031030 FIG01031035: hypothetical protein +FIG01031038 Hydrolase, haloacid delahogenase-like family +FIG01031042 czcN domain protein +FIG01031043 FIG01031044: hypothetical protein +FIG01031044 Lipoprotein, putative +FIG01031046 FIG01031048: hypothetical protein +FIG01031051 Expressed protein +FIG01031055 FIG01031059: hypothetical protein +FIG01031069 FIG01031071: hypothetical protein +FIG01031078 FIG01031080: hypothetical protein +FIG01031080 FIG01031086: hypothetical protein +FIG01031092 (AF072135) II.1 protein +FIG01031097 sterol carrier family protein +FIG01031130 FIG01031132: hypothetical protein +FIG01031145 His/Glu/Gln/Arg/opine family ABC transporter, periplasmic His/Glu/Gln/Arg/opine family-binding protein +FIG01031152 FIG01031154: hypothetical protein +FIG01031154 FIG00992203: hypothetical protein +FIG01031156 FIG00993552: hypothetical protein +FIG01031172 FIG01031173: hypothetical protein +FIG01031180 FIG01031191: hypothetical protein +FIG01031193 FIG01031196: hypothetical protein +FIG01031196 impact (1L558) / impact (1L558) +FIG01031198 Voltage-gated sodium channel subunit +FIG01031208 FIG01031210: hypothetical protein +FIG01031210 FIG01031211: hypothetical protein +FIG01031212 FIG01031213: hypothetical protein +FIG01031221 FIG01031222: hypothetical protein +FIG01031232 FIG01031238: hypothetical protein +FIG01031248 7-alpha-hydroxysteroid dehydrogenase +FIG01031252 C4-dicarboxylate transport sensor protein DctB +FIG01031255 FIG01031259: hypothetical protein +FIG01031270 FIG01031274: hypothetical protein +FIG01031274 ErfK/YbiS/YcfS/YnhG family protein/Tat domain protein +FIG01031291 FIG01031299: hypothetical protein +FIG01031299 FIG01031300: hypothetical protein +FIG01031306 WD domain/cytochrome c family protein +FIG01031308 LysM domain/M23/M37 peptidase +FIG01031312 FIG01031319: hypothetical protein +FIG01031338 FIG01031345: hypothetical protein +FIG01031345 Branched-chain amino acid ABC-type transport system, permease components +FIG01031353 Mll4390 protein +FIG01031355 Integral membrane protein CcmA involved in cell shape determination +FIG01031363 FIG01023191: hypothetical protein +FIG01031368 FIG01031373: hypothetical protein +FIG01031378 FIG01031379: hypothetical protein +FIG01031399 FIG01031400: hypothetical protein +FIG01031400 FIG01031402: hypothetical protein +FIG01031410 FIG01031411: hypothetical protein +FIG01031412 Msl4750 protein +FIG01031415 Polyhydroxyalkanoate depolymerase, intracellular +FIG01031418 Sterol carrier family protein +FIG01031431 FIG01031433: hypothetical protein +FIG01031433 FIG01031437: hypothetical protein +FIG01031438 DNA-binding response regulator +FIG01031439 probable integral membrane protein Cj1412c +FIG01031445 FIG00993848: hypothetical protein +FIG01031448 Type I secretion membrane fusion protein, HlyD family +FIG01031451 FIG00987571: hypothetical protein +FIG01031465 FIG01025449: hypothetical protein +FIG01031469 similar to acetolactate synthase large subunit +FIG01031474 FIG01031477: hypothetical protein +FIG01031495 FIG01031500: hypothetical protein +FIG01031500 FIG00993070: hypothetical protein +FIG01031512 FIG00991496: hypothetical protein +FIG01031518 FIG01031520: hypothetical protein +FIG01031522 COG1830: DhnA-type fructose-1,6-bisphosphate aldolase and related enzymes +FIG01031524 Possible ABC transporter subunit +FIG01031548 Ferredoxin--NADP reductase (EC 1.18.1.2) +FIG01031550 Branched-chain amino acid ABC transporter, periplasmic substrate- binding protein +FIG01031554 Isopropylmalate/homocitrate/citramalate synthases +FIG01031558 outer membrane protein, putative +FIG01031578 FIG167255: hypothetical protein +FIG01031585 FIG00989250: hypothetical protein +FIG01031595 FIG00992261: hypothetical protein +FIG01031596 Transcriptional regulator, MocR family, putative Taurine regulator tauR +FIG01031622 FIG01031623: hypothetical protein +FIG01031623 Methyltransferase, FkbM family +FIG01031628 Antioxidant, AhpC/Tsa family +FIG01031629 Flagellar motor switch protein +FIG01031634 FIG01031638: hypothetical protein +FIG01031638 Mlr3216 protein +FIG01031642 FIG01031643: hypothetical protein +FIG01031677 FIG01031683: hypothetical protein +FIG01031699 FIG01031704: hypothetical protein +FIG01031704 FIG00993001: hypothetical protein +FIG01031706 Drug/metabolite exporter family protein +FIG01031711 FIG01031712: hypothetical protein +FIG01031712 FIG01031714: hypothetical protein +FIG01031714 FIG01031715: hypothetical protein +FIG01031715 FIG00514877: hypothetical protein +FIG01031717 FIG01031718: hypothetical protein +FIG01031718 FIG01031719: hypothetical protein +FIG01031722 FIG01031723: hypothetical protein +FIG01031724 FIG01031725: hypothetical protein +FIG01031725 FIG01031726: hypothetical protein +FIG01031726 FIG01031727: hypothetical protein +FIG01031727 FIG01031728: hypothetical protein +FIG01031730 DNA packaging protein, putative +FIG01031731 FIG01031734: hypothetical protein +FIG01031735 FIG01031736: hypothetical protein +FIG01031736 FIG01031737: hypothetical protein +FIG01031737 FIG01031738: hypothetical protein +FIG01031738 FIG01031740: hypothetical protein +FIG01031740 FIG01031741: hypothetical protein +FIG01031745 FIG01031746: hypothetical protein +FIG01031746 FIG01031748: hypothetical protein +FIG01031753 FIG00516527: hypothetical protein +FIG01031754 FIG01031755: hypothetical protein +FIG01031755 FIG01031762: hypothetical protein +FIG01031766 FIG01031768: hypothetical protein +FIG01031768 FIG01031769: hypothetical protein +FIG01031772 FIG01031774: hypothetical protein +FIG01031774 FIG01031777: hypothetical protein +FIG01031777 FIG01031778: hypothetical protein +FIG01031778 FIG01031780: hypothetical protein +FIG01031783 SpoU rRNA Methylase family protein +FIG01031784 FIG01031786: hypothetical protein +FIG01031789 FIG01031791: hypothetical protein +FIG01031791 FIG01031793: hypothetical protein +FIG01031793 FIG01031795: hypothetical protein +FIG01031795 FIG01031798: hypothetical protein +FIG01031798 FIG01031799: hypothetical protein +FIG01031801 FIG00528420: hypothetical protein +FIG01031803 FIG01031805: hypothetical protein +FIG01031805 FIG01031806: hypothetical protein +FIG01031806 FIG00520221: hypothetical protein +FIG01031807 FIG01031808: hypothetical protein +FIG01031808 FIG01031809: hypothetical protein +FIG01031812 FIG01031813: hypothetical protein +FIG01031815 FIG01031817: hypothetical protein +FIG01031819 FIG01031820: hypothetical protein +FIG01031820 choline binding protein PcpA +FIG01031821 FIG01031822: hypothetical protein +FIG01031823 FIG01031825: hypothetical protein +FIG01031826 FIG01031828: hypothetical protein +FIG01031830 FIG01031831: hypothetical protein +FIG01031834 FIG01031836: hypothetical protein +FIG01031836 FIG01031837: hypothetical protein +FIG01031837 FIG01031838: hypothetical protein +FIG01031840 FIG01031841: hypothetical protein +FIG01031841 Stage III sporulation protein AB +FIG01031843 FIG01031845: hypothetical protein +FIG01031850 FIG01031853: hypothetical protein +FIG01031853 FIG01031854: hypothetical protein +FIG01031854 polar amino acid ABC transporter, substrate-binding component +FIG01031855 FIG01031856: hypothetical protein +FIG01031857 FIG01031858: hypothetical protein +FIG01031858 FIG01031859: hypothetical protein +FIG01031859 FIG01031860: hypothetical protein +FIG01031862 FIG01031864: hypothetical protein +FIG01031864 FIG01031865: hypothetical protein +FIG01031865 FIG01031866: hypothetical protein +FIG01031868 FIG01031870: hypothetical protein +FIG01031870 FIG01031873: hypothetical protein +FIG01031873 FIG01031876: hypothetical protein +FIG01031877 FIG00261083: hypothetical protein +FIG01031879 FIG01031880: hypothetical protein +FIG01031883 FIG01031885: hypothetical protein +FIG01031887 FIG01031888: hypothetical protein +FIG01031888 FIG01031889: hypothetical protein +FIG01031890 FIG01031891: hypothetical protein +FIG01031891 FIG01031892: hypothetical protein +FIG01031896 Anti-sigma F factor (EC 2.7.11.1) +FIG01031897 FIG01031898: hypothetical protein +FIG01031900 FIG01031901: hypothetical protein +FIG01031902 FIG01031904: hypothetical protein +FIG01031904 FIG01031907: hypothetical protein +FIG01031908 FIG01031909: hypothetical protein +FIG01031920 similar to Uncharacterized MobA-related protein +FIG01031924 FIG01031926: hypothetical protein +FIG01031927 FIG01031928: hypothetical protein +FIG01031934 FIG01031937: hypothetical protein +FIG01031938 Translocation-enhancing protein TepA +FIG01031953 FIG01031957: hypothetical protein +FIG01031961 FIG01031964: hypothetical protein +FIG01031971 FIG01031973: hypothetical protein +FIG01031973 FIG01031975: hypothetical protein +FIG01031975 FIG01031976: hypothetical protein +FIG01031981 FIG01031984: hypothetical protein +FIG01031988 FIG01031989: hypothetical protein +FIG01031989 FIG01031990: hypothetical protein +FIG01031990 FIG01031992: hypothetical protein +FIG01031993 FIG01031994: hypothetical protein +FIG01031994 FIG01031995: hypothetical protein +FIG01031995 FIG01031996: hypothetical protein +FIG01031996 FIG01031999: hypothetical protein +FIG01032000 FIG01032003: hypothetical protein +FIG01032003 FIG01032004: hypothetical protein +FIG01032005 FIG01032007: hypothetical protein +FIG01032007 Uracil-DNA glycosylase (EC 3.2.2.-) +FIG01032012 FIG01032013: hypothetical protein +FIG01032017 FIG01032018: hypothetical protein +FIG01032021 FIG01032022: hypothetical protein +FIG01032023 FIG01032024: hypothetical protein +FIG01032024 FIG01032025: hypothetical protein +FIG01032026 FIG01032027: hypothetical protein +FIG01032027 FIG01032028: hypothetical protein +FIG01032031 FIG01032032: hypothetical protein +FIG01032033 COG1399 protein, clustered with ribosomal protein L32p +FIG01032042 FIG01032043: hypothetical protein +FIG01032049 FIG01032050: hypothetical protein +FIG01032050 FIG01032054: hypothetical protein +FIG01032059 FIG01032060: hypothetical protein +FIG01032060 FIG01032062: hypothetical protein +FIG01032062 FIG00524870: hypothetical protein +FIG01032064 FIG01032066: hypothetical protein +FIG01032067 FIG01032068: hypothetical protein +FIG01032068 FIG01032070: hypothetical protein +FIG01032070 FIG01032071: hypothetical protein +FIG01032071 FIG01032072: hypothetical protein +FIG01032072 FIG01032073: hypothetical protein +FIG01032076 FIG01032077: hypothetical protein +FIG01032079 FIG01032080: hypothetical protein +FIG01032080 FIG01032082: hypothetical protein +FIG01032085 FIG01032086: hypothetical protein +FIG01032086 membrane protein, Rhomboid family +FIG01032089 FIG01032090: hypothetical protein +FIG01032090 FIG01032092: hypothetical protein +FIG01032094 Re face-specific citrate synthase (EC 2.3.3.3) +FIG01032097 FIG01032098: hypothetical protein +FIG01032098 FIG00526737: hypothetical protein +FIG01032099 FIG01032101: hypothetical protein +FIG01032104 FIG01032106: hypothetical protein +FIG01032110 FIG01032111: hypothetical protein +FIG01032111 FIG01032112: hypothetical protein +FIG01032116 FIG01032117: hypothetical protein +FIG01032117 FIG00528381: hypothetical protein +FIG01032118 FIG01032119: hypothetical protein +FIG01032119 FIG01032121: hypothetical protein +FIG01032124 FIG01032125: hypothetical protein +FIG01032126 FIG01032127: hypothetical protein +FIG01032127 FIG01032128: hypothetical protein +FIG01032132 FIG01032133: hypothetical protein +FIG01032133 FIG01032134: hypothetical protein +FIG01032135 FIG01032137: hypothetical protein +FIG01032137 FIG01032138: hypothetical protein +FIG01032138 FIG01032139: hypothetical protein +FIG01032141 FIG01032142: hypothetical protein +FIG01032147 FIG01032149: hypothetical protein +FIG01032155 FIG01032160: hypothetical protein +FIG01032160 FIG01032163: hypothetical protein +FIG01032163 FIG01032165: hypothetical protein +FIG01032165 FIG01032166: hypothetical protein +FIG01032166 FIG01032167: hypothetical protein +FIG01032174 FIG01032175: hypothetical protein +FIG01032175 FIG01032176: hypothetical protein +FIG01032177 FIG01032180: hypothetical protein +FIG01032180 FIG01032181: hypothetical protein +FIG01032183 FIG01032185: hypothetical protein +FIG01032185 FIG01032189: hypothetical protein +FIG01032192 FIG01032193: hypothetical protein +FIG01032198 FIG01032199: hypothetical protein +FIG01032199 FIG01032200: hypothetical protein +FIG01032202 FIG01032203: hypothetical protein +FIG01032207 FIG01032208: hypothetical protein +FIG01032208 FIG01032209: hypothetical protein +FIG01032209 FIG01032216: hypothetical protein +FIG01032216 FIG01032218: hypothetical protein +FIG01032218 FIG01032219: hypothetical protein +FIG01032221 FIG01032222: hypothetical protein +FIG01032224 FIG01032226: hypothetical protein +FIG01032226 FIG01032229: hypothetical protein +FIG01032230 FIG01032231: hypothetical protein +FIG01032231 FIG01032232: hypothetical protein +FIG01032233 FIG01032234: hypothetical protein +FIG01032235 FIG01032236: hypothetical protein +FIG01032236 FIG01032237: hypothetical protein +FIG01032245 FIG01032248: hypothetical protein +FIG01032248 FIG01032250: hypothetical protein +FIG01032252 FIG01032253: hypothetical protein +FIG01032255 FIG00517731: hypothetical protein +FIG01032258 FIG01032259: hypothetical protein +FIG01032259 FIG01032261: hypothetical protein +FIG01032262 FIG01032263: hypothetical protein +FIG01032265 FIG01032266: hypothetical protein +FIG01032266 FIG01032267: hypothetical protein +FIG01032272 FIG01032275: hypothetical protein +FIG01032277 FIG01032278: hypothetical protein +FIG01032278 FIG01032279: hypothetical protein +FIG01032282 FIG01032283: hypothetical protein +FIG01032286 FIG01032287: hypothetical protein +FIG01032287 FIG01032451: hypothetical protein +FIG01032289 FIG01032290: hypothetical protein +FIG01032291 FIG00515997: hypothetical protein +FIG01032293 FIG01032294: hypothetical protein +FIG01032294 FIG01032295: hypothetical protein +FIG01032296 FIG01032297: hypothetical protein +FIG01032298 FIG01032299: hypothetical protein +FIG01032299 FIG00518941: hypothetical protein +FIG01032304 FIG01032306: hypothetical protein +FIG01032309 FIG01032310: hypothetical protein +FIG01032311 FIG01032313: hypothetical protein +FIG01032313 FIG01032314: hypothetical protein +FIG01032314 FIG01032315: hypothetical protein +FIG01032319 FIG01032320: hypothetical protein +FIG01032321 FIG01032323: hypothetical protein +FIG01032323 FIG01032324: hypothetical protein +FIG01032327 FIG01032328: hypothetical protein +FIG01032329 FIG01032330: hypothetical protein +FIG01032332 FIG01032333: hypothetical protein +FIG01032333 FIG01032334: hypothetical protein +FIG01032334 Archaeal/vacuolar-type H+-ATPase subunit H +FIG01032336 FIG01032346: hypothetical protein +FIG01032337 FIG01032338: hypothetical protein +FIG01032340 FIG01032341: hypothetical protein +FIG01032342 FIG01032343: hypothetical protein +FIG01032346 FIG01032347: hypothetical protein +FIG01032347 FIG01032348: hypothetical protein +FIG01032358 FIG01032359: hypothetical protein +FIG01032360 FIG01032361: hypothetical protein +FIG01032369 FIG01032371: hypothetical protein +FIG01032371 FIG01032373: hypothetical protein +FIG01032374 FIG01032375: hypothetical protein +FIG01032385 FIG01032386: hypothetical protein +FIG01032387 FIG01032388: hypothetical protein +FIG01032396 FIG01032397: hypothetical protein +FIG01032398 FIG01032401: hypothetical protein +FIG01032405 FIG01032406: hypothetical protein +FIG01032407 FIG01032409: hypothetical protein +FIG01032410 small acid-soluble spore protein beta +FIG01032411 FIG01032415: hypothetical protein +FIG01032415 FIG01032418: hypothetical protein +FIG01032419 FIG01032420: hypothetical protein +FIG01032424 FIG01032425: hypothetical protein +FIG01032427 FIG01032430: hypothetical protein +FIG01032431 FIG01032432: hypothetical protein +FIG01032433 FIG01032434: hypothetical protein +FIG01032436 FIG01032438: hypothetical protein +FIG01032444 prophage pi2 protein 38 +FIG01032457 FIG01032458: hypothetical protein +FIG01032460 FIG01032461: hypothetical protein +FIG01032461 FIG01032463: hypothetical protein +FIG01032463 FIG01032465: hypothetical protein +FIG01032465 FIG01032466: hypothetical protein +FIG01032467 FIG01032468: hypothetical protein +FIG01032469 FIG01032470: hypothetical protein +FIG01032474 probable tRNA methyltransferase( EC:2.1.1.33 ) +FIG01032479 Lmo1113 protein +FIG01032485 FIG01032486: hypothetical protein +FIG01032487 FIG01032492: hypothetical protein +FIG01032492 SAM-dependent methyltransferase (EC 2.1.-.-) +FIG01032494 FIG00617256: hypothetical protein +FIG01032495 FIG01032496: hypothetical protein +FIG01032496 FIG01032497: hypothetical protein +FIG01032497 FIG00431384: hypothetical protein +FIG01032501 FIG00515792: hypothetical protein +FIG01032504 FIG01032505: hypothetical protein +FIG01032506 FIG01032508: hypothetical protein +FIG01032515 FIG01032517: hypothetical protein +FIG01032518 FIG01032519: hypothetical protein +FIG01032526 FIG01032527: hypothetical protein +FIG01032528 FIG00263398: hypothetical protein +FIG01032538 FIG01032539: hypothetical protein +FIG01032539 FIG01032540: hypothetical protein +FIG01032540 FIG01032543: hypothetical protein +FIG01032543 FIG01032544: hypothetical protein +FIG01032545 FIG01032546: hypothetical protein +FIG01032546 FIG01032547: hypothetical protein +FIG01032550 FIG01032551: hypothetical protein +FIG01032551 FIG01032553: hypothetical protein +FIG01032556 FIG01032557: hypothetical protein +FIG01032557 FIG01032560: hypothetical protein +FIG01032561 FIG01032562: hypothetical protein +FIG01032562 FIG01032563: hypothetical protein +FIG01032566 FIG01032567: hypothetical protein +FIG01032567 FIG01032569: hypothetical protein +FIG01032571 FIG01032572: hypothetical protein +FIG01032580 FIG01032582: hypothetical protein +FIG01032584 FIG01032585: hypothetical protein +FIG01032587 FIG01032589: hypothetical protein +FIG01032589 FIG01032590: hypothetical protein +FIG01032595 FIG01032596: hypothetical protein +FIG01032596 FIG00631409: hypothetical protein +FIG01032599 FIG01032600: hypothetical protein +FIG01032600 FIG01032601: hypothetical protein +FIG01032603 FIG01032605: hypothetical protein +FIG01032605 FIG01032608: hypothetical protein +FIG01032609 FIG01032482: hypothetical protein +FIG01032610 FIG01032611: hypothetical protein +FIG01032611 FIG01032613: hypothetical protein +FIG01032613 FIG01032614: hypothetical protein +FIG01032615 FIG01032617: hypothetical protein +FIG01032618 FIG01032619: hypothetical protein +FIG01032620 FIG01032621: hypothetical protein +FIG01032621 FIG01032623: hypothetical protein +FIG01032626 Protein of unknown function DUF344 +FIG01032631 FIG01032633: hypothetical protein +FIG01032637 FIG01032639: hypothetical protein +FIG01032639 FIG01032640: hypothetical protein +FIG01032640 FIG01032641: hypothetical protein +FIG01032643 FIG01032644: hypothetical protein +FIG01032648 FIG00514717: hypothetical protein +FIG01032653 FIG01032654: hypothetical protein +FIG01032654 FIG01032655: hypothetical protein +FIG01032658 FIG01032659: hypothetical protein +FIG01032660 putative arginase +FIG01032661 FIG01032662: hypothetical protein +FIG01032662 FIG01032666: hypothetical protein +FIG01032668 conserved hypothetical protein, conserved +FIG01032682 Lactose-binding protein precursor (LBP) +FIG01032684 FIG01032687: hypothetical protein +FIG01032687 FIG01032688: hypothetical protein +FIG01032688 FIG01032689: hypothetical protein +FIG01032689 FIG01032690: hypothetical protein +FIG01032690 FIG01032691: hypothetical protein +FIG01032692 FIG01032694: hypothetical protein +FIG01032695 FIG01032696: hypothetical protein +FIG01032699 FIG01032700: hypothetical protein +FIG01032701 FIG01032702: hypothetical protein +FIG01032704 FIG01032705: hypothetical protein +FIG01032705 FIG01032706: hypothetical protein +FIG01032707 probable S-adenosylmethionine-dependent methyltransferase( EC:2.1.1.- ) +FIG01032709 FIG01032710: hypothetical protein +FIG01032710 FIG01032712: hypothetical protein +FIG01032713 FIG01032714: hypothetical protein +FIG01032716 FIG01032717: hypothetical protein +FIG01032731 probable Xaa-Pro dipeptidase( EC:3.4.13.9 ) +FIG01032975 FIG01032994: hypothetical protein +FIG01033290 possible DGPF protein +FIG01033357 FIG01033380: hypothetical protein +FIG01033400 argininosuccinate lyase domain protein +FIG01033468 FIG01033472: hypothetical protein +FIG01033472 FIG01033489: hypothetical protein +FIG01033494 FIG01033523: hypothetical protein +FIG01033523 FIG01033533: hypothetical protein +FIG01033559 Na+ efflux ABC transporter permease +FIG01033754 protein of unknown function DUF1707 +FIG01033798 FIG01033834: hypothetical protein +FIG01033910 Barbiturase (EC 3.5.2.1) +FIG01033914 possible carboxymethylenebutenolidase +FIG01033979 ferric uptake regulator, FUR family +FIG01034051 putative DnaK family protein +FIG01034060 Copper resistance protein CopD +FIG01034081 FIG01034095: hypothetical protein +FIG01034212 3-oxoacyl-[acyl-carrier-protein] synthase / Chain length factor( EC:2.3.1.41 ) +FIG01034275 Amino acid permease-associated protein +FIG01034447 FIG01034453: hypothetical protein +FIG01034478 Glycine betaine ABC transport system, permease/glycine betaine-binding protein OpuABC +FIG01034651 FIG01034654: hypothetical protein +FIG01034697 FIG01037054: hypothetical protein +FIG01034815 Uncharacterized protein SCO4090 +FIG01035097 FIG01035101: hypothetical protein +FIG01035107 FIG01035111: hypothetical protein +FIG01035162 FIG01035167: hypothetical protein +FIG01035167 FIG01035171: hypothetical protein +FIG01035179 Signal transduction histidine kinase-like +FIG01035251 Cellulose binding, type IV +FIG01035384 FIG01035385: hypothetical protein +FIG01035432 FIG01035441: hypothetical protein +FIG01035546 FIG01035547: hypothetical protein +FIG01035893 FIG01035894: hypothetical protein +FIG01035915 2nd GPH family transporter in unknown oligosaccharide utilization Sde 1396 +FIG01035956 FIG01035957: hypothetical protein +FIG01036007 FIG01036008: hypothetical protein +FIG01036073 FIG01036079: hypothetical protein +FIG01036085 FIG01036089: hypothetical protein +FIG01036120 endonuclease containing a URI domain-like +FIG01036148 FIG01036154: hypothetical protein +FIG01036213 SirA protein homolog +FIG01036228 Lipopolysaccharide core biosynthesis mannosyltransferase +FIG01036250 Endoglucanase Y (EC 3.2.1.4) +FIG01036417 FIG01036423: hypothetical protein +FIG01036458 FIG01036464: hypothetical protein +FIG01036494 FIG01036498: hypothetical protein +FIG01036613 FIG01036625: hypothetical protein +FIG01036708 FIG01036710: hypothetical protein +FIG01036781 predicted signal transduction protein +FIG01036784 Protein affecting phage T7 exclusion by the F plasmid +FIG01036787 FIG01036791: hypothetical protein +FIG01036855 FIG01036858: hypothetical protein +FIG01036925 FIG01036928: hypothetical protein +FIG01036965 putative LysR-family transcriptional regulator +FIG01037074 Probable arabinan endo-1,5-alpha-L-arabinosidase (EC 3.2.1.99) +FIG01037124 CTP pyrophosphohydrolase( EC:3.6.1.- ) +FIG01037147 FIG01037150: hypothetical protein +FIG01037203 molecular chaperone protein +FIG01037279 possible transcriptional regulator, GntR family +FIG01037325 FIG01037326: hypothetical protein +FIG01037354 FIG01037363: hypothetical protein +FIG01037497 Zinc D-Ala-D-Ala carboxypeptidase (EC 3.4.17.14) +FIG01037658 FIG01037659: hypothetical protein +FIG01037700 Diacylglycerol kinase-related protein +FIG01037736 FIG01037741: hypothetical protein +FIG01037807 GAF:ATP-binding region, ATPase-like +FIG01037867 Probable MFS-transporter +FIG01037871 possible hydrolase +FIG01037873 POSSIBLE CONSERVED INTEGRAL MEMBRANE PROTEIN +FIG01037945 Probable sulfopyruvate decarboxylase alpha subunit (EC 4.1.1.79) +FIG01037963 FIG01037968: hypothetical protein +FIG01038007 probable RNA helicase +FIG01038013 CDA peptide synthetase III +FIG01038046 FIG01038048: hypothetical protein +FIG01038084 FIG01038085: hypothetical protein +FIG01038090 FIG01038091: hypothetical protein +FIG01038114 FIG01038119: hypothetical protein +FIG01038119 Two-component system sensor kinase +FIG01038137 Possible dicarboxylate carrier protein +FIG01038156 FIG01038157: hypothetical protein +FIG01038167 FIG01038168: hypothetical protein +FIG01038173 Sugar transporter, MFS superfamily protein +FIG01038178 Response regulator, two-component system +FIG01038209 Glucose/sorbosone dehydrogenase, lipoprotein LppZ +FIG01038252 FIG01038256: hypothetical protein +FIG01038262 Lanthionine biosynthesis protein LanL +FIG01038287 AmfC protein +FIG01038334 FIG01038337: hypothetical protein +FIG01038337 Probable transcriptional regulator protein, ROK family (EC 2.7.1.2) +FIG01038373 FIG01038376: hypothetical protein +FIG01038382 Probable arabinosyltransferase C +FIG01038430 FIG01038438: hypothetical protein +FIG01038511 FIG01038516: hypothetical protein +FIG01038523 FIG01121566: hypothetical protein +FIG01038564 Epoxide hydrolase-related protein +FIG01038600 predicted acyl-CoA transferase/carnitine dehydratase +FIG01038613 FIG01038615: hypothetical protein +FIG01038624 FIG01038628: hypothetical protein +FIG01038630 FIG01038631: hypothetical protein +FIG01038662 conserved membrane protein ML1526 +FIG01038676 FIG01038679: hypothetical protein +FIG01038704 Chromosome partitioning protein +FIG01038779 Probable beta lactamase (EC 3.5.2.6) +FIG01038820 FIG01038821: hypothetical protein +FIG01038849 FIG01038850: hypothetical protein +FIG01038870 COG0601: ABC-type dipeptide/oligopeptide/nickel transport systems, permease components +FIG01038887 Putative conserved integral membrane protein +FIG01038971 FIG01038974: hypothetical protein +FIG01038990 hypothetical protein SC2G5.12c +FIG01039038 possible flavin binding monooxygenase +FIG01039104 UPF0098 protein MTH_273 +FIG01039149 FIG01039150: hypothetical protein +FIG01039256 CG33251-PA +FIG01039270 FIG01039273: hypothetical protein +FIG01039273 FIG01039275: hypothetical protein +FIG01039347 FIG01039348: hypothetical protein +FIG01039405 Lipoprotein LpqE +FIG01039452 conserved lipoprotein LppL +FIG01039484 FIG01039486: hypothetical protein +FIG01039510 FIG01039512: hypothetical protein +FIG01039540 two-component regulator +FIG01039570 FIG01039571: hypothetical protein +FIG01039586 Arylmalonate decarboxylase or maleate isomerase (EC 5.2.1.1) +FIG01039592 FIG01039593: hypothetical protein +FIG01039605 FIG01039606: hypothetical protein +FIG01039636 secreted trypsin-like serine protease +FIG01039661 Purine catabolism PurC domain protein +FIG01039678 FIG01039679: hypothetical protein +FIG01039680 FIG01039681: hypothetical protein +FIG01039738 UPF0256 protein SAV5428 +FIG01039766 FIG01039768: hypothetical protein +FIG01039820 MbtH-like short polypeptide +FIG01039931 Carnitine O-palmitoyltransferase II, mitochondrial precursor (EC 2.3.1.21) +FIG01039945 putative sugar transport system permease protein +FIG01040082 bll2198; hypothetical protein +FIG01040091 Probable epoxide hydrolase +FIG01040111 FIG01040112: hypothetical protein +FIG01040131 arpA protein - Streptomyces griseus +FIG01040141 FIG01040142: hypothetical protein +FIG01040152 FIG01040154: hypothetical protein +FIG01040154 possible glycoprotein +FIG01040157 15,15' beta carotene dioxygenase +FIG01040164 FIG01040165: hypothetical protein +FIG01040170 puitative transferase +FIG01040214 FIG01040215: hypothetical protein +FIG01040223 Putative sensor-like histidine kinase +FIG01040333 FIG01040334: hypothetical protein +FIG01040350 multidrug transporter, MFS superfamily +FIG01040380 polyketide synthase type I +FIG01040395 FIG01040396: hypothetical protein +FIG01040454 FIG01040456: hypothetical protein +FIG01040503 FIG01040504: hypothetical protein +FIG01040509 Trypsin (EC 3.4.21.4) (SET) +FIG01040543 FIG01040544: hypothetical protein +FIG01040572 Potassium efflux system kefA / Small-conductance mechanosensitive channel +FIG01040599 FIG01040602: hypothetical protein +FIG01040602 FIG01040604: hypothetical protein +FIG01040606 FIG01040610: hypothetical protein +FIG01040610 FIG01040611: hypothetical protein +FIG01040612 FIG01040613: hypothetical protein +FIG01040613 FIG01040617: hypothetical protein +FIG01040617 probable transmembrane sensor histidine kinase transcription regulator protein +FIG01040620 FIG01040622: hypothetical protein +FIG01040623 FIG01040625: hypothetical protein +FIG01040625 FIG01040626: hypothetical protein +FIG01040628 FIG01040629: hypothetical protein +FIG01040629 FIG01040630: hypothetical protein +FIG01040630 FIG01040631: hypothetical protein +FIG01040631 FIG01040632: hypothetical protein +FIG01040632 FIG01040633: hypothetical protein +FIG01040633 FIG01040635: hypothetical protein +FIG01040635 FIG01040636: hypothetical protein +FIG01040636 FIG01040638: hypothetical protein +FIG01040638 FIG01040639: hypothetical protein +FIG01040639 secreted protein containing N-terminal Zinc-dependent carboxypeptidase related domain, putative +FIG01040640 FIG01040642: hypothetical protein +FIG01040642 FIG01040643: hypothetical protein +FIG01040643 FIG01040645: hypothetical protein +FIG01040646 FIG01040649: hypothetical protein +FIG01040649 FIG01040652: hypothetical protein +FIG01040652 FIG01040653: hypothetical protein +FIG01040653 FIG01040654: hypothetical protein +FIG01040654 FIG01040655: hypothetical protein +FIG01040655 FIG01040659: hypothetical protein +FIG01040660 FIG01040661: hypothetical protein +FIG01040663 FIG01040665: hypothetical protein +FIG01040665 FIG01040666: hypothetical protein +FIG01040668 FIG01040669: hypothetical protein +FIG01040669 FIG01040672: hypothetical protein +FIG01040672 FIG01040676: hypothetical protein +FIG01040676 FIG01040677: hypothetical protein +FIG01040677 FIG01040679: hypothetical protein +FIG01040684 FIG01040686: hypothetical protein +FIG01040686 FIG01040687: hypothetical protein +FIG01040689 FIG01040690: hypothetical protein +FIG01040690 FIG01040691: hypothetical protein +FIG01040691 FIG01040692: hypothetical protein +FIG01040692 FIG01040693: hypothetical protein +FIG01040693 nucleotidyl transferase, putative +FIG01040694 FIG01040696: hypothetical protein +FIG01040696 FIG01040697: hypothetical protein +FIG01040697 FIG01040699: hypothetical protein +FIG01040699 FIG01040702: hypothetical protein +FIG01040702 FIG01040704: hypothetical protein +FIG01040704 FIG01040705: hypothetical protein +FIG01040705 FIG01040709: hypothetical protein +FIG01040709 FIG01040710: hypothetical protein +FIG01040710 FIG01040711: hypothetical protein +FIG01040711 FIG01040712: hypothetical protein +FIG01040712 FIG01040713: hypothetical protein +FIG01040713 FIG01040714: hypothetical protein +FIG01040714 FIG01040715: hypothetical protein +FIG01040715 FIG01040716: hypothetical protein +FIG01040716 Putative rRNA methylase superfamily +FIG01040720 FIG01040721: hypothetical protein +FIG01040721 FIG01040723: hypothetical protein +FIG01040725 FIG01040730: hypothetical protein +FIG01040730 FIG01040732: hypothetical protein +FIG01040732 FIG01040733: hypothetical protein +FIG01040733 FIG01040734: hypothetical protein +FIG01040734 FIG01040735: hypothetical protein +FIG01040735 FIG01040737: hypothetical protein +FIG01040737 FIG01040738: hypothetical protein +FIG01040738 FIG01040740: hypothetical protein +FIG01040740 FIG01040744: hypothetical protein +FIG01040744 PIN domain protein, putative +FIG01040746 FIG01040747: hypothetical protein +FIG01040747 FIG01040753: hypothetical protein +FIG01040754 FIG01040759: hypothetical protein +FIG01040759 FIG01040761: hypothetical protein +FIG01040761 FIG01040763: hypothetical protein +FIG01040763 FIG01040764: hypothetical protein +FIG01040764 hdig domain protein, putative +FIG01040765 FIG01040767: hypothetical protein +FIG01040767 FIG01040769: hypothetical protein +FIG01040769 FIG01040773: hypothetical protein +FIG01040773 FIG01040774: hypothetical protein +FIG01040774 FIG01040775: hypothetical protein +FIG01040775 FIG01040776: hypothetical protein +FIG01040777 FIG01040778: hypothetical protein +FIG01040778 FIG01040780: hypothetical protein +FIG01040780 FIG01040781: hypothetical protein +FIG01040781 FIG01040782: hypothetical protein +FIG01040782 FIG01040784: hypothetical protein +FIG01040784 FIG01040785: hypothetical protein +FIG01040787 FIG01040788: hypothetical protein +FIG01040788 FIG01040789: hypothetical protein +FIG01040791 FIG01040792: hypothetical protein +FIG01040794 FIG01040795: hypothetical protein +FIG01040795 FIG01040796: hypothetical protein +FIG01040801 FIG01040804: hypothetical protein +FIG01040804 FIG01040805: hypothetical protein +FIG01040805 FIG01040808: hypothetical protein +FIG01040812 FIG01040815: hypothetical protein +FIG01040818 FIG01040821: hypothetical protein +FIG01040821 FIG01040822: hypothetical protein +FIG01040822 FIG01040823: hypothetical protein +FIG01040824 FIG01040826: hypothetical protein +FIG01040826 probable phosphatidylethanolamine N-methyltransferase( EC:2.1.1.17 ) +FIG01040830 FIG01040832: hypothetical protein +FIG01040832 FIG01040833: hypothetical protein +FIG01040833 FIG01040835: hypothetical protein +FIG01040835 FIG01040836: hypothetical protein +FIG01040836 FIG01040837: hypothetical protein +FIG01040837 FIG01040838: hypothetical protein +FIG01040838 FG-GAP repeat domain protein +FIG01040839 FIG01040841: hypothetical protein +FIG01040841 FIG01040844: hypothetical protein +FIG01040844 FIG01040848: hypothetical protein +FIG01040848 FIG01040850: hypothetical protein +FIG01040850 FIG01040851: hypothetical protein +FIG01040852 FIG01040853: hypothetical protein +FIG01040855 FIG01040857: hypothetical protein +FIG01040857 FIG01040858: hypothetical protein +FIG01040858 FIG01040860: hypothetical protein +FIG01040860 FIG01040862: hypothetical protein +FIG01040862 FIG01040863: hypothetical protein +FIG01040863 FIG01040866: hypothetical protein +FIG01040866 FIG01040867: hypothetical protein +FIG01040867 FIG01040871: hypothetical protein +FIG01040871 FIG01040872: hypothetical protein +FIG01040872 FIG01040873: hypothetical protein +FIG01040873 FIG01040874: hypothetical protein +FIG01040874 FIG01040875: hypothetical protein +FIG01040876 saccharopine dehydrogenase( EC:1.5.1.7 ) +FIG01040882 FIG01040884: hypothetical protein +FIG01040884 FIG01040885: hypothetical protein +FIG01040885 FIG01040886: hypothetical protein +FIG01040886 FIG01040887: hypothetical protein +FIG01040887 FIG01040890: hypothetical protein +FIG01040890 FIG01040891: hypothetical protein +FIG01040891 FIG01040894: hypothetical protein +FIG01040894 FIG01040898: hypothetical protein +FIG01040898 FIG01040899: hypothetical protein +FIG01040899 FIG01040901: hypothetical protein +FIG01040901 RND efflux membrane fusion protein +FIG01040906 HD domain protein, putative +FIG01040908 FIG01040909: hypothetical protein +FIG01040909 FIG01040910: hypothetical protein +FIG01040914 FIG01040915: hypothetical protein +FIG01040915 FIG01040918: hypothetical protein +FIG01040918 uncharacterized peroxidase-related enzyme subfamily +FIG01040919 FIG01040921: hypothetical protein +FIG01040921 FIG01040922: hypothetical protein +FIG01040922 putative thiosulfate sulfurtransferase, putative +FIG01040925 FIG01040927: hypothetical protein +FIG01040927 FIG01040928: hypothetical protein +FIG01040928 FIG01040931: hypothetical protein +FIG01040931 FIG01040935: hypothetical protein +FIG01040935 FIG01040936: hypothetical protein +FIG01040936 FIG01040938: hypothetical protein +FIG01040938 Beta-Ig-H3/Fasciclin +FIG01040939 FIG01040940: hypothetical protein +FIG01040940 FIG01040941: hypothetical protein +FIG01040942 FIG01040947: hypothetical protein +FIG01040951 FIG01040952: hypothetical protein +FIG01040952 FIG01040954: hypothetical protein +FIG01040954 FIG01040956: hypothetical protein +FIG01040956 FIG01040958: hypothetical protein +FIG01040958 2-phosphosulfolactate phosphatase( EC:3.1.3.71 ) +FIG01040959 FIG01040961: hypothetical protein +FIG01040961 FIG01040963: hypothetical protein +FIG01040963 FIG01040965: hypothetical protein +FIG01040965 FIG01040966: hypothetical protein +FIG01040968 putative 22-domain light- and oxygen-sensing histidine kinase +FIG01040974 FIG01040975: hypothetical protein +FIG01040975 FIG01040980: hypothetical protein +FIG01040980 FIG01040981: hypothetical protein +FIG01040984 X-Pro dipeptidyl-peptidase( EC:3.4.14.11 ) +FIG01040986 FIG01040987: hypothetical protein +FIG01040987 carboxyl-terminal protease( EC:3.4.21.- ) +FIG01040994 FIG01040995: hypothetical protein +FIG01040995 FIG01040998: hypothetical protein +FIG01040998 rrf2 family protein (putative transcriptional regulator) +FIG01040999 FIG01041000: hypothetical protein +FIG01041000 FIG01041003: hypothetical protein +FIG01041003 FIG01041007: hypothetical protein +FIG01041007 Sensory rhodopsin transducer (methyl-accepting chemotaxis protein) +FIG01041008 FIG01041009: hypothetical protein +FIG01041009 FIG01041010: hypothetical protein +FIG01041010 Na(+) H(+) antiporter subunit B +FIG01041011 FIG01041013: hypothetical protein +FIG01041014 FIG01041015: hypothetical protein +FIG01041015 FIG01041016: hypothetical protein +FIG01041016 FIG01041019: hypothetical protein +FIG01041019 FIG01041023: hypothetical protein +FIG01041023 FIG01041024: hypothetical protein +FIG01041025 universal stress protein, putative +FIG01041026 transporter, small conductance mechanosensitive ion channel (MscS) family +FIG01041027 FIG01041028: hypothetical protein +FIG01041028 FIG01041029: hypothetical protein +FIG01041029 FIG01041030: hypothetical protein +FIG01041030 Outer membrane protein Omp121 +FIG01041035 FIG01041037: hypothetical protein +FIG01041038 FIG01041041: hypothetical protein +FIG01041043 FIG01041045: hypothetical protein +FIG01041045 FIG01041046: hypothetical protein +FIG01041046 FIG01041049: hypothetical protein +FIG01041049 FIG01041050: hypothetical protein +FIG01041053 FIG01041055: hypothetical protein +FIG01041055 FIG01041056: hypothetical protein +FIG01041057 deoxycytidine triphosphate deaminase +FIG01041064 FIG01041067: hypothetical protein +FIG01041069 FIG01041071: hypothetical protein +FIG01041071 PKD domain protein +FIG01041072 FIG01041074: hypothetical protein +FIG01041075 FIG01041079: hypothetical protein +FIG01041079 FIG01041080: hypothetical protein +FIG01041083 FIG01041086: hypothetical protein +FIG01041086 FIG01041087: hypothetical protein +FIG01041087 FIG01041088: hypothetical protein +FIG01041091 FIG01041094: hypothetical protein +FIG01041094 FIG01041095: hypothetical protein +FIG01041100 FIG01041101: hypothetical protein +FIG01041101 FIG01041104: hypothetical protein +FIG01041108 FIG01041109: hypothetical protein +FIG01041109 FIG01041111: hypothetical protein +FIG01041114 Protein of unknown function, DUF583 family +FIG01041116 FIG01041117: hypothetical protein +FIG01041117 FIG01041118: hypothetical protein +FIG01041120 FIG01041122: hypothetical protein +FIG01041122 FIG01041123: hypothetical protein +FIG01041124 FIG01041125: hypothetical protein +FIG01041125 FIG01041126: hypothetical protein +FIG01041126 FIG01041128: hypothetical protein +FIG01041128 FIG01041129: hypothetical protein +FIG01041129 FIG01041130: hypothetical protein +FIG01041132 FIG01041133: hypothetical protein +FIG01041138 FIG01041140: hypothetical protein +FIG01041140 FIG01041142: hypothetical protein +FIG01041142 FIG01041143: hypothetical protein +FIG01041143 FIG01041144: hypothetical protein +FIG01041144 FIG01041145: hypothetical protein +FIG01041158 FIG01041159: hypothetical protein +FIG01041159 FIG01041162: hypothetical protein +FIG01041162 FIG01041163: hypothetical protein +FIG01041163 FIG01041164: hypothetical protein +FIG01041164 FIG01041167: hypothetical protein +FIG01041167 FIG01041168: hypothetical protein +FIG01041168 FIG01041169: hypothetical protein +FIG01041169 FIG01041170: hypothetical protein +FIG01041171 FIG01041172: hypothetical protein +FIG01041173 FIG01041174: hypothetical protein +FIG01041174 FIG01041175: hypothetical protein +FIG01041176 FIG01041178: hypothetical protein +FIG01041178 FIG01041179: hypothetical protein +FIG01041182 FIG01041183: hypothetical protein +FIG01041183 predicted SAM-dependent methyltransferase, putative +FIG01041184 FIG01041185: hypothetical protein +FIG01041185 FIG01041186: hypothetical protein +FIG01041186 FIG01041187: hypothetical protein +FIG01041187 FIG01041189: hypothetical protein +FIG01041189 FIG01041190: hypothetical protein +FIG01041190 FIG01041191: hypothetical protein +FIG01041192 FIG01041193: hypothetical protein +FIG01041193 FIG01041194: hypothetical protein +FIG01041194 FIG01041195: hypothetical protein +FIG01041195 FIG01041198: hypothetical protein +FIG01041199 FIG01041200: hypothetical protein +FIG01041200 FIG01041202: hypothetical protein +FIG01041202 FIG01041205: hypothetical protein +FIG01041205 FIG01041206: hypothetical protein +FIG01041206 FIG01041209: hypothetical protein +FIG01041209 dopamine receptor D4 +FIG01041210 FIG01041211: hypothetical protein +FIG01041211 FIG01041212: hypothetical protein +FIG01041213 FIG01041214: hypothetical protein +FIG01041214 FIG01041215: hypothetical protein +FIG01041217 FIG01041218: hypothetical protein +FIG01041218 FIG01041219: hypothetical protein +FIG01041219 FIG01041221: hypothetical protein +FIG01041221 FIG01041222: hypothetical protein +FIG01041222 FIG01041223: hypothetical protein +FIG01041223 FIG01041225: hypothetical protein +FIG01041225 FIG01041226: hypothetical protein +FIG01041226 FIG01041227: hypothetical protein +FIG01041229 FIG01041230: hypothetical protein +FIG01041231 FIG01041232: hypothetical protein +FIG01041232 FIG01041233: hypothetical protein +FIG01041233 phosphoribosyltransferase +FIG01041236 soluble lytic murein transglycosylase precursor +FIG01041237 FIG01041238: hypothetical protein +FIG01041239 FIG01041241: hypothetical protein +FIG01041241 FIG01041242: hypothetical protein +FIG01041242 FIG01041246: hypothetical protein +FIG01041246 FIG01041247: hypothetical protein +FIG01041247 outer membrane protein, OMP85 family, putative +FIG01041249 FIG01041250: hypothetical protein +FIG01041250 FIG01041254: hypothetical protein +FIG01041254 FIG01041255: hypothetical protein +FIG01041255 BNR repeat, putative +FIG01041259 FIG01041260: hypothetical protein +FIG01041260 FIG01041261: hypothetical protein +FIG01041266 FIG01041267: hypothetical protein +FIG01041267 FIG01041272: hypothetical protein +FIG01041272 Protein yccU +FIG01041281 FIG01041284: hypothetical protein +FIG01041284 FIG01041288: hypothetical protein +FIG01041288 FIG01041291: hypothetical protein +FIG01041293 FIG01041294: hypothetical protein +FIG01041294 FIG01041296: hypothetical protein +FIG01041299 FIG01041300: hypothetical protein +FIG01041300 FIG01041301: hypothetical protein +FIG01041301 general (Type II) secretion pathway (GSP) D protein, putative +FIG01041302 FIG01041304: hypothetical protein +FIG01041304 FIG01041305: hypothetical protein +FIG01041305 FIG01041306: hypothetical protein +FIG01041308 FIG01041312: hypothetical protein +FIG01041313 FIG01041314: hypothetical protein +FIG01041314 FIG01041315: hypothetical protein +FIG01041315 FIG01041316: hypothetical protein +FIG01041316 FIG00450539: hypothetical protein +FIG01041317 FIG01041318: hypothetical protein +FIG01041318 putative methionine sulfoxide reductase +FIG01041321 FIG01041323: hypothetical protein +FIG01041324 FIG01041325: hypothetical protein +FIG01041325 FIG01041326: hypothetical protein +FIG01041326 FIG01041328: hypothetical protein +FIG01041328 FIG01041329: hypothetical protein +FIG01041329 FIG01041330: hypothetical protein +FIG01041330 FIG01041331: hypothetical protein +FIG01041333 Penicillin acylase 2 precursor (EC 3.5.1.11) (Penicillin acylase II) (Penicillin amidase II) (Cephalosporin acylase II) [Contains: Penicillin acylase 2 small subunit (Penicillin acylase II small subunit); Penicillin acylase 2 large subunit (Penicillin acylase II large subunit)] +FIG01041335 FIG01041337: hypothetical protein +FIG01041337 FIG01041339: hypothetical protein +FIG01041340 3-phytase precursor (EC 3.1.3.8) +FIG01041341 FIG01041343: hypothetical protein +FIG01041343 FIG01041344: hypothetical protein +FIG01041344 FIG01041345: hypothetical protein +FIG01041345 FIG01041346: hypothetical protein +FIG01041348 FIG01041350: hypothetical protein +FIG01041350 SPFH domain / Band 7 family protein +FIG01041352 FixL-related histidine kinase +FIG01041355 FIG01041357: hypothetical protein +FIG01041357 FIG01041362: hypothetical protein +FIG01041362 FIG01041365: hypothetical protein +FIG01041366 Vng1355h +FIG01041367 methanol dehydrogenase regulator +FIG01041368 FIG01041370: hypothetical protein +FIG01041370 FIG01041371: hypothetical protein +FIG01041371 FIG01041372: hypothetical protein +FIG01041372 FIG01041373: hypothetical protein +FIG01041373 FIG01041376: hypothetical protein +FIG01041379 FIG01041382: hypothetical protein +FIG01041382 FAD dependent oxidoreductase, putative +FIG01041383 FIG01041384: hypothetical protein +FIG01041384 FIG01041386: hypothetical protein +FIG01041386 FIG01041387: hypothetical protein +FIG01041387 FIG01041389: hypothetical protein +FIG01041389 FIG01041391: hypothetical protein +FIG01041391 FIG01041393: hypothetical protein +FIG01041393 FIG01041396: hypothetical protein +FIG01041396 FIG01041397: hypothetical protein +FIG01041397 FIG01041398: hypothetical protein +FIG01041398 FIG01041403: hypothetical protein +FIG01041403 FIG01041404: hypothetical protein +FIG01041404 FIG01041405: hypothetical protein +FIG01041405 FIG01041406: hypothetical protein +FIG01041409 FIG01041410: hypothetical protein +FIG01041411 FIG01041413: hypothetical protein +FIG01041413 FIG01041414: hypothetical protein +FIG01041414 two-component system sensor protein, putative +FIG01041417 FIG01041419: hypothetical protein +FIG01041419 FIG01041420: hypothetical protein +FIG01041420 FIG01041421: hypothetical protein +FIG01041421 FIG01041422: hypothetical protein +FIG01041422 FIG01041423: hypothetical protein +FIG01041423 FIG01041429: hypothetical protein +FIG01041429 ABC-type Fe3+-siderophores transport systems +FIG01041431 FIG01041432: hypothetical protein +FIG01041432 adaptive-response sensory-kinase +FIG01041433 FIG01041435: hypothetical protein +FIG01041437 DoxX subfamily, putative +FIG01041438 FIG01041441: hypothetical protein +FIG01041446 FIG01041447: hypothetical protein +FIG01041447 FIG01041448: hypothetical protein +FIG01041448 FIG01041449: hypothetical protein +FIG01041449 FIG01041450: hypothetical protein +FIG01041455 FIG01041457: hypothetical protein +FIG01041457 FIG01041460: hypothetical protein +FIG01041460 FIG01041461: hypothetical protein +FIG01041461 FIG01041463: hypothetical protein +FIG01041463 FIG01041467: hypothetical protein +FIG01041467 FIG01041472: hypothetical protein +FIG01041472 FIG01041473: hypothetical protein +FIG01041474 FIG01041475: hypothetical protein +FIG01041475 FIG01041476: hypothetical protein +FIG01041477 probable sensor/response hybrid, putative +FIG01041479 FIG01041481: hypothetical protein +FIG01041481 FIG01041482: hypothetical protein +FIG01041482 rhamnosyl transferase +FIG01041483 FIG01041484: hypothetical protein +FIG01041484 FIG01041485: hypothetical protein +FIG01041485 FIG01041488: hypothetical protein +FIG01041491 FIG01041494: hypothetical protein +FIG01041494 GlcNAc-PI de-N-acetylase family +FIG01041495 FIG01041497: hypothetical protein +FIG01041497 FIG01041498: hypothetical protein +FIG01041498 FIG01041500: hypothetical protein +FIG01041500 FIG01041501: hypothetical protein +FIG01041501 FIG01041504: hypothetical protein +FIG01041504 Mta/Sah nucleosidase (P46) [includes: 5'-methylthioadenosine nucleosidase and S-adenosylhomocysteine nucleosidase], putative +FIG01041506 acetyltransferase, gnat family, putative +FIG01041509 FIG01041512: hypothetical protein +FIG01041512 FIG01041517: hypothetical protein +FIG01041517 FIG01041518: hypothetical protein +FIG01041520 FIG01041521: hypothetical protein +FIG01041521 FIG01041523: hypothetical protein +FIG01041523 FIG01041524: hypothetical protein +FIG01041524 FIG01041527: hypothetical protein +FIG01041528 FIG01041529: hypothetical protein +FIG01041530 FIG01041531: hypothetical protein +FIG01041532 FIG01041533: hypothetical protein +FIG01041533 FIG01041538: hypothetical protein +FIG01041542 FIG01041543: hypothetical protein +FIG01041543 FIG01041545: hypothetical protein +FIG01041550 phosphoglycolate phosphatase( EC:3.1.3.18 ) +FIG01041552 FIG01041554: hypothetical protein +FIG01041555 FIG01041557: hypothetical protein +FIG01041559 pyridoxal-dependent decarboxylase family protein, putative( EC:4.1.1.- ) +FIG01041560 FIG01041564: hypothetical protein +FIG01041564 two-component system sensor histidine kinase/response regulator, hybrid, putative +FIG01041565 FIG01041566: hypothetical protein +FIG01041566 FIG01041567: hypothetical protein +FIG01041567 FIG01041569: hypothetical protein +FIG01041569 FIG01041570: hypothetical protein +FIG01041570 FIG01041571: hypothetical protein +FIG01041571 FIG01041575: hypothetical protein +FIG01041576 acriflavin resistance protein AcrE, putative +FIG01041577 FIG01041578: hypothetical protein +FIG01041579 Phosphate-selective porin O and P superfamily +FIG01041580 FIG01041581: hypothetical protein +FIG01041581 FIG01041582: hypothetical protein +FIG01041582 FIG01041583: hypothetical protein +FIG01041583 FIG01041586: hypothetical protein +FIG01041586 FIG01041591: hypothetical protein +FIG01041591 SoxW precursor, putative +FIG01041592 FIG01041593: hypothetical protein +FIG01041594 FIG01041595: hypothetical protein +FIG01041596 FIG01041597: hypothetical protein +FIG01041597 phosphodiesterase/alkaline phosphatase D-like protein +FIG01041599 FIG01041601: hypothetical protein +FIG01041601 FIG01041602: hypothetical protein +FIG01041605 FIG01041607: hypothetical protein +FIG01041607 Phage integrase, N-terminal SAM-like domain protein +FIG01041609 FIG01041610: hypothetical protein +FIG01041611 FIG01041614: hypothetical protein +FIG01041621 FIG01041623: hypothetical protein +FIG01041627 FIG01041628: hypothetical protein +FIG01041629 FIG01041630: hypothetical protein +FIG01041630 membrane protein containing DUF421 +FIG01041635 FIG01041636: hypothetical protein +FIG01041636 FIG01041637: hypothetical protein +FIG01041638 FIG01041640: hypothetical protein +FIG01041641 FIG01041642: hypothetical protein +FIG01041642 FIG01041643: hypothetical protein +FIG01041644 FIG01041645: hypothetical protein +FIG01041645 FIG01041649: hypothetical protein +FIG01041649 FIG01041650: hypothetical protein +FIG01041650 FIG01041651: hypothetical protein +FIG01041651 FIG01041656: hypothetical protein +FIG01041656 FIG01041658: hypothetical protein +FIG01041658 FIG01041659: hypothetical protein +FIG01041659 FIG01041660: hypothetical protein +FIG01041660 FIG01041661: hypothetical protein +FIG01041661 FIG01041662: hypothetical protein +FIG01041664 FIG01041665: hypothetical protein +FIG01041665 protein of unknown function DUF833 +FIG01041668 FIG01041670: hypothetical protein +FIG01041671 FIG01041672: hypothetical protein +FIG01041675 FIG01041676: hypothetical protein +FIG01041679 FIG01041680: hypothetical protein +FIG01041680 FIG01041681: hypothetical protein +FIG01041681 FIG01041682: hypothetical protein +FIG01041682 FIG01041687: hypothetical protein +FIG01041691 FIG01041692: hypothetical protein +FIG01041692 FIG01041696: hypothetical protein +FIG01041696 intracellular alkaline serine proteinase +FIG01041697 FIG01041700: hypothetical protein +FIG01041700 FIG01041701: hypothetical protein +FIG01041701 FIG01041704: hypothetical protein +FIG01041704 FIG01041705: hypothetical protein +FIG01041705 FIG01041706: hypothetical protein +FIG01041706 FIG01041710: hypothetical protein +FIG01041710 FIG01041714: hypothetical protein +FIG01041714 FIG01041715: hypothetical protein +FIG01041718 FIG01041719: hypothetical protein +FIG01041720 aryl sulfotransferase +FIG01041721 FIG01041722: hypothetical protein +FIG01041722 FIG01041723: hypothetical protein +FIG01041723 FIG01041724: hypothetical protein +FIG01041724 FIG01041729: hypothetical protein +FIG01041729 FIG01041730: hypothetical protein +FIG01041732 FIG01041733: hypothetical protein +FIG01041733 FIG01041734: hypothetical protein +FIG01041734 FIG01041737: hypothetical protein +FIG01041737 FIG01041741: hypothetical protein +FIG01041743 FIG01041745: hypothetical protein +FIG01041745 FIG01041748: hypothetical protein +FIG01041748 subtilisin-like serine proteases +FIG01041753 FIG01041755: hypothetical protein +FIG01041755 FIG01041756: hypothetical protein +FIG01041756 FIG01041757: hypothetical protein +FIG01041767 FIG01041768: hypothetical protein +FIG01041768 FIG01041769: hypothetical protein +FIG01041769 FIG01041770: hypothetical protein +FIG01041770 FIG01041772: hypothetical protein +FIG01041774 FIG01041775: hypothetical protein +FIG01041777 short-chain dehydrogenase/reductase family prote in( EC:1.- ) +FIG01041781 FIG01041782: hypothetical protein +FIG01041782 FIG01041786: hypothetical protein +FIG01041786 FIG01041787: hypothetical protein +FIG01041787 FIG01041790: hypothetical protein +FIG01041790 FIG01041792: hypothetical protein +FIG01041792 FIG01041793: hypothetical protein +FIG01041793 FIG01041795: hypothetical protein +FIG01041795 FIG01041797: hypothetical protein +FIG01041797 FIG01041801: hypothetical protein +FIG01041803 FIG01041804: hypothetical protein +FIG01041807 FIG01041808: hypothetical protein +FIG01041810 FIG01041811: hypothetical protein +FIG01041811 FIG01041813: hypothetical protein +FIG01041813 FIG01041815: hypothetical protein +FIG01041815 FIG01041816: hypothetical protein +FIG01041816 FIG01041820: hypothetical protein +FIG01041820 FIG01041822: hypothetical protein +FIG01041822 FIG01041827: hypothetical protein +FIG01041827 FIG01041828: hypothetical protein +FIG01041828 FIG01041829: hypothetical protein +FIG01041829 FIG01041832: hypothetical protein +FIG01041832 FIG01041834: hypothetical protein +FIG01041835 FIG01041838: hypothetical protein +FIG01041841 FIG01041842: hypothetical protein +FIG01041842 FIG01041843: hypothetical protein +FIG01041843 FIG01041847: hypothetical protein +FIG01041850 FIG01041851: hypothetical protein +FIG01041851 Uncharacterized protein AF0741 (similar to YjbQ) +FIG01041852 FIG01041853: hypothetical protein +FIG01041857 FIG01041858: hypothetical protein +FIG01041858 FIG01041859: hypothetical protein +FIG01041859 FIG01041860: hypothetical protein +FIG01041861 FIG01041864: hypothetical protein +FIG01041864 FIG01041865: hypothetical protein +FIG01041866 FIG01041867: hypothetical protein +FIG01041868 FIG01041869: hypothetical protein +FIG01041869 batD protein, putative +FIG01041870 FIG01041876: hypothetical protein +FIG01041876 FIG01041877: hypothetical protein +FIG01041878 FIG01041879: hypothetical protein +FIG01041880 FIG01041883: hypothetical protein +FIG01041884 FIG01041886: hypothetical protein +FIG01041890 FIG01041893: hypothetical protein +FIG01041895 FIG01041896: hypothetical protein +FIG01041903 FIG01041904: hypothetical protein +FIG01041904 FIG01041905: hypothetical protein +FIG01041905 PASTA domain protein +FIG01041908 FIG01041909: hypothetical protein +FIG01041909 arsenite transport protein +FIG01041911 FIG01041912: hypothetical protein +FIG01041912 FIG01041913: hypothetical protein +FIG01041915 putative cytidine and deoxycytidylate deaminase +FIG01041916 FIG01041919: hypothetical protein +FIG01041919 FIG01041920: hypothetical protein +FIG01041921 FIG01041923: hypothetical protein +FIG01041923 FIG01041924: hypothetical protein +FIG01041924 FIG01041925: hypothetical protein +FIG01041925 FIG01041927: hypothetical protein +FIG01041927 FIG01041930: hypothetical protein +FIG01041930 FIG01041933: hypothetical protein +FIG01041933 FIG01041935: hypothetical protein +FIG01041939 FIG01041942: hypothetical protein +FIG01041944 putative phenol hydroxylase +FIG01041954 FIG01041957: hypothetical protein +FIG01041957 FIG01041960: hypothetical protein +FIG01041960 FIG01041962: hypothetical protein +FIG01041962 FIG01041967: hypothetical protein +FIG01041967 FIG01041968: hypothetical protein +FIG01041968 FIG01041970: hypothetical protein +FIG01041970 mannose-1-phosphate guanylyltransferase +FIG01041972 thiol:disulfide interchange protein tlpA, putative +FIG01041973 FIG01041982: hypothetical protein +FIG01041982 FIG01041983: hypothetical protein +FIG01041985 FIG01041986: hypothetical protein +FIG01041986 FIG01041987: hypothetical protein +FIG01041989 FIG01041990: hypothetical protein +FIG01041990 FIG01041992: hypothetical protein +FIG01041992 FIG01041993: hypothetical protein +FIG01041993 FIG01041994: hypothetical protein +FIG01041995 FIG01041998: hypothetical protein +FIG01041998 FIG01041999: hypothetical protein +FIG01041999 FIG01042001: hypothetical protein +FIG01042001 FIG01042002: hypothetical protein +FIG01042002 FIG01042006: hypothetical protein +FIG01042006 FIG01042008: hypothetical protein +FIG01042008 FIG01042012: hypothetical protein +FIG01042014 FIG01042015: hypothetical protein +FIG01042016 FIG01042017: hypothetical protein +FIG01042019 FIG01042020: hypothetical protein +FIG01042020 glycine oxidase, putative +FIG01042024 FIG01042027: hypothetical protein +FIG01042027 FIG01042028: hypothetical protein +FIG01042029 FIG01042034: hypothetical protein +FIG01042034 FIG01042039: hypothetical protein +FIG01042039 FIG061771: ATP-dependent nuclease subunit A +FIG01042041 FIG01042045: hypothetical protein +FIG01042045 FIG01042047: hypothetical protein +FIG01042047 FIG01042054: hypothetical protein +FIG01042055 FIG01042057: hypothetical protein +FIG01042061 FIG01042063: hypothetical protein +FIG01042063 tyrosine recombinase xerC +FIG01042071 FIG01042072: hypothetical protein +FIG01042072 FIG01042073: hypothetical protein +FIG01042073 FIG01042074: hypothetical protein +FIG01042074 FIG01042077: hypothetical protein +FIG01042079 FIG01042080: hypothetical protein +FIG01042080 FIG01042081: hypothetical protein +FIG01042081 FIG01042082: hypothetical protein +FIG01042086 FIG01042089: hypothetical protein +FIG01042091 FIG01042092: hypothetical protein +FIG01042094 FIG01042101: hypothetical protein +FIG01042104 FIG01042105: hypothetical protein +FIG01042105 FIG01042107: hypothetical protein +FIG01042108 FIG01042112: hypothetical protein +FIG01042113 FIG01042116: hypothetical protein +FIG01042116 FIG01042118: hypothetical protein +FIG01042119 FIG01042120: hypothetical protein +FIG01042120 FIG01042121: hypothetical protein +FIG01042121 FIG01042123: hypothetical protein +FIG01042126 Protein of unknown function (DUF541) superfamily +FIG01042129 FIG01042131: hypothetical protein +FIG01042135 FIG01042138: hypothetical protein +FIG01042138 FIG01042140: hypothetical protein +FIG01042141 Bacteriorhodopsin; Opsin +FIG01042143 Protein of unknown function (DUF330) superfamily +FIG01042144 Type I restriction enzyme R protein N terminus (HSDR_N) +FIG01042146 FIG01042147: hypothetical protein +FIG01042150 FIG01042151: hypothetical protein +FIG01042151 PhaF, putative +FIG01042152 FIG01042153: hypothetical protein +FIG01042153 FIG01042154: hypothetical protein +FIG01042154 FIG01042157: hypothetical protein +FIG01042157 FIG01042158: hypothetical protein +FIG01042158 FIG01042159: hypothetical protein +FIG01042160 FIG01042161: hypothetical protein +FIG01042161 FIG01042164: hypothetical protein +FIG01042164 FIG01042165: hypothetical protein +FIG01042165 TonB family C-terminal domain protein +FIG01042167 DUF89 domain of unknown function +FIG01042169 Putative RNA methylase family UPF0020 +FIG01042172 FIG01042173: hypothetical protein +FIG01042173 FIG01042174: hypothetical protein +FIG01042174 FIG01042175: hypothetical protein +FIG01042177 FIG01042179: hypothetical protein +FIG01042179 FIG01042181: hypothetical protein +FIG01042183 FIG01042185: hypothetical protein +FIG01042185 FIG01042186: hypothetical protein +FIG01042186 FIG01042188: hypothetical protein +FIG01042188 FIG01042189: hypothetical protein +FIG01042191 FIG01042193: hypothetical protein +FIG01042197 40-residue YVTN family beta-propeller repeat protein +FIG01042198 FIG01042199: hypothetical protein +FIG01042200 FIG01042202: hypothetical protein +FIG01042203 FIG01042206: hypothetical protein +FIG01042206 FIG01042208: hypothetical protein +FIG01042208 FIG01042209: hypothetical protein +FIG01042211 FIG01042213: hypothetical protein +FIG01042213 FIG01042216: hypothetical protein +FIG01042216 FIG01042217: hypothetical protein +FIG01042217 FIG01042218: hypothetical protein +FIG01042218 FIG01042219: hypothetical protein +FIG01042219 FIG01042220: hypothetical protein +FIG01042220 FIG01042221: hypothetical protein +FIG01042221 FIG01042223: hypothetical protein +FIG01042223 FIG01042225: hypothetical protein +FIG01042225 FIG01042226: hypothetical protein +FIG01042226 FIG01042227: hypothetical protein +FIG01042227 FIG01042228: hypothetical protein +FIG01042228 FIG01042229: hypothetical protein +FIG01042229 FIG01042230: hypothetical protein +FIG01042230 Bacterial Ig-like domain (group 2) family protein +FIG01042233 FIG01042236: hypothetical protein +FIG01042236 FIG01042239: hypothetical protein +FIG01042239 3-beta hydroxysteroid dehydrogenase/isomerase family +FIG01042240 succinylglutamate desuccinylase homolog +FIG01042241 FIG01042242: hypothetical protein +FIG01042242 FIG01042246: hypothetical protein +FIG01042247 FIG01042248: hypothetical protein +FIG01042248 FIG01042251: hypothetical protein +FIG01042254 FIG01042257: hypothetical protein +FIG01042257 FIG01042258: hypothetical protein +FIG01042262 FIG01042264: hypothetical protein +FIG01042264 FIG01042265: hypothetical protein +FIG01042265 phosphoribosylaminoimidazole carboxylase ATPase subunit, putative( EC:4.1.1.21 ) +FIG01042266 FIG01042269: hypothetical protein +FIG01042269 FIG01042270: hypothetical protein +FIG01042270 FIG01042272: hypothetical protein +FIG01042272 FIG01042274: hypothetical protein +FIG01042275 FIG01042278: hypothetical protein +FIG01042278 Vng1518h +FIG01042284 FIG01042285: hypothetical protein +FIG01042285 FIG01042288: hypothetical protein +FIG01042288 FIG01042294: hypothetical protein +FIG01042296 FIG01042302: hypothetical protein +FIG01042302 FIG01042303: hypothetical protein +FIG01042303 FIG01042304: hypothetical protein +FIG01042304 FIG01042306: hypothetical protein +FIG01042306 FIG01042309: hypothetical protein +FIG01042313 FIG01042315: hypothetical protein +FIG01042320 FIG01042321: hypothetical protein +FIG01042321 Sensory rhodopsin (SRI) +FIG01042322 FIG01042324: hypothetical protein +FIG01042324 FIG01042325: hypothetical protein +FIG01042325 FIG01042326: hypothetical protein +FIG01042326 FIG01042327: hypothetical protein +FIG01042327 FIG01042328: hypothetical protein +FIG01042328 FIG01042332: hypothetical protein +FIG01042340 FIG01042343: hypothetical protein +FIG01042343 FIG01042348: hypothetical protein +FIG01042348 RNA polymerase ECF-type sigma factor, putative +FIG01042350 FIG01042351: hypothetical protein +FIG01042352 FIG01042353: hypothetical protein +FIG01042354 FIG01042361: hypothetical protein +FIG01042362 FIG01042365: hypothetical protein +FIG01042365 FIG01042366: hypothetical protein +FIG01042368 FIG01042370: hypothetical protein +FIG01042370 high-potential iron-sulfur protein +FIG01042377 FIG01042379: hypothetical protein +FIG01042391 FIG01042394: hypothetical protein +FIG01042409 FIG01042412: hypothetical protein +FIG01042412 ABC-2 type transporter +FIG01042413 FIG01042414: hypothetical protein +FIG01042421 FIG01042424: hypothetical protein +FIG01042427 FIG01042429: hypothetical protein +FIG01042435 FIG01042437: hypothetical protein +FIG01042437 MOXR-LIKE ATPASE +FIG01042439 FIG01042443: hypothetical protein +FIG01042443 FIG01042445: hypothetical protein +FIG01042445 FIG00816570: hypothetical protein +FIG01042446 FIG01042447: hypothetical protein +FIG01042447 FIG01042452: hypothetical protein +FIG01042456 FIG01042458: hypothetical protein +FIG01042458 FIG01042459: hypothetical protein +FIG01042464 FIG01042466: hypothetical protein +FIG01042466 Aromatase +FIG01042468 FIG01042472: hypothetical protein +FIG01042472 FIG01042474: hypothetical protein +FIG01042477 FIG01042478: hypothetical protein +FIG01042482 FIG01042485: hypothetical protein +FIG01042485 FIG01042487: hypothetical protein +FIG01042487 FIG01042488: hypothetical protein +FIG01042491 FIG01042492: hypothetical protein +FIG01042492 FIG01042493: hypothetical protein +FIG01042495 FIG01042497: hypothetical protein +FIG01042497 FIG01042500: hypothetical protein +FIG01042500 FIG01042503: hypothetical protein +FIG01042505 FIG01042506: hypothetical protein +FIG01042506 FIG01042508: hypothetical protein +FIG01042508 FIG01042509: hypothetical protein +FIG01042510 FIG01042511: hypothetical protein +FIG01042511 FIG01042512: hypothetical protein +FIG01042512 FIG01042513: hypothetical protein +FIG01042515 Probable extracellular nuclease +FIG01042517 FIG01042518: hypothetical protein +FIG01042518 FIG01042519: hypothetical protein +FIG01042521 Trypsin alpha precursor (EC 3.4.21.4) +FIG01042522 FIG01042523: hypothetical protein +FIG01042524 FIG01042528: hypothetical protein +FIG01042528 FIG01042531: hypothetical protein +FIG01042532 FIG01042533: hypothetical protein +FIG01042533 FIG01042535: hypothetical protein +FIG01042538 FIG01042540: hypothetical protein +FIG01042540 FIG01042542: hypothetical protein +FIG01042543 FIG01042547: hypothetical protein +FIG01042547 FIG01042548: hypothetical protein +FIG01042552 FIG01042553: hypothetical protein +FIG01042553 FIG01042555: hypothetical protein +FIG01042563 FIG01042565: hypothetical protein +FIG01042570 LporfX +FIG01042574 FIG01042576: hypothetical protein +FIG01042576 FIG01042580: hypothetical protein +FIG01042580 LpqU +FIG01042582 FIG01042583: hypothetical protein +FIG01042587 FIG01042588: hypothetical protein +FIG01042588 FIG01042592: hypothetical protein +FIG01042592 FIG01042593: hypothetical protein +FIG01042593 FIG01042595: hypothetical protein +FIG01042600 FIG01042601: hypothetical protein +FIG01042607 FIG01042609: hypothetical protein +FIG01042609 FIG01042610: hypothetical protein +FIG01042610 FIG01042611: hypothetical protein +FIG01042611 FIG01042612: hypothetical protein +FIG01042616 FIG01042617: hypothetical protein +FIG01042617 FIG01042618: hypothetical protein +FIG01042618 FIG01042619: hypothetical protein +FIG01042619 FIG01042621: hypothetical protein +FIG01042624 FIG01042625: hypothetical protein +FIG01042625 FIG01042628: hypothetical protein +FIG01042630 FIG01042632: hypothetical protein +FIG01042634 FIG01042636: hypothetical protein +FIG01042637 FIG01042638: hypothetical protein +FIG01042644 FIG01042645: hypothetical protein +FIG01042656 FIG01042659: hypothetical protein +FIG01042659 FIG01042662: hypothetical protein +FIG01042662 FIG01042663: hypothetical protein +FIG01042670 FIG01042673: hypothetical protein +FIG01042673 FIG01042674: hypothetical protein +FIG01042678 FIG01042679: hypothetical protein +FIG01042679 FIG01042681: hypothetical protein +FIG01042681 FIG01042682: hypothetical protein +FIG01042688 FIG01042690: hypothetical protein +FIG01042690 Nudix dNTPase DR0004 (EC 3.6.1.-) +FIG01042692 FIG01042693: hypothetical protein +FIG01042693 FIG01042694: hypothetical protein +FIG01042694 FIG01042695: hypothetical protein +FIG01042695 FIG01042697: hypothetical protein +FIG01042697 FIG01042698: hypothetical protein +FIG01042698 FIG01042700: hypothetical protein +FIG01042700 FIG01042702: hypothetical protein +FIG01042702 FIG01042703: hypothetical protein +FIG01042703 FIG01042705: hypothetical protein +FIG01042706 FIG01042712: hypothetical protein +FIG01042712 hypothetical protein +FIG01042718 FIG01042720: hypothetical protein +FIG01042720 FIG01042721: hypothetical protein +FIG01042725 FIG01042727: hypothetical protein +FIG01042727 FIG01042728: hypothetical protein +FIG01042728 FIG01042729: hypothetical protein +FIG01042733 Oxygenase reductase-like protein +FIG01042738 FIG01042739: hypothetical protein +FIG01042741 FIG01042742: hypothetical protein +FIG01042742 FIG01042744: hypothetical protein +FIG01042744 FIG01042745: hypothetical protein +FIG01042748 FIG01042750: hypothetical protein +FIG01042750 FIG01042752: hypothetical protein +FIG01042754 PhoP +FIG01042758 FIG01042759: hypothetical protein +FIG01042760 FIG01042761: hypothetical protein +FIG01042762 FIG01042764: hypothetical protein +FIG01042764 FIG01042765: hypothetical protein +FIG01042766 FIG01042768: hypothetical protein +FIG01042768 FIG01042772: hypothetical protein +FIG01042773 FIG01042775: hypothetical protein +FIG01042775 FIG01042777: hypothetical protein +FIG01042777 FIG01042779: hypothetical protein +FIG01042781 FIG01042783: hypothetical protein +FIG01042783 FIG01042784: hypothetical protein +FIG01042784 FIG01042785: hypothetical protein +FIG01042794 Probable deoR-family transcriptional regulator +FIG01042796 FIG01042801: hypothetical protein +FIG01042801 FIG01042810: hypothetical protein +FIG01042810 FIG01042812: hypothetical protein +FIG01042813 FIG01042814: hypothetical protein +FIG01042814 FIG01042815: hypothetical protein +FIG01042815 FIG01042816: hypothetical protein +FIG01042816 Epsilon-toxin type B precursor +FIG01042817 FIG01042820: hypothetical protein +FIG01042824 FIG01042825: hypothetical protein +FIG01042825 FIG01042826: hypothetical protein +FIG01042826 FIG01042827: hypothetical protein +FIG01042832 FIG01042834: hypothetical protein +FIG01042834 Possible transmembrane-transport protein +FIG01042840 FIG01042841: hypothetical protein +FIG01042841 FIG01042843: hypothetical protein +FIG01042844 FIG01042846: hypothetical protein +FIG01042848 FIG01042850: hypothetical protein +FIG01042850 FIG01042853: hypothetical protein +FIG01042853 FIG01042854: hypothetical protein +FIG01042854 FIG01042856: hypothetical protein +FIG01042856 FIG01042857: hypothetical protein +FIG01042857 FIG01042861: hypothetical protein +FIG01042861 FIG01042862: hypothetical protein +FIG01042871 putative alkaline phosphatase +FIG01042872 FIG01042873: hypothetical protein +FIG01042873 FIG01042874: hypothetical protein +FIG01042878 FIG01042879: hypothetical protein +FIG01042885 FIG01042886: hypothetical protein +FIG01042886 FIG01042887: hypothetical protein +FIG01042887 FIG01042890: hypothetical protein +FIG01042890 FIG01042892: hypothetical protein +FIG01042892 FIG01042893: hypothetical protein +FIG01042893 FIG01042895: hypothetical protein +FIG01042895 FIG01042897: hypothetical protein +FIG01042899 FIG214983: hypothetical protein +FIG01042909 FIG01042910: hypothetical protein +FIG01042910 FIG01042913: hypothetical protein +FIG01042915 FIG01042919: hypothetical protein +FIG01042920 FIG01042921: hypothetical protein +FIG01042921 FIG01042924: hypothetical protein +FIG01042924 FIG01042925: hypothetical protein +FIG01042928 FIG01042930: hypothetical protein +FIG01042932 FIG01042936: hypothetical protein +FIG01042936 FIG01042937: hypothetical protein +FIG01042938 FIG01042941: hypothetical protein +FIG01042941 FIG01042942: hypothetical protein +FIG01042942 FIG01042944: hypothetical protein +FIG01042945 FIG01042948: hypothetical protein +FIG01042954 FIG01042955: hypothetical protein +FIG01042955 FIG01042956: hypothetical protein +FIG01042956 FIG01042957: hypothetical protein +FIG01042960 FIG01042961: hypothetical protein +FIG01042961 FIG01042963: hypothetical protein +FIG01042963 FIG01042964: hypothetical protein +FIG01042966 FIG01042967: hypothetical protein +FIG01042967 FIG01042969: hypothetical protein +FIG01042969 FIG01042971: hypothetical protein +FIG01042972 FIG01042975: hypothetical protein +FIG01042975 FIG01042976: hypothetical protein +FIG01042976 FIG01042977: hypothetical protein +FIG01042977 FIG01042979: hypothetical protein +FIG01042979 FIG01042980: hypothetical protein +FIG01042983 FIG01042984: hypothetical protein +FIG01042985 FIG01042987: hypothetical protein +FIG01042987 FIG01042988: hypothetical protein +FIG01042988 FIG01042991: hypothetical protein +FIG01042991 FIG01042992: hypothetical protein +FIG01042996 FIG01042998: hypothetical protein +FIG01043001 FIG01043002: hypothetical protein +FIG01043004 FIG01043006: hypothetical protein +FIG01043007 FIG01043008: hypothetical protein +FIG01043010 FIG01043011: hypothetical protein +FIG01043011 FIG01043012: hypothetical protein +FIG01043012 FIG01043014: hypothetical protein +FIG01043017 FIG01043019: hypothetical protein +FIG01043019 FIG01043020: hypothetical protein +FIG01043020 FIG01043022: hypothetical protein +FIG01043024 UPF0235 protein CT1832 +FIG01043027 FIG01043029: hypothetical protein +FIG01043030 FIG01043031: hypothetical protein +FIG01043037 FIG01043038: hypothetical protein +FIG01043038 FIG01043039: hypothetical protein +FIG01043040 FIG01043042: hypothetical protein +FIG01043042 FIG01043047: hypothetical protein +FIG01043047 FIG01043051: hypothetical protein +FIG01043054 FIG01043059: hypothetical protein +FIG01043062 FIG01043063: hypothetical protein +FIG01043063 FIG01043064: hypothetical protein +FIG01043064 UnbU +FIG01043066 FIG01043068: hypothetical protein +FIG01043068 FIG01043069: hypothetical protein +FIG01043076 FIG01043077: hypothetical protein +FIG01043085 FIG01043086: hypothetical protein +FIG01043086 FIG01043087: hypothetical protein +FIG01043087 FIG01043088: hypothetical protein +FIG01043090 FIG01043091: hypothetical protein +FIG01043093 PROBABLE MUTATOR PROTEIN MUTT2 (7,8-dihydro-8-oxoguanine- triphosphatase) (8-OXO-DGTPASE) (EC 3.6.1.-) +FIG01043099 FIG01043101: hypothetical protein +FIG01043106 FIG01043111: hypothetical protein +FIG01043117 FIG01043118: hypothetical protein +FIG01043118 FIG01043120: hypothetical protein +FIG01043126 FIG01043128: hypothetical protein +FIG01043129 FIG01043130: hypothetical protein +FIG01043132 FIG01043133: hypothetical protein +FIG01043133 FIG01043134: hypothetical protein +FIG01043136 FIG01043137: hypothetical protein +FIG01043140 FIG01043141: hypothetical protein +FIG01043146 FIG01043147: hypothetical protein +FIG01043147 Methyltransferase-like protein +FIG01043148 FIG01043156: hypothetical protein +FIG01043156 FIG01043157: hypothetical protein +FIG01043157 FIG01043159: hypothetical protein +FIG01043160 FIG01043162: hypothetical protein +FIG01043164 FIG01043165: hypothetical protein +FIG01043165 FIG01043166: hypothetical protein +FIG01043172 FIG01043175: hypothetical protein +FIG01043175 FIG01043176: hypothetical protein +FIG01043177 FIG01043178: hypothetical protein +FIG01043181 FIG01043182: hypothetical protein +FIG01043182 FIG01043183: hypothetical protein +FIG01043183 FIG01043185: hypothetical protein +FIG01043185 FIG01043186: hypothetical protein +FIG01043186 FIG01043187: hypothetical protein +FIG01043187 FIG01043196: hypothetical protein +FIG01043196 FIG01043199: hypothetical protein +FIG01043199 FIG01043200: hypothetical protein +FIG01043200 FIG01043202: hypothetical protein +FIG01043209 FIG01043211: hypothetical protein +FIG01043211 FIG01043212: hypothetical protein +FIG01043212 FIG01043213: hypothetical protein +FIG01043213 FIG01043215: hypothetical protein +FIG01043219 FIG01043221: hypothetical protein +FIG01043221 FIG01043224: hypothetical protein +FIG01043225 FIG01043226: hypothetical protein +FIG01043232 FIG01043235: hypothetical protein +FIG01043237 FIG01043238: hypothetical protein +FIG01043245 FIG01043247: hypothetical protein +FIG01043249 FIG01043250: hypothetical protein +FIG01043250 FIG01043252: hypothetical protein +FIG01043252 FIG01043254: hypothetical protein +FIG01043257 FIG01043260: hypothetical protein +FIG01043262 FIG01043264: hypothetical protein +FIG01043264 FIG01043268: hypothetical protein +FIG01043269 FIG01043270: hypothetical protein +FIG01043270 FIG01043271: hypothetical protein +FIG01043271 FIG01043273: hypothetical protein +FIG01043278 FIG01043282: hypothetical protein +FIG01043285 Prophage antirepressor protein +FIG01043286 FIG01043287: hypothetical protein +FIG01043287 FIG01043288: hypothetical protein +FIG01043292 FIG01043295: hypothetical protein +FIG01043295 FIG01043296: hypothetical protein +FIG01043296 FIG01123188: hypothetical protein +FIG01043301 FIG01043302: hypothetical protein +FIG01043302 FIG01043304: hypothetical protein +FIG01043304 FIG01043306: hypothetical protein +FIG01043313 FIG01043316: hypothetical protein +FIG01043316 FIG01043318: hypothetical protein +FIG01043318 FIG01043323: hypothetical protein +FIG01043323 FIG01043327: hypothetical protein +FIG01043327 FIG01043333: hypothetical protein +FIG01043333 FIG01043336: hypothetical protein +FIG01043336 FIG01043337: hypothetical protein +FIG01043337 FIG01121307: hypothetical protein +FIG01043339 FIG01043340: hypothetical protein +FIG01043340 FIG01043343: hypothetical protein +FIG01043343 MbtH domain protein +FIG01043349 FIG01043351: hypothetical protein +FIG01043353 FIG01043354: hypothetical protein +FIG01043354 TOMM biosynthesis cyclodehydratase (protein C) / TOMM biosynthesis docking scaffold (protein D) +FIG01043358 FIG01043359: hypothetical protein +FIG01043361 FIG01043362: hypothetical protein +FIG01043362 FIG01043363: hypothetical protein +FIG01043364 FIG01043365: hypothetical protein +FIG01043365 FIG01043366: hypothetical protein +FIG01043367 FIG01043368: hypothetical protein +FIG01043374 FIG01043381: hypothetical protein +FIG01043382 FIG01043384: hypothetical protein +FIG01043392 FIG01043393: hypothetical protein +FIG01043404 FIG01043405: hypothetical protein +FIG01043406 FIG01043407: hypothetical protein +FIG01043407 FIG01043408: hypothetical protein +FIG01043414 FIG01043415: hypothetical protein +FIG01043415 FIG01043416: hypothetical protein +FIG01043416 FIG01043418: hypothetical protein +FIG01043432 FIG01043434: hypothetical protein +FIG01043434 FIG01043435: hypothetical protein +FIG01043435 glycosyl transferase, WecB/TagA/CpsF family +FIG01043439 FIG01043440: hypothetical protein +FIG01043445 FIG01043449: hypothetical protein +FIG01043449 FIG01043450: hypothetical protein +FIG01043450 FIG01043451: hypothetical protein +FIG01043452 FIG01043456: hypothetical protein +FIG01043456 FIG01043458: hypothetical protein +FIG01043458 FIG01043460: hypothetical protein +FIG01043460 FIG01043462: hypothetical protein +FIG01043469 response regulator receiver +FIG01043470 gnl|WGS:AAAB|agCP12846|gb|EAA01736 +FIG01043485 FIG01043488: hypothetical protein +FIG01043488 FIG01043490: hypothetical protein +FIG01043491 FIG01043495: hypothetical protein +FIG01043495 FIG01043496: hypothetical protein +FIG01043500 FIG01043501: hypothetical protein +FIG01043501 FIG01043503: hypothetical protein +FIG01043511 FIG01043512: hypothetical protein +FIG01043513 FIG01043517: hypothetical protein +FIG01043519 FIG01043520: hypothetical protein +FIG01043520 FIG01043521: hypothetical protein +FIG01043537 FIG01043538: hypothetical protein +FIG01043540 FIG01043543: hypothetical protein +FIG01043543 FIG01043545: hypothetical protein +FIG01043545 Calcineurin-like phosphoesterase +FIG01043549 FIG01043551: hypothetical protein +FIG01043557 FIG01043559: hypothetical protein +FIG01043567 FIG01043568: hypothetical protein +FIG01043576 FIG01043580: hypothetical protein +FIG01043582 FIG01043585: hypothetical protein +FIG01043585 Mlr2412 protein +FIG01043586 cell envelope-related transcriptional attenuator +FIG01043588 FIG01043591: hypothetical protein +FIG01043594 CDP-alcohol phosphatidyltransferase( EC:2.7.8.- ) +FIG01043596 FIG01043598: hypothetical protein +FIG01043598 FIG01043599: hypothetical protein +FIG01043600 FIG01043601: hypothetical protein +FIG01043601 FIG01043604: hypothetical protein +FIG01043608 FIG01043609: hypothetical protein +FIG01043610 FIG01043611: hypothetical protein +FIG01043611 FIG01043612: hypothetical protein +FIG01043620 FIG01043622: hypothetical protein +FIG01043622 FIG01043627: hypothetical protein +FIG01043629 FIG01043631: hypothetical protein +FIG01043641 FIG01043642: hypothetical protein +FIG01043648 SseC +FIG01043660 FIG01043662: hypothetical protein +FIG01043664 FIG01043666: hypothetical protein +FIG01043679 FIG01043681: hypothetical protein +FIG01043687 FIG01043688: hypothetical protein +FIG01043688 FIG01043692: hypothetical protein +FIG01043694 FIG01043695: hypothetical protein +FIG01043695 FIG01043698: hypothetical protein +FIG01043698 FIG01043699: hypothetical protein +FIG01043699 FIG01043702: hypothetical protein +FIG01043702 FIG01043708: hypothetical protein +FIG01043710 FIG01043715: hypothetical protein +FIG01043715 FIG01043716: hypothetical protein +FIG01043716 UPF0256 protein SCO2625 +FIG01043719 FIG01043724: hypothetical protein +FIG01043728 FIG01043729: hypothetical protein +FIG01043729 FIG01043733: hypothetical protein +FIG01043733 FIG01043734: hypothetical protein +FIG01043734 ABC transporter associated permease +FIG01043736 FIG01043738: hypothetical protein +FIG01043738 FIG01043739: hypothetical protein +FIG01043740 FIG01043741: hypothetical protein +FIG01043741 FIG01043743: hypothetical protein +FIG01043754 FIG01043756: hypothetical protein +FIG01043756 Daunorubicin C-13 ketoreductase +FIG01043760 FIG01043762: hypothetical protein +FIG01043762 FIG01043763: hypothetical protein +FIG01043763 FIG00717937: hypothetical protein +FIG01043768 FIG01043769: hypothetical protein +FIG01043771 FIG01043773: hypothetical protein +FIG01043775 FIG01043778: hypothetical protein +FIG01043792 FIG01043793: hypothetical protein +FIG01043793 FIG01043795: hypothetical protein +FIG01043797 FIG01043800: hypothetical protein +FIG01043800 FIG01043801: hypothetical protein +FIG01043801 FIG01043806: hypothetical protein +FIG01043807 FIG01043808: hypothetical protein +FIG01043810 FIG01043813: hypothetical protein +FIG01043813 FIG01043815: hypothetical protein +FIG01043817 FIG01043818: hypothetical protein +FIG01043819 FIG01043823: hypothetical protein +FIG01043829 FIG01043830: hypothetical protein +FIG01043831 FIG01043832: hypothetical protein +FIG01043835 FIG01043836: hypothetical protein +FIG01043836 FIG01043839: hypothetical protein +FIG01043842 FIG01043846: hypothetical protein +FIG01043847 FIG01043856: hypothetical protein +FIG01043863 FIG01043864: hypothetical protein +FIG01043868 FIG01043870: hypothetical protein +FIG01043871 FIG01043872: hypothetical protein +FIG01043872 FIG01043874: hypothetical protein +FIG01043874 FIG01043875: hypothetical protein +FIG01043878 FIG01043880: hypothetical protein +FIG01043880 FIG01043884: hypothetical protein +FIG01043886 FIG01043888: hypothetical protein +FIG01043899 FIG01043900: hypothetical protein +FIG01043900 FIG01043902: hypothetical protein +FIG01043904 FIG01043906: hypothetical protein +FIG01043913 FIG01043918: hypothetical protein +FIG01043920 FIG01043922: hypothetical protein +FIG01043922 FIG01043926: hypothetical protein +FIG01043941 FIG01043944: hypothetical protein +FIG01043949 FIG01043950: hypothetical protein +FIG01043950 FIG01043954: hypothetical protein +FIG01043980 FIG01043982: hypothetical protein +FIG01043982 FIG01043984: hypothetical protein +FIG01043984 FIG01043985: hypothetical protein +FIG01043985 FIG01043986: hypothetical protein +FIG01043990 FIG01043991: hypothetical protein +FIG01043991 Cinorf13 protein +FIG01043992 FIG01043996: hypothetical protein +FIG01043999 FIG01044000: hypothetical protein +FIG01044004 FIG01044005: hypothetical protein +FIG01044005 FIG01044006: hypothetical protein +FIG01044011 FIG01044015: hypothetical protein +FIG01044017 Non-heme chloroperoxidase (EC 1.11.1.10) (Chloride peroxidase) (CPO-F) (Chloroperoxidase F) +FIG01044026 FIG00814737: hypothetical protein +FIG01044035 FIG01044036: hypothetical protein +FIG01044037 FIG01044039: hypothetical protein +FIG01044039 FIG01044040: hypothetical protein +FIG01044040 FIG01044044: hypothetical protein +FIG01044045 Glycine betaine ABC transport system, permease protein OpuAB +FIG01044047 FIG01044049: hypothetical protein +FIG01044054 FIG01044055: hypothetical protein +FIG01044057 FIG01044060: hypothetical protein +FIG01044061 FIG01044064: hypothetical protein +FIG01044064 FIG01044065: hypothetical protein +FIG01044065 FIG01044066: hypothetical protein +FIG01044066 FIG01044067: hypothetical protein +FIG01044069 FIG01044071: hypothetical protein +FIG01044075 FIG01044077: hypothetical protein +FIG01044077 FIG01044080: hypothetical protein +FIG01044086 FIG01044088: hypothetical protein +FIG01044091 FIG01044093: hypothetical protein +FIG01044093 FIG01044094: hypothetical protein +FIG01044097 FIG01044103: hypothetical protein +FIG01044103 FIG01044104: hypothetical protein +FIG01044109 FIG01044112: hypothetical protein +FIG01044118 FIG01044119: hypothetical protein +FIG01044119 FIG00822982: hypothetical protein +FIG01044123 lipolytic enzyme, G-D-S-L +FIG01044127 FIG01044129: hypothetical protein +FIG01044130 FIG01044132: hypothetical protein +FIG01044136 FIG01044137: hypothetical protein +FIG01044137 FIG01044139: hypothetical protein +FIG01044139 FIG01044141: hypothetical protein +FIG01044141 FIG01044143: hypothetical protein +FIG01044152 FIG01044156: hypothetical protein +FIG01044163 FIG01044167: hypothetical protein +FIG01044168 FIG01044175: hypothetical protein +FIG01044175 FIG01044176: hypothetical protein +FIG01044178 FIG01044179: hypothetical protein +FIG01044180 FIG01044184: hypothetical protein +FIG01044190 FIG01044191: hypothetical protein +FIG01044207 FIG01044208: hypothetical protein +FIG01044210 Probable polyketide synthase protein +FIG01044212 FIG01044215: hypothetical protein +FIG01044216 FIG01044219: hypothetical protein +FIG01044219 FIG01044221: hypothetical protein +FIG01044221 FIG01044222: hypothetical protein +FIG01044222 FIG01044224: hypothetical protein +FIG01044224 FIG00815991: hypothetical protein +FIG01044229 FIG01044230: hypothetical protein +FIG01044246 FIG01044247: hypothetical protein +FIG01044263 FIG01044265: hypothetical protein +FIG01044265 FIG01044267: hypothetical protein +FIG01044269 FIG01044270: hypothetical protein +FIG01044280 FIG01044282: hypothetical protein +FIG01044282 FIG01044284: hypothetical protein +FIG01044286 FIG01044287: hypothetical protein +FIG01044299 FIG01044300: hypothetical protein +FIG01044323 Similar to F420-dependent glucose-6-phosphate dehydrogenase, SCO7290 family +FIG01044329 FIG01044330: hypothetical protein +FIG01044330 FIG01044332: hypothetical protein +FIG01044335 FIG01044338: hypothetical protein +FIG01044338 FIG01044341: hypothetical protein +FIG01044341 FIG01044343: hypothetical protein +FIG01044365 FIG01044370: hypothetical protein +FIG01044379 FIG01044380: hypothetical protein +FIG01044380 FIG01044383: hypothetical protein +FIG01044383 FIG01044384: hypothetical protein +FIG01044384 FIG01044401: hypothetical protein +FIG01044403 FIG01044405: hypothetical protein +FIG01044405 FIG01044407: hypothetical protein +FIG01044419 FIG01044422: hypothetical protein +FIG01044422 FIG01044426: hypothetical protein +FIG01044435 FIG01044439: hypothetical protein +FIG01044439 Transmembrane efflux protein +FIG01044443 FIG01044444: hypothetical protein +FIG01044451 FIG01044455: hypothetical protein +FIG01044455 FIG01044456: hypothetical protein +FIG01044468 FIG01044469: hypothetical protein +FIG01044481 FIG01044482: hypothetical protein +FIG01044482 FIG01044483: hypothetical protein +FIG01044488 FIG01044489: hypothetical protein +FIG01044489 FIG01044492: hypothetical protein +FIG01044500 FIG01044503: hypothetical protein +FIG01044503 Alkyl hydroperoxide reductase/ Thiol specific antioxidant/ Mal allergen +FIG01044508 FIG01044509: hypothetical protein +FIG01044509 FIG01044511: hypothetical protein +FIG01044516 FIG01044520: hypothetical protein +FIG01044521 FIG01044524: hypothetical protein +FIG01044530 FIG01044533: hypothetical protein +FIG01044533 FIG01044536: hypothetical protein +FIG01044540 FIG01044543: hypothetical protein +FIG01044551 FIG01044554: hypothetical protein +FIG01044559 FIG01044560: hypothetical protein +FIG01044572 FIG01044575: hypothetical protein +FIG01044575 FIG01044578: hypothetical protein +FIG01044578 FIG01044579: hypothetical protein +FIG01044587 Fmn oxidoreductase protein +FIG01044601 FIG01044602: hypothetical protein +FIG01044602 FIG01044604: hypothetical protein +FIG01044605 FIG01044606: hypothetical protein +FIG01044617 FIG01044618: hypothetical protein +FIG01044618 FIG01044621: hypothetical protein +FIG01044622 FIG01122752: hypothetical protein +FIG01044636 FIG00814161: hypothetical protein +FIG01044639 Putative non-heme chloroperoxidase (EC 1.11.1.10) (Chloride peroxidase) +FIG01044641 FIG01044643: hypothetical protein +FIG01044648 FIG01044650: hypothetical protein +FIG01044650 FIG01044652: hypothetical protein +FIG01044663 FIG01044664: hypothetical protein +FIG01044664 Bll3994 protein +FIG01044671 FIG01044672: hypothetical protein +FIG01044672 FIG01044675: hypothetical protein +FIG01044684 FIG01044686: hypothetical protein +FIG01044693 FIG01044699: hypothetical protein +FIG01044714 FIG01044717: hypothetical protein +FIG01044736 FIG01044737: hypothetical protein +FIG01044746 4'-phosphopantetheinyl transferase +FIG01044747 FIG01044748: hypothetical protein +FIG01044750 FIG01044753: hypothetical protein +FIG01044766 FIG01044768: hypothetical protein +FIG01044774 FIG01044782: hypothetical protein +FIG01044782 FIG01044784: hypothetical protein +FIG01044786 FIG01044789: hypothetical protein +FIG01044793 FIG01044796: hypothetical protein +FIG01044808 FIG01044810: hypothetical protein +FIG01044818 Glycine-rich protein +FIG01044822 FIG01044823: hypothetical protein +FIG01044833 FIG01044838: hypothetical protein +FIG01044858 FIG01044859: hypothetical protein +FIG01044902 FIG01044905: hypothetical protein +FIG01044916 FIG01044921: hypothetical protein +FIG01044943 FIG01044945: hypothetical protein +FIG01044959 FIG01044961: hypothetical protein +FIG01045035 FIG01045036: hypothetical protein +FIG01045050 FIG01045051: hypothetical protein +FIG01045070 FIG01045071: hypothetical protein +FIG01045071 FIG01045074: hypothetical protein +FIG01045115 FIG01045119: hypothetical protein +FIG01045126 Putative mandelate racemase STM3833 +FIG01045127 FIG01045128: hypothetical protein +FIG01045128 FIG01045129: hypothetical protein +FIG01045129 FIG01045130: hypothetical protein +FIG01045133 FIG01045134: hypothetical protein +FIG01045134 hypothetical protein +FIG01045136 FIG01045137: hypothetical protein +FIG01045137 FIG01045138: hypothetical protein +FIG01045138 FIG01045139: hypothetical protein +FIG01045139 FIG01045140: hypothetical protein +FIG01045143 FIG01045144: hypothetical protein +FIG01045144 FIG01045145: hypothetical protein +FIG01045145 FIG01045146: hypothetical protein +FIG01045146 FIG01045148: hypothetical protein +FIG01045148 Pyridoxamine 5'-phosphate oxidase-related, FMN-binding +FIG01045150 FIG01045152: hypothetical protein +FIG01045152 FIG01045153: hypothetical protein +FIG01045154 FIG01045155: hypothetical protein +FIG01045155 FIG01045156: hypothetical protein +FIG01045157 FIG01045158: hypothetical protein +FIG01045158 corresponds to STY1986 from Accession AL513382: Salmonella typhi CT18 +FIG01045161 FIG01045162: hypothetical protein +FIG01045163 FIG01045165: hypothetical protein +FIG01045166 FIG01045168: hypothetical protein +FIG01045168 FIG01045169: hypothetical protein +FIG01045169 FIG01045170: hypothetical protein +FIG01045170 FIG01045174: hypothetical protein +FIG01045174 FIG01045176: hypothetical protein +FIG01045177 NAD(FAD)-utilizing dehydrogenases +FIG01045180 FIG01045182: hypothetical protein +FIG01045183 FIG01045184: hypothetical protein +FIG01045185 FIG01045186: hypothetical protein +FIG01045186 FIG01045187: hypothetical protein +FIG01045187 FIG01045188: hypothetical protein +FIG01045188 Putative regulatory protein +FIG01045191 FIG01045192: hypothetical protein +FIG01045192 FIG01045193: hypothetical protein +FIG01045193 FIG01045194: hypothetical protein +FIG01045194 FIG01045195: hypothetical protein +FIG01045196 FIG01045197: hypothetical protein +FIG01045197 FIG01045198: hypothetical protein +FIG01045198 FIG01045200: hypothetical protein +FIG01045202 FIG01045203: hypothetical protein +FIG01045203 FIG01045205: hypothetical protein +FIG01045205 FIG01045206: hypothetical protein +FIG01045206 FIG01045207: hypothetical protein +FIG01045207 FIG01045208: hypothetical protein +FIG01045208 Exodeoxyribonuclease VIII (EC 3.1.11.-) +FIG01045210 major outer membrane lipoprotein +FIG01045212 FIG01045213: hypothetical protein +FIG01045213 FIG01045215: hypothetical protein +FIG01045215 FIG01045217: hypothetical protein +FIG01045217 FIG01045218: hypothetical protein +FIG01045218 FIG01045219: hypothetical protein +FIG01045220 FIG01045222: hypothetical protein +FIG01045222 FIG01045224: hypothetical protein +FIG01045224 FIG01045226: hypothetical protein +FIG01045226 FIG01045227: hypothetical protein +FIG01045228 FIG01045230: hypothetical protein +FIG01045230 Flagellar synthesis: repressor of fliC +FIG01045235 probable bacteriophage protein STY1063 +FIG01045237 FIG01045240: hypothetical protein +FIG01045240 FIG01045241: hypothetical protein +FIG01045242 FIG01045243: hypothetical protein +FIG01045243 FIG01045244: hypothetical protein +FIG01045244 FIG01045245: hypothetical protein +FIG01045245 FIG01045246: hypothetical protein +FIG01045246 FIG01045247: hypothetical protein +FIG01045247 FIG01045248: hypothetical protein +FIG01045249 FIG01045250: hypothetical protein +FIG01045250 FIG01045251: hypothetical protein +FIG01045251 FIG01045252: hypothetical protein +FIG01045252 FIG01045253: hypothetical protein +FIG01045253 FIG01045255: hypothetical protein +FIG01045255 FIG01045256: hypothetical protein +FIG01045263 FIG01045264: hypothetical protein +FIG01045264 FIG01045265: hypothetical protein +FIG01045265 FIG01045267: hypothetical protein +FIG01045267 FIG01045268: hypothetical protein +FIG01045268 FIG01045269: hypothetical protein +FIG01045270 FIG01045271: hypothetical protein +FIG01045271 FIG01045272: hypothetical protein +FIG01045272 FIG01045274: hypothetical protein +FIG01045277 FIG01045278: hypothetical protein +FIG01045278 FIG01045280: hypothetical protein +FIG01045280 kinase (ribokinase family) +FIG01045283 putative multidrug transporter membrane ATP-binding components +FIG01045286 FIG01045287: hypothetical protein +FIG01045291 CIII protein +FIG01045294 FIG01045296: hypothetical protein +FIG01045298 FIG01045299: hypothetical protein +FIG01045299 FIG01045300: hypothetical protein +FIG01045302 FIG01045303: hypothetical protein +FIG01045303 FIG01045308: hypothetical protein +FIG01045308 Putative flagellin structural protein +FIG01045309 FIG01045310: hypothetical protein +FIG01045313 FIG01045316: hypothetical protein +FIG01045316 bactoprenol-linked glucose transferase +FIG01045317 FIG01045318: hypothetical protein +FIG01045319 FIG01045320: hypothetical protein +FIG01045320 FIG01045321: hypothetical protein +FIG01045321 Putative fimbrial chaperone protein +FIG01045322 FIG01045325: hypothetical protein +FIG01045325 FIG01045326: hypothetical protein +FIG01045326 FIG01045328: hypothetical protein +FIG01045328 FIG01045330: hypothetical protein +FIG01045330 putative phage gene +FIG01045331 FIG01045332: hypothetical protein +FIG01045332 FIG01045334: hypothetical protein +FIG01045336 Virulence genes transcriptional activator +FIG01045337 FIG00640156: hypothetical protein +FIG01045338 FIG01045339: hypothetical protein +FIG01045339 FIG01045341: hypothetical protein +FIG01045345 FIG01045346: hypothetical protein +FIG01045346 corresponds to STY4603 from Accession AL513382: Salmonella typhi CT18 +FIG01045349 FIG01045350: hypothetical protein +FIG01045350 putative DNA-binding protein +FIG01045352 FIG01045355: hypothetical protein +FIG01045355 FIG01045356: hypothetical protein +FIG01045360 FIG01045361: hypothetical protein +FIG01045362 Entericidin B precursor +FIG01045364 FIG01045366: hypothetical protein +FIG01045367 FIG01045369: hypothetical protein +FIG01045369 Hydrogenase maturation factor HoxQ / Hydrogenase maturation factor HoxR +FIG01045372 FIG01045374: hypothetical protein +FIG01045374 putative phage glucose translocase +FIG01045375 FIG01045376: hypothetical protein +FIG01045376 FIG01045377: hypothetical protein +FIG01045377 Bactoprenol-linked glucose translocase +FIG01045380 FIG01045382: hypothetical protein +FIG01045385 Hydrogenase maturation factor hoxO +FIG01045388 FIG01045389: hypothetical protein +FIG01045389 FIG01045390: hypothetical protein +FIG01045390 FIG01045391: hypothetical protein +FIG01045392 FIG01045393: hypothetical protein +FIG01045394 FIG01045395: hypothetical protein +FIG01045396 FIG01045397: hypothetical protein +FIG01045397 FIG01045399: hypothetical protein +FIG01045399 FIG01045401: hypothetical protein +FIG01045401 FIG01045402: hypothetical protein +FIG01045406 FIG01045407: hypothetical protein +FIG01045407 FIG01045408: hypothetical protein +FIG01045408 FIG01045415: hypothetical protein +FIG01045416 FIG01045417: hypothetical protein +FIG01045418 FIG01045420: hypothetical protein +FIG01045428 FIG01045429: hypothetical protein +FIG01045429 FIG01045430: hypothetical protein +FIG01045430 Phosphotransferase system HPr enzyme STM3779 +FIG01045431 putative ABC transport protein +FIG01045432 FIG01045433: hypothetical protein +FIG01045436 FIG01045438: hypothetical protein +FIG01045439 FIG01045442: hypothetical protein +FIG01045443 FIG01045444: hypothetical protein +FIG01045448 Putative inner membrane protein +FIG01045450 FIG01045451: hypothetical protein +FIG01045451 FIG01045452: hypothetical protein +FIG01045452 FIG01045453: hypothetical protein +FIG01045453 FIG01045455: hypothetical protein +FIG01045458 FIG01045459: hypothetical protein +FIG01045463 ATP-dependent helicase HrpB +FIG01045466 FIG01045467: hypothetical protein +FIG01045467 FIG01045468: hypothetical protein +FIG01045470 FIG01045471: hypothetical protein +FIG01045471 FIG01045472: hypothetical protein +FIG01045474 FIG01045476: hypothetical protein +FIG01045476 FIG01045477: hypothetical protein +FIG01045477 FIG01045479: hypothetical protein +FIG01045485 FIG01045486: hypothetical protein +FIG01045486 FIG01045487: hypothetical protein +FIG01045488 FIG01045489: hypothetical protein +FIG01045489 FIG01045490: hypothetical protein +FIG01045490 FIG01045491: hypothetical protein +FIG01045491 FIG01045493: hypothetical protein +FIG01045493 FIG01045494: hypothetical protein +FIG01045495 FIG01045496: hypothetical protein +FIG01045501 FIG01045503: hypothetical protein +FIG01045503 FIG01045504: hypothetical protein +FIG01045505 FIG01045506: hypothetical protein +FIG01045506 FIG01045509: hypothetical protein +FIG01045509 FIG01045510: hypothetical protein +FIG01045518 FIG01045519: hypothetical protein +FIG01045519 corresponds to STY3665 from Accession AL513382: Salmonella typhi CT18 +FIG01045524 FIG01045525: hypothetical protein +FIG01045525 Eaa protein +FIG01045527 FIG01045528: hypothetical protein +FIG01045530 FIG01045531: hypothetical protein +FIG01045532 FIG01045533: hypothetical protein +FIG01045533 FIG01045534: hypothetical protein +FIG01045534 FIG01045535: hypothetical protein +FIG01045535 FIG01045536: hypothetical protein +FIG01045540 PyrBI operon leader peptide +FIG01045541 FIG01045545: hypothetical protein +FIG01045550 FIG00643583: hypothetical protein +FIG01045551 FIG01045552: hypothetical protein +FIG01045555 FIG01045558: hypothetical protein +FIG01045558 FIG01045560: hypothetical protein +FIG01045561 FIG01045562: hypothetical protein +FIG01045563 FIG01045566: hypothetical protein +FIG01045566 FIG01045568: hypothetical protein +FIG01045570 FIG01045571: hypothetical protein +FIG01045574 FIG01045575: hypothetical protein +FIG01045575 FIG01045578: hypothetical protein +FIG01045582 FIG01045583: hypothetical protein +FIG01045583 FIG01045584: hypothetical protein +FIG01045584 FIG01045585: hypothetical protein +FIG01045589 FIG01045590: hypothetical protein +FIG01045590 FIG01045592: hypothetical protein +FIG01045592 FIG01045594: hypothetical protein +FIG01045594 FIG01045596: hypothetical protein +FIG01045597 FIG01045599: hypothetical protein +FIG01045599 FIG01045600: hypothetical protein +FIG01045603 hypothetical protein +FIG01045604 FIG01045605: hypothetical protein +FIG01045605 FIG01045607: hypothetical protein +FIG01045609 FIG01045611: hypothetical protein +FIG01045612 FIG023365: hypothetical protein in cluster with pertussis-like toxin +FIG01045613 FIG01045615: hypothetical protein +FIG01045616 Secretion system effector SseA +FIG01045617 FIG01045618: hypothetical protein +FIG01045620 FIG01045621: hypothetical protein +FIG01045621 FIG01045625: hypothetical protein +FIG01045625 putative arylsulfatase regulator +FIG01045626 FIG01045628: hypothetical protein +FIG01045628 similar to gamma-aminobutyric acid A receptor, epsilon +FIG01045631 FIG01045632: hypothetical protein +FIG01045632 FIG01045633: hypothetical protein +FIG01045636 FIG01045637: hypothetical protein +FIG01045637 FIG01045638: hypothetical protein +FIG01045641 FIG01045642: hypothetical protein +FIG01045643 FIG01045646: hypothetical protein +FIG01045646 FIG01045654: hypothetical protein +FIG01045654 FIG01045655: hypothetical protein +FIG01045663 FIG01045664: hypothetical protein +FIG01045665 FIG01045666: hypothetical protein +FIG01045667 FIG01045669: hypothetical protein +FIG01045671 FIG01045672: hypothetical protein +FIG01045672 FIG01045673: hypothetical protein +FIG01045673 FIG01045674: hypothetical protein +FIG01045674 FIG01045675: hypothetical protein +FIG01045677 FIG01045680: hypothetical protein +FIG01045681 FIG01045683: hypothetical protein +FIG01045683 FIG00640729: hypothetical protein +FIG01045692 Putative aldo/keto reductase +FIG01045695 FIG01045697: hypothetical protein +FIG01045697 FIG01045701: hypothetical protein +FIG01045701 FIG01045702: hypothetical protein +FIG01045702 FIG01045703: hypothetical protein +FIG01045705 FIG01045706: hypothetical protein +FIG01045706 FIG01045707: hypothetical protein +FIG01045707 FIG01045708: hypothetical protein +FIG01045709 FIG01045710: hypothetical protein +FIG01045711 FIG01045712: hypothetical protein +FIG01045712 FIG01045714: hypothetical protein +FIG01045715 FIG01045716: hypothetical protein +FIG01045717 FIG01045718: hypothetical protein +FIG01045718 FIG01045719: hypothetical protein +FIG01045720 FIG01045722: hypothetical protein +FIG01045722 FIG01045723: hypothetical protein +FIG01045723 FIG01045724: hypothetical protein +FIG01045724 FIG01045725: hypothetical protein +FIG01045726 FIG01045727: hypothetical protein +FIG01045729 FIG01045731: hypothetical protein +FIG01045731 FIG01045733: hypothetical protein +FIG01045734 FIG01045735: hypothetical protein +FIG01045735 FIG01045736: hypothetical protein +FIG01045736 FIG01045737: hypothetical protein +FIG01045737 FIG01045739: hypothetical protein +FIG01045740 FIG01045741: hypothetical protein +FIG01045742 FIG01045743: hypothetical protein +FIG01045750 FIG01045751: hypothetical protein +FIG01045751 Putative fimbrial subunit +FIG01045756 FIG01045757: hypothetical protein +FIG01045757 FIG01045760: hypothetical protein +FIG01045760 FIG01045761: hypothetical protein +FIG01045763 corresponds to STY4575 from Accession AL513382: Salmonella typhi CT18 +FIG01045764 FIG01045766: hypothetical protein +FIG01045766 FIG01045767: hypothetical protein +FIG01045768 FIG01045769: hypothetical protein +FIG01045769 FIG01045770: hypothetical protein +FIG01045770 FIG01045771: hypothetical protein +FIG01045771 Putative type IV pilin protein precursor +FIG01045772 FIG01045774: hypothetical protein +FIG01045776 FIG01045781: hypothetical protein +FIG01045782 FIG01045783: hypothetical protein +FIG01045783 FIG01045785: hypothetical protein +FIG01045785 FIG01045786: hypothetical protein +FIG01045791 FIG01045792: hypothetical protein +FIG01045792 FIG01045793: hypothetical protein +FIG01045793 FIG01045795: hypothetical protein +FIG01045797 Origin specific replication initiation factor +FIG01045798 ATP-binding component +FIG01045799 FIG01045803: hypothetical protein +FIG01045803 FIG01045804: hypothetical protein +FIG01045804 FIG01045805: hypothetical protein +FIG01045806 FIG01045807: hypothetical protein +FIG01045808 FIG01045811: hypothetical protein +FIG01045811 FIG01045813: hypothetical protein +FIG01045814 FIG01045817: hypothetical protein +FIG01045818 FIG01045819: hypothetical protein +FIG01045819 FIG01045820: hypothetical protein +FIG01045820 Cell division protein +FIG01045821 FIG01045823: hypothetical protein +FIG01045823 FIG01045824: hypothetical protein +FIG01045824 FIG01045826: hypothetical protein +FIG01045826 FIG01045827: hypothetical protein +FIG01045827 FIG01045828: hypothetical protein +FIG01045828 FIG01045829: hypothetical protein +FIG01045829 FIG01045832: hypothetical protein +FIG01045833 Secreted effector protein +FIG01045841 FIG01045843: hypothetical protein +FIG01045845 FIG01045846: hypothetical protein +FIG01045847 FIG01045848: hypothetical protein +FIG01045848 FIG01045849: hypothetical protein +FIG01045849 FIG01045850: hypothetical protein +FIG01045852 FIG01045853: hypothetical protein +FIG01045853 FIG01045854: hypothetical protein +FIG01045854 FIG01045855: hypothetical protein +FIG01045855 FIG01045857: hypothetical protein +FIG01045858 Probable integrase remnant +FIG01045859 FIG01045862: hypothetical protein +FIG01045862 UPF0379 protein yjfY precursor +FIG01045866 FIG01045867: hypothetical protein +FIG01045873 FIG001676: Ferredoxin +FIG01045874 FIG01045875: hypothetical protein +FIG01045875 probable fimbrial chain protein stcA +FIG01045876 probable regulatory protein YPO0878 +FIG01045877 FIG01045878: hypothetical protein +FIG01045878 FIG01045879: hypothetical protein +FIG01045879 FIG01045880: hypothetical protein +FIG01045884 FIG01045886: hypothetical protein +FIG01045886 FIG01045887: hypothetical protein +FIG01045887 FIG01045889: hypothetical protein +FIG01045890 FIG01045891: hypothetical protein +FIG01045892 FIG01045893: hypothetical protein +FIG01045898 FIG01045899: hypothetical protein +FIG01045899 FIG01045903: hypothetical protein +FIG01045904 FIG01045906: hypothetical protein +FIG01045907 FIG01045908: hypothetical protein +FIG01045914 FIG01045916: hypothetical protein +FIG01045916 Putative fimbriae +FIG01045918 FIG01045919: hypothetical protein +FIG01045921 FIG01045923: hypothetical protein +FIG01045923 FIG01045924: hypothetical protein +FIG01045924 Putative uncharacterized protein YjfN +FIG01045926 FIG01045929: hypothetical protein +FIG01045929 FIG01045930: hypothetical protein +FIG01045930 FIG01045932: hypothetical protein +FIG01045934 Phage outer membrane lytic protein Rz; Endopeptidase (EC 3.4.-.-) +FIG01045938 FIG01045939: hypothetical protein +FIG01045939 FIG01045941: hypothetical protein +FIG01045941 Putative phage tail protein +FIG01045942 FIG01045943: hypothetical protein +FIG01045944 RatA homolog +FIG01045946 FIG01045948: hypothetical protein +FIG01045948 FIG01045950: hypothetical protein +FIG01045950 FIG01045951: hypothetical protein +FIG01045954 FIG01045957: hypothetical protein +FIG01045961 FIG01045962: hypothetical protein +FIG01045962 FIG01045963: hypothetical protein +FIG01045966 FIG01045968: hypothetical protein +FIG01045968 FIG01045970: hypothetical protein +FIG01045970 FIG01045971: hypothetical protein +FIG01045972 FIG01045973: hypothetical protein +FIG01045975 FIG01045978: hypothetical protein +FIG01045980 Putative diguanylate cyclase/phosphodiesterase domain 0 +FIG01045982 FIG01045983: hypothetical protein +FIG01045986 FIG01045987: hypothetical protein +FIG01045987 FIG01045989: hypothetical protein +FIG01045989 FIG01045991: hypothetical protein +FIG01045992 FIG01045993: hypothetical protein +FIG01045993 FIG01045994: hypothetical protein +FIG01045994 FIG01045996: hypothetical protein +FIG01045996 hypothetical protein +FIG01045999 FIG01046001: hypothetical protein +FIG01046001 FIG01046004: hypothetical protein +FIG01046004 FIG01046005: hypothetical protein +FIG01046005 FIG01046006: hypothetical protein +FIG01046006 FIG01046007: hypothetical protein +FIG01046007 Similar to pipB +FIG01046008 Putative regulator +FIG01046014 FIG01046015: hypothetical protein +FIG01046015 FIG01046016: hypothetical protein +FIG01046016 DNA-invertase +FIG01046017 Transcriptional regulator SlmA, TetR family +FIG01046018 FIG01046019: hypothetical protein +FIG01046019 FIG01046022: hypothetical protein +FIG01046022 FIG01046023: hypothetical protein +FIG01046025 FIG01046027: hypothetical protein +FIG01046029 FIG01046030: hypothetical protein +FIG01046030 FIG01046031: hypothetical protein +FIG01046035 Dipeptide transport ATP-binding protein DppD in protein degradation cluster +FIG01046036 FIG01046037: hypothetical protein +FIG01046037 FIG01046038: hypothetical protein +FIG01046038 FIG01046039: hypothetical protein +FIG01046043 FIG01046044: hypothetical protein +FIG01046047 FIG01046048: hypothetical protein +FIG01046049 FIG01046050: hypothetical protein +FIG01046051 DNA distortion protein 1 +FIG01046052 FIG01046054: hypothetical protein +FIG01046054 FIG01046057: hypothetical protein +FIG01046060 FIG01046061: hypothetical protein +FIG01046061 FIG01046062: hypothetical protein +FIG01046065 FIG01046067: hypothetical protein +FIG01046071 FIG01046076: hypothetical protein +FIG01046076 FIG01046078: hypothetical protein +FIG01046078 FIG01046080: hypothetical protein +FIG01046080 FIG01046082: hypothetical protein +FIG01046085 FIG01046088: hypothetical protein +FIG01046088 FIG01046090: hypothetical protein +FIG01046090 FIG01046091: hypothetical protein +FIG01046091 FIG01046092: hypothetical protein +FIG01046092 FIG01046094: hypothetical protein +FIG01046094 FIG01046095: hypothetical protein +FIG01046098 hypothetical protein +FIG01046101 FIG01046102: hypothetical protein +FIG01046103 FIG01046110: hypothetical protein +FIG01046110 FIG01046111: hypothetical protein +FIG01046115 FIG01046117: hypothetical protein +FIG01046122 FIG01046124: hypothetical protein +FIG01046124 FIG01046128: hypothetical protein +FIG01046128 FIG01046129: hypothetical protein +FIG01046129 Sb9 +FIG01046134 Probable secreted protein +FIG01046136 FIG01046138: hypothetical protein +FIG01046138 Type III secretion system protein +FIG01046143 FIG01046144: hypothetical protein +FIG01046144 FIG01046146: hypothetical protein +FIG01046147 FIG01046148: hypothetical protein +FIG01046148 FIG01046149: hypothetical protein +FIG01046149 FIG01046150: hypothetical protein +FIG01046150 FIG01046153: hypothetical protein +FIG01046153 FIG01046156: hypothetical protein +FIG01046160 FIG01046161: hypothetical protein +FIG01046161 FIG01046162: hypothetical protein +FIG01046164 FIG01046166: hypothetical protein +FIG01046166 FIG01046167: hypothetical protein +FIG01046167 FIG01046168: hypothetical protein +FIG01046169 integrase (fragment) +FIG01046170 FIG01046172: hypothetical protein +FIG01046174 FIG01046176: hypothetical protein +FIG01046176 FIG01046179: hypothetical protein +FIG01046183 FIG01046185: hypothetical protein +FIG01046185 FIG01046187: hypothetical protein +FIG01046189 FIG01046190: hypothetical protein +FIG01046190 FIG01046191: hypothetical protein +FIG01046191 FIG01046192: hypothetical protein +FIG01046193 FIG01046194: hypothetical protein +FIG01046198 FIG01046199: hypothetical protein +FIG01046199 FIG01046201: hypothetical protein +FIG01046203 hypothetical protein +FIG01046205 FIG01046207: hypothetical protein +FIG01046210 FIG01046213: hypothetical protein +FIG01046213 Possible L-talarate utilization transcriptional regulator, LacI family +FIG01046219 FIG01046221: hypothetical protein +FIG01046221 FIG01046222: hypothetical protein +FIG01046222 FIG01046223: hypothetical protein +FIG01046223 FIG01046224: hypothetical protein +FIG01046224 FIG01046225: hypothetical protein +FIG01046230 FIG01046232: hypothetical protein +FIG01046232 FIG01046233: hypothetical protein +FIG01046236 FIG00639134: hypothetical protein +FIG01046238 FIG01046239: hypothetical protein +FIG01046240 FIG01046242: hypothetical protein +FIG01046242 FIG01046244: hypothetical protein +FIG01046244 Type III secretion protein SsaB +FIG01046245 FIG01046247: hypothetical protein +FIG01046248 FIG01046249: hypothetical protein +FIG01046250 FIG01046251: hypothetical protein +FIG01046251 FIG01046255: hypothetical protein +FIG01046255 FIG00639790: hypothetical protein +FIG01046257 FIG01046258: hypothetical protein +FIG01046258 FIG01046261: hypothetical protein +FIG01046263 FIG01046265: hypothetical protein +FIG01046265 FIG01046267: hypothetical protein +FIG01046270 FIG01046273: hypothetical protein +FIG01046273 FIG01046277: hypothetical protein +FIG01046277 Probable regulatory protein +FIG01046283 FIG01046284: hypothetical protein +FIG01046284 FIG01046286: hypothetical protein +FIG01046286 FIG01046287: hypothetical protein +FIG01046288 hypothetical protein +FIG01046290 FIG01046292: hypothetical protein +FIG01046296 FIG01046297: hypothetical protein +FIG01046297 FIG01046298: hypothetical protein +FIG01046300 Putative endopeptidase +FIG01046301 FIG01046305: hypothetical protein +FIG01046305 FIG01046306: hypothetical protein +FIG01046306 FIG01046307: hypothetical protein +FIG01046307 FIG01046309: hypothetical protein +FIG01046309 FIG01046310: hypothetical protein +FIG01046310 Transcriptional activator protein bglJ +FIG01046314 FIG01046316: hypothetical protein +FIG01046316 FIG01046318: hypothetical protein +FIG01046320 FIG01046323: hypothetical protein +FIG01046325 non-specific acid phosphatase( EC:3.1.3.2 ) +FIG01046326 FIG01046331: hypothetical protein +FIG01046331 FIG01046332: hypothetical protein +FIG01046332 FIG01046333: hypothetical protein +FIG01046333 FIG01046337: hypothetical protein +FIG01046337 FIG01046338: hypothetical protein +FIG01046340 FIG01046341: hypothetical protein +FIG01046342 FIG01046343: hypothetical protein +FIG01046343 FIG01046344: hypothetical protein +FIG01046344 FIG01046346: hypothetical protein +FIG01046346 hypothetical protein +FIG01046347 FIG01046348: hypothetical protein +FIG01046350 FIG01046351: hypothetical protein +FIG01046351 FIG01046352: hypothetical protein +FIG01046352 FIG01046353: hypothetical protein +FIG01046356 FIG01046357: hypothetical protein +FIG01046361 FIG01046362: hypothetical protein +FIG01046362 putative transport protein +FIG01046363 FIG01046364: hypothetical protein +FIG01046364 FIG01046365: hypothetical protein +FIG01046365 FIG01046366: hypothetical protein +FIG01046366 FIG01046368: hypothetical protein +FIG01046368 FIG01046369: hypothetical protein +FIG01046369 FIG01046370: hypothetical protein +FIG01046370 FIG01046371: hypothetical protein +FIG01046372 FIG01046376: hypothetical protein +FIG01046376 FIG01046377: hypothetical protein +FIG01046378 FIG01046381: hypothetical protein +FIG01046381 FIG01046382: hypothetical protein +FIG01046383 FIG01046385: hypothetical protein +FIG01046386 FIG01046388: hypothetical protein +FIG01046388 FIG01046389: hypothetical protein +FIG01046389 FIG01046392: hypothetical protein +FIG01046392 FIG01046394: hypothetical protein +FIG01046394 FIG01046396: hypothetical protein +FIG01046399 FIG01046400: hypothetical protein +FIG01046402 FIG01046403: hypothetical protein +FIG01046403 FIG01046404: hypothetical protein +FIG01046406 FIG01046410: hypothetical protein +FIG01046410 FIG01046411: hypothetical protein +FIG01046411 FIG01046412: hypothetical protein +FIG01046412 FIG01046414: hypothetical protein +FIG01046414 FIG01046415: hypothetical protein +FIG01046415 FIG01046416: hypothetical protein +FIG01046416 FIG01046421: hypothetical protein +FIG01046421 FIG01046422: hypothetical protein +FIG01046422 FIG01046423: hypothetical protein +FIG01046429 FIG01046430: hypothetical protein +FIG01046430 FIG01046434: hypothetical protein +FIG01046438 FIG01046441: hypothetical protein +FIG01046442 FIG01046443: hypothetical protein +FIG01046444 FIG01046445: hypothetical protein +FIG01046445 COG0847: DNA polymerase III, epsilon subunit and related 3'-5' exonucleases +FIG01046446 FIG01046447: hypothetical protein +FIG01046447 FIG01046448: hypothetical protein +FIG01046448 FIG01046450: hypothetical protein +FIG01046451 FIG01046452: hypothetical protein +FIG01046452 FIG01046455: hypothetical protein +FIG01046455 FIG01046458: hypothetical protein +FIG01046458 FIG01046459: hypothetical protein +FIG01046467 FIG01046469: hypothetical protein +FIG01046474 FIG01046477: hypothetical protein +FIG01046477 FIG01046479: hypothetical protein +FIG01046479 FIG01046482: hypothetical protein +FIG01046482 Hydrolase (HAD superfamily) +FIG01046485 FIG01046487: hypothetical protein +FIG01046487 FIG01046489: hypothetical protein +FIG01046489 FIG01046494: hypothetical protein +FIG01046494 Protein rpiR +FIG01046496 FIG01046497: hypothetical protein +FIG01046497 FIG01046500: hypothetical protein +FIG01046500 FIG01046501: hypothetical protein +FIG01046502 FIG01046505: hypothetical protein +FIG01046505 Sodium:dicarboxylate symporter +FIG01046509 FIG01046512: hypothetical protein +FIG01046512 putative phage endonuclease +FIG01046513 FIG01046515: hypothetical protein +FIG01046516 FIG01046518: hypothetical protein +FIG01046518 FIG01046519: hypothetical protein +FIG01046530 FIG01046532: hypothetical protein +FIG01046532 FIG01046534: hypothetical protein +FIG01046534 FIG01046535: hypothetical protein +FIG01046541 hypothetical protein +FIG01046546 rRNA small subunit methyltransferase J +FIG01046547 FIG01046551: hypothetical protein +FIG01046551 FIG01046552: hypothetical protein +FIG01046552 FIG01046553: hypothetical protein +FIG01046553 FIG01046555: hypothetical protein +FIG01046557 FIG01046559: hypothetical protein +FIG01046559 FIG01046564: hypothetical protein +FIG01046564 FIG01046570: hypothetical protein +FIG01046570 FIG01046572: hypothetical protein +FIG01046572 FIG01046574: hypothetical protein +FIG01046580 FIG01046581: hypothetical protein +FIG01046581 FIG01046582: hypothetical protein +FIG01046586 FIG01046588: hypothetical protein +FIG01046588 FIG01046596: hypothetical protein +FIG01046596 FIG01046599: hypothetical protein +FIG01046599 FIG01046602: hypothetical protein +FIG01046602 FIG01046605: hypothetical protein +FIG01046605 FIG01046608: hypothetical protein +FIG01046608 FIG01046611: hypothetical protein +FIG01046611 FIG01046617: hypothetical protein +FIG01046617 FIG01046618: hypothetical protein +FIG01046618 FIG01046619: hypothetical protein +FIG01046619 FIG01046620: hypothetical protein +FIG01046620 FIG01046621: hypothetical protein +FIG01046622 FIG01046625: hypothetical protein +FIG01046625 FIG01046626: hypothetical protein +FIG01046635 FIG01046636: hypothetical protein +FIG01046642 FIG01046644: hypothetical protein +FIG01046645 FIG01046647: hypothetical protein +FIG01046647 FIG01046648: hypothetical protein +FIG01046650 FIG01046651: hypothetical protein +FIG01046651 FIG01046652: hypothetical protein +FIG01046652 FIG01046653: hypothetical protein +FIG01046653 FIG01046654: hypothetical protein +FIG01046661 FIG01046662: hypothetical protein +FIG01046663 FIG01046664: hypothetical protein +FIG01046671 FIG01046673: hypothetical protein +FIG01046673 FIG01046674: hypothetical protein +FIG01046674 FIG01046676: hypothetical protein +FIG01046676 FIG01046681: hypothetical protein +FIG01046682 FIG01046683: hypothetical protein +FIG01046683 FIG01046685: hypothetical protein +FIG01046689 FIG01046691: hypothetical protein +FIG01046691 FIG01046694: hypothetical protein +FIG01046695 FIG01046696: hypothetical protein +FIG01046696 FIG01046701: hypothetical protein +FIG01046701 FIG01046702: hypothetical protein +FIG01046702 FIG01046703: hypothetical protein +FIG01046703 FIG01046704: hypothetical protein +FIG01046704 FIG01046705: hypothetical protein +FIG01046705 FIG01046706: hypothetical protein +FIG01046716 FIG01046717: hypothetical protein +FIG01046717 FIG01046719: hypothetical protein +FIG01046722 FIG01046723: hypothetical protein +FIG01046724 FIG01046725: hypothetical protein +FIG01046725 FIG01046727: hypothetical protein +FIG01046727 FIG01046728: hypothetical protein +FIG01046728 hypothetical protein +FIG01046729 FIG01046732: hypothetical protein +FIG01046732 FIG01046733: hypothetical protein +FIG01046733 FIG01046734: hypothetical protein +FIG01046734 FIG01046738: hypothetical protein +FIG01046739 Uncharacterized lipoprotein YsaB precursor +FIG01046743 hypothetical protein +FIG01046746 FIG01046747: hypothetical protein +FIG01046747 FIG01046751: hypothetical protein +FIG01046753 FIG01046754: hypothetical protein +FIG01046754 FIG01046757: hypothetical protein +FIG01046757 FIG01046761: hypothetical protein +FIG01046761 FIG01046763: hypothetical protein +FIG01046764 hypothetical protein +FIG01046765 FIG01046766: hypothetical protein +FIG01046767 FIG01046771: hypothetical protein +FIG01046771 FIG01046775: hypothetical protein +FIG01046779 FIG01046780: hypothetical protein +FIG01046781 FIG01046782: hypothetical protein +FIG01046782 FIG01046783: hypothetical protein +FIG01046783 FIG01046789: hypothetical protein +FIG01046790 FIG01046791: hypothetical protein +FIG01046793 FIG01046796: hypothetical protein +FIG01046799 Putative lipopolysaccharide modification acyltransferase +FIG01046803 FIG01046806: hypothetical protein +FIG01046806 FIG01046809: hypothetical protein +FIG01046809 FIG01046811: hypothetical protein +FIG01046811 FIG01046813: hypothetical protein +FIG01046817 FIG01046818: hypothetical protein +FIG01046818 FIG01046819: hypothetical protein +FIG01046820 FIG01046822: hypothetical protein +FIG01046822 FIG01046823: hypothetical protein +FIG01046823 FIG01046824: hypothetical protein +FIG01046824 FIG01046825: hypothetical protein +FIG01046825 FIG01046826: hypothetical protein +FIG01046826 FIG01046827: hypothetical protein +FIG01046829 Homology to phage-tail assembly proteins +FIG01046832 FIG01046835: hypothetical protein +FIG01046835 FIG01046836: hypothetical protein +FIG01046837 FIG01046839: hypothetical protein +FIG01046839 FIG01046842: hypothetical protein +FIG01046852 FIG01046854: hypothetical protein +FIG01046854 FIG01046855: hypothetical protein +FIG01046856 FIG01046857: hypothetical protein +FIG01046857 FIG01046858: hypothetical protein +FIG01046861 FIG01046862: hypothetical protein +FIG01046863 FIG01046865: hypothetical protein +FIG01046869 FIG01046870: hypothetical protein +FIG01046871 FIG01046874: hypothetical protein +FIG01046874 FIG01046878: hypothetical protein +FIG01046878 FIG00350233: hypothetical protein +FIG01046884 Repressor protein +FIG01046888 FIG01046889: hypothetical protein +FIG01046889 FIG01046891: hypothetical protein +FIG01046892 FIG01046893: hypothetical protein +FIG01046898 FIG01046901: hypothetical protein +FIG01046910 Manganese ABC transporter, inner membrane permease protein SitD +FIG01046920 FIG01046921: hypothetical protein +FIG01046921 FIG01046922: hypothetical protein +FIG01046922 FIG01046923: hypothetical protein +FIG01046924 FIG01046926: hypothetical protein +FIG01046929 gp8 +FIG01046930 FIG01046935: hypothetical protein +FIG01046935 FIG01046937: hypothetical protein +FIG01046944 hypothetical protein +FIG01046947 FIG01046948: hypothetical protein +FIG01046948 FIG01046949: hypothetical protein +FIG01046949 FIG01046955: hypothetical protein +FIG01046962 FIG01046965: hypothetical protein +FIG01046967 FIG01046970: hypothetical protein +FIG01046970 FIG01046975: hypothetical protein +FIG01046975 FIG01046976: hypothetical protein +FIG01046978 FIG01046979: hypothetical protein +FIG01046981 FIG01046982: hypothetical protein +FIG01046985 FIG01046987: hypothetical protein +FIG01046987 FIG01046990: hypothetical protein +FIG01046990 FIG01046991: hypothetical protein +FIG01046993 hypothetical protein +FIG01046994 FIG01046995: hypothetical protein +FIG01046998 FIG01046999: hypothetical protein +FIG01047001 FIG01047003: hypothetical protein +FIG01047011 FIG01047012: hypothetical protein +FIG01047012 FIG01047014: hypothetical protein +FIG01047017 FIG01047021: hypothetical protein +FIG01047021 FIG01047025: hypothetical protein +FIG01047025 FIG01047026: hypothetical protein +FIG01047026 FIG01047027: hypothetical protein +FIG01047027 Nickel/cobalt efflux transporter RcnA +FIG01047031 hypothetical protein +FIG01047035 FIG01047037: hypothetical protein +FIG01047037 FIG01047038: hypothetical protein +FIG01047038 FIG01047039: hypothetical protein +FIG01047043 FIG01047045: hypothetical protein +FIG01047045 FIG01047046: hypothetical protein +FIG01047049 FIG01047051: hypothetical protein +FIG01047053 FIG01047054: hypothetical protein +FIG01047054 FIG01047058: hypothetical protein +FIG01047061 FIG01047065: hypothetical protein +FIG01047067 FIG01047069: hypothetical protein +FIG01047069 FIG01047071: hypothetical protein +FIG01047071 FIG01047079: hypothetical protein +FIG01047080 Gifsy-1 prophage protein +FIG01047084 FIG01047085: hypothetical protein +FIG01047086 FIG01047087: hypothetical protein +FIG01047087 COG4385: Bacteriophage P2-related tail formation protein +FIG01047091 FIG01047095: hypothetical protein +FIG01047095 FIG01047098: hypothetical protein +FIG01047106 FIG01047110: hypothetical protein +FIG01047110 FIG01047115: hypothetical protein +FIG01047122 FIG01047123: hypothetical protein +FIG01047123 FIG01047124: hypothetical protein +FIG01047124 FIG01047125: hypothetical protein +FIG01047125 FIG01047127: hypothetical protein +FIG01047127 FIG01047128: hypothetical protein +FIG01047128 FIG01047135: hypothetical protein +FIG01047136 FIG01047148: hypothetical protein +FIG01047148 FIG01047149: hypothetical protein +FIG01047149 FIG01047150: hypothetical protein +FIG01047150 FIG01047153: hypothetical protein +FIG01047153 FIG01047157: hypothetical protein +FIG01047161 FIG01047170: hypothetical protein +FIG01047170 FIG01047172: hypothetical protein +FIG01047179 Relaxase /helicase +FIG01047183 FIG01047184: hypothetical protein +FIG01047193 FIG01047195: hypothetical protein +FIG01047195 FIG01047196: hypothetical protein +FIG01047197 FIG100795: Fimbriae usher protein StiC +FIG01047199 FIG01047200: hypothetical protein +FIG01047200 FIG01047201: hypothetical protein +FIG01047201 FIG01047204: hypothetical protein +FIG01047208 FIG01047211: hypothetical protein +FIG01047212 FIG01047214: hypothetical protein +FIG01047214 FIG01047216: hypothetical protein +FIG01047216 FIG01047220: hypothetical protein +FIG01047220 FIG01047222: hypothetical protein +FIG01047234 FIG01047235: hypothetical protein +FIG01047238 FIG01047239: hypothetical protein +FIG01047239 FIG01047240: hypothetical protein +FIG01047240 FIG01047241: hypothetical protein +FIG01047241 FIG01047242: hypothetical protein +FIG01047242 putative RecA/RadA recombinase +FIG01047243 FIG01047245: hypothetical protein +FIG01047252 FIG01047254: hypothetical protein +FIG01047254 FIG01047257: hypothetical protein +FIG01047257 FIG01047258: hypothetical protein +FIG01047258 FIG01047259: hypothetical protein +FIG01047262 FIG01047263: hypothetical protein +FIG01047263 FIG01047264: hypothetical protein +FIG01047265 Voltage-gated ClC-type chloride channel ClcB +FIG01047281 FIG01047282: hypothetical protein +FIG01047282 FIG01047283: hypothetical protein +FIG01047283 FIG01047284: hypothetical protein +FIG01047288 FIG01047291: hypothetical protein +FIG01047291 FIG01047293: hypothetical protein +FIG01047293 FIG01047296: hypothetical protein +FIG01047296 FIG01047298: hypothetical protein +FIG01047298 FIG01047299: hypothetical protein +FIG01047299 FIG01047300: hypothetical protein +FIG01047305 FIG01047307: hypothetical protein +FIG01047307 FIG01047311: hypothetical protein +FIG01047312 FIG01047314: hypothetical protein +FIG01047314 FIG01047316: hypothetical protein +FIG01047317 FIG01047318: hypothetical protein +FIG01047318 FIG01047320: hypothetical protein +FIG01047320 probable regulatory protein +FIG01047323 FIG01047325: hypothetical protein +FIG01047325 FIG01047326: hypothetical protein +FIG01047331 FIG01047335: hypothetical protein +FIG01047335 FIG01047336: hypothetical protein +FIG01047336 FIG01047337: hypothetical protein +FIG01047337 FIG01047344: hypothetical protein +FIG01047344 FIG01047345: hypothetical protein +FIG01047350 FIG01047351: hypothetical protein +FIG01047351 FIG01047352: hypothetical protein +FIG01047352 Putative phage tail fibre protein +FIG01047353 FIG01047354: hypothetical protein +FIG01047355 FIG01047360: hypothetical protein +FIG01047360 FIG01047363: hypothetical protein +FIG01047363 FIG01047364: hypothetical protein +FIG01047366 FIG01047370: hypothetical protein +FIG01047371 LysC +FIG01047378 FIG01047379: hypothetical protein +FIG01047379 FIG01047380: hypothetical protein +FIG01047380 FIG01047384: hypothetical protein +FIG01047384 FIG01047387: hypothetical protein +FIG01047387 FIG01047389: hypothetical protein +FIG01047389 Similarity with glutathionylspermidine synthase (EC 6.3.1.8), group 1 +FIG01047399 FIG01047407: hypothetical protein +FIG01047407 FIG01047408: hypothetical protein +FIG01047419 FIG01047420: hypothetical protein +FIG01047420 FIG01047421: hypothetical protein +FIG01047424 FIG01047425: hypothetical protein +FIG01047425 FIG01047426: hypothetical protein +FIG01047426 FIG01047432: hypothetical protein +FIG01047436 FIG01047439: hypothetical protein +FIG01047440 FIG01047441: hypothetical protein +FIG01047444 FIG01047445: hypothetical protein +FIG01047449 FIG01047454: hypothetical protein +FIG01047459 FIG01047460: hypothetical protein +FIG01047462 FIG01047465: hypothetical protein +FIG01047465 PhoPQ-regulated protein +FIG01047468 FIG01047469: hypothetical protein +FIG01047472 FIG01047473: hypothetical protein +FIG01047473 FIG01047474: hypothetical protein +FIG01047474 FIG01047477: hypothetical protein +FIG01047477 FIG01047479: hypothetical protein +FIG01047480 FIG01047481: hypothetical protein +FIG01047486 FIG01047494: hypothetical protein +FIG01047494 FIG01047498: hypothetical protein +FIG01047500 FIG01047503: hypothetical protein +FIG01047503 FIG01047504: hypothetical protein +FIG01047506 FIG01047508: hypothetical protein +FIG01047508 FIG01047509: hypothetical protein +FIG01047511 FIG01047512: hypothetical protein +FIG01047515 FIG01047518: hypothetical protein +FIG01047518 FIG01047519: hypothetical protein +FIG01047519 FIG01047520: hypothetical protein +FIG01047525 FIG01047533: hypothetical protein +FIG01047533 FIG01047534: hypothetical protein +FIG01047543 FIG01047544: hypothetical protein +FIG01047548 FIG01047552: hypothetical protein +FIG01047552 FIG01047553: hypothetical protein +FIG01047553 FIG01047565: hypothetical protein +FIG01047565 intimin-like protein +FIG01047566 FIG01047567: hypothetical protein +FIG01047570 FIG01047572: hypothetical protein +FIG01047572 CcgAII protein +FIG01047580 FIG01047586: hypothetical protein +FIG01047591 FIG01047596: hypothetical protein +FIG01047596 FIG01047597: hypothetical protein +FIG01047600 hypothetical protein +FIG01047604 hypothetical protein +FIG01047606 FIG01047607: hypothetical protein +FIG01047607 FIG01047610: hypothetical protein +FIG01047610 FIG01047617: hypothetical protein +FIG01047617 FIG01047621: hypothetical protein +FIG01047629 FIG01047632: hypothetical protein +FIG01047633 FIG01047634: hypothetical protein +FIG01047634 FIG01047636: hypothetical protein +FIG01047636 FIG01047637: hypothetical protein +FIG01047637 FIG01047638: hypothetical protein +FIG01047638 FIG01047641: hypothetical protein +FIG01047645 hypothetical protein +FIG01047646 FIG01047651: hypothetical protein +FIG01047654 FIG01210734: hypothetical protein +FIG01047656 FIG01047657: hypothetical protein +FIG01047657 hypothetical protein +FIG01047659 hypothetical protein +FIG01047664 FIG01047668: hypothetical protein +FIG01047670 Putative membrane protein +FIG01047677 FIG01047678: hypothetical protein +FIG01047682 FIG01047683: hypothetical protein +FIG01047683 FIG01047684: hypothetical protein +FIG01047690 FIG01047697: hypothetical protein +FIG01047697 Superinfection exclusion protein (Protein gp17) +FIG01047698 FIG01047699: hypothetical protein +FIG01047700 Putative DNA-binding protein Erf +FIG01047703 Ethanolamine utilization polyhedral-body-like protein EutM / Ethanolamine utilization polyhedral-body-like protein EutN +FIG01047709 Uncharacterized protein similar to the carboxyl terminus of YfaD +FIG01047711 FIG01047712: hypothetical protein +FIG01047712 FIG01047714: hypothetical protein +FIG01047714 FIG01047715: hypothetical protein +FIG01047715 FIG01047716: hypothetical protein +FIG01047716 FIG01047717: hypothetical protein +FIG01047720 FIG01047722: hypothetical protein +FIG01047725 ATP-binding component of a transport system +FIG01047727 probable bacteriophage protein STY2043 +FIG01047728 FIG01047729: hypothetical protein +FIG01047730 hypothetical protein +FIG01047731 FIG01047732: hypothetical protein +FIG01047732 FIG01047737: hypothetical protein +FIG01047741 DNA restriction methylase +FIG01047747 FIG01047748: hypothetical protein +FIG01047748 FIG01047756: hypothetical protein +FIG01047761 FIG01047763: hypothetical protein +FIG01047763 FIG01047764: hypothetical protein +FIG01047766 FIG01047777: hypothetical protein +FIG01047778 FIG01047780: hypothetical protein +FIG01047780 FIG01047784: hypothetical protein +FIG01047784 FIG01047787: hypothetical protein +FIG01047787 FIG01047788: hypothetical protein +FIG01047791 FIG01047793: hypothetical protein +FIG01047793 FIG01047796: hypothetical protein +FIG01047798 FIG01047800: hypothetical protein +FIG01047800 FIG01047803: hypothetical protein +FIG01047805 FIG01047808: hypothetical protein +FIG01047815 FIG01047817: hypothetical protein +FIG01047817 FIG01047819: hypothetical protein +FIG01047819 Side tail fiber protein +FIG01047822 FIG01047828: hypothetical protein +FIG01047828 FIG01047833: hypothetical protein +FIG01047833 FIG01047835: hypothetical protein +FIG01047835 FIG01047836: hypothetical protein +FIG01047838 FIG048677: hypothetical protein in cluster with cytolethal distending toxin +FIG01047841 putative inner membrane protein +FIG01047848 FIG01047850: hypothetical protein +FIG01047850 ORF54 +FIG01047852 FIG01047855: hypothetical protein +FIG01047858 FIG01047860: hypothetical protein +FIG01047860 FIG01047862: hypothetical protein +FIG01047866 FIG01047867: hypothetical protein +FIG01047869 FIG01047870: hypothetical protein +FIG01047870 Acyl-CoA dehydrogenase (EC 1.3.8.7) +FIG01047877 FIG01047879: hypothetical protein +FIG01047879 FIG01047880: hypothetical protein +FIG01047880 FIG01047881: hypothetical protein +FIG01047884 FIG01047892: hypothetical protein +FIG01047892 FIG01047894: hypothetical protein +FIG01047894 FIG01047895: hypothetical protein +FIG01047895 FIG01047896: hypothetical protein +FIG01047896 corresponds to STY0450 from Accession AL513382: Salmonella typhi CT18 +FIG01047910 FIG01047911: hypothetical protein +FIG01047927 FIG01047928: hypothetical protein +FIG01047938 FIG01047944: hypothetical protein +FIG01047944 FIG01047945: hypothetical protein +FIG01047948 FIG01047949: hypothetical protein +FIG01047949 FIG01047951: hypothetical protein +FIG01047951 FIG01047955: hypothetical protein +FIG01047955 FIG01047956: hypothetical protein +FIG01047956 FIG01047959: hypothetical protein +FIG01047963 FIG01047964: hypothetical protein +FIG01047969 FIG01047974: hypothetical protein +FIG01047974 FIG01047977: hypothetical protein +FIG01047977 FIG01047978: hypothetical protein +FIG01047978 FIG01047979: hypothetical protein +FIG01047981 FIG01047988: hypothetical protein +FIG01047988 FIG01047991: hypothetical protein +FIG01047991 FIG01047995: hypothetical protein +FIG01048000 FIG01048001: hypothetical protein +FIG01048001 Conserved hypothetical bacteriophage protein +FIG01048013 FIG01048014: hypothetical protein +FIG01048018 FIG01048024: hypothetical protein +FIG01048025 FIG01048026: hypothetical protein +FIG01048027 FIG01048028: hypothetical protein +FIG01048030 FIG01048034: hypothetical protein +FIG01048037 FIG01048039: hypothetical protein +FIG01048048 FIG01048052: hypothetical protein +FIG01048052 FIG01048061: hypothetical protein +FIG01048066 FIG01048068: hypothetical protein +FIG01048068 FIG01048070: hypothetical protein +FIG01048070 FIG01048080: hypothetical protein +FIG01048084 putative cytoplasmic protein +FIG01048089 putative type-I secretion protein +FIG01048091 FIG01048099: hypothetical protein +FIG01048104 FIG01048105: hypothetical protein +FIG01048105 FIG01048117: hypothetical protein +FIG01048117 FIG01048118: hypothetical protein +FIG01048118 FIG01048127: hypothetical protein +FIG01048127 putative inner membrane lipoprotein +FIG01048142 Regulatory protein CII +FIG01048152 FIG01048153: hypothetical protein +FIG01048153 Sel1-like repeat +FIG01048154 VagD +FIG01048157 FIG01048160: hypothetical protein +FIG01048160 Possible transferase +FIG01048173 FIG01048174: hypothetical protein +FIG01048175 FIG01048180: hypothetical protein +FIG01048180 FIG01048183: hypothetical protein +FIG01048183 FIG01048187: hypothetical protein +FIG01048188 FIG01048189: hypothetical protein +FIG01048189 FIG01048190: hypothetical protein +FIG01048190 RepA1 +FIG01048196 FIG01048202: hypothetical protein +FIG01048214 FIG01048215: hypothetical protein +FIG01048222 FIG01048226: hypothetical protein +FIG01048226 FIG01048227: hypothetical protein +FIG01048233 FIG01048237: hypothetical protein +FIG01048237 FIG01048239: hypothetical protein +FIG01048246 FIG01048255: hypothetical protein +FIG01048255 FIG01048260: hypothetical protein +FIG01048260 FIG01048269: hypothetical protein +FIG01048269 Putative diguanylate cyclase/phosphodiesterase domain 1 +FIG01048270 FIG01048272: hypothetical protein +FIG01048275 FIG01048276: hypothetical protein +FIG01048276 FIG01048277: hypothetical protein +FIG01048279 antirepressor-like protein +FIG01048286 FIG01048296: hypothetical protein +FIG01048296 FIG01048299: hypothetical protein +FIG01048306 FIG01048307: hypothetical protein +FIG01048307 FIG01068690: hypothetical protein +FIG01048312 FIG01048313: hypothetical protein +FIG01048321 FIG01048327: hypothetical protein +FIG01048331 putative galactose mutarotase +FIG01048344 hypothetical protein +FIG01048350 FIG01048353: hypothetical protein +FIG01048353 FIG01048359: hypothetical protein +FIG01048383 FIG01048384: hypothetical protein +FIG01048384 FIG01048391: hypothetical protein +FIG01048400 hypothetical protein +FIG01048415 FIG01048419: hypothetical protein +FIG01048422 FIG01048426: hypothetical protein +FIG01048426 FIG01048427: hypothetical protein +FIG01048429 FIG01048436: hypothetical protein +FIG01048466 FIG01048471: hypothetical protein +FIG01048479 FIG01048481: hypothetical protein +FIG01048493 FIG01048495: hypothetical protein +FIG01048495 FIG01048497: hypothetical protein +FIG01048497 FIG01048500: hypothetical protein +FIG01048502 FIG01048503: hypothetical protein +FIG01048504 FIG01048505: hypothetical protein +FIG01048505 FIG01048507: hypothetical protein +FIG01048507 FIG01048508: hypothetical protein +FIG01048512 FIG01048515: hypothetical protein +FIG01048529 FIG01048531: hypothetical protein +FIG01048531 FIG01048532: hypothetical protein +FIG01048536 involved in conjugative DNA transfer +FIG01048546 FIG01048567: hypothetical protein +FIG01048588 FIG01048594: hypothetical protein +FIG01048594 FIG01048595: hypothetical protein +FIG01048597 FIG01048598: hypothetical protein +FIG01048598 FIG01048612: hypothetical protein +FIG01048613 FIG01048616: hypothetical protein +FIG01048616 FIG01048622: hypothetical protein +FIG01048622 FIG01048628: hypothetical protein +FIG01048628 FIG01048632: hypothetical protein +FIG01048633 FIG01048634: hypothetical protein +FIG01048644 FIG01048645: hypothetical protein +FIG01048647 FIG01048649: hypothetical protein +FIG01048649 hypothetical protein +FIG01048655 FIG01048659: hypothetical protein +FIG01048659 FIG01048660: hypothetical protein +FIG01048663 Phage DNA-binding protein +FIG01048666 FIG01048668: hypothetical protein +FIG01048677 FIG01048679: hypothetical protein +FIG01048685 FIG01048690: hypothetical protein +FIG01048690 YagA protein +FIG01048695 FIG01048706: hypothetical protein +FIG01048721 FIG01048722: hypothetical protein +FIG01048722 FIG01048723: hypothetical protein +FIG01048725 FIG01048726: hypothetical protein +FIG01048728 FIG01048731: hypothetical protein +FIG01048733 Putative secreted protein +FIG01048734 FIG01048735: hypothetical protein +FIG01048740 FIG01048757: hypothetical protein +FIG01048764 FIG01048770: hypothetical protein +FIG01048789 putative chitinase +FIG01048790 FIG01048799: hypothetical protein +FIG01048838 FIG01048842: hypothetical protein +FIG01048851 putative endoprotease +FIG01048853 FIG01048854: hypothetical protein +FIG01048864 FIG01048865: hypothetical protein +FIG01048869 FIG01048870: hypothetical protein +FIG01048870 FIG01048886: hypothetical protein +FIG01048886 FIG01048891: hypothetical protein +FIG01048891 FIG01048892: hypothetical protein +FIG01048892 FIG01048896: hypothetical protein +FIG01048900 FIG01048903: hypothetical protein +FIG01048908 FIG01048909: hypothetical protein +FIG01048909 conserved phage protein +FIG01048918 FIG01048919: hypothetical protein +FIG01048919 FIG01048924: hypothetical protein +FIG01048924 FIG01048930: hypothetical protein +FIG01048951 FIG01048953: hypothetical protein +FIG01048953 FIG01048970: hypothetical protein +FIG01048982 FIG01048983: hypothetical protein +FIG01048987 FIG01048991: hypothetical protein +FIG01048994 invasion plasmid antigen +FIG01048996 Outer membrane fimbrial usher protein +FIG01049002 FIG01049004: hypothetical protein +FIG01049004 FIG01049009: hypothetical protein +FIG01049010 FIG01049015: hypothetical protein +FIG01049015 Type I restriction-modification system methylation subunit +FIG01049026 FIG01049029: hypothetical protein +FIG01049029 FIG01049033: hypothetical protein +FIG01049033 Replication gene B protein +FIG01049036 hypothetical protein +FIG01049046 FIG01049047: hypothetical protein +FIG01049047 FIG01049048: hypothetical protein +FIG01049049 FIG01049053: hypothetical protein +FIG01049062 corresponds to STY0478 from Accession AL513382: Salmonella typhi CT18 +FIG01049084 FIG01049085: hypothetical protein +FIG01049089 FIG01049106: hypothetical protein +FIG01049117 Phage holin, class II +FIG01049125 FIG01049126: hypothetical protein +FIG01049126 Mnt +FIG01049132 FIG01049133: hypothetical protein +FIG01049142 FIG01049143: hypothetical protein +FIG01049143 FIG01049144: hypothetical protein +FIG01049155 FIG01049160: hypothetical protein +FIG01049163 FIG01049164: hypothetical protein +FIG01049170 FIG01049172: hypothetical protein +FIG01049173 FIG01049183: hypothetical protein +FIG01049184 FIG01049191: hypothetical protein +FIG01049219 FIG01049220: hypothetical protein +FIG01049225 FIG01049226: hypothetical protein +FIG01049231 FIG01049233: hypothetical protein +FIG01049233 FIG01049236: hypothetical protein +FIG01049254 FIG01049259: hypothetical protein +FIG01049259 FIG01049265: hypothetical protein +FIG01049272 FIG00638178: hypothetical protein +FIG01049278 FIG01049280: hypothetical protein +FIG01049280 Helicase, C-terminal:Type III restriction enzyme, res subunit:DEAD/DEAH box helicase, N-terminal +FIG01049310 Type II restriction enzyme, methylase subunits +FIG01049336 FIG01049337: hypothetical protein +FIG01049337 FIG01049339: hypothetical protein +FIG01049349 FIG01049352: hypothetical protein +FIG01049352 FIG01049354: hypothetical protein +FIG01049365 FIG01049377: hypothetical protein +FIG01049378 FIG01049382: hypothetical protein +FIG01049431 FIG01049434: hypothetical protein +FIG01049435 FIG01049441: hypothetical protein +FIG01049456 FIG01049487: hypothetical protein +FIG01049524 FIG01049527: hypothetical protein +FIG01049537 FIG01049538: hypothetical protein +FIG01049545 FIG01049552: hypothetical protein +FIG01049552 FIG01049556: hypothetical protein +FIG01049556 FIG01049561: hypothetical protein +FIG01049561 FIG01049562: hypothetical protein +FIG01049570 Phage Nin protein +FIG01049571 FIG01049577: hypothetical protein +FIG01049578 FIG01049580: hypothetical protein +FIG01049610 FIG01049612: hypothetical protein +FIG01049652 FIG01049662: hypothetical protein +FIG01049700 FIG01049711: hypothetical protein +FIG01049726 FIG01049728: hypothetical protein +FIG01049728 FIG01049733: hypothetical protein +FIG01049739 FIG01049758: hypothetical protein +FIG01049770 FIG01049772: hypothetical protein +FIG01049785 FIG01049786: hypothetical protein +FIG01049790 FIG01049801: hypothetical protein +FIG01049803 FIG01049815: hypothetical protein +FIG01049815 FIG01049821: hypothetical protein +FIG01049937 aldose epimerase +FIG01049946 FIG01049960: hypothetical protein +FIG01049960 FIG01049962: hypothetical protein +FIG01049962 FIG01049965: hypothetical protein +FIG01050042 ferrichrome ABC transporter (ferrichrome-binding protein) +FIG01050051 predicted TIM-barrel fold metal-dependent hydrolase +FIG01050058 predicted hydrolase or acyltransferase of alpha/beta superfamily +FIG01050103 FIG01050116: hypothetical protein +FIG01050149 glucosyltransferase protein +FIG01050174 FIG01050176: hypothetical protein +FIG01050180 FIG01050206: hypothetical protein +FIG01050252 FIG01050255: hypothetical protein +FIG01050274 predicted branched-chain amino acid permease (azaleucine resistance) +FIG01050313 FIG01050318: hypothetical protein +FIG01050335 FIG01050343: hypothetical protein +FIG01050359 Cna B-type +FIG01050382 arabinose efflux permease family protein +FIG01050441 FIG01050453: hypothetical protein +FIG01050490 FIG01050506: hypothetical protein +FIG01050595 FIG01050598: hypothetical protein +FIG01050641 FIG01050643: hypothetical protein +FIG01050665 FIG01050685: hypothetical protein +FIG01050775 FIG01050777: hypothetical protein +FIG01050809 FIG01050822: hypothetical protein +FIG01050877 uncharacterized conserved protein, contains FHA domain +FIG01050889 FIG01050896: hypothetical protein +FIG01050961 FIG01050968: hypothetical protein +FIG01051018 FIG01121108: hypothetical protein +FIG01051035 FIG01051037: hypothetical protein +FIG01051095 FIG01051101: hypothetical protein +FIG01051108 FIG01051120: hypothetical protein +FIG01051132 FIG01051140: hypothetical protein +FIG01051195 FIG01051198: hypothetical protein +FIG01051229 dehydrogenase of unknown specificity, short-chain alcohol dehydrogenase like protein +FIG01051298 FIG01051300: hypothetical protein +FIG01051403 FIG01051405: hypothetical protein +FIG01051414 FIG01051421: hypothetical protein +FIG01051519 FIG01051526: hypothetical protein +FIG01051526 FIG01051528: hypothetical protein +FIG01051540 FIG01051543: hypothetical protein +FIG01051560 FIG01051564: hypothetical protein +FIG01051594 FIG01051597: hypothetical protein +FIG01051597 FIG01051606: hypothetical protein +FIG01051606 FIG01051608: hypothetical protein +FIG01051668 FIG01051675: hypothetical protein +FIG01051675 FIG01051686: hypothetical protein +FIG01051686 Gll1411 protein +FIG01051708 possible DNA binding protein +FIG01051714 FIG01051724: hypothetical protein +FIG01051736 FIG01051737: hypothetical protein +FIG01051737 FIG01051756: hypothetical protein +FIG01051837 FIG01051838: hypothetical protein +FIG01051865 FIG01051872: hypothetical protein +FIG01051873 FIG01051895: hypothetical protein +FIG01052415 FIG01052423: hypothetical protein +FIG01052618 FIG01052623: hypothetical protein +FIG01052675 branched-chain amino acid transporter +FIG01053564 putative PTS system IIA component +FIG01053583 Sugar-binding periplasmic proteins/domains +FIG01053733 PTS system, fructose-specific IIBC component (EC 2.7.1.69) +FIG01053985 periplasmic pectic oligomers binding protein +FIG01054233 Leucyl aminopeptidase +FIG01054472 probable PTS system +FIG01054488 PROTEASE( EC:3.4.- ) +FIG01054616 FIG01054617: hypothetical protein +FIG01054617 FIG01054618: hypothetical protein +FIG01054618 Thioredoxin:Thioredoxin type domain:Thioredoxin domain 2 +FIG01054620 FIG01054622: hypothetical protein +FIG01054622 FIG01054623: hypothetical protein +FIG01054625 FIG01054626: hypothetical protein +FIG01054627 FIG01054628: hypothetical protein +FIG01054634 FIG01054636: hypothetical protein +FIG01054640 FIG01054642: hypothetical protein +FIG01054644 FIG01054645: hypothetical protein +FIG01054646 FIG01054648: hypothetical protein +FIG01054650 Hexokinase( EC:2.7.1.1 ) +FIG01054658 FIG01054660: hypothetical protein +FIG01054664 FIG01054665: hypothetical protein +FIG01054666 FIG01054669: hypothetical protein +FIG01054669 FIG01054670: hypothetical protein +FIG01054670 FIG01054671: hypothetical protein +FIG01054671 FIG01054672: hypothetical protein +FIG01054672 FIG01054673: hypothetical protein +FIG01054674 FIG01054675: hypothetical protein +FIG01054675 FIG01054676: hypothetical protein +FIG01054676 FIG01054677: hypothetical protein +FIG01054682 FIG01054684: hypothetical protein +FIG01054684 FIG01054685: hypothetical protein +FIG01054685 FIG01054686: hypothetical protein +FIG01054691 FIG01054692: hypothetical protein +FIG01054693 FIG01054695: hypothetical protein +FIG01054696 FIG01054697: hypothetical protein +FIG01054697 FIG01054699: hypothetical protein +FIG01054699 FIG01054700: hypothetical protein +FIG01054700 FIG01054702: hypothetical protein +FIG01054703 FIG01054704: hypothetical protein +FIG01054704 FIG01054706: hypothetical protein +FIG01054714 FIG01054715: hypothetical protein +FIG01054715 protein of unknown function DUF502 +FIG01054716 FIG01054717: hypothetical protein +FIG01054717 Peptidase A24A, prepilin type IV:Peptidase A24A, N-terminal +FIG01054722 FIG01054723: hypothetical protein +FIG01054724 FIG01054725: hypothetical protein +FIG01054725 putative UDP-glucuronosyltransferase +FIG01054726 protein of unknown function DUF1078 domain protein +FIG01054729 FIG01054730: hypothetical protein +FIG01054736 Ferrichrome transport system permease protein fhuB (TC 3.A.1.14.3) +FIG01054741 Nitrogenase iron-molibdenum cofactor biosinthesis protein, gene nifE +FIG01054746 FIG01054747: hypothetical protein +FIG01054747 FIG01054748: hypothetical protein +FIG01054749 FIG01054750: hypothetical protein +FIG01054750 Transcriptional repressor of class III stress genes-like protein +FIG01054753 FIG01054755: hypothetical protein +FIG01054755 FIG01054756: hypothetical protein +FIG01054757 FIG01054758: hypothetical protein +FIG01054758 Fe2+ ABC transporter, permease protein 2 +FIG01054762 FIG01054763: hypothetical protein +FIG01054764 FIG01054765: hypothetical protein +FIG01054765 FIG01054766: hypothetical protein +FIG01054766 FIG01054767: hypothetical protein +FIG01054771 FIG01054772: hypothetical protein +FIG01054772 FIG01054773: hypothetical protein +FIG01054773 FIG01054774: hypothetical protein +FIG01054777 FIG01054778: hypothetical protein +FIG01054778 rRNA methylase( EC:2.1.1.- ) +FIG01054784 FIG01054785: hypothetical protein +FIG01054786 FIG01054789: hypothetical protein +FIG01054789 Phytochrome sensor diguanylate cyclase/phosphodiesterase +FIG01054790 FIG01054792: hypothetical protein +FIG01054792 FIG01054793: hypothetical protein +FIG01054793 FIG01054797: hypothetical protein +FIG01054797 FIG01054798: hypothetical protein +FIG01054798 FIG01054799: hypothetical protein +FIG01054800 FIG01054801: hypothetical protein +FIG01054804 FIG01054805: hypothetical protein +FIG01054805 FIG01054807: hypothetical protein +FIG01054808 FIG01054811: hypothetical protein +FIG01054812 FIG01054813: hypothetical protein +FIG01054815 FIG01054816: hypothetical protein +FIG01054816 FIG01054818: hypothetical protein +FIG01054819 FIG01054823: hypothetical protein +FIG01054826 FIG01054827: hypothetical protein +FIG01054827 FIG01054829: hypothetical protein +FIG01054829 FIG01054830: hypothetical protein +FIG01054838 FIG01054839: hypothetical protein +FIG01054841 FIG01054842: hypothetical protein +FIG01054845 FIG01054847: hypothetical protein +FIG01054850 methylmalonyl-CoA decarboxylase delta-subunit +FIG01054852 FIG01054853: hypothetical protein +FIG01054853 FIG01054855: hypothetical protein +FIG01054855 FIG01054856: hypothetical protein +FIG01054859 FIG01054860: hypothetical protein +FIG01054860 FIG01054861: hypothetical protein +FIG01054861 FIG01054862: hypothetical protein +FIG01054862 FIG01054863: hypothetical protein +FIG01054864 protein of unknown function DUF464 +FIG01054866 protein of unknown function DUF1290 +FIG01054874 FIG01054876: hypothetical protein +FIG01054876 FIG01054878: hypothetical protein +FIG01054878 FIG01054880: hypothetical protein +FIG01054880 FIG01054883: hypothetical protein +FIG01054898 FIG01054900: hypothetical protein +FIG01054901 Flagellar hook-associated protein fliD +FIG01054905 FIG01054907: hypothetical protein +FIG01054907 FIG01054908: hypothetical protein +FIG01054910 Molybdopterin biosynthesis enzyme +FIG01054913 FIG01054914: hypothetical protein +FIG01054915 FIG01054916: hypothetical protein +FIG01054916 FIG01054917: hypothetical protein +FIG01054918 Undecaprenyl-phosphate galactose phosphotransferase( EC:2.7.8.6 ) +FIG01054927 FIG01054928: hypothetical protein +FIG01054931 FIG01054932: hypothetical protein +FIG01054932 FIG01054933: hypothetical protein +FIG01054938 COG0861: Membrane protein TerC, possibly involved in tellurium resistance +FIG01054943 FIG01054944: hypothetical protein +FIG01054944 FIG01054945: hypothetical protein +FIG01054945 FIG01054948: hypothetical protein +FIG01054952 FIG01054955: hypothetical protein +FIG01054955 FIG01054956: hypothetical protein +FIG01054956 FIG01054957: hypothetical protein +FIG01054957 FIG01054958: hypothetical protein +FIG01054965 FIG01054966: hypothetical protein +FIG01054966 FIG01054968: hypothetical protein +FIG01054970 FIG01054971: hypothetical protein +FIG01054972 FIG01054973: hypothetical protein +FIG01054973 FIG01054974: hypothetical protein +FIG01054976 copper amine oxidase-like +FIG01054985 FIG01054986: hypothetical protein +FIG01054986 FIG01054987: hypothetical protein +FIG01054987 FIG01054988: hypothetical protein +FIG01054990 FIG01054991: hypothetical protein +FIG01054991 FIG01054993: hypothetical protein +FIG01054993 FIG01054994: hypothetical protein +FIG01054995 FIG01054997: hypothetical protein +FIG01054998 FIG01055000: hypothetical protein +FIG01055001 FIG01055002: hypothetical protein +FIG01055002 FIG01055003: hypothetical protein +FIG01055003 FIG01055004: hypothetical protein +FIG01055005 FIG01055006: hypothetical protein +FIG01055006 FIG01055007: hypothetical protein +FIG01055012 FIG01055013: hypothetical protein +FIG01055013 FIG01055014: hypothetical protein +FIG01055016 FIG01055017: hypothetical protein +FIG01055019 FIG01055020: hypothetical protein +FIG01055023 FIG01055026: hypothetical protein +FIG01055027 FIG01055029: hypothetical protein +FIG01055036 FIG01055037: hypothetical protein +FIG01055037 FIG01055038: hypothetical protein +FIG01055041 FIG01055042: hypothetical protein +FIG01055042 FIG01055043: hypothetical protein +FIG01055044 FIG01055046: hypothetical protein +FIG01055046 FIG01055047: hypothetical protein +FIG01055051 Carboxylesterase( EC:3.1.1.1 ) +FIG01055052 FIG01055054: hypothetical protein +FIG01055054 FIG01055055: hypothetical protein +FIG01055055 FIG01055057: hypothetical protein +FIG01055064 FIG01055065: hypothetical protein +FIG01055067 FIG01055068: hypothetical protein +FIG01055068 FIG01055069: hypothetical protein +FIG01055070 High-affinity zinc uptake system protein znuA precursor +FIG01055073 FIG01055074: hypothetical protein +FIG01055076 FIG01055077: hypothetical protein +FIG01055077 FIG01055079: hypothetical protein +FIG01055080 FIG01055081: hypothetical protein +FIG01055085 FIG01055086: hypothetical protein +FIG01055089 FIG01055090: hypothetical protein +FIG01055090 FIG01055091: hypothetical protein +FIG01055095 FIG01055096: hypothetical protein +FIG01055099 FIG01055100: hypothetical protein +FIG01055100 FIG01055102: hypothetical protein +FIG01055102 FIG01055104: hypothetical protein +FIG01055106 FIG01055107: hypothetical protein +FIG01055109 FIG01055110: hypothetical protein +FIG01055110 putative acyl-CoA thioester hydrolase +FIG01055113 FIG01055114: hypothetical protein +FIG01055116 FIG01055117: hypothetical protein +FIG01055118 FIG01055119: hypothetical protein +FIG01055119 FIG01055120: hypothetical protein +FIG01055120 FIG01055121: hypothetical protein +FIG01055122 FIG01055123: hypothetical protein +FIG01055123 FIG01055124: hypothetical protein +FIG01055127 FIG01055128: hypothetical protein +FIG01055129 FIG01055130: hypothetical protein +FIG01055135 FIG01055138: hypothetical protein +FIG01055139 Putative carbohydrate kinase, FGGY family +FIG01055142 RNA polymerase delta subunit +FIG01055146 FIG01055147: hypothetical protein +FIG01055147 FIG01055149: hypothetical protein +FIG01055150 FIG01055153: hypothetical protein +FIG01055159 FIG01055161: hypothetical protein +FIG01055164 FIG01055165: hypothetical protein +FIG01055165 FIG01055166: hypothetical protein +FIG01055166 FIG01055167: hypothetical protein +FIG01055169 FIG01055170: hypothetical protein +FIG01055170 FIG01055171: hypothetical protein +FIG01055171 FIG01055172: hypothetical protein +FIG01055173 Nitrogenase FeMo-cofactor scaffold and assembly protein NifE +FIG01055181 protein of unknown function DUF795 +FIG01055182 FIG01055184: hypothetical protein +FIG01055184 FIG01055185: hypothetical protein +FIG01055186 FIG01055187: hypothetical protein +FIG01055189 FIG01055190: hypothetical protein +FIG01055190 FIG01055192: hypothetical protein +FIG01055192 FIG01055193: hypothetical protein +FIG01055195 FIG01055196: hypothetical protein +FIG01055197 FIG01055198: hypothetical protein +FIG01055199 FIG01055200: hypothetical protein +FIG01055200 FIG01055201: hypothetical protein +FIG01055202 FIG01055203: hypothetical protein +FIG01055204 FIG01055208: hypothetical protein +FIG01055208 lipoprotein ABC transporter, ATP-binding protein LolD +FIG01055211 FIG01055212: hypothetical protein +FIG01055212 FIG01055213: hypothetical protein +FIG01055213 FIG01055214: hypothetical protein +FIG01055214 FIG01055216: hypothetical protein +FIG01055216 FIG01055217: hypothetical protein +FIG01055224 FIG01055225: hypothetical protein +FIG01055225 FIG01055226: hypothetical protein +FIG01055226 FIG01055227: hypothetical protein +FIG01055227 FIG01055228: hypothetical protein +FIG01055228 FIG01055229: hypothetical protein +FIG01055232 FIG01055233: hypothetical protein +FIG01055233 FIG01055234: hypothetical protein +FIG01055243 FIG01055244: hypothetical protein +FIG01055245 FIG01055246: hypothetical protein +FIG01055248 cytochrome c-type biogenesis protein CcmE, putative +FIG01055255 FIG01055256: hypothetical protein +FIG01055257 FIG01055258: hypothetical protein +FIG01055258 FIG01055259: hypothetical protein +FIG01055265 FIG01055266: hypothetical protein +FIG01055266 FIG01055267: hypothetical protein +FIG01055277 FIG01055278: hypothetical protein +FIG01055279 sigma-54 interaction domain family +FIG01055281 FIG01055282: hypothetical protein +FIG01055282 FIG01055283: hypothetical protein +FIG01055285 FIG01055287: hypothetical protein +FIG01055287 FIG01055289: hypothetical protein +FIG01055289 FIG01055290: hypothetical protein +FIG01055296 FIG01055299: hypothetical protein +FIG01055301 FIG01055303: hypothetical protein +FIG01055308 Putative hemolysin activator protein +FIG01055310 FIG01055313: hypothetical protein +FIG01055313 FIG01055314: hypothetical protein +FIG01055316 FIG01055317: hypothetical protein +FIG01055327 FIG01055330: hypothetical protein +FIG01055331 FIG01055332: hypothetical protein +FIG01055332 FIG01055334: hypothetical protein +FIG01055334 FIG01055335: hypothetical protein +FIG01055335 FIG01055336: hypothetical protein +FIG01055336 FIG01055337: hypothetical protein +FIG01055342 FIG01055343: hypothetical protein +FIG01055343 FIG01055344: hypothetical protein +FIG01055346 FIG01055349: hypothetical protein +FIG01055349 FIG01055351: hypothetical protein +FIG01055351 FIG01055353: hypothetical protein +FIG01055354 FIG01055355: hypothetical protein +FIG01055361 FIG01055362: hypothetical protein +FIG01055362 FIG01055363: hypothetical protein +FIG01055366 FIG01055367: hypothetical protein +FIG01055367 FIG01055368: hypothetical protein +FIG01055368 FIG01055372: hypothetical protein +FIG01055372 FIG01055373: hypothetical protein +FIG01055373 FIG01055376: hypothetical protein +FIG01055376 FIG01055377: hypothetical protein +FIG01055377 FIG01055378: hypothetical protein +FIG01055378 FIG01055379: hypothetical protein +FIG01055381 Prophage P2 OGR protein +FIG01055397 HmsT protein +FIG01055401 FIG01055403: hypothetical protein +FIG01055403 FIG01055405: hypothetical protein +FIG01055406 FIG01055407: hypothetical protein +FIG01055410 FIG01055411: hypothetical protein +FIG01055412 FIG01055413: hypothetical protein +FIG01055413 FIG01055416: hypothetical protein +FIG01055416 FIG01055417: hypothetical protein +FIG01055419 Hok/gef cell toxic protein +FIG01055421 FIG01220350: hypothetical protein +FIG01055427 FIG01055429: hypothetical protein +FIG01055429 Putative periplasmic solute-binding protein +FIG01055433 FIG01055434: hypothetical protein +FIG01055436 FIG01055437: hypothetical protein +FIG01055437 FIG01055438: hypothetical protein +FIG01055438 FIG01055439: hypothetical protein +FIG01055439 FIG01055441: hypothetical protein +FIG01055447 FIG01055452: hypothetical protein +FIG01055455 FIG01055456: hypothetical protein +FIG01055456 FIG01055459: hypothetical protein +FIG01055460 FIG01055461: hypothetical protein +FIG01055462 FIG01055464: hypothetical protein +FIG01055473 FIG01055476: hypothetical protein +FIG01055476 FIG01055478: hypothetical protein +FIG01055478 FIG01055479: hypothetical protein +FIG01055479 FIG01055480: hypothetical protein +FIG01055480 FIG01055481: hypothetical protein +FIG01055481 FIG01055482: hypothetical protein +FIG01055482 FIG01055484: hypothetical protein +FIG01055484 Sugar-phosphate stress protein SgrT (embedded in SgrS) +FIG01055493 FIG01055496: hypothetical protein +FIG01055502 FIG01055504: hypothetical protein +FIG01055504 FIG00511031: hypothetical protein +FIG01055506 FIG01055508: hypothetical protein +FIG01055508 FIG01055509: hypothetical protein +FIG01055511 FIG01055512: hypothetical protein +FIG01055512 FIG01055513: hypothetical protein +FIG01055513 FIG01055514: hypothetical protein +FIG01055519 FIG01055520: hypothetical protein +FIG01055525 FIG01055528: hypothetical protein +FIG01055529 FIG01055530: hypothetical protein +FIG01055531 FIG01055532: hypothetical protein +FIG01055534 FIG01055535: hypothetical protein +FIG01055535 FIG01055536: hypothetical protein +FIG01055550 FIG01055554: hypothetical protein +FIG01055554 putative transcriptional regulator protein (AraC family) +FIG01055580 FIG01055581: hypothetical protein +FIG01055584 FIG01055585: hypothetical protein +FIG01055586 FIG01055587: hypothetical protein +FIG01055587 FIG01055588: hypothetical protein +FIG01055588 FIG01055590: hypothetical protein +FIG01055590 FIG01055591: hypothetical protein +FIG01055591 probable ABC transporter, ATP-binding protein +FIG01055593 FIG01055596: hypothetical protein +FIG01055596 FIG01055597: hypothetical protein +FIG01055600 FIG01055601: hypothetical protein +FIG01055602 FIG01055603: hypothetical protein +FIG01055608 FIG01055609: hypothetical protein +FIG01055612 FIG01055613: hypothetical protein +FIG01055613 FIG01055614: hypothetical protein +FIG01055617 FIG01055618: hypothetical protein +FIG01055618 putative pectin degradation protein (sugar phosphate isomerase family) +FIG01055623 FIG01055624: hypothetical protein +FIG01055625 FIG01055628: hypothetical protein +FIG01055628 FIG01055629: hypothetical protein +FIG01055632 FIG01055633: hypothetical protein +FIG01055634 FIG01055636: hypothetical protein +FIG01055641 FIG01055643: hypothetical protein +FIG01055643 FIG01055645: hypothetical protein +FIG01055649 FIG01055650: hypothetical protein +FIG01055655 FIG01055656: hypothetical protein +FIG01055656 FIG01055658: hypothetical protein +FIG01055659 FIG01055660: hypothetical protein +FIG01055662 FIG01055664: hypothetical protein +FIG01055664 FIG01055667: hypothetical protein +FIG01055667 FIG01055669: hypothetical protein +FIG01055677 FIG01055678: hypothetical protein +FIG01055678 FIG01055679: hypothetical protein +FIG01055683 FIG01055684: hypothetical protein +FIG01055684 FIG01055685: hypothetical protein +FIG01055685 FIG01055690: hypothetical protein +FIG01055690 protein of unknown function DUF1304 +FIG01055694 FIG01055695: hypothetical protein +FIG01055699 FIG01055700: hypothetical protein +FIG01055705 acetyltransferase, GNAT family , putative +FIG01055713 LysR family transcriptional regulator QseA +FIG01055723 FIG01055724: hypothetical protein +FIG01055724 extracellular secretory protein nucE +FIG01055731 metalloprotease inhibitor I38 +FIG01055741 FIG01055746: hypothetical protein +FIG01055746 FIG01055748: hypothetical protein +FIG01055753 FIG01055754: hypothetical protein +FIG01055755 FIG01055756: hypothetical protein +FIG01055757 FIG01055758: hypothetical protein +FIG01055764 FIG01055767: hypothetical protein +FIG01055769 FIG01055770: hypothetical protein +FIG01055770 FIG00895529: hypothetical protein +FIG01055771 FIG01055772: hypothetical protein +FIG01055785 FIG01055786: hypothetical protein +FIG01055786 FIG01055790: hypothetical protein +FIG01055791 FIG01055795: hypothetical protein +FIG01055795 FIG01055796: hypothetical protein +FIG01055797 FIG01055799: hypothetical protein +FIG01055801 FIG01055802: hypothetical protein +FIG01055802 FIG01055803: hypothetical protein +FIG01055803 FIG01055804: hypothetical protein +FIG01055811 FIG01055813: hypothetical protein +FIG01055817 FIG01055819: hypothetical protein +FIG01055819 FIG01055820: hypothetical protein +FIG01055820 FIG01055823: hypothetical protein +FIG01055823 FIG01055826: hypothetical protein +FIG01055826 SirA-like domain-containing protein +FIG01055829 FIG01055831: hypothetical protein +FIG01055839 FIG01055840: hypothetical protein +FIG01055843 FIG01055844: hypothetical protein +FIG01055844 FIG01055846: hypothetical protein +FIG01055856 FIG01055858: hypothetical protein +FIG01055858 FIG01055859: hypothetical protein +FIG01055866 FIG01055867: hypothetical protein +FIG01055871 FIG01055872: hypothetical protein +FIG01055872 FIG01055876: hypothetical protein +FIG01055878 FIG01055880: hypothetical protein +FIG01055888 FIG01055891: hypothetical protein +FIG01055891 FIG01055893: hypothetical protein +FIG01055924 FIG01055925: hypothetical protein +FIG01055926 FIG01055928: hypothetical protein +FIG01055928 FIG01055929: hypothetical protein +FIG01055929 FIG01055933: hypothetical protein +FIG01055935 FIG01055937: hypothetical protein +FIG01055943 Major facilitator superfamily +FIG01055944 FIG01055945: hypothetical protein +FIG01055947 FIG01055948: hypothetical protein +FIG01055948 FIG01055952: hypothetical protein +FIG01055953 Putative minor fimbrial subunit +FIG01055954 FIG01055955: hypothetical protein +FIG01055965 FIG01055966: hypothetical protein +FIG01055966 FIG01055967: hypothetical protein +FIG01055967 FIG01055970: hypothetical protein +FIG01055971 FIG01055972: hypothetical protein +FIG01055979 FIG01055980: hypothetical protein +FIG01055986 FIG01055987: hypothetical protein +FIG01055987 FIG01055989: hypothetical protein +FIG01055989 FIG01055990: hypothetical protein +FIG01055994 FIG01055998: hypothetical protein +FIG01056005 FIG01056006: hypothetical protein +FIG01056009 FIG01056014: hypothetical protein +FIG01056014 FIG01056015: hypothetical protein +FIG01056022 FIG01056027: hypothetical protein +FIG01056028 FIG01056029: hypothetical protein +FIG01056029 Esterase/lipase/thioesterase (EC 3.1.1.3) +FIG01056033 FIG01056034: hypothetical protein +FIG01056034 FIG01056037: hypothetical protein +FIG01056047 FIG01056049: hypothetical protein +FIG01056059 FIG01056060: hypothetical protein +FIG01056063 FIG01056065: hypothetical protein +FIG01056066 FIG01056067: hypothetical protein +FIG01056067 FIG01056068: hypothetical protein +FIG01056069 FIG01056070: hypothetical protein +FIG01056072 FIG01056074: hypothetical protein +FIG01056074 FIG01056075: hypothetical protein +FIG01056075 FIG00895504: hypothetical protein +FIG01056086 FIG01056087: hypothetical protein +FIG01056096 FIG01056098: hypothetical protein +FIG01056102 Unknown, probable recombinase involved in the regulation of fimbrial operon +FIG01056110 FIG01056111: hypothetical protein +FIG01056112 7,8-dihydro-8-oxoguanine-triphosphatase, putative( EC:3.6.1.- ) +FIG01056115 FIG01056117: hypothetical protein +FIG01056117 FIG01056118: hypothetical protein +FIG01056126 FIG01056128: hypothetical protein +FIG01056128 FIG01056132: hypothetical protein +FIG01056134 FIG01056136: hypothetical protein +FIG01056139 FIG01056140: hypothetical protein +FIG01056141 FIG01056145: hypothetical protein +FIG01056145 FIG01056146: hypothetical protein +FIG01056146 Regulatory protein soxS +FIG01056150 FIG01056153: hypothetical protein +FIG01056166 putative ORF-4 +FIG01056169 entry exclusion protein 2 (exc2) +FIG01056173 FIG01056174: hypothetical protein +FIG01056178 Swarming motility regulation protein rssB +FIG01056188 acetyltransferase, gnat family +FIG01056192 FIG01056194: hypothetical protein +FIG01056197 FIG01056198: hypothetical protein +FIG01056198 FIG01056199: hypothetical protein +FIG01056201 FIG01056203: hypothetical protein +FIG01056204 FIG01056205: hypothetical protein +FIG01056212 FIG01056215: hypothetical protein +FIG01056217 FIG01056218: hypothetical protein +FIG01056218 Lipoate-protein ligase A +FIG01056226 FIG01056228: hypothetical protein +FIG01056231 FIG01056233: hypothetical protein +FIG01056233 FIG01056235: hypothetical protein +FIG01056235 FIG01056236: hypothetical protein +FIG01056236 FIG01056237: hypothetical protein +FIG01056240 FIG01056241: hypothetical protein +FIG01056241 FIG01056244: hypothetical protein +FIG01056256 FIG01056257: hypothetical protein +FIG01056274 FIG01056275: hypothetical protein +FIG01056289 FIG01056292: hypothetical protein +FIG01056293 FIG01056294: hypothetical protein +FIG01056295 Conserved putative membrane protein precursor +FIG01056296 putative acyltransferase (PhnO) +FIG01056297 FIG01056298: hypothetical protein +FIG01056310 Putative multidrug resistance protein +FIG01056321 FIG01056322: hypothetical protein +FIG01056324 Putative lipoprotein protein precursor +FIG01056325 FIG00626754: hypothetical protein +FIG01056335 FIG01056338: hypothetical protein +FIG01056349 FIG01056350: hypothetical protein +FIG01056350 FIG01056353: hypothetical protein +FIG01056366 FIG01056367: hypothetical protein +FIG01056374 Putative amidohydrolase +FIG01056379 FIG01056381: hypothetical protein +FIG01056386 FIG01056387: hypothetical protein +FIG01056423 FIG01056426: hypothetical protein +FIG01056426 FIG01056428: hypothetical protein +FIG01056456 FIG01056457: hypothetical protein +FIG01056457 FIG01056458: hypothetical protein +FIG01056458 FIG01056459: hypothetical protein +FIG01056459 FIG01056462: hypothetical protein +FIG01056481 FIG01056482: hypothetical protein +FIG01056485 FIG01056489: hypothetical protein +FIG01056493 FIG01056494: hypothetical protein +FIG01056507 FIG01056508: hypothetical protein +FIG01056508 FIG01056509: hypothetical protein +FIG01056511 FIG01056512: hypothetical protein +FIG01056514 FIG01056516: hypothetical protein +FIG01056531 FIG01056534: hypothetical protein +FIG01056535 FIG01056537: hypothetical protein +FIG01056538 FIG01056539: hypothetical protein +FIG01056542 FIG01056543: hypothetical protein +FIG01056546 FIG01056549: hypothetical protein +FIG01056552 FIG01056553: hypothetical protein +FIG01056569 FIG01056571: hypothetical protein +FIG01056581 FIG01056582: hypothetical protein +FIG01056586 FIG01056587: hypothetical protein +FIG01056594 FIG01056596: hypothetical protein +FIG01056599 FIG01056600: hypothetical protein +FIG01056606 Membrane protein precursor +FIG01056632 FIG01056640: hypothetical protein +FIG01056643 FIG01056644: hypothetical protein +FIG01056644 FIG01056645: hypothetical protein +FIG01056646 FIG01056647: hypothetical protein +FIG01056650 FIG01056651: hypothetical protein +FIG01056651 FIG01056652: hypothetical protein +FIG01056658 FIG01056659: hypothetical protein +FIG01056659 FIG01056660: hypothetical protein +FIG01056664 FIG01056667: hypothetical protein +FIG01056667 FIG01056671: hypothetical protein +FIG01056671 FIG01056672: hypothetical protein +FIG01056672 Peptidoglycan-binding domain 1 +FIG01056674 FIG01056675: hypothetical protein +FIG01056676 FIG01056677: hypothetical protein +FIG01056677 Putative acriflavin resistence protein +FIG01056678 FIG01056680: hypothetical protein +FIG01056682 FIG01056684: hypothetical protein +FIG01056684 FIG01056686: hypothetical protein +FIG01056686 FIG01056687: hypothetical protein +FIG01056687 FIG01056688: hypothetical protein +FIG01056688 FIG01056689: hypothetical protein +FIG01056692 FIG01056693: hypothetical protein +FIG01056693 FIG01056694: hypothetical protein +FIG01056694 FIG01056698: hypothetical protein +FIG01056699 FIG01056700: hypothetical protein +FIG01056702 FIG01056704: hypothetical protein +FIG01056704 FIG01056705: hypothetical protein +FIG01056705 FIG01056706: hypothetical protein +FIG01056706 FIG01056707: hypothetical protein +FIG01056709 FIG01056711: hypothetical protein +FIG01056711 FIG01056713: hypothetical protein +FIG01056713 FIG01056714: hypothetical protein +FIG01056714 FIG01056715: hypothetical protein +FIG01056715 putative pullulanase precursor +FIG01056721 FIG01056722: hypothetical protein +FIG01056724 FIG01056725: hypothetical protein +FIG01056728 FIG01056729: hypothetical protein +FIG01056729 Methyl-accepting chemotaxis protein, homolog 6 +FIG01056730 FIG01056731: hypothetical protein +FIG01056731 FIG01056734: hypothetical protein +FIG01056734 FIG01056736: hypothetical protein +FIG01056736 FIG01056739: hypothetical protein +FIG01056739 FIG01056740: hypothetical protein +FIG01056740 FIG01056744: hypothetical protein +FIG01056744 FIG01056746: hypothetical protein +FIG01056746 FIG00949707: hypothetical protein +FIG01056747 FIG01056748: hypothetical protein +FIG01056748 FIG01056749: hypothetical protein +FIG01056749 FIG01056750: hypothetical protein +FIG01056750 FIG01056751: hypothetical protein +FIG01056751 FIG01056752: hypothetical protein +FIG01056752 FIG01056753: hypothetical protein +FIG01056753 Dihydrofolate reductase homolog +FIG01056754 FIG01056755: hypothetical protein +FIG01056758 FIG01056763: hypothetical protein +FIG01056763 FIG01056764: hypothetical protein +FIG01056768 FIG01056769: hypothetical protein +FIG01056771 FIG01056772: hypothetical protein +FIG01056772 FIG01056775: hypothetical protein +FIG01056778 FIG01056779: hypothetical protein +FIG01056779 FIG01056781: hypothetical protein +FIG01056781 FIG01056782: hypothetical protein +FIG01056782 FIG01056783: hypothetical protein +FIG01056783 Likely secreted protein containing plastocyanin domain +FIG01056786 FIG01056788: hypothetical protein +FIG01056790 FIG01056791: hypothetical protein +FIG01056791 FIG01056793: hypothetical protein +FIG01056793 FIG01056796: hypothetical protein +FIG01056797 FIG01056799: hypothetical protein +FIG01056800 FIG081498: hypothetical protein +FIG01056801 Diguanylate cyclase with GAF sensor +FIG01056803 FIG01056804: hypothetical protein +FIG01056807 FIG01056808: hypothetical protein +FIG01056808 FIG01056809: hypothetical protein +FIG01056809 FIG01056811: hypothetical protein +FIG01056815 Insulinase-like:Peptidase M16, C-terminal precursor +FIG01056819 FIG01056820: hypothetical protein +FIG01056820 FIG01056821: hypothetical protein +FIG01056821 FIG01056822: hypothetical protein +FIG01056822 FIG01056823: hypothetical protein +FIG01056823 FIG01056824: hypothetical protein +FIG01056824 FIG01056826: hypothetical protein +FIG01056826 Similar to ribosomal large subunit pseudouridine synthase F, group RluF2 +FIG01056829 FIG01056835: hypothetical protein +FIG01056835 FIG01056837: hypothetical protein +FIG01056837 FIG01056839: hypothetical protein +FIG01056840 FIG01056842: hypothetical protein +FIG01056842 FIG01056844: hypothetical protein +FIG01056847 FIG01056851: hypothetical protein +FIG01056851 FIG01056853: hypothetical protein +FIG01056854 FIG01056859: hypothetical protein +FIG01056859 FIG01056862: hypothetical protein +FIG01056862 FIG01056863: hypothetical protein +FIG01056864 Zinc finger-related protein +FIG01056865 UPF0319 protein VPA1584 precursor +FIG01056872 FIG01056873: hypothetical protein +FIG01056873 FIG01056876: hypothetical protein +FIG01056876 FIG01056879: hypothetical protein +FIG01056879 FIG01056881: hypothetical protein +FIG01056881 FIG01056882: hypothetical protein +FIG01056883 FIG01056884: hypothetical protein +FIG01056890 FIG01056897: hypothetical protein +FIG01056897 FIG01056900: hypothetical protein +FIG01056900 Slr0686 protein +FIG01056902 FIG01056903: hypothetical protein +FIG01056903 FIG01056904: hypothetical protein +FIG01056904 FIG01056905: hypothetical protein +FIG01056911 FIG01056912: hypothetical protein +FIG01056912 FIG01056913: hypothetical protein +FIG01056914 FIG01056915: hypothetical protein +FIG01056915 FIG01056919: hypothetical protein +FIG01056920 Putative membrane protein +FIG01056921 FIG01056923: hypothetical protein +FIG01056923 FIG01056924: hypothetical protein +FIG01056924 FIG01056925: hypothetical protein +FIG01056929 FIG01056932: hypothetical protein +FIG01056933 FIG01056937: hypothetical protein +FIG01056937 FIG01056938: hypothetical protein +FIG01056938 FIG01057998: hypothetical protein +FIG01056940 FIG01056942: hypothetical protein +FIG01056948 FIG01056949: hypothetical protein +FIG01056949 FIG01057932: hypothetical protein +FIG01056951 FIG01056953: hypothetical protein +FIG01056954 FIG01056955: hypothetical protein +FIG01056960 FIG01056961: hypothetical protein +FIG01056968 FIG01056969: hypothetical protein +FIG01056969 FIG01056970: hypothetical protein +FIG01056970 FIG01056972: hypothetical protein +FIG01056973 Ada regulatory protein +FIG01056974 FIG01056976: hypothetical protein +FIG01056977 FIG01056978: hypothetical protein +FIG01056978 FIG01056979: hypothetical protein +FIG01056979 FIG01056980: hypothetical protein +FIG01056980 FIG01056983: hypothetical protein +FIG01056985 FIG01056986: hypothetical protein +FIG01056987 FIG01056988: hypothetical protein +FIG01056988 FIG01056990: hypothetical protein +FIG01056990 FIG01056992: hypothetical protein +FIG01056993 FIG01056994: hypothetical protein +FIG01056994 FIG01056995: hypothetical protein +FIG01056995 Outer membrane porin F precursor +FIG01056996 FIG01056999: hypothetical protein +FIG01056999 FIG01057001: hypothetical protein +FIG01057010 FIG01057012: hypothetical protein +FIG01057012 FIG01057013: hypothetical protein +FIG01057016 FIG00564637: hypothetical protein +FIG01057017 alkyl sulfatase or beta-lactamase +FIG01057018 FIG01057019: hypothetical protein +FIG01057019 FIG01057020: hypothetical protein +FIG01057020 FIG01057021: hypothetical protein +FIG01057021 GGDEF domain family protein +FIG01057023 FIG01057024: hypothetical protein +FIG01057024 FIG01057025: hypothetical protein +FIG01057025 FIG01057028: hypothetical protein +FIG01057028 FIG01057029: hypothetical protein +FIG01057029 transporter, AcrB/D/F family +FIG01057030 FIG01057031: hypothetical protein +FIG01057032 FIG01057036: hypothetical protein +FIG01057036 FIG01057037: hypothetical protein +FIG01057037 FIG01057038: hypothetical protein +FIG01057038 FIG01057040: hypothetical protein +FIG01057041 FIG01057042: hypothetical protein +FIG01057042 FIG01057044: hypothetical protein +FIG01057046 FIG01057048: hypothetical protein +FIG01057048 diguanylate cyclase/phosphodiesterase (GGDEF & EAL domains) +FIG01057050 FIG01057052: hypothetical protein +FIG01057052 FIG01057053: hypothetical protein +FIG01057053 major outer membrane lipoprotein, putative +FIG01057055 FIG01057056: hypothetical protein +FIG01057057 FIG01057058: hypothetical protein +FIG01057058 FIG01057060: hypothetical protein +FIG01057063 FIG020302: hypothetical protein +FIG01057064 FIG01057066: hypothetical protein +FIG01057066 FIG01057067: hypothetical protein +FIG01057067 FIG01057069: hypothetical protein +FIG01057069 FIG01057071: hypothetical protein +FIG01057072 FIG01057073: hypothetical protein +FIG01057074 FIG01057075: hypothetical protein +FIG01057076 FIG01057081: hypothetical protein +FIG01057081 FIG01057095: hypothetical protein +FIG01057095 FIG01057098: hypothetical protein +FIG01057098 FIG01057100: hypothetical protein +FIG01057100 FIG01057101: hypothetical protein +FIG01057101 FIG01057104: hypothetical protein +FIG01057104 FIG01057105: hypothetical protein +FIG01057118 Outer membrane protein and related peptidoglycan-associated (Lipo) proteins +FIG01057119 FIG01057127: hypothetical protein +FIG01057127 putative factor; Replication (Phage or Prophage Related) +FIG01057128 FIG01057129: hypothetical protein +FIG01057129 FIG01057130: hypothetical protein +FIG01057130 FIG01057131: hypothetical protein +FIG01057132 FIG01057133: hypothetical protein +FIG01057133 FIG01057135: hypothetical protein +FIG01057137 FIG01057138: hypothetical protein +FIG01057139 FIG01057140: hypothetical protein +FIG01057140 FIG01057142: hypothetical protein +FIG01057143 FIG01057145: hypothetical protein +FIG01057147 Transcriptional regulator VC0068, LysR family +FIG01057152 FIG01057153: hypothetical protein +FIG01057154 Major facilitator superfamily precursor +FIG01057157 FIG01057158: hypothetical protein +FIG01057158 FIG01057159: hypothetical protein +FIG01057159 FIG01057160: hypothetical protein +FIG01057161 Signal transduction histidine kinase for Quinone-reactive Ni/Fe-hydrogenase +FIG01057168 FIG01057169: hypothetical protein +FIG01057170 FIG01057171: hypothetical protein +FIG01057172 FIG01057173: hypothetical protein +FIG01057174 FIG01057178: hypothetical protein +FIG01057178 Type III secretion injected virulence protein (YopH,tyrosine phosphatase of FAK and p130cas, prevents phagocytosis) +FIG01057186 FIG01057187: hypothetical protein +FIG01057189 FIG01057190: hypothetical protein +FIG01057193 FIG01057196: hypothetical protein +FIG01057197 FIG01057198: hypothetical protein +FIG01057200 FIG01057201: hypothetical protein +FIG01057201 FIG01057202: hypothetical protein +FIG01057202 FIG01057203: hypothetical protein +FIG01057203 FIG01057204: hypothetical protein +FIG01057205 FIG01057206: hypothetical protein +FIG01057206 FIG01062352: hypothetical protein +FIG01057209 FIG01057210: hypothetical protein +FIG01057211 FIG01057212: hypothetical protein +FIG01057212 FIG01057214: hypothetical protein +FIG01057214 FIG01057215: hypothetical protein +FIG01057215 FIG01057217: hypothetical protein +FIG01057217 FIG01057220: hypothetical protein +FIG01057220 FIG01057222: hypothetical protein +FIG01057222 FIG01057223: hypothetical protein +FIG01057223 FIG01057225: hypothetical protein +FIG01057227 FIG01057228: hypothetical protein +FIG01057228 FIG01057229: hypothetical protein +FIG01057229 FIG01057234: hypothetical protein +FIG01057234 FIG01057236: hypothetical protein +FIG01057236 FIG01057237: hypothetical protein +FIG01057239 FIG01057241: hypothetical protein +FIG01057241 FIG01057244: hypothetical protein +FIG01057247 FIG01057248: hypothetical protein +FIG01057248 FIG01057254: hypothetical protein +FIG01057256 FIG01057257: hypothetical protein +FIG01057257 FIG01057258: hypothetical protein +FIG01057265 FIG01057266: hypothetical protein +FIG01057266 FIG01057267: hypothetical protein +FIG01057267 FIG01057269: hypothetical protein +FIG01057269 FIG160851: peptidase +FIG01057271 FIG01057274: hypothetical protein +FIG01057274 FIG01057276: hypothetical protein +FIG01057276 FIG01057278: hypothetical protein +FIG01057278 FIG01057279: hypothetical protein +FIG01057283 FIG01057284: hypothetical protein +FIG01057284 FIG01057287: hypothetical protein +FIG01057287 FIG01057289: hypothetical protein +FIG01057291 Decarboxylase family protein +FIG01057293 FIG01057296: hypothetical protein +FIG01057296 Siderophore synthetase superfamily, group C @ Siderophore synthetase component, ligase +FIG01057297 FIG01057298: hypothetical protein +FIG01057298 FIG01057301: hypothetical protein +FIG01057301 FIG01057304: hypothetical protein +FIG01057304 FIG01057310: hypothetical protein +FIG01057312 FIG01057314: hypothetical protein +FIG01057314 Candidate 1: dienelactone hydrolase +FIG01057317 FIG01057320: hypothetical protein +FIG01057320 FIG01057324: hypothetical protein +FIG01057324 FIG01057326: hypothetical protein +FIG01057327 FIG01057329: hypothetical protein +FIG01057329 FIG01057333: hypothetical protein +FIG01057335 FIG01057338: hypothetical protein +FIG01057338 FIG01057339: hypothetical protein +FIG01057339 Chorismate mutase I (EC 5.4.99.5) / Prephenate dehydratase (EC 4.2.1.51) / 2-keto-3-deoxy-D-arabino-heptulosonate-7-phosphate synthase I beta (EC 2.5.1.54) +FIG01057343 FIG01057346: hypothetical protein +FIG01057352 FIG00949754: hypothetical protein +FIG01057354 FIG01057355: hypothetical protein +FIG01057355 FIG01057357: hypothetical protein +FIG01057357 FIG01057359: hypothetical protein +FIG01057359 FIG01057361: hypothetical protein +FIG01057361 FIG01057363: hypothetical protein +FIG01057363 FIG01057364: hypothetical protein +FIG01057366 FIG01057367: hypothetical protein +FIG01057369 Gamma-BHC dehydrochlorinase +FIG01057371 FIG01057372: hypothetical protein +FIG01057372 Cation efflux protein +FIG01057374 FIG01057375: hypothetical protein +FIG01057376 FIG01057379: hypothetical protein +FIG01057379 FIG01057381: hypothetical protein +FIG01057382 FIG01057384: hypothetical protein +FIG01057384 FIG01057386: hypothetical protein +FIG01057386 FIG01057389: hypothetical protein +FIG01057390 Methyl-accepting chemotaxis protein, homolog 13 +FIG01057391 Amino acid-binding protein +FIG01057397 FIG00950616: hypothetical protein +FIG01057398 FIG01057400: hypothetical protein +FIG01057400 FIG01057401: hypothetical protein +FIG01057401 FIG01057405: hypothetical protein +FIG01057408 FIG01057410: hypothetical protein +FIG01057412 FIG01057415: hypothetical protein +FIG01057415 FIG01057417: hypothetical protein +FIG01057417 FIG01057418: hypothetical protein +FIG01057418 FIG01057420: hypothetical protein +FIG01057422 FIG01057423: hypothetical protein +FIG01057423 Redox-active disulfide protein 2 +FIG01057425 FIG01057426: hypothetical protein +FIG01057433 FIG01057434: hypothetical protein +FIG01057434 FIG01057435: hypothetical protein +FIG01057435 FIG01057436: hypothetical protein +FIG01057436 FIG01057438: hypothetical protein +FIG01057438 FIG01057441: hypothetical protein +FIG01057441 FIG01057445: hypothetical protein +FIG01057445 FIG01057446: hypothetical protein +FIG01057446 FIG01057448: hypothetical protein +FIG01057449 FIG01057456: hypothetical protein +FIG01057456 Protein rarD +FIG01057462 FIG021625: hypothetical protein +FIG01057463 FIG01057465: hypothetical protein +FIG01057465 FIG01057466: hypothetical protein +FIG01057466 FIG01057467: hypothetical protein +FIG01057467 FIG01057468: hypothetical protein +FIG01057468 HEXOSEPHOSPHATE TRANSPORT PROTEIN +FIG01057469 FIG01057472: hypothetical protein +FIG01057472 FIG01057473: hypothetical protein +FIG01057473 FIG01057474: hypothetical protein +FIG01057480 FIG01057481: hypothetical protein +FIG01057481 Sensory box protein +FIG01057482 FIG01057483: hypothetical protein +FIG01057483 FIG01057484: hypothetical protein +FIG01057484 FIG01057485: hypothetical protein +FIG01057485 FIG01057486: hypothetical protein +FIG01057486 FIG01057489: hypothetical protein +FIG01057489 FIG01057491: hypothetical protein +FIG01057492 FIG01057493: hypothetical protein +FIG01057496 FIG01057498: hypothetical protein +FIG01057498 FIG01057499: hypothetical protein +FIG01057499 FIG01057501: hypothetical protein +FIG01057501 FIG01057502: hypothetical protein +FIG01057502 Methyl-accepting chemotaxis sensory transducer with Pas/Pac sensor +FIG01057506 FIG01057509: hypothetical protein +FIG01057510 FIG01057512: hypothetical protein +FIG01057512 FIG01057514: hypothetical protein +FIG01057514 WD40 repeats containg secreted protein +FIG01057515 FIG01057516: hypothetical protein +FIG01057520 FIG01057521: hypothetical protein +FIG01057521 FIG01057522: hypothetical protein +FIG01057526 FIG01057527: hypothetical protein +FIG01057527 FIG01057532: hypothetical protein +FIG01057532 Duplicated ATPase component Dace2069 of energizing module of predicted ECF transporter +FIG01057534 FIG01057535: hypothetical protein +FIG01057535 FIG01057537: hypothetical protein +FIG01057537 FIG01057539: hypothetical protein +FIG01057540 hypothetical Transcription elongation factor +FIG01057543 FIG01057544: hypothetical protein +FIG01057544 FIG01057547: hypothetical protein +FIG01057547 FIG01057549: hypothetical protein +FIG01057549 FIG01057550: hypothetical protein +FIG01057552 FIG01057555: hypothetical protein +FIG01057555 FIG01057558: hypothetical protein +FIG01057558 FIG01057559: hypothetical protein +FIG01057559 FIG01057561: hypothetical protein +FIG01057561 FIG01057562: hypothetical protein +FIG01057564 FIG01057565: hypothetical protein +FIG01057565 FIG01057566: hypothetical protein +FIG01057567 FIG01057570: hypothetical protein +FIG01057576 FIG01057577: hypothetical protein +FIG01057577 Uncharacterized phage-encoded protein-like protein +FIG01057579 FIG01057580: hypothetical protein +FIG01057580 Probable mdcF malonate transporter +FIG01057581 FIG01057582: hypothetical protein +FIG01057584 FIG01057587: hypothetical protein +FIG01057587 FIG01057589: hypothetical protein +FIG01057589 FIG01057591: hypothetical protein +FIG01057591 Probable sodium:alanine symporter +FIG01057593 FIG01057595: hypothetical protein +FIG01057598 Protease, insulinase family/protease, insulinase family +FIG01057599 FIG01057601: hypothetical protein +FIG01057601 FIG01057602: hypothetical protein +FIG01057602 FIG01057603: hypothetical protein +FIG01057603 FIG01057604: hypothetical protein +FIG01057604 FIG01057605: hypothetical protein +FIG01057610 FIG01057612: hypothetical protein +FIG01057612 ATP-dependent RNA helicase YejH +FIG01057613 FIG01057616: hypothetical protein +FIG01057616 FIG01057617: hypothetical protein +FIG01057618 FIG01057620: hypothetical protein +FIG01057621 FIG01057622: hypothetical protein +FIG01057622 FIG01057625: hypothetical protein +FIG01057625 FIG01057626: hypothetical protein +FIG01057626 FIG01057628: hypothetical protein +FIG01057628 FIG01057629: hypothetical protein +FIG01057631 FIG01057633: hypothetical protein +FIG01057635 FIG01057636: hypothetical protein +FIG01057636 FIG01057637: hypothetical protein +FIG01057641 FIG01057642: hypothetical protein +FIG01057642 FIG01057643: hypothetical protein +FIG01057646 FIG01057647: hypothetical protein +FIG01057647 FIG01057648: hypothetical protein +FIG01057651 FIG01057652: hypothetical protein +FIG01057652 Transcriptional regulator-related protein +FIG01057656 FIG01057657: hypothetical protein +FIG01057664 FIG01057665: hypothetical protein +FIG01057667 FIG01057668: hypothetical protein +FIG01057668 FIG01057672: hypothetical protein +FIG01057672 FIG01057676: hypothetical protein +FIG01057676 FIG01057677: hypothetical protein +FIG01057677 FIG01057678: hypothetical protein +FIG01057681 FIG01057682: hypothetical protein +FIG01057684 FIG01057687: hypothetical protein +FIG01057687 FIG01057688: hypothetical protein +FIG01057691 FIG01057692: hypothetical protein +FIG01057692 FIG01057695: hypothetical protein +FIG01057695 GGDEF domain/HAMP domain protein +FIG01057696 FIG01057702: hypothetical protein +FIG01057702 FIG01057706: hypothetical protein +FIG01057706 FIG01057707: hypothetical protein +FIG01057707 FIG01057708: hypothetical protein +FIG01057709 Diguanylate cyclase/phosphodiesterase +FIG01057713 FIG01057715: hypothetical protein +FIG01057716 FIG01057717: hypothetical protein +FIG01057717 Methyl-accepting chemotaxis protein, homolog 4 +FIG01057718 rRNA (guanine-N1-)-methyltransferase +FIG01057719 FIG01057722: hypothetical protein +FIG01057722 FIG01057723: hypothetical protein +FIG01057723 FIG01059049: hypothetical protein +FIG01057725 FIG01057727: hypothetical protein +FIG01057727 Methyl-accepting chemotaxis protein, homolog 1 +FIG01057731 FIG01057733: hypothetical protein +FIG01057733 FIG01057734: hypothetical protein +FIG01057734 FIG01057736: hypothetical protein +FIG01057736 Outer membrane protein, probably efflux family +FIG01057737 FIG01057738: hypothetical protein +FIG01057738 FIG01057739: hypothetical protein +FIG01057739 FIG01057740: hypothetical protein +FIG01057740 FIG01057742: hypothetical protein +FIG01057743 FIG01057744: hypothetical protein +FIG01057744 FIG01057747: hypothetical protein +FIG01057747 FIG01057748: hypothetical protein +FIG01057748 FIG01057749: hypothetical protein +FIG01057749 FIG01057751: hypothetical protein +FIG01057753 FIG01057756: hypothetical protein +FIG01057756 FIG01057759: hypothetical protein +FIG01057765 prolyl oligopeptidase family protein +FIG01057769 FIG01057771: hypothetical protein +FIG01057772 FIG01057775: hypothetical protein +FIG01057777 FIG01057778: hypothetical protein +FIG01057779 FIG01057780: hypothetical protein +FIG01057781 FIG01057783: hypothetical protein +FIG01057783 CheW domain protein +FIG01057785 FIG01057787: hypothetical protein +FIG01057789 Structural protein P3 +FIG01057790 FIG01057791: hypothetical protein +FIG01057791 FIG01057792: hypothetical protein +FIG01057792 FIG01057793: hypothetical protein +FIG01057793 FIG01057795: hypothetical protein +FIG01057795 Cation antiporter precursor +FIG01057799 FIG01057800: hypothetical protein +FIG01057801 FIG01057803: hypothetical protein +FIG01057803 FIG01057804: hypothetical protein +FIG01057804 PHOSPHATIDYLGLYCEROPHOSPHATASE B (EC 3.1.3.27) +FIG01057806 Serine/threonine protein kinase involved in cell cycle control +FIG01057814 FIG01057816: hypothetical protein +FIG01057816 FIG01057817: hypothetical protein +FIG01057818 FIG01057819: hypothetical protein +FIG01057821 FIG01057823: hypothetical protein +FIG01057823 FIG01057825: hypothetical protein +FIG01057825 hypothetical protein +FIG01057827 outer membrane protein, MtrE +FIG01057832 FIG01057834: hypothetical protein +FIG01057835 FIG01057837: hypothetical protein +FIG01057839 FIG01057840: hypothetical protein +FIG01057840 FIG01057841: hypothetical protein +FIG01057843 Sodium-type flagellar protein MotX +FIG01057844 FIG01057845: hypothetical protein +FIG01057846 FIG01057847: hypothetical protein +FIG01057847 FIG01057849: hypothetical protein +FIG01057851 FIG01057852: hypothetical protein +FIG01057852 FIG01057855: hypothetical protein +FIG01057866 FIG01057867: hypothetical protein +FIG01057867 transcriptional regulator, CadC +FIG01057872 FIG01057874: hypothetical protein +FIG01057874 FIG01057875: hypothetical protein +FIG01057875 FIG01057876: hypothetical protein +FIG01057876 T1SS secreted agglutinin (RTX) +FIG01057877 FIG01057878: hypothetical protein +FIG01057880 FIG01057881: hypothetical protein +FIG01057881 FIG01057883: hypothetical protein +FIG01057886 FIG01057887: hypothetical protein +FIG01057887 FIG01057888: hypothetical protein +FIG01057888 FIG01057890: hypothetical protein +FIG01057901 FIG01057904: hypothetical protein +FIG01057904 FIG01057905: hypothetical protein +FIG01057913 Predicted signal transduction protein containing a membrane domain +FIG01057915 FIG01057918: hypothetical protein +FIG01057918 FIG01057921: hypothetical protein +FIG01057921 FIG01057926: hypothetical protein +FIG01057926 FIG01057928: hypothetical protein +FIG01057928 FIG01057929: hypothetical protein +FIG01057932 FIG01057933: hypothetical protein +FIG01057933 FIG01057934: hypothetical protein +FIG01057935 Fic family protein +FIG01057938 FIG01057945: hypothetical protein +FIG01057945 FIG01057947: hypothetical protein +FIG01057947 FIG01057950: hypothetical protein +FIG01057954 FIG01057955: hypothetical protein +FIG01057956 FIG01057957: hypothetical protein +FIG01057958 FIG01057959: hypothetical protein +FIG01057959 FIG01057960: hypothetical protein +FIG01057960 FIG01057963: hypothetical protein +FIG01057966 FIG01057967: hypothetical protein +FIG01057967 FIG01057968: hypothetical protein +FIG01057972 FIG01057974: hypothetical protein +FIG01057974 FIG01057976: hypothetical protein +FIG01057980 FIG01057983: hypothetical protein +FIG01057983 FIG01057984: hypothetical protein +FIG01057985 FIG01057990: hypothetical protein +FIG01057990 FIG01057991: hypothetical protein +FIG01057995 FIG01057997: hypothetical protein +FIG01057998 FIG01057999: hypothetical protein +FIG01058002 FIG01058007: hypothetical protein +FIG01058009 FIG01058010: hypothetical protein +FIG01058016 FIG01058017: hypothetical protein +FIG01058017 FIG01058018: hypothetical protein +FIG01058019 FIG01058021: hypothetical protein +FIG01058021 FIG01058022: hypothetical protein +FIG01058022 FIG01058023: hypothetical protein +FIG01058023 FIG01058025: hypothetical protein +FIG01058025 FIG01058028: hypothetical protein +FIG01058030 FIG01058031: hypothetical protein +FIG01058031 FIG01058032: hypothetical protein +FIG01058032 FIG01058033: hypothetical protein +FIG01058033 FIG01058035: hypothetical protein +FIG01058035 FIG01058037: hypothetical protein +FIG01058039 FIG01058041: hypothetical protein +FIG01058041 FIG01058042: hypothetical protein +FIG01058043 FIG01058049: hypothetical protein +FIG01058052 FIG01058053: hypothetical protein +FIG01058053 FIG01058054: hypothetical protein +FIG01058056 YebG, DNA damage-inducible gene in SOS regulon, expressed in stationary phase +FIG01058059 FIG01058060: hypothetical protein +FIG01058060 FIG01058063: hypothetical protein +FIG01058063 FIG01058065: hypothetical protein +FIG01058065 FIG01058066: hypothetical protein +FIG01058070 FIG01058071: hypothetical protein +FIG01058077 FIG01058078: hypothetical protein +FIG01058078 FIG01058079: hypothetical protein +FIG01058079 FIG01058083: hypothetical protein +FIG01058084 FIG01058086: hypothetical protein +FIG01058087 FIG01058089: hypothetical protein +FIG01058089 FIG01058093: hypothetical protein +FIG01058093 FIG01058095: hypothetical protein +FIG01058097 FIG01058099: hypothetical protein +FIG01058109 FIG01058110: hypothetical protein +FIG01058110 FIG01058111: hypothetical protein +FIG01058111 FIG01058112: hypothetical protein +FIG01058112 FIG01058116: hypothetical protein +FIG01058116 FIG01058118: hypothetical protein +FIG01058118 FIG01058119: hypothetical protein +FIG01058119 FIG01058122: hypothetical protein +FIG01058132 metalloprotease MEP1-like protein +FIG01058134 FIG01058138: hypothetical protein +FIG01058140 FIG01058141: hypothetical protein +FIG01058148 FIG01058150: hypothetical protein +FIG01058150 FIG01058151: hypothetical protein +FIG01058154 FIG01058158: hypothetical protein +FIG01058158 FIG01058159: hypothetical protein +FIG01058159 FIG01058162: hypothetical protein +FIG01058162 FIG01058164: hypothetical protein +FIG01058164 FIG01058166: hypothetical protein +FIG01058166 FIG01058167: hypothetical protein +FIG01058169 FIG01058172: hypothetical protein +FIG01058177 FIG01058178: hypothetical protein +FIG01058181 periplasmic decaheme cytochrome c, MtrD +FIG01058182 FIG01058183: hypothetical protein +FIG01058183 FIG01058185: hypothetical protein +FIG01058186 FIG01058187: hypothetical protein +FIG01058187 FIG01058191: hypothetical protein +FIG01058191 FIG01058192: hypothetical protein +FIG01058193 FIG01058194: hypothetical protein +FIG01058196 FIG01058197: hypothetical protein +FIG01058197 FIG01058198: hypothetical protein +FIG01058198 FIG01058201: hypothetical protein +FIG01058201 FIG01058202: hypothetical protein +FIG01058206 FIG01058207: hypothetical protein +FIG01058207 FIG206191: hypothetical protein +FIG01058209 FIG01058210: hypothetical protein +FIG01058210 FIG01058211: hypothetical protein +FIG01058218 FIG01058220: hypothetical protein +FIG01058223 FIG01058226: hypothetical protein +FIG01058226 FIG01058228: hypothetical protein +FIG01058228 FIG01058230: hypothetical protein +FIG01058230 FIG01058231: hypothetical protein +FIG01058231 FIG01058233: hypothetical protein +FIG01058233 FIG01058237: hypothetical protein +FIG01058240 FIG01058245: hypothetical protein +FIG01058245 FIG01058247: hypothetical protein +FIG01058247 sensory box protein, putative +FIG01058249 FIG01058250: hypothetical protein +FIG01058251 FIG01058253: hypothetical protein +FIG01058254 FIG01058255: hypothetical protein +FIG01058259 FIG01058263: hypothetical protein +FIG01058265 FIG00950053: hypothetical protein +FIG01058266 FIG01058267: hypothetical protein +FIG01058270 FIG01058271: hypothetical protein +FIG01058271 FIG01058273: hypothetical protein +FIG01058273 FIG01058274: hypothetical protein +FIG01058275 FIG01058276: hypothetical protein +FIG01058276 FIG01058277: hypothetical protein +FIG01058287 FIG01058288: hypothetical protein +FIG01058288 FIG01058289: hypothetical protein +FIG01058289 FIG01058292: hypothetical protein +FIG01058292 FIG01058295: hypothetical protein +FIG01058295 FIG01058300: hypothetical protein +FIG01058302 FIG01058308: hypothetical protein +FIG01058308 FIG01058309: hypothetical protein +FIG01058310 FIG01058311: hypothetical protein +FIG01058311 FIG01058313: hypothetical protein +FIG01058313 FIG01058314: hypothetical protein +FIG01058314 FIG01058319: hypothetical protein +FIG01058319 FIG01058320: hypothetical protein +FIG01058320 Mll2627 protein +FIG01058324 FIG01058325: hypothetical protein +FIG01058325 FIG01058326: hypothetical protein +FIG01058332 FIG01058333: hypothetical protein +FIG01058333 FIG01058334: hypothetical protein +FIG01058334 FIG01058335: hypothetical protein +FIG01058337 FIG01058338: hypothetical protein +FIG01058338 FIG01058340: hypothetical protein +FIG01058340 FIG01058344: hypothetical protein +FIG01058344 FIG01058345: hypothetical protein +FIG01058345 FIG01058347: hypothetical protein +FIG01058347 FIG01058353: hypothetical protein +FIG01058353 FIG01058354: hypothetical protein +FIG01058354 FIG01058357: hypothetical protein +FIG01058357 FIG01058358: hypothetical protein +FIG01058358 FIG01058360: hypothetical protein +FIG01058360 FIG01058361: hypothetical protein +FIG01058361 FIG01058364: hypothetical protein +FIG01058372 FIG01058373: hypothetical protein +FIG01058375 FIG01058377: hypothetical protein +FIG01058377 FIG01058378: hypothetical protein +FIG01058378 FIG01058379: hypothetical protein +FIG01058379 FIG01058381: hypothetical protein +FIG01058381 FIG01058385: hypothetical protein +FIG01058385 FIG01058386: hypothetical protein +FIG01058386 FIG01058388: hypothetical protein +FIG01058389 FIG01058390: hypothetical protein +FIG01058390 FIG01058391: hypothetical protein +FIG01058391 FIG01058394: hypothetical protein +FIG01058394 FIG01058397: hypothetical protein +FIG01058403 FIG01058405: hypothetical protein +FIG01058405 FIG01058406: hypothetical protein +FIG01058406 FIG01058412: hypothetical protein +FIG01058419 Iron-compound ABC transporter, permease protein +FIG01058421 FIG01058423: hypothetical protein +FIG01058423 FIG01058424: hypothetical protein +FIG01058425 FIG01058426: hypothetical protein +FIG01058433 FIG01058434: hypothetical protein +FIG01058434 FIG01058435: hypothetical protein +FIG01058435 FIG01058436: hypothetical protein +FIG01058436 FIG01058440: hypothetical protein +FIG01058440 FIG01058441: hypothetical protein +FIG01058441 FIG01058443: hypothetical protein +FIG01058448 FIG01058451: hypothetical protein +FIG01058451 FIG01058452: hypothetical protein +FIG01058457 FIG01058459: hypothetical protein +FIG01058459 FIG01058460: hypothetical protein +FIG01058460 FIG01058463: hypothetical protein +FIG01058463 putative c'cytochrome +FIG01058464 predicted N-acetylglucosamine kinase, ROK family (EC 2.7.1.59) +FIG01058470 FIG01058471: hypothetical protein +FIG01058471 FIG01058472: hypothetical protein +FIG01058472 FIG01058473: hypothetical protein +FIG01058473 FIG01058474: hypothetical protein +FIG01058474 FIG01058477: hypothetical protein +FIG01058478 FIG01058485: hypothetical protein +FIG01058488 FIG01058489: hypothetical protein +FIG01058489 FIG01058490: hypothetical protein +FIG01058490 FIG01058491: hypothetical protein +FIG01058491 FIG01058494: hypothetical protein +FIG01058495 FIG01058498: hypothetical protein +FIG01058505 FIG01058508: hypothetical protein +FIG01058509 FIG01058513: hypothetical protein +FIG01058514 FIG01058515: hypothetical protein +FIG01058515 FIG01058520: hypothetical protein +FIG01058520 FIG01058521: hypothetical protein +FIG01058521 FIG01058523: hypothetical protein +FIG01058524 FIG01058525: hypothetical protein +FIG01058525 FIG01058526: hypothetical protein +FIG01058527 FIG01058528: hypothetical protein +FIG01058530 FIG01058531: hypothetical protein +FIG01058531 FIG01058532: hypothetical protein +FIG01058532 Pirin-like protein YhhW, possibly qercetin 2,3-dioxygenase activity +FIG01058534 FIG01058536: hypothetical protein +FIG01058541 FIG01058551: hypothetical protein +FIG01058551 Macrolide-specific efflux protein macA precursor +FIG01058554 FIG01058555: hypothetical protein +FIG01058555 surface localized decaheme cytochrome c lipoprotein, OmcA +FIG01058568 FIG01058569: hypothetical protein +FIG01058581 FIG01058583: hypothetical protein +FIG01058583 FIG01058585: hypothetical protein +FIG01058585 FIG01058586: hypothetical protein +FIG01058587 FIG01058589: hypothetical protein +FIG01058589 FIG01058593: hypothetical protein +FIG01058593 Protein kinase +FIG01058595 FIG01058596: hypothetical protein +FIG01058602 FIG01058605: hypothetical protein +FIG01058608 FIG01058609: hypothetical protein +FIG01058610 BsuBI-PstI family restriction endonuclease (PF06616) +FIG01058615 FIG01058616: hypothetical protein +FIG01058616 FIG01058617: hypothetical protein +FIG01058619 FIG01058620: hypothetical protein +FIG01058620 FIG01058623: hypothetical protein +FIG01058623 FIG01058624: hypothetical protein +FIG01058626 FIG01058628: hypothetical protein +FIG01058628 FIG01058629: hypothetical protein +FIG01058635 FIG01058636: hypothetical protein +FIG01058636 FIG01058637: hypothetical protein +FIG01058637 FIG01058638: hypothetical protein +FIG01058638 FIG01058641: hypothetical protein +FIG01058643 FIG01058644: hypothetical protein +FIG01058652 putative transcriptional regulator, CadC +FIG01058659 FIG01058661: hypothetical protein +FIG01058663 membrane-flanked domain +FIG01058666 Hypotehtical protein in Cytochrome oxidase biogenesis cluster +FIG01058671 FIG01058672: hypothetical protein +FIG01058672 FIG01058676: hypothetical protein +FIG01058676 FIG01058677: hypothetical protein +FIG01058677 FIG01058679: hypothetical protein +FIG01058679 FIG01058680: hypothetical protein +FIG01058681 FIG01058682: hypothetical protein +FIG01058682 FIG01058683: hypothetical protein +FIG01058683 FIG01058686: hypothetical protein +FIG01058696 FIG01058697: hypothetical protein +FIG01058701 FIG01058702: hypothetical protein +FIG01058702 FIG01058703: hypothetical protein +FIG01058703 FIG01058705: hypothetical protein +FIG01058705 Oxidoreductase Tas, aldo/keto reductase family +FIG01058708 FIG01058711: hypothetical protein +FIG01058711 FIG01058713: hypothetical protein +FIG01058713 FIG01058717: hypothetical protein +FIG01058717 FIG01058720: hypothetical protein +FIG01058721 FIG01058725: hypothetical protein +FIG01058725 FIG01058726: hypothetical protein +FIG01058726 FIG01058727: hypothetical protein +FIG01058730 ATP-dependent protease La (LON) domain protein +FIG01058738 FIG01058740: hypothetical protein +FIG01058740 FIG01058741: hypothetical protein +FIG01058745 FIG01058746: hypothetical protein +FIG01058749 FIG01058753: hypothetical protein +FIG01058754 FIG01058756: hypothetical protein +FIG01058756 FIG01058761: hypothetical protein +FIG01058762 FIG01058764: hypothetical protein +FIG01058765 FIG01058767: hypothetical protein +FIG01058767 FIG01058771: hypothetical protein +FIG01058771 FIG01058773: hypothetical protein +FIG01058773 FIG01058775: hypothetical protein +FIG01058776 FIG01058779: hypothetical protein +FIG01058783 FIG01058784: hypothetical protein +FIG01058784 FIG01058785: hypothetical protein +FIG01058785 FIG01058787: hypothetical protein +FIG01058790 FIG01058791: hypothetical protein +FIG01058794 FIG01058795: hypothetical protein +FIG01058796 FIG01058797: hypothetical protein +FIG01058799 FIG01058800: hypothetical protein +FIG01058802 FIG01058803: hypothetical protein +FIG01058810 Possible protease sohB (EC 3.4.21.-) +FIG01058816 FIG01058818: hypothetical protein +FIG01058818 FIG01058819: hypothetical protein +FIG01058819 cell wall degradation protein +FIG01058827 FIG01058829: hypothetical protein +FIG01058829 FIG01058832: hypothetical protein +FIG01058832 FIG01058840: hypothetical protein +FIG01058842 FIG01058843: hypothetical protein +FIG01058843 FIG01058852: hypothetical protein +FIG01058853 FIG01058854: hypothetical protein +FIG01058854 FIG01058856: hypothetical protein +FIG01058857 FIG01058867: hypothetical protein +FIG01058867 FIG01058869: hypothetical protein +FIG01058871 FIG01058873: hypothetical protein +FIG01058873 FIG01058874: hypothetical protein +FIG01058874 FIG01058875: hypothetical protein +FIG01058876 FIG01058878: hypothetical protein +FIG01058880 FIG01058881: hypothetical protein +FIG01058883 FIG01058884: hypothetical protein +FIG01058885 superfamily II helicase and inactivated derivatives-like protein +FIG01058891 FIG01058892: hypothetical protein +FIG01058892 FIG01058893: hypothetical protein +FIG01058896 FIG01058899: hypothetical protein +FIG01058899 FIG01058900: hypothetical protein +FIG01058918 Type III secretion effector SseB +FIG01058919 FIG01058922: hypothetical protein +FIG01058922 FIG01058923: hypothetical protein +FIG01058926 hypothetical protein +FIG01058931 FIG01058933: hypothetical protein +FIG01058937 FIG01058941: hypothetical protein +FIG01058941 FIG01058942: hypothetical protein +FIG01058942 FIG01058944: hypothetical protein +FIG01058946 FIG01058947: hypothetical protein +FIG01058947 FIG01058948: hypothetical protein +FIG01058948 FIG01058950: hypothetical protein +FIG01058952 FIG01058956: hypothetical protein +FIG01058956 FIG01058957: hypothetical protein +FIG01058957 FIG01058959: hypothetical protein +FIG01058959 FIG01058962: hypothetical protein +FIG01058962 FIG01058964: hypothetical protein +FIG01058965 FIG01058966: hypothetical protein +FIG01058966 FIG01058968: hypothetical protein +FIG01058974 FIG01058980: hypothetical protein +FIG01058980 FIG01058981: hypothetical protein +FIG01058984 FIG01058992: hypothetical protein +FIG01058994 FIG01058996: hypothetical protein +FIG01058999 FIG01059000: hypothetical protein +FIG01059000 FIG01059003: hypothetical protein +FIG01059003 FIG01059005: hypothetical protein +FIG01059005 FIG01059010: hypothetical protein +FIG01059010 FIG01059012: hypothetical protein +FIG01059013 FIG01059014: hypothetical protein +FIG01059014 FIG01059018: hypothetical protein +FIG01059021 FIG01059022: hypothetical protein +FIG01059022 FIG01059023: hypothetical protein +FIG01059023 FIG01059024: hypothetical protein +FIG01059024 FIG01059025: hypothetical protein +FIG01059025 FIG01059026: hypothetical protein +FIG01059035 FIG01059036: hypothetical protein +FIG01059036 FIG01059041: hypothetical protein +FIG01059041 FIG01059043: hypothetical protein +FIG01059043 FIG01059044: hypothetical protein +FIG01059045 FIG01059046: hypothetical protein +FIG01059050 FIG01059054: hypothetical protein +FIG01059054 FIG01059057: hypothetical protein +FIG01059059 FIG01059061: hypothetical protein +FIG01059064 FIG01059067: hypothetical protein +FIG01059069 FIG01059072: hypothetical protein +FIG01059072 FIG01059074: hypothetical protein +FIG01059074 FIG01059076: hypothetical protein +FIG01059078 FIG01059079: hypothetical protein +FIG01059079 FIG01059081: hypothetical protein +FIG01059081 FIG01059082: hypothetical protein +FIG01059083 FIG01059085: hypothetical protein +FIG01059091 FIG01059092: hypothetical protein +FIG01059092 FIG01059094: hypothetical protein +FIG01059096 FIG01059097: hypothetical protein +FIG01059099 FIG01059100: hypothetical protein +FIG01059117 FIG01059118: hypothetical protein +FIG01059118 FIG01059126: hypothetical protein +FIG01059129 FIG01059130: hypothetical protein +FIG01059130 FIG01059134: hypothetical protein +FIG01059137 FIG01059138: hypothetical protein +FIG01059138 MSHA pilin protein MshB BUT NOT +FIG01059139 FIG01059140: hypothetical protein +FIG01059140 FIG01059141: hypothetical protein +FIG01059142 FIG01059143: hypothetical protein +FIG01059143 putative Mdr +FIG01059153 FIG01059154: hypothetical protein +FIG01059154 FIG01059155: hypothetical protein +FIG01059157 FIG01059158: hypothetical protein +FIG01059158 FIG01059159: hypothetical protein +FIG01059159 FIG01059160: hypothetical protein +FIG01059160 FIG01059161: hypothetical protein +FIG01059161 FIG01059163: hypothetical protein +FIG01059163 FIG01059164: hypothetical protein +FIG01059164 FIG01059165: hypothetical protein +FIG01059168 FIG01059169: hypothetical protein +FIG01059169 surface localized decaheme cytochrome c lipoprotein, MtrF +FIG01059170 FIG01059172: hypothetical protein +FIG01059172 FIG01059173: hypothetical protein +FIG01059176 FIG01059177: hypothetical protein +FIG01059179 FIG01059180: hypothetical protein +FIG01059180 FIG01059181: hypothetical protein +FIG01059181 FIG01059183: hypothetical protein +FIG01059183 Uncharacterized protein Mlr1045 +FIG01059189 FIG01059190: hypothetical protein +FIG01059197 FIG01059198: hypothetical protein +FIG01059198 FIG01059205: hypothetical protein +FIG01059205 HTH-type transcriptional regulator prtR +FIG01059207 FIG01059208: hypothetical protein +FIG01059210 putative short-chain dehydrogenase +FIG01059211 FIG01059216: hypothetical protein +FIG01059217 putative zinc-dependent oxidoreductase +FIG01059225 anaerobic C4-dicarboxylate membrane transporter +FIG01059226 FIG01059227: hypothetical protein +FIG01059227 FIG01059229: hypothetical protein +FIG01059229 FIG01059230: hypothetical protein +FIG01059230 FIG01059235: hypothetical protein +FIG01059244 FIG01059246: hypothetical protein +FIG01059249 FIG01059250: hypothetical protein +FIG01059250 FIG01059254: hypothetical protein +FIG01059256 FIG032767: hypothetical protein +FIG01059259 FIG01059260: hypothetical protein +FIG01059272 FIG01059275: hypothetical protein +FIG01059283 FIG01059284: hypothetical protein +FIG01059284 FIG01059286: hypothetical protein +FIG01059287 FIG01059288: hypothetical protein +FIG01059296 FIG01059297: hypothetical protein +FIG01059297 FIG01059298: hypothetical protein +FIG01059298 FIG01059299: hypothetical protein +FIG01059299 FIG01059301: hypothetical protein +FIG01059301 FIG01059302: hypothetical protein +FIG01059303 FIG01059306: hypothetical protein +FIG01059307 FIG01059308: hypothetical protein +FIG01059311 FIG01059312: hypothetical protein +FIG01059312 FIG01059314: hypothetical protein +FIG01059314 FIG01059317: hypothetical protein +FIG01059317 FIG01059318: hypothetical protein +FIG01059318 FIG01059320: hypothetical protein +FIG01059327 FIG01059331: hypothetical protein +FIG01059331 FIG01059334: hypothetical protein +FIG01059338 Probable multidrug efflux system protein +FIG01059341 FIG01059343: hypothetical protein +FIG01059343 FIG01059346: hypothetical protein +FIG01059347 FIG01059348: hypothetical protein +FIG01059348 FIG01059351: hypothetical protein +FIG01059351 FIG01059361: hypothetical protein +FIG01059374 FIG01059375: hypothetical protein +FIG01059384 FIG01061964: hypothetical protein +FIG01059385 FIG01059386: hypothetical protein +FIG01059389 FIG01059390: hypothetical protein +FIG01059394 FIG01059398: hypothetical protein +FIG01059399 FIG01059402: hypothetical protein +FIG01059406 FIG01059407: hypothetical protein +FIG01059409 FIG01059410: hypothetical protein +FIG01059410 FIG01059411: hypothetical protein +FIG01059414 FIG01059416: hypothetical protein +FIG01059416 FIG01059418: hypothetical protein +FIG01059418 FIG01059420: hypothetical protein +FIG01059423 FIG01059425: hypothetical protein +FIG01059428 FIG01059429: hypothetical protein +FIG01059429 FIG01059430: hypothetical protein +FIG01059430 FIG01059432: hypothetical protein +FIG01059432 FIG01059433: hypothetical protein +FIG01059435 FIG01059437: hypothetical protein +FIG01059439 FIG01059440: hypothetical protein +FIG01059440 FIG01059441: hypothetical protein +FIG01059441 FIG01059446: hypothetical protein +FIG01059447 FIG01059448: hypothetical protein +FIG01059450 FIG01059451: hypothetical protein +FIG01059453 Gpr1/fun34/yaaH family protein +FIG01059455 FIG01059456: hypothetical protein +FIG01059456 FIG01059457: hypothetical protein +FIG01059458 FIG01059465: hypothetical protein +FIG01059465 FIG01059470: hypothetical protein +FIG01059470 Cold-active alkaline serine protease (EC 3.4.21.62) +FIG01059473 FIG01059475: hypothetical protein +FIG01059475 FIG01059479: hypothetical protein +FIG01059479 FIG01059484: hypothetical protein +FIG01059485 FIG01059488: hypothetical protein +FIG01059489 FIG01059492: hypothetical protein +FIG01059492 FIG01059493: hypothetical protein +FIG01059493 FIG01059495: hypothetical protein +FIG01059495 Putative xanthosine permease +FIG01059498 FIG01059502: hypothetical protein +FIG01059507 FIG01059511: hypothetical protein +FIG01059514 FIG01059518: hypothetical protein +FIG01059519 Surface lipoprotein VacJ +FIG01059522 FIG01059523: hypothetical protein +FIG01059523 FIG01059524: hypothetical protein +FIG01059536 FIG01059537: hypothetical protein +FIG01059537 FIG01059538: hypothetical protein +FIG01059538 FIG01059539: hypothetical protein +FIG01059547 FIG01059548: hypothetical protein +FIG01059548 FIG01059549: hypothetical protein +FIG01059549 FIG01059552: hypothetical protein +FIG01059552 FIG01059553: hypothetical protein +FIG01059557 FIG01059562: hypothetical protein +FIG01059562 FIG01059563: hypothetical protein +FIG01059565 Glycerophosphoryl diester phosphodiesterase-like protein +FIG01059568 FIG01059570: hypothetical protein +FIG01059570 FIG01059571: hypothetical protein +FIG01059571 Trpba operon transcriptional activator +FIG01059579 FIG01059585: hypothetical protein +FIG01059585 FIG01059588: hypothetical protein +FIG01059588 FIG01059591: hypothetical protein +FIG01059594 FIG01059595: hypothetical protein +FIG01059595 FIG01059596: hypothetical protein +FIG01059596 FIG01059598: hypothetical protein +FIG01059598 FIG01059601: hypothetical protein +FIG01059601 FIG01059602: hypothetical protein +FIG01059602 FIG01059604: hypothetical protein +FIG01059604 FIG01059605: hypothetical protein +FIG01059605 FIG01059607: hypothetical protein +FIG01059607 FIG01059611: hypothetical protein +FIG01059611 FIG01059613: hypothetical protein +FIG01059613 FIG01059617: hypothetical protein +FIG01059618 FIG01059626: hypothetical protein +FIG01059626 FIG01059627: hypothetical protein +FIG01059627 methylation site containing protein +FIG01059628 FIG01059629: hypothetical protein +FIG01059629 FIG01059630: hypothetical protein +FIG01059638 FIG01059639: hypothetical protein +FIG01059639 FIG01059644: hypothetical protein +FIG01059645 FIG01059648: hypothetical protein +FIG01059648 FIG01059649: hypothetical protein +FIG01059649 FIG01059652: hypothetical protein +FIG01059652 Phenylacetaldoxime dehydratase (EC 4.99.1.7) +FIG01059653 FIG01059659: hypothetical protein +FIG01059660 FIG01059665: hypothetical protein +FIG01059671 FIG01059672: hypothetical protein +FIG01059672 FIG01059678: hypothetical protein +FIG01059680 prophage LambdaSo, replication protein O +FIG01059685 FIG01059692: hypothetical protein +FIG01059694 FIG01059696: hypothetical protein +FIG01059696 FIG01059699: hypothetical protein +FIG01059699 FIG01059700: hypothetical protein +FIG01059705 FIG01059710: hypothetical protein +FIG01059713 FIG01059714: hypothetical protein +FIG01059719 FIG01059720: hypothetical protein +FIG01059723 FIG01059724: hypothetical protein +FIG01059724 FIG01059727: hypothetical protein +FIG01059733 FIG01059734: hypothetical protein +FIG01059734 FIG01059735: hypothetical protein +FIG01059735 FIG01059738: hypothetical protein +FIG01059738 FIG01059739: hypothetical protein +FIG01059740 FIG01059741: hypothetical protein +FIG01059742 FIG01059744: hypothetical protein +FIG01059744 FIG01059748: hypothetical protein +FIG01059748 FIG01059749: hypothetical protein +FIG01059754 FIG01059755: hypothetical protein +FIG01059755 Membrane protein, HPP family +FIG01059762 FIG01059763: hypothetical protein +FIG01059763 FIG01059764: hypothetical protein +FIG01059764 FIG01059767: hypothetical protein +FIG01059767 FIG01059769: hypothetical protein +FIG01059769 FIG01059773: hypothetical protein +FIG01059773 FIG01059775: hypothetical protein +FIG01059775 FIG01059778: hypothetical protein +FIG01059784 ATPase family protein +FIG01059785 FIG01059786: hypothetical protein +FIG01059787 FIG01059790: hypothetical protein +FIG01059795 FIG01059796: hypothetical protein +FIG01059803 FIG01059804: hypothetical protein +FIG01059804 FIG01059805: hypothetical protein +FIG01059807 FIG01059808: hypothetical protein +FIG01059808 FIG01059809: hypothetical protein +FIG01059817 FIG01059820: hypothetical protein +FIG01059820 FIG01059822: hypothetical protein +FIG01059822 FIG01059827: hypothetical protein +FIG01059835 FIG01059836: hypothetical protein +FIG01059836 Alr1538 protein +FIG01059839 FIG01059843: hypothetical protein +FIG01059843 FIG01059844: hypothetical protein +FIG01059846 FIG01059847: hypothetical protein +FIG01059848 FIG01059849: hypothetical protein +FIG01059849 FIG01059850: hypothetical protein +FIG01059850 FIG01059854: hypothetical protein +FIG01059854 FIG01059857: hypothetical protein +FIG01059857 FIG01059862: hypothetical protein +FIG01059864 FIG01059865: hypothetical protein +FIG01059867 FIG01059868: hypothetical protein +FIG01059868 FIG01059872: hypothetical protein +FIG01059879 FIG01059881: hypothetical protein +FIG01059885 FIG01059888: hypothetical protein +FIG01059890 FIG01059891: hypothetical protein +FIG01059894 FIG01059898: hypothetical protein +FIG01059898 FIG01059904: hypothetical protein +FIG01059904 FIG01059907: hypothetical protein +FIG01059908 FIG01059909: hypothetical protein +FIG01059919 surface localized decaheme cytochrome c lipoprotein, MtrH +FIG01059920 FIG01059921: hypothetical protein +FIG01059921 FIG01059922: hypothetical protein +FIG01059922 Secreted protein containing internal repeats +FIG01059924 FIG01059926: hypothetical protein +FIG01059926 FIG01059930: hypothetical protein +FIG01059935 FIG01059936: hypothetical protein +FIG01059940 FIG01059943: hypothetical protein +FIG01059943 FIG01059944: hypothetical protein +FIG01059944 RTN PROTEIN +FIG01059948 FIG01059951: hypothetical protein +FIG01059952 FIG01059953: hypothetical protein +FIG01059955 FIG01059956: hypothetical protein +FIG01059962 FIG01059965: hypothetical protein +FIG01059965 FIG01059967: hypothetical protein +FIG01059967 Putative Histidinol phosphatase +FIG01059974 FIG01059975: hypothetical protein +FIG01059976 FIG01059977: hypothetical protein +FIG01059977 prophage LambdaSo, major tail protein V, putative +FIG01059983 FIG01059984: hypothetical protein +FIG01060001 FIG01060002: hypothetical protein +FIG01060002 FIG01060006: hypothetical protein +FIG01060013 FIG01060017: hypothetical protein +FIG01060030 FIG01060034: hypothetical protein +FIG01060034 FIG01060037: hypothetical protein +FIG01060037 FIG01060038: hypothetical protein +FIG01060040 FIG01060043: hypothetical protein +FIG01060045 TraT complement resistance +FIG01060046 FIG01060047: hypothetical protein +FIG01060048 Probable collagenase (EC 3.4.24.3) +FIG01060049 FIG01060050: hypothetical protein +FIG01060051 FIG01060052: hypothetical protein +FIG01060058 FIG01060059: hypothetical protein +FIG01060060 FIG01060061: hypothetical protein +FIG01060069 FIG01060070: hypothetical protein +FIG01060078 FIG01060081: hypothetical protein +FIG01060081 FIG01060083: hypothetical protein +FIG01060090 FIG01060092: hypothetical protein +FIG01060092 prophage LambdaSo, site-specific recombinase, phage integrase family +FIG01060094 FIG01060097: hypothetical protein +FIG01060101 FIG01060105: hypothetical protein +FIG01060105 other cation transporters (Na(+) ,K(+) ,Ca(2+) ,NH4(+) ,etc.) +FIG01060113 FIG01060118: hypothetical protein +FIG01060118 FIG01060121: hypothetical protein +FIG01060121 FIG01060123: hypothetical protein +FIG01060123 FIG01060124: hypothetical protein +FIG01060128 FIG01060133: hypothetical protein +FIG01060133 FIG01060134: hypothetical protein +FIG01060134 FIG01060135: hypothetical protein +FIG01060135 FIG01060136: hypothetical protein +FIG01060136 FIG01060137: hypothetical protein +FIG01060147 FIG01060148: hypothetical protein +FIG01060148 FIG01060150: hypothetical protein +FIG01060150 FIG01060153: hypothetical protein +FIG01060161 FIG01060162: hypothetical protein +FIG01060163 FIG01060164: hypothetical protein +FIG01060164 FIG01060171: hypothetical protein +FIG01060171 FIG01060174: hypothetical protein +FIG01060174 FIG01060180: hypothetical protein +FIG01060184 FIG01060185: hypothetical protein +FIG01060185 FIG01056778: hypothetical protein +FIG01060186 FIG01060187: hypothetical protein +FIG01060187 FIG01060189: hypothetical protein +FIG01060189 FIG01060191: hypothetical protein +FIG01060195 FIG01060196: hypothetical protein +FIG01060196 FIG01060197: hypothetical protein +FIG01060197 FIG01060199: hypothetical protein +FIG01060201 FIG01060203: hypothetical protein +FIG01060203 FIG01060209: hypothetical protein +FIG01060210 FIG01060212: hypothetical protein +FIG01060212 FIG01060213: hypothetical protein +FIG01060216 FIG01060217: hypothetical protein +FIG01060223 FIG01060224: hypothetical protein +FIG01060224 FIG01060228: hypothetical protein +FIG01060228 FIG01060234: hypothetical protein +FIG01060234 FIG01060235: hypothetical protein +FIG01060238 FIG01060239: hypothetical protein +FIG01060239 FIG01060240: hypothetical protein +FIG01060240 FIG01060244: hypothetical protein +FIG01060244 Transposon Tn7 transposition protein tnsE +FIG01060250 FIG01060252: hypothetical protein +FIG01060258 Transcriptional regulator, LysR family, homolog 10 +FIG01060266 FIG01060274: hypothetical protein +FIG01060283 FIG01060287: hypothetical protein +FIG01060298 FIG01060302: hypothetical protein +FIG01060302 FIG01060304: hypothetical protein +FIG01060304 FIG01060307: hypothetical protein +FIG01060307 FIG01060308: hypothetical protein +FIG01060308 FIG01060312: hypothetical protein +FIG01060312 FIG01060314: hypothetical protein +FIG01060314 FIG01060315: hypothetical protein +FIG01060315 FIG01067482: hypothetical protein +FIG01060327 FIG01060328: hypothetical protein +FIG01060329 FIG01060330: hypothetical protein +FIG01060330 FIG01060331: hypothetical protein +FIG01060335 FIG01060338: hypothetical protein +FIG01060341 protein of unknown function DUF331 +FIG01060343 FIG01060344: hypothetical protein +FIG01060344 FIG01060346: hypothetical protein +FIG01060346 FIG01060352: hypothetical protein +FIG01060356 FIG01060357: hypothetical protein +FIG01060357 FIG01060362: hypothetical protein +FIG01060367 FIG01060368: hypothetical protein +FIG01060368 FIG01060369: hypothetical protein +FIG01060369 FIG01060372: hypothetical protein +FIG01060372 FIG01060375: hypothetical protein +FIG01060376 FIG01060378: hypothetical protein +FIG01060378 FIG01060380: hypothetical protein +FIG01060380 FIG01060384: hypothetical protein +FIG01060384 FIG01060387: hypothetical protein +FIG01060388 FIG01060390: hypothetical protein +FIG01060390 FIG01060394: hypothetical protein +FIG01060397 FIG01060398: hypothetical protein +FIG01060398 FIG01060400: hypothetical protein +FIG01060400 FIG01060402: hypothetical protein +FIG01060402 FIG01060403: hypothetical protein +FIG01060403 FIG01060404: hypothetical protein +FIG01060404 FIG01060405: hypothetical protein +FIG01060405 Decaheme cytochrome c +FIG01060408 FIG01060411: hypothetical protein +FIG01060417 FIG01060418: hypothetical protein +FIG01060418 FIG01060419: hypothetical protein +FIG01060420 FIG01060421: hypothetical protein +FIG01060423 FIG01060425: hypothetical protein +FIG01060425 FIG01060429: hypothetical protein +FIG01060431 FIG01060436: hypothetical protein +FIG01060437 FIG01060444: hypothetical protein +FIG01060444 FIG01060445: hypothetical protein +FIG01060445 FIG01060446: hypothetical protein +FIG01060457 FIG01060459: hypothetical protein +FIG01060460 FIG01060461: hypothetical protein +FIG01060461 FIG01060464: hypothetical protein +FIG01060473 FIG01060474: hypothetical protein +FIG01060481 FIG01060483: hypothetical protein +FIG01060485 FIG01060486: hypothetical protein +FIG01060486 FIG01060490: hypothetical protein +FIG01060490 FIG01060499: hypothetical protein +FIG01060499 FIG01060500: hypothetical protein +FIG01060500 FIG01060503: hypothetical protein +FIG01060503 FIG01060506: hypothetical protein +FIG01060506 FIG01060510: hypothetical protein +FIG01060521 FIG01060522: hypothetical protein +FIG01060522 FIG01060525: hypothetical protein +FIG01060542 FIG01060544: hypothetical protein +FIG01060556 FIG01060558: hypothetical protein +FIG01060562 FIG01060563: hypothetical protein +FIG01060563 FIG01060565: hypothetical protein +FIG01060568 FIG01060571: hypothetical protein +FIG01060572 FIG01060574: hypothetical protein +FIG01060575 acyltransferase domain protein +FIG01060577 FIG01060578: hypothetical protein +FIG01060580 Protein of unknown function DUF467 +FIG01060586 FIG01060587: hypothetical protein +FIG01060590 FIG01060591: hypothetical protein +FIG01060592 FIG01060596: hypothetical protein +FIG01060600 FIG01060603: hypothetical protein +FIG01060610 FIG01060611: hypothetical protein +FIG01060613 FIG01060616: hypothetical protein +FIG01060616 FIG01060625: hypothetical protein +FIG01060625 FIG01060629: hypothetical protein +FIG01060629 FIG01060630: hypothetical protein +FIG01060632 FIG01060633: hypothetical protein +FIG01060636 FIG01060637: hypothetical protein +FIG01060651 FIG01060652: hypothetical protein +FIG01060652 FIG01060654: hypothetical protein +FIG01060654 FIG01060657: hypothetical protein +FIG01060665 FIG01060667: hypothetical protein +FIG01060674 FIG01060675: hypothetical protein +FIG01060679 FIG01060689: hypothetical protein +FIG01060695 FIG01060697: hypothetical protein +FIG01060709 FIG01060712: hypothetical protein +FIG01060713 FIG01060715: hypothetical protein +FIG01060716 FIG01060718: hypothetical protein +FIG01060718 hypothetical protein +FIG01060732 FIG01060735: hypothetical protein +FIG01060735 FIG01060748: hypothetical protein +FIG01060748 FIG01060759: hypothetical protein +FIG01060761 Mlr5283 protein +FIG01060762 FIG01060763: hypothetical protein +FIG01060764 FIG01060765: hypothetical protein +FIG01060772 FIG01060773: hypothetical protein +FIG01060777 FIG01060781: hypothetical protein +FIG01060789 FIG01060791: hypothetical protein +FIG01060794 FIG01060798: hypothetical protein +FIG01060804 FIG01060805: hypothetical protein +FIG01060805 FIG01060806: hypothetical protein +FIG01060806 FIG01060809: hypothetical protein +FIG01060809 FIG01065933: hypothetical protein +FIG01060810 FIG01060815: hypothetical protein +FIG01060815 FIG01060820: hypothetical protein +FIG01060828 FIG01060830: hypothetical protein +FIG01060830 FIG01060832: hypothetical protein +FIG01060838 FIG01060839: hypothetical protein +FIG01060850 FIG01060852: hypothetical protein +FIG01060852 FIG01060854: hypothetical protein +FIG01060866 FIG01060872: hypothetical protein +FIG01060876 FIG01060877: hypothetical protein +FIG01060881 FIG01060882: hypothetical protein +FIG01060899 FIG01060901: hypothetical protein +FIG01060901 FIG01060905: hypothetical protein +FIG01060905 FIG01060907: hypothetical protein +FIG01060908 FIG01060911: hypothetical protein +FIG01060916 FIG01060923: hypothetical protein +FIG01060923 FIG01060925: hypothetical protein +FIG01060932 FIG01060933: hypothetical protein +FIG01060953 FIG01060954: hypothetical protein +FIG01060958 FIG01060959: hypothetical protein +FIG01060959 FIG01060961: hypothetical protein +FIG01060965 Methyl-accepting chemotaxis protein, homolog 3 +FIG01060974 FIG01060977: hypothetical protein +FIG01060992 FIG01060999: hypothetical protein +FIG01060999 FIG01061011: hypothetical protein +FIG01061014 FIG01061015: hypothetical protein +FIG01061019 FIG01061021: hypothetical protein +FIG01061021 Spermidine acetyltransferase +FIG01061023 FIG01061026: hypothetical protein +FIG01061026 FIG01061027: hypothetical protein +FIG01061027 FIG01061028: hypothetical protein +FIG01061028 FIG01061029: hypothetical protein +FIG01061030 FIG01061031: hypothetical protein +FIG01061033 FIG01061036: hypothetical protein +FIG01061037 FIG01061039: hypothetical protein +FIG01061041 FIG01061042: hypothetical protein +FIG01061042 FIG01061045: hypothetical protein +FIG01061046 FIG01061047: hypothetical protein +FIG01061047 FIG01061049: hypothetical protein +FIG01061049 FIG01057995: hypothetical protein +FIG01061064 FIG01061170: hypothetical protein +FIG01061073 FIG01061076: hypothetical protein +FIG01061077 FIG01061081: hypothetical protein +FIG01061084 FIG01061086: hypothetical protein +FIG01061086 FIG01061090: hypothetical protein +FIG01061090 FIG01061091: hypothetical protein +FIG01061092 FIG01061093: hypothetical protein +FIG01061095 FIG01061097: hypothetical protein +FIG01061100 FIG01061101: hypothetical protein +FIG01061107 FIG01061110: hypothetical protein +FIG01061110 FIG01061113: hypothetical protein +FIG01061127 FIG01061130: hypothetical protein +FIG01061130 FIG01061131: hypothetical protein +FIG01061131 FIG01061133: hypothetical protein +FIG01061133 FIG01061134: hypothetical protein +FIG01061143 FIG01061153: hypothetical protein +FIG01061153 FIG01203453: hypothetical protein +FIG01061159 FIG01061163: hypothetical protein +FIG01061165 FIG01061166: hypothetical protein +FIG01061167 FIG01061169: hypothetical protein +FIG01061173 Prepilin-type cleavage/methylation-like protein +FIG01061180 similar to protein-disulfide isomerase +FIG01061181 FIG01061183: hypothetical protein +FIG01061190 FIG01061191: hypothetical protein +FIG01061195 FIG01061198: hypothetical protein +FIG01061199 FIG01061204: hypothetical protein +FIG01061204 FIG01061205: hypothetical protein +FIG01061218 FIG01061219: hypothetical protein +FIG01061223 FIG01061224: hypothetical protein +FIG01061224 FIG01061228: hypothetical protein +FIG01061230 FIG01061236: hypothetical protein +FIG01061236 FIG01061237: hypothetical protein +FIG01061238 FIG01061240: hypothetical protein +FIG01061240 FIG01061243: hypothetical protein +FIG01061243 HPP domain-containing protein +FIG01061245 FIG01061248: hypothetical protein +FIG01061249 FIG01061251: hypothetical protein +FIG01061254 FIG01061256: hypothetical protein +FIG01061256 FIG01061258: hypothetical protein +FIG01061259 FIG01061264: hypothetical protein +FIG01061264 FIG01061266: hypothetical protein +FIG01061266 surface localized undecaheme cytochrome c lipoprotein, UndB +FIG01061268 FIG01061270: hypothetical protein +FIG01061272 FIG01061273: hypothetical protein +FIG01061289 FIG01061290: hypothetical protein +FIG01061290 Lysine exporter protein (LYSE/YGGA) +FIG01061292 FIG01061293: hypothetical protein +FIG01061293 FIG01061294: hypothetical protein +FIG01061300 FIG01061304: hypothetical protein +FIG01061304 FIG01061305: hypothetical protein +FIG01061305 FIG01061314: hypothetical protein +FIG01061322 FIG01061330: hypothetical protein +FIG01061330 FIG01061331: hypothetical protein +FIG01061331 FIG01061332: hypothetical protein +FIG01061334 FIG01061335: hypothetical protein +FIG01061340 FIG01061346: hypothetical protein +FIG01061346 FIG01061354: hypothetical protein +FIG01061365 FIG01061366: hypothetical protein +FIG01061366 COGs COG0226 +FIG01061367 FIG01061368: hypothetical protein +FIG01061369 FIG01061370: hypothetical protein +FIG01061370 FIG01061371: hypothetical protein +FIG01061371 FIG01061372: hypothetical protein +FIG01061372 FIG01061374: hypothetical protein +FIG01061384 FIG01061391: hypothetical protein +FIG01061391 FIG01061394: hypothetical protein +FIG01061394 Sodium/hydrogen exchanger family protein +FIG01061403 FIG01061408: hypothetical protein +FIG01061414 FIG01061415: hypothetical protein +FIG01061421 FIG01061422: hypothetical protein +FIG01061429 FIG01061431: hypothetical protein +FIG01061433 FIG01061435: hypothetical protein +FIG01061441 FIG01061442: hypothetical protein +FIG01061442 FIG01062974: hypothetical protein +FIG01061451 FIG01061452: hypothetical protein +FIG01061452 FIG01061453: hypothetical protein +FIG01061453 Modification methylase (EC 2.1.1.37) +FIG01061456 Phage-related regulatory protein cII +FIG01061457 FIG01061459: hypothetical protein +FIG01061459 FIG01061460: hypothetical protein +FIG01061480 FIG01061486: hypothetical protein +FIG01061486 FIG01061489: hypothetical protein +FIG01061495 FIG01061500: hypothetical protein +FIG01061504 FIG01061507: hypothetical protein +FIG01061515 FIG01061522: hypothetical protein +FIG01061522 FIG01061526: hypothetical protein +FIG01061526 FIG01061527: hypothetical protein +FIG01061528 FIG01061533: hypothetical protein +FIG01061536 FIG01061538: hypothetical protein +FIG01061538 Membrane lipoprotein +FIG01061550 FIG01061555: hypothetical protein +FIG01061557 FIG01061562: hypothetical protein +FIG01061562 FIG01061565: hypothetical protein +FIG01061575 Putative hemagglutinin/hemolysin-related protein +FIG01061576 FIG01061578: hypothetical protein +FIG01061593 FIG01061595: hypothetical protein +FIG01061598 metallo-beta-lactamase superfamily, putative +FIG01061608 FIG01061609: hypothetical protein +FIG01061609 FIG01061610: hypothetical protein +FIG01061612 FIG01061615: hypothetical protein +FIG01061617 FIG01061619: hypothetical protein +FIG01061620 FIG01061621: hypothetical protein +FIG01061625 FIG01061631: hypothetical protein +FIG01061631 FIG01061632: hypothetical protein +FIG01061632 FIG01061635: hypothetical protein +FIG01061635 FIG01061643: hypothetical protein +FIG01061643 FIG01061652: hypothetical protein +FIG01061668 SICP +FIG01061675 FIG01061676: hypothetical protein +FIG01061676 FIG01061677: hypothetical protein +FIG01061707 prophage MuSo1, transcriptional regulator, Cro/CI family +FIG01061709 FIG01061711: hypothetical protein +FIG01061712 FIG01061713: hypothetical protein +FIG01061713 FIG01061715: hypothetical protein +FIG01061721 FIG01061728: hypothetical protein +FIG01061729 FIG01061730: hypothetical protein +FIG01061749 FIG01061752: hypothetical protein +FIG01061752 Hypothetical, similar to orf34 (AB008550) [phage phi CTX] +FIG01061763 FIG01061764: hypothetical protein +FIG01061764 FIG01061765: hypothetical protein +FIG01061771 FIG01061772: hypothetical protein +FIG01061783 Molybdenum cofactor biosynthesis enzyme +FIG01061786 FIG01061787: hypothetical protein +FIG01061787 FIG01061788: hypothetical protein +FIG01061788 pesticin domain protein +FIG01061813 FIG01061814: hypothetical protein +FIG01061814 FIG01061818: hypothetical protein +FIG01061824 FIG01061826: hypothetical protein +FIG01061845 FIG01061848: hypothetical protein +FIG01061849 FIG01061853: hypothetical protein +FIG01061853 FIG01061858: hypothetical protein +FIG01061858 FIG01061859: hypothetical protein +FIG01061864 FIG01061867: hypothetical protein +FIG01061875 FIG01061879: hypothetical protein +FIG01061879 FIG01061881: hypothetical protein +FIG01061881 FIG01061885: hypothetical protein +FIG01061888 FIG01061890: hypothetical protein +FIG01061892 FIG01061894: hypothetical protein +FIG01061900 FIG01061901: hypothetical protein +FIG01061903 FIG01061904: hypothetical protein +FIG01061914 FIG01061926: hypothetical protein +FIG01061926 FIG01061928: hypothetical protein +FIG01061928 FIG01061930: hypothetical protein +FIG01061930 FIG01061935: hypothetical protein +FIG01061935 FIG01061944: hypothetical protein +FIG01061944 FIG01061945: hypothetical protein +FIG01061946 FIG01061947: hypothetical protein +FIG01061955 FIG00784464: hypothetical protein +FIG01061958 FIG01061961: hypothetical protein +FIG01061966 FIG01061969: hypothetical protein +FIG01061969 FIG01061971: hypothetical protein +FIG01061973 FIG01061974: hypothetical protein +FIG01062000 FIG01062002: hypothetical protein +FIG01062002 FIG01062004: hypothetical protein +FIG01062009 FIG01062011: hypothetical protein +FIG01062012 acetyltransferase including N-acetylase of ribosomal protein +FIG01062015 FIG01062017: hypothetical protein +FIG01062017 hypothetical protein +FIG01062022 prophage MuMc02, structural protein P5 +FIG01062026 FIG01062031: hypothetical protein +FIG01062036 FIG01062052: hypothetical protein +FIG01062055 FIG01062056: hypothetical protein +FIG01062057 FIG01062058: hypothetical protein +FIG01062058 FIG01062062: hypothetical protein +FIG01062062 FIG01062067: hypothetical protein +FIG01062079 FIG01062086: hypothetical protein +FIG01062086 Pilin glycosylation enzyme +FIG01062089 FIG01062095: hypothetical protein +FIG01062096 FIG01062099: hypothetical protein +FIG01062107 FIG01062108: hypothetical protein +FIG01062114 FIG01062118: hypothetical protein +FIG01062128 FIG01062130: hypothetical protein +FIG01062146 FIG01062149: hypothetical protein +FIG01062151 FIG01062155: hypothetical protein +FIG01062164 FIG01200099: hypothetical protein +FIG01062165 FIG01062166: hypothetical protein +FIG01062166 FIG01062169: hypothetical protein +FIG01062169 FIG01062171: hypothetical protein +FIG01062171 FIG01062172: hypothetical protein +FIG01062174 FIG01062179: hypothetical protein +FIG01062179 FIG01062186: hypothetical protein +FIG01062191 FIG01062198: hypothetical protein +FIG01062203 FIG01062206: hypothetical protein +FIG01062206 FIG01062207: hypothetical protein +FIG01062207 FIG01062208: hypothetical protein +FIG01062213 FIG01062215: hypothetical protein +FIG01062223 FIG01062225: hypothetical protein +FIG01062225 FIG01062227: hypothetical protein +FIG01062228 FIG01062233: hypothetical protein +FIG01062233 FIG01062241: hypothetical protein +FIG01062241 FIG01062242: hypothetical protein +FIG01062242 FIG01062248: hypothetical protein +FIG01062263 FIG01062266: hypothetical protein +FIG01062272 FIG01062273: hypothetical protein +FIG01062275 prophage LambdaSo, DNA modification methyltransferase, putative +FIG01062276 FIG01062286: hypothetical protein +FIG01062298 FIG01062304: hypothetical protein +FIG01062305 FIG01062306: hypothetical protein +FIG01062306 FIG01062311: hypothetical protein +FIG01062311 FIG01062314: hypothetical protein +FIG01062317 FIG01062319: hypothetical protein +FIG01062322 FIG01062326: hypothetical protein +FIG01062327 FIG01062331: hypothetical protein +FIG01062331 FIG01062333: hypothetical protein +FIG01062356 FIG01062360: hypothetical protein +FIG01062360 FIG01062361: hypothetical protein +FIG01062383 AraC-type DNA-binding domain-containing proteins-like +FIG01062390 FIG01062391: hypothetical protein +FIG01062400 FIG01062401: hypothetical protein +FIG01062401 FIG01062407: hypothetical protein +FIG01062407 FIG01062409: hypothetical protein +FIG01062416 FIG01062417: hypothetical protein +FIG01062426 FIG01062430: hypothetical protein +FIG01062444 FIG01062445: hypothetical protein +FIG01062464 FIG01062465: hypothetical protein +FIG01062466 FIG01062469: hypothetical protein +FIG01062481 FIG01062485: hypothetical protein +FIG01062485 FIG01062489: hypothetical protein +FIG01062493 FIG01062495: hypothetical protein +FIG01062495 FIG01062496: hypothetical protein +FIG01062509 FIG01062512: hypothetical protein +FIG01062516 FIG01062518: hypothetical protein +FIG01062518 FIG01062525: hypothetical protein +FIG01062525 FIG01062530: hypothetical protein +FIG01062530 FIG01062536: hypothetical protein +FIG01062536 FIG01062537: hypothetical protein +FIG01062547 FIG01062549: hypothetical protein +FIG01062552 FIG01062554: hypothetical protein +FIG01062554 FIG01062557: hypothetical protein +FIG01062557 FIG01062558: hypothetical protein +FIG01062563 FIG01062564: hypothetical protein +FIG01062564 FIG01062570: hypothetical protein +FIG01062577 FIG01062578: hypothetical protein +FIG01062586 HicB-related protein +FIG01062588 FIG01062594: hypothetical protein +FIG01062594 FIG01062597: hypothetical protein +FIG01062599 FIG01062602: hypothetical protein +FIG01062602 FIG01062603: hypothetical protein +FIG01062603 FIG01062604: hypothetical protein +FIG01062604 FIG01062606: hypothetical protein +FIG01062643 FIG01062644: hypothetical protein +FIG01062658 FIG01062659: hypothetical protein +FIG01062676 FIG01062681: hypothetical protein +FIG01062692 FIG01062698: hypothetical protein +FIG01062698 FIG01062703: hypothetical protein +FIG01062703 FIG01062704: hypothetical protein +FIG01062719 FIG01062720: hypothetical protein +FIG01062724 FIG01062725: hypothetical protein +FIG01062725 FIG01062726: hypothetical protein +FIG01062726 hypothetical protein +FIG01062730 FIG01062732: hypothetical protein +FIG01062734 FIG01062736: hypothetical protein +FIG01062738 FIG01062745: hypothetical protein +FIG01062746 FIG01062751: hypothetical protein +FIG01062751 FIG01062753: hypothetical protein +FIG01062761 FIG01062763: hypothetical protein +FIG01062775 FIG01062776: hypothetical protein +FIG01062789 FIG01062795: hypothetical protein +FIG01062805 helix-turn-helix, AraC type +FIG01062807 FIG01062808: hypothetical protein +FIG01062808 FIG01062811: hypothetical protein +FIG01062813 FIG01062815: hypothetical protein +FIG01062815 FIG01062816: hypothetical protein +FIG01062823 FIG01062825: hypothetical protein +FIG01062832 FIG01062838: hypothetical protein +FIG01062839 AFG1-family ATPase +FIG01062855 FIG01062858: hypothetical protein +FIG01062881 FIG01062882: hypothetical protein +FIG01062889 FIG01062890: hypothetical protein +FIG01062891 FIG01062892: hypothetical protein +FIG01062892 Anion permease ArsB/NhaD-like +FIG01062914 FIG01062915: hypothetical protein +FIG01062919 FIG01062920: hypothetical protein +FIG01062929 Bll3563 protein +FIG01062939 FIG01062942: hypothetical protein +FIG01062961 FIG01062964: hypothetical protein +FIG01062965 FIG01062966: hypothetical protein +FIG01062975 FIG01062979: hypothetical protein +FIG01062986 FIG01062989: hypothetical protein +FIG01062999 FIG01063001: hypothetical protein +FIG01063002 FIG01063003: hypothetical protein +FIG01063012 FIG01063014: hypothetical protein +FIG01063033 FIG01063037: hypothetical protein +FIG01063037 Probable peptidase yuxL (EC 3.4.21.-) +FIG01063044 FIG01063047: hypothetical protein +FIG01063057 hypothetical protein +FIG01063075 NiFe-hydrogenase I cytochrome b subunit +FIG01063087 FIG01063088: hypothetical protein +FIG01063092 FIG01063096: hypothetical protein +FIG01063097 Cys-tRNA(Pro) deacylase YbaK +FIG01063101 FIG01063103: hypothetical protein +FIG01063112 FIG01063113: hypothetical protein +FIG01063125 FIG01063128: hypothetical protein +FIG01063135 FIG01063137: hypothetical protein +FIG01063147 FIG01063149: hypothetical protein +FIG01063183 FIG01063184: hypothetical protein +FIG01063187 FIG01063188: hypothetical protein +FIG01063189 FIG01063193: hypothetical protein +FIG01063200 FIG01063205: hypothetical protein +FIG01063205 FIG01063207: hypothetical protein +FIG01063243 Steroid Delta-isomerase (EC 5.3.3.1) (Delta(5)-3-ketosteroid isomerase) +FIG01063251 FIG01063255: hypothetical protein +FIG01063262 FIG01063264: hypothetical protein +FIG01063270 Amino acid ABC transporter, periplasmic amino acid-binding precursor +FIG01063273 FIG01063276: hypothetical protein +FIG01063276 FIG01063281: hypothetical protein +FIG01063282 FIG01063286: hypothetical protein +FIG01063300 FIG01063301: hypothetical protein +FIG01063306 FIG01063307: hypothetical protein +FIG01063310 FIG01063312: hypothetical protein +FIG01063318 FIG01063323: hypothetical protein +FIG01063325 Secretion system apparatus SsaD +FIG01063328 FIG01063330: hypothetical protein +FIG01063334 FIG01063337: hypothetical protein +FIG01063337 FIG01063338: hypothetical protein +FIG01063347 FIG01063348: hypothetical protein +FIG01063363 FIG01063370: hypothetical protein +FIG01063378 FIG01063379: hypothetical protein +FIG01063399 FIG01063407: hypothetical protein +FIG01063407 FIG01063412: hypothetical protein +FIG01063424 decaheme cytochrome c MtrF +FIG01063425 FIG01063429: hypothetical protein +FIG01063432 FIG01063433: hypothetical protein +FIG01063443 WblR protein +FIG01063444 FIG01063448: hypothetical protein +FIG01063458 Modification methylase Bsp6I +FIG01063464 FIG01063468: hypothetical protein +FIG01063471 FIG01063474: hypothetical protein +FIG01063474 FIG01063475: hypothetical protein +FIG01063476 FIG01063479: hypothetical protein +FIG01063496 FIG01063499: hypothetical protein +FIG01063501 FIG01063503: hypothetical protein +FIG01063503 FIG01063504: hypothetical protein +FIG01063504 FIG01063509: hypothetical protein +FIG01063509 FIG01063515: hypothetical protein +FIG01063528 FIG01063529: hypothetical protein +FIG01063532 Uncharacterized protein Mlr1045 +FIG01063533 FIG01063534: hypothetical protein +FIG01063550 FIG01063551: hypothetical protein +FIG01063552 FIG01063555: hypothetical protein +FIG01063564 Nucleoside-binding outer membrane protein +FIG01063574 FIG01063576: hypothetical protein +FIG01063578 FIG01063579: hypothetical protein +FIG01063579 FIG01063580: hypothetical protein +FIG01063591 predicted glycosyltransferase +FIG01063598 FIG01063599: hypothetical protein +FIG01063600 FIG01063603: hypothetical protein +FIG01063610 FIG01063614: hypothetical protein +FIG01063617 FIG01063618: hypothetical protein +FIG01063623 FIG01063624: hypothetical protein +FIG01063629 FIG01063632: hypothetical protein +FIG01063635 FIG01063637: hypothetical protein +FIG01063643 FIG01063645: hypothetical protein +FIG01063647 FIG01063651: hypothetical protein +FIG01063651 FIG01063655: hypothetical protein +FIG01063671 FIG01063673: hypothetical protein +FIG01063675 FIG01063676: hypothetical protein +FIG01063687 FIG01063688: hypothetical protein +FIG01063704 FIG01063705: hypothetical protein +FIG01063706 FIG01063707: hypothetical protein +FIG01063711 Restriction endonuclease PvuRts1 I +FIG01063724 FIG01063731: hypothetical protein +FIG01063737 FIG01063741: hypothetical protein +FIG01063756 FIG01063757: hypothetical protein +FIG01063757 FIG01063759: hypothetical protein +FIG01063769 FIG01063776: hypothetical protein +FIG01063783 FIG01063788: hypothetical protein +FIG01063790 Split-Soret cytochrome c +FIG01063808 FIG01063820: hypothetical protein +FIG01063846 FIG01063847: hypothetical protein +FIG01063847 Putative subunit of Alternative cytochrome c oxidase +FIG01063865 FIG01063871: hypothetical protein +FIG01063871 FIG01063880: hypothetical protein +FIG01063897 FIG01063904: hypothetical protein +FIG01063919 FIG01063920: hypothetical protein +FIG01063932 FIG01063940: hypothetical protein +FIG01063940 His-Xaa-Ser system protein HxsD +FIG01063975 FIG01063980: hypothetical protein +FIG01063984 FIG01063988: hypothetical protein +FIG01063989 FIG01063990: hypothetical protein +FIG01064009 FIG01064010: hypothetical protein +FIG01064027 FIG01064028: hypothetical protein +FIG01064028 FIG01064032: hypothetical protein +FIG01064033 FIG01064034: hypothetical protein +FIG01064040 FIG01064048: hypothetical protein +FIG01064048 FIG01064051: hypothetical protein +FIG01064061 FIG01064062: hypothetical protein +FIG01064102 FIG01064105: hypothetical protein +FIG01064109 FIG01064110: hypothetical protein +FIG01064115 Octopine catabolism/uptake operon regulatory protein occR +FIG01064116 FIG01064118: hypothetical protein +FIG01064118 FIG01064120: hypothetical protein +FIG01064123 FIG01064125: hypothetical protein +FIG01064130 FIG01064132: hypothetical protein +FIG01064132 FIG01064133: hypothetical protein +FIG01064143 FIG01064145: hypothetical protein +FIG01064152 FIG01064154: hypothetical protein +FIG01064155 FIG01064160: hypothetical protein +FIG01064170 Cylicin II +FIG01064175 FIG01064178: hypothetical protein +FIG01064178 FIG01064179: hypothetical protein +FIG01064179 FIG01064181: hypothetical protein +FIG01064181 FIG01064185: hypothetical protein +FIG01064217 FIG01064221: hypothetical protein +FIG01064221 FIG01064225: hypothetical protein +FIG01064228 FIG01064229: hypothetical protein +FIG01064230 FIG01064232: hypothetical protein +FIG01064236 FIG01064240: hypothetical protein +FIG01064253 FIG01064259: hypothetical protein +FIG01064259 FIG01064265: hypothetical protein +FIG01064265 transcriptional regulator, XRE family +FIG01064267 Repressor protein CI +FIG01064268 FIG01064269: hypothetical protein +FIG01064269 FIG01064270: hypothetical protein +FIG01064318 FIG01064319: hypothetical protein +FIG01064332 FIG01064336: hypothetical protein +FIG01064336 FIG01064338: hypothetical protein +FIG01064339 Sodium:alanine symporter +FIG01064360 FIG01064362: hypothetical protein +FIG01064380 FIG01064382: hypothetical protein +FIG01064384 mobile mystery protein B +FIG01064389 Protein of unknown function DUF102 +FIG01064392 FIG01064394: hypothetical protein +FIG01064401 FIG01064402: hypothetical protein +FIG01064409 FIG01064410: hypothetical protein +FIG01064419 FIG01064421: hypothetical protein +FIG01064439 FIG01064440: hypothetical protein +FIG01064443 FIG01064444: hypothetical protein +FIG01064444 FIG01064446: hypothetical protein +FIG01064461 FIG01064462: hypothetical protein +FIG01064468 FIG01064470: hypothetical protein +FIG01064478 FIG01064479: hypothetical protein +FIG01064479 FIG01064480: hypothetical protein +FIG01064480 FIG01064482: hypothetical protein +FIG01064485 FIG01064488: hypothetical protein +FIG01064493 FIG01064498: hypothetical protein +FIG01064504 putative cation efflux protein +FIG01064508 FIG01064515: hypothetical protein +FIG01064528 FIG01064529: hypothetical protein +FIG01064529 FIG01064531: hypothetical protein +FIG01064531 FIG01064539: hypothetical protein +FIG01064546 protein of unknown function UPF0057 +FIG01064547 FIG01064549: hypothetical protein +FIG01064551 FIG01064553: hypothetical protein +FIG01064563 prophage MuSo1, positive regulator of late transcription, putative +FIG01064564 FIG01064565: hypothetical protein +FIG01064574 FIG01064576: hypothetical protein +FIG01064580 FIG01064581: hypothetical protein +FIG01064581 IntegraseI +FIG01064583 FIG01064590: hypothetical protein +FIG01064591 FIG01064593: hypothetical protein +FIG01064603 FIG01064604: hypothetical protein +FIG01064604 FIG01064608: hypothetical protein +FIG01064623 FIG01064625: hypothetical protein +FIG01064625 FIG01064629: hypothetical protein +FIG01064640 FIG01064649: hypothetical protein +FIG01064661 type II site-specific deoxyribonuclease +FIG01064662 FIG01064664: hypothetical protein +FIG01064664 FIG01063049: hypothetical protein +FIG01064669 FIG01064671: hypothetical protein +FIG01064677 FIG01064679: hypothetical protein +FIG01064684 FIG01064689: hypothetical protein +FIG01064713 FIG01064714: hypothetical protein +FIG01064716 transcriptional regulator, CopG family +FIG01064736 FIG01064746: hypothetical protein +FIG01064746 FIG01064748: hypothetical protein +FIG01064753 FIG01064760: hypothetical protein +FIG01064763 FIG01064767: hypothetical protein +FIG01064767 FIG01064769: hypothetical protein +FIG01064770 FIG01064772: hypothetical protein +FIG01064784 ApbE family lipoprotein +FIG01064785 FIG01064792: hypothetical protein +FIG01064809 FIG01064811: hypothetical protein +FIG01064829 FIG01064833: hypothetical protein +FIG01064838 FIG01064844: hypothetical protein +FIG01064860 FIG01064861: hypothetical protein +FIG01064887 FIG01064888: hypothetical protein +FIG01064890 FIG01064900: hypothetical protein +FIG01064903 FIG01064907: hypothetical protein +FIG01064908 FIG01064913: hypothetical protein +FIG01064916 Fmu (Sun) /eukaryotic nucleolar NOL1/Nop2p +FIG01064921 FIG01064922: hypothetical protein +FIG01064961 FIG01064970: hypothetical protein +FIG01064977 FIG01064978: hypothetical protein +FIG01065001 FIG01065003: hypothetical protein +FIG01065035 FIG01065037: hypothetical protein +FIG01065037 FIG01065038: hypothetical protein +FIG01065038 FIG01065043: hypothetical protein +FIG01065053 FIG01065057: hypothetical protein +FIG01065057 FIG01065062: hypothetical protein +FIG01065062 helix-destabilizing protein +FIG01065064 FIG01065065: hypothetical protein +FIG01065082 FIG01065097: hypothetical protein +FIG01065141 FIG01065146: hypothetical protein +FIG01065146 FIG01065149: hypothetical protein +FIG01065167 FIG01065169: hypothetical protein +FIG01065169 FIG01065172: hypothetical protein +FIG01065191 hypothetical ammonia permease +FIG01065205 FIG01065207: hypothetical protein +FIG01065255 FIG01065259: hypothetical protein +FIG01065259 FIG01065263: hypothetical protein +FIG01065270 FIG01065274: hypothetical protein +FIG01065274 FIG01065275: hypothetical protein +FIG01065278 FIG01065279: hypothetical protein +FIG01065279 FIG01065282: hypothetical protein +FIG01065282 FIG01065287: hypothetical protein +FIG01065301 FIG01065302: hypothetical protein +FIG01065311 FIG01065315: hypothetical protein +FIG01065331 FIG01065341: hypothetical protein +FIG01065353 FIG01065361: hypothetical protein +FIG01065378 FIG01065383: hypothetical protein +FIG01065412 Cytochrome P460 +FIG01065428 FIG01065440: hypothetical protein +FIG01065451 FIG01065456: hypothetical protein +FIG01065456 FIG01065457: hypothetical protein +FIG01065457 FIG01065459: hypothetical protein +FIG01065461 FIG01065469: hypothetical protein +FIG01065469 FIG01065472: hypothetical protein +FIG01065472 FIG01065476: hypothetical protein +FIG01065476 FIG01065479: hypothetical protein +FIG01065496 FIG01065497: hypothetical protein +FIG01065510 FIG01065514: hypothetical protein +FIG01065517 FIG01065518: hypothetical protein +FIG01065518 FIG01065523: hypothetical protein +FIG01065523 FIG01065524: hypothetical protein +FIG01065524 FIG01065526: hypothetical protein +FIG01065526 FIG01065533: hypothetical protein +FIG01065535 FIG01065542: hypothetical protein +FIG01065558 prophage MuSo1, protein Gp32, putative +FIG01065563 FIG01065569: hypothetical protein +FIG01065574 FIG01065577: hypothetical protein +FIG01065588 FIG01065590: hypothetical protein +FIG01065596 FIG01065598: hypothetical protein +FIG01065610 FIG01065619: hypothetical protein +FIG01065629 Hydroxylamine oxidoreductase +FIG01065631 FIG01065644: hypothetical protein +FIG01065648 FIG01065649: hypothetical protein +FIG01065703 FIG01065706: hypothetical protein +FIG01065719 Protein transport protein hofB +FIG01065727 FIG01065730: hypothetical protein +FIG01065741 FIG01065747: hypothetical protein +FIG01065760 FIG01065761: hypothetical protein +FIG01065787 FIG01065790: hypothetical protein +FIG01065804 FIG01065809: hypothetical protein +FIG01065822 FIG01065824: hypothetical protein +FIG01065850 FIG01065856: hypothetical protein +FIG01065891 FIG01065892: hypothetical protein +FIG01065895 FIG01065904: hypothetical protein +FIG01065913 FIG01065916: hypothetical protein +FIG01065919 FIG01065920: hypothetical protein +FIG01065933 FIG01065936: hypothetical protein +FIG01065936 probable cell surface glycoprotein +FIG01065952 FIG01065953: hypothetical protein +FIG01065972 FIG01065977: hypothetical protein +FIG01065993 FIG01065994: hypothetical protein +FIG01066011 FIG01066014: hypothetical protein +FIG01066014 FIG01066015: hypothetical protein +FIG01066032 FIG01066040: hypothetical protein +FIG01066048 FIG01066049: hypothetical protein +FIG01066049 FIG01066050: hypothetical protein +FIG01066054 FIG01066055: hypothetical protein +FIG01066058 FIG01066067: hypothetical protein +FIG01066067 FIG01066068: hypothetical protein +FIG01066073 FIG01066074: hypothetical protein +FIG01066078 putative pore-forming cytotoxin integrase +FIG01066096 FIG01066101: hypothetical protein +FIG01066118 FIG01066120: hypothetical protein +FIG01066121 FIG01066123: hypothetical protein +FIG01066123 FIG01066125: hypothetical protein +FIG01066141 FIG01066145: hypothetical protein +FIG01066156 FIG01066158: hypothetical protein +FIG01066158 FIG01066173: hypothetical protein +FIG01066173 FIG01066177: hypothetical protein +FIG01066212 PQAA +FIG01066238 FIG01066246: hypothetical protein +FIG01066246 FIG01066248: hypothetical protein +FIG01066250 FIG01066255: hypothetical protein +FIG01066256 FIG01066262: hypothetical protein +FIG01066267 FIG01066275: hypothetical protein +FIG01066309 FIG01066313: hypothetical protein +FIG01066313 FIG01066329: hypothetical protein +FIG01066374 FIG01066377: hypothetical protein +FIG01066378 FIG01066381: hypothetical protein +FIG01066400 FIG01066401: hypothetical protein +FIG01066425 FIG01066426: hypothetical protein +FIG01066426 FIG01066431: hypothetical protein +FIG01066476 FIG01066477: hypothetical protein +FIG01066477 FIG01066478: hypothetical protein +FIG01066512 FIG01066513: hypothetical protein +FIG01066518 FIG01066523: hypothetical protein +FIG01066538 FIG01066539: hypothetical protein +FIG01066596 FIG01066605: hypothetical protein +FIG01066628 FIG01066631: hypothetical protein +FIG01066631 FIG01066634: hypothetical protein +FIG01066662 FIG01066663: hypothetical protein +FIG01066698 FIG01066708: hypothetical protein +FIG01066724 FIG01066730: hypothetical protein +FIG01066753 Peptidase S45, penicillin amidase precursor +FIG01066761 Formyl transferase domain protein +FIG01066810 FIG01066814: hypothetical protein +FIG01066834 FIG01066839: hypothetical protein +FIG01066901 FIG01066903: hypothetical protein +FIG01066903 FIG01066904: hypothetical protein +FIG01066913 FIG01066916: hypothetical protein +FIG01066916 FIG01066921: hypothetical protein +FIG01066954 FIG01066958: hypothetical protein +FIG01066959 FIG01066960: hypothetical protein +FIG01066960 FIG01066965: hypothetical protein +FIG01066982 FIG01066992: hypothetical protein +FIG01067007 FIG01067027: hypothetical protein +FIG01067078 FIG01067085: hypothetical protein +FIG01067182 FIG01067183: hypothetical protein +FIG01067190 FIG01067192: hypothetical protein +FIG01067262 FIG01067264: hypothetical protein +FIG01067338 FIG01067339: hypothetical protein +FIG01067339 FIG01067341: hypothetical protein +FIG01067341 FIG01067345: hypothetical protein +FIG01067353 FIG01067354: hypothetical protein +FIG01067354 hypothetical protein +FIG01067411 FIG01067416: hypothetical protein +FIG01067511 FIG01067512: hypothetical protein +FIG01067553 FIG01067554: hypothetical protein +FIG01067570 FIG01067577: hypothetical protein +FIG01067582 FIG01067583: hypothetical protein +FIG01067584 FIG01067587: hypothetical protein +FIG01067603 FIG01067604: hypothetical protein +FIG01067612 FIG01067636: hypothetical protein +FIG01067745 FIG01067748: hypothetical protein +FIG01067785 Lipopolysaccharide biosynthesis +FIG01067792 FIG01067796: hypothetical protein +FIG01067833 FIG01067838: hypothetical protein +FIG01067841 FIG01067842: hypothetical protein +FIG01067846 PROBABLE TONB-DEPENDENT RECEPTOR YBIL PRECURSOR +FIG01067852 FIG01067855: hypothetical protein +FIG01067872 COG4135: ABC-type uncharacterized transport system, permease component +FIG01067880 Multiple antibiotic resistance protein marC +FIG01067886 FIG01067888: hypothetical protein +FIG01067923 outer membrane autotransporter barrel domain protein +FIG01067929 FIG00642107: hypothetical protein +FIG01067958 FIG01067961: hypothetical protein +FIG01067992 FIG01067998: hypothetical protein +FIG01068018 2,5-diketo-D-gluconic acid reductase (EC 1.1.1.-) +FIG01068067 Virulence factor VirK +FIG01068068 FIG01068071: hypothetical protein +FIG01068071 FIG00639160: hypothetical protein +FIG01068082 Spa15 +FIG01068102 MxiH protein +FIG01068105 FIG01068108: hypothetical protein +FIG01068152 FIG00638980: hypothetical protein +FIG01068162 FIG01068165: hypothetical protein +FIG01068165 FIG01068168: hypothetical protein +FIG01068168 FIG01068177: hypothetical protein +FIG01068177 FIG01068181: hypothetical protein +FIG01068185 FIG01068186: hypothetical protein +FIG01068188 FIG01068196: hypothetical protein +FIG01068285 FIG00643431: hypothetical protein +FIG01068291 FIG01068293: hypothetical protein +FIG01068337 FIG01068340: hypothetical protein +FIG01068384 FIG01045890: hypothetical protein +FIG01068386 hypothetical protein +FIG01068387 FIG01068391: hypothetical protein +FIG01068412 Putative HTH-type transcriptional regulator ypdC +FIG01068427 hypothetical protein +FIG01068469 FIG00634007: hypothetical protein +FIG01068507 FIG01068513: hypothetical protein +FIG01068527 Uncharacterized fimbrial-like protein ygiL precursor +FIG01068530 LygF +FIG01068559 hypothetical protein +FIG01068586 Hypothetical oxidoreductase YgcW (EC 1.-.-.-) +FIG01068635 ABC transporter, solute-binding protein +FIG01068639 FIG01068656: hypothetical protein +FIG01068658 FIG01068667: hypothetical protein +FIG01068674 FIG01068676: hypothetical protein +FIG01068706 FIG01068710: hypothetical protein +FIG01068710 FIG01068711: hypothetical protein +FIG01068711 orf; Unknown function +FIG01068719 FIG00638885: hypothetical protein +FIG01068720 FIG01068724: hypothetical protein +FIG01068735 FIG01068739: hypothetical protein +FIG01068741 FIG01068751: hypothetical protein +FIG01068768 FIG010505: hypothetical protein +FIG01068774 invasion plasmid antigen fragment +FIG01068777 Uncharacterized protein YcdU +FIG01068820 FIG01068823: hypothetical protein +FIG01068830 Putative DMT superfamily metabolite efflux protein precursor +FIG01068840 FIG01068841: hypothetical protein +FIG01068853 Putative purine permease YbbY +FIG01068867 FIG01068875: hypothetical protein +FIG01068907 FIG01068909: hypothetical protein +FIG01068928 FIG01068929: hypothetical protein +FIG01068964 FIG01068969: hypothetical protein +FIG01068969 FIG01068982: hypothetical protein +FIG01068982 Uncharacterized metabolite ABC transporter in Enterobacteriaceae, permease protein EC-YbbP +FIG01069003 hypothetical protein +FIG01069007 FIG00638692: hypothetical protein +FIG01069060 FIG004212: hypothetical protein +FIG01069070 LysR family transcriptional regulator YgfI +FIG01069086 FIG01069091: hypothetical protein +FIG01069115 FIG00639856: hypothetical protein +FIG01069121 FIG00640177: hypothetical protein +FIG01069145 FIG00640166: hypothetical protein +FIG01069155 6-phospho-beta-glucosidase ascB (EC 3.2.1.86) / PTS system, arbutin-, cellobiose-, and salicin-specific IIBC component (EC 2.7.1.69) +FIG01069170 inner membrane protein yhiM +FIG01069174 FIG01069176: hypothetical protein +FIG01069176 FIG01069181: hypothetical protein +FIG01069185 FIG01069189: hypothetical protein +FIG01069189 FIG01069191: hypothetical protein +FIG01069205 General secretion pathway protein D +FIG01069253 Dienelactone hydrolase family +FIG01069272 FIG01069282: hypothetical protein +FIG01069282 hypothetical bacteriophage protein +FIG01069323 hypothetical protein +FIG01069350 putative transport protein +FIG01069357 hypothetical protein +FIG01069385 FIG01067913: hypothetical protein +FIG01069399 FIG01069404: hypothetical protein +FIG01069440 FIG01069441: hypothetical protein +FIG01069444 FIG01069452: hypothetical protein +FIG01069454 FIG01069456: hypothetical protein +FIG01069478 putative DNA repair protein +FIG01069481 hypothetical protein +FIG01069495 FIG00638968: hypothetical protein +FIG01069511 FIG01069513: hypothetical protein +FIG01069513 FIG01069516: hypothetical protein +FIG01069526 endopeptidase +FIG01069531 YjbI protein +FIG01069533 hypothetical protein +FIG01069549 prophage P2 ogr protein +FIG01069555 Xanthine/uracil permease family protein +FIG01069573 FIG00642941: hypothetical protein +FIG01069590 FIG01069591: hypothetical protein +FIG01069592 FIG01069594: hypothetical protein +FIG01069610 CRISPR-associated protein, CT1975 family +FIG01069640 FIG01069642: hypothetical protein +FIG01069669 FIG01069670: hypothetical protein +FIG01069672 hypothetical protein +FIG01069680 FIG01069681: hypothetical protein +FIG01069690 COG2200: FOG: EAL domain +FIG01069716 LysR family transcriptional regulator YgiP +FIG01069753 FIG01069755: hypothetical protein +FIG01069760 FIG01069761: hypothetical protein +FIG01069787 FIG01069793: hypothetical protein +FIG01069797 L-galactonate transporter +FIG01069799 FIG01069805: hypothetical protein +FIG01069817 FIG01069818: hypothetical protein +FIG01069822 FIG01069823: hypothetical protein +FIG01069823 FIG00637978: hypothetical protein +FIG01069843 Starvation sensing protein RspB +FIG01069855 Puative autotransporter/virulence factor +FIG01069870 FIG01069871: hypothetical protein +FIG01069873 hypothetical protein +FIG01069912 Putative OspC2 +FIG01069940 FIG01069941: hypothetical protein +FIG01069944 Putative glutamate mutase L +FIG01069945 FIG01069947: hypothetical protein +FIG01069952 oriT nicking and unwinding protein, fragment +FIG01069955 COG2202: FOG: PAS/PAC domain +FIG01070047 FIG01070050: hypothetical protein +FIG01070065 repressor protein CI +FIG01070074 FIG01070076: hypothetical protein +FIG01070081 FIG01070085: hypothetical protein +FIG01070117 FIG01070118: hypothetical protein +FIG01070157 FIG01070162: hypothetical protein +FIG01070162 FIG01070164: hypothetical protein +FIG01070167 FIG01070171: hypothetical protein +FIG01070230 FIG01070232: hypothetical protein +FIG01070300 COG2199: FOG: GGDEF domain +FIG01070335 FIG01070354: hypothetical protein +FIG01070363 FIG01070367: hypothetical protein +FIG01070440 probable cytochrome oxidase +FIG01070441 Phage prohead protease, HK97 family +FIG01070453 COG3675: Predicted lipase +FIG01070454 FIG01070474: hypothetical protein +FIG01070513 FIG129294: predicted inner membrane protein +FIG01070569 FIG01070575: hypothetical protein +FIG01070680 Fimbriae-like periplasmic protein SfmF +FIG01070783 FIG01070786: hypothetical protein +FIG01070873 FIG01070878: hypothetical protein +FIG01070907 rac prophage; predicted domain protein +FIG01070951 COG1263: Phosphotransferase system IIC components, glucose/maltose/N-acetylglucosamine-specific +FIG01070966 Prevent host death protein, Phd antitoxin +FIG01071847 Phage tail sheath protein +FIG01071933 FIG01071968: hypothetical protein +FIG01071997 FIG01163484: hypothetical protein +FIG01072101 transcriptional regulator-related protein +FIG01072266 general secretion pathway protein, ATPase +FIG01072300 Amylopullulanase (EC 3.2.1.1) / (EC 3.2.1.41) +FIG01072619 N-formylglutamate amidohydrolase family protein +FIG01072625 FIG01072627: hypothetical protein +FIG01072627 globin domain protein +FIG01072629 FIG01072632: hypothetical protein +FIG01072637 putative diguanylate cyclase (GGDEF) +FIG01072638 protein of unknown function DUF1127 +FIG01072639 FIG01072642: hypothetical protein +FIG01072642 FIG01072643: hypothetical protein +FIG01072647 FIG01072649: hypothetical protein +FIG01072651 FIG01072652: hypothetical protein +FIG01072657 COG1872 +FIG01072658 FIG01072659: hypothetical protein +FIG01072659 FIG01072661: hypothetical protein +FIG01072661 autoinducer-binding transcriptional regulator LuxR +FIG01072662 FIG01072663: hypothetical protein +FIG01072669 FIG01072672: hypothetical protein +FIG01072675 FIG01072678: hypothetical protein +FIG01072679 peptide/nickel/opine uptake family ABC transporter, ATP-binding protein, putative +FIG01072680 FIG01072682: hypothetical protein +FIG01072683 FIG01072684: hypothetical protein +FIG01072684 FIG01072686: hypothetical protein +FIG01072693 FIG01072694: hypothetical protein +FIG01072694 FIG01072701: hypothetical protein +FIG01072702 FIG00992611: hypothetical protein +FIG01072704 FIG01072709: hypothetical protein +FIG01072709 FIG01072714: hypothetical protein +FIG01072714 Peptide/opine/nickel uptake family ABC transporter, periplasmic substrate-binding protein +FIG01072715 thiamine biosynthesis protein ThiF +FIG01072717 FIG01072718: hypothetical protein +FIG01072718 FIG01072720: hypothetical protein +FIG01072722 Efflux ABC transporter, transmembrane ATP-binding protein +FIG01072730 FIG01072731: hypothetical protein +FIG01072733 FIG01072736: hypothetical protein +FIG01072744 FIG01072745: hypothetical protein +FIG01072752 FIG01072753: hypothetical protein +FIG01072758 FIG01072760: hypothetical protein +FIG01072762 FIG01072766: hypothetical protein +FIG01072766 FIG01072771: hypothetical protein +FIG01072774 FIG01072775: hypothetical protein +FIG01072775 FIG01072776: hypothetical protein +FIG01072776 Fatty acid desaturase family protein +FIG01072779 FIG01072780: hypothetical protein +FIG01072781 FIG01072783: hypothetical protein +FIG01072786 FIG01072787: hypothetical protein +FIG01072789 FIG01072790: hypothetical protein +FIG01072794 FIG01072797: hypothetical protein +FIG01072803 cytochrome b, putative +FIG01072805 FIG01072806: hypothetical protein +FIG01072809 FIG01072810: hypothetical protein +FIG01072810 FIG01072813: hypothetical protein +FIG01072813 FIG01072815: hypothetical protein +FIG01072815 FIG01072816: hypothetical protein +FIG01072816 FIG01072817: hypothetical protein +FIG01072817 FIG01072821: hypothetical protein +FIG01072821 FIG01072822: hypothetical protein +FIG01072826 FIG01072827: hypothetical protein +FIG01072827 Oxidoreductase, zinc-binding dehydrogenase family +FIG01072830 DNA-binding protein, putative +FIG01072831 FIG01072832: hypothetical protein +FIG01072832 FIG01072834: hypothetical protein +FIG01072834 FIG01072837: hypothetical protein +FIG01072843 FIG01072844: hypothetical protein +FIG01072845 FIG01072846: hypothetical protein +FIG01072846 NADH-ubiquinone oxidoreductase family protein +FIG01072853 FIG01072854: hypothetical protein +FIG01072857 FIG00987745: hypothetical protein +FIG01072862 FIG01072863: hypothetical protein +FIG01072863 Peptide/opine/nickel uptake family ABC transporter, permease protein +FIG01072866 FIG01072870: hypothetical protein +FIG01072871 FIG01072872: hypothetical protein +FIG01072874 FIG01072875: hypothetical protein +FIG01072875 methyltransferase, UbiE/COQ5 family protein +FIG01072889 Glutamine ABC transporter, periplasmic glutamine-binding protein +FIG01072899 FIG01072900: hypothetical protein +FIG01072900 FIG01072902: hypothetical protein +FIG01072902 dnaK suppressor protein, putative +FIG01072905 FIG01072908: hypothetical protein +FIG01072908 FIG01072909: hypothetical protein +FIG01072912 Multidrug and toxin extrusion (MATE) family efflux pump YdhE/NorM, homolog +FIG01072913 Fnr-type transcriptional regulator +FIG01072917 FIG01072918: hypothetical protein +FIG01072921 Mlr3099 protein +FIG01072923 FIG01072926: hypothetical protein +FIG01072926 FIG01072928: hypothetical protein +FIG01072928 ABC-type Fe3+-siderophore transport system inner membrane subunit +FIG01072930 OsmC-like family protein +FIG01072935 FIG01072936: hypothetical protein +FIG01072936 FIG01072938: hypothetical protein +FIG01072938 FIG01072939: hypothetical protein +FIG01072939 FIG01072940: hypothetical protein +FIG01072940 FIG01072941: hypothetical protein +FIG01072941 FIG01072942: hypothetical protein +FIG01072942 FIG01072950: hypothetical protein +FIG01072951 flagellar basal body-associated protein FliL +FIG01072958 FIG00990892: hypothetical protein +FIG01072970 FIG01072971: hypothetical protein +FIG01072971 FIG01072972: hypothetical protein +FIG01072972 FIG01072973: hypothetical protein +FIG01072973 FIG01072977: hypothetical protein +FIG01072986 FIG01072987: hypothetical protein +FIG01072988 sll8035 +FIG01072991 FIG01072993: hypothetical protein +FIG01072993 FIG01072994: hypothetical protein +FIG01072995 FIG01072996: hypothetical protein +FIG01072996 FIG01072997: hypothetical protein +FIG01072997 FIG01072998: hypothetical protein +FIG01072998 Probable TPR domain protein +FIG01073001 FIG01073002: hypothetical protein +FIG01073002 FIG01073003: hypothetical protein +FIG01073012 FIG01073013: hypothetical protein +FIG01073014 MobC protein +FIG01073016 FIG01073017: hypothetical protein +FIG01073017 Asp/Glu/Hydantoin racemase family protein +FIG01073020 FIG01073025: hypothetical protein +FIG01073027 FIG01073030: hypothetical protein +FIG01073031 FIG01073034: hypothetical protein +FIG01073034 FIG01073035: hypothetical protein +FIG01073037 Bll6462 protein +FIG01073039 FIG01073040: hypothetical protein +FIG01073040 FIG01073041: hypothetical protein +FIG01073041 FIG01073044: hypothetical protein +FIG01073044 FIG01073045: hypothetical protein +FIG01073045 FIG01073047: hypothetical protein +FIG01073047 Acyltransferase domain protein +FIG01073049 putative oxidoreductase [EC:1.-.-.-] +FIG01073054 FIG01073058: hypothetical protein +FIG01073062 FIG01073063: hypothetical protein +FIG01073063 FIG00992117: hypothetical protein +FIG01073066 FIG01073068: hypothetical protein +FIG01073068 Oligopeptide/dipeptide ABC transporter, ATP-binding protein +FIG01073070 FIG01073072: hypothetical protein +FIG01073072 thiamine-phosphate pyrophosphorylase, putative +FIG01073076 FIG01073079: hypothetical protein +FIG01073079 FIG01073080: hypothetical protein +FIG01073080 FIG01073082: hypothetical protein +FIG01073092 Permease, YjgP/YjgQ family +FIG01073095 FIG01073097: hypothetical protein +FIG01073099 3-hydroxyacyl-CoA dehydrogenase (EC 1.1.1.35) @ 17hydroxysteroid dehydrogenase type 10 (HSD10)-like +FIG01073102 FIG01073104: hypothetical protein +FIG01073106 FIG01073107: hypothetical protein +FIG01073112 FIG01073113: hypothetical protein +FIG01073113 FIG01073120: hypothetical protein +FIG01073121 FIG01073123: hypothetical protein +FIG01073127 FIG01073128: hypothetical protein +FIG01073129 FIG01073132: hypothetical protein +FIG01073138 C4-dicarboxylate transport transcriptional regulatory protein DctD +FIG01073144 FIG01073147: hypothetical protein +FIG01073148 FIG01073150: hypothetical protein +FIG01073152 FIG01073154: hypothetical protein +FIG01073154 FIG00990786: hypothetical protein +FIG01073159 FIG01073164: hypothetical protein +FIG01073164 Oligopeptide/dipeptide uptake family ABC transporter, ATP-binding protein +FIG01073179 FIG01073180: hypothetical protein +FIG01073181 FIG01073183: hypothetical protein +FIG01073183 identified by similarity to GB:BAB50844.1 +FIG01073186 Peptidase, M20/M25/M40 family +FIG01073188 FIG01073190: hypothetical protein +FIG01073193 FIG01073194: hypothetical protein +FIG01073194 FIG01073195: hypothetical protein +FIG01073195 FIG01073197: hypothetical protein +FIG01073198 FIG01073199: hypothetical protein +FIG01073199 DNA-binding protein, H-NS family +FIG01073204 FIG01073206: hypothetical protein +FIG01073207 FIG01073208: hypothetical protein +FIG01073209 Mll3258 protein +FIG01073216 Ribonuclease, Rne/Rng family +FIG01073218 FIG01073219: hypothetical protein +FIG01073219 FIG01073220: hypothetical protein +FIG01073221 FIG01073223: hypothetical protein +FIG01073223 FIG01073224: hypothetical protein +FIG01073230 FIG01073232: hypothetical protein +FIG01073237 FIG01073238: hypothetical protein +FIG01073239 Intracellular septation protein A +FIG01073242 FIG01073243: hypothetical protein +FIG01073243 FIG00992417: hypothetical protein +FIG01073246 FIG01073248: hypothetical protein +FIG01073253 FIG01073254: hypothetical protein +FIG01073259 exopolysaccharide transport protein, putative +FIG01073260 Pyridoxamine 5'-phosphate oxidase family protein +FIG01073269 FIG01073272: hypothetical protein +FIG01073272 FIG01073274: hypothetical protein +FIG01073275 Oligopeptide/dipeptide ABC transporter, permease protein +FIG01073281 FIG01073282: hypothetical protein +FIG01073285 FIG01073286: hypothetical protein +FIG01073290 FIG01073292: hypothetical protein +FIG01073292 HAD-superfamily hydrolase, subfamily IA, variant 1 family protein +FIG01073294 FIG00992832: hypothetical protein +FIG01073297 FIG01143062: hypothetical protein +FIG01073302 FIG01073303: hypothetical protein +FIG01073310 FIG01073311: hypothetical protein +FIG01073313 transmembrane efflux protein, homoserine/threonine (RhtB) family +FIG01073315 FIG01073316: hypothetical protein +FIG01073316 FIG01073317: hypothetical protein +FIG01073317 FIG01073318: hypothetical protein +FIG01073318 FIG01073319: hypothetical protein +FIG01073319 FIG01142573: hypothetical protein +FIG01073325 FIG01023127: hypothetical protein +FIG01073328 FIG01073329: hypothetical protein +FIG01073331 FIG01073332: hypothetical protein +FIG01073333 FIG01073334: hypothetical protein +FIG01073335 Polyamine ABC transporter, permease protein +FIG01073338 FIG01073340: hypothetical protein +FIG01073341 FIG01073342: hypothetical protein +FIG01073342 gamma-butyrobetaine hydroxylase, putative +FIG01073349 FIG01073351: hypothetical protein +FIG01073358 FIG01073364: hypothetical protein +FIG01073364 sugar-ABC transporter, permease protein, putative +FIG01073366 FIG01073370: hypothetical protein +FIG01073374 FIG01073375: hypothetical protein +FIG01073378 FIG01073379: hypothetical protein +FIG01073380 metallopeptidase, family M24 +FIG01073393 FIG01073395: hypothetical protein +FIG01073398 FIG01073399: hypothetical protein +FIG01073400 FIG01073401: hypothetical protein +FIG01073409 putative exoD-like membrane protein +FIG01073410 FIG01073411: hypothetical protein +FIG01073424 FIG00989612: hypothetical protein +FIG01073426 FIG01073433: hypothetical protein +FIG01073433 FIG01073434: hypothetical protein +FIG01073435 FIG01073438: hypothetical protein +FIG01073438 FIG01073439: hypothetical protein +FIG01073440 FIG00991599: hypothetical protein +FIG01073443 FIG01073444: hypothetical protein +FIG01073448 FIG00988860: hypothetical protein +FIG01073455 FIG01073456: hypothetical protein +FIG01073461 FIG01073462: hypothetical protein +FIG01073464 drug resistance transporter, Bcr/CflA subfamily protein +FIG01073465 FIG01073466: hypothetical protein +FIG01073467 FIG01073468: hypothetical protein +FIG01073470 FIG01073473: hypothetical protein +FIG01073473 FIG01073475: hypothetical protein +FIG01073477 Mll5120 protein +FIG01073478 FIG00987907: hypothetical protein +FIG01073480 FIG01073483: hypothetical protein +FIG01073488 FIG01073489: hypothetical protein +FIG01073489 FIG01073491: hypothetical protein +FIG01073493 Mannose-1-phosphate guanylyltransferase (GDP) (EC 2.7.7.22) / Mannose-6-phosphate isomerase (EC 5.3.1.8) +FIG01073498 FIG01073499: hypothetical protein +FIG01073499 FIG01073501: hypothetical protein +FIG01073501 FIG01073505: hypothetical protein +FIG01073510 FIG01073512: hypothetical protein +FIG01073512 FIG00987983: hypothetical protein +FIG01073515 identified by similarity to GB:BAB47950.1 +FIG01073517 Oligopeptide/dipeptide ABC transporter, periplasmic substrate-binding protein +FIG01073525 FIG01073526: hypothetical protein +FIG01073532 Chloramphenicol acetyltransferase (EC 2.3.1.28) +FIG01073534 Glycosyl transferases group 1:TPR repeat +FIG01073537 FIG01073538: hypothetical protein +FIG01073539 FIG01073540: hypothetical protein +FIG01073549 FIG01073550: hypothetical protein +FIG01073550 molybdopterin biosynthesis protein MoeB, putative +FIG01073563 FIG01073564: hypothetical protein +FIG01073566 FIG01073568: hypothetical protein +FIG01073568 FIG01073570: hypothetical protein +FIG01073570 FIG01073571: hypothetical protein +FIG01073571 FIG01073574: hypothetical protein +FIG01073575 FIG01073576: hypothetical protein +FIG01073580 Peptidase, M48 family +FIG01073586 FIG01073589: hypothetical protein +FIG01073589 FIG01073590: hypothetical protein +FIG01073591 FIG01073592: hypothetical protein +FIG01073593 FIG01073595: hypothetical protein +FIG01073597 FIG01073599: hypothetical protein +FIG01073599 FIG01073602: hypothetical protein +FIG01073602 FIG01073603: hypothetical protein +FIG01073608 FIG01073609: hypothetical protein +FIG01073616 FIG01073619: hypothetical protein +FIG01073630 RDD family protein +FIG01073637 FIG01073638: hypothetical protein +FIG01073638 FIG01073639: hypothetical protein +FIG01073640 FIG01073642: hypothetical protein +FIG01073660 FIG01073661: hypothetical protein +FIG01073661 Mlr3268 protein +FIG01073665 FIG01073666: hypothetical protein +FIG01073673 FIG01073674: hypothetical protein +FIG01073674 Transcriptional regulator, LuxR family/sensory box protein +FIG01073681 FIG01073682: hypothetical protein +FIG01073685 putative aromatic-ring hydroxylating dioxygenase, alpha-subunit +FIG01073687 FIG01073690: hypothetical protein +FIG01073690 FIG01073693: hypothetical protein +FIG01073699 FIG01073701: hypothetical protein +FIG01073701 FIG01073702: hypothetical protein +FIG01073705 Thioesterase family protein +FIG01073707 FIG01073708: hypothetical protein +FIG01073709 FIG01073710: hypothetical protein +FIG01073717 FIG01073718: hypothetical protein +FIG01073722 YOAT +FIG01073727 FIG01073729: hypothetical protein +FIG01073737 FIG01073739: hypothetical protein +FIG01073739 OmpA domain protein +FIG01073740 FIG01073743: hypothetical protein +FIG01073750 FIG01073752: hypothetical protein +FIG01073753 FIG01073754: hypothetical protein +FIG01073754 FIG01073755: hypothetical protein +FIG01073756 FIG01073758: hypothetical protein +FIG01073758 FIG01073759: hypothetical protein +FIG01073762 oxidoreductase, zinc-binding dehydrogenase family +FIG01073769 FIG01073770: hypothetical protein +FIG01073770 FIG01073772: hypothetical protein +FIG01073772 FIG01073776: hypothetical protein +FIG01073778 FIG01073780: hypothetical protein +FIG01073781 Probable oligopeptide ABC transporter, ATP-binding protein +FIG01073784 FIG01073786: hypothetical protein +FIG01073786 Mannosyl-3-phosphoglycerate phosphatase +FIG01073795 putative CheA signal transduction histidine kinases +FIG01073797 FIG01073800: hypothetical protein +FIG01073800 FIG01073801: hypothetical protein +FIG01073807 transcriptional repressor of sporulation, septation and degradative enzyme +FIG01073809 Putative glycerate kinase and pyruvate kinase (pykA) genes +FIG01073811 FIG00993295: hypothetical protein +FIG01073825 FIG01073828: hypothetical protein +FIG01073829 glycosyl transferase, family 25 +FIG01073830 FIG01073833: hypothetical protein +FIG01073835 FIG01073836: hypothetical protein +FIG01073836 FIG01073838: hypothetical protein +FIG01073838 FIG01073841: hypothetical protein +FIG01073841 FIG01073844: hypothetical protein +FIG01073844 FIG01073845: hypothetical protein +FIG01073845 FIG01073846: hypothetical protein +FIG01073853 FIG01073857: hypothetical protein +FIG01073858 FIG01073861: hypothetical protein +FIG01073861 FIG01025422: hypothetical protein +FIG01073866 FIG01073867: hypothetical protein +FIG01073876 Oxidoreductase, FAD-binding +FIG01073879 DNA-binding HTH domain-containing proteins-like +FIG01073880 FIG01073884: hypothetical protein +FIG01073884 ATP-binding protein of ABC transporter +FIG01073889 FIG01073890: hypothetical protein +FIG01073898 Putative ABC transporter permease +FIG01073899 FIG01073900: hypothetical protein +FIG01073901 putative periplasmic binding protein +FIG01073903 DNA gyrase, subunit B +FIG01073905 FIG01073906: hypothetical protein +FIG01073906 FIG01073910: hypothetical protein +FIG01073914 Two component sensor kinase +FIG01073916 FIG01073917: hypothetical protein +FIG01073917 FIG01073921: hypothetical protein +FIG01073921 FIG01073929: hypothetical protein +FIG01073934 FIG01073936: hypothetical protein +FIG01073939 Conserved hypothetical protein, gene in Ubiquinol-cytochrome C chaperone locus +FIG01073943 FIG01073944: hypothetical protein +FIG01073944 FIG01073945: hypothetical protein +FIG01073945 FIG01073947: hypothetical protein +FIG01073948 FIG01073949: hypothetical protein +FIG01073949 FIG01073951: hypothetical protein +FIG01073951 FIG01073952: hypothetical protein +FIG01073960 FIG01073961: hypothetical protein +FIG01073966 FIG01073969: hypothetical protein +FIG01073973 FIG01073974: hypothetical protein +FIG01073975 FIG01073977: hypothetical protein +FIG01073978 putative ABC transporter sugar-binding protein +FIG01073982 putative sulfotransferase protein +FIG01073990 FIG01073991: hypothetical protein +FIG01073993 probable MerR-family transcriptional regulator +FIG01073998 FIG01074001: hypothetical protein +FIG01074004 FIG01074011: hypothetical protein +FIG01074011 FIG01074012: hypothetical protein +FIG01074015 Small molecule metabolism; Amino acid biosynthesis; arginine +FIG01074019 FIG01074021: hypothetical protein +FIG01074021 FIG01074022: hypothetical protein +FIG01074038 FIG01074039: hypothetical protein +FIG01074040 FIG046685: Glycosyltransferase +FIG01074042 FIG01074043: hypothetical protein +FIG01074047 FIG01074049: hypothetical protein +FIG01074053 FIG01074054: hypothetical protein +FIG01074056 FIG01074058: hypothetical protein +FIG01074063 FIG01074064: hypothetical protein +FIG01074071 FIG01074072: hypothetical protein +FIG01074077 FIG01074079: hypothetical protein +FIG01074083 FIG01074084: hypothetical protein +FIG01074086 FIG01074088: hypothetical protein +FIG01074088 FIG01074089: hypothetical protein +FIG01074093 putative transcription regulator protein +FIG01074094 putative transcriptional regulator, LysR family protein +FIG01074102 FIG01074106: hypothetical protein +FIG01074108 FIG01074109: hypothetical protein +FIG01074109 FIG01074113: hypothetical protein +FIG01074124 FIG01074125: hypothetical protein +FIG01074131 FIG01074132: hypothetical protein +FIG01074132 HYPOTHETICAL/UNKNOWN TRANSMEMBRANE PROTEIN +FIG01074139 FIG01074140: hypothetical protein +FIG01074141 Naphthalene 1,2-dioxygenase system ferredoxin component +FIG01074145 FIG01074146: hypothetical protein +FIG01074148 FIG01074149: hypothetical protein +FIG01074149 FIG01074151: hypothetical protein +FIG01074155 hypothetical ABC transporter periplasmic solute-binding protein +FIG01074162 FIG01074166: hypothetical protein +FIG01074175 FIG01074180: hypothetical protein +FIG01074182 FIG00450254: hypothetical protein +FIG01074186 FIG01074187: hypothetical protein +FIG01074192 FIG01074193: hypothetical protein +FIG01074193 FIG01074195: hypothetical protein +FIG01074195 Protein crcB homolog +FIG01074196 FIG01074198: hypothetical protein +FIG01074198 FIG01074200: hypothetical protein +FIG01074200 FIG01074201: hypothetical protein +FIG01074205 FIG01074206: hypothetical protein +FIG01074207 FIG01074208: hypothetical protein +FIG01074208 FIG01074209: hypothetical protein +FIG01074213 PUTATIVE ATP BINDING ABC TRANSPORTER PROTEIN +FIG01074216 FIG00450953: hypothetical protein +FIG01074217 FIG01074218: hypothetical protein +FIG01074218 FIG01074219: hypothetical protein +FIG01074219 FIG01074220: hypothetical protein +FIG01074223 FIG01074225: hypothetical protein +FIG01074225 FIG01074226: hypothetical protein +FIG01074226 FIG01074230: hypothetical protein +FIG01074230 Sarcosine oxidase +FIG01074232 putative amicyanin precursor protein +FIG01074242 FIG01074243: hypothetical protein +FIG01074244 FIG01074245: hypothetical protein +FIG01074247 FIG01074249: hypothetical protein +FIG01074249 FIG01074251: hypothetical protein +FIG01074255 FIG01074256: hypothetical protein +FIG01074256 FIG01074259: hypothetical protein +FIG01074259 FIG01074260: hypothetical protein +FIG01074264 FIG01074265: hypothetical protein +FIG01074265 FIG01074268: hypothetical protein +FIG01074276 Hypothetical protein, AT1G64980 homolog +FIG01074280 FIG01074281: hypothetical protein +FIG01074281 putative enzyme, C-terminal domain similar to sulfotransferase protein +FIG01074285 FIG01074289: hypothetical protein +FIG01074289 FIG01074290: hypothetical protein +FIG01074290 miscellaneous +FIG01074293 FIG01074298: hypothetical protein +FIG01074309 transcriptional activator of exopolysaccharide II synthesis, MarR family protein +FIG01074310 FIG01074313: hypothetical protein +FIG01074313 FIG01074316: hypothetical protein +FIG01074316 FIG01074317: hypothetical protein +FIG01074318 FIG01074319: hypothetical protein +FIG01074325 Hydroxybenzoyl-CoA reductase subunit +FIG01074334 FIG01074338: hypothetical protein +FIG01074338 FIG01074343: hypothetical protein +FIG01074343 FIG01074346: hypothetical protein +FIG01074352 FIG01074353: hypothetical protein +FIG01074353 FIG01074355: hypothetical protein +FIG01074355 FIG01074356: hypothetical protein +FIG01074357 FIG01074358: hypothetical protein +FIG01074359 FIG01074360: hypothetical protein +FIG01074371 FIG00992505: hypothetical protein +FIG01074374 FIG01074375: hypothetical protein +FIG01074379 FIG01074380: hypothetical protein +FIG01074387 FIG01074388: hypothetical protein +FIG01074389 FIG01074392: hypothetical protein +FIG01074392 dioxygenase (EC 1.13.11.-) +FIG01074394 FIG01074396: hypothetical protein +FIG01074402 FIG01074404: hypothetical protein +FIG01074419 MFS family transporter protein +FIG01074426 Small Molecule Metabolism; Degradation; carbon compounds +FIG01074433 FIG01074434: hypothetical protein +FIG01074434 FIG01074435: hypothetical protein +FIG01074435 EXTENSIN-LIKE PROTEIN +FIG01074436 FIG01074437: hypothetical protein +FIG01074437 FIG01074439: hypothetical protein +FIG01074440 FIG01074442: hypothetical protein +FIG01074443 FIG01074444: hypothetical protein +FIG01074447 putative transcriptional regulator TRANSCRIPTION REGULATOR protein +FIG01074448 FIG01074451: hypothetical protein +FIG01074451 Ornithine decarboxylase (EC 4.1.1.17) / Arginine decarboxylase (EC 4.1.1.19) +FIG01074453 FIG01074457: hypothetical protein +FIG01074457 FIG01074459: hypothetical protein +FIG01074459 FIG01074461: hypothetical protein +FIG01074461 FIG01074462: hypothetical protein +FIG01074465 conjugal transfer protein D +FIG01074471 FIG01074473: hypothetical protein +FIG01074485 FIG01074491: hypothetical protein +FIG01074506 FIG01074507: hypothetical protein +FIG01074507 FIG01074508: hypothetical protein +FIG01074517 FIG01074519: hypothetical protein +FIG01074519 Shikimate 5-dehydrogenase I alpha (EC 1.1.1.25) +FIG01074522 FIG01074524: hypothetical protein +FIG01074524 FIG01074528: hypothetical protein +FIG01074531 FIG01074533: hypothetical protein +FIG01074533 Lipopolysaccharide core biosynthesis glycosyltransferase lpsD (EC 2.-.-.-) +FIG01074538 FIG01074540: hypothetical protein +FIG01074540 putative transcriptional regulator, AraC family protein +FIG01074545 FIG01074547: hypothetical protein +FIG01074547 FIG01074548: hypothetical protein +FIG01074552 FIG01074553: hypothetical protein +FIG01074553 FIG01074554: hypothetical protein +FIG01074554 FIG01074555: hypothetical protein +FIG01074560 Bll4710 protein +FIG01074561 FIG01074563: hypothetical protein +FIG01074566 FIG01074567: hypothetical protein +FIG01074571 RTX toxin transporter, ATP-binding protein +FIG01074574 FIG01074576: hypothetical protein +FIG01074576 FIG01074578: hypothetical protein +FIG01074578 FIG01074579: hypothetical protein +FIG01074580 FIG01074584: hypothetical protein +FIG01074588 FIG01074589: hypothetical protein +FIG01074589 putative sugar kinase protein +FIG01074590 small molecule metabolism; energy transfer; electron transport +FIG01074596 FIG01074597: hypothetical protein +FIG01074597 FIG01074598: hypothetical protein +FIG01074603 FIG01074604: hypothetical protein +FIG01074604 FIG01074607: hypothetical protein +FIG01074608 FIG01074609: hypothetical protein +FIG01074620 FIG01074625: hypothetical protein +FIG01074625 FIG01074626: hypothetical protein +FIG01074626 FIG01074627: hypothetical protein +FIG01074635 FIG01074636: hypothetical protein +FIG01074641 FIG01074642: hypothetical protein +FIG01074644 FIG01074646: hypothetical protein +FIG01074653 Small Molecule Metabolism; Fatty acid biosynthesis +FIG01074655 FIG01074659: hypothetical protein +FIG01074660 FIG01074664: hypothetical protein +FIG01074665 FIG01074666: hypothetical protein +FIG01074675 FIG01074678: hypothetical protein +FIG01074678 FIG01074680: hypothetical protein +FIG01074684 tRNA:m(5)U-54 MTase gid +FIG01074685 FIG01074687: hypothetical protein +FIG01074699 FIG01074701: hypothetical protein +FIG01074702 FIG01074703: hypothetical protein +FIG01074705 FIG01074706: hypothetical protein +FIG01074711 FIG01074712: hypothetical protein +FIG01074718 FIG01074719: hypothetical protein +FIG01074722 FIG01074723: hypothetical protein +FIG01074723 FIG01074724: hypothetical protein +FIG01074724 FIG01074725: hypothetical protein +FIG01074726 FIG01074727: hypothetical protein +FIG01074733 putative ATPGTP-binding protein +FIG01074734 FIG01074735: hypothetical protein +FIG01074742 conserved hypothetical glycine-rich protein +FIG01074744 FIG01074746: hypothetical protein +FIG01074746 FIG01074748: hypothetical protein +FIG01074748 FIG01074752: hypothetical protein +FIG01074760 FIG01074765: hypothetical protein +FIG01074767 FIG01074768: hypothetical protein +FIG01074768 FIG01074769: hypothetical protein +FIG01074771 FIG01074773: hypothetical protein +FIG01074782 FIG01074783: hypothetical protein +FIG01074784 FIG01074785: hypothetical protein +FIG01074785 FIG01074787: hypothetical protein +FIG01074787 FIG01074788: hypothetical protein +FIG01074789 FIG01074794: hypothetical protein +FIG01074795 miscellaneous; hypothetical/global homology +FIG01074800 HYPOTHETICAL UNKNOWN TRANSMEMBRANE PROTEIN +FIG01074803 FIG01074804: hypothetical protein +FIG01074805 Flavoprotein WrbA +FIG01074811 FIG01074813: hypothetical protein +FIG01074814 Betaine-aldehyde dehydrogenase (EC 1.2.1.3) +FIG01074815 FIG01074816: hypothetical protein +FIG01074816 Cell processes; Transport of small molecules; carbohydrates, organic acids, alcohols +FIG01074822 FIG01074823: hypothetical protein +FIG01074823 FIG01074824: hypothetical protein +FIG01074832 FIG01074833: hypothetical protein +FIG01074833 FIG01074834: hypothetical protein +FIG01074848 FIG01074849: hypothetical protein +FIG01074849 FIG01074850: hypothetical protein +FIG01074851 FIG01074852: hypothetical protein +FIG01074852 FIG01074855: hypothetical protein +FIG01074855 FIG01074857: hypothetical protein +FIG01074888 FIG01074889: hypothetical protein +FIG01074893 FIG01074895: hypothetical protein +FIG01074897 FIG01074898: hypothetical protein +FIG01074898 FIG01074899: hypothetical protein +FIG01074899 FIG01074900: hypothetical protein +FIG01074902 FIG01074904: hypothetical protein +FIG01074905 FIG01074908: hypothetical protein +FIG01074908 FIG01074909: hypothetical protein +FIG01074910 FIG01074913: hypothetical protein +FIG01074915 FIG00451006: hypothetical protein +FIG01074916 FIG01074918: hypothetical protein +FIG01074923 FIG01074925: hypothetical protein +FIG01074925 FIG01074927: hypothetical protein +FIG01074927 FIG01074931: hypothetical protein +FIG01074931 FIG01074939: hypothetical protein +FIG01074942 FIG01074944: hypothetical protein +FIG01074944 FIG01074945: hypothetical protein +FIG01074945 FIG01074946: hypothetical protein +FIG01074946 probable osmotically inducible sensory protein +FIG01074948 FIG01074949: hypothetical protein +FIG01074957 FIG01074960: hypothetical protein +FIG01074960 FIG01074963: hypothetical protein +FIG01074973 FIG01074974: hypothetical protein +FIG01074975 FIG01074977: hypothetical protein +FIG01074977 FIG01074978: hypothetical protein +FIG01074979 FIG01074981: hypothetical protein +FIG01074985 FIG01074987: hypothetical protein +FIG01074987 putative nutrient deprivation-induced protein +FIG01074989 RpoH suppressor +FIG01074990 oxidoreductase-like +FIG01074993 FIG01074995: hypothetical protein +FIG01075003 FIG01075005: hypothetical protein +FIG01075012 FIG01075013: hypothetical protein +FIG01075014 FIG01075015: hypothetical protein +FIG01075015 FIG01075018: hypothetical protein +FIG01075023 FIG01075025: hypothetical protein +FIG01075030 cell processes; transport of large molecules; protein, peptide secretion +FIG01075031 FIG01075032: hypothetical protein +FIG01075033 FIG01075034: hypothetical protein +FIG01075040 UBIQUINONE/MENAQUINONE BIOSYNTHESIS METHYLTRANSFERASE UBIE +FIG01075041 L-sorbosone dehydrogenase (FAD)( EC:1.2.99.- ) +FIG01075074 FIG00918622: hypothetical protein +FIG01075078 FIG01075079: hypothetical protein +FIG01075079 FIG01075080: hypothetical protein +FIG01075080 protein secretion protein, HlyD family +FIG01075084 FIG01075085: hypothetical protein +FIG01075086 FIG01075090: hypothetical protein +FIG01075091 putative serine/threonine protein phosphatase +FIG01075093 FIG01075097: hypothetical protein +FIG01075098 FIG01075101: hypothetical protein +FIG01075107 FIG01075110: hypothetical protein +FIG01075113 possible protease( EC:3.4.24.40 ) +FIG01075118 FIG01075119: hypothetical protein +FIG01075119 FIG01075120: hypothetical protein +FIG01075120 FIG01075122: hypothetical protein +FIG01075122 FIG01075123: hypothetical protein +FIG01075123 FIG01075124: hypothetical protein +FIG01075124 FIG01075125: hypothetical protein +FIG01075126 FIG01075130: hypothetical protein +FIG01075135 probable nutrient deprivation-induced protein +FIG01075136 putative permease transmembrane transport protein +FIG01075141 conserved hypothetical/unknown signal peptide protein +FIG01075143 Pyridoxamine 5'-phosphate oxidase-related, FMN-binding +FIG01075146 FIG01075148: hypothetical protein +FIG01075148 FIG01075149: hypothetical protein +FIG01075149 FIG01075150: hypothetical protein +FIG01075150 FIG01075153: hypothetical protein +FIG01075153 FIG01075154: hypothetical protein +FIG01075154 FIG01075159: hypothetical protein +FIG01075159 FIG01075161: hypothetical protein +FIG01075164 FIG01075165: hypothetical protein +FIG01075165 FIG01075166: hypothetical protein +FIG01075167 FIG01075168: hypothetical protein +FIG01075168 nitrilotriacetate monooxygenase +FIG01075170 FIG01075173: hypothetical protein +FIG01075173 FIG01075174: hypothetical protein +FIG01075174 FIG01075179: hypothetical protein +FIG01075179 FIG01075181: hypothetical protein +FIG01075181 FIG01075182: hypothetical protein +FIG01075183 FIG01075190: hypothetical protein +FIG01075190 cation (Ca) exchange protein, possible +FIG01075196 FIG01075197: hypothetical protein +FIG01075197 FIG01075199: hypothetical protein +FIG01075199 FIG01075200: hypothetical protein +FIG01075200 hypothetical exported glutamine-rich protein +FIG01075201 FIG01075203: hypothetical protein +FIG01075205 FIG01075210: hypothetical protein +FIG01075210 FIG01075211: hypothetical protein +FIG01075211 FIG01075214: hypothetical protein +FIG01075217 biotin-regulated protein +FIG01075219 FIG01075220: hypothetical protein +FIG01075220 hypothetical nucleotide-binding protein +FIG01075221 FIG01075227: hypothetical protein +FIG01075227 FIG01075229: hypothetical protein +FIG01075234 FIG01075236: hypothetical protein +FIG01075237 FIG01075239: hypothetical protein +FIG01075239 PROBABLE AMINOGLYCOSIDE N3'-ACETYLTRANSFERASE PROTEIN( EC:2.3.1.81 ) +FIG01075242 conserved hypothetical signal peptide protein +FIG01075247 FIG01075248: hypothetical protein +FIG01075249 putative chemotaxis protein CheX +FIG01075250 FIG01075251: hypothetical protein +FIG01075257 FIG01075258: hypothetical protein +FIG01075258 FIG01075260: hypothetical protein +FIG01075260 FIG01075262: hypothetical protein +FIG01075272 putative LysR type regulator +FIG01075274 FIG01075278: hypothetical protein +FIG01075286 FIG01075297: hypothetical protein +FIG01075300 FixU nitrogen fixation protein +FIG01075302 FIG01075304: hypothetical protein +FIG01075314 FIG01075316: hypothetical protein +FIG01075329 Acetyl-CoA:acetoacetyl-CoA transferase, alpha subunit (EC 2.8.3.8) / Acetyl-CoA:acetoacetyl-CoA transferase, beta subunit (EC 2.8.3.8) +FIG01075331 FIG01075332: hypothetical protein +FIG01075332 Mlr3471 protein +FIG01075338 FIG01075340: hypothetical protein +FIG01075340 FIG01075341: hypothetical protein +FIG01075343 transcriptional regulator, Rok family protein +FIG01075348 FIG01075349: hypothetical protein +FIG01075349 FIG01075351: hypothetical protein +FIG01075352 FIG01075353: hypothetical protein +FIG01075353 FIG01075354: hypothetical protein +FIG01075356 FIG01075357: hypothetical protein +FIG01075362 FIG01075363: hypothetical protein +FIG01075363 Exonuclease III +FIG01075367 probable transcriptional regulator protein, Cro/CI family +FIG01075368 FIG01075371: hypothetical protein +FIG01075371 FIG01075373: hypothetical protein +FIG01075373 FIG01075375: hypothetical protein +FIG01075378 lignin beta-ether hydrolase +FIG01075386 FIG01075391: hypothetical protein +FIG01075391 sterol binding protein +FIG01075397 FIG01075399: hypothetical protein +FIG01075399 FIG01075403: hypothetical protein +FIG01075403 FIG01075406: hypothetical protein +FIG01075406 FIG01075409: hypothetical protein +FIG01075410 FIG01075412: hypothetical protein +FIG01075412 FIG01075416: hypothetical protein +FIG01075420 FIG01075421: hypothetical protein +FIG01075421 FIG01075423: hypothetical protein +FIG01075423 FIG01075425: hypothetical protein +FIG01075428 Similar to regulator of nucleoside diphosphate kinase +FIG01075429 FIG01075433: hypothetical protein +FIG01075433 FIG01075434: hypothetical protein +FIG01075435 FIG01075438: hypothetical protein +FIG01075440 putative oligopeptidemurein peptide ABC transporter permease protein +FIG01075442 protein of unknown function DUF1232 +FIG01075443 FIG01075447: hypothetical protein +FIG01075447 FIG01075448: hypothetical protein +FIG01075448 FIG01075449: hypothetical protein +FIG01075449 FIG01075450: hypothetical protein +FIG01075454 putative dioxygenase ferredoxin protein +FIG01075458 FIG01075459: hypothetical protein +FIG01075460 FIG01075461: hypothetical protein +FIG01075462 FIG01075463: hypothetical protein +FIG01075464 Putative ABC transporter, periplasmic sugar binding protein precursor +FIG01075466 FIG01075467: hypothetical protein +FIG01075477 FIG01075478: hypothetical protein +FIG01075479 FIG01075480: hypothetical protein +FIG01075480 FIG01134926: hypothetical protein +FIG01075482 FIG01075484: hypothetical protein +FIG01075485 probable transcriptional regulator, lysR family, possibly activator of the expression of chvE protein +FIG01075486 putative heat resistant agglutinin 1 signal peptide protein +FIG01075488 FIG01075489: hypothetical protein +FIG01075489 Mll9711 protein +FIG01075491 hypothetical membrane-anchored protein +FIG01075495 FIG01075497: hypothetical protein +FIG01075497 FIG01075501: hypothetical protein +FIG01075504 FIG01075509: hypothetical protein +FIG01075511 FIG01075512: hypothetical protein +FIG01075512 FIG01075513: hypothetical protein +FIG01075515 FIG01075516: hypothetical protein +FIG01075517 FIG01075518: hypothetical protein +FIG01075524 FIG01075525: hypothetical protein +FIG01075529 FIG01075532: hypothetical protein +FIG01075540 FIG01075541: hypothetical protein +FIG01075545 FIG01075546: hypothetical protein +FIG01075547 FIG01075548: hypothetical protein +FIG01075548 FIG01075551: hypothetical protein +FIG01075552 protein of unknown function DUF1362 +FIG01075555 FIG01075557: hypothetical protein +FIG01075557 FIG01075561: hypothetical protein +FIG01075561 FIG01075562: hypothetical protein +FIG01075568 FIG01075569: hypothetical protein +FIG01075573 FIG01075575: hypothetical protein +FIG01075576 small molecule metabolism; central intermediary metabolism; nitrogen metabolism +FIG01075579 FIG01075580: hypothetical protein +FIG01075581 FIG01075583: hypothetical protein +FIG01075583 FIG01075584: hypothetical protein +FIG01075588 FIG01075589: hypothetical protein +FIG01075589 FIG01075590: hypothetical protein +FIG01075591 FIG01075592: hypothetical protein +FIG01075596 FIG01075599: hypothetical protein +FIG01075608 FIG01075609: hypothetical protein +FIG01075609 FIG01075610: hypothetical protein +FIG01075610 FIG01075612: hypothetical protein +FIG01075613 PUTATIVE AMINO ACID-BINDING PERIPLASMIC ABC TRANSPORTER PROTEIN +FIG01075617 FIG01075620: hypothetical protein +FIG01075623 FIG01075624: hypothetical protein +FIG01075635 FIG01075636: hypothetical protein +FIG01075636 FIG01075637: hypothetical protein +FIG01075653 putative sugar ABC transporter permease protein +FIG01075661 Glucose-fructose oxidoreductase (EC 1.1.99.28) +FIG01075663 FIG01075665: hypothetical protein +FIG01075665 FIG01075667: hypothetical protein +FIG01075668 FIG01075671: hypothetical protein +FIG01075672 endo-1,3-1,4-beta-glycanase, C-terminal secretion signal protein +FIG01075678 FIG100719: hypothetical protein +FIG01075680 FIG01075681: hypothetical protein +FIG01075683 FIG01075684: hypothetical protein +FIG01075684 Outer membrane lipoprotein-related protein +FIG01075685 FIG01075686: hypothetical protein +FIG01075690 FIG01075691: hypothetical protein +FIG01075694 FIG01075695: hypothetical protein +FIG01075708 HYPOTHETICAL/UNKNOWN SIGNAL PEPTIDE PROTEIN +FIG01075715 FIG01075717: hypothetical protein +FIG01075718 putative Sir2-like transcriptional silencer protein +FIG01075719 FIG01075720: hypothetical protein +FIG01075726 FIG01075729: hypothetical protein +FIG01075729 FIG01075732: hypothetical protein +FIG01075734 FIG01075737: hypothetical protein +FIG01075737 FIG01075738: hypothetical protein +FIG01075738 FIG01075741: hypothetical protein +FIG01075743 conserved hypothetical protein, possibly membrane-anchored +FIG01075753 conserved hypothetical membrane-anchored protein +FIG01075760 FIG01075761: hypothetical protein +FIG01075761 FIG01075765: hypothetical protein +FIG01075773 FIG01075774: hypothetical protein +FIG01075779 FIG01075781: hypothetical protein +FIG01075785 FIG01075786: hypothetical protein +FIG01075787 PROBABLE DNA PACKAGING PROTEIN GP2 +FIG01075788 FIG01075790: hypothetical protein +FIG01075795 FIG00919194: hypothetical protein +FIG01075799 FIG01075807: hypothetical protein +FIG01075808 RidA/YER057c/UK114 superfamily, group 2, YoaB-like protein +FIG01075813 putative transcriptional regulator, lysR family protein +FIG01075818 FIG01075819: hypothetical protein +FIG01075819 FIG01075820: hypothetical protein +FIG01075820 FIG01075821: hypothetical protein +FIG01075832 FIG01075833: hypothetical protein +FIG01075833 FIG01075834: hypothetical protein +FIG01075837 FIG01075839: hypothetical protein +FIG01075839 FIG00450156: hypothetical protein +FIG01075840 FIG01075841: hypothetical protein +FIG01075846 Cell processes; Transport of small molecules; amino acids, amines, peptides +FIG01075847 FIG01075849: hypothetical protein +FIG01075850 FIG01075852: hypothetical protein +FIG01075855 FIG01075856: hypothetical protein +FIG01075868 FIG01075869: hypothetical protein +FIG01075876 FIG01075878: hypothetical protein +FIG01075878 putative repetitive two-component sensor histidine kinase transcriptional regulatory protein +FIG01075879 FIG01075881: hypothetical protein +FIG01075881 FIG01075882: hypothetical protein +FIG01075884 FIG01075887: hypothetical protein +FIG01075900 branched-chain amino acid ABC transporter, periplasmic amino acid-binding protein, putative +FIG01075902 FIG01075905: hypothetical protein +FIG01075908 FIG01075910: hypothetical protein +FIG01075910 FIG01075911: hypothetical protein +FIG01075911 Nodulation protein D (transcriptional regulator, LysR family) +FIG01075913 FIG01075914: hypothetical protein +FIG01075914 PUTATIVE TRANSCRIPTION REGULATION PROTEIN +FIG01075915 FIG01075918: hypothetical protein +FIG01075918 PUTATIVE TRANSCRIPTION REGULATOR PROTEIN +FIG01075919 FIG01075921: hypothetical protein +FIG01075921 FIG01075922: hypothetical protein +FIG01075924 FIG01075925: hypothetical protein +FIG01075927 FIG01075933: hypothetical protein +FIG01075936 putative sugar uptake ABC transporter permease protein +FIG01075941 FIG01075942: hypothetical protein +FIG01075944 FIG01075946: hypothetical protein +FIG01075950 FIG01075952: hypothetical protein +FIG01075953 FIG01075954: hypothetical protein +FIG01075954 FIG01075955: hypothetical protein +FIG01075955 FIG01075958: hypothetical protein +FIG01075960 macromolecule metabolism; macromolecule synthesis, modification; phospholipides +FIG01075966 FIG01075967: hypothetical protein +FIG01075967 FIG01075973: hypothetical protein +FIG01075973 FIG01075975: hypothetical protein +FIG01075984 FIG01075985: hypothetical protein +FIG01075992 FIG01075993: hypothetical protein +FIG01076005 FIG01076007: hypothetical protein +FIG01076010 ELEMENTS OF EXTERNAL ORIGIN; Colicin-related functions Non-bacterial functions +FIG01076012 FIG01076015: hypothetical protein +FIG01076024 FIG01076025: hypothetical protein +FIG01076026 putative ABC transporter, periplasmic solute-binding protein +FIG01076027 FIG01076031: hypothetical protein +FIG01076031 glutamate/aspartate transport protein, putative +FIG01076051 FIG01076053: hypothetical protein +FIG01076059 FIG01076060: hypothetical protein +FIG01076063 putative membrane-anchored protein +FIG01076064 FIG01076068: hypothetical protein +FIG01076074 FIG01076077: hypothetical protein +FIG01076081 FIG01076083: hypothetical protein +FIG01076086 FIG01076087: hypothetical protein +FIG01076087 FIG01076088: hypothetical protein +FIG01076092 FIG01076093: hypothetical protein +FIG01076096 FIG01076099: hypothetical protein +FIG01076099 FIG01076100: hypothetical protein +FIG01076115 FIG01076117: hypothetical protein +FIG01076117 FIG01076118: hypothetical protein +FIG01076118 FIG01076120: hypothetical protein +FIG01076121 FIG01076122: hypothetical protein +FIG01076124 FIG01076130: hypothetical protein +FIG01076130 FIG01076131: hypothetical protein +FIG01076131 ABC-type uncharacterized transport system, periplasmic component +FIG01076139 FIG01076144: hypothetical protein +FIG01076145 FIG01076147: hypothetical protein +FIG01076150 FIG01076152: hypothetical protein +FIG01076156 D-aminopeptidase (EC 3.4.11.19) +FIG01076159 FIG01076162: hypothetical protein +FIG01076166 putative two-component sensor histidine kinase protein( EC:2.7.3.- ) +FIG01076178 FIG01076180: hypothetical protein +FIG01076180 putative aliphatic sulfonates uptake ABC transporter periplasmic solute-binding protein precursor +FIG01076182 FIG01076183: hypothetical protein +FIG01076188 FIG01076189: hypothetical protein +FIG01076192 FIG01076193: hypothetical protein +FIG01076194 FIG01076197: hypothetical protein +FIG01076206 FIG01076207: hypothetical protein +FIG01076223 FIG01076224: hypothetical protein +FIG01076224 FIG01076226: hypothetical protein +FIG01076226 FIG01076231: hypothetical protein +FIG01076231 FIG01076233: hypothetical protein +FIG01076234 FIG01076236: hypothetical protein +FIG01076236 FIG00450271: hypothetical protein +FIG01076246 FIG01076248: hypothetical protein +FIG01076254 FIG01076256: hypothetical protein +FIG01076261 FIG01076262: hypothetical protein +FIG01076262 RhrA transcriptional activator +FIG01076268 FIG01076270: hypothetical protein +FIG01076285 HYPOTHETICAL LIPOPROTEIN TRANSMEMBRANE +FIG01076286 FIG01076290: hypothetical protein +FIG01076290 Aminomethyltransferase +FIG01076292 FIG01076295: hypothetical protein +FIG01076299 FIG01076301: hypothetical protein +FIG01076301 conserved putative protein +FIG01076313 PUTATIVE ACETYLTRANSFERASE PROTEIN +FIG01076316 Uncharacterized protein Mlr1045 +FIG01076319 FIG01076320: hypothetical protein +FIG01076323 FIG01076325: hypothetical protein +FIG01076325 FIG01076329: hypothetical protein +FIG01076329 FIG01076331: hypothetical protein +FIG01076331 FIG01076332: hypothetical protein +FIG01076332 FIG01076335: hypothetical protein +FIG01076335 Nodulation +FIG01076341 FIG01076345: hypothetical protein +FIG01076347 FIG01076348: hypothetical protein +FIG01076353 FIG01076356: hypothetical protein +FIG01076359 FIG01076361: hypothetical protein +FIG01076369 FIG01076371: hypothetical protein +FIG01076374 FIG01076375: hypothetical protein +FIG01076375 FIG01076376: hypothetical protein +FIG01076387 FIG01076388: hypothetical protein +FIG01076388 conserved hypothetical protein, similar to SMa10599 +FIG01076392 PUTATIVE PERIPLASMIC BINDING ABC TRANSPORTER PROTEIN +FIG01076397 HYPOTHETICAL UNKNOWN PROTEIN +FIG01076398 FIG01076401: hypothetical protein +FIG01076401 FIG01076404: hypothetical protein +FIG01076405 FIG01076407: hypothetical protein +FIG01076413 conserved putative membrane protein +FIG01076417 FIG01076419: hypothetical protein +FIG01076419 HYPOTHETICAL SIGNAL PEPTIDE PROTEIN +FIG01076425 FIG01076428: hypothetical protein +FIG01076430 PUTATIVE LIPOPOLYSACCHARIDE CORE BIOSYNTHESIS GLYCOSYL TRANSFERASE PROTEIN( EC:2.- ) +FIG01076431 FIG01076433: hypothetical protein +FIG01076436 FIG01076439: hypothetical protein +FIG01076444 Bona fide RidA/YjgF/TdcF/RutC subgroup +FIG01076447 FIG01076453: hypothetical protein +FIG01076453 FIG01076454: hypothetical protein +FIG01076454 FIG01076455: hypothetical protein +FIG01076455 FIG01076457: hypothetical protein +FIG01076457 hypothetical protein +FIG01076460 2-haloacid halidohydrolase Iva( EC:3.8.1.2 ) +FIG01076467 FIG01076475: hypothetical protein +FIG01076477 FIG01076481: hypothetical protein +FIG01076481 FIG01076488: hypothetical protein +FIG01076504 Mll8168 protein +FIG01076508 FIG01076510: hypothetical protein +FIG01076526 FIG01076528: hypothetical protein +FIG01076528 putative TonB-dependent receptor protein +FIG01076538 FIG01076540: hypothetical protein +FIG01076540 FIG01076541: hypothetical protein +FIG01076541 Transcriptional regulator protein fixT (Antikinase fixT) +FIG01076543 PUTATIVE PERMEASE TRANSMEMBRANE PROTEIN +FIG01076546 FIG01076554: hypothetical protein +FIG01076554 FIG01076555: hypothetical protein +FIG01076555 FIG01076556: hypothetical protein +FIG01076570 FIG01076572: hypothetical protein +FIG01076582 FIG01076584: hypothetical protein +FIG01076586 ATP-binding component of a ABC transport system (oligopeptide) +FIG01076588 PUTATIVE AMINO ACID-BINDING PERIPLASMIC PROTEIN +FIG01076589 Mll2721 protein +FIG01076593 FIG01076595: hypothetical protein +FIG01076602 FIG01076605: hypothetical protein +FIG01076612 FIG01076614: hypothetical protein +FIG01076614 FIG01076615: hypothetical protein +FIG01076615 FIG01076616: hypothetical protein +FIG01076619 FIG01076620: hypothetical protein +FIG01076625 FIG01076631: hypothetical protein +FIG01076646 FIG01076647: hypothetical protein +FIG01076650 FIG01076651: hypothetical protein +FIG01076674 Cell wall endopeptidase and peptidase, C40, NLP/P60 family fusion protein +FIG01076687 nitrate/nitrite transporter +FIG01076695 FIG01076699: hypothetical protein +FIG01076702 iron-dependent transcriptional regulator +FIG01076706 unknown domain / Cell division protein DivIC (FtsB), stabilizes FtsL against RasP cleavage +FIG01076715 FIG01076720: hypothetical protein +FIG01076730 FIG01076733: hypothetical protein +FIG01076736 FIG01076741: hypothetical protein +FIG01076741 FIG01076748: hypothetical protein +FIG01076748 FIG01076749: hypothetical protein +FIG01076750 FIG01076751: hypothetical protein +FIG01076751 FIG01076753: hypothetical protein +FIG01076754 FIG01076757: hypothetical protein +FIG01076771 FIG01076773: hypothetical protein +FIG01076779 FIG01076780: hypothetical protein +FIG01076828 FIG01076830: hypothetical protein +FIG01076830 lipopolysaccharide biosynthesis protein LicD +FIG01076854 FIG01076855: hypothetical protein +FIG01076856 Tagatose-6-phosphate kinase( EC:2.7.1.144 ) +FIG01076889 FIG01076910: hypothetical protein +FIG01076984 FIG01076985: hypothetical protein +FIG01076993 FIG01076994: hypothetical protein +FIG01077028 Ferredoxin-like protein ydiT +FIG01077039 FIG01077061: hypothetical protein +FIG01077063 FIG01077080: hypothetical protein +FIG01077082 FIG01077086: hypothetical protein +FIG01077127 FIG01077135: hypothetical protein +FIG01077138 Regulator of polyketide synthase expression-like +FIG01077146 FIG01077147: hypothetical protein +FIG01077186 FIG01077193: hypothetical protein +FIG01077193 FIG01077200: hypothetical protein +FIG01077215 FIG01077216: hypothetical protein +FIG01077226 FIG01077227: hypothetical protein +FIG01077227 FIG01077228: hypothetical protein +FIG01077237 FIG01077238: hypothetical protein +FIG01077255 FIG01077256: hypothetical protein +FIG01077267 FIG01077269: hypothetical protein +FIG01077269 FIG01077271: hypothetical protein +FIG01077279 FIG01077283: hypothetical protein +FIG01077305 DivIVA +FIG01077320 FIG01077328: hypothetical protein +FIG01077365 FIG01077372: hypothetical protein +FIG01077378 FIG01077385: hypothetical protein +FIG01077399 FIG01077401: hypothetical protein +FIG01077401 FIG01077404: hypothetical protein +FIG01077406 FIG01077407: hypothetical protein +FIG01077411 FIG01077416: hypothetical protein +FIG01077427 FIG01077431: hypothetical protein +FIG01077431 FIG01077436: hypothetical protein +FIG01077452 2-isopropylmalate synthase +FIG01077505 FIG01077506: hypothetical protein +FIG01077544 FIG01077552: hypothetical protein +FIG01077563 Peptidase family T4 +FIG01077564 FIG01077569: hypothetical protein +FIG01077576 FIG01077581: hypothetical protein +FIG01077613 FIG01077614: hypothetical protein +FIG01077625 FIG01077627: hypothetical protein +FIG01077627 FIG01077629: hypothetical protein +FIG01077629 FIG01077633: hypothetical protein +FIG01077639 FIG01077650: hypothetical protein +FIG01077661 FIG01077664: hypothetical protein +FIG01077664 FIG01077669: hypothetical protein +FIG01077687 FIG01077688: hypothetical protein +FIG01077710 FIG01077711: hypothetical protein +FIG01077723 FIG01077736: hypothetical protein +FIG01077768 FIG01077769: hypothetical protein +FIG01077794 FIG01077804: hypothetical protein +FIG01077830 FIG01077831: hypothetical protein +FIG01077860 FIG01077878: hypothetical protein +FIG01077886 FIG01077889: hypothetical protein +FIG01077905 FIG01077915: hypothetical protein +FIG01077975 FIG01077976: hypothetical protein +FIG01077997 FIG01078008: hypothetical protein +FIG01078021 Thioredoxin-like proteins and domains +FIG01078072 FIG01078073: hypothetical protein +FIG01078078 Cytoplasmic chaperone TorD +FIG01078188 Sll8048 protein +FIG01078239 FIG01078244: hypothetical protein +FIG01078256 FIG01078258: hypothetical protein +FIG01078259 FIG01078261: hypothetical protein +FIG01078317 FIG01078329: hypothetical protein +FIG01078471 FIG01078475: hypothetical protein +FIG01078475 putative phage antiterminator Q protein +FIG01078482 FIG01070919: hypothetical protein +FIG01078503 Acetyl-CoA:acetoacetyl-CoA transferase, alpha subunit (EC 2.8.3.8) / Acetyl-CoA:acetoacetyl-CoA transferase, beta subunit (EC 2.8.3.8) +FIG01078509 FIG01078512: hypothetical protein +FIG01078518 FIG01078528: hypothetical protein +FIG01078583 Long tail fiber protein p37 +FIG01078631 Putative aminohydrolase +FIG01078671 FIG01078673: hypothetical protein +FIG01078690 FIG01078692: hypothetical protein +FIG01078780 FIG01078785: hypothetical protein +FIG01078907 FIG01078911: hypothetical protein +FIG01078914 FIG01078916: hypothetical protein +FIG01078950 FIG01078951: hypothetical protein +FIG01078951 FIG01078952: hypothetical protein +FIG01078987 FIG01078988: hypothetical protein +FIG01079070 Putative sugar kinase/putative transcriptional regulator +FIG01079080 hypothetical protein +FIG01079217 FIG01079221: hypothetical protein +FIG01079392 putative 4-hydroxyphenylacetate permease +FIG01079438 Anthranilate phosphoribosyltransferase (EC 2.4.2.18) like +FIG01079524 Membrane-protein yhjW +FIG01079623 FIG01079625: hypothetical protein +FIG01080106 FIG01080108: hypothetical protein +FIG01080182 FIG01080189: hypothetical protein +FIG01080232 FIG01080233: hypothetical protein +FIG01080303 FIG01080306: hypothetical protein +FIG01080394 Vanillate demethylase( EC:1.14.13.82 ) +FIG01080480 Terminase, ATPase subunit +FIG01080500 Mlr2180 protein +FIG01080531 FIG01080539: hypothetical protein +FIG01080555 FIG01080558: hypothetical protein +FIG01080691 FIG01080692: hypothetical protein +FIG01080791 FIG01080792: hypothetical protein +FIG01080812 Probable serine proteinase, subtilase family +FIG01081308 FIG01081309: hypothetical protein +FIG01081399 FIG01081400: hypothetical protein +FIG01081470 FIG00801094: hypothetical protein +FIG01081522 Peroxiredoxin-like +FIG01081545 central metabolism +FIG01081595 Rolling pebbles isoform 7 +FIG01081925 3-demethylubiquinone-9 3-methyltransferase-like protein (EC 2.1.1.64) +FIG01081939 FIG01081942: hypothetical protein +FIG01081957 FIG01081959: hypothetical protein +FIG01082166 protein of unknown function DUF132 +FIG01082194 FIG01082195: hypothetical protein +FIG01082197 FIG01082201: hypothetical protein +FIG01082251 electron transfer flavoprotein beta subunit-like protein +FIG01082497 FIG01082500: hypothetical protein +FIG01082519 predicted DNA-binding proteins with PD1-like DNA-binding motif +FIG01082630 FIG01082631: hypothetical protein +FIG01082669 FIG01082671: hypothetical protein +FIG01083021 Integral membrane sensor signal transduction histidine kinase precursor +FIG01083200 FIG01083201: hypothetical protein +FIG01083367 FIG01083368: hypothetical protein +FIG01083437 probable platelet-activating factor acetylhydrolase IB gamma subunit +FIG01083439 FIG01083440: hypothetical protein +FIG01083704 FIG01083705: hypothetical protein +FIG01083748 FIG01083750: hypothetical protein +FIG01083895 Aminopeptidase Y (EC 3.4.11.-) +FIG01083931 bll3016; hypothetical protein +FIG01083932 related to two-component system sensory/regulatory protein (Ntr family) +FIG01083936 periplasmic protein-like +FIG01083951 FIG01083952: hypothetical protein +FIG01084048 Putative chloride channel +FIG01084112 Transcribed locus, weakly similar to NP_063946.1 N-acylsphingosine amidohydrolase (non-lysosomal ceramidase) 2 [Homo sapiens] [Source:UniGene;Acc:Cin.12797] +FIG01084279 FIG01084283: hypothetical protein +FIG01084502 FIG01084504: hypothetical protein +FIG01084555 Regulatory sensor-transducer, BlaR1/MecR1 family / Tetratricopeptide repeat-containing protein +FIG01084592 FIG01084593: hypothetical protein +FIG01084659 FIG01084660: hypothetical protein +FIG01084735 FIG01084738: hypothetical protein +FIG01084748 Multi-sensor signal transduction histidine kinase precursor +FIG01084777 FIG01084778: hypothetical protein +FIG01084864 Cytoplasmic membrane protein +FIG01084910 Regulatory protein, LacI +FIG01085056 Molybdopterin oxidoreductase, iron sulfur subunit +FIG01085074 Leukocyte elastase inhibitor (LEI) (Serpin B1) (Leukocyte neutral proteinase inhibitor) (LNPI) +FIG01085103 Response regulator/sensor histidine kinase +FIG01085210 Glycosyl hydrolase, family 30 +FIG01085226 RTX (Repeat in toxin) cytotoxin +FIG01085279 Gll4200 protein +FIG01085447 ADP-ribose 1"-phosphate phophatase +FIG01085475 Probable transmembrane abc transporter protein +FIG01085560 Predicted thiol oxidoreductase +FIG01085677 Urate oxidase( EC:1.7.3.3 ) +FIG01085727 FIG01085728: hypothetical protein +FIG01085737 Mlr5077 protein +FIG01085763 Kynureninase (EC 3.7.1.3) homolog +FIG01085985 FIG01085988: hypothetical protein +FIG01086055 FIG01086056: hypothetical protein +FIG01086165 Thiol-disulfide oxidoreductase +FIG01086264 FIG01086266: hypothetical protein +FIG01086315 Multiple EGF-like-domain protein 3 precursor +FIG01086486 probable ABC transporter ATP-binding protein +FIG01086510 FIG01086517: hypothetical protein +FIG01086543 Transcriptional regulatory protein prrA +FIG01086931 Cardiolipin synthetase +FIG01086993 Outer membrane protein A-like protein +FIG01087130 Fibroin +FIG01087149 Acetoacetate metabolism regulatory protein atoC (Ornithine/arginine decarboxylase inhibitor) (Ornithine decarboxylase antizyme) +FIG01087261 FIG01087264: hypothetical protein +FIG01087280 Serine-threonine protein kinase +FIG01087319 CBS domain-containing protein +FIG01087477 Uncharacterized lipoprotein aq_1262 precursor +FIG01087484 Probable Rhs-family protein +FIG01087585 Gll0995 protein +FIG01087737 FIG01087738: hypothetical protein +FIG01087980 TOMM biosynthesis dehydrogenase (protein B) +FIG01088071 Insecticidal toxin complex protein TccB1 +FIG01088083 putative mannose-1-phosphate guanyltransferase +FIG01088125 2-dehydropantoate 2-reductase (EC 1.1.1.169) homolog +FIG01088218 Serine/threonine kinase PKN11 +FIG01088234 FIG01088236: hypothetical protein +FIG01088238 FIG01088242: hypothetical protein +FIG01088368 Mandelate racemase (EC 5.1.2.2) +FIG01088637 FIG01088641: hypothetical protein +FIG01088709 Serine/threonine protein kinase PpkA +FIG01088758 MEGF11 protein +FIG01088935 Nitrilotriacetate monooxygenase component A +FIG01089012 FIG01089013: hypothetical protein +FIG01089054 Pressure-regulated protein +FIG01089171 MxcI +FIG01089269 Gll0645 protein +FIG01089274 FIG01089275: hypothetical protein +FIG01089461 Mannanase +FIG01089471 Circumsporozoite protein +FIG01089550 Serine/threonine protein kinase PknB (EC 2.7.11.1) +FIG01089612 rRNA small subunit 7-methylguanosine (m7G) methyltransferase GidB +FIG01089681 Serine/threonine kinase PKN9 +FIG01089973 FIG01089978: hypothetical protein +FIG01090189 FIG01090219: hypothetical protein +FIG01090379 Uroporphyrinogen decarboxylase (URO-D) +FIG01090473 FIG01090474: hypothetical protein +FIG01090474 FIG01090501: hypothetical protein +FIG01090821 probable transport portein +FIG01090912 FIG01090914: hypothetical protein +FIG01090922 DnaD/phage-associated domain protein +FIG01090957 acetolactate synthase large subunit +FIG01090972 probable penicillin-binding protein +FIG01091002 FIG01091004: hypothetical protein +FIG01091042 ABC daunorubicin resistance transporter, transmembrane permease component +FIG01091059 FIG01091061: hypothetical protein +FIG01091133 FIG01091141: hypothetical protein +FIG01091227 FIG01091228: hypothetical protein +FIG01091378 FIG01091380: hypothetical protein +FIG01091390 protein of unknown function DUF470 +FIG01091509 FIG01091510: hypothetical protein +FIG01091557 FIG01091594: hypothetical protein +FIG01091875 4-carboxymuconolactone decarboxylase domain protein +FIG01091920 COG2256: ATPase related to the helicase subunit of the Holliday junction resolvase +FIG01091932 FIG01091934: hypothetical protein +FIG01091998 gas vesicle protein, GvpL/GvpF family +FIG01092001 conserved protein YtkL +FIG01092008 FIG01092009: hypothetical protein +FIG01092032 FIG01092033: hypothetical protein +FIG01092052 FIG01092053: hypothetical protein +FIG01092125 FIG01092127: hypothetical protein +FIG01092149 FIG01092150: hypothetical protein +FIG01092213 FIG01092214: hypothetical protein +FIG01092251 FIG01092252: hypothetical protein +FIG01092255 FIG01092256: hypothetical protein +FIG01092279 FIG01092280: hypothetical protein +FIG01092289 FIG01092290: hypothetical protein +FIG01092319 FIG01092320: hypothetical protein +FIG01092367 two-component system, transcriptional regulatory protein +FIG01092410 FIG01092412: hypothetical protein +FIG01092415 FIG01092416: hypothetical protein +FIG01092452 conserved hypothetical protein, with TPR repeat +FIG01092488 FIG01092489: hypothetical protein +FIG01092504 FIG01092505: hypothetical protein +FIG01092509 arabinose-proton symporter +FIG01092519 FIG01092520: hypothetical protein +FIG01092538 MerP, putative +FIG01092587 FIG01092588: hypothetical protein +FIG01092634 FIG01092635: hypothetical protein +FIG01092639 FIG01092640: hypothetical protein +FIG01092713 PepSY-associated TM helix domain protein +FIG01092745 FIG01092746: hypothetical protein +FIG01092757 FIG01092758: hypothetical protein +FIG01092784 FIG01092786: hypothetical protein +FIG01092834 FIG01092835: hypothetical protein +FIG01092844 FIG01092845: hypothetical protein +FIG01092870 FIG01092871: hypothetical protein +FIG01092913 FIG01092914: hypothetical protein +FIG01092934 FIG01092935: hypothetical protein +FIG01092942 FIG01092943: hypothetical protein +FIG01092959 FIG01092960: hypothetical protein +FIG01092961 FIG01092962: hypothetical protein +FIG01092986 FIG01092988: hypothetical protein +FIG01093012 FIG01093013: hypothetical protein +FIG01093028 FIG01093029: hypothetical protein +FIG01093047 FIG01093048: hypothetical protein +FIG01093141 putative extracytoplasmic function alternative sigma factor +FIG01093142 FIG01093143: hypothetical protein +FIG01093149 FIG01093150: hypothetical protein +FIG01093184 FIG01093185: hypothetical protein +FIG01093238 FIG01093239: hypothetical protein +FIG01093259 FIG01093260: hypothetical protein +FIG01093261 putative membrane-bound lytic murein transglycosylase +FIG01093263 FIG01093264: hypothetical protein +FIG01093292 FIG01093294: hypothetical protein +FIG01093295 SCO1/SenC family electron transport protein +FIG01093300 FIG01093301: hypothetical protein +FIG01093327 FIG01093328: hypothetical protein +FIG01093427 FIG01093428: hypothetical protein +FIG01093441 FIG01093442: hypothetical protein +FIG01093474 FIG01093475: hypothetical protein +FIG01093483 FIG01093484: hypothetical protein +FIG01093489 FIG01093490: hypothetical protein +FIG01093500 mechanosensitive ion channel +FIG01093511 FIG01093512: hypothetical protein +FIG01093520 Endo-beta-N-acetylglucosaminidase F1 precursor (EC 3.2.1.96) (Mannosyl-glycoprotein endo-beta-N-acetyl-glucosaminidase F1) (Di-N-acetylchitobiosyl beta-N-acetylglucosaminidase F1) (Endoglycosidase F1) +FIG01093524 FIG01093525: hypothetical protein +FIG01093531 FIG01093532: hypothetical protein +FIG01093579 FIG01093580: hypothetical protein +FIG01093605 FIG01093606: hypothetical protein +FIG01093648 FIG01093649: hypothetical protein +FIG01093663 FIG01093664: hypothetical protein +FIG01093671 FIG01093672: hypothetical protein +FIG01093685 RNA polymerase sigma factor (possible RNA polymerase sigma-24 factor) +FIG01093713 FIG01093714: hypothetical protein +FIG01093720 FIG01093721: hypothetical protein +FIG01093729 phytase +FIG01093829 FIG01093830: hypothetical protein +FIG01093849 FIG01093850: hypothetical protein +FIG01093856 FIG01093857: hypothetical protein +FIG01093886 FIG01093887: hypothetical protein +FIG01093921 FIG00404578: hypothetical protein +FIG01093938 protein containing DUF853 +FIG01093995 FIG01093996: hypothetical protein +FIG01094007 FIG01094008: hypothetical protein +FIG01094016 FIG01094017: hypothetical protein +FIG01094116 FIG01094118: hypothetical protein +FIG01094123 FIG01094124: hypothetical protein +FIG01094126 putative ECF-type RNA polymerase sigma factor +FIG01094136 FIG01094137: hypothetical protein +FIG01094155 FIG01094156: hypothetical protein +FIG01094174 FIG01094176: hypothetical protein +FIG01094179 FIG01094180: hypothetical protein +FIG01094196 transcriptional regulator, PbsX family protein +FIG01094316 FIG01094317: hypothetical protein +FIG01094322 Rieske (2Fe-2S) region( EC:1.14.13.82 ) +FIG01094326 FIG01094327: hypothetical protein +FIG01094374 Endo-1,3-1,4-beta-glycanase exsH (EC 3.2.1.-) +FIG01094377 FIG01094381: hypothetical protein +FIG01094396 FIG01094397: hypothetical protein +FIG01094398 probable beta lactamase( EC:3.5.2.6 ) +FIG01094411 FIG01094412: hypothetical protein +FIG01094443 Two-component signal transduction histidine kinase +FIG01094542 Succinyl-CoA:3-ketoacid-coenzyme A transferase subunit B (EC 2.8.3.5) +FIG01094579 FIG01094583: hypothetical protein +FIG01094583 FIG01094584: hypothetical protein +FIG01094633 FIG01094634: hypothetical protein +FIG01094647 FIG01094649: hypothetical protein +FIG01094653 FIG01094656: hypothetical protein +FIG01094666 FIG01094667: hypothetical protein +FIG01094668 Sensor histidine kinase precursor +FIG01094684 FIG01094685: hypothetical protein +FIG01094697 peptidase C1A, papain +FIG01094698 FIG01094699: hypothetical protein +FIG01094699 FIG01094700: hypothetical protein +FIG01094706 FIG01094707: hypothetical protein +FIG01094734 FIG01094736: hypothetical protein +FIG01094741 FIG01094745: hypothetical protein +FIG01094766 FIG01094767: hypothetical protein +FIG01094794 FIG01094795: hypothetical protein +FIG01094808 FIG01094809: hypothetical protein +FIG01094809 FIG01094811: hypothetical protein +FIG01094812 membrane-associated proteins in eicosanoid and glutathione metabolism (MAPEG) +FIG01094834 putative glutatione S-transferase +FIG01094835 Alr3170 protein +FIG01094844 FIG01094846: hypothetical protein +FIG01094952 FIG01094955: hypothetical protein +FIG01095004 FIG01095008: hypothetical protein +FIG01095036 Mlr0862 protein +FIG01095044 Mlr7180 protein +FIG01095169 FIG01095170: hypothetical protein +FIG01095200 FIG01095201: hypothetical protein +FIG01095236 FIG01095237: hypothetical protein +FIG01095244 FIG01095245: hypothetical protein +FIG01095308 FIG01095310: hypothetical protein +FIG01095352 FIG01095356: hypothetical protein +FIG01095379 FIG01095382: hypothetical protein +FIG01095413 Xenobiotic compound monooxygenase, DszA family, A subunit +FIG01095427 FIG01095428: hypothetical protein +FIG01095435 FIG01095443: hypothetical protein +FIG01095460 FIG01095463: hypothetical protein +FIG01095464 FIG01095466: hypothetical protein +FIG01095525 FIG01095526: hypothetical protein +FIG01095557 FIG01095558: hypothetical protein +FIG01095610 TRANSCRIPTIONAL REGULATOR, MERR FAMILY +FIG01095634 protein of unknown function DUF849 +FIG01095643 FIG01095644: hypothetical protein +FIG01095668 FIG01095670: hypothetical protein +FIG01095691 FIG01095692: hypothetical protein +FIG01095698 FIG01095700: hypothetical protein +FIG01095749 FIG01095750: hypothetical protein +FIG01095790 FIG01095791: hypothetical protein +FIG01095887 FIG01095889: hypothetical protein +FIG01095920 FIG01095921: hypothetical protein +FIG01095966 FIG01095969: hypothetical protein +FIG01095995 Glutathione-regulated potassium-efflux system protein kefB +FIG01096022 FIG01096024: hypothetical protein +FIG01096059 FIG01096060: hypothetical protein +FIG01096105 FIG01096106: hypothetical protein +FIG01096108 FIG01096109: hypothetical protein +FIG01096199 TspO and MBR like proteins +FIG01096222 Short-chain dehydrogenase/reductase SDR (EC 1.1.1.100) +FIG01096224 TadE-like protein +FIG01096283 FIG01096284: hypothetical protein +FIG01096306 FIG01096308: hypothetical protein +FIG01096308 Circumsporozoite protein precursor +FIG01096327 Mlr0480 protein +FIG01096336 FIG01096339: hypothetical protein +FIG01096405 FIG01096413: hypothetical protein +FIG01096446 FIG01096447: hypothetical protein +FIG01096488 FIG01096489: hypothetical protein +FIG01096576 Phytase domain protein (EC 3.1.3.8) +FIG01096594 Regulator +FIG01096599 FIG01096602: hypothetical protein +FIG01096654 Nodulation protein D II +FIG01096743 FIG01096744: hypothetical protein +FIG01096747 FIG01096748: hypothetical protein +FIG01096859 Mll2521 protein +FIG01096911 FIG01096913: hypothetical protein +FIG01096998 FIG01096999: hypothetical protein +FIG01097036 FIG01097037: hypothetical protein +FIG01097081 COG0419: ATPase involved in DNA repair +FIG01097107 FIG01097108: hypothetical protein +FIG01097167 FIG01097168: hypothetical protein +FIG01097171 FIG01097172: hypothetical protein +FIG01097197 FIG01097200: hypothetical protein +FIG01097213 FIG01097214: hypothetical protein +FIG01097243 transcription regulator TetR/AcrR family homolog ydeS +FIG01097262 FIG01097263: hypothetical protein +FIG01097318 FIG01097320: hypothetical protein +FIG01097320 FIG01094483: hypothetical protein +FIG01097335 FIG01097338: hypothetical protein +FIG01097358 peptidase M16-like protein +FIG01097385 FIG01097387: hypothetical protein +FIG01097409 dihydropteroate synthase +FIG01097493 Bll0819 protein +FIG01097517 FIG01097519: hypothetical protein +FIG01097541 FIG01097544: hypothetical protein +FIG01097647 FIG01097649: hypothetical protein +FIG01097687 putative NnrU protein +FIG01097718 FIG006285: ICC-like protein phosphoesterase +FIG01097796 FIG01097797: hypothetical protein +FIG01097875 FIG01224800: hypothetical protein +FIG01097876 FIG01097881: hypothetical protein +FIG01097885 tgtA5 cluster protein 1 +FIG01098125 putative purple acid phosphatase +FIG01098293 metallophosphoesterase/PKD domain protein +FIG01098366 crispr-associated protein Cas6 +FIG01098422 FIG01098424: hypothetical protein +FIG01098483 probable L-sorbosone dehydrogenase +FIG01098515 glycoside hydrolase, family 43 +FIG01098606 phytochrome +FIG01098776 FIG01098778: hypothetical protein +FIG01098846 Cytochrome c subunit of cbb3 type cytochrome +FIG01098925 phosphoserine aminotransferase( EC:2.6.1.52 ) +FIG01099054 5'(3')-deoxyribonucleotidase( EC:3.1.3.- ) +FIG01099240 methylamine utilization protein/Cytochrome c peroxidase +FIG01099249 UDP-2,3-diacylglucosamine hydrolase (EC 3.6.1.-) +FIG01099336 FIG01099341: hypothetical protein +FIG01099501 two-component sensor histidine kinase of extracellular degradative enzyme, putative +FIG01099554 Fe-S oxidoreductase, possible dehydrogenase subunit +FIG01099644 COG2244: Membrane protein involved in the export of O-antigen and teichoic acid +FIG01099835 FIG01099837: hypothetical protein +FIG01099840 AAA_5 ATPase +FIG01099846 8-amino-7-oxononanoate synthase +FIG01100194 hemin ABC transporter, permease protein, putative +FIG01100294 putative outer-membrane lipoproteins carrier protein +FIG01100467 L-fucose transporter +FIG01100632 Possible TonB-dependent receptor +FIG01100711 sensor for ctr capsule biosynthesis, probable histidine kinase acting on RcsB( EC:2.7.3.- ) +FIG01100749 PorT-related protein +FIG01100831 UTP--glucose-1-phosphate uridylyltransferase-like protein +FIG01100966 probable sodium:solute symporter +FIG01101089 putative anti sigma factor +FIG01101145 ATP-dependent endonuclease of the OLD family-like +FIG01101150 FIG01101155: hypothetical protein +FIG01101174 FIG01101175: hypothetical protein +FIG01101259 putative large, multifunctional secreted protein +FIG01101309 alginate O-acetylation protein +FIG01101443 FIG01101450: hypothetical protein +FIG01101487 FIG01101490: hypothetical protein +FIG01101519 biotin carboxyl carrier protein of acyl-CoA carb oxylase +FIG01101840 FIG01101850: hypothetical protein +FIG01101880 SusD/RagB family protein +FIG01102015 nodulation protein L +FIG01102032 possible thiol-disulfide isomerase +FIG01102176 anti-anti-sigma regulatory factor (antagonist of anti-sigma factor) +FIG01102360 FIG01102362: hypothetical protein +FIG01102370 Putative reverse transcriptase +FIG01102372 transcriptional regulator, sigma-54-related +FIG01102454 FIG01102458: hypothetical protein +FIG01102475 bacteroides aerotolerance operon protein +FIG01102500 intradiol ring-cleavage dioxygenase +FIG01102528 a-glycosyltransferase-related protein, glycosyltransferase family 4 protein +FIG01102543 Acetylornithine aminotransferase (EC 2.6.1.11) (ACOAT) +FIG01102758 Rubredoxin +FIG01103010 Similar to ribosomal large subunit pseudouridine synthase D, type RluD3 +FIG01103027 FIG01103029: hypothetical protein +FIG01103038 FIG01103044: hypothetical protein +FIG01103046 proteophosphoglycan 5 +FIG01103050 FIG01103052: hypothetical protein +FIG01103052 FIG01103058: hypothetical protein +FIG01103058 FIG01103060: hypothetical protein +FIG01103060 probable ABC quaternary amine transporter,permease component +FIG01103062 FIG01103064: hypothetical protein +FIG01103069 proteinase (secreted protein) +FIG01103119 FIG01103124: hypothetical protein +FIG01103155 FIG01103156: hypothetical protein +FIG01103156 Zinc protease +FIG01103192 ADP-ribosylglycohydrolase (EC 3.2.-.-) +FIG01103193 FIG01103203: hypothetical protein +FIG01103203 FIG01103208: hypothetical protein +FIG01103227 FIG01103229: hypothetical protein +FIG01103229 FIG01103239: hypothetical protein +FIG01103239 FAD-binding monooxygenase, PheA/TfdB family, similarity to 2,4-dichlorophenol 6-monooxygenase +FIG01103248 FIG01103249: hypothetical protein +FIG01103249 FIG01103257: hypothetical protein +FIG01103288 FIG01103295: hypothetical protein +FIG01103308 FIG01103321: hypothetical protein +FIG01103329 FIG01103339: hypothetical protein +FIG01103350 FIG01103354: hypothetical protein +FIG01103354 FIG01103356: hypothetical protein +FIG01103356 FIG01103360: hypothetical protein +FIG01103363 FIG01103367: hypothetical protein +FIG01103367 FIG01103368: hypothetical protein +FIG01103383 FIG01103396: hypothetical protein +FIG01103396 FIG01103399: hypothetical protein +FIG01103403 FIG01103409: hypothetical protein +FIG01103409 sugar ABC transporter sugar-binding protein +FIG01103418 FIG01103425: hypothetical protein +FIG01103434 FIG01103436: hypothetical protein +FIG01103441 FIG01103443: hypothetical protein +FIG01103450 FIG01103460: hypothetical protein +FIG01103460 cysteine dioxygenase +FIG01103464 FIG01103465: hypothetical protein +FIG01103498 FIG01103510: hypothetical protein +FIG01103510 FIG01103523: hypothetical protein +FIG01103523 FIG01103527: hypothetical protein +FIG01103527 ABC-type dipeptide/oligopeptide/nickel transport systems, periplasmic components +FIG01103531 FIG01103548: hypothetical protein +FIG01103558 FIG01103560: hypothetical protein +FIG01103564 FIG01103588: hypothetical protein +FIG01103588 FIG01103597: hypothetical protein +FIG01103606 FIG01103609: hypothetical protein +FIG01103619 FIG01103636: hypothetical protein +FIG01103643 2,3-dihydro-2,3-dihydroxybenzoate dehydrogenase (EC 1.3.1.28) of siderophore biosynthesis +FIG01103659 FIG01103660: hypothetical protein +FIG01103667 FIG01103687: hypothetical protein +FIG01103687 FIG01103700: hypothetical protein +FIG01103700 FIG01103707: hypothetical protein +FIG01103734 FIG01103751: hypothetical protein +FIG01103751 FIG01103767: hypothetical protein +FIG01103782 FIG01103784: hypothetical protein +FIG01103790 FIG01103791: hypothetical protein +FIG01103814 FIG01103821: hypothetical protein +FIG01103838 FIG01103841: hypothetical protein +FIG01103842 FIG01103851: hypothetical protein +FIG01103851 FIG01103853: hypothetical protein +FIG01103853 FIG01103863: hypothetical protein +FIG01103863 FIG01103865: hypothetical protein +FIG01103868 FIG01103874: hypothetical protein +FIG01103874 TIORF63 protein +FIG01103902 FIG01103907: hypothetical protein +FIG01103907 FIG01103910: hypothetical protein +FIG01103947 ABC transporter membrane protein +FIG01103957 FIG01103964: hypothetical protein +FIG01103965 ABC transporter sugar binding protein +FIG01103978 FIG01103980: hypothetical protein +FIG01103988 cytochrome-c3 hydrogenase delta chain PAB1786 +FIG01103995 FIG01104001: hypothetical protein +FIG01104007 FIG01104020: hypothetical protein +FIG01104028 FIG01104030: hypothetical protein +FIG01104038 FIG01104043: hypothetical protein +FIG01104048 FIG01104054: hypothetical protein +FIG01104054 FIG01104058: hypothetical protein +FIG01104059 FIG01104067: hypothetical protein +FIG01104067 alkylhydroperoxidase AhpD +FIG01104069 FIG01104073: hypothetical protein +FIG01104073 putative secreted/membrane protein +FIG01104086 FIG01104087: hypothetical protein +FIG01104087 FIG01104099: hypothetical protein +FIG01104134 FIG01104137: hypothetical protein +FIG01104137 FIG01104139: hypothetical protein +FIG01104202 FIG01104205: hypothetical protein +FIG01104205 FIG00823427: hypothetical protein +FIG01104225 FIG01104230: hypothetical protein +FIG01104230 FIG01104252: hypothetical protein +FIG01104252 Mannan endo-1,4-beta-mannosidase A and B precursor (EC 3.2.1.78) (Beta-mannanase) (Endo-1,4-mannanase) [Contains: Mannan endo-1,4-beta-mannosidase A; Mannan endo-1,4-beta-mannosidase B] +FIG01104270 LuxR family two component system response regulator +FIG01104271 FIG01104272: hypothetical protein +FIG01104272 FIG01104273: hypothetical protein +FIG01104282 FIG01104285: hypothetical protein +FIG01104325 FIG01104335: hypothetical protein +FIG01104336 FIG01104340: hypothetical protein +FIG01104340 FIG01104342: hypothetical protein +FIG01104348 FIG01104350: hypothetical protein +FIG01104353 FIG01104355: hypothetical protein +FIG01104355 FIG01104357: hypothetical protein +FIG01104357 FIG01104358: hypothetical protein +FIG01104379 FIG01104389: hypothetical protein +FIG01104389 alkanal monooxygenase (luciferase) +FIG01104397 FIG01104399: hypothetical protein +FIG01104431 FIG01104441: hypothetical protein +FIG01104451 FIG01104462: hypothetical protein +FIG01104462 FIG01104479: hypothetical protein +FIG01104479 FIG01104490: hypothetical protein +FIG01104490 FIG01104502: hypothetical protein +FIG01104509 FIG01104512: hypothetical protein +FIG01104512 FIG01104521: hypothetical protein +FIG01104525 FIG01104537: hypothetical protein +FIG01104537 FIG01104543: hypothetical protein +FIG01104558 FIG01104559: hypothetical protein +FIG01104559 FIG01104583: hypothetical protein +FIG01104583 FIG01104595: hypothetical protein +FIG01104603 FIG01104607: hypothetical protein +FIG01104607 FIG01104610: hypothetical protein +FIG01104628 FIG01104630: hypothetical protein +FIG01104630 FIG01104634: hypothetical protein +FIG01104649 FIG01104651: hypothetical protein +FIG01104651 FIG01104660: hypothetical protein +FIG01104687 FIG01104690: hypothetical protein +FIG01104701 FIG01104707: hypothetical protein +FIG01104709 FIG01104711: hypothetical protein +FIG01104742 FIG01104743: hypothetical protein +FIG01104772 FIG01104777: hypothetical protein +FIG01104804 FIG01104833: hypothetical protein +FIG01104835 FIG01104849: hypothetical protein +FIG01104849 FIG01104852: hypothetical protein +FIG01104852 FIG01104856: hypothetical protein +FIG01104856 FIG01104862: hypothetical protein +FIG01104862 FIG01104863: hypothetical protein +FIG01104863 transcriptional regulator, PbsX family +FIG01104864 FIG01104873: hypothetical protein +FIG01104873 FIG01104880: hypothetical protein +FIG01104880 COG1404: Subtilisin-like serine proteases +FIG01104910 FIG01104917: hypothetical protein +FIG01104921 FIG01104930: hypothetical protein +FIG01104930 FIG01104933: hypothetical protein +FIG01104940 FIG01104941: hypothetical protein +FIG01104941 FIG01104942: hypothetical protein +FIG01104950 FIG01104966: hypothetical protein +FIG01104966 cysteine dioxygenase type I +FIG01104973 FIG01104979: hypothetical protein +FIG01104979 FIG01104986: hypothetical protein +FIG01104986 FIG01104995: hypothetical protein +FIG01104995 FIG01105003: hypothetical protein +FIG01105003 FIG01105012: hypothetical protein +FIG01105012 FIG01105014: hypothetical protein +FIG01105014 FIG01105021: hypothetical protein +FIG01105021 FIG01105023: hypothetical protein +FIG01105023 FIG01105035: hypothetical protein +FIG01105035 FIG01105042: hypothetical protein +FIG01105042 FIG01105047: hypothetical protein +FIG01105054 FIG01105058: hypothetical protein +FIG01105058 FIG01105060: hypothetical protein +FIG01105067 putative aldose-1-epimerase +FIG01105069 FIG01105070: hypothetical protein +FIG01105070 FIG01105073: hypothetical protein +FIG01105073 FIG01105089: hypothetical protein +FIG01105089 Death on curing protein, Doc toxin +FIG01105104 FIG01105109: hypothetical protein +FIG01105109 FIG01105111: hypothetical protein +FIG01105126 FIG01105137: hypothetical protein +FIG01105181 FIG01105211: hypothetical protein +FIG01105217 FIG01105218: hypothetical protein +FIG01105232 FIG01105236: hypothetical protein +FIG01105236 FIG01105252: hypothetical protein +FIG01105252 FIG01105261: hypothetical protein +FIG01105264 putative integral membrane plasmid transfer protein +FIG01105266 possible lyase +FIG01105274 FIG01105280: hypothetical protein +FIG01105296 FAD-binding monooxygenase, PheA/TfdB family, similarity to 2,4-dichlorophenol 6-monooxygenase +FIG01105298 FIG01105300: hypothetical protein +FIG01105302 FIG01105305: hypothetical protein +FIG01105322 FIG01105326: hypothetical protein +FIG01105332 FIG01105341: hypothetical protein +FIG01105374 PUTATIVE OXIDOREDUCTASE PROTEIN( EC:1.- ) +FIG01105376 FIG01105389: hypothetical protein +FIG01105411 hyaluronoglucosaminidase precursor +FIG01105419 FIG01105422: hypothetical protein +FIG01105429 FIG01105435: hypothetical protein +FIG01105435 FIG01105437: hypothetical protein +FIG01105437 FIG01105438: hypothetical protein +FIG01105456 FIG01105457: hypothetical protein +FIG01105457 FIG01105458: hypothetical protein +FIG01105463 FIG01105464: hypothetical protein +FIG01105475 FIG01105477: hypothetical protein +FIG01105488 FIG01105493: hypothetical protein +FIG01105495 FIG01105497: hypothetical protein +FIG01105510 FIG01105513: hypothetical protein +FIG01105513 FIG01105516: hypothetical protein +FIG01105516 FIG01105528: hypothetical protein +FIG01105528 FIG01105529: hypothetical protein +FIG01105529 FIG01105531: hypothetical protein +FIG01105538 FIG01105561: hypothetical protein +FIG01105580 FIG01105591: hypothetical protein +FIG01105591 FIG01105600: hypothetical protein +FIG01105604 FIG01105606: hypothetical protein +FIG01105608 FIG01105621: hypothetical protein +FIG01105621 purine and other phosphorylases, family 1 +FIG01105653 FIG01105678: hypothetical protein +FIG01105678 FIG01105689: hypothetical protein +FIG01105689 FIG01105717: hypothetical protein +FIG01105718 FIG01105733: hypothetical protein +FIG01105733 FIG01105738: hypothetical protein +FIG01105739 FIG01105743: hypothetical protein +FIG01105754 FIG01105761: hypothetical protein +FIG01105768 ABC transporter ATP-binding protein (EC 3.6.3.25) +FIG01105771 FIG01105772: hypothetical protein +FIG01105803 FIG01105808: hypothetical protein +FIG01105851 FIG01105858: hypothetical protein +FIG01105858 FIG01105863: hypothetical protein +FIG01105863 FIG01105874: hypothetical protein +FIG01105875 FIG01105881: hypothetical protein +FIG01105881 FIG01105882: hypothetical protein +FIG01105882 FIG01105883: hypothetical protein +FIG01105913 AMIDASE +FIG01105926 FIG01105932: hypothetical protein +FIG01105974 FIG01105974: Probable conserved alanine rich transmembrane protein +FIG01105975 FIG01105978: hypothetical protein +FIG01105979 FIG01105980: hypothetical protein +FIG01105980 FIG01105982: hypothetical protein +FIG01105982 FIG01105996: hypothetical protein +FIG01105996 FIG01105998: hypothetical protein +FIG01105998 FIG01106001: hypothetical protein +FIG01106001 putative ABC-2 type transporter, permease protein +FIG01106006 FIG01106012: hypothetical protein +FIG01106012 putative sugar phosphate isomerase/epimerase +FIG01106022 FIG01106029: hypothetical protein +FIG01106029 FIG01106033: hypothetical protein +FIG01106033 FIG01106036: hypothetical protein +FIG01106065 FIG01106066: hypothetical protein +FIG01106077 FIG01106083: hypothetical protein +FIG01106083 FIG01106090: hypothetical protein +FIG01106090 FIG01106091: hypothetical protein +FIG01106116 FIG01106118: hypothetical protein +FIG01106118 FIG01106123: hypothetical protein +FIG01106123 FIG01106125: hypothetical protein +FIG01106125 FIG01106128: hypothetical protein +FIG01106128 FIG01106129: hypothetical protein +FIG01106154 FIG01106156: hypothetical protein +FIG01106156 FIG01106157: hypothetical protein +FIG01106157 FIG01106158: hypothetical protein +FIG01106158 FIG01106167: hypothetical protein +FIG01106170 FIG01106180: hypothetical protein +FIG01106180 FIG01106186: hypothetical protein +FIG01106201 FIG01106209: hypothetical protein +FIG01106209 FIG01106211: hypothetical protein +FIG01106250 FIG01106253: hypothetical protein +FIG01106255 Serine-type D-Ala-D-Ala carboxypeptidase( EC:3.4.16.4 ) +FIG01106267 FIG01106279: hypothetical protein +FIG01106279 ABC-type polysaccharide/polyol phosphate export systems, permease component +FIG01106289 FIG01106295: hypothetical protein +FIG01106295 FIG01106296: hypothetical protein +FIG01106304 FIG01106307: hypothetical protein +FIG01106309 FIG01106322: hypothetical protein +FIG01106322 FIG01106326: hypothetical protein +FIG01106326 similar to Carboxylesterase 2 +FIG01106354 hypothetical protein; putative signal peptide; putative serine protease +FIG01106385 carbohydrate kinase, FGGY( EC:2.7.1.17 ) +FIG01106391 FIG01106393: hypothetical protein +FIG01106400 FIG01106406: hypothetical protein +FIG01106406 FIG01106410: hypothetical protein +FIG01106410 FIG01106424: hypothetical protein +FIG01106424 FIG01106429: hypothetical protein +FIG01106429 FIG01106431: hypothetical protein +FIG01106432 Penicillin-binding protein 4 (PBP-4) +FIG01106438 putative dehydrogenase (putative secreted protein) +FIG01106444 putative L-arabinose isomerase +FIG01106451 FIG01106473: hypothetical protein +FIG01106506 FIG01106515: hypothetical protein +FIG01106515 FIG01106522: hypothetical protein +FIG01106538 Ribosomal-protein-S5p-alanine acetyltransferase related proteins +FIG01106540 FIG01106557: hypothetical protein +FIG01106561 FIG01106563: hypothetical protein +FIG01106573 putative membrane protein (DUF990 family) +FIG01106576 FIG01106591: hypothetical protein +FIG01106591 FIG01106597: hypothetical protein +FIG01106597 FIG01106609: hypothetical protein +FIG01106623 FIG01106624: hypothetical protein +FIG01106624 putative esterase/lipase +FIG01106636 FIG01106638: hypothetical protein +FIG01106666 FIG01106677: hypothetical protein +FIG01106677 FIG01106680: hypothetical protein +FIG01106699 FIG01106700: hypothetical protein +FIG01106700 FIG01106718: hypothetical protein +FIG01106733 FIG01106738: hypothetical protein +FIG01106738 ABC transporter integral membrane protein BldKA +FIG01106784 FIG01106788: hypothetical protein +FIG01106790 FIG01106793: hypothetical protein +FIG01106793 FIG01106802: hypothetical protein +FIG01106809 Surface protein precursor (Plasmin-sensitive surface protein) (230 kDa cell-wall protein) +FIG01106811 FIG01106816: hypothetical protein +FIG01106816 teichoic acid biosynthesis protein c +FIG01106838 FIG01106848: hypothetical protein +FIG01106859 FIG01106864: hypothetical protein +FIG01106864 FIG01106871: hypothetical protein +FIG01106871 FIG01106875: hypothetical protein +FIG01106875 FIG01106889: hypothetical protein +FIG01106889 putative streptomycin 6-O-phosphotransferase +FIG01106904 FIG01106905: hypothetical protein +FIG01106905 FIG01106908: hypothetical protein +FIG01106908 FIG01106917: hypothetical protein +FIG01106917 FIG01106923: hypothetical protein +FIG01106937 FIG01106954: hypothetical protein +FIG01106958 dehydrogenase (secreted protein) +FIG01107014 FIG01107016: hypothetical protein +FIG01107022 FIG01173569: hypothetical protein +FIG01107027 FIG01107029: hypothetical protein +FIG01107029 FIG01107035: hypothetical protein +FIG01107045 FIG01107056: hypothetical protein +FIG01107056 FIG01107065: hypothetical protein +FIG01107069 FIG01107071: hypothetical protein +FIG01107071 FIG01107097: hypothetical protein +FIG01107109 FIG01107118: hypothetical protein +FIG01107118 FIG01107123: hypothetical protein +FIG01107136 FIG01107143: hypothetical protein +FIG01107143 FIG01107154: hypothetical protein +FIG01107154 FIG01107169: hypothetical protein +FIG01107203 FIG01107219: hypothetical protein +FIG01107224 FIG01107226: hypothetical protein +FIG01107226 FIG01107232: hypothetical protein +FIG01107232 FIG01107247: hypothetical protein +FIG01107250 FIG01107266: hypothetical protein +FIG01107266 FIG01107270: hypothetical protein +FIG01107270 FIG01107285: hypothetical protein +FIG01107285 FIG01107297: hypothetical protein +FIG01107303 FIG01107315: hypothetical protein +FIG01107315 FIG01107316: hypothetical protein +FIG01107316 FIG01107318: hypothetical protein +FIG01107318 FIG01107344: hypothetical protein +FIG01107344 FIG01107345: hypothetical protein +FIG01107346 FIG01107361: hypothetical protein +FIG01107367 FIG01107372: hypothetical protein +FIG01107397 FIG01107404: hypothetical protein +FIG01107404 FIG01107409: hypothetical protein +FIG01107409 FIG01107410: hypothetical protein +FIG01107421 FIG01107440: hypothetical protein +FIG01107461 FIG01107464: hypothetical protein +FIG01107465 FIG01107475: hypothetical protein +FIG01107482 glycoside hydrolase, family 25 +FIG01107537 FIG01107547: hypothetical protein +FIG01107557 FIG01107561: hypothetical protein +FIG01107572 FIG01107583: hypothetical protein +FIG01107585 FIG01107589: hypothetical protein +FIG01107596 FIG01107603: hypothetical protein +FIG01107608 FIG01107609: hypothetical protein +FIG01107609 FIG01107616: hypothetical protein +FIG01107622 FIG01107633: hypothetical protein +FIG01107643 FIG01107649: hypothetical protein +FIG01107649 FIG01107650: hypothetical protein +FIG01107650 FIG01107658: hypothetical protein +FIG01107658 FIG01107661: hypothetical protein +FIG01107725 Sulfur carrier protein ThiS @ Opine oxidase subunit C +FIG01107751 FIG01107766: hypothetical protein +FIG01107774 FIG01107776: hypothetical protein +FIG01107781 FIG01107784: hypothetical protein +FIG01107784 FIG01107786: hypothetical protein +FIG01107789 FIG01107792: hypothetical protein +FIG01107801 FIG01107819: hypothetical protein +FIG01107819 FIG01107826: hypothetical protein +FIG01107828 FIG01107831: hypothetical protein +FIG01107831 FIG01107835: hypothetical protein +FIG01107835 FIG01107836: hypothetical protein +FIG01107836 FIG01107837: hypothetical protein +FIG01107837 FIG01107838: hypothetical protein +FIG01107838 FIG01107839: hypothetical protein +FIG01107839 FIG01107840: hypothetical protein +FIG01107840 FIG01107841: hypothetical protein +FIG01107842 FIG01107843: hypothetical protein +FIG01107843 FIG01107844: hypothetical protein +FIG01107844 FIG01107845: hypothetical protein +FIG01107846 FIG01107847: hypothetical protein +FIG01107847 FIG018171: hypothetical protein of Cupin superfamily +FIG01107848 FIG01107849: hypothetical protein +FIG01107849 FIG01107850: hypothetical protein +FIG01107850 FIG01107851: hypothetical protein +FIG01107851 FIG01107852: hypothetical protein +FIG01107852 FIG01107853: hypothetical protein +FIG01107853 FIG01107854: hypothetical protein +FIG01107854 FIG01107855: hypothetical protein +FIG01107855 FIG01107856: hypothetical protein +FIG01107856 FIG01107857: hypothetical protein +FIG01107857 FIG01107858: hypothetical protein +FIG01107858 FIG01107859: hypothetical protein +FIG01107860 FIG01107861: hypothetical protein +FIG01107861 FIG01107862: hypothetical protein +FIG01107862 FIG01107863: hypothetical protein +FIG01107863 FIG01107864: hypothetical protein +FIG01107864 Hypothetical protein, PVL orf39 homolog [SA bacteriophages 11, Mu50B] +FIG01107865 FIG01107866: hypothetical protein +FIG01107866 ORF037 +FIG01107867 FIG01107869: hypothetical protein +FIG01107869 FIG01107870: hypothetical protein +FIG01107870 FIG01107872: hypothetical protein +FIG01107872 FIG01107873: hypothetical protein +FIG01107874 FIG01107875: hypothetical protein +FIG01107875 FIG01107876: hypothetical protein +FIG01107876 FIG01107877: hypothetical protein +FIG01107877 FIG01107878: hypothetical protein +FIG01107878 FIG01107880: hypothetical protein +FIG01107880 FIG01107881: hypothetical protein +FIG01107881 FIG01107882: hypothetical protein +FIG01107882 FIG01107883: hypothetical protein +FIG01107883 FIG01107884: hypothetical protein +FIG01107884 Tandem lipoprotein within Pathogenicity island +FIG01107885 FIG01107887: hypothetical protein +FIG01107887 FIG01107888: hypothetical protein +FIG01107888 FIG01107889: hypothetical protein +FIG01107889 FIG01107890: hypothetical protein +FIG01107893 FIG01107894: hypothetical protein +FIG01107894 FIG01107895: hypothetical protein +FIG01107895 FIG01107896: hypothetical protein +FIG01107896 FIG01107899: hypothetical protein +FIG01107899 FIG01107900: hypothetical protein +FIG01107900 FIG01107901: hypothetical protein +FIG01107901 FIG01107902: hypothetical protein +FIG01107902 FIG01107905: hypothetical protein +FIG01107905 FIG01107906: hypothetical protein +FIG01107906 FIG01107907: hypothetical protein +FIG01107909 FIG01107910: hypothetical protein +FIG01107910 FIG01107911: hypothetical protein +FIG01107911 FIG01107912: hypothetical protein +FIG01107912 FIG009707: Betaine operon transcriptional regulator +FIG01107913 FIG01107914: hypothetical protein +FIG01107914 FIG01107916: hypothetical protein +FIG01107916 FIG01107917: hypothetical protein +FIG01107917 Hypothetical protein, SAB1734c homolog [SA bacteriophages 11, Mu50B] +FIG01107918 Putative Staphylococcal surface anchored protein +FIG01107919 sensor histidine kinase +FIG01107921 FIG01107922: hypothetical protein +FIG01107922 FIG01107923: hypothetical protein +FIG01107923 hypothetical protein +FIG01107924 FIG01107925: hypothetical protein +FIG01107926 FIG01107927: hypothetical protein +FIG01107927 FIG01107928: hypothetical protein +FIG01107928 FIG01107929: hypothetical protein +FIG01107930 FIG01107932: hypothetical protein +FIG01107932 FIG01107933: hypothetical protein +FIG01107933 FIG01107934: hypothetical protein +FIG01107934 FIG01107935: hypothetical protein +FIG01107935 FIG01107937: hypothetical protein +FIG01107937 FIG01107938: hypothetical protein +FIG01107939 FIG01107940: hypothetical protein +FIG01107940 FIG01107942: hypothetical protein +FIG01107942 FIG01107943: hypothetical protein +FIG01107943 FIG01107944: hypothetical protein +FIG01107945 Secreted von Willebrand factor-binding protein VWbp +FIG01107946 FIG01107947: hypothetical protein +FIG01107947 FIG01107948: hypothetical protein +FIG01107950 FIG01107951: hypothetical protein +FIG01107951 FIG01107952: hypothetical protein +FIG01107952 FIG01107953: hypothetical protein +FIG01107953 FIG01107957: hypothetical protein +FIG01107957 FIG01107958: hypothetical protein +FIG01107960 FIG01107962: hypothetical protein +FIG01107962 FIG01107965: hypothetical protein +FIG01107965 FIG01107966: hypothetical protein +FIG01107966 FIG01107967: hypothetical protein +FIG01107967 FIG01107968: hypothetical protein +FIG01107968 FIG01107969: hypothetical protein +FIG01107969 FIG01107971: hypothetical protein +FIG01107971 FIG01107972: hypothetical protein +FIG01107973 maltose/maltodextrin transport permease-like protein +FIG01107974 FIG01107975: hypothetical protein +FIG01107975 FIG01107977: hypothetical protein +FIG01107977 FIG01107978: hypothetical protein +FIG01107978 FIG01107979: hypothetical protein +FIG01107979 FIG01107980: hypothetical protein +FIG01107980 FIG01107981: hypothetical protein +FIG01107981 FIG01107983: hypothetical protein +FIG01107983 FIG01107984: hypothetical protein +FIG01107984 Uncharacterized protein Bsub YpbR +FIG01107986 FIG01107987: hypothetical protein +FIG01107987 FIG01107989: hypothetical protein +FIG01107989 FIG01107992: hypothetical protein +FIG01107992 FIG01109806: hypothetical protein +FIG01107993 FIG01107994: hypothetical protein +FIG01107994 antibacterial protein +FIG01107996 FIG01107997: hypothetical protein +FIG01107998 FIG01107999: hypothetical protein +FIG01107999 FIG01108000: hypothetical protein +FIG01108001 FIG01108005: hypothetical protein +FIG01108005 FIG01108007: hypothetical protein +FIG01108008 FIG01108009: hypothetical protein +FIG01108009 Exotoxin 8 +FIG01108013 FIG01108015: hypothetical protein +FIG01108015 FIG01108016: hypothetical protein +FIG01108018 FIG01108021: hypothetical protein +FIG01108021 FIG01108023: hypothetical protein +FIG01108023 FIG01108024: hypothetical protein +FIG01108024 FIG01108025: hypothetical protein +FIG01108025 FIG028593: membrane protein +FIG01108027 FIG01108029: hypothetical protein +FIG01108029 FIG01108030: hypothetical protein +FIG01108030 FIG01108031: hypothetical protein +FIG01108031 FIG01108032: hypothetical protein +FIG01108032 FIG01108033: hypothetical protein +FIG01108037 FIG01108038: hypothetical protein +FIG01108038 Hypothetical protein, SAV0880 homolog [SA bacteriophages 11, Mu50B] +FIG01108041 FIG01108043: hypothetical protein +FIG01108043 FIG01108044: hypothetical protein +FIG01108044 FIG01108046: hypothetical protein +FIG01108046 FIG01108047: hypothetical protein +FIG01108047 FIG01108048: hypothetical protein +FIG01108048 FIG01108049: hypothetical protein +FIG01108049 FIG01108051: hypothetical protein +FIG01108051 FIG01108052: hypothetical protein +FIG01108052 FIG01108053: hypothetical protein +FIG01108053 FIG01108056: hypothetical protein +FIG01108060 FIG01108061: hypothetical protein +FIG01108061 FIG01108062: hypothetical protein +FIG01108062 FIG01108063: hypothetical protein +FIG01108063 FIG01108064: hypothetical protein +FIG01108064 FIG01108065: hypothetical protein +FIG01108065 FIG01108067: hypothetical protein +FIG01108067 FIG01108068: hypothetical protein +FIG01108068 FIG01108069: hypothetical protein +FIG01108070 FIG01108071: hypothetical protein +FIG01108074 FIG01108076: hypothetical protein +FIG01108076 FIG01108077: hypothetical protein +FIG01108077 FIG01108078: hypothetical protein +FIG01108078 FIG01108079: hypothetical protein +FIG01108079 FIG01108081: hypothetical protein +FIG01108081 FIG01108082: hypothetical protein +FIG01108082 Hypothetical protein, phi-ETA orf58 homolog [SA bacteriophages 11, Mu50B] +FIG01108083 FIG01108084: hypothetical protein +FIG01108084 FIG01108085: hypothetical protein +FIG01108086 FIG01108087: hypothetical protein +FIG01108087 conjugal transfer protein transposon-related +FIG01108088 FIG01108089: hypothetical protein +FIG01108089 FIG01108090: hypothetical protein +FIG01108090 FIG01108091: hypothetical protein +FIG01108091 FIG01108092: hypothetical protein +FIG01108092 FIG01108093: hypothetical protein +FIG01108093 FIG01108094: hypothetical protein +FIG01108095 FIG01108097: hypothetical protein +FIG01108097 FIG01108099: hypothetical protein +FIG01108099 FIG01108100: hypothetical protein +FIG01108100 FIG01108101: hypothetical protein +FIG01108101 FIG01108103: hypothetical protein +FIG01108103 FIG01108104: hypothetical protein +FIG01108104 FIG01108105: hypothetical protein +FIG01108105 FIG01108106: hypothetical protein +FIG01108106 FIG01108108: hypothetical protein +FIG01108108 FIG01108109: hypothetical protein +FIG01108110 FIG016210: probable monooxygenase +FIG01108112 FIG01108113: hypothetical protein +FIG01108113 FIG01108114: hypothetical protein +FIG01108114 ORF101 +FIG01108116 FIG01108117: hypothetical protein +FIG01108117 FIG01108118: hypothetical protein +FIG01108118 FIG01108120: hypothetical protein +FIG01108120 FIG01108121: hypothetical protein +FIG01108121 FIG01108122: hypothetical protein +FIG01108122 FIG01108123: hypothetical protein +FIG01108123 FIG01108124: hypothetical protein +FIG01108124 FIG01108125: hypothetical protein +FIG01108125 FIG01108126: hypothetical protein +FIG01108128 FIG01108129: hypothetical protein +FIG01108129 FIG01108130: hypothetical protein +FIG01108130 FIG01108132: hypothetical protein +FIG01108132 FIG01108133: hypothetical protein +FIG01108133 FIG01108134: hypothetical protein +FIG01108134 Fe3+ ABC transporter substrate-binding protein +FIG01108135 FIG01108136: hypothetical protein +FIG01108136 FIG01108137: hypothetical protein +FIG01108137 FIG01108138: hypothetical protein +FIG01108138 FIG01226173: hypothetical protein +FIG01108140 FIG01108141: hypothetical protein +FIG01108141 Conjugative transfer protein PilR in PFGI-1-like cluster +FIG01108142 FIG01108144: hypothetical protein +FIG01108144 FIG01108145: hypothetical protein +FIG01108145 FIG01108146: hypothetical protein +FIG01108146 FIG01108147: hypothetical protein +FIG01108147 FIG01108148: hypothetical protein +FIG01108148 FIG01108149: hypothetical protein +FIG01108150 FIG01108151: hypothetical protein +FIG01108151 FIG01108153: hypothetical protein +FIG01108154 FIG01108155: hypothetical protein +FIG01108155 FIG01108156: hypothetical protein +FIG01108156 FIG01108157: hypothetical protein +FIG01108157 FIG01108158: hypothetical protein +FIG01108158 FIG01108159: hypothetical protein +FIG01108159 FIG01108160: hypothetical protein +FIG01108160 FIG01108161: hypothetical protein +FIG01108161 FIG01108162: hypothetical protein +FIG01108162 FIG01108163: hypothetical protein +FIG01108163 FIG01108164: hypothetical protein +FIG01108164 FIG01108165: hypothetical protein +FIG01108165 FIG01108166: hypothetical protein +FIG01108166 FIG01108167: hypothetical protein +FIG01108168 FIG01108169: hypothetical protein +FIG01108169 FIG01108170: hypothetical protein +FIG01108170 FIG01108172: hypothetical protein +FIG01108172 FIG01108173: hypothetical protein +FIG01108174 phi 11 orf43 homolog [SA bacteriophages 11, Mu50B] +FIG01108175 FIG01108176: hypothetical protein +FIG01108180 hypothetical protein +FIG01108181 FIG01108182: hypothetical protein +FIG01108182 FIG01108183: hypothetical protein +FIG01108183 FIG01108185: hypothetical protein +FIG01108185 FIG01108186: hypothetical protein +FIG01108186 FIG01108187: hypothetical protein +FIG01108187 FIG01108188: hypothetical protein +FIG01108189 Accessory gene regulator D (pheromone precursor, type III) +FIG01108190 FIG01108191: hypothetical protein +FIG01108192 FIG01108193: hypothetical protein +FIG01108194 FIG01108195: hypothetical protein +FIG01108196 FIG01108197: hypothetical protein +FIG01108197 FIG01108198: hypothetical protein +FIG01108198 FIG01108199: hypothetical protein +FIG01108199 FIG01108200: hypothetical protein +FIG01108200 FIG01108201: hypothetical protein +FIG01108201 FIG01108202: hypothetical protein +FIG01108202 FIG01108203: hypothetical protein +FIG01108204 Hypothetical protein, PV83 orf23 homolog [SA bacteriophages 11, Mu50B] +FIG01108205 FIG01108206: hypothetical protein +FIG01108207 FIG01108208: hypothetical protein +FIG01108208 FIG01108209: hypothetical protein +FIG01108209 FIG01108210: hypothetical protein +FIG01108210 FIG01108212: hypothetical protein +FIG01108212 FIG01108213: hypothetical protein +FIG01108213 FIG01108215: hypothetical protein +FIG01108215 FIG01108216: hypothetical protein +FIG01108216 FIG01108217: hypothetical protein +FIG01108217 FIG01108218: hypothetical protein +FIG01108218 FIG01108219: hypothetical protein +FIG01108219 FIG01108220: hypothetical protein +FIG01108220 FIG01108221: hypothetical protein +FIG01108221 FIG01108223: hypothetical protein +FIG01108223 FIG01108224: hypothetical protein +FIG01108224 ORFID:MW1725 +FIG01108225 FIG01108228: hypothetical protein +FIG01108228 FIG01108230: hypothetical protein +FIG01108230 FIG01108232: hypothetical protein +FIG01108232 FIG01108234: hypothetical protein +FIG01108234 FIG01108235: hypothetical protein +FIG01108235 FIG01108236: hypothetical protein +FIG01108236 FIG01108237: hypothetical protein +FIG01108237 FIG01108238: hypothetical protein +FIG01108239 FIG01108241: hypothetical protein +FIG01108241 FIG01108243: hypothetical protein +FIG01108243 FIG01108245: hypothetical protein +FIG01108245 FIG01108246: hypothetical protein +FIG01108247 FIG01108249: hypothetical protein +FIG01108249 FIG01108250: hypothetical protein +FIG01108254 FIG01108255: hypothetical protein +FIG01108256 FIG01108257: hypothetical protein +FIG01108258 hypothetical protein +FIG01108259 FIG01108261: hypothetical protein +FIG01108261 FIG01108262: hypothetical protein +FIG01108262 FIG01108263: hypothetical protein +FIG01108263 FIG01108264: hypothetical protein +FIG01108264 FIG01108265: hypothetical protein +FIG01108266 FIG01108267: hypothetical protein +FIG01108267 FIG01108269: hypothetical protein +FIG01108269 FIG01108271: hypothetical protein +FIG01108271 FIG01108272: hypothetical protein +FIG01108273 FIG01108274: hypothetical protein +FIG01108274 FIG01108275: hypothetical protein +FIG01108275 FIG01108277: hypothetical protein +FIG01108277 FIG01108278: hypothetical protein +FIG01108278 FIG01108279: hypothetical protein +FIG01108279 FIG01108280: hypothetical protein +FIG01108280 FIG01108281: hypothetical protein +FIG01108281 FIG01108282: hypothetical protein +FIG01108282 UPF0154 membrane protein YoxG +FIG01108286 FIG01108287: hypothetical protein +FIG01108287 FIG01108288: hypothetical protein +FIG01108288 FIG01108289: hypothetical protein +FIG01108290 FIG01108291: hypothetical protein +FIG01108291 FIG01108292: hypothetical protein +FIG01108292 FIG01108295: hypothetical protein +FIG01108295 FIG01108299: hypothetical protein +FIG01108299 FIG01108300: hypothetical protein +FIG01108300 FIG01108301: hypothetical protein +FIG01108301 FIG01228566: hypothetical protein +FIG01108302 FIG01108303: hypothetical protein +FIG01108303 FIG01108305: hypothetical protein +FIG01108305 FIG01108306: hypothetical protein +FIG01108306 FIG01108307: hypothetical protein +FIG01108307 hypothetical protein +FIG01108308 FIG01108309: hypothetical protein +FIG01108309 FIG01108312: hypothetical protein +FIG01108312 Transcriptional activator rinB, phage associated +FIG01108313 FIG01108314: hypothetical protein +FIG01108314 FIG01108315: hypothetical protein +FIG01108315 FIG01108316: hypothetical protein +FIG01108316 FIG01108317: hypothetical protein +FIG01108317 FIG01108320: hypothetical protein +FIG01108321 FIG01108322: hypothetical protein +FIG01108322 FIG01108324: hypothetical protein +FIG01108326 FIG01108328: hypothetical protein +FIG01108328 FIG01108329: hypothetical protein +FIG01108329 HNH homing endonuclease +FIG01108331 FIG01108332: hypothetical protein +FIG01108332 FIG01108333: hypothetical protein +FIG01108333 FIG01108334: hypothetical protein +FIG01108334 FIG01108335: hypothetical protein +FIG01108335 FIG01108336: hypothetical protein +FIG01108336 hypothetical protein +FIG01108337 FIG01108338: hypothetical protein +FIG01108338 FIG01108339: hypothetical protein +FIG01108339 FIG01108340: hypothetical protein +FIG01108340 FIG01108341: hypothetical protein +FIG01108341 FIG01108342: hypothetical protein +FIG01108343 FIG01108344: hypothetical protein +FIG01108345 FIG01108346: hypothetical protein +FIG01108346 FIG01108348: hypothetical protein +FIG01108348 FIG01108349: hypothetical protein +FIG01108349 FIG01108350: hypothetical protein +FIG01108350 FIG01108351: hypothetical protein +FIG01108351 hypothetical protein within prophage +FIG01108352 FIG01108353: hypothetical protein +FIG01108353 FIG081523: hypothetical protein within a prophage +FIG01108357 FIG01108359: hypothetical protein +FIG01108359 FIG01108361: hypothetical protein +FIG01108361 Hypothetical protein, phi-ETA orf17 homolog [SA bacteriophages 11, Mu50B] +FIG01108364 FIG01108365: hypothetical protein +FIG01108365 FIG01108366: hypothetical protein +FIG01108366 FIG01108367: hypothetical protein +FIG01108367 FIG01108368: hypothetical protein +FIG01108368 FIG01108370: hypothetical protein +FIG01108370 FIG01108371: hypothetical protein +FIG01108371 FIG01108372: hypothetical protein +FIG01108372 FIG01108373: hypothetical protein +FIG01108373 FIG01108375: hypothetical protein +FIG01108375 FIG01108377: hypothetical protein +FIG01108377 FIG01108379: hypothetical protein +FIG01108379 FIG01108380: hypothetical protein +FIG01108381 FIG01108382: hypothetical protein +FIG01108383 Hypothetical protein, SAV0860 homolog [SA bacteriophages 11, Mu50B] +FIG01108385 FIG01108386: hypothetical protein +FIG01108386 Transcriptional activator rinB, phage associated +FIG01108388 FIG01108389: hypothetical protein +FIG01108394 FIG01108395: hypothetical protein +FIG01108395 FIG01108396: hypothetical protein +FIG01108396 FIG01108398: hypothetical protein +FIG01108398 FIG01108399: hypothetical protein +FIG01108399 DNA primase, phage associated +FIG01108401 FIG01108403: hypothetical protein +FIG01108403 Bacteriophage +FIG01108404 FIG01108405: hypothetical protein +FIG01108405 FIG01108406: hypothetical protein +FIG01108406 FIG01108407: hypothetical protein +FIG01108407 FIG01108408: hypothetical protein +FIG01108408 ORF058 +FIG01108410 FIG01108412: hypothetical protein +FIG01108412 FIG01108414: hypothetical protein +FIG01108415 FIG01108416: hypothetical protein +FIG01108416 FIG01108417: hypothetical protein +FIG01108417 FIG01108418: hypothetical protein +FIG01108418 FIG01108419: hypothetical protein +FIG01108424 FIG01108426: hypothetical protein +FIG01108426 FIG01108427: hypothetical protein +FIG01108431 FIG01108433: hypothetical protein +FIG01108433 FIG01108434: hypothetical protein +FIG01108434 FIG01108436: hypothetical protein +FIG01108439 FIG01108442: hypothetical protein +FIG01108442 FIG01108443: hypothetical protein +FIG01108445 FIG01108446: hypothetical protein +FIG01108446 FIG01108447: hypothetical protein +FIG01108447 FIG01108448: hypothetical protein +FIG01108448 FIG01108449: hypothetical protein +FIG01108449 FIG01108451: hypothetical protein +FIG01108451 FIG01108452: hypothetical protein +FIG01108452 FIG01108453: hypothetical protein +FIG01108453 FIG01108454: hypothetical protein +FIG01108454 FIG01108455: hypothetical protein +FIG01108455 FIG01108459: hypothetical protein +FIG01108459 FIG01108460: hypothetical protein +FIG01108460 enterotoxin +FIG01108463 Deoxyuridine 5'-triphosphate nucleotidohydrolase (EC 3.6.1.23) [SA bacteriophages 11, Mu50B] +FIG01108465 FIG01108466: hypothetical protein +FIG01108466 FIG01108467: hypothetical protein +FIG01108469 FIG01108470: hypothetical protein +FIG01108470 FIG01108472: hypothetical protein +FIG01108472 FIG01108474: hypothetical protein +FIG01108474 FIG01108475: hypothetical protein +FIG01108475 FIG01108477: hypothetical protein +FIG01108477 FIG01108478: hypothetical protein +FIG01108478 FIG01108480: hypothetical protein +FIG01108480 FIG01108481: hypothetical protein +FIG01108481 FIG01108482: hypothetical protein +FIG01108482 FIG01109027: hypothetical protein +FIG01108487 FIG01108489: hypothetical protein +FIG01108491 hypothetical protein +FIG01108494 FIG01108497: hypothetical protein +FIG01108497 FIG01108503: hypothetical protein +FIG01108503 FIG01108504: hypothetical protein +FIG01108504 FIG01108505: hypothetical protein +FIG01108507 FIG01108508: hypothetical protein +FIG01108508 FIG01108510: hypothetical protein +FIG01108510 FIG01108512: hypothetical protein +FIG01108512 FIG01108514: hypothetical protein +FIG01108514 FIG01108516: hypothetical protein +FIG01108516 FIG01108517: hypothetical protein +FIG01108517 FIG01108519: hypothetical protein +FIG01108519 FIG01108520: hypothetical protein +FIG01108520 FIG01108521: hypothetical protein +FIG01108521 FIG01108523: hypothetical protein +FIG01108523 FIG01108524: hypothetical protein +FIG01108524 FIG01108527: hypothetical protein +FIG01108527 FIG01108529: hypothetical protein +FIG01108530 FIG01108532: hypothetical protein +FIG01108532 FIG01108533: hypothetical protein +FIG01108533 FIG01108534: hypothetical protein +FIG01108534 FIG01108536: hypothetical protein +FIG01108536 FIG01108537: hypothetical protein +FIG01108537 Modification methylase Rho11sI (EC 2.1.1.37) +FIG01108538 FIG01108542: hypothetical protein +FIG01108542 FIG01108543: hypothetical protein +FIG01108543 FIG01108548: hypothetical protein +FIG01108549 FIG01108553: hypothetical protein +FIG01108553 FIG01108555: hypothetical protein +FIG01108555 FIG01108556: hypothetical protein +FIG01108556 FIG01108557: hypothetical protein +FIG01108561 FIG01108562: hypothetical protein +FIG01108563 FIG01108564: hypothetical protein +FIG01108564 FIG01108566: hypothetical protein +FIG01108566 FIG01108567: hypothetical protein +FIG01108567 FIG01108568: hypothetical protein +FIG01108568 FIG01110849: hypothetical protein +FIG01108569 FIG01108570: hypothetical protein +FIG01108570 FIG01108571: hypothetical protein +FIG01108575 FIG01108578: hypothetical protein +FIG01108579 FIG01108580: hypothetical protein +FIG01108580 FIG01108582: hypothetical protein +FIG01108582 FIG01108584: hypothetical protein +FIG01108584 FIG01108585: hypothetical protein +FIG01108585 FIG01108586: hypothetical protein +FIG01108586 SA0191/BacG-like protein +FIG01108590 FIG01108591: hypothetical protein +FIG01108591 FIG01108593: hypothetical protein +FIG01108593 FIG01108595: hypothetical protein +FIG01108595 FIG01108598: hypothetical protein +FIG01108598 FIG01108599: hypothetical protein +FIG01108600 FIG01108601: hypothetical protein +FIG01108601 FIG01108603: hypothetical protein +FIG01108603 FIG01108604: hypothetical protein +FIG01108604 FIG01108606: hypothetical protein +FIG01108608 FIG01108609: hypothetical protein +FIG01108609 FIG01108613: hypothetical protein +FIG01108614 FIG01108616: hypothetical protein +FIG01108618 FIG01108619: hypothetical protein +FIG01108619 FIG01108620: hypothetical protein +FIG01108622 FIG01108623: hypothetical protein +FIG01108623 FIG01108624: hypothetical protein +FIG01108624 FIG01108625: hypothetical protein +FIG01108625 FIG01108627: hypothetical protein +FIG01108627 FIG01108628: hypothetical protein +FIG01108628 FIG01108629: hypothetical protein +FIG01108629 FIG01108630: hypothetical protein +FIG01108630 FIG01108632: hypothetical protein +FIG01108633 FIG01108634: hypothetical protein +FIG01108634 FIG01108637: hypothetical protein +FIG01108641 FIG01108642: hypothetical protein +FIG01108642 FIG01108643: hypothetical protein +FIG01108643 FIG01108644: hypothetical protein +FIG01108648 FIG01108649: hypothetical protein +FIG01108649 FIG01108651: hypothetical protein +FIG01108651 FIG01108652: hypothetical protein +FIG01108652 FIG01108654: hypothetical protein +FIG01108654 FIG01108656: hypothetical protein +FIG01108657 FIG01108658: hypothetical protein +FIG01108658 FIG01108661: hypothetical protein +FIG01108661 FIG01108663: hypothetical protein +FIG01108666 FIG01108667: hypothetical protein +FIG01108669 FIG01108670: hypothetical protein +FIG01108671 Pathogenicity island SaPIn1 +FIG01108672 ORF022 +FIG01108674 FIG01108678: hypothetical protein +FIG01108678 FIG01108681: hypothetical protein +FIG01108681 FIG01108682: hypothetical protein +FIG01108688 FIG01108691: hypothetical protein +FIG01108691 FIG01108692: hypothetical protein +FIG01108694 FIG01108695: hypothetical protein +FIG01108695 FIG01108697: hypothetical protein +FIG01108699 FIG01108701: hypothetical protein +FIG01108705 FIG01108706: hypothetical protein +FIG01108706 FIG01108708: hypothetical protein +FIG01108710 FIG01108714: hypothetical protein +FIG01108723 FIG01108726: hypothetical protein +FIG01108726 FIG01108728: hypothetical protein +FIG01108728 FIG01108730: hypothetical protein +FIG01108731 FIG01108732: hypothetical protein +FIG01108732 FIG01108733: hypothetical protein +FIG01108733 FIG01108734: hypothetical protein +FIG01108734 FIG01108736: hypothetical protein +FIG01108739 FIG01108740: hypothetical protein +FIG01108740 FIG01108742: hypothetical protein +FIG01108742 ORF136 +FIG01108745 FIG01108746: hypothetical protein +FIG01108746 FIG01108747: hypothetical protein +FIG01108748 FIG01108751: hypothetical protein +FIG01108751 FIG01108752: hypothetical protein +FIG01108753 FIG01108754: hypothetical protein +FIG01108754 FIG01108761: hypothetical protein +FIG01108764 FIG01108766: hypothetical protein +FIG01108766 FIG01108768: hypothetical protein +FIG01108768 FIG01108769: hypothetical protein +FIG01108769 FIG01108771: hypothetical protein +FIG01108771 FIG01108772: hypothetical protein +FIG01108773 ORF024 +FIG01108777 FIG01108778: hypothetical protein +FIG01108780 FIG01108781: hypothetical protein +FIG01108781 hypothetical protein +FIG01108784 FIG01108785: hypothetical protein +FIG01108785 FIG01108786: hypothetical protein +FIG01108786 FIG01108787: hypothetical protein +FIG01108788 FIG01108790: hypothetical protein +FIG01108794 FmtB (Mrp) protein involved in methicillin resistance and cell wall biosynthesis +FIG01108799 FIG01108800: hypothetical protein +FIG01108800 FIG01108802: hypothetical protein +FIG01108802 FIG01108803: hypothetical protein +FIG01108803 hypothetical fig|282458.1.peg.583 homolog +FIG01108813 FIG01108818: hypothetical protein +FIG01108818 hypothetical protein +FIG01108820 FIG01108824: hypothetical protein +FIG01108824 FIG01108826: hypothetical protein +FIG01108826 hypothetical protein +FIG01108831 FIG01108833: hypothetical protein +FIG01108836 FIG01108840: hypothetical protein +FIG01108840 FIG01108841: hypothetical protein +FIG01108841 FIG01108842: hypothetical protein +FIG01108843 recombinase Sin +FIG01108846 FIG01108847: hypothetical protein +FIG01108852 FIG01108853: hypothetical protein +FIG01108855 Capsular polysaccharide synthesis enzyme Cap5M +FIG01108858 FIG01108860: hypothetical protein +FIG01108861 FIG01108862: hypothetical protein +FIG01108863 FIG01108866: hypothetical protein +FIG01108866 FIG01108867: hypothetical protein +FIG01108867 FIG01108868: hypothetical protein +FIG01108868 FIG01108872: hypothetical protein +FIG01108874 FIG01108876: hypothetical protein +FIG01108876 FIG01108878: hypothetical protein +FIG01108881 Pathogenesis-related transcriptional factor and ERF +FIG01108883 FIG01108884: hypothetical protein +FIG01108884 FIG01108886: hypothetical protein +FIG01108886 ORF065 +FIG01108888 FIG01108889: hypothetical protein +FIG01108890 ORF027 +FIG01108893 FIG01108895: hypothetical protein +FIG01108895 FIG01108898: hypothetical protein +FIG01108898 FIG01108899: hypothetical protein +FIG01108899 FIG01108905: hypothetical protein +FIG01108907 FIG01108908: hypothetical protein +FIG01108908 FIG01108912: hypothetical protein +FIG01108912 FIG01108913: hypothetical protein +FIG01108913 FIG01108918: hypothetical protein +FIG01108920 FIG01108921: hypothetical protein +FIG01108921 FIG01108926: hypothetical protein +FIG01108935 FIG01108936: hypothetical protein +FIG01108936 FIG01108938: hypothetical protein +FIG01108938 FIG01108940: hypothetical protein +FIG01108941 FIG01108946: hypothetical protein +FIG01108946 ORF021 +FIG01108950 FIG01108952: hypothetical protein +FIG01108957 ORF077 +FIG01108959 FIG01108962: hypothetical protein +FIG01108962 FIG01108963: hypothetical protein +FIG01108967 FIG01108968: hypothetical protein +FIG01108970 FIG01108973: hypothetical protein +FIG01108973 FIG01108976: hypothetical protein +FIG01108976 FIG01108977: hypothetical protein +FIG01108977 immunodominant antigen B +FIG01108984 FIG01108985: hypothetical protein +FIG01108985 hypothetical protein +FIG01108986 FIG01108988: hypothetical protein +FIG01108988 FIG01108990: hypothetical protein +FIG01108993 FIG01108994: hypothetical protein +FIG01108996 transcriptional regulator, LysR family +FIG01109000 FIG01109001: hypothetical protein +FIG01109003 FIG01109004: hypothetical protein +FIG01109008 FIG01109011: hypothetical protein +FIG01109014 FIG01109017: hypothetical protein +FIG01109017 hyaluronate lyase precursor +FIG01109019 hypothetical protein +FIG01109033 Hypothetical SAV2026 homolog in superantigen-encoding pathogenicity islands SaPI +FIG01109035 FIG01109036: hypothetical protein +FIG01109036 FIG01109037: hypothetical protein +FIG01109037 hypothetical protein +FIG01109040 FIG01109042: hypothetical protein +FIG01109045 FIG01109046: hypothetical protein +FIG01109053 FIG01109056: hypothetical protein +FIG01109057 secretory antigen SsaA +FIG01109060 FIG01109061: hypothetical protein +FIG01109062 FIG01109063: hypothetical protein +FIG01109063 FIG01109064: hypothetical protein +FIG01109064 FIG01109065: hypothetical protein +FIG01109071 FIG01109073: hypothetical protein +FIG01109073 FIG01109074: hypothetical protein +FIG01109075 FIG01109077: hypothetical protein +FIG01109078 FIG01109079: hypothetical protein +FIG01109079 FIG01109082: hypothetical protein +FIG01109082 FIG01109083: hypothetical protein +FIG01109083 FIG01109085: hypothetical protein +FIG01109085 FIG01109088: hypothetical protein +FIG01109088 FIG01109096: hypothetical protein +FIG01109098 FIG01109099: hypothetical protein +FIG01109099 FIG01109102: hypothetical protein +FIG01109102 FIG01109103: hypothetical protein +FIG01109103 FIG01109104: hypothetical protein +FIG01109114 FIG01109118: hypothetical protein +FIG01109122 FIG01109124: hypothetical protein +FIG01109124 FIG01109125: hypothetical protein +FIG01109125 FIG01109127: hypothetical protein +FIG01109127 FIG01109129: hypothetical protein +FIG01109138 FIG01109143: hypothetical protein +FIG01109143 FIG01109144: hypothetical protein +FIG01109145 FIG01109147: hypothetical protein +FIG01109147 FIG01109157: hypothetical protein +FIG01109157 hypothetical protein +FIG01109161 FIG01109165: hypothetical protein +FIG01109168 FIG01109173: hypothetical protein +FIG01109177 ORF007 +FIG01109179 FIG01109184: hypothetical protein +FIG01109188 FIG01109191: hypothetical protein +FIG01109193 FIG01109196: hypothetical protein +FIG01109197 FIG01109198: hypothetical protein +FIG01109199 DNA helicase-like protein, putative +FIG01109206 FIG01109210: hypothetical protein +FIG01109210 Probable amino-acid ABC transporter permease protein yxeN +FIG01109211 FIG01109212: hypothetical protein +FIG01109212 FIG01109215: hypothetical protein +FIG01109218 FIG01109227: hypothetical protein +FIG01109227 FIG01109228: hypothetical protein +FIG01109234 FIG01109236: hypothetical protein +FIG01109253 FIG01109254: hypothetical protein +FIG01109263 FIG01109266: hypothetical protein +FIG01109267 Abi-alpha protein +FIG01109268 FIG01109272: hypothetical protein +FIG01109272 FIG01109273: hypothetical protein +FIG01109273 ERF superfamily family +FIG01109275 hypothetical protein +FIG01109277 FIG01109281: hypothetical protein +FIG01109284 FIG01109285: hypothetical protein +FIG01109285 FIG01109286: hypothetical protein +FIG01109286 FIG01109287: hypothetical protein +FIG01109289 FIG01109290: hypothetical protein +FIG01109290 FIG01109292: hypothetical protein +FIG01109292 FIG01109296: hypothetical protein +FIG01109299 FIG01109301: hypothetical protein +FIG01109301 FIG01109302: hypothetical protein +FIG01109306 FIG01109310: hypothetical protein +FIG01109310 FIG01109311: hypothetical protein +FIG01109311 FIG01109314: hypothetical protein +FIG01109314 FIG01109315: hypothetical protein +FIG01109325 FIG01109327: hypothetical protein +FIG01109327 FIG01109328: hypothetical protein +FIG01109337 ABC transporter amino acid permease protein +FIG01109340 FIG01109342: hypothetical protein +FIG01109342 FIG01109343: hypothetical protein +FIG01109345 FIG01109349: hypothetical protein +FIG01109349 FIG01109350: hypothetical protein +FIG01109355 FIG01109356: hypothetical protein +FIG01109356 FIG01109360: hypothetical protein +FIG01109360 FIG01109361: hypothetical protein +FIG01109361 FIG01109362: hypothetical protein +FIG01109364 FIG01109368: hypothetical protein +FIG01109371 FIG01109373: hypothetical protein +FIG01109382 FIG01109383: hypothetical protein +FIG01109385 FIG01109387: hypothetical protein +FIG01109390 FIG01109393: hypothetical protein +FIG01109393 FIG01109400: hypothetical protein +FIG01109400 FIG01109401: hypothetical protein +FIG01109401 FIG01109402: hypothetical protein +FIG01109402 FIG01109405: hypothetical protein +FIG01109405 FIG01109406: hypothetical protein +FIG01109412 phosphohydrolase, Icc family +FIG01109413 FIG01109414: hypothetical protein +FIG01109414 FIG01109420: hypothetical protein +FIG01109420 FIG01109421: hypothetical protein +FIG01109421 FIG01109422: hypothetical protein +FIG01109422 FIG01109426: hypothetical protein +FIG01109426 FIG01109428: hypothetical protein +FIG01109428 FIG01109431: hypothetical protein +FIG01109439 FIG01109440: hypothetical protein +FIG01109442 FIG01109445: hypothetical protein +FIG01109445 FIG01109448: hypothetical protein +FIG01109448 FIG01109449: hypothetical protein +FIG01109461 FIG01109464: hypothetical protein +FIG01109465 FIG01109470: hypothetical protein +FIG01109470 FIG01109471: hypothetical protein +FIG01109471 FIG01109472: hypothetical protein +FIG01109472 FIG01109473: hypothetical protein +FIG01109473 FIG01109476: hypothetical protein +FIG01109478 FIG01109481: hypothetical protein +FIG01109487 FIG01109494: hypothetical protein +FIG01109497 FIG01109498: hypothetical protein +FIG01109503 FIG01109505: hypothetical protein +FIG01109505 FIG01109509: hypothetical protein +FIG01109512 FIG01109517: hypothetical protein +FIG01109528 FIG01109529: hypothetical protein +FIG01109537 FIG01109538: hypothetical protein +FIG01109552 Hypothetical protein, phi-ETA orf63 homolog [SA bacteriophages 11, Mu50B] +FIG01109555 FIG01109558: hypothetical protein +FIG01109562 FIG01109564: hypothetical protein +FIG01109564 FIG01109565: hypothetical protein +FIG01109565 FIG01109566: hypothetical protein +FIG01109566 FIG01109567: hypothetical protein +FIG01109568 FIG01109573: hypothetical protein +FIG01109578 FIG01109581: hypothetical protein +FIG01109586 putative ABC-type polar amino acid transport system ATPase component +FIG01109590 hypothetical protein +FIG01109592 FIG01109594: hypothetical protein +FIG01109594 Integral membrane protein LmrP +FIG01109609 Antirestriction protein +FIG01109624 FIG01109629: hypothetical protein +FIG01109629 FIG01109632: hypothetical protein +FIG01109632 FIG01109633: hypothetical protein +FIG01109633 FIG01109635: hypothetical protein +FIG01109635 Serine protease mycosin MycP1, component of Type VII secretion system ESX-1 +FIG01109636 FIG01109643: hypothetical protein +FIG01109643 FIG01109646: hypothetical protein +FIG01109646 FIG01109649: hypothetical protein +FIG01109649 FIG01109651: hypothetical protein +FIG01109651 FIG01109654: hypothetical protein +FIG01109654 FIG01109657: hypothetical protein +FIG01109657 ORF048 +FIG01109676 FIG01109680: hypothetical protein +FIG01109680 FIG01109681: hypothetical protein +FIG01109681 FIG01109683: hypothetical protein +FIG01109683 FIG01109685: hypothetical protein +FIG01109685 FIG01109686: hypothetical protein +FIG01109686 FIG01109687: hypothetical protein +FIG01109687 FIG01109699: hypothetical protein +FIG01109700 hypothetical protein +FIG01109720 FIG01109724: hypothetical protein +FIG01109749 FIG01109752: hypothetical protein +FIG01109752 cylM protein +FIG01109757 hypothetical protein +FIG01109758 FIG01109760: hypothetical protein +FIG01109760 FIG01109761: hypothetical protein +FIG01109764 phiSLT ORF78-like protein +FIG01109766 FIG01109777: hypothetical protein +FIG01109777 FIG01109780: hypothetical protein +FIG01109781 FIG01109785: hypothetical protein +FIG01109785 hypothetical protein +FIG01109787 [Genomic island nu Sa beta2] +FIG01109788 FIG01109795: hypothetical protein +FIG01109795 Haloacid dehalogenase-like hydrolase +FIG01109796 FIG01109805: hypothetical protein +FIG01109812 hypothetical protein +FIG01109821 putative membrane protein TraC +FIG01109834 hypothetical protein +FIG01109847 putative extracellular amidase +FIG01109858 FIG01109863: hypothetical protein +FIG01109863 FIG01109870: hypothetical protein +FIG01109870 FIG01109874: hypothetical protein +FIG01109882 HTH-type transcriptional regulator pksA +FIG01109888 FIG01109892: hypothetical protein +FIG01109900 FIG01109911: hypothetical protein +FIG01109934 FIG01109936: hypothetical protein +FIG01109936 FIG01109938: hypothetical protein +FIG01109938 FIG01109957: hypothetical protein +FIG01109958 FIG01109962: hypothetical protein +FIG01109972 FIG01109973: hypothetical protein +FIG01109973 FIG01109975: hypothetical protein +FIG01109975 ORF079 +FIG01109982 FIG01109984: hypothetical protein +FIG01109984 FIG01109986: hypothetical protein +FIG01109986 FIG01109989: hypothetical protein +FIG01109993 FIG01109999: hypothetical protein +FIG01109999 FIG01110005: hypothetical protein +FIG01110005 FIG01110006: hypothetical protein +FIG01110006 FIG01110008: hypothetical protein +FIG01110014 FIG01110018: hypothetical protein +FIG01110020 FIG01110022: hypothetical protein +FIG01110022 FIG01110033: hypothetical protein +FIG01110033 FIG01110037: hypothetical protein +FIG01110038 FIG01110040: hypothetical protein +FIG01110071 FIG01110076: hypothetical protein +FIG01110095 FIG01110103: hypothetical protein +FIG01110103 protein TrsK +FIG01110105 FIG01110106: hypothetical protein +FIG01110111 FIG01110112: hypothetical protein +FIG01110112 integral membrane protein LmrP +FIG01110117 FIG01110123: hypothetical protein +FIG01110123 FIG01110124: hypothetical protein +FIG01110124 FIG01110126: hypothetical protein +FIG01110126 FIG01110127: hypothetical protein +FIG01110133 FIG01110136: hypothetical protein +FIG01110136 FIG01110139: hypothetical protein +FIG01110140 hypothetical protein +FIG01110152 FIG01110153: hypothetical protein +FIG01110165 Transfer complex protein TraA +FIG01110171 FIG01110177: hypothetical protein +FIG01110180 FIG01110181: hypothetical protein +FIG01110183 FIG01110184: hypothetical protein +FIG01110186 FIG01110192: hypothetical protein +FIG01110193 FIG01110195: hypothetical protein +FIG01110204 ribokinase, putative +FIG01110208 FIG01110209: hypothetical protein +FIG01110222 FIG01110224: hypothetical protein +FIG01110236 FIG01110237: hypothetical protein +FIG01110237 FIG01110239: hypothetical protein +FIG01110245 FIG01110247: hypothetical protein +FIG01110254 ORF029 +FIG01110265 FIG01110270: hypothetical protein +FIG01110273 FIG01110275: hypothetical protein +FIG01110275 phiPVL ORF050-like protein +FIG01110296 FIG01110297: hypothetical protein +FIG01110299 FIG01110300: hypothetical protein +FIG01110300 FIG01110303: hypothetical protein +FIG01110304 FIG01110306: hypothetical protein +FIG01110315 FIG01110316: hypothetical protein +FIG01110316 FIG01110323: hypothetical protein +FIG01110324 type I restriction-modification system endonuclease +FIG01110338 FIG01110342: hypothetical protein +FIG01110342 FIG01110345: hypothetical protein +FIG01110349 FIG01110353: hypothetical protein +FIG01110353 FIG01110357: hypothetical protein +FIG01110360 FIG01110361: hypothetical protein +FIG01110366 hypothetical protein +FIG01110377 FIG01110388: hypothetical protein +FIG01110399 FIG01110404: hypothetical protein +FIG01110428 FIG01110429: hypothetical protein +FIG01110469 FIG01110470: hypothetical protein +FIG01110488 hypothetical protein +FIG01110496 FIG01110498: hypothetical protein +FIG01110531 FIG01110541: hypothetical protein +FIG01110555 FIG01110556: hypothetical protein +FIG01110556 putative ABC-type amino acid transport system periplasmic component +FIG01110558 glycosyltransferase, group 1 family protein +FIG01110569 FIG01110571: hypothetical protein +FIG01110582 FIG01110586: hypothetical protein +FIG01110586 FIG01110589: hypothetical protein +FIG01110613 FIG01110615: hypothetical protein +FIG01110615 FIG01110621: hypothetical protein +FIG01110640 ABC transporter, ATP-binding protein( EC:3.6.3.25 ) +FIG01110648 Secreted von Willebrand factor-binding protein VWbp +FIG01110656 FIG01110657: hypothetical protein +FIG01110733 FIG01110734: hypothetical protein +FIG01110734 FIG01110750: hypothetical protein +FIG01110751 Secretory antigen precursor SsaA +FIG01110764 FIG01110768: hypothetical protein +FIG01110768 FIG01110773: hypothetical protein +FIG01110796 Similarity +FIG01110798 hypothetical protein +FIG01110817 Hypothetical protein, phi-ETA orf33 homolog [SA bacteriophages 11, Mu50B] +FIG01110849 FIG01110852: hypothetical protein +FIG01110859 FIG01110863: hypothetical protein +FIG01110887 FIG01110888: hypothetical protein +FIG01110921 Antiseptic resistance protein QacA +FIG01110930 FIG01110938: hypothetical protein +FIG01110938 FIG01110940: hypothetical protein +FIG01110940 FIG01110941: hypothetical protein +FIG01110942 FIG01110944: hypothetical protein +FIG01110945 FIG01110946: hypothetical protein +FIG01110948 FIG01110949: hypothetical protein +FIG01110949 FIG01110950: hypothetical protein +FIG01110950 FIG01110953: hypothetical protein +FIG01110953 FIG01110954: hypothetical protein +FIG01110954 FIG01110955: hypothetical protein +FIG01110955 FIG01110956: hypothetical protein +FIG01110956 FIG01110958: hypothetical protein +FIG01110958 FIG01110959: hypothetical protein +FIG01110959 esterase, PHB depolymerase family +FIG01110963 FIG01110964: hypothetical protein +FIG01110965 FIG01110966: hypothetical protein +FIG01110966 FIG01110967: hypothetical protein +FIG01110969 FIG01110970: hypothetical protein +FIG01110974 FIG01110976: hypothetical protein +FIG01110976 FIG01110977: hypothetical protein +FIG01110977 FIG01110978: hypothetical protein +FIG01110978 FIG01110979: hypothetical protein +FIG01110979 FIG01110980: hypothetical protein +FIG01110980 FIG01110982: hypothetical protein +FIG01110982 FIG01110983: hypothetical protein +FIG01110983 FIG01110988: hypothetical protein +FIG01110994 FIG01110996: hypothetical protein +FIG01110996 FIG01110998: hypothetical protein +FIG01111001 Interferon-induced transmembrane protein +FIG01111004 Fap unknown function protein-Stenotrophomonas type +FIG01111005 FIG01111008: hypothetical protein +FIG01111008 FIG01111009: hypothetical protein +FIG01111011 FIG01111012: hypothetical protein +FIG01111012 FIG01111013: hypothetical protein +FIG01111014 FIG01111015: hypothetical protein +FIG01111015 FIG01111016: hypothetical protein +FIG01111016 FIG01111018: hypothetical protein +FIG01111018 FIG01111019: hypothetical protein +FIG01111019 FIG01111020: hypothetical protein +FIG01111022 FIG01111025: hypothetical protein +FIG01111025 FIG01111026: hypothetical protein +FIG01111026 FIG01111028: hypothetical protein +FIG01111031 FIG01111034: hypothetical protein +FIG01111034 FIG01111035: hypothetical protein +FIG01111035 FIG01111036: hypothetical protein +FIG01111036 Putative transmembrane sensor +FIG01111037 FIG01111038: hypothetical protein +FIG01111038 FIG01111040: hypothetical protein +FIG01111040 FIG01111041: hypothetical protein +FIG01111041 Dipeptidyl-peptidase +FIG01111042 FIG01111043: hypothetical protein +FIG01111043 FIG01111044: hypothetical protein +FIG01111044 FIG01111045: hypothetical protein +FIG01111045 FIG01111046: hypothetical protein +FIG01111055 FIG01111056: hypothetical protein +FIG01111057 FIG01111059: hypothetical protein +FIG01111059 FIG01111061: hypothetical protein +FIG01111061 FIG01111062: hypothetical protein +FIG01111062 FIG01111063: hypothetical protein +FIG01111063 FIG01111064: hypothetical protein +FIG01111065 FIG01111067: hypothetical protein +FIG01111071 BLUF domain containing protein +FIG01111073 FIG01111074: hypothetical protein +FIG01111074 putative sec-independent protein translocase protein TatC +FIG01111075 FIG01111077: hypothetical protein +FIG01111078 FIG01111081: hypothetical protein +FIG01111081 FIG01111082: hypothetical protein +FIG01111083 FIG01111084: hypothetical protein +FIG01111085 FIG01111088: hypothetical protein +FIG01111088 FIG01111089: hypothetical protein +FIG01111101 FIG01111102: hypothetical protein +FIG01111102 FIG01111103: hypothetical protein +FIG01111103 FIG01111105: hypothetical protein +FIG01111105 FIG01111106: hypothetical protein +FIG01111106 FIG01111108: hypothetical protein +FIG01111114 FIG01111115: hypothetical protein +FIG01111115 FIG01111116: hypothetical protein +FIG01111116 FIG01111117: hypothetical protein +FIG01111117 FIG01111120: hypothetical protein +FIG01111120 FIG01111121: hypothetical protein +FIG01111121 FIG01111122: hypothetical protein +FIG01111122 FIG01111123: hypothetical protein +FIG01111123 FIG01111124: hypothetical protein +FIG01111124 FIG01111127: hypothetical protein +FIG01111127 FIG01111128: hypothetical protein +FIG01111130 FIG01111131: hypothetical protein +FIG01111131 FIG01111132: hypothetical protein +FIG01111137 FIG01111139: hypothetical protein +FIG01111139 FIG01111140: hypothetical protein +FIG01111140 FIG01111141: hypothetical protein +FIG01111141 FIG01111142: hypothetical protein +FIG01111142 FIG01111143: hypothetical protein +FIG01111143 FIG01111145: hypothetical protein +FIG01111148 FIG01111149: hypothetical protein +FIG01111153 FIG01111154: hypothetical protein +FIG01111155 FIG01111158: hypothetical protein +FIG01111158 FIG01111160: hypothetical protein +FIG01111160 FIG01111161: hypothetical protein +FIG01111162 Type II secretion system protein-like protein +FIG01111163 FIG01111165: hypothetical protein +FIG01111165 FIG01111166: hypothetical protein +FIG01111167 FIG01111168: hypothetical protein +FIG01111171 FIG01111173: hypothetical protein +FIG01111178 FIG01111179: hypothetical protein +FIG01111181 P pilus assembly protein, chaperone PapD +FIG01111182 FIG01111183: hypothetical protein +FIG01111184 FIG01111185: hypothetical protein +FIG01111186 FIG01111187: hypothetical protein +FIG01111193 FIG01111198: hypothetical protein +FIG01111198 FIG01111200: hypothetical protein +FIG01111202 FIG01111203: hypothetical protein +FIG01111206 FIG01111207: hypothetical protein +FIG01111207 FIG01111210: hypothetical protein +FIG01111211 FIG01111215: hypothetical protein +FIG01111215 FIG01111216: hypothetical protein +FIG01111218 FIG01111219: hypothetical protein +FIG01111220 FIG01111221: hypothetical protein +FIG01111221 Outer membrane protein +FIG01111223 FIG01111224: hypothetical protein +FIG01111228 FIG01111229: hypothetical protein +FIG01111231 FIG01111232: hypothetical protein +FIG01111236 FIG01111237: hypothetical protein +FIG01111240 FIG01111241: hypothetical protein +FIG01111241 putative proline-rich protein +FIG01111245 FIG01211600: hypothetical protein +FIG01111249 FIG01111250: hypothetical protein +FIG01111251 FIG01111252: hypothetical protein +FIG01111255 FIG01111256: hypothetical protein +FIG01111257 FIG01111258: hypothetical protein +FIG01111258 FIG01111259: hypothetical protein +FIG01111261 FIG01111262: hypothetical protein +FIG01111262 FIG01111264: hypothetical protein +FIG01111264 FIG01111265: hypothetical protein +FIG01111265 FIG01111269: hypothetical protein +FIG01111270 FIG01111271: hypothetical protein +FIG01111271 FIG01111272: hypothetical protein +FIG01111276 FIG01111277: hypothetical protein +FIG01111281 FIG01111283: hypothetical protein +FIG01111283 FIG01111284: hypothetical protein +FIG01111284 FIG01111286: hypothetical protein +FIG01111286 Nisin-resistance protein +FIG01111288 FIG01111290: hypothetical protein +FIG01111290 FIG01111291: hypothetical protein +FIG01111291 Phosphate-binding protein +FIG01111294 FIG01111295: hypothetical protein +FIG01111295 FIG01111298: hypothetical protein +FIG01111298 FIG01111299: hypothetical protein +FIG01111299 FIG01111300: hypothetical protein +FIG01111304 FIG01111305: hypothetical protein +FIG01111306 FIG01111307: hypothetical protein +FIG01111307 FIG01111308: hypothetical protein +FIG01111309 FIG01111310: hypothetical protein +FIG01111313 Poly(Hydroxyalcanoate) granule associated protein +FIG01111319 conserved hypothetical protein-transmembrane prediction +FIG01111320 FIG01111321: hypothetical protein +FIG01111321 FIG01111323: hypothetical protein +FIG01111323 FIG01111324: hypothetical protein +FIG01111324 FIG01111325: hypothetical protein +FIG01111325 FIG01111326: hypothetical protein +FIG01111329 FIG01111332: hypothetical protein +FIG01111332 FIG01111333: hypothetical protein +FIG01111333 FIG01111334: hypothetical protein +FIG01111335 FIG01111337: hypothetical protein +FIG01111340 FIG01111341: hypothetical protein +FIG01111342 FIG01111343: hypothetical protein +FIG01111343 FIG01111344: hypothetical protein +FIG01111344 FIG01111345: hypothetical protein +FIG01111346 FIG01111348: hypothetical protein +FIG01111348 FIG01111350: hypothetical protein +FIG01111350 FIG01111351: hypothetical protein +FIG01111354 FIG01111356: hypothetical protein +FIG01111356 FIG01111358: hypothetical protein +FIG01111358 FIG01111359: hypothetical protein +FIG01111359 FIG01111360: hypothetical protein +FIG01111360 FIG01111361: hypothetical protein +FIG01111361 FIG01111362: hypothetical protein +FIG01111362 Dipeptidyl carboxypeptidase +FIG01111366 FIG01111367: hypothetical protein +FIG01111367 FIG01111368: hypothetical protein +FIG01111368 FIG01111369: hypothetical protein +FIG01111369 FIG01111370: hypothetical protein +FIG01111370 FIG01111371: hypothetical protein +FIG01111371 FIG01111372: hypothetical protein +FIG01111372 FIG01111375: hypothetical protein +FIG01111376 FIG01111377: hypothetical protein +FIG01111379 FIG01111381: hypothetical protein +FIG01111381 FIG01111382: hypothetical protein +FIG01111382 FIG01111383: hypothetical protein +FIG01111389 FIG01111390: hypothetical protein +FIG01111391 FIG01111392: hypothetical protein +FIG01111394 Predicted exported glycosyl hydrolase family 31 protein +FIG01111400 FIG01111403: hypothetical protein +FIG01111403 FIG01111405: hypothetical protein +FIG01111409 FIG01111410: hypothetical protein +FIG01111412 FIG01111413: hypothetical protein +FIG01111413 FIG01111415: hypothetical protein +FIG01111415 FIG01111417: hypothetical protein +FIG01111422 FIG01111424: hypothetical protein +FIG01111425 FIG01111426: hypothetical protein +FIG01111426 FIG01111427: hypothetical protein +FIG01111429 FIG01111431: hypothetical protein +FIG01111431 Oligoendopeptidase F (EC 3.4.24.-) +FIG01111433 FIG01111434: hypothetical protein +FIG01111434 FIG01111437: hypothetical protein +FIG01111442 FIG01111445: hypothetical protein +FIG01111445 FIG01111446: hypothetical protein +FIG01111446 FIG01111448: hypothetical protein +FIG01111454 FIG01111455: hypothetical protein +FIG01111455 FIG01111456: hypothetical protein +FIG01111459 FIG01111461: hypothetical protein +FIG01111462 FIG01111464: hypothetical protein +FIG01111464 FIG01111467: hypothetical protein +FIG01111467 FIG01111468: hypothetical protein +FIG01111472 FIG01111473: hypothetical protein +FIG01111476 FIG01111477: hypothetical protein +FIG01111477 FIG01111479: hypothetical protein +FIG01111482 FIG01111483: hypothetical protein +FIG01111495 FIG01111496: hypothetical protein +FIG01111496 FIG01111500: hypothetical protein +FIG01111500 FIG01111501: hypothetical protein +FIG01111507 FIG01111509: hypothetical protein +FIG01111509 FIG01111510: hypothetical protein +FIG01111513 FIG01111514: hypothetical protein +FIG01111516 FIG01111517: hypothetical protein +FIG01111517 FIG01111518: hypothetical protein +FIG01111521 FIG01111522: hypothetical protein +FIG01111522 FIG01111526: hypothetical protein +FIG01111526 FIG01111530: hypothetical protein +FIG01111530 probable Two component sensor +FIG01111531 FIG01111532: hypothetical protein +FIG01111532 FIG01111534: hypothetical protein +FIG01111534 FIG01111538: hypothetical protein +FIG01111540 FIG01111541: hypothetical protein +FIG01111543 FIG01111545: hypothetical protein +FIG01111545 FIG01111546: hypothetical protein +FIG01111546 FIG01111547: hypothetical protein +FIG01111547 FIG01111551: hypothetical protein +FIG01111551 FIG01111557: hypothetical protein +FIG01111557 FIG01111558: hypothetical protein +FIG01111558 FIG01111559: hypothetical protein +FIG01111560 FIG01111563: hypothetical protein +FIG01111565 FIG01111568: hypothetical protein +FIG01111568 Cyclase family protein +FIG01111571 FIG01111572: hypothetical protein +FIG01111577 FIG01111578: hypothetical protein +FIG01111581 FIG01111582: hypothetical protein +FIG01111584 FIG01111585: hypothetical protein +FIG01111586 FIG01111587: hypothetical protein +FIG01111587 FIG01111588: hypothetical protein +FIG01111590 FIG01111591: hypothetical protein +FIG01111594 FIG01111596: hypothetical protein +FIG01111601 FIG01111602: hypothetical protein +FIG01111602 FIG01111603: hypothetical protein +FIG01111603 FIG01111604: hypothetical protein +FIG01111604 FIG01111605: hypothetical protein +FIG01111605 FIG01111606: hypothetical protein +FIG01111608 FIG01111610: hypothetical protein +FIG01111610 FIG01111611: hypothetical protein +FIG01111613 FIG01111614: hypothetical protein +FIG01111614 FIG01111616: hypothetical protein +FIG01111616 FIG01111617: hypothetical protein +FIG01111620 soluble lytic murein transglycosylase +FIG01111621 FIG01111622: hypothetical protein +FIG01111622 FIG01111625: hypothetical protein +FIG01111625 FIG01111626: hypothetical protein +FIG01111626 FIG01111627: hypothetical protein +FIG01111627 FIG01111630: hypothetical protein +FIG01111635 FIG01111636: hypothetical protein +FIG01111636 FIG01111637: hypothetical protein +FIG01111638 FIG01111639: hypothetical protein +FIG01111641 FIG01111643: hypothetical protein +FIG01111646 FIG01210543: hypothetical protein +FIG01111653 FIG01111654: hypothetical protein +FIG01111657 FIG01111658: hypothetical protein +FIG01111658 FIG01111659: hypothetical protein +FIG01111661 FIG01111663: hypothetical protein +FIG01111663 FIG01111665: hypothetical protein +FIG01111666 FIG01111668: hypothetical protein +FIG01111669 FIG01111671: hypothetical protein +FIG01111671 FIG01111672: hypothetical protein +FIG01111675 FIG01111678: hypothetical protein +FIG01111678 c-di-GMP phosphodiesterase A +FIG01111679 FIG01111681: hypothetical protein +FIG01111681 FIG01111683: hypothetical protein +FIG01111684 sulphate transporter +FIG01111685 FIG01111686: hypothetical protein +FIG01111686 FIG01111688: hypothetical protein +FIG01111689 FIG01111691: hypothetical protein +FIG01111692 FIG01111693: hypothetical protein +FIG01111696 Carboxypeptidase (EC 3.4.17.2) +FIG01111701 FIG01111702: hypothetical protein +FIG01111704 FIG01111705: hypothetical protein +FIG01111705 FIG01111706: hypothetical protein +FIG01111706 FIG01111707: hypothetical protein +FIG01111709 FIG01111711: hypothetical protein +FIG01111711 FIG01111714: hypothetical protein +FIG01111715 FIG01111717: hypothetical protein +FIG01111717 FIG01111718: hypothetical protein +FIG01111718 FIG01111719: hypothetical protein +FIG01111721 FIG01111723: hypothetical protein +FIG01111723 FIG01111726: hypothetical protein +FIG01111730 FIG01111731: hypothetical protein +FIG01111734 FIG01111735: hypothetical protein +FIG01111735 FIG01111736: hypothetical protein +FIG01111736 FIG01111737: hypothetical protein +FIG01111737 FIG01111738: hypothetical protein +FIG01111743 FIG01111744: hypothetical protein +FIG01111744 FIG01111745: hypothetical protein +FIG01111747 putative FecR +FIG01111748 FIG01111749: hypothetical protein +FIG01111749 FIG01111750: hypothetical protein +FIG01111750 FIG01111752: hypothetical protein +FIG01111752 FIG01111754: hypothetical protein +FIG01111755 thiamineS +FIG01111758 FIG01111761: hypothetical protein +FIG01111764 FIG01111765: hypothetical protein +FIG01111766 FIG01111767: hypothetical protein +FIG01111770 FIG01111772: hypothetical protein +FIG01111772 FIG01111775: hypothetical protein +FIG01111775 FIG01111776: hypothetical protein +FIG01111776 FIG01111779: hypothetical protein +FIG01111784 FIG01111785: hypothetical protein +FIG01111785 FIG01111787: hypothetical protein +FIG01111792 FIG01111793: hypothetical protein +FIG01111796 FIG01111797: hypothetical protein +FIG01111800 FIG01111801: hypothetical protein +FIG01111801 FIG01111802: hypothetical protein +FIG01111802 FIG01111804: hypothetical protein +FIG01111809 FIG01111811: hypothetical protein +FIG01111811 Chemotaxis protein cheA (EC 2.7.3.-) +FIG01111812 FIG01111814: hypothetical protein +FIG01111814 FIG01111815: hypothetical protein +FIG01111818 FIG01111820: hypothetical protein +FIG01111820 FIG01111821: hypothetical protein +FIG01111821 choline/carnitine/betaine transporter +FIG01111823 CoA tranferase +FIG01111828 FIG01111829: hypothetical protein +FIG01111829 N-hydroxyarylamine O-acetyltransferase, putative +FIG01111830 FIG01111831: hypothetical protein +FIG01111834 FIG01111835: hypothetical protein +FIG01111835 FIG01111836: hypothetical protein +FIG01111837 FIG01111838: hypothetical protein +FIG01111838 FIG01111839: hypothetical protein +FIG01111844 FIG01111845: hypothetical protein +FIG01111845 FIG01111846: hypothetical protein +FIG01111846 FIG01111847: hypothetical protein +FIG01111848 FIG01111849: hypothetical protein +FIG01111849 FIG01111850: hypothetical protein +FIG01111850 FIG01111851: hypothetical protein +FIG01111851 FIG01111852: hypothetical protein +FIG01111852 FIG01111853: hypothetical protein +FIG01111853 Peptidoglycan-associated outer membrane lipoprotein +FIG01111858 FIG01111859: hypothetical protein +FIG01111859 FIG01111860: hypothetical protein +FIG01111860 FIG01111861: hypothetical protein +FIG01111865 FIG01111866: hypothetical protein +FIG01111866 FIG01111867: hypothetical protein +FIG01111867 FIG01111868: hypothetical protein +FIG01111871 FIG01111872: hypothetical protein +FIG01111873 FIG01111874: hypothetical protein +FIG01111874 FIG01111875: hypothetical protein +FIG01111881 FIG01111882: hypothetical protein +FIG01111882 FIG01111883: hypothetical protein +FIG01111885 FIG01111886: hypothetical protein +FIG01111888 FIG01111889: hypothetical protein +FIG01111890 FIG01111891: hypothetical protein +FIG01111891 FIG01111895: hypothetical protein +FIG01111896 FIG01111897: hypothetical protein +FIG01111899 FIG01111900: hypothetical protein +FIG01111902 FIG01111905: hypothetical protein +FIG01111905 FIG01111909: hypothetical protein +FIG01111909 FIG01111911: hypothetical protein +FIG01111913 FIG01111914: hypothetical protein +FIG01111914 FIG01111915: hypothetical protein +FIG01111915 FIG01111917: hypothetical protein +FIG01111924 FIG01111926: hypothetical protein +FIG01111926 FIG01111928: hypothetical protein +FIG01111928 FIG01111929: hypothetical protein +FIG01111929 FIG01111930: hypothetical protein +FIG01111930 Minor pilin of type IV secretion complex, VirB5 +FIG01111933 FIG01111934: hypothetical protein +FIG01111935 FIG01111936: hypothetical protein +FIG01111939 FIG01111940: hypothetical protein +FIG01111940 FIG01111943: hypothetical protein +FIG01111943 FIG01111944: hypothetical protein +FIG01111946 FIG01111948: hypothetical protein +FIG01111948 FIG01111950: hypothetical protein +FIG01111951 FIG01111952: hypothetical protein +FIG01111952 FIG01111955: hypothetical protein +FIG01111956 Putative short-chain dehydrogenase +FIG01111958 FIG01111959: hypothetical protein +FIG01111962 FIG01111963: hypothetical protein +FIG01111963 FIG01111965: hypothetical protein +FIG01111967 FIG01111968: hypothetical protein +FIG01111968 FIG01111969: hypothetical protein +FIG01111969 FIG01111970: hypothetical protein +FIG01111976 FIG01111979: hypothetical protein +FIG01111979 FIG01111981: hypothetical protein +FIG01111981 FIG01111982: hypothetical protein +FIG01111982 FIG01111984: hypothetical protein +FIG01111986 FIG01111987: hypothetical protein +FIG01111987 FIG01111989: hypothetical protein +FIG01111992 FIG01111993: hypothetical protein +FIG01111993 FIG01111994: hypothetical protein +FIG01111994 FIG01111997: hypothetical protein +FIG01111997 FIG01111999: hypothetical protein +FIG01112000 FIG01112001: hypothetical protein +FIG01112001 FIG01112002: hypothetical protein +FIG01112003 FIG01112004: hypothetical protein +FIG01112004 FIG01112006: hypothetical protein +FIG01112006 FIG01112007: hypothetical protein +FIG01112007 putative multi-domain protein +FIG01112010 FIG01112011: hypothetical protein +FIG01112011 FIG01112012: hypothetical protein +FIG01112012 FIG01112013: hypothetical protein +FIG01112015 FIG01112017: hypothetical protein +FIG01112019 FIG01112024: hypothetical protein +FIG01112024 FIG01112026: hypothetical protein +FIG01112026 FIG01112028: hypothetical protein +FIG01112028 FIG01112029: hypothetical protein +FIG01112029 FIG01112032: hypothetical protein +FIG01112032 FIG01112033: hypothetical protein +FIG01112036 FIG01112037: hypothetical protein +FIG01112037 FIG01112038: hypothetical protein +FIG01112038 FIG01112039: hypothetical protein +FIG01112039 FIG01112041: hypothetical protein +FIG01112044 FIG01112046: hypothetical protein +FIG01112049 FIG01112051: hypothetical protein +FIG01112051 FIG01112053: hypothetical protein +FIG01112053 FIG01112054: hypothetical protein +FIG01112054 FIG01112055: hypothetical protein +FIG01112055 FIG01112056: hypothetical protein +FIG01112056 FIG01112059: hypothetical protein +FIG01112061 FIG01112063: hypothetical protein +FIG01112063 FIG01112064: hypothetical protein +FIG01112065 FIG01112067: hypothetical protein +FIG01112067 FIG01112068: hypothetical protein +FIG01112070 FIG01112071: hypothetical protein +FIG01112071 FIG01112072: hypothetical protein +FIG01112075 FIG01112076: hypothetical protein +FIG01112076 FIG01112077: hypothetical protein +FIG01112077 FIG01112078: hypothetical protein +FIG01112078 FIG01112079: hypothetical protein +FIG01112083 FIG01112085: hypothetical protein +FIG01112085 FIG01112086: hypothetical protein +FIG01112086 FIG01112087: hypothetical protein +FIG01112089 FIG01112091: hypothetical protein +FIG01112095 FIG01112096: hypothetical protein +FIG01112096 FIG01112098: hypothetical protein +FIG01112098 FIG01112099: hypothetical protein +FIG01112102 FIG01112103: hypothetical protein +FIG01112103 FIG01112104: hypothetical protein +FIG01112112 FIG01112113: hypothetical protein +FIG01112113 FIG01112114: hypothetical protein +FIG01112114 FIG01112115: hypothetical protein +FIG01112119 FIG01112121: hypothetical protein +FIG01112121 FIG01112122: hypothetical protein +FIG01112122 FIG01112123: hypothetical protein +FIG01112124 FIG01112125: hypothetical protein +FIG01112125 FIG01112126: hypothetical protein +FIG01112129 FIG01112130: hypothetical protein +FIG01112131 FIG01112132: hypothetical protein +FIG01112132 FIG01112135: hypothetical protein +FIG01112136 FIG01112138: hypothetical protein +FIG01112138 FIG01112143: hypothetical protein +FIG01112143 FIG01112144: hypothetical protein +FIG01112144 benzene 1,2-dioxygenase, ferredoxin protein +FIG01112145 FIG01112146: hypothetical protein +FIG01112146 FIG01112147: hypothetical protein +FIG01112150 FIG01112151: hypothetical protein +FIG01112151 FIG01112154: hypothetical protein +FIG01112154 FIG01112157: hypothetical protein +FIG01112157 FIG01112159: hypothetical protein +FIG01112165 PsiF +FIG01112166 FIG01112168: hypothetical protein +FIG01112168 FIG01112171: hypothetical protein +FIG01112172 FIG01112174: hypothetical protein +FIG01112182 FIG01112183: hypothetical protein +FIG01112184 FIG01112186: hypothetical protein +FIG01112186 FIG01112189: hypothetical protein +FIG01112190 FIG01112191: hypothetical protein +FIG01112192 FIG01112193: hypothetical protein +FIG01112194 FIG01112195: hypothetical protein +FIG01112195 FIG01112196: hypothetical protein +FIG01112196 FIG01112197: hypothetical protein +FIG01112199 FIG01112200: hypothetical protein +FIG01112207 FIG01112209: hypothetical protein +FIG01112211 FIG01112212: hypothetical protein +FIG01112212 FIG01112213: hypothetical protein +FIG01112215 FIG01112216: hypothetical protein +FIG01112223 FIG01112224: hypothetical protein +FIG01112224 FIG01112225: hypothetical protein +FIG01112225 FIG01112226: hypothetical protein +FIG01112226 FIG01112229: hypothetical protein +FIG01112229 FIG01112232: hypothetical protein +FIG01112236 FIG01112237: hypothetical protein +FIG01112237 FIG01112238: hypothetical protein +FIG01112238 FIG01112239: hypothetical protein +FIG01112239 FIG01112242: hypothetical protein +FIG01112242 FIG01112243: hypothetical protein +FIG01112243 FIG01112244: hypothetical protein +FIG01112248 FIG01112249: hypothetical protein +FIG01112249 FIG01112251: hypothetical protein +FIG01112252 FIG01112253: hypothetical protein +FIG01112253 FIG01112255: hypothetical protein +FIG01112256 FIG01112257: hypothetical protein +FIG01112257 FIG01112260: hypothetical protein +FIG01112260 FIG01112264: hypothetical protein +FIG01112264 FIG01112267: hypothetical protein +FIG01112274 FIG01112275: hypothetical protein +FIG01112278 PROBABLE PREPILIN PEPTIDASE TRANSMEMBRANE PROTEIN +FIG01112287 FIG01112288: hypothetical protein +FIG01112288 Transcriptional regulator, TetR (AcrR) family [USSDB4A] +FIG01112291 FIG01112292: hypothetical protein +FIG01112292 FIG01112293: hypothetical protein +FIG01112293 FIG01112294: hypothetical protein +FIG01112295 FIG01112296: hypothetical protein +FIG01112301 FIG01112302: hypothetical protein +FIG01112303 FIG01112304: hypothetical protein +FIG01112304 FIG01112306: hypothetical protein +FIG01112307 FIG01112310: hypothetical protein +FIG01112311 protein of unknown function DUF1697 +FIG01112312 FIG01112313: hypothetical protein +FIG01112320 protein of unknown function DUF1458 +FIG01112322 FIG01112323: hypothetical protein +FIG01112323 FIG01112324: hypothetical protein +FIG01112325 FIG01112326: hypothetical protein +FIG01112328 FIG01112331: hypothetical protein +FIG01112331 FIG01112334: hypothetical protein +FIG01112334 FIG01112335: hypothetical protein +FIG01112335 FIG01112336: hypothetical protein +FIG01112336 FIG01112338: hypothetical protein +FIG01112338 FIG01112339: hypothetical protein +FIG01112340 FIG01112342: hypothetical protein +FIG01112344 FIG01112347: hypothetical protein +FIG01112347 FIG01112349: hypothetical protein +FIG01112354 FIG01112356: hypothetical protein +FIG01112356 FIG01112358: hypothetical protein +FIG01112364 FIG01112365: hypothetical protein +FIG01112365 FIG01112367: hypothetical protein +FIG01112367 FIG01112368: hypothetical protein +FIG01112368 FIG01112369: hypothetical protein +FIG01112374 chaperone protein EcpD precursor +FIG01112375 FIG01112376: hypothetical protein +FIG01112377 FIG01112378: hypothetical protein +FIG01112379 FIG01112380: hypothetical protein +FIG01112381 FIG01112382: hypothetical protein +FIG01112382 FIG01112383: hypothetical protein +FIG01112383 FIG01112384: hypothetical protein +FIG01112387 FIG01112389: hypothetical protein +FIG01112390 FIG01112391: hypothetical protein +FIG01112395 FIG01112396: hypothetical protein +FIG01112400 protein of unknown function DUF188 +FIG01112402 FIG01112403: hypothetical protein +FIG01112406 FIG01112407: hypothetical protein +FIG01112407 FIG01112408: hypothetical protein +FIG01112409 FIG01112411: hypothetical protein +FIG01112411 FIG01112412: hypothetical protein +FIG01112413 FIG01112416: hypothetical protein +FIG01112417 Diamine acetyltransferase 1 (EC 2.3.1.57) +FIG01112420 FIG01112421: hypothetical protein +FIG01112421 FIG01112422: hypothetical protein +FIG01112422 L-fucose permease +FIG01112423 FIG01112424: hypothetical protein +FIG01112427 FIG01112428: hypothetical protein +FIG01112429 FIG01112432: hypothetical protein +FIG01112434 FIG01112435: hypothetical protein +FIG01112440 FIG01112441: hypothetical protein +FIG01112443 Plasmid replication/partition related protein +FIG01112447 FIG01112448: hypothetical protein +FIG01112448 FIG01112449: hypothetical protein +FIG01112449 FIG01112450: hypothetical protein +FIG01112450 FIG01112451: hypothetical protein +FIG01112451 FIG01112452: hypothetical protein +FIG01112452 FIG01112453: hypothetical protein +FIG01112460 LasA +FIG01112462 FIG01112466: hypothetical protein +FIG01112466 FIG01112471: hypothetical protein +FIG01112471 FIG01112472: hypothetical protein +FIG01112473 FIG01112475: hypothetical protein +FIG01112475 Roadblock/LC7 +FIG01112482 FIG01112483: hypothetical protein +FIG01112483 FIG01112484: hypothetical protein +FIG01112488 FIG01112492: hypothetical protein +FIG01112493 FIG01112494: hypothetical protein +FIG01112494 FIG01112495: hypothetical protein +FIG01112500 FIG01112502: hypothetical protein +FIG01112507 FIG01112508: hypothetical protein +FIG01112508 COG4832: Uncharacterized conserved protein +FIG01112511 FIG01211448: hypothetical protein +FIG01112513 FIG01112514: hypothetical protein +FIG01112517 FIG01112519: hypothetical protein +FIG01112519 FIG01112520: hypothetical protein +FIG01112522 FIG01112524: hypothetical protein +FIG01112525 FIG01112526: hypothetical protein +FIG01112526 FIG01112529: hypothetical protein +FIG01112531 FIG01112532: hypothetical protein +FIG01112534 Probable pilus assembly protein +FIG01112541 FIG01112551: hypothetical protein +FIG01112555 FIG01112557: hypothetical protein +FIG01112560 FIG01112563: hypothetical protein +FIG01112563 FIG01112565: hypothetical protein +FIG01112565 FIG01112566: hypothetical protein +FIG01112569 FIG01112570: hypothetical protein +FIG01112572 FIG01112573: hypothetical protein +FIG01112576 FIG01112577: hypothetical protein +FIG01112580 FIG01112582: hypothetical protein +FIG01112582 FIG01112583: hypothetical protein +FIG01112583 FIG01112584: hypothetical protein +FIG01112584 Voltage-gated potassium channel beta subunit +FIG01112586 FIG01112589: hypothetical protein +FIG01112589 FIG01112590: hypothetical protein +FIG01112591 FIG01112593: hypothetical protein +FIG01112593 FIG01112594: hypothetical protein +FIG01112596 FIG01112597: hypothetical protein +FIG01112597 FIG01112600: hypothetical protein +FIG01112600 FIG01112601: hypothetical protein +FIG01112601 FIG01112607: hypothetical protein +FIG01112610 FIG01112614: hypothetical protein +FIG01112614 FIG01112617: hypothetical protein +FIG01112617 FIG01112619: hypothetical protein +FIG01112619 FIG01112620: hypothetical protein +FIG01112620 FIG01112621: hypothetical protein +FIG01112621 FIG01112622: hypothetical protein +FIG01112622 FIG01112623: hypothetical protein +FIG01112623 FIG01112624: hypothetical protein +FIG01112624 FIG01112625: hypothetical protein +FIG01112625 FIG01112626: hypothetical protein +FIG01112630 FIG01112631: hypothetical protein +FIG01112632 FIG01112633: hypothetical protein +FIG01112635 FIG01112637: hypothetical protein +FIG01112637 FIG01210549: hypothetical protein +FIG01112639 FIG01112641: hypothetical protein +FIG01112645 FIG01112647: hypothetical protein +FIG01112655 FIG01112656: hypothetical protein +FIG01112656 FIG01112657: hypothetical protein +FIG01112657 FIG01112660: hypothetical protein +FIG01112660 FIG01112662: hypothetical protein +FIG01112662 FIG01112663: hypothetical protein +FIG01112663 FIG01112664: hypothetical protein +FIG01112664 FIG01112665: hypothetical protein +FIG01112667 FIG01112668: hypothetical protein +FIG01112669 FIG01112671: hypothetical protein +FIG01112671 FIG01112672: hypothetical protein +FIG01112672 FIG01112673: hypothetical protein +FIG01112673 FIG01112674: hypothetical protein +FIG01112677 FIG01112678: hypothetical protein +FIG01112680 FIG01112683: hypothetical protein +FIG01112683 protein of unknown function DUF1311 +FIG01112684 FIG01112685: hypothetical protein +FIG01112685 FIG01112686: hypothetical protein +FIG01112687 FIG01112689: hypothetical protein +FIG01112689 integrase catalytic subunit +FIG01112690 FIG01112692: hypothetical protein +FIG01112695 FIG01112698: hypothetical protein +FIG01112702 FIG01112704: hypothetical protein +FIG01112704 fimbrial protein +FIG01112705 FIG01112709: hypothetical protein +FIG01112709 FIG01112712: hypothetical protein +FIG01112712 FIG01112714: hypothetical protein +FIG01112714 FIG01112715: hypothetical protein +FIG01112715 FIG01112718: hypothetical protein +FIG01112718 methyl parathion hydrolase +FIG01112720 FIG01112724: hypothetical protein +FIG01112725 FIG01112728: hypothetical protein +FIG01112729 putative helicase, superfamily II +FIG01112732 FIG01112734: hypothetical protein +FIG01112734 FIG01112736: hypothetical protein +FIG01112736 Luciferase-like +FIG01112741 FIG01112742: hypothetical protein +FIG01112742 FIG01112743: hypothetical protein +FIG01112743 FIG01112744: hypothetical protein +FIG01112744 FIG01112747: hypothetical protein +FIG01112747 FIG01112754: hypothetical protein +FIG01112766 FIG01112767: hypothetical protein +FIG01112767 FIG01112772: hypothetical protein +FIG01112772 FIG01112774: hypothetical protein +FIG01112775 FIG01112778: hypothetical protein +FIG01112779 Bll1684 protein +FIG01112782 Pseudouridylate synthase +FIG01112787 FIG01112792: hypothetical protein +FIG01112792 FIG01112794: hypothetical protein +FIG01112796 FIG01112798: hypothetical protein +FIG01112799 FIG01112800: hypothetical protein +FIG01112801 FIG01112805: hypothetical protein +FIG01112805 FIG01112809: hypothetical protein +FIG01112810 FIG01112815: hypothetical protein +FIG01112816 FIG01112818: hypothetical protein +FIG01112818 FIG01112819: hypothetical protein +FIG01112824 FIG01112835: hypothetical protein +FIG01112835 FIG01112838: hypothetical protein +FIG01112838 FIG01112841: hypothetical protein +FIG01112842 FIG01112843: hypothetical protein +FIG01112843 FIG01112844: hypothetical protein +FIG01112848 FIG01112849: hypothetical protein +FIG01112849 FIG01112852: hypothetical protein +FIG01112853 FIG01112855: hypothetical protein +FIG01112855 FIG01112860: hypothetical protein +FIG01112863 FIG01112864: hypothetical protein +FIG01112864 FIG01112865: hypothetical protein +FIG01112865 FIG01112867: hypothetical protein +FIG01112871 FIG01112874: hypothetical protein +FIG01112874 FIG01112876: hypothetical protein +FIG01112888 FIG01112891: hypothetical protein +FIG01112891 FIG01112892: hypothetical protein +FIG01112897 FIG01112898: hypothetical protein +FIG01112903 FIG01112904: hypothetical protein +FIG01112906 FIG01112907: hypothetical protein +FIG01112914 FIG01112916: hypothetical protein +FIG01112918 FIG01112920: hypothetical protein +FIG01112923 FIG01112925: hypothetical protein +FIG01112930 FIG01112936: hypothetical protein +FIG01112954 FIG01112957: hypothetical protein +FIG01112957 FIG01112958: hypothetical protein +FIG01112958 FIG01112959: hypothetical protein +FIG01112959 Cytochrome C552 +FIG01112962 FIG01112965: hypothetical protein +FIG01112965 FIG01112966: hypothetical protein +FIG01112966 FIG01112967: hypothetical protein +FIG01112967 FIG01112968: hypothetical protein +FIG01112988 FIG01112989: hypothetical protein +FIG01112999 FIG01113002: hypothetical protein +FIG01113003 FIG01113005: hypothetical protein +FIG01113006 Plectin 1 +FIG01113007 FIG01113010: hypothetical protein +FIG01113011 FIG01113014: hypothetical protein +FIG01113023 FIG01113025: hypothetical protein +FIG01113025 FIG01113027: hypothetical protein +FIG01113030 FIG01113032: hypothetical protein +FIG01113033 FIG01113038: hypothetical protein +FIG01113038 FIG01113040: hypothetical protein +FIG01113040 FIG01113041: hypothetical protein +FIG01113044 FIG01113046: hypothetical protein +FIG01113047 FIG01113048: hypothetical protein +FIG01113053 FIG01113054: hypothetical protein +FIG01113055 FIG01113056: hypothetical protein +FIG01113058 FIG01113061: hypothetical protein +FIG01113061 FIG01113066: hypothetical protein +FIG01113076 FIG01113078: hypothetical protein +FIG01113085 FIG01113088: hypothetical protein +FIG01113088 FIG01113095: hypothetical protein +FIG01113100 FIG01113101: hypothetical protein +FIG01113102 FIG01113103: hypothetical protein +FIG01113105 FIG01113111: hypothetical protein +FIG01113114 FIG01113119: hypothetical protein +FIG01113119 FIG01113124: hypothetical protein +FIG01113124 FIG01113126: hypothetical protein +FIG01113131 FIG01113137: hypothetical protein +FIG01113143 FIG01113151: hypothetical protein +FIG01113156 FIG01113157: hypothetical protein +FIG01113174 FIG01113176: hypothetical protein +FIG01113181 FIG01113183: hypothetical protein +FIG01113183 Similar to F420-dependent glucose-6-phosphate dehydrogenase, Mext_1273 family +FIG01113186 FIG01113189: hypothetical protein +FIG01113189 DNA modification methylase +FIG01113195 FIG01113199: hypothetical protein +FIG01113204 FIG01113208: hypothetical protein +FIG01113391 Nickel transport ATP-binding protein nikD +FIG01113460 putative intracellular protease/amidase +FIG01113606 Exonuclease, RNase T and DNA polymerase III +FIG01113771 modification methylase HpaII (Cytosine-specific methyltransferase HpaII)( EC:2.1.1.73 ) +FIG01113904 FIG01020321: hypothetical protein +FIG01113946 FIG01113947: hypothetical protein +FIG01113947 FIG01113949: hypothetical protein +FIG01113950 FIG01113951: hypothetical protein +FIG01113955 FIG01113960: hypothetical protein +FIG01113960 FIG01113961: hypothetical protein +FIG01113963 FIG01113964: hypothetical protein +FIG01113964 FIG01113965: hypothetical protein +FIG01113965 FIG01113967: hypothetical protein +FIG01113971 FIG01113973: hypothetical protein +FIG01113973 FIG01113973: possible membrane protein +FIG01113974 FIG01113975: hypothetical protein +FIG01113975 FIG01113976: hypothetical protein +FIG01113977 FIG01113978: hypothetical protein +FIG01113979 FIG01113980: hypothetical protein +FIG01113982 FIG01113984: hypothetical protein +FIG01113984 FIG01113985: hypothetical protein +FIG01113985 FIG01113986: hypothetical protein +FIG01113986 FIG01113987: hypothetical protein +FIG01113987 FIG01113988: hypothetical protein +FIG01113990 FIG01113991: hypothetical protein +FIG01113991 FIG01113992: hypothetical protein +FIG01113992 FIG01113993: hypothetical protein +FIG01113993 FIG01113994: hypothetical protein +FIG01113995 FIG01113997: hypothetical protein +FIG01114002 FIG01114003: hypothetical protein +FIG01114004 acetyltransferase, GNAT family +FIG01114005 FIG01114006: hypothetical protein +FIG01114009 FIG01114010: hypothetical protein +FIG01114011 Phage endopeptidase +FIG01114013 FIG01114015: hypothetical protein +FIG01114016 FIG01114018: hypothetical protein +FIG01114018 FIG01114019: hypothetical protein +FIG01114019 FIG01114020: hypothetical protein +FIG01114020 FIG01114021: hypothetical protein +FIG01114021 FIG01114022: hypothetical protein +FIG01114022 FIG01114023: hypothetical protein +FIG01114023 FIG01114024: hypothetical protein +FIG01114026 FIG01114027: hypothetical protein +FIG01114027 FIG01114029: hypothetical protein +FIG01114031 FIG01114033: hypothetical protein +FIG01114033 FIG01114034: hypothetical protein +FIG01114038 Phage shock protein C, putative; stress-responsive transcriptional regulator +FIG01114039 FIG01114040: hypothetical protein +FIG01114040 FIG01114041: hypothetical protein +FIG01114041 FIG01114042: hypothetical protein +FIG01114042 FIG01114043: hypothetical protein +FIG01114044 FIG01114045: hypothetical protein +FIG01114047 FIG01114048: hypothetical protein +FIG01114049 phosphoenolpyruvate-dependent sugar phosphotransferase system EIIC, probable sorbose specific +FIG01114051 FIG01114054: hypothetical protein +FIG01114057 hypothetical protein - phage associated +FIG01114058 FIG01114059: hypothetical protein +FIG01114059 FIG01114060: hypothetical protein +FIG01114060 FIG01114062: hypothetical protein +FIG01114062 FIG01114063: hypothetical protein +FIG01114065 FIG01114066: hypothetical protein +FIG01114066 FIG01114067: hypothetical protein +FIG01114067 FIG01114068: hypothetical protein +FIG01114069 FIG01114070: hypothetical protein +FIG01114070 FIG01114071: hypothetical protein +FIG01114071 alpha/beta fold family hydrolase +FIG01114072 FIG01114073: hypothetical protein +FIG01114073 bacteriocin immunity protein +FIG01114074 FIG01114076: hypothetical protein +FIG01114076 FIG01114077: hypothetical protein +FIG01114077 hypothetical protein - phage associated +FIG01114079 FIG01114080: hypothetical protein +FIG01114080 FIG01114081: hypothetical protein +FIG01114084 Chromosome segregation helicase +FIG01114086 FIG01114089: hypothetical protein +FIG01114089 FIG01114090: hypothetical protein +FIG01114090 FIG01114091: hypothetical protein +FIG01114091 FIG01114092: hypothetical protein +FIG01114093 FIG01114095: hypothetical protein +FIG01114095 FIG01114096: hypothetical protein +FIG01114096 FIG01114097: hypothetical protein +FIG01114097 FIG01114098: hypothetical protein +FIG01114098 FIG01114099: hypothetical protein +FIG01114102 FIG01114103: hypothetical protein +FIG01114103 FIG01114104: hypothetical protein +FIG01114105 hypothetical protein +FIG01114110 FIG01116721: hypothetical protein +FIG01114113 FIG01114114: hypothetical protein +FIG01114114 FIG01114115: hypothetical protein +FIG01114115 FIG01114116: hypothetical protein +FIG01114116 FIG01114118: hypothetical protein +FIG01114121 FIG01114122: hypothetical protein +FIG01114126 putative arylalkylamine n-acetyltransferase +FIG01114127 FIG01114128: hypothetical protein +FIG01114129 FIG01114130: hypothetical protein +FIG01114130 FIG01114133: hypothetical protein +FIG01114134 Cell wall surface anchor family protein, LPXTG motif +FIG01114140 FIG01114141: hypothetical protein +FIG01114142 FIG01114146: hypothetical protein +FIG01114146 FIG01114147: hypothetical protein +FIG01114147 FIG01114148: hypothetical protein +FIG01114148 FIG01114149: hypothetical protein +FIG01114151 FIG01114153: hypothetical protein +FIG01114153 FIG01114154: hypothetical protein +FIG01114158 FIG01114159: hypothetical protein +FIG01114159 FIG01114161: hypothetical protein +FIG01114165 FIG01114166: hypothetical protein +FIG01114168 Tn5252, Orf 10 protein +FIG01114170 FIG01114171: hypothetical protein +FIG01114171 FIG01114172: hypothetical protein +FIG01114172 FIG01114173: hypothetical protein +FIG01114173 FIG01114174: hypothetical protein +FIG01114174 FIG01114175: hypothetical protein +FIG01114175 FIG01114177: hypothetical protein +FIG01114178 FIG01114180: hypothetical protein +FIG01114183 FIG01114768: hypothetical protein +FIG01114184 FIG01114186: hypothetical protein +FIG01114186 FIG01114187: hypothetical protein +FIG01114187 FIG01114188: hypothetical protein +FIG01114188 FIG01114189: hypothetical protein +FIG01114190 FIG01114191: hypothetical protein +FIG01114191 FIG01114192: hypothetical protein +FIG01114192 FIG01114193: hypothetical protein +FIG01114194 FIG01114195: hypothetical protein +FIG01114196 FIG01114199: hypothetical protein +FIG01114199 FIG01114201: hypothetical protein +FIG01114203 FIG01114205: hypothetical protein +FIG01114207 FIG01114208: hypothetical protein +FIG01114211 FIG01114212: hypothetical protein +FIG01114212 FIG01114213: hypothetical protein +FIG01114213 FIG01114214: hypothetical protein +FIG01114214 Toxin to DNA-damage-inducible protein J +FIG01114215 FIG01114216: hypothetical protein +FIG01114216 FIG01114217: hypothetical protein +FIG01114217 FIG01114220: hypothetical protein +FIG01114220 FIG01114221: hypothetical protein +FIG01114221 FIG01114222: hypothetical protein +FIG01114222 FIG01114223: hypothetical protein +FIG01114223 FIG01114224: hypothetical protein +FIG01114224 FIG01114225: hypothetical protein +FIG01114227 FIG01114229: hypothetical protein +FIG01114231 Small integral membrane protein +FIG01114232 FIG01114234: hypothetical protein +FIG01114238 FIG01114239: hypothetical protein +FIG01114239 FIG01114242: hypothetical protein +FIG01114242 FIG01114246: hypothetical protein +FIG01114247 FIG01114249: hypothetical protein +FIG01114249 FIG01114250: hypothetical protein +FIG01114251 FIG01114252: hypothetical protein +FIG01114252 FIG01114253: hypothetical protein +FIG01114253 FIG01114254: hypothetical protein +FIG01114254 FIG01114255: hypothetical protein +FIG01114255 FIG01114256: hypothetical protein +FIG01114256 FIG01114257: hypothetical protein +FIG01114257 FIG01114261: hypothetical protein +FIG01114262 FIG01114263: hypothetical protein +FIG01114263 FIG01114264: hypothetical protein +FIG01114265 FIG01114267: hypothetical protein +FIG01114267 FIG01114268: hypothetical protein +FIG01114268 FIG01114269: hypothetical protein +FIG01114270 FIG01114272: hypothetical protein +FIG01114272 FIG01114273: hypothetical protein +FIG01114273 FIG01114275: hypothetical protein +FIG01114275 FIG01114277: hypothetical protein +FIG01114279 FIG01114280: hypothetical protein +FIG01114280 FIG01114281: hypothetical protein +FIG01114281 FIG01114282: hypothetical protein +FIG01114283 Hypothetical protein SPy1656 +FIG01114284 FIG01114286: hypothetical protein +FIG01114286 FIG01114287: hypothetical protein +FIG01114287 FIG01114288: hypothetical protein +FIG01114292 FIG01114293: hypothetical protein +FIG01114293 FIG01114296: hypothetical protein +FIG01114296 FIG01114299: hypothetical protein +FIG01114299 FIG01114302: hypothetical protein +FIG01114303 FIG01114304: hypothetical protein +FIG01114304 FIG01114305: hypothetical protein +FIG01114305 Glutamate transport ATP-binding protein +FIG01114306 hypothetical protein +FIG01114308 FIG01114309: hypothetical protein +FIG01114309 COG4529 +FIG01114311 BOX elements +FIG01114313 FIG01197404: hypothetical protein +FIG01114316 FIG01114317: hypothetical protein +FIG01114317 FIG01114318: hypothetical protein +FIG01114318 FIG01114320: hypothetical protein +FIG01114320 FIG01114322: hypothetical protein +FIG01114322 FIG01114323: hypothetical protein +FIG01114323 FIG01114324: hypothetical protein +FIG01114325 3'->5' exoribonuclease Bsu YhaM +FIG01114326 FIG01114328: hypothetical protein +FIG01114328 FIG01114329: hypothetical protein +FIG01114330 FIG01114332: hypothetical protein +FIG01114332 FIG01114333: hypothetical protein +FIG01114333 FIG01114335: hypothetical protein +FIG01114335 FIG01114336: hypothetical protein +FIG01114336 conserved hypothetical protein - phage associated +FIG01114338 FIG01115666: hypothetical protein +FIG01114339 FIG01114340: hypothetical protein +FIG01114340 FIG01114175: hypothetical protein +FIG01114344 tRNA-dependent lipid II--L-alanine ligase @ tRNA-dependent lipid II--L-serine ligase +FIG01114345 FIG01114346: hypothetical protein +FIG01114347 FIG01114348: hypothetical protein +FIG01114348 FIG01114350: hypothetical protein +FIG01114351 FIG01114354: hypothetical protein +FIG01114354 ABC transporter ATP-binding protein YydI +FIG01114355 FIG01114356: hypothetical protein +FIG01114360 FIG01114361: hypothetical protein +FIG01114363 Accessory gene regulator protein C +FIG01114367 Phage transcriptional regulator, Cro/CI family +FIG01114368 Mycobacterial persistence regulator MprA (Two component response transcriptional regulatory protein) +FIG01114370 tRNA-dependent lipid II-Ala--L-alanine ligase @ tRNA-dependent lipid II-Ser--L-alanine ligase +FIG01114372 FIG01114373: hypothetical protein +FIG01114373 FIG01114374: hypothetical protein +FIG01114374 possible permease +FIG01114376 FIG01114377: hypothetical protein +FIG01114377 FIG01114378: hypothetical protein +FIG01114378 Integral membrane protein, putative +FIG01114379 FIG01114380: hypothetical protein +FIG01114380 FIG01114382: hypothetical protein +FIG01114382 FIG01114383: hypothetical protein +FIG01114383 FIG01114384: hypothetical protein +FIG01114384 Trans-acting positive regulator +FIG01114388 FIG01114389: hypothetical protein +FIG01114397 FIG01114398: hypothetical protein +FIG01114398 FIG01114400: hypothetical protein +FIG01114401 pneumococcal histidine triad protein B +FIG01114405 FIG01114407: hypothetical protein +FIG01114408 FIG01114410: hypothetical protein +FIG01114410 FIG01114411: hypothetical protein +FIG01114411 FIG01114412: hypothetical protein +FIG01114418 FIG01114419: hypothetical protein +FIG01114421 FIG01114422: hypothetical protein +FIG01114422 FIG01114423: hypothetical protein +FIG01114425 FIG01114426: hypothetical protein +FIG01114427 FIG01114428: hypothetical protein +FIG01114431 FIG01114432: hypothetical protein +FIG01114432 FIG01114433: hypothetical protein +FIG01114433 hypothetical protein +FIG01114435 FIG01114436: hypothetical protein +FIG01114436 FIG01114438: possible membrane protein +FIG01114439 FIG01114441: hypothetical protein +FIG01114446 FIG01114447: hypothetical protein +FIG01114447 FIG01114448: hypothetical protein +FIG01114452 FIG01114453: hypothetical protein +FIG01114456 FIG01114458: hypothetical protein +FIG01114458 FIG01114460: hypothetical protein +FIG01114460 putative autolysin; amidase +FIG01114463 FIG01114465: hypothetical protein +FIG01114465 FIG01114466: hypothetical protein +FIG01114466 FIG01114467: hypothetical protein +FIG01114467 FIG01114468: hypothetical protein +FIG01114469 FIG01114473: hypothetical protein +FIG01114473 hypothetical protein +FIG01114475 FIG01114476: hypothetical protein +FIG01114476 FIG01114477: hypothetical protein +FIG01114477 FIG01114479: hypothetical protein +FIG01114479 FIG01114480: hypothetical protein +FIG01114481 Capsular polysaccharide biosynthesis protein Cps4E +FIG01114484 FIG01114485: hypothetical protein +FIG01114485 FIG01114487: hypothetical protein +FIG01114487 FIG01114490: hypothetical protein +FIG01114491 FIG01114492: hypothetical protein +FIG01114492 FIG01114494: hypothetical protein +FIG01114494 FIG01114496: hypothetical protein +FIG01114496 FIG01114497: hypothetical protein +FIG01114498 FIG01114499: hypothetical protein +FIG01114499 Unknown +FIG01114500 FIG01114501: hypothetical protein +FIG01114501 FIG01114502: hypothetical protein +FIG01114502 FIG01114503: hypothetical protein +FIG01114506 FIG01114509: hypothetical protein +FIG01114513 FIG01114514: hypothetical protein +FIG01114514 FIG01114515: hypothetical protein +FIG01114515 FIG01114516: hypothetical protein +FIG01114517 FIG01114518: hypothetical protein +FIG01114520 FIG01107939: hypothetical protein +FIG01114522 FIG01114523: hypothetical protein +FIG01114523 FIG01114524: hypothetical protein +FIG01114524 FIG01114525: hypothetical protein +FIG01114525 IgA1 protease (EC 3.4.24.13) +FIG01114527 FIG01114528: hypothetical protein +FIG01114528 putative replication protein +FIG01114529 FIG01114530: hypothetical protein +FIG01114530 FIG01114532: hypothetical protein +FIG01114532 FIG01114534: hypothetical protein +FIG01114534 FIG01114535: hypothetical protein +FIG01114535 signal peptide containing protein +FIG01114539 FIG01114292: hypothetical protein +FIG01114546 FIG01114547: hypothetical protein +FIG01114547 FIG01114548: hypothetical protein +FIG01114548 FIG01114549: hypothetical protein +FIG01114549 FIG01114553: hypothetical protein +FIG01114553 FIG01114554: hypothetical protein +FIG01114554 FIG01114555: hypothetical protein +FIG01114556 FIG01114557: hypothetical protein +FIG01114561 FIG01114562: hypothetical protein +FIG01114562 FIG01114563: hypothetical protein +FIG01114563 FIG01114564: hypothetical protein +FIG01114569 FIG01114570: hypothetical protein +FIG01114571 FIG01114573: hypothetical protein +FIG01114575 FIG01114576: hypothetical protein +FIG01114576 FIG01114577: hypothetical protein +FIG01114579 FIG01114580: hypothetical protein +FIG01114580 lactococcin 972 family bacteriocin +FIG01114583 FIG01114584: hypothetical protein +FIG01114584 hypothetical protein +FIG01114586 FIG01114587: hypothetical protein +FIG01114587 FIG01114588: hypothetical protein +FIG01114588 FIG01114589: hypothetical protein +FIG01114590 FIG01114591: hypothetical protein +FIG01114591 hypothetical protein +FIG01114592 hypothetical protein +FIG01114597 FIG01114598: hypothetical protein +FIG01114598 FIG01114599: hypothetical protein +FIG01114599 FIG01114600: hypothetical protein +FIG01114603 FIG01114604: hypothetical protein +FIG01114604 FIG01114605: hypothetical protein +FIG01114605 FIG01114606: hypothetical protein +FIG01114607 FIG01114608: hypothetical protein +FIG01114609 FIG01114610: hypothetical protein +FIG01114610 hypothetical protein +FIG01114611 FIG01114189: hypothetical protein +FIG01114612 FIG01114613: hypothetical protein +FIG01114613 FIG01114614: hypothetical protein +FIG01114617 putative transport accessory protein +FIG01114621 FIG01114622: hypothetical protein +FIG01114625 FIG01114627: hypothetical protein +FIG01114627 FIG01114628: hypothetical protein +FIG01114629 FIG01117806: hypothetical protein +FIG01114631 FIG01114632: hypothetical protein +FIG01114632 FIG01114633: hypothetical protein +FIG01114633 FIG01114634: hypothetical protein +FIG01114635 FIG01114638: hypothetical protein +FIG01114639 FIG01114640: hypothetical protein +FIG01114640 FIG01114641: hypothetical protein +FIG01114641 FIG01114642: hypothetical protein +FIG01114643 FIG01114646: hypothetical protein +FIG01114653 Choline binding protein J +FIG01114655 FIG01114656: hypothetical protein +FIG01114656 FIG01114657: hypothetical protein +FIG01114657 FIG01114659: hypothetical protein +FIG01114659 FIG01114660: hypothetical protein +FIG01114660 FIG01114662: hypothetical protein +FIG01114662 FIG01114663: hypothetical protein +FIG01114665 FIG01114666: hypothetical protein +FIG01114667 FIG01114669: hypothetical protein +FIG01114675 FIG01114676: hypothetical protein +FIG01114676 FIG01114677: hypothetical protein +FIG01114677 FIG01114678: hypothetical protein +FIG01114680 Peptide ABC transporter ATP binding/permease protein +FIG01114684 FIG01114685: hypothetical protein +FIG01114685 FIG01114686: hypothetical protein +FIG01114686 FIG01114689: hypothetical protein +FIG01114694 FIG01114695: hypothetical protein +FIG01114695 FIG01114697: hypothetical protein +FIG01114697 FIG01114698: hypothetical protein +FIG01114700 FIG01114702: hypothetical protein +FIG01114704 FIG01114705: hypothetical protein +FIG01114705 FIG01114706: hypothetical protein +FIG01114706 FIG01114707: hypothetical protein +FIG01114707 Phage transcriptional regulator +FIG01114709 FIG01114710: hypothetical protein +FIG01114712 FIG01114713: hypothetical protein +FIG01114713 FIG01114714: hypothetical protein +FIG01114714 FIG01114715: hypothetical protein +FIG01114715 FIG01114716: hypothetical protein +FIG01114716 FIG01114717: hypothetical protein +FIG01114717 FIG01114719: hypothetical protein +FIG01114720 FIG01114721: hypothetical protein +FIG01114724 FIG01114725: hypothetical protein +FIG01114728 FIG01114729: hypothetical protein +FIG01114729 FIG01114731: hypothetical protein +FIG01114731 FIG01114733: hypothetical protein +FIG01114735 FIG01114736: hypothetical protein +FIG01114736 FIG01114737: hypothetical protein +FIG01114737 hypothetical protein +FIG01114740 FIG01114743: hypothetical protein +FIG01114743 FIG01114744: hypothetical protein +FIG01114746 VanZF-related protein +FIG01114748 FIG01114750: hypothetical protein +FIG01114753 FIG01114754: hypothetical protein +FIG01114754 CRISPR-associated protein, Csn2 family +FIG01114758 FIG01114759: hypothetical protein +FIG01114759 FIG01114762: hypothetical protein +FIG01114762 FIG01114764: hypothetical protein +FIG01114764 FIG01114765: hypothetical protein +FIG01114765 FIG01114766: hypothetical protein +FIG01114766 FIG01114767: hypothetical protein +FIG01114768 FIG01114770: hypothetical protein +FIG01114770 FIG01114771: hypothetical protein +FIG01114771 FIG01114772: hypothetical protein +FIG01114780 FIG01114781: hypothetical protein +FIG01114793 DNA-binding response regulator, AraC family +FIG01114794 FIG01114795: hypothetical protein +FIG01114796 hypothetical protein +FIG01114797 FIG01114800: hypothetical protein +FIG01114800 FIG01114801: hypothetical protein +FIG01114801 FIG01114802: hypothetical protein +FIG01114802 FIG01114803: hypothetical protein +FIG01114803 FIG01114804: hypothetical protein +FIG01114804 FIG01114806: hypothetical protein +FIG01114806 N-ethylammeline chlorohydrolase +FIG01114810 FIG01114811: hypothetical protein +FIG01114811 FIG01114812: hypothetical protein +FIG01114812 Phage CI-like repressor +FIG01114813 FIG01114815: hypothetical protein +FIG01114815 FIG01114816: hypothetical protein +FIG01114816 FIG01114817: hypothetical protein +FIG01114817 FIG01114818: hypothetical protein +FIG01114823 FIG01114830: hypothetical protein +FIG01114832 FIG01114833: hypothetical protein +FIG01114834 FIG01114835: hypothetical protein +FIG01114837 FIG01114840: hypothetical protein +FIG01114844 FIG01114845: hypothetical protein +FIG01114845 FIG01114846: hypothetical protein +FIG01114849 FIG01114850: hypothetical protein +FIG01114851 FIG01114852: hypothetical protein +FIG01114852 FIG01114855: hypothetical protein +FIG01114855 FIG01114857: hypothetical protein +FIG01114858 FIG01114860: hypothetical protein +FIG01114860 FIG01114861: hypothetical protein +FIG01114864 FIG01114865: hypothetical protein +FIG01114865 putative role in replication +FIG01114871 FIG01114872: hypothetical protein +FIG01114873 FIG01114875: hypothetical protein +FIG01114875 FIG01114876: hypothetical protein +FIG01114878 FIG01114879: hypothetical protein +FIG01114879 FIG01114881: hypothetical protein +FIG01114881 FIG01114882: hypothetical protein +FIG01114886 FIG01114887: hypothetical protein +FIG01114887 FIG01114888: hypothetical protein +FIG01114888 FIG01114889: hypothetical protein +FIG01114890 FIG01114891: hypothetical protein +FIG01114892 FIG01116135: hypothetical protein +FIG01114894 FIG01114895: hypothetical protein +FIG01114895 FIG01114898: hypothetical protein +FIG01114898 FIG01114899: hypothetical protein +FIG01114899 FIG01114900: hypothetical protein +FIG01114901 FIG01114903: hypothetical protein +FIG01114903 FIG01114904: hypothetical protein +FIG01114904 FIG01114905: hypothetical protein +FIG01114905 FIG01114906: hypothetical protein +FIG01114906 FIG01114907: hypothetical protein +FIG01114907 conserved hypothetical, predicted membrane protein (TMS5) +FIG01114910 FIG01114912: hypothetical protein +FIG01114912 hypothetical protein +FIG01114913 peptidase, U32 family small subunit [C1] +FIG01114915 FIG01114918: hypothetical protein +FIG01114918 FIG01114919: hypothetical protein +FIG01114919 FIG01114920: hypothetical protein +FIG01114920 FIG01114921: hypothetical protein +FIG01114921 FIG01114922: hypothetical protein +FIG01114924 hypothetical protein +FIG01114926 FIG01114927: hypothetical protein +FIG01114929 FIG01114930: hypothetical protein +FIG01114932 FIG01114933: hypothetical protein +FIG01114933 Metal-dependent hydrolase (EC 3.-.-.-) +FIG01114934 putative membrane protein +FIG01114936 FIG01114937: hypothetical protein +FIG01114939 FIG01114940: hypothetical protein +FIG01114940 FIG01114941: hypothetical protein +FIG01114944 FIG01114945: hypothetical protein +FIG01114946 FIG01114947: hypothetical protein +FIG01114947 FIG01114948: hypothetical protein +FIG01114948 FIG01114949: hypothetical protein +FIG01114949 FIG01114950: hypothetical protein +FIG01114955 FIG01114959: hypothetical protein +FIG01114959 FIG01114961: hypothetical protein +FIG01114961 Histone acetyltransferase Gcn5 +FIG01114962 FIG01114963: hypothetical protein +FIG01114963 FIG01114964: hypothetical protein +FIG01114964 FIG01114965: hypothetical protein +FIG01114965 FIG01114966: hypothetical protein +FIG01114969 FIG01114970: hypothetical protein +FIG01114971 FIG01114972: hypothetical protein +FIG01114986 FtsK protein +FIG01114988 FIG01114989: hypothetical protein +FIG01114990 FIG01114991: hypothetical protein +FIG01114993 Type II restriction enzyme MjaIII (EC 3.1.21.4) +FIG01114997 Putative repressor protein-phage associated +FIG01114999 FIG01115000: hypothetical protein +FIG01115001 FIG01115002: hypothetical protein +FIG01115004 FIG01115005: hypothetical protein +FIG01115005 Toxin to DNA-damage-inducible protein J +FIG01115010 FIG01115012: hypothetical protein +FIG01115014 FIG01115015: hypothetical protein +FIG01115015 transposase (12) BH0978 +FIG01115020 FIG01115021: hypothetical protein +FIG01115024 FIG01115025: hypothetical protein +FIG01115026 FIG01115027: hypothetical protein +FIG01115027 hypothetical protein +FIG01115030 FIG01115032: hypothetical protein +FIG01115032 FIG01115034: hypothetical protein +FIG01115034 FIG01115037: hypothetical protein +FIG01115037 FIG01115038: hypothetical protein +FIG01115038 FIG01115039: hypothetical protein +FIG01115042 FIG01115043: hypothetical protein +FIG01115045 membrane protein, related to Actinobacillus protein (1944168) +FIG01115048 FIG01115049: hypothetical protein +FIG01115049 FIG01115050: hypothetical protein +FIG01115050 N-ethylammeline chlorohydrolase +FIG01115051 FIG01115053: hypothetical protein +FIG01115054 FIG01115055: hypothetical protein +FIG01115058 FIG01115059: hypothetical protein +FIG01115059 FIG01115060: hypothetical protein +FIG01115062 FIG01115063: hypothetical protein +FIG01115069 FIG01115071: hypothetical protein +FIG01115073 FIG01115074: hypothetical protein +FIG01115074 putative toxic anion resistance protein +FIG01115076 Erythrocyte binding protein 2 +FIG01115077 hypothetical protein +FIG01115078 hypothetical protein +FIG01115082 FIG01115083: hypothetical protein +FIG01115089 FIG01115091: hypothetical protein +FIG01115091 NTP-binding protein +FIG01115092 Predicted divalent heavy-metal cations transporter +FIG01115093 FIG01115095: hypothetical protein +FIG01115096 FIG01115097: hypothetical protein +FIG01115097 FIG01115098: hypothetical protein +FIG01115098 FIG01115099: hypothetical protein +FIG01115099 FIG01115101: hypothetical protein +FIG01115101 FIG01115102: hypothetical protein +FIG01115103 FIG01115104: hypothetical protein +FIG01115104 FIG01115105: hypothetical protein +FIG01115106 FIG01115107: hypothetical protein +FIG01115108 FIG01115109: hypothetical protein +FIG01115109 FIG01115110: hypothetical protein +FIG01115112 FIG01115113: hypothetical protein +FIG01115113 FIG01115114: hypothetical protein +FIG01115114 hypothetical protein - phage associated +FIG01115115 FIG01115117: hypothetical protein +FIG01115117 FIG01115118: hypothetical protein +FIG01115118 FIG01115119: hypothetical protein +FIG01115119 FIG01115120: hypothetical protein +FIG01115120 FIG01115121: hypothetical protein +FIG01115121 FIG01115122: hypothetical protein +FIG01115122 Predicted metal-dependent membrane protease +FIG01115123 FIG01116743: hypothetical protein +FIG01115127 FIG021474: Phage protein +FIG01115128 FIG01115130: hypothetical protein +FIG01115130 Phage-associated HNH homing endonuclease +FIG01115132 N-ethylammeline chlorohydrolase +FIG01115135 FIG01115136: hypothetical protein +FIG01115138 FIG01115139: hypothetical protein +FIG01115139 Conserved domain protein +FIG01115140 FIG01115141: hypothetical protein +FIG01115141 FIG01115144: hypothetical protein +FIG01115144 FIG01115145: hypothetical protein +FIG01115145 FIG01115146: hypothetical protein +FIG01115146 FIG01115147: hypothetical protein +FIG01115149 FIG01115151: hypothetical protein +FIG01115152 FIG01115153: hypothetical protein +FIG01115154 FIG01115155: hypothetical protein +FIG01115155 FIG01115158: hypothetical protein +FIG01115158 FIG01115161: hypothetical protein +FIG01115163 FIG01115164: hypothetical protein +FIG01115164 Surface protein from Gram-positive cocci, anchor region +FIG01115168 FIG01115169: hypothetical protein +FIG01115169 hypothetical protein +FIG01115174 FIG01115175: hypothetical protein +FIG01115176 FIG01115180: hypothetical protein +FIG01115180 FIG01115181: hypothetical protein +FIG01115181 FIG01115182: hypothetical protein +FIG01115188 FIG01115190: hypothetical protein +FIG01115190 FIG01115195: hypothetical protein +FIG01115195 FIG01115198: hypothetical protein +FIG01115200 Mannitol operon activator, BglG family +FIG01115208 FIG01115209: hypothetical protein +FIG01115209 FIG01115210: hypothetical protein +FIG01115210 FIG01115211: hypothetical protein +FIG01115211 FIG01115213: hypothetical protein +FIG01115215 FIG01115216: hypothetical protein +FIG01115218 FIG01115219: hypothetical protein +FIG01115225 FIG01115226: hypothetical protein +FIG01115229 SAM-dependent methyltransferase +FIG01115230 hypothetical protein +FIG01115233 FIG01115235: hypothetical protein +FIG01115235 FIG01115236: hypothetical protein +FIG01115239 FIG01115240: hypothetical protein +FIG01115244 hypothetical protein +FIG01115245 FIG01115247: hypothetical protein +FIG01115247 FIG01115248: hypothetical protein +FIG01115250 FIG01115251: hypothetical protein +FIG01115255 FIG01115256: hypothetical protein +FIG01115256 FIG01115257: hypothetical protein +FIG01115257 FIG01115258: hypothetical protein +FIG01115259 hypothetical protein +FIG01115261 Degenerate integrase +FIG01115262 FIG01115263: hypothetical protein +FIG01115263 FIG01115264: hypothetical protein +FIG01115264 FIG01115265: hypothetical protein +FIG01115267 FIG01115268: hypothetical protein +FIG01115268 FIG01115270: hypothetical protein +FIG01115271 YitT family protein +FIG01115275 FIG01115278: hypothetical protein +FIG01115278 FIG01115279: hypothetical protein +FIG01115280 FIG01115281: hypothetical protein +FIG01115286 FIG01115287: hypothetical protein +FIG01115287 FIG01115288: hypothetical protein +FIG01115288 FIG01115289: hypothetical protein +FIG01115289 FIG01115290: hypothetical protein +FIG01115291 FIG01115292: hypothetical protein +FIG01115292 FIG01115294: hypothetical protein +FIG01115294 FIG01115296: hypothetical protein +FIG01115296 FIG01115297: hypothetical protein +FIG01115297 FIG01115299: hypothetical protein +FIG01115300 FIG01115301: hypothetical protein +FIG01115304 FIG01115305: hypothetical protein +FIG01115306 Levansucrase precursor (EC 2.4.1.10) +FIG01115307 FIG01115309: hypothetical protein +FIG01115313 FIG01115314: hypothetical protein +FIG01115315 FIG01115319: hypothetical protein +FIG01115319 FIG01115320: hypothetical protein +FIG01115322 FIG01115324: hypothetical protein +FIG01115324 FIG01115325: hypothetical protein +FIG01115325 FIG01115329: hypothetical protein +FIG01115330 FIG01115331: hypothetical protein +FIG01115331 FIG01115332: hypothetical protein +FIG01115333 FIG01115302: hypothetical protein +FIG01115334 FIG01115335: hypothetical protein +FIG01115335 FIG01115339: hypothetical protein +FIG01115339 ABC transporter substrate-binding protein +FIG01115340 FIG01115343: hypothetical protein +FIG01115345 FIG01115348: hypothetical protein +FIG01115349 FIG01115352: hypothetical protein +FIG01115354 FIG01115355: hypothetical protein +FIG01115355 FIG01115356: hypothetical protein +FIG01115356 acetyltransferase, GNAT family protein +FIG01115358 FIG01115359: hypothetical protein +FIG01115363 FIG01115364: hypothetical protein +FIG01115364 Zn-dependent alcohol dehydrogenases and related dehydrogenases +FIG01115370 FIG01115371: hypothetical protein +FIG01115373 FIG01115377: hypothetical protein +FIG01115382 FIG01115385: hypothetical protein +FIG01115385 FIG01115386: hypothetical protein +FIG01115389 FIG01115392: hypothetical protein +FIG01115394 FIG01115395: hypothetical protein +FIG01115395 FIG01115398: hypothetical protein +FIG01115398 FIG01115401: hypothetical protein +FIG01115401 FIG01115402: hypothetical protein +FIG01115402 FIG01115406: hypothetical protein +FIG01115408 FIG01115409: hypothetical protein +FIG01115409 FIG01115410: hypothetical protein +FIG01115410 FIG01115411: hypothetical protein +FIG01115411 FIG01115412: hypothetical protein +FIG01115414 FIG01115415: hypothetical protein +FIG01115415 FIG01115416: hypothetical protein +FIG01115416 FIG01115417: hypothetical protein +FIG01115417 FIG01115418: hypothetical protein +FIG01115419 FIG01115421: hypothetical protein +FIG01115421 FIG01115424: hypothetical protein +FIG01115426 FIG01115427: hypothetical protein +FIG01115428 FIG01115429: hypothetical protein +FIG01115429 FIG01115430: hypothetical protein +FIG01115430 FIG01115432: hypothetical protein +FIG01115435 FIG01115436: hypothetical protein +FIG01115436 FIG01115437: hypothetical protein +FIG01115438 FIG01115440: hypothetical protein +FIG01115443 hypothetical protein +FIG01115444 FIG01115448: hypothetical protein +FIG01115448 FIG01115449: hypothetical protein +FIG01115450 FIG01115451: hypothetical protein +FIG01115451 FIG01115455: hypothetical protein +FIG01115455 FIG01115460: hypothetical protein +FIG01115460 FIG01115461: hypothetical protein +FIG01115461 FIG01115463: hypothetical protein +FIG01115463 FIG01115464: hypothetical protein +FIG01115464 FIG01115465: hypothetical protein +FIG01115465 FIG01115466: hypothetical protein +FIG01115467 FIG01115469: hypothetical protein +FIG01115472 hypothetical protein +FIG01115473 FIG01115476: hypothetical protein +FIG01115476 FIG01115477: hypothetical protein +FIG01115478 FIG01115479: hypothetical protein +FIG01115479 ABC transporter, truncation +FIG01115480 FIG01115481: hypothetical protein +FIG01115485 hypothetical protein +FIG01115488 FIG01115489: hypothetical protein +FIG01115494 FIG01115495: hypothetical protein +FIG01115497 FIG01115498: hypothetical protein +FIG01115499 FIG01115500: hypothetical protein +FIG01115500 FIG01115501: hypothetical protein +FIG01115501 FIG01115503: hypothetical protein +FIG01115504 FIG01115506: hypothetical protein +FIG01115506 FIG01115507: hypothetical protein +FIG01115507 FIG01115510: hypothetical protein +FIG01115510 hypothetical protein +FIG01115515 FIG01115516: hypothetical protein +FIG01115516 FIG01115520: hypothetical protein +FIG01115520 FIG01115523: hypothetical protein +FIG01115525 hypothetical protein +FIG01115527 FIG01115528: hypothetical protein +FIG01115528 FIG01115530: hypothetical protein +FIG01115530 FIG01115531: hypothetical protein +FIG01115531 FIG01115532: hypothetical protein +FIG01115534 FIG01115536: hypothetical protein +FIG01115537 FIG01115538: hypothetical protein +FIG01115538 FIG01115539: hypothetical protein +FIG01115545 FIG01115549: hypothetical protein +FIG01115550 FIG01115553: hypothetical protein +FIG01115554 FIG01115561: hypothetical protein +FIG01115562 hypothetical protein +FIG01115563 FIG01115565: hypothetical protein +FIG01115570 FIG01115573: hypothetical protein +FIG01115573 Unknown +FIG01115574 FIG01115575: hypothetical protein +FIG01115575 Phage excisionase +FIG01115577 FIG01115581: hypothetical protein +FIG01115584 FIG01115585: hypothetical protein +FIG01115586 FIG01115587: hypothetical protein +FIG01115587 Streptococcal inhibitor of complement (SIC) +FIG01115591 3-demethylubiquinone-9 3-methyltransferase +FIG01115592 FIG01115594: hypothetical protein +FIG01115596 FIG01115597: hypothetical protein +FIG01115608 hypothetical protein +FIG01115609 FIG01115610: hypothetical protein +FIG01115612 FIG01115613: hypothetical protein +FIG01115613 FIG01115614: hypothetical protein +FIG01115614 FIG01115616: hypothetical protein +FIG01115616 FIG01115617: hypothetical protein +FIG01115621 FIG01115625: hypothetical protein +FIG01115625 FIG01115627: hypothetical protein +FIG01115630 FIG01115631: hypothetical protein +FIG01115631 FIG01115632: hypothetical protein +FIG01115634 FIG01115635: hypothetical protein +FIG01115635 FIG01115637: hypothetical protein +FIG01115637 FIG01115638: hypothetical protein +FIG01115638 FIG01115642: hypothetical protein +FIG01115647 FIG01115648: hypothetical protein +FIG01115653 FIG01115656: hypothetical protein +FIG01115656 putative sensor histidine kinase +FIG01115659 FIG01115660: hypothetical protein +FIG01115666 FIG01115667: hypothetical protein +FIG01115667 FIG01115668: hypothetical protein +FIG01115668 FIG01115672: hypothetical protein +FIG01115677 FIG01115678: hypothetical protein +FIG01115684 FIG01115686: hypothetical protein +FIG01115686 FIG01115688: hypothetical protein +FIG01115688 FIG01115689: hypothetical protein +FIG01115691 FIG01115693: hypothetical protein +FIG01115693 FIG01115695: hypothetical protein +FIG01115695 hypothetical protein +FIG01115698 PTS cellobiose-specific IIC component +FIG01115700 FIG01115701: hypothetical protein +FIG01115701 FIG01115703: hypothetical protein +FIG01115703 FIG01115704: hypothetical protein +FIG01115705 FIG01115706: hypothetical protein +FIG01115706 FIG01115708: hypothetical protein +FIG01115708 DNA helicase, phage-associated +FIG01115709 FIG01115710: hypothetical protein +FIG01115711 FIG01115853: hypothetical protein +FIG01115715 FIG01115716: hypothetical protein +FIG01115716 FIG01115717: hypothetical protein +FIG01115720 FIG01115722: hypothetical protein +FIG01115723 FIG01115725: hypothetical protein +FIG01115725 FIG01115726: hypothetical protein +FIG01115727 Polysaccharide biosynthesis protein CpsH(V) +FIG01115728 FIG01115729: hypothetical protein +FIG01115739 FIG01115740: hypothetical protein +FIG01115740 FIG01115741: hypothetical protein +FIG01115744 FIG01115745: hypothetical protein +FIG01115748 FIG01115752: hypothetical protein +FIG01115752 FIG01115755: hypothetical protein +FIG01115755 hypothetical protein +FIG01115756 FIG01115760: hypothetical protein +FIG01115760 Terminase large subunit +FIG01115761 Membrane spanning protein +FIG01115763 FIG01115766: hypothetical protein +FIG01115766 FIG01115767: hypothetical protein +FIG01115767 FIG01115768: hypothetical protein +FIG01115768 FIG01115771: hypothetical protein +FIG01115771 FIG01115772: hypothetical protein +FIG01115772 FIG01115774: hypothetical protein +FIG01115774 Transcriptional regulator, Cro/CI family +FIG01115776 FIG01115777: hypothetical protein +FIG01115777 FIG01115779: hypothetical protein +FIG01115779 FIG01115781: hypothetical protein +FIG01115781 FIG01115782: hypothetical protein +FIG01115784 FIG01115786: hypothetical protein +FIG01115786 FIG01115789: hypothetical protein +FIG01115790 FIG01115793: hypothetical protein +FIG01115795 FIG01115797: hypothetical protein +FIG01115797 FIG01115799: hypothetical protein +FIG01115814 FIG01115816: hypothetical protein +FIG01115816 FIG01115818: hypothetical protein +FIG01115820 Rep protein +FIG01115821 FIG01115822: hypothetical protein +FIG01115822 FIG01115823: hypothetical protein +FIG01115823 FIG01115824: hypothetical protein +FIG01115824 FIG01115825: hypothetical protein +FIG01115825 FIG01115826: hypothetical protein +FIG01115826 FIG01115829: hypothetical protein +FIG01115829 FIG01115830: hypothetical protein +FIG01115833 hypothetical protein +FIG01115835 FIG01115839: hypothetical protein +FIG01115839 FIG01115840: hypothetical protein +FIG01115840 FIG01115841: hypothetical protein +FIG01115856 ABC transporter permease protein +FIG01115858 FIG01115859: hypothetical protein +FIG01115859 FIG01115860: hypothetical protein +FIG01115861 FIG01115862: hypothetical protein +FIG01115862 FIG01115863: hypothetical protein +FIG01115863 FIG01115864: hypothetical protein +FIG01115868 FIG01115870: hypothetical protein +FIG01115870 FIG01115872: hypothetical protein +FIG01115886 FIG01115891: hypothetical protein +FIG01115891 hypothetical protein +FIG01115893 FIG01115894: hypothetical protein +FIG01115895 hypothetical protein +FIG01115896 FIG01115897: hypothetical protein +FIG01115897 Amino acid ABC transporter, ATP-binding protein +FIG01115901 FIG01115902: hypothetical protein +FIG01115902 FIG01115904: hypothetical protein +FIG01115912 FIG01115913: hypothetical protein +FIG01115913 FIG01115914: hypothetical protein +FIG01115914 FIG01115915: hypothetical protein +FIG01115915 hypothetical protein +FIG01115916 Levansucrase precursor (EC 2.4.1.10) (Beta-D-fructofuranosyl transferase) (Sucrose 6-fructosyl transferase) +FIG01115918 FIG01115919: hypothetical protein +FIG01115919 hypothetical protein +FIG01115927 FIG01115928: hypothetical protein +FIG01115933 FIG01115934: hypothetical protein +FIG01115934 FIG01115935: hypothetical protein +FIG01115935 FIG01115936: hypothetical protein +FIG01115936 FIG01115938: hypothetical protein +FIG01115941 FIG01115942: hypothetical protein +FIG01115942 FIG01115945: hypothetical protein +FIG01115945 FIG01115948: hypothetical protein +FIG01115950 RelB/StbD replicon stabilization protein (antitoxin to RelE/StbE) +FIG01115953 FIG01115954: hypothetical protein +FIG01115956 FIG01115957: hypothetical protein +FIG01115957 FIG01115961: hypothetical protein +FIG01115971 FIG01115972: hypothetical protein +FIG01115972 Hypothetical protein spyM18_0155 +FIG01115973 FIG01115975: hypothetical protein +FIG01115977 FIG01115978: hypothetical protein +FIG01115979 FIG01115980: hypothetical protein +FIG01115980 FIG01115981: hypothetical protein +FIG01115981 FIG01115982: hypothetical protein +FIG01115982 FIG01115983: hypothetical protein +FIG01115985 FIG01115988: hypothetical protein +FIG01115988 FIG01115991: hypothetical protein +FIG01116001 ABC-type polysaccharide transport system, permease component +FIG01116003 FIG01116006: hypothetical protein +FIG01116013 FIG01116014: hypothetical protein +FIG01116014 FIG01116017: hypothetical protein +FIG01116018 FIG01116020: hypothetical protein +FIG01116023 hypothetical protein - phage associated +FIG01116024 FIG01116025: hypothetical protein +FIG01116025 FIG01116026: hypothetical protein +FIG01116026 FIG01116027: hypothetical protein +FIG01116029 FIG01116030: hypothetical protein +FIG01116030 FIG01116031: hypothetical protein +FIG01116033 FIG01116034: hypothetical protein +FIG01116034 FIG01116035: hypothetical protein +FIG01116036 FIG01116037: hypothetical protein +FIG01116045 FIG021300: Phage-associated protein +FIG01116048 FIG01116049: hypothetical protein +FIG01116049 FIG01116051: hypothetical protein +FIG01116056 FIG01116057: hypothetical protein +FIG01116057 FIG01116058: hypothetical protein +FIG01116058 FIG01116062: hypothetical protein +FIG01116063 FIG01116064: hypothetical protein +FIG01116064 FIG01116065: hypothetical protein +FIG01116069 FIG01116070: hypothetical protein +FIG01116070 FIG01116071: hypothetical protein +FIG01116071 FIG01116075: hypothetical protein +FIG01116076 FIG01116077: hypothetical protein +FIG01116078 FIG01116080: hypothetical protein +FIG01116080 FIG01116082: hypothetical protein +FIG01116082 FIG01116083: hypothetical protein +FIG01116087 FIG01116088: hypothetical protein +FIG01116088 FIG01116089: hypothetical protein +FIG01116091 FIG01116092: hypothetical protein +FIG01116092 FIG01116093: hypothetical protein +FIG01116099 FIG01116100: hypothetical protein +FIG01116100 FIG01116102: hypothetical protein +FIG01116102 FIG01116104: hypothetical protein +FIG01116104 FIG01116105: hypothetical protein +FIG01116106 FIG01116107: hypothetical protein +FIG01116107 FIG01116108: hypothetical protein +FIG01116108 FIG01116109: hypothetical protein +FIG01116110 FIG01116111: hypothetical protein +FIG01116113 FIG01116114: hypothetical protein +FIG01116122 Competence pheromone precursor +FIG01116125 FIG01116126: hypothetical protein +FIG01116126 FIG01116130: hypothetical protein +FIG01116132 hypothetical protein +FIG01116134 FIG01116135: hypothetical protein +FIG01116140 FIG01116141: hypothetical protein +FIG01116141 FIG01116145: hypothetical protein +FIG01116145 Beta-phosphoglucomutase (EC 5.4.2.6) (EC 2.7.1.41) +FIG01116146 FIG01116147: hypothetical protein +FIG01116147 FIG01116149: hypothetical protein +FIG01116149 FIG01116151: hypothetical protein +FIG01116152 FIG01116153: hypothetical protein +FIG01116156 FIG01116157: hypothetical protein +FIG01116161 FIG01116163: hypothetical protein +FIG01116169 FIG01116170: hypothetical protein +FIG01116171 FIG01116174: hypothetical protein +FIG01116174 FIG01116176: hypothetical protein +FIG01116176 phage protein +FIG01116177 FIG01116178: hypothetical protein +FIG01116181 FIG01116182: hypothetical protein +FIG01116183 FIG01116184: hypothetical protein +FIG01116184 FIG01116187: hypothetical protein +FIG01116187 FIG01116190: hypothetical protein +FIG01116194 FIG01116195: hypothetical protein +FIG01116195 FIG01116197: hypothetical protein +FIG01116197 FIG01116201: hypothetical protein +FIG01116203 FIG01116204: hypothetical protein +FIG01116208 FIG01116209: hypothetical protein +FIG01116214 FIG01116215: hypothetical protein +FIG01116220 FIG01116221: hypothetical protein +FIG01116221 FIG01116224: hypothetical protein +FIG01116224 FIG01116225: hypothetical protein +FIG01116225 site-specific recombinase (phage integrase family) +FIG01116234 FIG01116235: hypothetical protein +FIG01116235 FIG01116236: hypothetical protein +FIG01116242 FIG01116243: hypothetical protein +FIG01116245 FIG01116246: hypothetical protein +FIG01116246 FIG01116249: hypothetical protein +FIG01116249 FIG01116250: hypothetical protein +FIG01116250 FIG01116251: hypothetical protein +FIG01116251 FIG01116252: hypothetical protein +FIG01116253 FIG01116258: hypothetical protein +FIG01116258 Response regulator of the LytR/AlgR family +FIG01116262 FIG01116263: hypothetical protein +FIG01116263 hypothetical protein +FIG01116266 FIG01116268: hypothetical protein +FIG01116269 FIG01116271: hypothetical protein +FIG01116272 FIG01116274: hypothetical protein +FIG01116274 FIG01116276: hypothetical protein +FIG01116276 FIG01116278: hypothetical protein +FIG01116281 FIG01116282: hypothetical protein +FIG01116282 FIG01116283: hypothetical protein +FIG01116283 FIG01116284: hypothetical protein +FIG01116292 FIG01116294: hypothetical protein +FIG01116294 FIG01116295: hypothetical protein +FIG01116296 FIG01116297: hypothetical protein +FIG01116297 FIG01116299: hypothetical protein +FIG01116301 FIG01116302: hypothetical protein +FIG01116303 FIG01116305: hypothetical protein +FIG01116305 FIG01116306: hypothetical protein +FIG01116306 FIG01116307: hypothetical protein +FIG01116319 FIG01116320: hypothetical protein +FIG01116326 FIG01116327: hypothetical protein +FIG01116327 FIG01116328: hypothetical protein +FIG01116329 FIG01116330: hypothetical protein +FIG01116336 FIG01116337: hypothetical protein +FIG01116338 FIG01116340: hypothetical protein +FIG01116340 FIG01116341: hypothetical protein +FIG01116341 FIG01116343: hypothetical protein +FIG01116343 FIG01116344: hypothetical protein +FIG01116344 FIG01116346: hypothetical protein +FIG01116347 FIG01116348: hypothetical protein +FIG01116348 hypothetical protein +FIG01116351 hypothetical protein +FIG01116353 FIG01116354: hypothetical protein +FIG01116354 FIG01116356: hypothetical protein +FIG01116363 FIG01116364: hypothetical protein +FIG01116364 FIG01116367: hypothetical protein +FIG01116372 FIG01116375: hypothetical protein +FIG01116375 FIG01116376: hypothetical protein +FIG01116376 FIG01116377: hypothetical protein +FIG01116379 FIG01116380: hypothetical protein +FIG01116381 FIG01116382: hypothetical protein +FIG01116382 FIG01116383: hypothetical protein +FIG01116385 FIG01116388: hypothetical protein +FIG01116388 FIG01116389: hypothetical protein +FIG01116389 FIG01116391: hypothetical protein +FIG01116391 putative phage integrase +FIG01116394 FIG01116395: hypothetical protein +FIG01116402 FIG01116403: hypothetical protein +FIG01116406 FIG01116407: hypothetical protein +FIG01116408 FIG01116409: hypothetical protein +FIG01116409 FIG01116412: hypothetical protein +FIG01116412 FIG01116413: hypothetical protein +FIG01116413 FIG01116415: hypothetical protein +FIG01116415 FIG01116418: hypothetical protein +FIG01116418 FIG01116422: hypothetical protein +FIG01116423 FIG01116424: hypothetical protein +FIG01116424 ATP-dependent DNA helicase recG (EC 3.6.1.-) +FIG01116426 FIG01116427: hypothetical protein +FIG01116427 FIG01116429: hypothetical protein +FIG01116430 FIG01116431: hypothetical protein +FIG01116431 FIG01116432: hypothetical protein +FIG01116434 FIG01116435: hypothetical protein +FIG01116435 FIG01116439: hypothetical protein +FIG01116439 FIG01116440: hypothetical protein +FIG01116442 FIG01116444: hypothetical protein +FIG01116445 FIG01116446: hypothetical protein +FIG01116451 FIG01116453: hypothetical protein +FIG01116453 FIG01116454: hypothetical protein +FIG01116458 FIG01116459: hypothetical protein +FIG01116459 Permease, putative +FIG01116460 FIG01116461: hypothetical protein +FIG01116461 FIG01116462: hypothetical protein +FIG01116462 FIG01116463: hypothetical protein +FIG01116463 FIG01116465: hypothetical protein +FIG01116467 FIG01116469: hypothetical protein +FIG01116469 FIG01116470: hypothetical protein +FIG01116470 FIG01116471: hypothetical protein +FIG01116474 FIG01116476: hypothetical protein +FIG01116480 FIG01116481: hypothetical protein +FIG01116481 RRNA (Adenine-N(6)-) -methyltransferase (EC 2.1.1.48) +FIG01116482 FIG01116483: hypothetical protein +FIG01116488 FIG01116489: hypothetical protein +FIG01116491 FIG01116492: hypothetical protein +FIG01116492 FIG01116493: hypothetical protein +FIG01116493 FIG01116494: hypothetical protein +FIG01116499 FIG01116501: hypothetical protein +FIG01116501 FIG01116502: hypothetical protein +FIG01116504 FIG01116505: hypothetical protein +FIG01116505 FIG01116506: hypothetical protein +FIG01116508 Formate/nitrite transporter +FIG01116510 FIG01116511: hypothetical protein +FIG01116512 hypothetical protein +FIG01116513 FIG01116514: hypothetical protein +FIG01116518 FIG01116521: hypothetical protein +FIG01116521 FIG01116522: hypothetical protein +FIG01116522 FIG01116523: hypothetical protein +FIG01116529 FIG01116915: hypothetical protein +FIG01116531 FIG01116532: hypothetical protein +FIG01116533 FIG01116534: hypothetical protein +FIG01116535 FIG01116536: hypothetical protein +FIG01116539 FIG01116540: hypothetical protein +FIG01116540 FIG01116541: hypothetical protein +FIG01116541 FIG01116542: hypothetical protein +FIG01116542 Phosphotransferase system, mannose/fructose/N-acetylgalactosamine-specific component IIB +FIG01116543 FIG01116544: hypothetical protein +FIG01116544 FIG01116547: hypothetical protein +FIG01116549 FIG01116550: hypothetical protein +FIG01116550 FIG01116554: hypothetical protein +FIG01116554 FIG01116555: hypothetical protein +FIG01116555 FIG01116556: hypothetical protein +FIG01116562 FIG01116563: hypothetical protein +FIG01116563 FIG01116564: hypothetical protein +FIG01116564 FIG01116565: hypothetical protein +FIG01116570 FIG01116572: hypothetical protein +FIG01116572 FIG01116574: hypothetical protein +FIG01116574 FIG01116575: hypothetical protein +FIG01116577 two-component sensor histidine kinase +FIG01116578 FIG01116579: hypothetical protein +FIG01116579 FIG01116580: hypothetical protein +FIG01116580 FIG01116581: hypothetical protein +FIG01116582 hypothetical protein +FIG01116590 conserved hypothetical protein +FIG01116595 FIG01116596: hypothetical protein +FIG01116596 FIG01116600: hypothetical protein +FIG01116603 FIG01116604: hypothetical protein +FIG01116604 FIG01116605: hypothetical protein +FIG01116608 FIG01116611: hypothetical protein +FIG01116613 FIG01116616: hypothetical protein +FIG01116622 FIG01116623: hypothetical protein +FIG01116623 FIG01116624: hypothetical protein +FIG01116624 FIG01116625: hypothetical protein +FIG01116627 FIG01116628: hypothetical protein +FIG01116630 FIG01116631: hypothetical protein +FIG01116631 FIG01116633: hypothetical protein +FIG01116633 FIG01116634: hypothetical protein +FIG01116634 FIG01116635: hypothetical protein +FIG01116636 FIG01116638: hypothetical protein +FIG01116638 FIG01116639: hypothetical protein +FIG01116639 FIG01118442: hypothetical protein +FIG01116640 hypothetical protein +FIG01116645 FIG01116646: hypothetical protein +FIG01116646 FIG01116647: hypothetical protein +FIG01116652 FIG01116655: hypothetical protein +FIG01116655 FIG01116656: hypothetical protein +FIG01116657 FIG01116659: hypothetical protein +FIG01116659 FIG01116660: hypothetical protein +FIG01116660 FIG01116661: hypothetical protein +FIG01116662 Integrase +FIG01116664 FIG01116665: hypothetical protein +FIG01116665 FIG01116666: hypothetical protein +FIG01116666 FIG01116668: hypothetical protein +FIG01116668 FIG01116669: hypothetical protein +FIG01116669 FIG01116673: hypothetical protein +FIG01116673 FIG01116675: hypothetical protein +FIG01116675 FIG01116676: hypothetical protein +FIG01116681 FIG01116682: hypothetical protein +FIG01116682 FIG01116683: hypothetical protein +FIG01116683 FIG01116684: hypothetical protein +FIG01116684 FIG01116685: hypothetical protein +FIG01116686 FIG01116687: hypothetical protein +FIG01116694 FIG01116695: hypothetical protein +FIG01116695 FIG01116696: hypothetical protein +FIG01116696 FIG01116698: hypothetical protein +FIG01116698 FIG01116699: hypothetical protein +FIG01116705 FIG01116706: hypothetical protein +FIG01116713 FIG01116715: hypothetical protein +FIG01116717 FIG01116787: hypothetical protein +FIG01116723 FIG01116724: hypothetical protein +FIG01116731 FIG01116732: hypothetical protein +FIG01116732 FIG01116734: hypothetical protein +FIG01116734 FIG01116735: hypothetical protein +FIG01116737 FIG01116738: hypothetical protein +FIG01116738 FIG01116741: hypothetical protein +FIG01116741 Integrase +FIG01116743 FIG01116744: hypothetical protein +FIG01116745 FIG01116748: hypothetical protein +FIG01116754 hypothetical protein +FIG01116756 FIG01116757: hypothetical protein +FIG01116757 FIG01116760: hypothetical protein +FIG01116760 FIG01116761: hypothetical protein +FIG01116761 FIG01116763: hypothetical protein +FIG01116763 FIG01116764: hypothetical protein +FIG01116765 FIG01116766: hypothetical protein +FIG01116766 FIG01116767: hypothetical protein +FIG01116767 FIG01116769: hypothetical protein +FIG01116769 hypothetical protein +FIG01116777 FIG01116782: hypothetical protein +FIG01116782 FIG01116783: hypothetical protein +FIG01116783 FIG01116784: hypothetical protein +FIG01116789 FIG01116791: hypothetical protein +FIG01116791 FIG01116792: hypothetical protein +FIG01116792 FIG01116793: hypothetical protein +FIG01116793 FIG01116796: hypothetical protein +FIG01116796 FIG01116798: hypothetical protein +FIG01116798 FIG01116800: hypothetical protein +FIG01116801 FIG01116802: hypothetical protein +FIG01116804 FIG01116805: hypothetical protein +FIG01116805 Inducible Fructanase (EC 3.2.1.80), FruB +FIG01116806 Transporter, truncation +FIG01116808 hypothetical protein +FIG01116814 FIG01120124: hypothetical protein +FIG01116816 FIG01116817: hypothetical protein +FIG01116817 FIG01116818: hypothetical protein +FIG01116822 FIG01116823: hypothetical protein +FIG01116825 FIG01116832: hypothetical protein +FIG01116833 FIG01116834: hypothetical protein +FIG01116837 FIG01116838: hypothetical protein +FIG01116839 FIG01116840: hypothetical protein +FIG01116840 hypothetical protein - phage associated +FIG01116841 Conserved uncharacterized protein +FIG01116842 FIG01119268: hypothetical protein +FIG01116843 FIG01116850: hypothetical protein +FIG01116850 ABC transporter amino acid-binding protein +FIG01116852 FIG01116853: hypothetical protein +FIG01116857 hypothetical protein - phage associated +FIG01116859 FIG01116860: hypothetical protein +FIG01116864 FIG01116866: hypothetical protein +FIG01116867 FIG01116868: hypothetical protein +FIG01116868 FIG01116872: hypothetical protein +FIG01116872 choline binding protein D +FIG01116876 FIG01116881: hypothetical protein +FIG01116881 ketopantoate reductase PanE/ApbA superfamily protein +FIG01116883 FIG01116885: hypothetical protein +FIG01116885 FIG01116888: hypothetical protein +FIG01116888 FIG01116889: hypothetical protein +FIG01116890 hypothetical protein +FIG01116893 FIG01116894: hypothetical protein +FIG01116894 FIG01116895: hypothetical protein +FIG01116898 FIG01116899: hypothetical protein +FIG01116899 FIG01116901: hypothetical protein +FIG01116901 FIG01116902: hypothetical protein +FIG01116903 FIG01116905: hypothetical protein +FIG01116905 FIG01116906: hypothetical protein +FIG01116906 FIG01116907: hypothetical protein +FIG01116907 FIG01116909: hypothetical protein +FIG01116909 FIG01116910: hypothetical protein +FIG01116910 FIG01116911: hypothetical protein +FIG01116915 FIG01116922: hypothetical protein +FIG01116922 FIG01116923: hypothetical protein +FIG01116923 FIG01116924: hypothetical protein +FIG01116930 FIG01116932: hypothetical protein +FIG01116934 FIG01118889: hypothetical protein +FIG01116936 Transcriptional regulator, AraC family (arabinose operon control), putative +FIG01116939 FIG01116940: hypothetical protein +FIG01116940 FIG01116941: hypothetical protein +FIG01116941 FIG01116942: hypothetical protein +FIG01116942 FIG01116943: hypothetical protein +FIG01116944 FIG01116946: hypothetical protein +FIG01116946 FIG01116947: hypothetical protein +FIG01116950 FIG01116951: hypothetical protein +FIG01116951 FIG01116952: hypothetical protein +FIG01116953 FIG01116954: hypothetical protein +FIG01116956 FIG01116957: hypothetical protein +FIG01116960 FIG01116964: hypothetical protein +FIG01116964 FIG01116966: hypothetical protein +FIG01116966 FIG01116967: hypothetical protein +FIG01116969 cylB protein +FIG01116971 FIG01116974: hypothetical protein +FIG01116974 FIG01116975: hypothetical protein +FIG01116975 FIG01116976: hypothetical protein +FIG01116976 FIG01116978: hypothetical protein +FIG01116978 FIG01116979: hypothetical protein +FIG01116979 FIG01116981: hypothetical protein +FIG01116982 FIG01116984: hypothetical protein +FIG01116984 FIG01116985: hypothetical protein +FIG01116985 FIG01116986: hypothetical protein +FIG01116987 FIG01116988: hypothetical protein +FIG01116992 FIG01116993: hypothetical protein +FIG01116995 FIG01116996: hypothetical protein +FIG01116996 probable esterase of alpha/beta hydrolase superfamily, YBBA B. subtilis ortholog +FIG01117004 FIG01117006: hypothetical protein +FIG01117006 FIG01117009: hypothetical protein +FIG01117009 FIG01117010: hypothetical protein +FIG01117010 FIG01117011: hypothetical protein +FIG01117011 FIG01117012: hypothetical protein +FIG01117014 FIG01117016: hypothetical protein +FIG01117017 FIG01117018: hypothetical protein +FIG01117018 FIG01117019: hypothetical protein +FIG01117023 FIG01117024: hypothetical protein +FIG01117027 FIG01117029: hypothetical protein +FIG01117029 FIG01117030: hypothetical protein +FIG01117031 FIG01117032: hypothetical protein +FIG01117033 FIG01117036: hypothetical protein +FIG01117042 FIG01117044: hypothetical protein +FIG01117047 FIG01117048: hypothetical protein +FIG01117051 putative ABC transporter, integral membrane protein +FIG01117057 FIG01117062: hypothetical protein +FIG01117062 putative UDP-galactose--lipooligosaccharide galactosyltransferase +FIG01117069 Induced during competence +FIG01117070 hypothetical protein +FIG01117071 FIG01117073: hypothetical protein +FIG01117073 FIG01117074: hypothetical protein +FIG01117074 FIG01117075: hypothetical protein +FIG01117075 FIG01117078: hypothetical protein +FIG01117080 FIG01117084: hypothetical protein +FIG01117084 FIG01117085: hypothetical protein +FIG01117085 FIG01117087: hypothetical protein +FIG01117087 FIG01117088: hypothetical protein +FIG01117088 CI-like repressor [SA bacteriophages 11, Mu50B] +FIG01117091 FIG01117092: hypothetical protein +FIG01117093 FIG01117098: hypothetical protein +FIG01117098 FIG01117099: hypothetical protein +FIG01117099 FIG01117101: hypothetical protein +FIG01117103 FIG01117106: hypothetical protein +FIG01117107 FIG01117108: hypothetical protein +FIG01117110 Mundticin KS immunity protein +FIG01117111 FIG01117112: hypothetical protein +FIG01117113 hypothetical protein +FIG01117117 FIG01117118: hypothetical protein +FIG01117118 FIG01117119: hypothetical protein +FIG01117120 FIG01117121: hypothetical protein +FIG01117121 FIG01117123: hypothetical protein +FIG01117123 FIG01117125: hypothetical protein +FIG01117131 FIG01117132: hypothetical protein +FIG01117137 FIG01117138: hypothetical protein +FIG01117138 FIG00520490: hypothetical protein +FIG01117141 FIG01117142: hypothetical protein +FIG01117143 FIG01117147: hypothetical protein +FIG01117147 FIG01117149: hypothetical protein +FIG01117149 FIG01117153: hypothetical protein +FIG01117153 FIG01117154: hypothetical protein +FIG01117159 FIG01117162: hypothetical protein +FIG01117163 FIG01117167: hypothetical protein +FIG01117167 Leucine rich protein +FIG01117169 FIG01117170: hypothetical protein +FIG01117176 FIG01117177: hypothetical protein +FIG01117177 FIG01117178: hypothetical protein +FIG01117178 FIG01117180: hypothetical protein +FIG01117180 Ribonucleases G and E +FIG01117183 FIG01117187: hypothetical protein +FIG01117188 hypothetical protein - phage associated +FIG01117193 FIG01117195: hypothetical protein +FIG01117201 FIG01117203: hypothetical protein +FIG01117207 FIG01117213: hypothetical protein +FIG01117213 FIG01117214: hypothetical protein +FIG01117222 FIG01117223: hypothetical protein +FIG01117223 FIG01117225: hypothetical protein +FIG01117225 FIG01117228: hypothetical protein +FIG01117232 FIG01117233: hypothetical protein +FIG01117239 FIG01117240: hypothetical protein +FIG01117240 FIG01117241: hypothetical protein +FIG01117246 FIG01117248: hypothetical protein +FIG01117248 CI-like repressor, phage associated +FIG01117249 hypothetical protein +FIG01117254 putative conjugative transposon membrane protein +FIG01117255 FIG01117258: hypothetical protein +FIG01117258 FIG01117259: hypothetical protein +FIG01117259 FIG01117260: hypothetical protein +FIG01117265 FIG01117266: hypothetical protein +FIG01117267 FIG01117270: hypothetical protein +FIG01117271 prophage pi2 protein 37 +FIG01117272 FIG01117275: hypothetical protein +FIG01117275 putative membrane protein +FIG01117276 FIG01117277: hypothetical protein +FIG01117277 FIG01117279: hypothetical protein +FIG01117282 FIG01117288: hypothetical protein +FIG01117288 FIG01117289: hypothetical protein +FIG01117289 FIG01117290: hypothetical protein +FIG01117295 FIG01117296: hypothetical protein +FIG01117298 FIG01117300: hypothetical protein +FIG01117300 FIG01117304: hypothetical protein +FIG01117304 FIG01117305: hypothetical protein +FIG01117318 FIG01117320: hypothetical protein +FIG01117320 FIG01117322: hypothetical protein +FIG01117322 FIG01117324: hypothetical protein +FIG01117324 FIG01117325: hypothetical protein +FIG01117325 FIG01117326: hypothetical protein +FIG01117326 FIG01117327: hypothetical protein +FIG01117328 FIG01117332: hypothetical protein +FIG01117339 FIG01117340: hypothetical protein +FIG01117343 putative immunity protein, BLpL-like +FIG01117351 FIG01117352: hypothetical protein +FIG01117352 FIG01117355: hypothetical protein +FIG01117356 FIG01117357: hypothetical protein +FIG01117357 hypothetical protein +FIG01117360 FIG01117361: hypothetical protein +FIG01117366 FIG01117368: hypothetical protein +FIG01117370 FIG01117374: hypothetical protein +FIG01117374 FIG01117375: hypothetical protein +FIG01117375 FIG01117380: hypothetical protein +FIG01117380 FIG01117382: hypothetical protein +FIG01117382 ORF26 +FIG01117385 FIG01117386: hypothetical protein +FIG01117386 FIG01117387: hypothetical protein +FIG01117387 Response regulator FasA +FIG01117391 FIG01117393: hypothetical protein +FIG01117393 FIG01117394: hypothetical protein +FIG01117403 FIG01117404: hypothetical protein +FIG01117405 FIG01117408: hypothetical protein +FIG01117408 FIG01117410: hypothetical protein +FIG01117413 FIG01117414: hypothetical protein +FIG01117421 FIG01117425: hypothetical protein +FIG01117429 conserved hypothetical protein; possible inner membrane protein +FIG01117435 FIG01117437: hypothetical protein +FIG01117438 FIG01117441: hypothetical protein +FIG01117444 FIG01118284: hypothetical protein +FIG01117445 FIG01117447: hypothetical protein +FIG01117447 FIG01117452: hypothetical protein +FIG01117457 FIG01117458: hypothetical protein +FIG01117458 FIG01117459: hypothetical protein +FIG01117459 FIG01117462: hypothetical protein +FIG01117462 FIG01117463: hypothetical protein +FIG01117466 FIG01117467: hypothetical protein +FIG01117467 FIG01117469: hypothetical protein +FIG01117474 FIG01117476: hypothetical protein +FIG01117476 FIG01117477: hypothetical protein +FIG01117477 hypothetical protein +FIG01117483 FIG01117484: hypothetical protein +FIG01117492 FIG01117494: hypothetical protein +FIG01117494 AAA ATPase +FIG01117505 FIG01117507: hypothetical protein +FIG01117507 FIG01117510: hypothetical protein +FIG01117510 Unknown +FIG01117511 FIG01117512: hypothetical protein +FIG01117513 FIG01117515: hypothetical protein +FIG01117515 FIG01117516: hypothetical protein +FIG01117517 FIG01117518: hypothetical protein +FIG01117524 hypothetical protein +FIG01117537 FIG01117543: hypothetical protein +FIG01117544 FIG01117545: hypothetical protein +FIG01117549 FIG01117550: hypothetical protein +FIG01117552 FIG01117553: hypothetical protein +FIG01117553 FIG01117554: hypothetical protein +FIG01117554 FIG01117555: hypothetical protein +FIG01117555 FIG01117556: hypothetical protein +FIG01117559 FIG01117563: hypothetical protein +FIG01117568 FIG01117569: hypothetical protein +FIG01117569 FIG01117570: hypothetical protein +FIG01117570 FIG01117572: hypothetical protein +FIG01117572 FIG01117573: hypothetical protein +FIG01117573 FIG01117579: hypothetical protein +FIG01117579 FIG01117580: hypothetical protein +FIG01117587 FIG01117589: hypothetical protein +FIG01117589 FIG01117590: hypothetical protein +FIG01117590 FIG01117591: hypothetical protein +FIG01117591 FIG01117594: hypothetical protein +FIG01117594 FIG01117601: hypothetical protein +FIG01117601 some similarities to phage related proteins +FIG01117603 FIG01117604: hypothetical protein +FIG01117606 putative autolysin; amidase +FIG01117613 FIG01117615: hypothetical protein +FIG01117615 FIG01117617: hypothetical protein +FIG01117618 FIG01117623: hypothetical protein +FIG01117624 FIG01117625: hypothetical protein +FIG01117634 FIG01117635: hypothetical protein +FIG01117636 FIG01117638: hypothetical protein +FIG01117638 FIG01116171: hypothetical protein +FIG01117642 FIG01117644: hypothetical protein +FIG01117646 Uncharacterized iron compound ABC uptake transporter, permease protein +FIG01117647 FIG01117648: hypothetical protein +FIG01117651 FIG01117652: hypothetical protein +FIG01117655 FIG01117657: hypothetical protein +FIG01117659 FIG01117662: hypothetical protein +FIG01117669 FIG01117670: hypothetical protein +FIG01117670 putative ATP-dependent Clp proteinase (ATP-binding subunit) +FIG01117676 FIG01117677: hypothetical protein +FIG01117677 FIG01117678: hypothetical protein +FIG01117680 FIG01117681: hypothetical protein +FIG01117685 FIG01117686: hypothetical protein +FIG01117693 FIG01117694: hypothetical protein +FIG01117694 FIG01117695: hypothetical protein +FIG01117697 Unknon +FIG01117701 FIG01117702: hypothetical protein +FIG01117702 FIG01117708: hypothetical protein +FIG01117708 FIG01117712: hypothetical protein +FIG01117714 FIG01117715: hypothetical protein +FIG01117720 FIG01117722: hypothetical protein +FIG01117722 FIG01117723: hypothetical protein +FIG01117724 FIG01117727: hypothetical protein +FIG01117727 FIG01117728: hypothetical protein +FIG01117733 FIG01117734: hypothetical protein +FIG01117734 FIG01117735: hypothetical protein +FIG01117737 hypothetical protein +FIG01117739 FIG01117740: hypothetical protein +FIG01117745 FIG01117750: hypothetical protein +FIG01117750 FIG01117751: hypothetical protein +FIG01117755 hypothetical protein +FIG01117759 Methyltransferase, putative( EC:2.1.1.- ) +FIG01117762 FIG01117763: hypothetical protein +FIG01117765 FIG01117768: hypothetical protein +FIG01117768 FIG01117769: hypothetical protein +FIG01117769 FIG01117771: hypothetical protein +FIG01117787 FIG01114246: hypothetical protein +FIG01117794 FIG01117796: hypothetical protein +FIG01117796 FIG01117798: hypothetical protein +FIG01117798 FIG01117801: hypothetical protein +FIG01117802 FIG01117803: hypothetical protein +FIG01117803 hypothetical protein +FIG01117806 FIG01117807: hypothetical protein +FIG01117809 FIG01117810: hypothetical protein +FIG01117812 FIG01117816: hypothetical protein +FIG01117816 FIG01117817: hypothetical protein +FIG01117817 FIG01117820: hypothetical protein +FIG01117820 hypothetical protein +FIG01117829 FIG01117831: hypothetical protein +FIG01117831 FIG01117833: hypothetical protein +FIG01117833 FIG01117834: hypothetical protein +FIG01117834 FIG01117836: hypothetical protein +FIG01117836 FIG01117839: hypothetical protein +FIG01117839 FIG01117840: hypothetical protein +FIG01117844 FIG01117845: hypothetical protein +FIG01117845 Adenine-specific methyltransferase +FIG01117855 FIG01117856: hypothetical protein +FIG01117859 FIG01117862: hypothetical protein +FIG01117867 FIG01117868: hypothetical protein +FIG01117869 FIG01117873: hypothetical protein +FIG01117873 FIG01117874: hypothetical protein +FIG01117884 hypothetical protein +FIG01117887 FIG01117889: hypothetical protein +FIG01117889 FIG01117892: hypothetical protein +FIG01117894 FIG01117896: hypothetical protein +FIG01117896 FIG01117897: hypothetical protein +FIG01117899 FIG01117900: hypothetical protein +FIG01117901 FIG01117906: hypothetical protein +FIG01117906 N-ethylammeline chlorohydrolase +FIG01117910 FIG01117914: hypothetical protein +FIG01117914 FIG01117915: hypothetical protein +FIG01117915 FIG01117917: hypothetical protein +FIG01117917 FIG01117918: hypothetical protein +FIG01117918 FIG01117920: hypothetical protein +FIG01117923 FIG01117926: hypothetical protein +FIG01117927 FIG01117928: hypothetical protein +FIG01117930 FIG01117931: hypothetical protein +FIG01117935 FIG01117936: hypothetical protein +FIG01117939 FIG01117940: hypothetical protein +FIG01117943 FIG01117944: hypothetical protein +FIG01117944 FIG01117945: hypothetical protein +FIG01117948 FIG01117951: hypothetical protein +FIG01117951 FIG01117953: hypothetical protein +FIG01117953 FIG01117954: hypothetical protein +FIG01117954 FIG01117958: hypothetical protein +FIG01117958 FIG01117960: hypothetical protein +FIG01117968 FIG01117969: hypothetical protein +FIG01117973 FIG01117978: hypothetical protein +FIG01117984 FIG01117988: hypothetical protein +FIG01117989 FIG01117991: hypothetical protein +FIG01117992 FIG01117993: hypothetical protein +FIG01117993 FIG01117994: hypothetical protein +FIG01117994 FIG01118000: hypothetical protein +FIG01118002 FIG01118003: hypothetical protein +FIG01118010 Two-component response regulator, SrtR, lantibiotic-associated +FIG01118011 FIG01118012: hypothetical protein +FIG01118012 Sucrose operon repressor (SCR operon regulatory protein) +FIG01118017 FIG01118018: hypothetical protein +FIG01118023 FIG01118024: hypothetical protein +FIG01118024 FIG01118025: hypothetical protein +FIG01118026 FIG01118027: hypothetical protein +FIG01118028 Hypothetical protein spyM18_0155 +FIG01118029 hypothetical protein +FIG01118030 FIG01118035: hypothetical protein +FIG01118039 FIG01118041: hypothetical protein +FIG01118041 FIG01118043: hypothetical protein +FIG01118055 FIG01118056: hypothetical protein +FIG01118056 DNA modification methylase +FIG01118058 FIG01118066: hypothetical protein +FIG01118069 FIG01118072: hypothetical protein +FIG01118072 Serine-threonine rich antigen +FIG01118076 FIG01118078: hypothetical protein +FIG01118078 FIG01118080: hypothetical protein +FIG01118081 FIG01118083: hypothetical protein +FIG01118083 FIG01118084: hypothetical protein +FIG01118085 FIG01118086: hypothetical protein +FIG01118086 hypothetical protein +FIG01118089 FIG01118090: hypothetical protein +FIG01118090 FIG01118091: hypothetical protein +FIG01118093 HTH-type transcriptional regulator rgg +FIG01118108 FIG01118109: hypothetical protein +FIG01118109 FIG01118110: hypothetical protein +FIG01118115 Beta-1,3-glucosyltransferase +FIG01118116 FIG01118120: hypothetical protein +FIG01118134 FIG01118135: hypothetical protein +FIG01118135 FIG01118136: hypothetical protein +FIG01118138 FIG01118139: hypothetical protein +FIG01118139 FIG01118141: hypothetical protein +FIG01118144 FIG01118147: hypothetical protein +FIG01118147 Low temperature requirement C protein +FIG01118148 FIG01118149: hypothetical protein +FIG01118149 FIG01118151: hypothetical protein +FIG01118155 FIG01118158: hypothetical protein +FIG01118166 FIG01118169: hypothetical protein +FIG01118169 FIG01118170: hypothetical protein +FIG01118174 FIG01118177: hypothetical protein +FIG01118177 FIG01118178: hypothetical protein +FIG01118178 FIG01118181: hypothetical protein +FIG01118181 FIG01118182: hypothetical protein +FIG01118182 FIG01118185: hypothetical protein +FIG01118185 Aminoglycoside adenylyltransferase +FIG01118196 FIG01118197: hypothetical protein +FIG01118197 FIG01118198: hypothetical protein +FIG01118198 FIG01118202: hypothetical protein +FIG01118202 FIG01118207: hypothetical protein +FIG01118210 FIG01118213: hypothetical protein +FIG01118215 Relaxase +FIG01118217 FIG01118218: hypothetical protein +FIG01118218 FIG01118221: hypothetical protein +FIG01118221 RelB/StbD replicon stabilization protein (antitoxin to RelE/StbE) +FIG01118222 FIG01118224: hypothetical protein +FIG01118224 Esterase/lipase +FIG01118232 FIG01118239: hypothetical protein +FIG01118239 ABC transporter ATP-binding/membrane spanning protein - multidrug resistance +FIG01118243 FIG01118244: hypothetical protein +FIG01118244 FIG01118250: hypothetical protein +FIG01118251 FIG01118252: hypothetical protein +FIG01118252 Predicted integral membrane protein +FIG01118258 FIG01118262: hypothetical protein +FIG01118269 FIG01118270: hypothetical protein +FIG01118271 FIG01118273: hypothetical protein +FIG01118274 Phosphoribosylglycinamide synthetase ATP-grasp (A) domain protein +FIG01118287 FIG01118288: hypothetical protein +FIG01118294 FIG01118295: hypothetical protein +FIG01118295 FIG01118296: hypothetical protein +FIG01118297 FIG01118298: hypothetical protein +FIG01118298 FIG01118300: hypothetical protein +FIG01118313 FIG01118314: hypothetical protein +FIG01118314 FIG01118315: hypothetical protein +FIG01118318 FIG01118320: hypothetical protein +FIG01118320 FIG01118323: hypothetical protein +FIG01118323 ABC transporter permease protein +FIG01118324 FIG01118329: hypothetical protein +FIG01118329 FIG01118335: hypothetical protein +FIG01118336 FIG01118337: hypothetical protein +FIG01118337 FIG01118338: hypothetical protein +FIG01118349 FIG01118351: hypothetical protein +FIG01118351 FIG01118352: hypothetical protein +FIG01118355 hypothetical protein (phage associated) +FIG01118356 FIG01118357: hypothetical protein +FIG01118361 FIG01118362: hypothetical protein +FIG01118362 Receptor polysaccharide phosphotransferase wefC (EC 2.7.-.-) (Stealth protein wefC) +FIG01118382 FIG01118383: hypothetical protein +FIG01118386 hypothetical protein +FIG01118388 FIG01118389: hypothetical protein +FIG01118389 FIG01118390: hypothetical protein +FIG01118394 FIG01118395: hypothetical protein +FIG01118399 FIG01118403: hypothetical protein +FIG01118405 FIG01118406: hypothetical protein +FIG01118406 FIG01118408: hypothetical protein +FIG01118408 FIG01118409: hypothetical protein +FIG01118412 FIG01118413: hypothetical protein +FIG01118413 FIG01118414: hypothetical protein +FIG01118414 FIG01118418: hypothetical protein +FIG01118418 FIG01118420: hypothetical protein +FIG01118420 FIG01118421: hypothetical protein +FIG01118423 FIG01119167: hypothetical protein +FIG01118425 FIG01118427: hypothetical protein +FIG01118436 FIG01118437: hypothetical protein +FIG01118439 NanA gene +FIG01118442 Prophage LambdaBa04, DNA-binding protein +FIG01118445 FIG01118450: hypothetical protein +FIG01118450 FIG01118451: hypothetical protein +FIG01118455 FIG01118460: hypothetical protein +FIG01118463 FIG01118464: hypothetical protein +FIG01118465 replication initiator protein A +FIG01118469 Hyaluronate lyase (phage associated) +FIG01118475 FIG01118478: hypothetical protein +FIG01118478 FIG01118479: hypothetical protein +FIG01118479 FIG01118484: hypothetical protein +FIG01118484 FIG01118487: hypothetical protein +FIG01118487 FIG01118489: hypothetical protein +FIG01118490 FIG01117022: hypothetical protein +FIG01118492 FIG01118495: hypothetical protein +FIG01118505 FIG01118506: hypothetical protein +FIG01118507 FIG01118508: hypothetical protein +FIG01118509 FIG01118513: hypothetical protein +FIG01118514 FIG01118515: hypothetical protein +FIG01118522 FIG01118525: hypothetical protein +FIG01118525 Surface protein Rib +FIG01118543 FIG01118547: hypothetical protein +FIG01118547 FIG01118551: hypothetical protein +FIG01118551 FIG01118552: hypothetical protein +FIG01118555 hypothetical protein +FIG01118571 FIG01118575: hypothetical protein +FIG01118576 FIG01118577: hypothetical protein +FIG01118583 FIG01118584: hypothetical protein +FIG01118584 N-ethylammeline chlorohydrolase +FIG01118585 FIG01118586: hypothetical protein +FIG01118586 FIG01118588: hypothetical protein +FIG01118590 FIG01118598: hypothetical protein +FIG01118598 FIG01118599: hypothetical protein +FIG01118599 FIG01118600: hypothetical protein +FIG01118600 FIG01118601: hypothetical protein +FIG01118601 FIG01118602: hypothetical protein +FIG01118607 FIG01118608: hypothetical protein +FIG01118610 FIG01118612: hypothetical protein +FIG01118612 SNF2 family protein +FIG01118613 FIG01118614: hypothetical protein +FIG01118615 FIG01118618: hypothetical protein +FIG01118618 FIG01118619: hypothetical protein +FIG01118619 FIG01118626: hypothetical protein +FIG01118626 FIG01118627: hypothetical protein +FIG01118630 putative bacteriocin peptide precursor +FIG01118631 FIG01118633: hypothetical protein +FIG01118633 FIG01118636: hypothetical protein +FIG01118636 FIG01118639: hypothetical protein +FIG01118647 FIG01118648: hypothetical protein +FIG01118648 FIG01118649: hypothetical protein +FIG01118655 FIG01118659: hypothetical protein +FIG01118659 FIG01118660: hypothetical protein +FIG01118671 FIG01118673: hypothetical protein +FIG01118678 FIG01118680: hypothetical protein +FIG01118680 FIG01118681: hypothetical protein +FIG01118682 FIG01118684: hypothetical protein +FIG01118684 FIG01118685: hypothetical protein +FIG01118685 FIG01118687: hypothetical protein +FIG01118688 FIG01118689: hypothetical protein +FIG01118689 FIG01118690: hypothetical protein +FIG01118700 FIG01118701: hypothetical protein +FIG01118704 hypothetical protein +FIG01118707 FIG01118231: hypothetical protein +FIG01118727 FIG01118729: hypothetical protein +FIG01118733 FIG01118738: hypothetical protein +FIG01118738 FIG01118741: hypothetical protein +FIG01118748 FIG01118749: hypothetical protein +FIG01118754 FIG01118758: hypothetical protein +FIG01118761 FIG01118762: hypothetical protein +FIG01118763 FIG01118764: hypothetical protein +FIG01118776 FIG01118778: hypothetical protein +FIG01118778 FIG01118780: hypothetical protein +FIG01118785 FIG01118786: hypothetical protein +FIG01118790 FIG01118791: hypothetical protein +FIG01118798 FIG01118799: hypothetical protein +FIG01118799 FIG01118805: hypothetical protein +FIG01118805 FIG01118806: hypothetical protein +FIG01118812 FIG01032298: hypothetical protein +FIG01118819 FIG01118820: hypothetical protein +FIG01118820 FIG01118821: hypothetical protein +FIG01118830 FIG01118832: hypothetical protein +FIG01118832 FIG01118834: hypothetical protein +FIG01118834 FIG01118835: hypothetical protein +FIG01118838 FIG01118842: hypothetical protein +FIG01118843 FIG01118844: hypothetical protein +FIG01118845 FIG01118846: hypothetical protein +FIG01118846 Conjugation protein, TraG/TraD family, +FIG01118856 FIG01118857: hypothetical protein +FIG01118860 FIG01118866: hypothetical protein +FIG01118866 FIG01118867: hypothetical protein +FIG01118874 FIG01118878: hypothetical protein +FIG01118889 FIG01118891: hypothetical protein +FIG01118891 FIG01118892: hypothetical protein +FIG01118901 FIG01118905: hypothetical protein +FIG01118908 FIG01118909: hypothetical protein +FIG01118913 FIG01118917: hypothetical protein +FIG01118917 FIG01118918: hypothetical protein +FIG01118924 FIG01118927: hypothetical protein +FIG01118927 FIG01118928: hypothetical protein +FIG01118934 FIG01118937: hypothetical protein +FIG01118937 FIG01118939: hypothetical protein +FIG01118943 FIG01118946: hypothetical protein +FIG01118948 FIG01118952: hypothetical protein +FIG01118952 FIG01118953: hypothetical protein +FIG01118953 FIG01118957: hypothetical protein +FIG01118958 FIG01118962: hypothetical protein +FIG01118969 FIG01118971: hypothetical protein +FIG01118975 FIG01118976: hypothetical protein +FIG01118976 FIG01118977: hypothetical protein +FIG01118981 FIG01118983: hypothetical protein +FIG01118985 FIG01118986: hypothetical protein +FIG01118986 FIG01118987: hypothetical protein +FIG01118988 FIG01118989: hypothetical protein +FIG01118999 FIG01119003: hypothetical protein +FIG01119007 FIG01119008: hypothetical protein +FIG01119013 FIG01119014: hypothetical protein +FIG01119016 FIG01119019: hypothetical protein +FIG01119030 FIG01119035: hypothetical protein +FIG01119035 Beta-glucosidase (EC 3.2.1.21) +FIG01119039 FIG01119040: hypothetical protein +FIG01119042 FIG01119043: hypothetical protein +FIG01119052 FIG01119053: hypothetical protein +FIG01119053 FIG01119056: hypothetical protein +FIG01119056 FIG01119057: hypothetical protein +FIG01119057 FIG01119058: hypothetical protein +FIG01119061 FIG01119063: hypothetical protein +FIG01119071 FIG01119073: hypothetical protein +FIG01119073 FIG01119076: hypothetical protein +FIG01119076 FIG01119078: hypothetical protein +FIG01119078 FIG01119081: hypothetical protein +FIG01119081 FIG01119083: hypothetical protein +FIG01119085 FIG01119091: hypothetical protein +FIG01119095 FIG01119097: hypothetical protein +FIG01119098 FIG01119099: hypothetical protein +FIG01119102 FIG01119103: hypothetical protein +FIG01119104 FIG01119105: hypothetical protein +FIG01119105 FIG01119106: hypothetical protein +FIG01119117 FIG01119121: hypothetical protein +FIG01119121 Toxin to DNA-damage-inducible protein J +FIG01119124 FIG01119126: hypothetical protein +FIG01119126 FIG01119129: hypothetical protein +FIG01119129 FIG01119132: hypothetical protein +FIG01119132 FIG01119133: hypothetical protein +FIG01119134 FIG01119136: hypothetical protein +FIG01119138 FIG01119140: hypothetical protein +FIG01119140 FIG01119143: hypothetical protein +FIG01119143 FIG01119145: hypothetical protein +FIG01119145 FIG01119147: hypothetical protein +FIG01119148 FIG01119149: hypothetical protein +FIG01119149 FIG01119151: hypothetical protein +FIG01119151 FIG01119152: hypothetical protein +FIG01119152 FIG01119153: hypothetical protein +FIG01119154 FIG01119155: hypothetical protein +FIG01119155 FIG01119156: hypothetical protein +FIG01119160 putative DNA-binding phage protein +FIG01119161 FIG01119163: hypothetical protein +FIG01119163 RelB/StbD replicon stabilization protein (antitoxin to RelE/StbE) +FIG01119168 putative DinF, damage-inducible protein; possible cation efflux pump (multidrug resistance protein) +FIG01119176 Acetyltransferases, including N-acetylases of ribosomal proteins +FIG01119181 FIG01119184: hypothetical protein +FIG01119184 FIG01119185: hypothetical protein +FIG01119185 FIG01119187: hypothetical protein +FIG01119192 ABC transporter, NBP/MSD fusion protein +FIG01119195 FIG01119198: hypothetical protein +FIG01119198 FIG01119199: hypothetical protein +FIG01119199 FIG01119200: hypothetical protein +FIG01119200 galactofuranose transferase +FIG01119209 FIG01119212: hypothetical protein +FIG01119217 FIG01119219: hypothetical protein +FIG01119256 FIG01119258: hypothetical protein +FIG01119258 FIG01119262: hypothetical protein +FIG01119262 FIG01119263: hypothetical protein +FIG01119265 FIG01119266: hypothetical protein +FIG01119266 FIG01119267: hypothetical protein +FIG01119282 FIG01119283: hypothetical protein +FIG01119288 FIG01119289: hypothetical protein +FIG01119289 FIG01119292: hypothetical protein +FIG01119294 FIG01119295: hypothetical protein +FIG01119299 FIG01119300: hypothetical protein +FIG01119307 FIG01119309: hypothetical protein +FIG01119313 FIG01119317: hypothetical protein +FIG01119323 FIG01119325: hypothetical protein +FIG01119325 Acetyltransferase, putative +FIG01119345 FIG01119348: hypothetical protein +FIG01119351 enhancing factor +FIG01119356 FIG01119357: hypothetical protein +FIG01119361 FIG01119363: hypothetical protein +FIG01119363 FIG01119364: hypothetical protein +FIG01119364 FIG01119370: hypothetical protein +FIG01119387 FIG01119388: hypothetical protein +FIG01119388 FIG01119391: hypothetical protein +FIG01119391 FIG01119392: hypothetical protein +FIG01119393 FIG01119395: hypothetical protein +FIG01119408 putative transcriptional regulator (TetR/AcrR family) +FIG01119412 FIG01119415: hypothetical protein +FIG01119424 FIG01119425: hypothetical protein +FIG01119425 FIG01119427: hypothetical protein +FIG01119427 FIG01119428: hypothetical protein +FIG01119434 FIG01119435: hypothetical protein +FIG01119444 FIG01119448: hypothetical protein +FIG01119448 FIG01119452: hypothetical protein +FIG01119457 FIG01119458: hypothetical protein +FIG01119458 putative endoglucanase precursor +FIG01119462 MutT/NudX family protein (putative) +FIG01119463 FIG01119464: hypothetical protein +FIG01119464 FIG01119465: hypothetical protein +FIG01119467 FIG01119470: hypothetical protein +FIG01119470 FIG01119478: hypothetical protein +FIG01119479 FIG01119487: hypothetical protein +FIG01119487 FIG01119489: hypothetical protein +FIG01119493 FIG01119497: hypothetical protein +FIG01119497 Streptococcal histidine triad protein +FIG01119505 FIG01119506: hypothetical protein +FIG01119507 hypothetical protein +FIG01119514 FIG01119515: hypothetical protein +FIG01119523 FIG01119524: hypothetical protein +FIG01119528 FIG01119531: hypothetical protein +FIG01119533 hypothetical protein +FIG01119539 conserved hypothetical protein; possible intracellular protease +FIG01119544 FIG01119547: hypothetical protein +FIG01119549 FIG01119550: hypothetical protein +FIG01119552 FIG01119553: hypothetical protein +FIG01119553 FIG01119556: hypothetical protein +FIG01119556 Rhodanese-like domain protein +FIG01119571 FIG01119573: hypothetical protein +FIG01119573 FIG01119575: hypothetical protein +FIG01119575 FIG01119580: hypothetical protein +FIG01119583 Phage T7 exclusion protein +FIG01119593 FIG01119599: hypothetical protein +FIG01119605 FIG01119607: hypothetical protein +FIG01119610 FIG01119611: hypothetical protein +FIG01119611 FIG01119612: hypothetical protein +FIG01119633 FIG01119634: hypothetical protein +FIG01119634 FIG01119637: hypothetical protein +FIG01119637 FIG01119638: hypothetical protein +FIG01119638 FIG01119640: hypothetical protein +FIG01119640 FIG01119642: hypothetical protein +FIG01119644 FIG01119645: hypothetical protein +FIG01119645 FIG01119653: hypothetical protein +FIG01119659 FIG01119660: hypothetical protein +FIG01119660 FIG01119661: hypothetical protein +FIG01119666 FIG01119668: hypothetical protein +FIG01119671 FIG01119673: hypothetical protein +FIG01119673 FIG01119674: hypothetical protein +FIG01119682 FIG01119683: hypothetical protein +FIG01119683 FIG01119695: hypothetical protein +FIG01119696 FIG01119700: hypothetical protein +FIG01119700 putative coenzyme PQQ synthesis protein +FIG01119701 FIG01119703: hypothetical protein +FIG01119704 FIG01119706: hypothetical protein +FIG01119709 FIG01119714: hypothetical protein +FIG01119715 FIG01119717: hypothetical protein +FIG01119717 FIG01119721: hypothetical protein +FIG01119722 FIG01119725: hypothetical protein +FIG01119733 HAD hydrolase superfamily protein +FIG01119734 FIG01119736: hypothetical protein +FIG01119738 FIG01119743: hypothetical protein +FIG01119749 FIG01119753: hypothetical protein +FIG01119753 FIG01119755: hypothetical protein +FIG01119759 FIG01119762: hypothetical protein +FIG01119762 FIG01119765: hypothetical protein +FIG01119766 FIG01119769: hypothetical protein +FIG01119769 FIG01119773: hypothetical protein +FIG01119785 FIG01119788: hypothetical protein +FIG01119791 FIG01119792: hypothetical protein +FIG01119801 FIG01119803: hypothetical protein +FIG01119803 FIG01119804: hypothetical protein +FIG01119805 putative CDP-diglyceride synthetase( EC:2.7.7.41 ) +FIG01119818 FIG01119820: hypothetical protein +FIG01119835 FIG01119837: hypothetical protein +FIG01119839 Unknown +FIG01119842 FIG01119843: hypothetical protein +FIG01119846 FIG01119849: hypothetical protein +FIG01119849 FIG01119857: hypothetical protein +FIG01119858 FIG01119859: hypothetical protein +FIG01119859 FIG01119860: hypothetical protein +FIG01119863 FIG01119864: hypothetical protein +FIG01119869 FIG01119870: hypothetical protein +FIG01119870 FIG01119876: hypothetical protein +FIG01119876 FIG01119879: hypothetical protein +FIG01119881 FIG01119883: hypothetical protein +FIG01119883 FIG01119886: hypothetical protein +FIG01119892 FIG01119893: hypothetical protein +FIG01119893 FIG01119896: hypothetical protein +FIG01119908 FIG01119909: hypothetical protein +FIG01119912 FIG01119918: hypothetical protein +FIG01119918 FIG01119925: hypothetical protein +FIG01119925 FIG01119926: hypothetical protein +FIG01119926 FIG01119928: hypothetical protein +FIG01119929 FIG01119931: hypothetical protein +FIG01119936 FIG01119937: hypothetical protein +FIG01119955 FIG01119958: hypothetical protein +FIG01119962 FIG01119965: hypothetical protein +FIG01119965 FIG01119966: hypothetical protein +FIG01119966 FIG01119968: hypothetical protein +FIG01119974 FIG01119979: hypothetical protein +FIG01119992 FIG01119994: hypothetical protein +FIG01120009 FIG01120014: hypothetical protein +FIG01120015 Streptococcal pyrogenic exotoxin I (SpeI) +FIG01120016 FIG01120017: hypothetical protein +FIG01120019 FIG01120026: hypothetical protein +FIG01120026 putative BglB fragment +FIG01120029 FIG01120030: hypothetical protein +FIG01120034 FIG01120035: hypothetical protein +FIG01120039 FIG01120040: hypothetical protein +FIG01120046 immunity region +FIG01120053 FIG01120054: hypothetical protein +FIG01120056 FIG01120057: hypothetical protein +FIG01120063 FIG01120064: hypothetical protein +FIG01120073 FIG01196775: hypothetical protein +FIG01120087 FIG01120088: hypothetical protein +FIG01120088 TnpY +FIG01120089 FIG01120091: hypothetical protein +FIG01120094 FIG01120097: hypothetical protein +FIG01120097 FIG01120100: hypothetical protein +FIG01120103 FIG01120104: hypothetical protein +FIG01120104 FIG01120110: hypothetical protein +FIG01120116 FIG01120118: hypothetical protein +FIG01120131 FIG01120136: hypothetical protein +FIG01120139 FIG01120146: hypothetical protein +FIG01120148 hypothetical protein, SatC +FIG01120172 Predicted hydrolase (HAD superfamily) +FIG01120173 FIG01120176: hypothetical protein +FIG01120176 FIG01120178: hypothetical protein +FIG01120178 FIG01120188: hypothetical protein +FIG01120188 FIG01120193: hypothetical protein +FIG01120193 FIG01120196: hypothetical protein +FIG01120196 FIG01120199: hypothetical protein +FIG01120199 FIG01120204: hypothetical protein +FIG01120207 FIG01120208: hypothetical protein +FIG01120215 FIG01120216: hypothetical protein +FIG01120216 FIG01120217: hypothetical protein +FIG01120239 FIG01120240: hypothetical protein +FIG01120247 FIG01120248: hypothetical protein +FIG01120256 FIG01120257: hypothetical protein +FIG01120258 FIG01120263: hypothetical protein +FIG01120264 FIG01120266: hypothetical protein +FIG01120276 FIG01120277: hypothetical protein +FIG01120282 FIG01120285: hypothetical protein +FIG01120285 FIG01120287: hypothetical protein +FIG01120292 FIG01120293: hypothetical protein +FIG01120293 FIG01120295: hypothetical protein +FIG01120307 FIG01120308: hypothetical protein +FIG01120308 FIG01120312: hypothetical protein +FIG01120319 FIG01120320: hypothetical protein +FIG01120327 FIG01120330: hypothetical protein +FIG01120346 FIG01120352: hypothetical protein +FIG01120354 Orf46 +FIG01120367 FIG01120369: hypothetical protein +FIG01120369 Glycosyl transferase, group 1 +FIG01120374 FIG01120375: hypothetical protein +FIG01120375 FIG01120376: hypothetical protein +FIG01120376 FIG01120378: hypothetical protein +FIG01120390 FIG01120391: hypothetical protein +FIG01120392 Ubiquitin C-terminal hydrolase, putative +FIG01120398 FIG01120399: hypothetical protein +FIG01120412 FIG01120414: hypothetical protein +FIG01120423 gp2 +FIG01120433 FIG01120434: hypothetical protein +FIG01120439 FIG01120440: hypothetical protein +FIG01120440 FIG01120441: hypothetical protein +FIG01120447 FIG01120448: hypothetical protein +FIG01120448 FIG01120449: hypothetical protein +FIG01120451 FIG01120452: hypothetical protein +FIG01120452 FIG01120456: hypothetical protein +FIG01120471 hypothetical protein +FIG01120474 putative MDR permease; possible transmembrane efflux protein +FIG01120476 FIG01120478: hypothetical protein +FIG01120481 FIG01120482: hypothetical protein +FIG01120488 Lipase/Acylhydrolase family protein +FIG01120505 FIG01120506: hypothetical protein +FIG01120509 FIG01120510: hypothetical protein +FIG01120510 FIG01120512: hypothetical protein +FIG01120520 FIG01120522: hypothetical protein +FIG01120561 FIG01120564: hypothetical protein +FIG01120564 FIG01120567: hypothetical protein +FIG01120574 putative transcriptional regulator MutR +FIG01120579 FIG01119870: hypothetical protein +FIG01120582 FIG01120590: hypothetical protein +FIG01120592 FIG01120597: hypothetical protein +FIG01120605 FIG01120612: hypothetical protein +FIG01120612 FIG01120614: hypothetical protein +FIG01120623 FIG01120624: hypothetical protein +FIG01120644 FIG01120645: hypothetical protein +FIG01120681 FIG01120684: hypothetical protein +FIG01120694 FIG01120704: hypothetical protein +FIG01120704 Cell division protein FtsH (EC 3.4.24.-) +FIG01120711 FIG01120715: hypothetical protein +FIG01120735 FIG01120737: hypothetical protein +FIG01120757 FIG01120759: hypothetical protein +FIG01120763 FIG01120764: hypothetical protein +FIG01120769 FIG01120770: hypothetical protein +FIG01120770 sugar ABC transporter ATP-binding protein +FIG01120771 FIG01120773: hypothetical protein +FIG01120773 FIG01120775: hypothetical protein +FIG01120775 FIG01120777: hypothetical protein +FIG01120777 FIG01120778: hypothetical protein +FIG01120778 FIG01120779: hypothetical protein +FIG01120779 SpdD2 protein +FIG01120780 FIG01120782: hypothetical protein +FIG01120782 FIG01120783: hypothetical protein +FIG01120783 FIG01120784: hypothetical protein +FIG01120787 Subtilisin inhibitor-like protein 5 (SIL-5) (SIL5) +FIG01120789 FIG01120790: hypothetical protein +FIG01120790 hypothetical protein SCE22.12 +FIG01120791 FIG01120793: hypothetical protein +FIG01120793 putative ABC transporter ATP-binding component +FIG01120794 FIG01120796: hypothetical protein +FIG01120798 FIG01120799: hypothetical protein +FIG01120800 multi-component regulatory system-3, containing roadblock/LC7 domain +FIG01120801 FIG01120802: hypothetical protein +FIG01120803 putative membrane protei +FIG01120805 FIG01120806: hypothetical protein +FIG01120806 FIG01120807: hypothetical protein +FIG01120807 FIG01120808: hypothetical protein +FIG01120808 SC4G6.31c, unknown, len: 403aa +FIG01120809 FIG01120810: hypothetical protein +FIG01120810 FIG01120811: hypothetical protein +FIG01120813 FIG01120814: hypothetical protein +FIG01120814 FIG01120815: hypothetical protein +FIG01120815 guanyl-specific ribonuclease Sa3 precursor (RNase Sa3)( EC:3.1.27.3 ) +FIG01120816 FIG01120817: hypothetical protein +FIG01120817 SCI11.21, hypothetical protein, len: 44 aa; unknown function, possible CDS suggested by GC frameplot and the presence of a possible RBS +FIG01120818 FIG01120820: hypothetical protein +FIG01120820 FIG01120821: hypothetical protein +FIG01120821 FIG01120822: hypothetical protein +FIG01120822 FIG01120823: hypothetical protein +FIG01120823 FIG01120824: hypothetical protein +FIG01120829 FIG01120831: hypothetical protein +FIG01120831 hypothetical proline-rich protein +FIG01120834 FIG01120835: hypothetical protein +FIG01120836 FIG01120838: hypothetical protein +FIG01120838 FIG01120839: hypothetical protein +FIG01120839 FIG00820747: hypothetical protein +FIG01120842 ECF sigma factor +FIG01120843 FIG01120844: hypothetical protein +FIG01120854 FIG01120857: hypothetical protein +FIG01120863 FIG01120864: hypothetical protein +FIG01120864 hypothetical protein SC10H5.08c +FIG01120869 FIG01120870: hypothetical protein +FIG01120873 hypothetical protein SC2G5.28 +FIG01120874 SC5F7.06, unknown, len: 71aa +FIG01120880 FIG01120881: hypothetical protein +FIG01120885 FIG01120886: hypothetical protein +FIG01120886 FIG01120887: hypothetical protein +FIG01120887 FIG01120888: hypothetical protein +FIG01120888 FIG01120889: hypothetical protein +FIG01120892 FIG01120893: hypothetical protein +FIG01120893 FIG01120895: hypothetical protein +FIG01120895 FIG01120896: hypothetical protein +FIG01120896 FIG01120898: hypothetical protein +FIG01120898 Anthraniloyl-CoA monooxygenase (EC 1.14.13.40) +FIG01120899 FIG01120900: hypothetical protein +FIG01120900 FIG01120903: hypothetical protein +FIG01120903 FIG01120904: hypothetical protein +FIG01120904 FIG01120905: hypothetical protein +FIG01120905 FIG01120906: hypothetical protein +FIG01120906 FIG01120907: hypothetical protein +FIG01120907 FIG01120908: hypothetical protein +FIG01120909 cell division protein, regulatory protein +FIG01120914 FIG01120915: hypothetical protein +FIG01120915 FIG01120916: hypothetical protein +FIG01120916 FIG01120918: hypothetical protein +FIG01120918 FIG00665196: hypothetical protein +FIG01120923 FIG01120924: hypothetical protein +FIG01120925 FIG01120927: hypothetical protein +FIG01120930 membrane transport protein +FIG01120932 lyase +FIG01120933 FIG01120934: hypothetical protein +FIG01120940 FIG01120941: hypothetical protein +FIG01120941 FIG01120942: hypothetical protein +FIG01120942 FIG01120943: hypothetical protein +FIG01120943 FIG01120944: hypothetical protein +FIG01120945 FIG01120946: hypothetical protein +FIG01120947 putative sugar binding secreted protein +FIG01120950 FIG01120952: hypothetical protein +FIG01120952 FIG01120953: hypothetical protein +FIG01120954 FIG01120955: hypothetical protein +FIG01120955 FIG01120956: hypothetical protein +FIG01120958 FIG01120959: hypothetical protein +FIG01120959 putative two-component system response transcriptional regulator +FIG01120960 FIG01120961: hypothetical protein +FIG01120961 FIG01120962: hypothetical protein +FIG01120963 FIG01120964: hypothetical protein +FIG01120965 FIG01120966: hypothetical protein +FIG01120967 FIG01120968: hypothetical protein +FIG01120968 FIG01120972: hypothetical protein +FIG01120972 FIG01120973: hypothetical protein +FIG01120977 FIG01120978: hypothetical protein +FIG01120978 FIG01120982: hypothetical protein +FIG01120982 FIG01120983: hypothetical protein +FIG01120983 FIG01120984: hypothetical protein +FIG01120984 SCO5464; SC3D11.21, possible calcium-binding protein, len: 70aa; similar to many eukaryotic calcium-binding proteins eg. TR:Q42470 (EMBL:D63153) calcium-binding protein from Brassica rapa (Turnip), and Brassica napus (Rape) (79 aa) fasta scores; opt: 153, z-score: 214.7, E(): 0.00015, 45.3% identity in 64 aa overlap and SW:P02599 (CALM_DICDI) calmodulin from Dictyostelium discoideum (Slime mold) (151 aa) fasta scores; opt: 155, z-score: 213.0, E(): 0.00019, 43.3% identity in 60 aa overlap. Contains Pfam match to entry PF00036 efhand, EF hand and two Prosite matches to PS00018 EF-hand calcium-binding domain +FIG01120988 FIG01120989: hypothetical protein +FIG01120989 FIG01120992: hypothetical protein +FIG01120992 ATP-binding protein +FIG01120993 FIG01120994: hypothetical protein +FIG01120994 FIG01120995: hypothetical protein +FIG01120996 FIG01120997: hypothetical protein +FIG01120997 putative sugar transport inner membrane protein +FIG01121002 FIG01121003: hypothetical protein +FIG01121003 FIG01121004: hypothetical protein +FIG01121004 FIG01121007: hypothetical protein +FIG01121007 SCE19A.19c, hypothetical protein, len: 114 aa; unknown function, probable CDS suggested by probable CDS suggested by GC frameplot, positional base preference and amino acid composition +FIG01121012 conserved ATP/GTP-binding protein +FIG01121014 FIG01121015: hypothetical protein +FIG01121015 sugar ABC transporter integral membrane protein +FIG01121016 Acyl-CoA synthetase (NDP forming) +FIG01121019 FIG01121020: hypothetical protein +FIG01121020 translocase protein +FIG01121028 FIG01121029: hypothetical protein +FIG01121029 FIG01121030: hypothetical protein +FIG01121034 FIG01121036: hypothetical protein +FIG01121037 FIG01121038: hypothetical protein +FIG01121039 FIG01121040: hypothetical protein +FIG01121044 FIG01121045: hypothetical protein +FIG01121045 FIG01121047: hypothetical protein +FIG01121047 FIG01121048: hypothetical protein +FIG01121048 FIG01121049: hypothetical protein +FIG01121050 FIG01121051: hypothetical protein +FIG01121051 FIG01121053: hypothetical protein +FIG01121054 FIG01121056: hypothetical protein +FIG01121056 FIG01121059: hypothetical protein +FIG01121059 iron sulphur protein +FIG01121061 FIG01121062: hypothetical protein +FIG01121062 FIG01121063: hypothetical protein +FIG01121063 Mll5128 protein +FIG01121065 Protein crcB homolog 2 +FIG01121066 FIG01121067: hypothetical protein +FIG01121067 putative hydrolase CbbY/CbbZ/GpH/YieH family +FIG01121069 FIG01121070: hypothetical protein +FIG01121070 FIG01121071: hypothetical protein +FIG01121071 hypothetical protein SC5A7.26 +FIG01121074 FIG01121077: hypothetical protein +FIG01121077 putative secreted solute-binding protein +FIG01121078 FIG01121079: hypothetical protein +FIG01121079 FIG01121080: hypothetical protein +FIG01121080 FIG01121081: hypothetical protein +FIG01121083 putative redoxin +FIG01121084 hypothetical protein; putative SAM binding motif +FIG01121085 FIG01121086: hypothetical protein +FIG01121088 FIG01121090: hypothetical protein +FIG01121091 FIG01121092: hypothetical protein +FIG01121099 FIG01121100: hypothetical protein +FIG01121100 transcriptional regulator, LacI-family +FIG01121102 FIG01121103: hypothetical protein +FIG01121104 FIG01121105: hypothetical protein +FIG01121105 FIG01121106: hypothetical protein +FIG01121106 FIG01121107: hypothetical protein +FIG01121108 FIG01121110: hypothetical protein +FIG01121110 FIG01121111: hypothetical protein +FIG01121111 FIG01121112: hypothetical protein +FIG01121112 FIG01121113: hypothetical protein +FIG01121119 conserved hypothetical protein; possible metallopeptidase +FIG01121125 FIG01121126: hypothetical protein +FIG01121126 FIG01121127: hypothetical protein +FIG01121128 FIG01121130: hypothetical protein +FIG01121133 FIG01121136: hypothetical protein +FIG01121136 FIG01121139: hypothetical protein +FIG01121140 FIG01121141: hypothetical protein +FIG01121141 FIG01121142: hypothetical protein +FIG01121142 FIG01121143: hypothetical protein +FIG01121143 FIG01121145: hypothetical protein +FIG01121145 FIG01121146: hypothetical protein +FIG01121152 FIG01121153: hypothetical protein +FIG01121153 FIG01121154: hypothetical protein +FIG01121155 Putative ribonucleoprotein related-protein TROVE Domain +FIG01121157 FIG01121158: hypothetical protein +FIG01121161 FIG01121163: hypothetical protein +FIG01121163 FIG01121164: hypothetical protein +FIG01121164 pectate lyase +FIG01121167 FIG01121168: hypothetical protein +FIG01121168 FIG01121169: hypothetical protein +FIG01121169 FIG01121171: hypothetical protein +FIG01121177 FIG01121178: hypothetical protein +FIG01121178 hypothetical protein SCD35.16 +FIG01121179 FIG01121180: hypothetical protein +FIG01121183 FIG01121184: hypothetical protein +FIG01121186 FIG01121187: hypothetical protein +FIG01121187 FIG01121190: hypothetical protein +FIG01121190 FIG01121191: hypothetical protein +FIG01121191 FIG01121192: hypothetical protein +FIG01121194 secreted protease +FIG01121195 FIG01121197: hypothetical protein +FIG01121197 FIG01121198: hypothetical protein +FIG01121198 putative secreted hydrolase +FIG01121200 FIG01121201: hypothetical protein +FIG01121202 FIG01121203: hypothetical protein +FIG01121203 FIG01121205: hypothetical protein +FIG01121205 FIG01121207: hypothetical protein +FIG01121207 conserved hypothetical protein SCD84.04c +FIG01121208 FIG01121209: hypothetical protein +FIG01121210 FIG01121211: hypothetical protein +FIG01121211 FIG01121212: hypothetical protein +FIG01121212 FIG01121213: hypothetical protein +FIG01121214 FIG01121215: hypothetical protein +FIG01121215 FIG01121216: hypothetical protein +FIG01121216 SC6G9.43c, cvnB5, conserved hypothetical protein, len: 150 aa; similar to hypothetical proteins from S. coelicolor and Mycobacterium tuberculosis e.g. TR:O86524 (EMBL:AL031124) S.coelicolor hypothetical protein (173 aa), fasta scores; opt: 316 z-score: 394.7 E(): 1.2e-14, 48.1% identity in 131 aa overlap and TR:O50393 (EMBL:AL009198) Mycobacterium tuberculosis hypothetical protein (130 aa) (36.7% identity in 120 aa overlap) +FIG01121218 FIG01121219: hypothetical protein +FIG01121219 hypothetical protein SCF42.04. +FIG01121220 FIG01121221: hypothetical protein +FIG01121222 FIG01121225: hypothetical protein +FIG01121226 FIG01121227: hypothetical protein +FIG01121227 FIG01121228: hypothetical protein +FIG01121228 FIG01121229: hypothetical protein +FIG01121229 FIG01121230: hypothetical protein +FIG01121235 putative PTS transmembrane component +FIG01121239 FIG01121240: hypothetical protein +FIG01121247 FIG01121248: hypothetical protein +FIG01121253 putative phosphinothricin N-acetyltransferase +FIG01121254 FIG01121256: hypothetical protein +FIG01121259 2-phospho-L-lactate guanylyltransferase (EC 2.7.7.68) +FIG01121261 FIG01121263: hypothetical protein +FIG01121264 FIG01121265: hypothetical protein +FIG01121265 FIG01121266: hypothetical protein +FIG01121266 FIG01121267: hypothetical protein +FIG01121267 Putative anti-terminator regulatory protein +FIG01121268 FIG01121269: hypothetical protein +FIG01121269 FIG01121270: hypothetical protein +FIG01121270 FIG01121271: hypothetical protein +FIG01121273 FIG01121274: hypothetical protein +FIG01121274 FIG01121275: hypothetical protein +FIG01121275 FIG01121276: hypothetical protein +FIG01121276 FIG01121280: hypothetical protein +FIG01121280 FIG01121281: hypothetical protein +FIG01121281 FIG01121283: hypothetical protein +FIG01121283 FIG01121284: hypothetical protein +FIG01121287 FIG01121288: hypothetical protein +FIG01121289 FIG01121292: hypothetical protein +FIG01121292 FIG01121294: hypothetical protein +FIG01121294 FIG01121295: hypothetical protein +FIG01121295 FIG01121296: hypothetical protein +FIG01121297 FIG01121298: hypothetical protein +FIG01121298 FIG01121299: hypothetical protein +FIG01121299 FIG01121300: hypothetical protein +FIG01121300 FIG01121302: hypothetical protein +FIG01121302 FIG01121303: hypothetical protein +FIG01121311 FIG01121314: hypothetical protein +FIG01121319 FIG01121321: hypothetical protein +FIG01121321 FIG01121322: hypothetical protein +FIG01121323 FIG01121324: hypothetical protein +FIG01121324 FIG01121325: hypothetical protein +FIG01121325 FIG01121326: hypothetical protein +FIG01121326 Molybdopterin converting factor small subunit +FIG01121327 putative ECF-sigma factor +FIG01121328 FIG01121329: hypothetical protein +FIG01121330 endo alpha-1,4 polygalactosaminidase, putative +FIG01121332 FIG01121334: hypothetical protein +FIG01121337 putative undecaprenyl-phosphate glycosyl-1-phosphate transferase( EC:2.7.8.6 ) +FIG01121340 FIG01121341: hypothetical protein +FIG01121342 FIG01121343: hypothetical protein +FIG01121343 FIG01121344: hypothetical protein +FIG01121344 FIG01121345: hypothetical protein +FIG01121346 FIG01121347: hypothetical protein +FIG01121347 FIG01121348: hypothetical protein +FIG01121350 FIG01121352: hypothetical protein +FIG01121352 FIG01121353: hypothetical protein +FIG01121355 FIG01121356: hypothetical protein +FIG01121360 FIG01121362: hypothetical protein +FIG01121363 FIG01121364: hypothetical protein +FIG01121367 FIG01121368: hypothetical protein +FIG01121368 FIG01121369: hypothetical protein +FIG01121370 FIG01121371: hypothetical protein +FIG01121371 FIG01121372: hypothetical protein +FIG01121373 FIG01121374: hypothetical protein +FIG01121374 FIG01121375: hypothetical protein +FIG01121375 FIG01121376: hypothetical protein +FIG01121376 FIG01121378: hypothetical protein +FIG01121378 putative phosphatase +FIG01121379 Alkaline shock protein 23 +FIG01121382 FIG01121385: hypothetical protein +FIG01121386 putative DHA2-subfamily multidrug transporter +FIG01121388 Putative two-component system response regulator +FIG01121389 FIG01121391: hypothetical protein +FIG01121391 FIG01121392: hypothetical protein +FIG01121392 FIG01121393: hypothetical protein +FIG01121397 FIG01121398: hypothetical protein +FIG01121398 oligopeptide transport integral membrane protein +FIG01121399 FIG01121400: hypothetical protein +FIG01121400 FIG01121401: hypothetical protein +FIG01121401 FIG01121402: hypothetical protein +FIG01121403 FIG01121405: hypothetical protein +FIG01121405 zinc protease +FIG01121407 FIG01121409: hypothetical protein +FIG01121409 FIG01121410: hypothetical protein +FIG01121410 FIG01121411: hypothetical protein +FIG01121411 putative metalloprotease +FIG01121414 FIG01121415: hypothetical protein +FIG01121415 FIG01121418: hypothetical protein +FIG01121419 FIG01121420: hypothetical protein +FIG01121427 FIG01121428: hypothetical protein +FIG01121429 FIG01121430: hypothetical protein +FIG01121432 FIG01121434: hypothetical protein +FIG01121434 FIG01121436: hypothetical protein +FIG01121438 FIG01121439: hypothetical protein +FIG01121439 FIG01121441: hypothetical protein +FIG01121444 FIG01121445: hypothetical protein +FIG01121446 FIG01121447: hypothetical protein +FIG01121447 FIG01121449: hypothetical protein +FIG01121449 FIG01121450: hypothetical protein +FIG01121451 FIG01121452: hypothetical protein +FIG01121453 FIG01121455: hypothetical protein +FIG01121455 FIG01121456: hypothetical protein +FIG01121456 FIG01121461: hypothetical protein +FIG01121466 FIG01121467: hypothetical protein +FIG01121467 putative ATP-dependent RNA helicase +FIG01121470 FIG01121471: hypothetical protein +FIG01121471 FIG01121472: hypothetical protein +FIG01121473 FIG01121474: hypothetical protein +FIG01121475 FIG01121476: hypothetical protein +FIG01121476 FIG01121477: hypothetical protein +FIG01121478 FIG01121479: hypothetical protein +FIG01121479 FIG01121481: hypothetical protein +FIG01121481 FIG01121483: hypothetical protein +FIG01121484 FIG01121485: hypothetical protein +FIG01121485 FIG01121486: hypothetical protein +FIG01121490 FIG01121491: hypothetical protein +FIG01121491 FIG01121493: hypothetical protein +FIG01121495 Putative serine protease +FIG01121496 FIG01121497: hypothetical protein +FIG01121498 FIG01121499: hypothetical protein +FIG01121499 FIG01121500: hypothetical protein +FIG01121500 FIG01121501: hypothetical protein +FIG01121501 Guanosine-3',5'-bis(Diphosphate) 3'-pyrophosphohydrolase (EC 3.1.7.2) +FIG01121502 FIG01121503: hypothetical protein +FIG01121505 FIG00672531: hypothetical protein +FIG01121506 FIG01121507: hypothetical protein +FIG01121507 FIG01121509: hypothetical protein +FIG01121509 FIG01121510: hypothetical protein +FIG01121511 FIG01121512: hypothetical protein +FIG01121512 FIG01121513: hypothetical protein +FIG01121516 FIG01121517: hypothetical protein +FIG01121520 FIG01121521: hypothetical protein +FIG01121527 putative serine proteinase +FIG01121530 ABC drug efflux pump, inner membrane subunit, DrrB family +FIG01121533 FIG01121536: hypothetical protein +FIG01121539 FIG01121541: hypothetical protein +FIG01121541 FIG01121542: hypothetical protein +FIG01121542 FIG01121544: hypothetical protein +FIG01121545 Isopeptidase T +FIG01121548 FIG01121549: hypothetical protein +FIG01121549 SCC22.13c, unknown, len: 259aa +FIG01121552 FIG01121553: hypothetical protein +FIG01121554 FIG01121555: hypothetical protein +FIG01121556 putative DeoR-family transcriptional regulator +FIG01121557 FIG01121558: hypothetical protein +FIG01121558 FIG01121559: hypothetical protein +FIG01121559 FIG01121560: hypothetical protein +FIG01121560 FIG01121561: hypothetical protein +FIG01121561 putative secreted sugar binding protein +FIG01121562 Lanthionine biosynthesis protein LanB +FIG01121570 FIG00820885: hypothetical protein +FIG01121571 mobile element transfer protein SpdB +FIG01121573 conserved hypothetical protein SCF43.06 +FIG01121578 FIG01121581: hypothetical protein +FIG01121581 FIG01121582: hypothetical protein +FIG01121585 FIG01121586: hypothetical protein +FIG01121586 FIG01121589: hypothetical protein +FIG01121589 FIG01121590: hypothetical protein +FIG01121590 FIG01121591: hypothetical protein +FIG01121593 FIG01121594: hypothetical protein +FIG01121594 FIG01121596: hypothetical protein +FIG01121596 FIG01121597: hypothetical protein +FIG01121597 FIG01121599: hypothetical protein +FIG01121605 FIG01121606: hypothetical protein +FIG01121606 FIG01121607: hypothetical protein +FIG01121610 putative permease inner membrane component +FIG01121611 Sugar ABC transporter sugar-binding protein +FIG01121613 FIG01121614: hypothetical protein +FIG01121614 FIG01121615: hypothetical protein +FIG01121615 FIG01121616: hypothetical protein +FIG01121616 type IV peptidase +FIG01121619 FIG01121620: hypothetical protein +FIG01121620 FIG01121622: hypothetical protein +FIG01121622 FIG01121623: hypothetical protein +FIG01121625 transcriptional regulator, XRE family with cupin sensor +FIG01121626 FIG01121627: hypothetical protein +FIG01121627 FIG01121629: hypothetical protein +FIG01121629 FIG01121630: hypothetical protein +FIG01121632 putative sporulation protein K +FIG01121634 FIG01121635: hypothetical protein +FIG01121635 FIG01121637: hypothetical protein +FIG01121638 FIG01121639: hypothetical protein +FIG01121639 putative phosphotransferase +FIG01121641 secreted serine protease +FIG01121643 FIG01121644: hypothetical protein +FIG01121644 FIG01121645: hypothetical protein +FIG01121646 FIG01121647: hypothetical protein +FIG01121647 FIG01121649: hypothetical protein +FIG01121649 FIG01121650: hypothetical protein +FIG01121651 FIG01121653: hypothetical protein +FIG01121653 FIG01121654: hypothetical protein +FIG01121654 FIG01121655: hypothetical protein +FIG01121655 FIG01121656: hypothetical protein +FIG01121657 FIG01121658: hypothetical protein +FIG01121658 FIG01121659: hypothetical protein +FIG01121659 POSSIBLE METHYLTRANSFERASE (METHYLASE) +FIG01121660 FIG01121661: hypothetical protein +FIG01121666 FIG01121667: hypothetical protein +FIG01121667 FIG01121668: hypothetical protein +FIG01121668 FIG01121669: hypothetical protein +FIG01121669 FIG01121670: hypothetical protein +FIG01121670 hypothetical protein SCD25.06 +FIG01121672 FIG01121674: hypothetical protein +FIG01121680 FIG01121681: hypothetical protein +FIG01121682 FIG01121683: hypothetical protein +FIG01121684 FIG01121685: hypothetical protein +FIG01121685 FIG01121686: hypothetical protein +FIG01121686 L-glutamine:scyllo-inosose aminotransferase (EC 2.6.1.50) (Glutamine--scyllo-inositol transaminase) +FIG01121687 FIG01121688: hypothetical protein +FIG01121690 FIG01121691: hypothetical protein +FIG01121691 FIG01121693: hypothetical protein +FIG01121694 FIG01121696: hypothetical protein +FIG01121696 FIG01121697: hypothetical protein +FIG01121697 FIG01121698: hypothetical protein +FIG01121698 FIG01121699: hypothetical protein +FIG01121699 FIG01121700: hypothetical protein +FIG01121700 FIG01121701: hypothetical protein +FIG01121701 FIG01121702: hypothetical protein +FIG01121702 FIG01121703: hypothetical protein +FIG01121703 FIG01121705: hypothetical protein +FIG01121705 FIG01121707: hypothetical protein +FIG01121707 FIG01121708: hypothetical protein +FIG01121709 FIG01121710: hypothetical protein +FIG01121710 FIG01121711: hypothetical protein +FIG01121711 septum site-determining protein +FIG01121714 FIG01121715: hypothetical protein +FIG01121715 hydrophobic protein +FIG01121716 FIG01121717: hypothetical protein +FIG01121717 ArsR-family transcriptional regulatory protein +FIG01121719 FIG01121722: hypothetical protein +FIG01121722 FIG01121723: hypothetical protein +FIG01121730 FIG01121731: hypothetical protein +FIG01121733 FIG01121735: hypothetical protein +FIG01121735 FIG01121736: hypothetical protein +FIG01121737 FIG01121738: hypothetical protein +FIG01121739 hypothetical protein SC10B7.06 +FIG01121740 protein serine/threonine kinase +FIG01121741 FIG01121742: hypothetical protein +FIG01121742 putative GroES-family molecular chaperone. +FIG01121743 FIG01121746: hypothetical protein +FIG01121746 FIG01121750: hypothetical protein +FIG01121751 FIG01121752: hypothetical protein +FIG01121752 SCL6.06c, hypothetical protein, len: 152 aa; similar to SW:YBGC_ECOLI (EMBL:M16489) Escherichia coli hypothetical 15.6 kD protein in CydB-TolQ intergenic region YbgC, 134 aa; fasta scores: opt: 140 z-score: 193.8 E(): 0.0023; 26.7% identity in 116 aa overlap +FIG01121756 FIG01121757: hypothetical protein +FIG01121757 sortase family protein +FIG01121758 FIG01121759: hypothetical protein +FIG01121759 FIG01121760: hypothetical protein +FIG01121760 FIG01121762: hypothetical protein +FIG01121762 FIG01121763: hypothetical protein +FIG01121764 probable regulatory protein +FIG01121765 FIG01121768: hypothetical protein +FIG01121768 tellurium resistance protein +FIG01121770 FIG01121772: hypothetical protein +FIG01121772 FIG01121773: hypothetical protein +FIG01121775 FIG01121776: hypothetical protein +FIG01121778 FIG01121780: hypothetical protein +FIG01121782 FIG01121783: hypothetical protein +FIG01121783 FIG01121785: hypothetical protein +FIG01121785 multi-component regulatory system-11, containing roadblock/LC7 domain +FIG01121787 putative bicyclomycin resistance protein +FIG01121790 FIG01121792: hypothetical protein +FIG01121792 FIG01121793: hypothetical protein +FIG01121793 aminoglycoside 2'-N-acetyltransferase +FIG01121796 FIG01121797: hypothetical protein +FIG01121797 putative RNA polymerase sigma factor +FIG01121800 FIG01121801: hypothetical protein +FIG01121801 FIG01121802: hypothetical protein +FIG01121802 FIG01121804: hypothetical protein +FIG01121805 FIG01121806: hypothetical protein +FIG01121806 FIG01121807: hypothetical protein +FIG01121807 FIG01121808: hypothetical protein +FIG01121808 glutamate dehydrogenase (NAD(P)+)( EC:1.4.1.3 ) +FIG01121809 FIG01121811: hypothetical protein +FIG01121811 transmembrane sugar transport protein +FIG01121812 multi-component regulatory system-7 +FIG01121817 FIG01121818: hypothetical protein +FIG01121818 2-(S)-hydroxypropyl-CoM dehydrogenase( EC:1.1.1.269 ) +FIG01121826 FIG01121828: hypothetical protein +FIG01121832 putative serine protease (putative membrane protein) +FIG01121835 FIG01121836: hypothetical protein +FIG01121836 FIG01121838: hypothetical protein +FIG01121839 FIG01121840: hypothetical protein +FIG01121840 FIG01121841: hypothetical protein +FIG01121841 FIG01121842: hypothetical protein +FIG01121843 FIG01121844: hypothetical protein +FIG01121844 FIG01121845: hypothetical protein +FIG01121846 FIG01121847: hypothetical protein +FIG01121847 FIG01121848: hypothetical protein +FIG01121855 FIG01121856: hypothetical protein +FIG01121856 putative ion channel subunit +FIG01121857 FIG01121860: hypothetical protein +FIG01121860 FIG01121861: hypothetical protein +FIG01121861 FIG01121862: hypothetical protein +FIG01121867 FIG01121868: hypothetical protein +FIG01121868 Possible membrane protein +FIG01121869 FIG01121870: hypothetical protein +FIG01121873 FIG01121875: hypothetical protein +FIG01121875 FIG01121876: hypothetical protein +FIG01121877 FIG01121878: hypothetical protein +FIG01121881 FIG01121882: hypothetical protein +FIG01121882 FIG01121883: hypothetical protein +FIG01121883 FIG01121884: hypothetical protein +FIG01121884 FIG01121885: hypothetical protein +FIG01121886 FIG01121887: hypothetical protein +FIG01121888 FIG01121890: hypothetical protein +FIG01121890 sugar ABC transporter integral membrane subunit +FIG01121891 putative ABC transporter permease protein +FIG01121892 putative NLP/P60-family protein +FIG01121896 domain of unknown function / Cobalamin biosynthesis protein BluB @ 5,6-dimethylbenzimidazole synthase, flavin destructase family / Nicotinate-nucleotide--dimethylbenzimidazole phosphoribosyltransferase (EC 2.4.2.21) +FIG01121898 FIG01121900: hypothetical protein +FIG01121900 FIG01121902: hypothetical protein +FIG01121902 protein of unknown function DUF81 +FIG01121903 FIG01121904: hypothetical protein +FIG01121904 FIG01121905: hypothetical protein +FIG01121905 FIG01121906: hypothetical protein +FIG01121907 FIG01121908: hypothetical protein +FIG01121911 FIG01121913: hypothetical protein +FIG01121917 hypothetical protein SCD6.18 +FIG01121919 FIG01121920: hypothetical protein +FIG01121921 FIG01121923: hypothetical protein +FIG01121924 hypothetical protein SCE41.26 +FIG01121925 FIG01121927: hypothetical protein +FIG01121933 FIG01121934: hypothetical protein +FIG01121934 FIG01121935: hypothetical protein +FIG01121936 FIG01121937: hypothetical protein +FIG01121938 FIG01121941: hypothetical protein +FIG01121941 FIG01121942: hypothetical protein +FIG01121944 FIG01121945: hypothetical protein +FIG01121945 FIG01121947: hypothetical protein +FIG01121947 Cytochrome oxidase assembly protein +FIG01121950 FIG01121951: hypothetical protein +FIG01121956 FIG01121957: hypothetical protein +FIG01121958 FIG01121959: hypothetical protein +FIG01121959 FIG01121960: hypothetical protein +FIG01121960 FIG01121964: hypothetical protein +FIG01121964 polar amino acid ABC transporter, inner membrane subunit +FIG01121965 FIG01121967: hypothetical protein +FIG01121967 endo alpha-1,4 polygalactosaminidase +FIG01121970 FIG01121971: hypothetical protein +FIG01121972 FIG01121974: hypothetical protein +FIG01121974 secreted extracellular small neutral protease +FIG01121976 FIG01121978: hypothetical protein +FIG01121978 FIG01121979: hypothetical protein +FIG01121980 transferase +FIG01121981 FIG01121982: hypothetical protein +FIG01121982 FIG01121983: hypothetical protein +FIG01121983 secreted cellulose-binding protein +FIG01121988 ROK family transcriptional regulator +FIG01121989 FIG01121990: hypothetical protein +FIG01121990 FIG01121991: hypothetical protein +FIG01121991 sugar uptake ABC transporter sugar-binding protein +FIG01121994 FIG01121996: hypothetical protein +FIG01121996 secreted peptidoglycan binding protein +FIG01121998 FIG01122000: hypothetical protein +FIG01122000 FIG01122002: hypothetical protein +FIG01122003 FIG01122004: hypothetical protein +FIG01122012 FIG01122013: hypothetical protein +FIG01122014 FIG01122017: hypothetical protein +FIG01122019 FIG01122022: hypothetical protein +FIG01122026 FIG01122028: hypothetical protein +FIG01122029 FIG01122030: hypothetical protein +FIG01122030 FIG01122031: hypothetical protein +FIG01122031 FIG01122032: hypothetical protein +FIG01122032 FIG01122033: hypothetical protein +FIG01122034 FIG01122035: hypothetical protein +FIG01122035 FIG01122036: hypothetical protein +FIG01122036 ABC transporter transmembrane protein +FIG01122037 peptidase S8 and S53 subtilisin kexin sedolisin +FIG01122045 putative secreted protein. +FIG01122051 FIG01122052: hypothetical protein +FIG01122052 FIG01121988: hypothetical protein +FIG01122054 FIG01122055: hypothetical protein +FIG01122058 FIG01122059: hypothetical protein +FIG01122059 FIG01122060: hypothetical protein +FIG01122061 FIG01122062: hypothetical protein +FIG01122062 FIG01122063: hypothetical protein +FIG01122064 FIG01122066: hypothetical protein +FIG01122066 multi-component regulatory system-3 +FIG01122069 FIG01122071: hypothetical protein +FIG01122071 FIG01122072: hypothetical protein +FIG01122074 putative alkanal monooxygenase (luciferase) +FIG01122076 FIG01122077: hypothetical protein +FIG01122079 FIG01122080: hypothetical protein +FIG01122080 FIG01122081: hypothetical protein +FIG01122081 FIG01122082: hypothetical protein +FIG01122082 FIG01122083: hypothetical protein +FIG01122084 FIG01122085: hypothetical protein +FIG01122087 FIG01122088: hypothetical protein +FIG01122088 FIG01122089: hypothetical protein +FIG01122089 FIG01122092: hypothetical protein +FIG01122093 FIG01122098: hypothetical protein +FIG01122102 FIG01122104: hypothetical protein +FIG01122104 FIG01122106: hypothetical protein +FIG01122109 FIG01122110: hypothetical protein +FIG01122110 FIG01122111: hypothetical protein +FIG01122111 FIG01122112: hypothetical protein +FIG01122115 FIG01122116: hypothetical protein +FIG01122116 replication initiator protein +FIG01122117 FIG01122118: hypothetical protein +FIG01122119 FIG01122120: hypothetical protein +FIG01122121 FIG01122122: hypothetical protein +FIG01122122 FIG01122123: hypothetical protein +FIG01122123 FIG01122124: hypothetical protein +FIG01122124 FIG01122125: hypothetical protein +FIG01122125 Streptomycin biosynthesis protein strG +FIG01122127 PROBABLE AMINO-ACID ATP-BINDING ABC TRANSPORTER PROTEIN +FIG01122129 FIG01122131: hypothetical protein +FIG01122131 FIG01122133: hypothetical protein +FIG01122133 FIG01122137: hypothetical protein +FIG01122138 FIG01122139: hypothetical protein +FIG01122139 FIG01122141: hypothetical protein +FIG01122146 FIG01122149: hypothetical protein +FIG01122152 FIG01122158: hypothetical protein +FIG01122158 FIG01122159: hypothetical protein +FIG01122159 FIG01122160: hypothetical protein +FIG01122160 FIG00820755: hypothetical protein +FIG01122162 FIG01122163: hypothetical protein +FIG01122163 putative prolyl aminopeptidase +FIG01122166 FIG01122168: hypothetical protein +FIG01122171 FIG01122172: hypothetical protein +FIG01122176 FIG01122178: hypothetical protein +FIG01122178 FIG01122180: hypothetical protein +FIG01122182 FIG01122184: hypothetical protein +FIG01122184 FIG01122186: hypothetical protein +FIG01122189 FIG01122190: hypothetical protein +FIG01122190 FIG01122193: hypothetical protein +FIG01122193 FIG01122195: hypothetical protein +FIG01122195 FIG01122196: hypothetical protein +FIG01122198 FIG01122199: hypothetical protein +FIG01122199 hypothetical protein SCE34.17 +FIG01122201 FIG01122203: hypothetical protein +FIG01122203 FIG01122204: hypothetical protein +FIG01122204 FIG01122205: hypothetical protein +FIG01122205 FIG01122206: hypothetical protein +FIG01122206 FIG01122208: hypothetical protein +FIG01122208 RdlA protein +FIG01122212 FIG01122213: hypothetical protein +FIG01122213 FIG01122214: hypothetical protein +FIG01122214 FIG01122215: hypothetical protein +FIG01122216 FIG01122217: hypothetical protein +FIG01122217 FIG01122218: hypothetical protein +FIG01122218 FIG01122220: hypothetical protein +FIG01122223 FIG01122226: hypothetical protein +FIG01122226 Stage II sporulation E family protein +FIG01122227 FIG01122229: hypothetical protein +FIG01122232 putative LuxR-family transcriptional regulator +FIG01122233 FIG01122234: hypothetical protein +FIG01122237 FIG01122238: hypothetical protein +FIG01122239 FIG01122240: hypothetical protein +FIG01122242 FIG01122243: hypothetical protein +FIG01122244 FIG01122247: hypothetical protein +FIG01122247 FIG01122248: hypothetical protein +FIG01122248 FIG01122249: hypothetical protein +FIG01122249 FIG01122250: hypothetical protein +FIG01122251 FIG01122252: hypothetical protein +FIG01122252 FIG01122253: hypothetical protein +FIG01122253 putative glutamate binding protein +FIG01122254 FIG01122257: hypothetical protein +FIG01122261 FIG01122262: hypothetical protein +FIG01122262 FIG01122266: hypothetical protein +FIG01122266 FIG01122267: hypothetical protein +FIG01122267 FIG01122268: hypothetical protein +FIG01122268 FIG01122270: hypothetical protein +FIG01122271 FIG01122273: hypothetical protein +FIG01122273 FIG01122275: hypothetical protein +FIG01122275 FIG01122276: hypothetical protein +FIG01122276 FIG01122278: hypothetical protein +FIG01122279 FIG00659510: hypothetical protein +FIG01122281 FIG01122282: hypothetical protein +FIG01122287 ribosylglycohydrolase (secreted protein) +FIG01122288 FIG01122290: hypothetical protein +FIG01122291 FIG01122293: hypothetical protein +FIG01122301 FIG01122302: hypothetical protein +FIG01122302 FIG01122303: hypothetical protein +FIG01122305 FIG01122307: hypothetical protein +FIG01122309 FIG01122310: hypothetical protein +FIG01122311 FIG01122312: hypothetical protein +FIG01122312 FIG01122313: hypothetical protein +FIG01122314 FIG01122315: hypothetical protein +FIG01122315 FIG01122316: hypothetical protein +FIG01122320 FIG01122321: hypothetical protein +FIG01122321 FIG01122322: hypothetical protein +FIG01122322 FIG01122323: hypothetical protein +FIG01122327 FIG01122328: hypothetical protein +FIG01122328 FIG01122329: hypothetical protein +FIG01122332 MutT-family protein +FIG01122333 FIG01122334: hypothetical protein +FIG01122334 FIG01122336: hypothetical protein +FIG01122337 FIG01122338: hypothetical protein +FIG01122338 FIG01122339: hypothetical protein +FIG01122339 FIG01122340: hypothetical protein +FIG01122343 FIG01122344: hypothetical protein +FIG01122344 putative hydroxylase +FIG01122346 FIG01122347: hypothetical protein +FIG01122347 FIG01122349: hypothetical protein +FIG01122351 FIG01122353: hypothetical protein +FIG01122357 FIG01122358: hypothetical protein +FIG01122360 FIG01122362: hypothetical protein +FIG01122364 FIG01122365: hypothetical protein +FIG01122366 FIG01122367: hypothetical protein +FIG01122367 FIG01122369: hypothetical protein +FIG01122369 1-aminocyclopropane-1-carboxylate deaminase (EC 3.5.99.7) +FIG01122374 FIG01122375: hypothetical protein +FIG01122375 FIG01122376: hypothetical protein +FIG01122376 FIG01122377: hypothetical protein +FIG01122377 FIG01122378: hypothetical protein +FIG01122379 FIG01122381: hypothetical protein +FIG01122385 FIG01122386: hypothetical protein +FIG01122386 FIG01122387: hypothetical protein +FIG01122387 FIG01122388: hypothetical protein +FIG01122388 Apolipoprotein N-acyltransferase (EC 2.3.1.-) in lipid-linked oligosaccharide synthesis cluster +FIG01122389 FIG01122390: hypothetical protein +FIG01122390 FIG01122394: hypothetical protein +FIG01122395 FIG01122396: hypothetical protein +FIG01122396 FIG01122397: hypothetical protein +FIG01122397 putative LacI-family transcriptional regulator +FIG01122398 GntR-family transcriptional regulator DevA, required for proper development +FIG01122400 FIG01122401: hypothetical protein +FIG01122401 FIG01122403: hypothetical protein +FIG01122403 Substrate-binding region of ABC-type glycine betaine transport system +FIG01122404 ArsR-family transcriptional regulator +FIG01122405 FIG01122406: hypothetical protein +FIG01122406 FIG01122407: hypothetical protein +FIG01122408 FIG01122409: hypothetical protein +FIG01122409 FIG01122410: hypothetical protein +FIG01122410 FIG01122412: hypothetical protein +FIG01122412 putative acetyltransferase. +FIG01122413 FIG01122415: hypothetical protein +FIG01122419 putative cobalamin synthesis protein +FIG01122420 FIG01122421: hypothetical protein +FIG01122423 Oligopeptide transport ATP-binding protein oppD +FIG01122428 FIG01122429: hypothetical protein +FIG01122429 FIG01122430: hypothetical protein +FIG01122431 FIG01122433: hypothetical protein +FIG01122433 FIG01122435: hypothetical protein +FIG01122435 FIG01122436: hypothetical protein +FIG01122437 FIG01122438: hypothetical protein +FIG01122442 FIG01122443: hypothetical protein +FIG01122444 FIG01122445: hypothetical protein +FIG01122445 FIG01122446: hypothetical protein +FIG01122446 FIG01122448: hypothetical protein +FIG01122450 FIG01122454: hypothetical protein +FIG01122454 FIG01122455: hypothetical protein +FIG01122455 FIG01122456: hypothetical protein +FIG01122457 FIG01122459: hypothetical protein +FIG01122462 FIG01122463: hypothetical protein +FIG01122463 FIG01122465: hypothetical protein +FIG01122465 FIG01122466: hypothetical protein +FIG01122467 small hydrophobic protein (putative membrane protein) +FIG01122468 putative DNA polymerase III +FIG01122469 FIG01122471: hypothetical protein +FIG01122473 FIG01122474: hypothetical protein +FIG01122474 FIG01122475: hypothetical protein +FIG01122475 FIG01122476: hypothetical protein +FIG01122476 FIG01122477: hypothetical protein +FIG01122478 FIG01122479: hypothetical protein +FIG01122480 FIG01122482: hypothetical protein +FIG01122482 FIG01122483: hypothetical protein +FIG01122486 FIG01122489: hypothetical protein +FIG01122489 aldo/keto reductase +FIG01122490 non-ribosomal peptide synthetase, terminal component +FIG01122495 FIG01122496: hypothetical protein +FIG01122496 FIG01122497: hypothetical protein +FIG01122498 FIG01122499: hypothetical protein +FIG01122500 FIG01122501: hypothetical protein +FIG01122501 FIG01122502: hypothetical protein +FIG01122503 FIG01122504: hypothetical protein +FIG01122504 FIG01122506: hypothetical protein +FIG01122507 putative secreted endoglucanase +FIG01122508 FIG01122510: hypothetical protein +FIG01122511 FIG01122514: hypothetical protein +FIG01122514 FIG01122515: hypothetical protein +FIG01122515 FIG01122516: hypothetical protein +FIG01122518 FIG01122521: hypothetical protein +FIG01122521 FIG01122522: hypothetical protein +FIG01122526 deacetylase (secreted protein) +FIG01122527 FIG01122531: hypothetical protein +FIG01122531 FIG01122534: hypothetical protein +FIG01122534 FIG01122535: hypothetical protein +FIG01122535 FIG01122536: hypothetical protein +FIG01122537 FIG01122538: hypothetical protein +FIG01122542 FIG01122543: hypothetical protein +FIG01122543 FIG01122544: hypothetical protein +FIG01122544 FIG01122545: hypothetical protein +FIG01122546 FIG01122547: hypothetical protein +FIG01122547 FIG01122548: hypothetical protein +FIG01122555 hypothetical protein SCF91.31c. +FIG01122557 FIG01122558: hypothetical protein +FIG01122560 FIG01122561: hypothetical protein +FIG01122561 ORF1 +FIG01122562 FIG01122564: hypothetical protein +FIG01122564 hypothetical protein, SCC4613 +FIG01122567 FIG01122568: hypothetical protein +FIG01122568 FIG01122571: hypothetical protein +FIG01122571 FIG01122572: hypothetical protein +FIG01122572 FIG01122573: hypothetical protein +FIG01122574 FIG01122575: hypothetical protein +FIG01122575 FIG01122576: hypothetical protein +FIG01122577 FIG01122582: hypothetical protein +FIG01122582 hypothetical protein, SCM10.04c +FIG01122584 FIG01122586: hypothetical protein +FIG01122586 FIG01122587: hypothetical protein +FIG01122587 FIG01122588: hypothetical protein +FIG01122588 FIG01122590: hypothetical protein +FIG01122593 hypothetical protein SCL6.09 +FIG01122595 FIG01122596: hypothetical protein +FIG01122597 secreted lyase +FIG01122599 FIG01122600: hypothetical protein +FIG01122601 Phosphosugar mutase of unknown sugar (see annotation) +FIG01122606 Lanthionine biosynthesis cyclase LanC +FIG01122608 FIG01122609: hypothetical protein +FIG01122609 FIG01122610: hypothetical protein +FIG01122610 FIG01122611: hypothetical protein +FIG01122614 FIG01122615: hypothetical protein +FIG01122618 FIG01122619: hypothetical protein +FIG01122619 FIG01122620: hypothetical protein +FIG01122623 FIG01122624: hypothetical protein +FIG01122624 FIG01122625: hypothetical protein +FIG01122625 FIG01122626: hypothetical protein +FIG01122627 FIG01122629: hypothetical protein +FIG01122630 FIG01122631: hypothetical protein +FIG01122634 putative NLP/P60 family protein (putative secreted protein) +FIG01122636 putative C-3 methyl transferase +FIG01122639 FIG01122643: hypothetical protein +FIG01122647 FIG01122649: hypothetical protein +FIG01122649 FIG01122650: hypothetical protein +FIG01122650 FIG01122651: hypothetical protein +FIG01122653 FIG01122654: hypothetical protein +FIG01122654 tRNA/rRNA methyltransferase +FIG01122656 FIG01122657: hypothetical protein +FIG01122657 FIG01122658: hypothetical protein +FIG01122658 FIG01122660: hypothetical protein +FIG01122660 FIG00995041: hypothetical protein +FIG01122662 FIG01122663: hypothetical protein +FIG01122665 FIG01122667: hypothetical protein +FIG01122668 FIG01122669: hypothetical protein +FIG01122672 FIG01122673: hypothetical protein +FIG01122673 FIG01122674: hypothetical protein +FIG01122674 FIG01122676: hypothetical protein +FIG01122678 FIG01122680: hypothetical protein +FIG01122680 FIG01122682: hypothetical protein +FIG01122683 FIG01122684: hypothetical protein +FIG01122686 FIG01122687: hypothetical protein +FIG01122687 putative MerR-family transcriptional regulator +FIG01122688 FIG01122692: hypothetical protein +FIG01122693 FIG01122694: hypothetical protein +FIG01122694 FIG01122698: hypothetical protein +FIG01122700 FIG01122701: hypothetical protein +FIG01122701 FIG01122702: hypothetical protein +FIG01122703 FIG01122704: hypothetical protein +FIG01122704 FIG01122705: hypothetical protein +FIG01122705 FIG01122706: hypothetical protein +FIG01122706 FAD-dependent oxygenase +FIG01122707 FIG01122708: hypothetical protein +FIG01122709 FIG01122712: hypothetical protein +FIG01122712 FIG01122713: hypothetical protein +FIG01122714 FIG01122716: hypothetical protein +FIG01122716 FIG01122717: hypothetical protein +FIG01122717 putative small secreted protein +FIG01122720 FIG01122721: hypothetical protein +FIG01122721 FIG01122723: hypothetical protein +FIG01122724 FIG01122725: hypothetical protein +FIG01122726 FIG01122727: hypothetical protein +FIG01122730 FIG01122731: hypothetical protein +FIG01122731 FIG01122732: hypothetical protein +FIG01122734 hypothetical protein SCL24.07 +FIG01122735 pyridoxamine 5'-phosphate oxidase-related, FMN-binding protein +FIG01122737 FIG01122738: hypothetical protein +FIG01122745 FIG01122746: hypothetical protein +FIG01122747 FIG01122749: hypothetical protein +FIG01122753 putative membrane prootein +FIG01122757 FIG052618: hypothetical antitoxin ( to FIG131131: hypothetical toxin) +FIG01122768 Sensor protein cutS (EC 2.7.13.3) +FIG01122769 FIG01122771: hypothetical protein +FIG01122772 FIG01122774: hypothetical protein +FIG01122777 Chitinase (EC 3.2.1.14) +FIG01122786 FIG01122787: hypothetical protein +FIG01122787 FIG01122788: hypothetical protein +FIG01122788 putative LuxAB-like protein (oxygenase) +FIG01122789 FIG01122791: hypothetical protein +FIG01122795 FIG01122796: hypothetical protein +FIG01122796 FIG01122797: hypothetical protein +FIG01122797 FIG01122798: hypothetical protein +FIG01122799 FIG01122800: hypothetical protein +FIG01122801 FIG01122804: hypothetical protein +FIG01122806 FIG01122808: hypothetical protein +FIG01122811 FIG01122813: hypothetical protein +FIG01122813 FIG01122814: hypothetical protein +FIG01122814 FIG01122815: hypothetical protein +FIG01122815 FIG01122816: hypothetical protein +FIG01122819 FIG01122820: hypothetical protein +FIG01122820 putative LacI-family transcriptional regulatory protein +FIG01122821 FIG01122823: hypothetical protein +FIG01122828 FIG01122830: hypothetical protein +FIG01122830 FIG01122831: hypothetical protein +FIG01122831 FIG01122832: hypothetical protein +FIG01122832 FIG01122836: hypothetical protein +FIG01122839 FIG131131: hypothetical toxin +FIG01122840 FIG01122841: hypothetical protein +FIG01122841 FIG01122842: hypothetical protein +FIG01122844 putative ArsR-family transcriptional regulatory protein. +FIG01122846 FIG01122848: hypothetical protein +FIG01122852 FIG01122853: hypothetical protein +FIG01122857 FIG01122858: hypothetical protein +FIG01122860 FIG01122861: hypothetical protein +FIG01122864 FIG01122865: hypothetical protein +FIG01122872 FIG01122873: hypothetical protein +FIG01122874 FIG01122875: hypothetical protein +FIG01122875 FIG01122878: hypothetical protein +FIG01122878 FIG01122879: hypothetical protein +FIG01122879 FIG01122880: hypothetical protein +FIG01122886 putative drug exporters of the RND superfamily +FIG01122891 FIG01122893: hypothetical protein +FIG01122893 FIG01122894: hypothetical protein +FIG01122894 FIG01122895: hypothetical protein +FIG01122903 Pleiotropic negative regulator for morphological and physiological development in Streptomyces, BldD +FIG01122906 FIG01122907: hypothetical protein +FIG01122907 FIG01122908: hypothetical protein +FIG01122912 FIG00816680: hypothetical protein +FIG01122915 putative thiolase +FIG01122919 FIG01122922: hypothetical protein +FIG01122922 FIG01122923: hypothetical protein +FIG01122923 FIG01122924: hypothetical protein +FIG01122925 Transcriptional regulator KorSA, GntR family +FIG01122930 FIG01122931: hypothetical protein +FIG01122933 FIG01122934: hypothetical protein +FIG01122934 FIG01122936: hypothetical protein +FIG01122937 reductase +FIG01122940 FIG01122941: hypothetical protein +FIG01122941 FIG01122942: hypothetical protein +FIG01122943 FIG01122945: hypothetical protein +FIG01122945 FIG01122946: hypothetical protein +FIG01122946 Probable protease htpX homolog 1 (EC 3.4.24.-) +FIG01122949 FIG01122952: hypothetical protein +FIG01122954 FIG01122955: hypothetical protein +FIG01122955 putative ppGpp synthetase/hydrolase +FIG01122960 FIG01122961: hypothetical protein +FIG01122966 FIG01122968: hypothetical protein +FIG01122968 FIG01122970: hypothetical protein +FIG01122971 putative polyketide cyclase /reductase +FIG01122974 FIG01122975: hypothetical protein +FIG01122980 FIG01122981: hypothetical protein +FIG01122984 FIG01122985: hypothetical protein +FIG01122991 FIG01122994: hypothetical protein +FIG01122994 FIG01122996: hypothetical protein +FIG01122996 FIG01122997: hypothetical protein +FIG01122999 FIG01050400: hypothetical protein +FIG01123000 sporulation associated protein +FIG01123003 FIG01123004: hypothetical protein +FIG01123004 FIG01123005: hypothetical protein +FIG01123005 FIG01123006: hypothetical protein +FIG01123007 FIG01123008: hypothetical protein +FIG01123008 FIG00820727: hypothetical protein +FIG01123010 sensor kinase protein +FIG01123012 FIG01123014: hypothetical protein +FIG01123018 FIG01123019: hypothetical protein +FIG01123023 3-oxoadipate enol-lactone hydrolase +FIG01123024 FIG01123026: hypothetical protein +FIG01123026 probable two-component system sensor kinase +FIG01123029 FIG01123030: hypothetical protein +FIG01123031 FIG01123032: hypothetical protein +FIG01123032 FIG01123034: hypothetical protein +FIG01123034 FIG01123036: hypothetical protein +FIG01123036 FIG01123037: hypothetical protein +FIG01123037 FIG01123038: hypothetical protein +FIG01123038 FIG01123039: hypothetical protein +FIG01123039 FIG01123040: hypothetical protein +FIG01123040 FIG01123041: hypothetical protein +FIG01123051 FIG01123053: hypothetical protein +FIG01123053 FIG01123054: hypothetical protein +FIG01123054 FIG01123055: hypothetical protein +FIG01123056 FIG01123058: hypothetical protein +FIG01123058 FIG01123061: hypothetical protein +FIG01123064 FIG01123065: hypothetical protein +FIG01123066 FIG01123068: hypothetical protein +FIG01123068 FIG01123070: hypothetical protein +FIG01123070 FIG01123071: hypothetical protein +FIG01123071 FIG01123073: hypothetical protein +FIG01123073 TetR-family transcriptional regulator +FIG01123076 FIG01123079: hypothetical protein +FIG01123079 putative proteinase +FIG01123080 FIG01123081: hypothetical protein +FIG01123081 Caffeoyl-CoA O-methyltransferase( EC:2.1.1.104 ) +FIG01123082 FIG01123083: hypothetical protein +FIG01123083 FIG01123087: hypothetical protein +FIG01123088 FIG01123089: hypothetical protein +FIG01123091 FIG01123093: hypothetical protein +FIG01123093 FIG01123094: hypothetical protein +FIG01123094 FIG01123098: hypothetical protein +FIG01123098 FIG01123099: hypothetical protein +FIG01123103 FIG01123105: hypothetical protein +FIG01123105 membrane protein SCJ126 +FIG01123109 FIG01123112: hypothetical protein +FIG01123112 FIG01123113: hypothetical protein +FIG01123115 FIG01123116: hypothetical protein +FIG01123116 nitroreductase +FIG01123120 FIG01123121: hypothetical protein +FIG01123123 conserved hypothetical protein SC8G12.04. +FIG01123132 putative membrane spanning protein +FIG01123133 FIG01123135: hypothetical protein +FIG01123136 FIG01123137: hypothetical protein +FIG01123142 regulatory protein, LacI +FIG01123143 SC6G10.11c, len: 79aa +FIG01123144 isomerase +FIG01123145 FIG01123146: hypothetical protein +FIG01123146 FIG01123147: hypothetical protein +FIG01123147 FIG01123150: hypothetical protein +FIG01123150 FIG01123152: hypothetical protein +FIG01123152 FIG01123153: hypothetical protein +FIG01123153 FIG01123155: hypothetical protein +FIG01123155 putative sugar transporter membrane protein +FIG01123162 FIG01123164: hypothetical protein +FIG01123166 FIG01123167: hypothetical protein +FIG01123169 FIG01123171: hypothetical protein +FIG01123171 FIG01123173: hypothetical protein +FIG01123173 FIG01123174: hypothetical protein +FIG01123174 FIG01123175: hypothetical protein +FIG01123177 FIG01123178: hypothetical protein +FIG01123179 FIG01123180: hypothetical protein +FIG01123186 FIG01123187: hypothetical protein +FIG01123191 FIG01123193: hypothetical protein +FIG01123193 FIG01123194: hypothetical protein +FIG01123198 FIG01123199: hypothetical protein +FIG01123199 FIG01123200: hypothetical protein +FIG01123200 FIG01123201: hypothetical protein +FIG01123201 FIG01123202: hypothetical protein +FIG01123203 FIG01123204: hypothetical protein +FIG01123204 FIG01123205: hypothetical protein +FIG01123205 putative septum site-determining protein +FIG01123206 Putative glutamate mutase subumit E +FIG01123211 FIG01123212: hypothetical protein +FIG01123214 FIG01123215: hypothetical protein +FIG01123215 FIG01123217: hypothetical protein +FIG01123217 putative integral membrane transporter +FIG01123218 FIG01123219: hypothetical protein +FIG01123221 FIG01123222: hypothetical protein +FIG01123222 FIG01123223: hypothetical protein +FIG01123228 FIG01123230: hypothetical protein +FIG01123232 FIG01123233: hypothetical protein +FIG01123234 FIG01123235: hypothetical protein +FIG01123235 FIG01123236: hypothetical protein +FIG01123236 SC5F2A.07, unknown, len: 109 aa +FIG01123240 FIG01123243: hypothetical protein +FIG01123243 FIG01123244: hypothetical protein +FIG01123244 FIG01123246: hypothetical protein +FIG01123246 Putative membrane protein (Fragment) +FIG01123249 FIG01123251: hypothetical protein +FIG01123252 FIG01123253: hypothetical protein +FIG01123255 FIG01123256: hypothetical protein +FIG01123256 probable amino acid ABC transporter integral membrane protein +FIG01123264 FIG01123265: hypothetical protein +FIG01123265 FIG01123266: hypothetical protein +FIG01123266 FIG01123268: hypothetical protein +FIG01123268 FIG129854: hypothetical protein +FIG01123272 FIG01123273: hypothetical protein +FIG01123273 putative NLP/P60 family protein +FIG01123274 FIG01123275: hypothetical protein +FIG01123275 FIG01123277: hypothetical protein +FIG01123277 FIG01123278: hypothetical protein +FIG01123278 FIG01123280: hypothetical protein +FIG01123280 FIG01123282: hypothetical protein +FIG01123282 FIG01123283: hypothetical protein +FIG01123286 integrase (recombinase) +FIG01123287 FIG01123291: hypothetical protein +FIG01123291 FIG01123292: hypothetical protein +FIG01123292 FIG01123293: hypothetical protein +FIG01123293 FIG01123294: hypothetical protein +FIG01123299 FIG01123300: hypothetical protein +FIG01123300 FIG01123301: hypothetical protein +FIG01123301 FIG01123302: hypothetical protein +FIG01123304 Probable phosphoglycerate mutase +FIG01123305 putative adenylate cyclase +FIG01123309 hypothetical protein SCI8.13 +FIG01123312 probable LysR-family transcriptional regulator. +FIG01123315 FIG01123316: hypothetical protein +FIG01123321 putative gas vesicle synthesis protein +FIG01123323 FIG01123324: hypothetical protein +FIG01123324 FIG01123325: hypothetical protein +FIG01123331 multi-component regulatory system-2 +FIG01123332 FIG01123333: hypothetical protein +FIG01123333 FIG01123334: hypothetical protein +FIG01123337 FIG01123338: hypothetical protein +FIG01123338 FIG01123341: hypothetical protein +FIG01123341 FIG01123342: hypothetical protein +FIG01123342 putative N-formylglutamate aminohydrolase +FIG01123350 SCBAC25E3.11c, unknown, len: 321aa: contains Pfam match to entry PF02810 SEC-C, SEC-C motif. +FIG01123351 FIG01123352: hypothetical protein +FIG01123352 FIG01123353: hypothetical protein +FIG01123353 FIG01123354: hypothetical protein +FIG01123355 FIG01123357: hypothetical protein +FIG01123357 FIG01123359: hypothetical protein +FIG01123359 FIG01123360: hypothetical protein +FIG01123360 FIG01123361: hypothetical protein +FIG01123361 FIG01123362: hypothetical protein +FIG01123362 FIG01123363: hypothetical protein +FIG01123366 FIG01123367: hypothetical protein +FIG01123368 FIG01123369: hypothetical protein +FIG01123375 FIG01123376: hypothetical protein +FIG01123376 SpdC2 protein +FIG01123379 FIG01123380: hypothetical protein +FIG01123381 FIG01123382: hypothetical protein +FIG01123382 FIG01123383: hypothetical protein +FIG01123383 FIG01123384: hypothetical protein +FIG01123384 FIG01123385: hypothetical protein +FIG01123385 Glycosyltransferase of family GT2 +FIG01123387 putative serine/threonine phosphatase +FIG01123396 FIG01123397: hypothetical protein +FIG01123397 FIG01123398: hypothetical protein +FIG01123407 FIG01123408: hypothetical protein +FIG01123409 FIG01123411: hypothetical protein +FIG01123412 FIG01123413: hypothetical protein +FIG01123413 FIG01123415: hypothetical protein +FIG01123415 FIG01123416: hypothetical protein +FIG01123416 FIG01123417: hypothetical protein +FIG01123419 FIG01123420: hypothetical protein +FIG01123421 FIG01123422: hypothetical protein +FIG01123422 Competence-like protein +FIG01123423 putative DNA polymerase III epsilon subunit +FIG01123425 FIG01123426: hypothetical protein +FIG01123430 FIG01123434: hypothetical protein +FIG01123434 FIG01123435: hypothetical protein +FIG01123443 FIG01123446: hypothetical protein +FIG01123446 FIG01123447: hypothetical protein +FIG01123447 FIG01123449: hypothetical protein +FIG01123450 FIG01123451: hypothetical protein +FIG01123451 FIG01123453: hypothetical protein +FIG01123453 FIG01123454: hypothetical protein +FIG01123454 FIG01123455: hypothetical protein +FIG01123457 FIG01123461: hypothetical protein +FIG01123462 FIG01123466: hypothetical protein +FIG01123466 FIG01123467: hypothetical protein +FIG01123467 FIG01123468: hypothetical protein +FIG01123468 FIG01123471: hypothetical protein +FIG01123474 FIG01123476: hypothetical protein +FIG01123477 FIG01123478: hypothetical protein +FIG01123485 putative arginine/ornithine binding protein +FIG01123487 FIG01123488: hypothetical protein +FIG01123488 FIG01123489: hypothetical protein +FIG01123489 FIG01123490: hypothetical protein +FIG01123490 FIG01123491: hypothetical protein +FIG01123491 FIG01123492: hypothetical protein +FIG01123495 FIG01123497: hypothetical protein +FIG01123498 FIG01123499: hypothetical protein +FIG01123499 FIG01123500: hypothetical protein +FIG01123502 FIG01123503: hypothetical protein +FIG01123503 putative L-arabinose ABC transporter, permease component +FIG01123504 FIG01123505: hypothetical protein +FIG01123510 FIG01123512: hypothetical protein +FIG01123512 FIG01123513: hypothetical protein +FIG01123513 FIG01123514: hypothetical protein +FIG01123519 FIG01123520: hypothetical protein +FIG01123524 SC8B7.06c, unknown, len: 152 aa +FIG01123533 FIG01123536: hypothetical protein +FIG01123543 FIG01123544: hypothetical protein +FIG01123555 putative short chain oxidoreductase +FIG01123556 FIG01123560: hypothetical protein +FIG01123566 FIG01123568: hypothetical protein +FIG01123570 integral membrane transport protein +FIG01123571 FIG01123572: hypothetical protein +FIG01123573 FIG01123574: hypothetical protein +FIG01123575 uncharacterized membrane-associated protein-like protein +FIG01123578 FIG01123579: Glyoxalase/bleomycin resistance protein/dioxygenase +FIG01123579 FIG01123580: hypothetical protein +FIG01123583 integral membrane efflux protein +FIG01123584 FIG01123585: hypothetical protein +FIG01123590 FIG01123591: hypothetical protein +FIG01123591 FIG01123592: hypothetical protein +FIG01123592 FIG01123593: hypothetical protein +FIG01123593 FIG01123594: hypothetical protein +FIG01123594 FIG01123598: hypothetical protein +FIG01123600 FIG01123602: hypothetical protein +FIG01123603 FIG01123604: hypothetical protein +FIG01123605 FIG01123606: hypothetical protein +FIG01123611 FIG01123612: hypothetical protein +FIG01123613 FIG01123615: hypothetical protein +FIG01123616 hypothetical protein SC5A7.24c +FIG01123617 FIG01123619: hypothetical protein +FIG01123624 FIG01123626: hypothetical protein +FIG01123628 FIG01123629: hypothetical protein +FIG01123630 FIG01123631: hypothetical protein +FIG01123631 FIG01123633: hypothetical protein +FIG01123633 subtilisin inhibitor +FIG01123634 FIG01123636: hypothetical protein +FIG01123641 FIG01123643: hypothetical protein +FIG01123643 FIG01123644: hypothetical protein +FIG01123644 FIG01123645: hypothetical protein +FIG01123645 FIG01123648: hypothetical protein +FIG01123648 FIG01123649: hypothetical protein +FIG01123651 FIG01123652: hypothetical protein +FIG01123652 glycine-rich secreted protein +FIG01123653 secreted pectate lyase +FIG01123654 FIG01123655: hypothetical protein +FIG01123661 FIG01123664: hypothetical protein +FIG01123665 Putative regulator of the mannose operon, ManO +FIG01123669 Sterol-binding +FIG01123673 FIG01123674: hypothetical protein +FIG01123675 FIG01123676: hypothetical protein +FIG01123676 FIG01123678: hypothetical protein +FIG01123680 FIG01123681: hypothetical protein +FIG01123681 FIG01123682: hypothetical protein +FIG01123682 regulator protein +FIG01123685 FIG01123687: hypothetical protein +FIG01123687 putative ankyrin-like protein. +FIG01123688 FIG01123689: hypothetical protein +FIG01123689 FIG01123690: hypothetical protein +FIG01123691 FIG01123692: hypothetical protein +FIG01123692 FIG01123695: hypothetical protein +FIG01123696 FIG01123697: hypothetical protein +FIG01123697 putative alcohol dehydrogenase (zinc-binding) +FIG01123704 putative fatty acid-CoA ligase +FIG01123707 FIG01123710: hypothetical protein +FIG01123711 actinorhodin polyketide synthase bifunctional cyclase/dehydratase +FIG01123715 Mg(2+) transport ATPase, P-type (EC 3.6.3.2) +FIG01123717 FIG01123719: hypothetical protein +FIG01123719 FIG01123720: hypothetical protein +FIG01123720 putative DNA topology modulation protein FlaR +FIG01123721 FIG01123722: hypothetical protein +FIG01123722 FIG01123723: hypothetical protein +FIG01123723 Ser/Arg-related nuclear matrix protein +FIG01123724 FIG01123726: hypothetical protein +FIG01123727 FIG01123728: hypothetical protein +FIG01123728 FIG01123729: hypothetical protein +FIG01123729 FIG01123730: hypothetical protein +FIG01123730 putative MutT/NUDIX-family protein +FIG01123733 FIG01123734: hypothetical protein +FIG01123734 FIG01123735: hypothetical protein +FIG01123735 FIG01123736: hypothetical protein +FIG01123736 FIG01123738: hypothetical protein +FIG01123740 FIG01123741: hypothetical protein +FIG01123741 FIG01123744: hypothetical protein +FIG01123745 FIG01123746: hypothetical protein +FIG01123746 FIG01123747: hypothetical protein +FIG01123747 putative aldehyde dehydrogenase +FIG01123748 FIG01123749: hypothetical protein +FIG01123749 FIG01123753: hypothetical protein +FIG01123754 FIG01123755: hypothetical protein +FIG01123755 FIG01123756: hypothetical protein +FIG01123757 putative cellobiose transport permease +FIG01123758 sensor-like histidine kinase +FIG01123759 FIG01123761: hypothetical protein +FIG01123767 FIG01123768: hypothetical protein +FIG01123770 SC6G10.32, unknown, len: 69aa +FIG01123773 FIG01123776: hypothetical protein +FIG01123776 MutT1 +FIG01123777 FIG01123778: hypothetical protein +FIG01123780 FIG01123781: hypothetical protein +FIG01123781 FIG01123782: hypothetical protein +FIG01123783 FIG01123784: hypothetical protein +FIG01123787 FIG01123788: hypothetical protein +FIG01123788 FIG01123789: hypothetical protein +FIG01123789 FIG01123792: hypothetical protein +FIG01123792 FIG01123793: hypothetical protein +FIG01123793 FIG01123794: hypothetical protein +FIG01123795 FIG01123796: hypothetical protein +FIG01123796 FIG01123798: hypothetical protein +FIG01123798 FIG01123799: hypothetical protein +FIG01123799 nudix hydrolase +FIG01123801 FIG01123805: hypothetical protein +FIG01123805 putative solute binding transport lipoprotein +FIG01123806 FIG01123807: hypothetical protein +FIG01123811 protein of unknown function DUF407 +FIG01123813 FIG01123816: hypothetical protein +FIG01123821 FIG01123823: hypothetical protein +FIG01123826 5-carboxymethyl-2-hydroxymuconate delta-isomerase( EC:5.3.3.10 ) +FIG01123827 FIG01123828: hypothetical protein +FIG01123829 FIG01123830: hypothetical protein +FIG01123830 FIG01123831: hypothetical protein +FIG01123831 FIG01123833: hypothetical protein +FIG01123833 FIG01123834: hypothetical protein +FIG01123834 FIG01123835: hypothetical protein +FIG01123835 FIG01123836: hypothetical protein +FIG01123836 FIG01123837: hypothetical protein +FIG01123837 FIG01123838: hypothetical protein +FIG01123840 FIG01123843: hypothetical protein +FIG01123844 FIG01123845: hypothetical protein +FIG01123845 FIG01123846: hypothetical protein +FIG01123846 FIG01123848: hypothetical protein +FIG01123848 FIG01123849: hypothetical protein +FIG01123849 FIG01123850: hypothetical protein +FIG01123851 FIG01123853: hypothetical protein +FIG01123856 FIG01123857: hypothetical protein +FIG01123858 FIG01123859: hypothetical protein +FIG01123860 Penicillin amidase precursor (EC 3.5.1.11) +FIG01123862 FIG01123865: hypothetical protein +FIG01123865 FIG01123867: hypothetical protein +FIG01123868 SCI51.04, hypothetical protein, len: 253 aa; unknown function, shows weak similarity to TR:P94389 (EMBL:D50453), YcgL, Bacillus subtilis hypothetical protein (260 aa), fasta scores; opt: 177 z-score: 222.1 E(): 5.1e-05, 28.1% identity in 196 aa overlap. There is some overlap with the C-terminus of SCI51.5c and weak similarity with SCI51.5c (250 aa) (29.6% identity in 233 aa overlap) +FIG01123870 Periplasmic binding protein +FIG01123872 FIG01123873: hypothetical protein +FIG01123873 FIG01123875: hypothetical protein +FIG01123876 Putative aminoacid efflux protein +FIG01123878 FIG01123879: hypothetical protein +FIG01123881 Probable peptidyl-prolyl cis-trans isomerase B (EC 5.2.1.8) (PPIase B) (Rotamase B) +FIG01123884 FIG01123886: hypothetical protein +FIG01123888 FIG01123889: hypothetical protein +FIG01123893 FIG01123894: hypothetical protein +FIG01123894 protein MbtH +FIG01123895 FIG01123896: hypothetical protein +FIG01123896 FIG01123898: hypothetical protein +FIG01123900 FIG01123901: hypothetical protein +FIG01123901 FIG01123905: hypothetical protein +FIG01123905 lacI-family transcriptional regulatory protein +FIG01123910 FIG01123914: hypothetical protein +FIG01123914 FIG01123915: hypothetical protein +FIG01123917 FIG01123918: hypothetical protein +FIG01123926 FIG01123928: hypothetical protein +FIG01123929 FIG01123931: hypothetical protein +FIG01123931 FIG01123933: hypothetical protein +FIG01123933 FIG01123935: hypothetical protein +FIG01123935 FIG01123937: hypothetical protein +FIG01123937 FIG01123938: hypothetical protein +FIG01123938 FIG01123940: hypothetical protein +FIG01123943 membrane protei +FIG01123948 FIG01123949: hypothetical protein +FIG01123952 conserved hypothetical protein SC6D10.11 +FIG01123953 FIG01123954: hypothetical protein +FIG01123958 FIG01123959: hypothetical protein +FIG01123959 FIG01123960: hypothetical protein +FIG01123972 FIG01123973: hypothetical protein +FIG01123973 FIG01123975: hypothetical protein +FIG01123975 FIG01123976: hypothetical protein +FIG01123976 FIG01123977: hypothetical protein +FIG01123977 FIG01123978: hypothetical protein +FIG01123978 FIG01123979: hypothetical protein +FIG01123979 FIG01123980: hypothetical protein +FIG01123980 possible integral membrane protein +FIG01123984 FIG01123985: hypothetical protein +FIG01123985 putative ABC-transporter transmembrane protein +FIG01123991 FIG01123992: hypothetical protein +FIG01123992 FIG01123995: hypothetical protein +FIG01123995 FIG01123996: hypothetical protein +FIG01124000 FIG01124001: hypothetical protein +FIG01124003 FIG01124005: hypothetical protein +FIG01124005 FIG01124006: hypothetical protein +FIG01124006 FIG01124008: hypothetical protein +FIG01124008 FIG01124010: hypothetical protein +FIG01124010 FIG01124012: hypothetical protein +FIG01124012 FIG01124013: hypothetical protein +FIG01124018 FIG01124019: hypothetical protein +FIG01124020 FIG01124021: hypothetical protein +FIG01124022 FIG01124023: hypothetical protein +FIG01124027 FIG01124029: hypothetical protein +FIG01124033 FIG01124035: hypothetical protein +FIG01124035 regulator +FIG01124036 FIG01124038: hypothetical protein +FIG01124044 putative secreted protease +FIG01124046 FIG01124047: hypothetical protein +FIG01124047 FIG01124048: hypothetical protein +FIG01124049 surface antigen gene +FIG01124057 FIG01124058: hypothetical protein +FIG01124059 FIG01124060: hypothetical protein +FIG01124060 putative two-component sensor +FIG01124062 Carboxypeptidase T (EC 3.4.17.18) +FIG01124064 FIG01124065: hypothetical protein +FIG01124065 FIG01124067: hypothetical protein +FIG01124067 FIG01124068: hypothetical protein +FIG01124068 FIG01124069: hypothetical protein +FIG01124072 FIG01124074: hypothetical protein +FIG01124078 FIG01124079: hypothetical protein +FIG01124079 FIG01124080: hypothetical protein +FIG01124081 iron-siderophore binding lipoprotein +FIG01124083 FIG01124085: hypothetical protein +FIG01124088 FIG01124089: hypothetical protein +FIG01124090 FIG01124091: hypothetical protein +FIG01124093 FIG01124094: hypothetical protein +FIG01124101 FIG01124104: hypothetical protein +FIG01124109 FIG01124112: hypothetical protein +FIG01124113 FIG01124114: hypothetical protein +FIG01124121 FIG01124122: hypothetical protein +FIG01124122 FIG01124123: hypothetical protein +FIG01124125 FIG01124127: hypothetical protein +FIG01124130 FIG01124133: hypothetical protein +FIG01124136 FIG01124138: hypothetical protein +FIG01124138 FIG01124140: hypothetical protein +FIG01124140 FIG01124141: hypothetical protein +FIG01124142 FIG01124143: hypothetical protein +FIG01124143 FIG01124144: hypothetical protein +FIG01124144 FIG01124145: hypothetical protein +FIG01124147 FIG01124148: hypothetical protein +FIG01124148 FIG01124150: hypothetical protein +FIG01124150 FIG01124151: hypothetical protein +FIG01124154 FIG01124155: hypothetical protein +FIG01124168 FIG01124169: hypothetical protein +FIG01124170 FIG01124172: hypothetical protein +FIG01124173 FIG01124174: hypothetical protein +FIG01124174 FIG01124175: hypothetical protein +FIG01124182 FIG01124183: hypothetical protein +FIG01124184 FIG01124185: hypothetical protein +FIG01124185 FIG01124186: hypothetical protein +FIG01124193 FIG01124194: hypothetical protein +FIG01124195 FIG01124198: hypothetical protein +FIG01124199 FIG01124200: hypothetical protein +FIG01124200 FIG01124202: hypothetical protein +FIG01124205 FIG01124206: hypothetical protein +FIG01124209 FIG01124211: hypothetical protein +FIG01124211 FIG01124213: hypothetical protein +FIG01124214 FIG01124215: hypothetical protein +FIG01124221 FIG01124222: hypothetical protein +FIG01124222 FIG01124227: hypothetical protein +FIG01124229 integral membrane transporter +FIG01124234 serine/threonine protein kinase (fragment) +FIG01124237 FIG01124238: hypothetical protein +FIG01124239 Cinorf9 protein +FIG01124240 FIG01124241: hypothetical protein +FIG01124243 FIG01124246: hypothetical protein +FIG01124246 FIG01124249: hypothetical protein +FIG01124250 FIG01124251: hypothetical protein +FIG01124253 FIG01124256: hypothetical protein +FIG01124256 FIG01124257: hypothetical protein +FIG01124257 FIG01124258: hypothetical protein +FIG01124260 FIG01124262: hypothetical protein +FIG01124263 FIG01124264: hypothetical protein +FIG01124264 FIG01124265: hypothetical protein +FIG01124265 SgaA homolog +FIG01124268 FIG01124270: hypothetical protein +FIG01124270 FIG01124273: hypothetical protein +FIG01124273 arginase +FIG01124274 FIG01124275: hypothetical protein +FIG01124275 FIG01124276: hypothetical protein +FIG01124276 FIG01124278: hypothetical protein +FIG01124278 FIG01124279: hypothetical protein +FIG01124279 FIG01124280: hypothetical protein +FIG01124280 FIG01124282: hypothetical protein +FIG01124282 FIG01124283: hypothetical protein +FIG01124283 FIG01124284: hypothetical protein +FIG01124284 FIG01124285: hypothetical protein +FIG01124285 FIG01124288: hypothetical protein +FIG01124288 putative sporulation-control gene +FIG01124291 FIG01124292: hypothetical protein +FIG01124295 FIG01124296: hypothetical protein +FIG01124296 FIG01124297: hypothetical protein +FIG01124301 Arsenical resistance operon repressor +FIG01124303 FIG01124305: hypothetical protein +FIG01124313 FIG01124314: hypothetical protein +FIG01124314 GMP synthase( EC:6.3.5.2 ) +FIG01124316 FIG01124317: hypothetical protein +FIG01124317 Cell division protein CrgA +FIG01124319 putative sensory box/GGDEF family protein +FIG01124320 hypothetical protein SC9G1.07c +FIG01124322 FIG01124324: hypothetical protein +FIG01124324 putative ABC transporter, periplasmic iron-siderophore binding protein +FIG01124327 FIG01124328: hypothetical protein +FIG01124330 FIG01124332: hypothetical protein +FIG01124334 FIG01124335: hypothetical protein +FIG01124335 FIG01124336: hypothetical protein +FIG01124336 FIG01124337: hypothetical protein +FIG01124337 FIG01124338: hypothetical protein +FIG01124338 FIG01124339: hypothetical protein +FIG01124339 FIG01124340: hypothetical protein +FIG01124340 putative two-component system response regulator +FIG01124341 hypothetical protein SC1B2.23c +FIG01124342 FIG01124344: hypothetical protein +FIG01124344 FIG01124345: hypothetical protein +FIG01124350 FIG01124356: hypothetical protein +FIG01124356 FIG01124357: hypothetical protein +FIG01124357 FIG01124358: hypothetical protein +FIG01124358 FIG01124359: hypothetical protein +FIG01124359 FIG01124360: hypothetical protein +FIG01124360 FIG01124361: hypothetical protein +FIG01124361 FIG01124362: hypothetical protein +FIG01124362 FIG01124363: hypothetical protein +FIG01124363 FIG01124365: hypothetical protein +FIG01124366 FIG01124367: hypothetical protein +FIG01124368 chitinase 19-1 +FIG01124371 FIG01124372: hypothetical protein +FIG01124372 cobalamin B12-binding +FIG01124373 FIG01124376: hypothetical protein +FIG01124376 FIG01124377: hypothetical protein +FIG01124383 FIG01124384: hypothetical protein +FIG01124387 4'-phosphopantetheinyl transferase EntD (EC 2.7.8.-) +FIG01124391 FIG01124394: hypothetical protein +FIG01124394 FIG01124396: hypothetical protein +FIG01124396 FIG01124398: hypothetical protein +FIG01124398 FIG01124400: hypothetical protein +FIG01124400 FIG01124401: hypothetical protein +FIG01124401 FIG01124403: hypothetical protein +FIG01124403 putative anti-sigma factor antagonist +FIG01124406 FIG01124407: hypothetical protein +FIG01124407 FIG01124409: hypothetical protein +FIG01124409 FIG01124412: hypothetical protein +FIG01124412 FIG01124413: hypothetical protein +FIG01124413 FIG01124414: hypothetical protein +FIG01124414 FIG01124418: hypothetical protein +FIG01124418 FIG01124419: hypothetical protein +FIG01124420 FIG01124421: hypothetical protein +FIG01124423 histidine autokinase +FIG01124428 FIG01124429: hypothetical protein +FIG01124429 FIG01124430: hypothetical protein +FIG01124434 SCQ11.14, hypothetical protein, len: 99 aa; unknown function, probable CDS suggested by GC frameplot, positional base preference and amino acid composition +FIG01124436 FIG01124437: hypothetical protein +FIG01124437 FIG01124438: hypothetical protein +FIG01124438 putative secreted glucosidase +FIG01124440 tyrosinase (monophenol monooxygenase) +FIG01124442 FIG01124443: hypothetical protein +FIG01124443 FIG01124444: hypothetical protein +FIG01124444 FIG01124445: hypothetical protein +FIG01124446 FIG01124447: hypothetical protein +FIG01124449 FIG01124451: hypothetical protein +FIG01124451 FIG01124452: hypothetical protein +FIG01124453 FIG01124454: hypothetical protein +FIG01124457 FIG01124460: hypothetical protein +FIG01124461 FIG01124462: hypothetical protein +FIG01124467 FIG01124470: hypothetical protein +FIG01124473 FIG01124475: hypothetical protein +FIG01124475 FIG01124477: hypothetical protein +FIG01124477 FIG01124478: hypothetical protein +FIG01124478 metallo-beta-lactamase-like protein +FIG01124483 FIG01124484: hypothetical protein +FIG01124484 FIG01124485: hypothetical protein +FIG01124486 FIG01124487: hypothetical protein +FIG01124491 FIG01124493: hypothetical protein +FIG01124493 FIG01124494: hypothetical protein +FIG01124494 FIG01124497: hypothetical protein +FIG01124497 FIG01124498: hypothetical protein +FIG01124498 FIG01124500: hypothetical protein +FIG01124501 putative small membrane protein +FIG01124503 FIG01124504: hypothetical protein +FIG01124506 FIG01124507: hypothetical protein +FIG01124507 FIG01124508: hypothetical protein +FIG01124511 putative transferase +FIG01124513 FIG01124517: hypothetical protein +FIG01124518 Probable O-methyltransferase +FIG01124519 FIG01124520: hypothetical protein +FIG01124520 FIG01124521: hypothetical protein +FIG01124521 FIG01124522: hypothetical protein +FIG01124522 SC5H1.30c, hypothetical protein, len: 54 aa; unknown function, possible short CDS suggested by positional base preference, GC frame analysis and amino acid composition +FIG01124525 FIG01124528: hypothetical protein +FIG01124528 Serine/threonine protein phosphatase +FIG01124529 FIG01124533: hypothetical protein +FIG01124533 FIG01124534: hypothetical protein +FIG01124541 FIG01124542: hypothetical protein +FIG01124542 FIG01124544: hypothetical protein +FIG01124544 FIG01124547: hypothetical protein +FIG01124548 FIG01124553: hypothetical protein +FIG01124554 FIG01124555: hypothetical protein +FIG01124555 FIG01124556: hypothetical protein +FIG01124557 FIG01124560: hypothetical protein +FIG01124560 FIG01124561: hypothetical protein +FIG01124561 FIG01124562: hypothetical protein +FIG01124562 FIG01124564: hypothetical protein +FIG01124565 FIG01124566: hypothetical protein +FIG01124566 FIG01124567: hypothetical protein +FIG01124567 FIG01124569: hypothetical protein +FIG01124569 FIG01124573: hypothetical protein +FIG01124573 FIG01124574: hypothetical protein +FIG01124574 putative plasmid transfer protein +FIG01124579 FIG01124580: hypothetical protein +FIG01124581 FIG01124582: hypothetical protein +FIG01124582 FIG01124583: hypothetical protein +FIG01124584 Uncharacterized protein Rv1841c/MT1889 +FIG01124585 FIG01124587: hypothetical protein +FIG01124596 putative membrane associated phophodiesterase +FIG01124606 FIG01124607: hypothetical protein +FIG01124607 FIG01124608: hypothetical protein +FIG01124608 FIG01124609: hypothetical protein +FIG01124611 possible chromosome condensation protein +FIG01124613 FIG01124614: hypothetical protein +FIG01124618 FIG01124620: hypothetical protein +FIG01124620 FIG01124622: hypothetical protein +FIG01124623 putative BldB protein +FIG01124625 FIG01124627: hypothetical protein +FIG01124630 amidinotransferase +FIG01124631 FIG01124632: hypothetical protein +FIG01124632 FIG01124633: hypothetical protein +FIG01124633 FIG01124634: hypothetical protein +FIG01124634 FIG01124635: hypothetical protein +FIG01124635 coenzyme F420-dependent N5,N10-methylene tetrahydromethanopterin reductase +FIG01124638 probable oxidoreductase +FIG01124639 FIG01124640: hypothetical protein +FIG01124640 FIG01124641: hypothetical protein +FIG01124641 FIG01124643: hypothetical protein +FIG01124644 FIG01124645: hypothetical protein +FIG01124646 FIG01124647: hypothetical protein +FIG01124647 FIG01124650: hypothetical protein +FIG01124650 FIG01124652: hypothetical protein +FIG01124654 FIG01124655: hypothetical protein +FIG01124659 terpene cyclase +FIG01124663 FIG01124664: hypothetical protein +FIG01124667 FIG01124668: hypothetical protein +FIG01124668 FIG01124670: hypothetical protein +FIG01124670 FIG01124671: hypothetical protein +FIG01124671 FIG01124673: hypothetical protein +FIG01124673 FIG01124677: hypothetical protein +FIG01124677 FIG01124682: hypothetical protein +FIG01124683 hypothetical protein; SCN_6 +FIG01124686 FIG01124688: hypothetical protein +FIG01124689 FIG01124693: hypothetical protein +FIG01124693 FIG01124695: hypothetical protein +FIG01124699 FIG01124700: hypothetical protein +FIG01124700 Protein-L-isoaspartate methyltransferase (EC 2.1.1.77) +FIG01124701 FIG01124703: hypothetical protein +FIG01124703 FIG01124704: hypothetical protein +FIG01124704 FIG01124705: hypothetical protein +FIG01124705 Probable secreted peptidase +FIG01124707 FIG00662410: hypothetical protein +FIG01124708 FIG01124709: hypothetical protein +FIG01124709 FIG01124710: hypothetical protein +FIG01124712 FIG01124713: hypothetical protein +FIG01124716 putative transfer protein SpdA +FIG01124717 FIG01124718: hypothetical protein +FIG01124718 FIG01124719: hypothetical protein +FIG01124720 FIG01124723: hypothetical protein +FIG01124723 FIG01124724: hypothetical protein +FIG01124729 FIG01124730: hypothetical protein +FIG01124730 FIG01124732: hypothetical protein +FIG01124734 FIG01124737: hypothetical protein +FIG01124737 FIG01124738: hypothetical protein +FIG01124738 putative sigma factor +FIG01124739 FIG01124740: hypothetical protein +FIG01124740 FIG01124741: hypothetical protein +FIG01124742 FIG01124743: hypothetical protein +FIG01124748 FIG01124750: hypothetical protein +FIG01124750 ABC-type sugar transport systems, permease components +FIG01124757 FIG01124758: hypothetical protein +FIG01124762 FIG01124763: hypothetical protein +FIG01124765 FIG01124766: hypothetical protein +FIG01124766 FIG01124767: hypothetical protein +FIG01124767 FIG01124768: hypothetical protein +FIG01124769 FIG01124770: hypothetical protein +FIG01124770 FIG01124771: hypothetical protein +FIG01124771 FIG01124772: hypothetical protein +FIG01124778 FIG01124779: hypothetical protein +FIG01124779 FIG01124780: hypothetical protein +FIG01124784 FIG01124787: hypothetical protein +FIG01124787 FIG01124788: hypothetical protein +FIG01124788 FIG01124789: hypothetical protein +FIG01124789 FIG01124791: hypothetical protein +FIG01124792 FIG01124793: hypothetical protein +FIG01124793 FIG01124794: hypothetical protein +FIG01124795 putative M protein +FIG01124802 FIG01124804: hypothetical protein +FIG01124804 FIG01124805: hypothetical protein +FIG01124807 FIG01124808: hypothetical protein +FIG01124808 mutT-like protein +FIG01124813 FIG01124814: hypothetical protein +FIG01124814 FIG01124815: hypothetical protein +FIG01124815 putative ABC transporter transmembrane protein +FIG01124817 FIG01124818: hypothetical protein +FIG01124818 acetyl-CoA acetyltransferase +FIG01124820 probable sseC protein +FIG01124821 FIG01124822: hypothetical protein +FIG01124822 FIG01124823: hypothetical protein +FIG01124826 FIG01124828: hypothetical protein +FIG01124830 FIG01124831: hypothetical protein +FIG01124833 FIG01124836: hypothetical protein +FIG01124836 FIG01124839: hypothetical protein +FIG01124840 FIG01124841: hypothetical protein +FIG01124841 FIG01124842: hypothetical protein +FIG01124842 FIG01124843: hypothetical protein +FIG01124847 FIG01124848: hypothetical protein +FIG01124848 FIG01124849: hypothetical protein +FIG01124849 FIG01124850: hypothetical protein +FIG01124853 FIG01124856: hypothetical protein +FIG01124856 putative secreted protein/lipoprotein +FIG01124857 FIG01124858: hypothetical protein +FIG01124859 hypothetical protein SCL2.25c +FIG01124861 FIG01124865: hypothetical protein +FIG01124866 FIG01124867: hypothetical protein +FIG01124867 FIG01124868: hypothetical protein +FIG01124871 FIG01124875: hypothetical protein +FIG01124875 FIG01124876: hypothetical protein +FIG01124885 FIG01124888: hypothetical protein +FIG01124888 FIG01124890: hypothetical protein +FIG01124894 FIG01124895: hypothetical protein +FIG01124896 FIG01124897: hypothetical protein +FIG01124898 FIG01124899: hypothetical protein +FIG01124899 FIG01124900: hypothetical protein +FIG01124900 FIG01124901: hypothetical protein +FIG01124901 FIG01124902: hypothetical protein +FIG01124905 FIG01124906: hypothetical protein +FIG01124908 FIG01124909: hypothetical protein +FIG01124910 FIG01124912: hypothetical protein +FIG01124919 ABC transporter related +FIG01124920 FIG01124921: hypothetical protein +FIG01124921 putative two-component system sensory histidine kinase. +FIG01124922 FIG01124923: hypothetical protein +FIG01124923 putative 6-phospho-beta-glucosidase +FIG01124925 FIG01124927: hypothetical protein +FIG01124929 FIG01124931: hypothetical protein +FIG01124931 bifunctional protein +FIG01124934 putative peptidase (putative secreted protein) +FIG01124936 FIG01124938: hypothetical protein +FIG01124939 FIG01124940: hypothetical protein +FIG01124941 FIG01124944: hypothetical protein +FIG01124944 FIG01124945: hypothetical protein +FIG01124945 FIG01124946: hypothetical protein +FIG01124946 FIG01124948: hypothetical protein +FIG01124952 FIG01124955: hypothetical protein +FIG01124958 FIG01124960: hypothetical protein +FIG01124961 FIG01124963: hypothetical protein +FIG01124966 FIG01124968: hypothetical protein +FIG01124971 FIG01124972: hypothetical protein +FIG01124972 FIG01124973: hypothetical protein +FIG01124976 FIG01124978: hypothetical protein +FIG01124978 FIG01124979: hypothetical protein +FIG01124979 Molybdenum cofactor biosynthesis protein A +FIG01124981 NrtR-regulated hypothetical NrtX, Band 7 protein domain +FIG01124982 FIG01124983: hypothetical protein +FIG01124985 FIG01124986: hypothetical protein +FIG01124986 putative epimerase +FIG01124987 FIG01124988: hypothetical protein +FIG01124988 FIG01124989: hypothetical protein +FIG01124990 FIG01124992: hypothetical protein +FIG01124992 FIG01124993: hypothetical protein +FIG01124993 FIG01124995: hypothetical protein +FIG01124995 FIG01124996: hypothetical protein +FIG01125002 FIG01125003: hypothetical protein +FIG01125004 FIG01125005: hypothetical protein +FIG01125005 FIG01125007: hypothetical protein +FIG01125009 FIG01125012: hypothetical protein +FIG01125013 FIG01125014: hypothetical protein +FIG01125019 FIG01125020: hypothetical protein +FIG01125020 FIG01125021: hypothetical protein +FIG01125021 FIG01125022: hypothetical protein +FIG01125027 FIG01125028: hypothetical protein +FIG01125028 FIG01125030: hypothetical protein +FIG01125030 FIG01125031: hypothetical protein +FIG01125031 FIG01125034: hypothetical protein +FIG01125034 FIG01125035: hypothetical protein +FIG01125036 FIG01125037: hypothetical protein +FIG01125037 FIG01125038: hypothetical protein +FIG01125039 FIG01125041: hypothetical protein +FIG01125042 FIG01125043: hypothetical protein +FIG01125043 FIG01125044: hypothetical protein +FIG01125046 FIG01125047: hypothetical protein +FIG01125047 FIG01125048: hypothetical protein +FIG01125054 FIG01125058: hypothetical protein +FIG01125058 FIG01125059: hypothetical protein +FIG01125059 FIG01125060: hypothetical protein +FIG01125060 FIG01125062: hypothetical protein +FIG01125062 FIG01125063: hypothetical protein +FIG01125063 FIG01125064: hypothetical protein +FIG01125064 FIG01125067: hypothetical protein +FIG01125067 Protein of unknown function DUF1470 +FIG01125068 FIG01125069: hypothetical protein +FIG01125076 FIG01125079: hypothetical protein +FIG01125080 FIG01125082: hypothetical protein +FIG01125083 FIG01125084: hypothetical protein +FIG01125088 FIG01125089: hypothetical protein +FIG01125089 (AJ250023) putative polyketide synthase +FIG01125094 FIG01125096: hypothetical protein +FIG01125098 N-acetyl-ornithine/N-acetyl-lysine deacetylase +FIG01125099 FIG01125100: hypothetical protein +FIG01125104 FIG01125105: hypothetical protein +FIG01125110 FIG01125111: hypothetical protein +FIG01125113 FIG01125114: hypothetical protein +FIG01125119 FIG01125120: hypothetical protein +FIG01125120 FIG01125123: hypothetical protein +FIG01125129 FIG01125130: hypothetical protein +FIG01125133 FIG01125134: hypothetical protein +FIG01125137 SCI11.19, hypothetical protein, len: 166 aa; unknown function, probable CDS suggested by GC frameplot, positional base preference and amino acid composition. Overlaps the upstream CDS by 6 codons +FIG01125138 Clavaminate synthase 2 (EC 1.14.11.21) (Clavaminic acid synthetase 2) (CAS2) (CS2) +FIG01125142 FIG01125143: hypothetical protein +FIG01125143 FIG01125144: hypothetical protein +FIG01125145 FIG01125146: hypothetical protein +FIG01125148 FIG01125149: hypothetical protein +FIG01125156 FIG01125158: hypothetical protein +FIG01125160 FIG01125162: hypothetical protein +FIG01125164 putative two component system sensor kinase +FIG01125165 FIG01125166: hypothetical protein +FIG01125173 hypothetical protein SC1B2.19 +FIG01125174 Cellulase 1 precursor (EC 3.2.1.4) (Endoglucanase) (Endo-1,4-beta-glucanase) (Avicelase) +FIG01125177 FIG01125178: hypothetical protein +FIG01125182 FIG01125183: hypothetical protein +FIG01125183 FIG01125185: hypothetical protein +FIG01125187 FIG01125189: hypothetical protein +FIG01125191 putative ATP/GTP-binding Gly/Ala-rich protein +FIG01125192 FIG01125194: hypothetical protein +FIG01125194 FIG01125195: hypothetical protein +FIG01125201 hypothetical protein SC1B2.21 +FIG01125204 FIG01125206: hypothetical protein +FIG01125211 FIG01125212: hypothetical protein +FIG01125213 RNA polymerase ECF-subfamily sigma factor +FIG01125215 FIG01125216: hypothetical protein +FIG01125217 FIG01125218: hypothetical protein +FIG01125222 FIG01125225: hypothetical protein +FIG01125226 FIG01125228: hypothetical protein +FIG01125232 Asp-rich hydrophilic protein (putative membrane protein) +FIG01125233 FIG01125234: hypothetical protein +FIG01125235 putative transcriptional regulatory protein +FIG01125243 FIG01125246: hypothetical protein +FIG01125246 FIG01125247: hypothetical protein +FIG01125247 FIG01125251: hypothetical protein +FIG01125252 sulfotransferase domain protein +FIG01125256 FIG01125258: hypothetical protein +FIG01125264 FIG01125265: hypothetical protein +FIG01125265 FIG01125266: hypothetical protein +FIG01125267 FIG01125269: hypothetical protein +FIG01125269 FIG01125270: hypothetical protein +FIG01125270 FIG01125271: hypothetical protein +FIG01125271 FIG01125272: hypothetical protein +FIG01125272 FIG01125274: hypothetical protein +FIG01125276 FIG01125277: hypothetical protein +FIG01125278 FIG01125281: hypothetical protein +FIG01125281 FIG01125283: hypothetical protein +FIG01125283 FIG01125284: hypothetical protein +FIG01125284 FIG01125285: hypothetical protein +FIG01125289 FIG01125290: hypothetical protein +FIG01125291 FIG01125292: hypothetical protein +FIG01125292 FIG01125294: hypothetical protein +FIG01125297 FIG01125298: hypothetical protein +FIG01125298 FIG01125299: hypothetical protein +FIG01125299 FIG01125301: hypothetical protein +FIG01125311 FIG01125312: hypothetical protein +FIG01125312 FIG01125314: hypothetical protein +FIG01125315 putative sugar transport permease +FIG01125317 FIG01125318: hypothetical protein +FIG01125318 FIG01125321: hypothetical protein +FIG01125328 FIG01125330: hypothetical protein +FIG01125335 FIG01125336: hypothetical protein +FIG01125337 FIG01125338: hypothetical protein +FIG01125338 FIG01125339: hypothetical protein +FIG01125339 FIG01125340: hypothetical protein +FIG01125341 FIG01125342: hypothetical protein +FIG01125342 luxR-family transcriptional regulator +FIG01125344 FIG01125345: hypothetical protein +FIG01125345 Putative methyltransferase,bldM, influences various aspects of colony growth and development +FIG01125348 FIG01125349: hypothetical protein +FIG01125349 FIG01125350: hypothetical protein +FIG01125350 putative lipase (putative secreted protein) +FIG01125352 FIG01125355: hypothetical protein +FIG01125356 FIG01125357: hypothetical protein +FIG01125364 FIG01125366: hypothetical protein +FIG01125368 FIG01125369: hypothetical protein +FIG01125369 FIG01125370: hypothetical protein +FIG01125370 FIG01125371: hypothetical protein +FIG01125371 FIG01125374: hypothetical protein +FIG01125376 FIG01125378: hypothetical protein +FIG01125378 FIG01125379: hypothetical protein +FIG01125380 FIG01125381: hypothetical protein +FIG01125381 FIG01125382: hypothetical protein +FIG01125384 FIG01125385: hypothetical protein +FIG01125385 FIG01125386: hypothetical protein +FIG01125386 FIG01125387: hypothetical protein +FIG01125387 FIG01125389: hypothetical protein +FIG01125389 FIG01125390: hypothetical protein +FIG01125391 FIG01125392: hypothetical protein +FIG01125392 FIG01125393: hypothetical protein +FIG01125393 FIG01125394: hypothetical protein +FIG01125394 FIG01125395: hypothetical protein +FIG01125395 FIG01125402: hypothetical protein +FIG01125406 FIG060545: short hypothetical protein +FIG01125417 hypothetical protein SCC75A.36. +FIG01125418 steroid delta-isomerase( EC:5.3.3.1 ) +FIG01125421 FIG01125422: hypothetical protein +FIG01125422 FIG01125423: hypothetical protein +FIG01125423 FIG01125424: hypothetical protein +FIG01125424 FIG01125425: hypothetical protein +FIG01125427 FIG01125428: hypothetical protein +FIG01125429 FIG01125431: hypothetical protein +FIG01125441 FIG01125443: hypothetical protein +FIG01125443 putative efflux membrane protein +FIG01125444 FIG01125445: hypothetical protein +FIG01125445 FIG01125448: hypothetical protein +FIG01125448 FIG01125450: hypothetical protein +FIG01125450 hypothetical protein SC8E4A.12c +FIG01125456 FIG01125457: hypothetical protein +FIG01125468 FIG01125469: hypothetical protein +FIG01125469 FIG01125471: hypothetical protein +FIG01125474 FIG01125475: hypothetical protein +FIG01125475 NovD +FIG01125481 FIG01125484: hypothetical protein +FIG01125484 FIG01125486: hypothetical protein +FIG01125488 FIG01125491: hypothetical protein +FIG01125493 FIG01125494: hypothetical protein +FIG01125495 secreted hydrolase +FIG01125501 FIG01125504: hypothetical protein +FIG01125506 methyltransferase +FIG01125508 FIG01125509: hypothetical protein +FIG01125509 FIG01125512: hypothetical protein +FIG01125512 FIG01125513: hypothetical protein +FIG01125513 FIG01125514: hypothetical protein +FIG01125514 FIG01125518: hypothetical protein +FIG01125522 FIG01125524: hypothetical protein +FIG01125524 FIG01125525: hypothetical protein +FIG01125531 probable ECF-family sigma factor. +FIG01125533 FIG01125536: hypothetical protein +FIG01125536 SagD family docking scaffold +FIG01125539 putative penicillin-binding protein +FIG01125545 FIG01125546: hypothetical protein +FIG01125549 FIG01125550: hypothetical protein +FIG01125554 FIG01125557: hypothetical protein +FIG01125557 FIG01125558: hypothetical protein +FIG01125558 SugE protein +FIG01125568 FIG01125569: hypothetical protein +FIG01125584 FIG01125585: hypothetical protein +FIG01125585 FIG01125587: hypothetical protein +FIG01125590 FIG01125591: hypothetical protein +FIG01125597 FIG01125599: hypothetical protein +FIG01125602 FIG01125603: hypothetical protein +FIG01125604 multi-component regulatory system-10, containing roadblock/LC7 domain +FIG01125606 oligopeptide binding protein +FIG01125614 FIG01125615: hypothetical protein +FIG01125615 putative multidrug resistance efflux protein +FIG01125620 FIG01125621: hypothetical protein +FIG01125621 Hypothetical radical SAM family enzyme in interesting gene cluster +FIG01125625 FIG01125626: hypothetical protein +FIG01125626 Subtilisin inhibitor-like protein 3 (SIL-3) (SIL3) +FIG01125627 FIG01125629: hypothetical protein +FIG01125635 putative conserved integral membrane protein +FIG01125640 FIG01125642: hypothetical protein +FIG01125645 FIG01170067: hypothetical protein +FIG01125646 FIG01125648: hypothetical protein +FIG01125649 FIG01125651: hypothetical protein +FIG01125651 FIG01125652: hypothetical protein +FIG01125653 FIG01125654: hypothetical protein +FIG01125654 FIG01125655: hypothetical protein +FIG01125656 FIG01125657: hypothetical protein +FIG01125657 FIG01125658: hypothetical protein +FIG01125658 Tyrosinase cofactor +FIG01125661 FIG01125662: hypothetical protein +FIG01125663 FIG01125664: hypothetical protein +FIG01125667 FIG01125669: hypothetical protein +FIG01125672 FIG01125674: hypothetical protein +FIG01125678 FIG01125686: hypothetical protein +FIG01125686 FIG01125687: hypothetical protein +FIG01125687 FIG01125689: hypothetical protein +FIG01125689 FIG01125690: hypothetical protein +FIG01125691 FIG01125692: hypothetical protein +FIG01125694 FIG01125695: hypothetical protein +FIG01125695 FIG01125698: hypothetical protein +FIG01125698 FIG01125699: hypothetical protein +FIG01125701 FIG01125702: hypothetical protein +FIG01125702 FIG01125703: hypothetical protein +FIG01125703 probable solute-binding lipoprotein. +FIG01125709 FIG01125710: hypothetical protein +FIG01125715 FIG01125718: hypothetical protein +FIG01125718 FIG01125719: hypothetical protein +FIG01125719 FIG01125720: hypothetical protein +FIG01125721 FIG01125723: hypothetical protein +FIG01125723 FIG01125724: hypothetical protein +FIG01125724 FIG01125730: hypothetical protein +FIG01125730 FIG01125731: hypothetical protein +FIG01125731 FIG01125732: hypothetical protein +FIG01125736 FIG01125740: hypothetical protein +FIG01125740 FIG01125741: hypothetical protein +FIG01125741 FIG01125743: hypothetical protein +FIG01125743 FIG01125746: hypothetical protein +FIG01125746 FIG01125749: hypothetical protein +FIG01125750 FIG01125751: hypothetical protein +FIG01125752 FIG01125755: hypothetical protein +FIG01125756 FIG01125758: hypothetical protein +FIG01125760 FIG01125761: hypothetical protein +FIG01125761 FIG01125762: hypothetical protein +FIG01125762 FIG01125763: hypothetical protein +FIG01125768 FIG01125770: hypothetical protein +FIG01125770 FIG01125771: hypothetical protein +FIG01125771 FIG01125772: hypothetical protein +FIG01125772 FIG01125773: hypothetical protein +FIG01125778 FIG01125780: hypothetical protein +FIG01125781 FIG01125782: hypothetical protein +FIG01125785 FIG01125786: hypothetical protein +FIG01125787 FIG01125788: hypothetical protein +FIG01125789 FIG01125790: hypothetical protein +FIG01125791 FIG01125792: hypothetical protein +FIG01125792 FIG01125793: hypothetical protein +FIG01125797 anti sigma factor antagonist +FIG01125800 FIG01125801: hypothetical protein +FIG01125801 Glutamyl endopeptidase 2 (EC 3.4.21.82) (Glutamyl endopeptidase II) (Glutamic acid-specific protease) (GLUSGP) (Streptogrisin-E) (Serine protease E) (SGPE) +FIG01125802 FIG01125803: hypothetical protein +FIG01125810 Sterol-regulatory element binding protein (SREBP) site 2 protease family +FIG01125812 FIG01125814: hypothetical protein +FIG01125814 FIG01125815: hypothetical protein +FIG01125818 Lipid transfer protein or keto acyl-CoA thiolase Ltp4 +FIG01125826 putative DNA invertase +FIG01125831 hypothetical protein SCF81.12 +FIG01125833 FIG01125834: hypothetical protein +FIG01125834 FIG01125837: hypothetical protein +FIG01125842 FIG01125843: hypothetical protein +FIG01125843 FIG01125847: hypothetical protein +FIG01125848 FIG01125849: hypothetical protein +FIG01125849 FIG01125850: hypothetical protein +FIG01125851 FIG01125854: hypothetical protein +FIG01125858 FIG01125860: hypothetical protein +FIG01125863 FIG01125864: hypothetical protein +FIG01125864 FIG01125865: hypothetical protein +FIG01125865 FIG01125866: hypothetical protein +FIG01125867 FIG01125869: hypothetical protein +FIG01125871 FIG01125872: hypothetical protein +FIG01125873 FIG01125874: hypothetical protein +FIG01125874 FIG01125875: hypothetical protein +FIG01125877 FIG01125881: hypothetical protein +FIG01125881 FIG01125883: hypothetical protein +FIG01125883 FIG01125887: hypothetical protein +FIG01125887 FIG01125888: hypothetical protein +FIG01125888 FIG01125890: hypothetical protein +FIG01125896 FIG01125898: hypothetical protein +FIG01125899 FIG01125900: hypothetical protein +FIG01125900 FIG01125902: hypothetical protein +FIG01125902 FIG01125903: hypothetical protein +FIG01125903 FIG01125905: hypothetical protein +FIG01125914 FIG01125917: hypothetical protein +FIG01125917 FIG01125919: hypothetical protein +FIG01125920 FIG01125921: hypothetical protein +FIG01125921 putative secreted lyase +FIG01125925 FIG01125926: hypothetical protein +FIG01125926 FIG01125927: hypothetical protein +FIG01125927 FIG01125930: hypothetical protein +FIG01125938 FIG01125939: hypothetical protein +FIG01125939 peptidase, S1E (streptogrisin A) subfamily( EC:3.4.21.- ) +FIG01125943 FIG01125944: hypothetical protein +FIG01125944 FIG01125945: hypothetical protein +FIG01125952 FIG01125953: hypothetical protein +FIG01125953 FIG01125955: hypothetical protein +FIG01125955 FIG01125958: hypothetical protein +FIG01125958 FIG01125959: hypothetical protein +FIG01125964 FIG01125965: hypothetical protein +FIG01125965 FIG01125966: hypothetical protein +FIG01125966 FIG01125967: hypothetical protein +FIG01125967 FIG01125970: hypothetical protein +FIG01125970 FIG01125971: hypothetical protein +FIG01125972 formyltransferase +FIG01125973 FIG01125975: hypothetical protein +FIG01125976 FIG01125978: hypothetical protein +FIG01125983 FIG01125984: hypothetical protein +FIG01125989 FIG01125990: hypothetical protein +FIG01125990 FIG01125991: hypothetical protein +FIG01125993 FIG01125994: hypothetical protein +FIG01125997 putative glycoside hydrolase +FIG01126000 FIG01126001: hypothetical protein +FIG01126003 FIG01126004: hypothetical protein +FIG01126004 FIG01126005: hypothetical protein +FIG01126005 putative phage or prophage related protein +FIG01126010 FIG01126011: hypothetical protein +FIG01126015 FIG01126017: hypothetical protein +FIG01126029 FIG01126030: hypothetical protein +FIG01126030 FIG01126031: hypothetical protein +FIG01126031 mini-circle protein +FIG01126032 FIG01126033: hypothetical protein +FIG01126037 FIG01126038: hypothetical protein +FIG01126042 putative two-component sensor kinase +FIG01126043 FIG01126044: hypothetical protein +FIG01126044 iron (III) dicitrate transport system, permease +FIG01126048 FIG01126049: hypothetical protein +FIG01126049 FIG01126050: hypothetical protein +FIG01126056 FIG01126057: hypothetical protein +FIG01126057 FIG01126059: hypothetical protein +FIG01126059 FIG01126060: hypothetical protein +FIG01126060 FIG01126061: hypothetical protein +FIG01126061 FIG01126064: hypothetical protein +FIG01126064 FIG01126065: hypothetical protein +FIG01126070 FIG01126072: hypothetical protein +FIG01126072 NADPH-dependent glyceraldehyde-3-phosphate dehydrogenase (EC 1.2.1.13) +FIG01126075 FIG01126077: hypothetical protein +FIG01126077 FIG01126079: hypothetical protein +FIG01126079 FIG01126080: hypothetical protein +FIG01126080 FIG01126082: hypothetical protein +FIG01126086 FIG01126087: hypothetical protein +FIG01126097 FIG01126100: hypothetical protein +FIG01126108 FIG01126109: hypothetical protein +FIG01126118 FIG01126119: hypothetical protein +FIG01126123 Bona fide RidA/YjgF/TdcF/RutC subgroup +FIG01126124 FIG01126125: hypothetical protein +FIG01126125 FIG01126127: hypothetical protein +FIG01126127 FIG01126129: hypothetical protein +FIG01126137 FIG01126138: hypothetical protein +FIG01126144 FIG01126145: hypothetical protein +FIG01126145 FIG01126146: hypothetical protein +FIG01126146 FIG01126148: hypothetical protein +FIG01126148 FIG01126151: hypothetical protein +FIG01126151 FIG01126152: hypothetical protein +FIG01126152 FIG01126153: hypothetical protein +FIG01126153 putative fatty acid synthase +FIG01126154 FIG01126155: hypothetical protein +FIG01126155 FIG01126156: hypothetical protein +FIG01126156 FIG01126157: hypothetical protein +FIG01126157 putative two-component regulator +FIG01126158 FIG01126159: hypothetical protein +FIG01126160 SCC53.30c, unknown, len: 160aa +FIG01126162 FIG01126163: hypothetical protein +FIG01126163 FIG01126166: hypothetical protein +FIG01126170 FIG01126173: hypothetical protein +FIG01126181 FIG01126182: hypothetical protein +FIG01126184 FIG01126186: hypothetical protein +FIG01126187 FIG01126190: hypothetical protein +FIG01126198 FIG01126199: hypothetical protein +FIG01126200 FIG01126201: hypothetical protein +FIG01126202 FIG01126203: hypothetical protein +FIG01126203 FIG01126205: hypothetical protein +FIG01126210 FIG01126213: hypothetical protein +FIG01126219 phosphate binding protein (secreted protein) +FIG01126220 FIG01126223: hypothetical protein +FIG01126223 FIG01126224: hypothetical protein +FIG01126225 FIG01126226: hypothetical protein +FIG01126226 FIG01126228: hypothetical protein +FIG01126228 FIG01126231: hypothetical protein +FIG01126234 FIG01126235: hypothetical protein +FIG01126237 FIG01126239: hypothetical protein +FIG01126242 FIG01126244: hypothetical protein +FIG01126244 FIG01126245: hypothetical protein +FIG01126251 FIG01126253: hypothetical protein +FIG01126253 FIG01126254: hypothetical protein +FIG01126255 FIG01126259: hypothetical protein +FIG01126260 FIG01126261: hypothetical protein +FIG01126262 FIG01126265: hypothetical protein +FIG01126269 FIG01126271: hypothetical protein +FIG01126274 FIG01126275: hypothetical protein +FIG01126276 FIG01126277: hypothetical protein +FIG01126277 FIG01126278: hypothetical protein +FIG01126278 FIG01126280: hypothetical protein +FIG01126282 FIG01126283: hypothetical protein +FIG01126283 BldKC, putative ABC transport system integral membrane protein +FIG01126285 FIG01126286: hypothetical protein +FIG01126286 FIG01126287: hypothetical protein +FIG01126287 FIG01126288: hypothetical protein +FIG01126288 FIG01126289: hypothetical protein +FIG01126292 FIG01126297: hypothetical protein +FIG01126297 FIG00820258: hypothetical protein +FIG01126298 FIG01126300: hypothetical protein +FIG01126303 FIG01126304: hypothetical protein +FIG01126304 FIG01126305: hypothetical protein +FIG01126308 FIG01126309: hypothetical protein +FIG01126309 FIG01126310: hypothetical protein +FIG01126310 FIG01126311: hypothetical protein +FIG01126311 FIG01126314: hypothetical protein +FIG01126316 FIG01126317: hypothetical protein +FIG01126318 FIG01123579: Glyoxalase/bleomycin resistance protein/dioxygenase +FIG01126322 FIG01126324: hypothetical protein +FIG01126324 FIG01126326: hypothetical protein +FIG01126327 FIG01126328: hypothetical protein +FIG01126328 FIG01126330: hypothetical protein +FIG01126331 FIG01126332: hypothetical protein +FIG01126332 FIG01126334: hypothetical protein +FIG01126335 FIG01126337: hypothetical protein +FIG01126350 FIG01126351: hypothetical protein +FIG01126353 FIG01126354: hypothetical protein +FIG01126356 FIG01126357: hypothetical protein +FIG01126357 FIG01126359: hypothetical protein +FIG01126359 Serine protease +FIG01126360 FIG01126361: hypothetical protein +FIG01126361 FIG01126362: hypothetical protein +FIG01126362 FIG01126363: hypothetical protein +FIG01126366 FIG01126367: hypothetical protein +FIG01126368 FIG01126369: hypothetical protein +FIG01126369 stsF +FIG01126373 FIG01126374: hypothetical protein +FIG01126377 FIG01126378: hypothetical protein +FIG01126383 FIG01126384: hypothetical protein +FIG01126388 FIG01126389: hypothetical protein +FIG01126389 FIG01126390: hypothetical protein +FIG01126390 FIG01126393: hypothetical protein +FIG01126396 FIG01126398: hypothetical protein +FIG01126398 FIG01126400: hypothetical protein +FIG01126400 FIG01126401: hypothetical protein +FIG01126406 FIG01126407: hypothetical protein +FIG01126407 FIG01126409: hypothetical protein +FIG01126409 FIG01126410: hypothetical protein +FIG01126412 FIG01126415: hypothetical protein +FIG01126416 FIG01126419: hypothetical protein +FIG01126422 FIG01126423: hypothetical protein +FIG01126425 secreted cellulase +FIG01126427 ABC-transporter transmembrane component +FIG01126431 FIG01126432: hypothetical protein +FIG01126438 SCP1.22c, unknown, len: 77aa +FIG01126445 FIG01126447: hypothetical protein +FIG01126453 FIG01126454: hypothetical protein +FIG01126454 FIG01126459: hypothetical protein +FIG01126461 FIG01126463: hypothetical protein +FIG01126463 FIG01126464: hypothetical protein +FIG01126467 secreted chitinase (secreted protein) +FIG01126470 FIG01126471: hypothetical protein +FIG01126472 FIG01126473: hypothetical protein +FIG01126475 FIG00829067: hypothetical protein +FIG01126477 FIG01126478: hypothetical protein +FIG01126481 FIG01126483: hypothetical protein +FIG01126490 FIG01126491: hypothetical protein +FIG01126494 FIG01126497: hypothetical protein +FIG01126497 FIG01126499: hypothetical protein +FIG01126499 FIG01126500: hypothetical protein +FIG01126504 FIG01126505: hypothetical protein +FIG01126509 hypothetical protein SCM11.10c +FIG01126510 FIG01126511: hypothetical protein +FIG01126512 FIG01126513: hypothetical protein +FIG01126513 FIG01126514: hypothetical protein +FIG01126519 FIG01126520: hypothetical protein +FIG01126520 FIG01126521: hypothetical protein +FIG01126522 FIG01126523: hypothetical protein +FIG01126523 putative transmembrane transport protein +FIG01126524 FIG01126525: hypothetical protein +FIG01126526 FIG01126528: hypothetical protein +FIG01126528 FIG01126529: hypothetical protein +FIG01126530 FIG01126531: hypothetical protein +FIG01126536 Zinc D-Ala-D-Ala carboxypeptidase precursor (EC 3.4.17.14) (Metallo DD-peptidase) (Zn DD-peptidase) (D-alanyl-D-alanine carboxypeptidase) +FIG01126539 FIG01126540: hypothetical protein +FIG01126540 FIG01126541: hypothetical protein +FIG01126542 putative secreted alkaline phosphatase +FIG01126543 FIG01126545: hypothetical protein +FIG01126545 FIG01126548: hypothetical protein +FIG01126548 FIG01126549: hypothetical protein +FIG01126549 FIG01126550: hypothetical protein +FIG01126552 FIG01126553: hypothetical protein +FIG01126553 FIG01126554: hypothetical protein +FIG01126554 FIG01126555: hypothetical protein +FIG01126557 FIG01126558: hypothetical protein +FIG01126558 FIG01126559: hypothetical protein +FIG01126564 FIG01126565: hypothetical protein +FIG01126571 FIG01126572: hypothetical protein +FIG01126572 FIG01126574: hypothetical protein +FIG01126574 FIG01126575: hypothetical protein +FIG01126575 FIG01126579: hypothetical protein +FIG01126579 FIG01126580: hypothetical protein +FIG01126586 FIG01126587: hypothetical protein +FIG01126587 SCP1.35, unknown, len: 99aa +FIG01126589 FIG01126591: hypothetical protein +FIG01126591 cytochrome P450 monooxygenase +FIG01126592 secreted endo-1,4-beta-xylanase B (xylanase B) +FIG01126593 FIG01126594: hypothetical protein +FIG01126594 FIG01126595: hypothetical protein +FIG01126595 FIG01126599: hypothetical protein +FIG01126601 Asp/Glu racemase +FIG01126604 FIG01126608: hypothetical protein +FIG01126609 FIG01126612: hypothetical protein +FIG01126613 Conserved TM helix +FIG01126615 FIG01126616: hypothetical protein +FIG01126616 FIG01126617: hypothetical protein +FIG01126619 FIG01126620: hypothetical protein +FIG01126625 FIG01126627: hypothetical protein +FIG01126627 probable ABC transport permease +FIG01126631 FIG01126632: hypothetical protein +FIG01126638 FIG01126639: hypothetical protein +FIG01126643 FIG01126645: hypothetical protein +FIG01126645 FIG01126646: hypothetical protein +FIG01126646 FIG01126647: hypothetical protein +FIG01126648 FIG01126649: hypothetical protein +FIG01126649 FIG01126650: hypothetical protein +FIG01126651 FIG01126653: hypothetical protein +FIG01126653 FIG01126655: hypothetical protein +FIG01126658 FIG01126659: hypothetical protein +FIG01126661 FIG01133440: hypothetical protein +FIG01126662 FIG01126664: hypothetical protein +FIG01126664 FIG01126665: hypothetical protein +FIG01126667 FIG01126672: hypothetical protein +FIG01126672 putative glycosyl hydrolase [EC:3.2.1.21] +FIG01126673 FIG01126674: hypothetical protein +FIG01126674 FIG01126675: hypothetical protein +FIG01126681 FIG01126682: hypothetical protein +FIG01126682 FIG01126686: hypothetical protein +FIG01126689 FIG01126690: hypothetical protein +FIG01126691 putative polyketide synthase. +FIG01126692 FIG01126694: hypothetical protein +FIG01126694 FIG01126695: hypothetical protein +FIG01126707 FIG01126708: hypothetical protein +FIG01126709 FIG01126711: hypothetical protein +FIG01126715 FIG01126719: hypothetical protein +FIG01126719 putative ADP-ribosylglycohydrolase +FIG01126720 type II secretion system protein +FIG01126722 FIG01126723: hypothetical protein +FIG01126723 FIG01126724: hypothetical protein +FIG01126725 FIG01126727: hypothetical protein +FIG01126728 FIG01126729: hypothetical protein +FIG01126732 FIG01126735: hypothetical protein +FIG01126737 FIG01126738: hypothetical protein +FIG01126740 FIG01126744: hypothetical protein +FIG01126744 FIG01126746: hypothetical protein +FIG01126746 FIG01126747: hypothetical protein +FIG01126749 FIG01126750: hypothetical protein +FIG01126750 FIG01126751: hypothetical protein +FIG01126753 FIG01126755: hypothetical protein +FIG01126756 FIG01126759: hypothetical protein +FIG01126761 FIG01126764: hypothetical protein +FIG01126764 FIG01126766: hypothetical protein +FIG01126768 FIG01126769: hypothetical protein +FIG01126769 FIG01126770: hypothetical protein +FIG01126770 FIG01126772: hypothetical protein +FIG01126773 protein of unknown function DUF336 +FIG01126775 putative serine/threonine protein kinase (putative secreted protein) +FIG01126783 FIG01126785: hypothetical protein +FIG01126790 acetyltranferase +FIG01126802 RdlB protein +FIG01126807 FIG01123579: Glyoxalase/bleomycin resistance protein/dioxygenase +FIG01126813 peptidase C45, acyl-coenzyme A:6-aminopenicillanic acid acyl-transferase +FIG01126816 FIG01126819: hypothetical protein +FIG01126833 FIG01126834: hypothetical protein +FIG01126834 FIG01126835: hypothetical protein +FIG01126837 Endoglucanase celA precursor (EC 3.2.1.4) (Endo-1,4-beta-glucanase) (Cellulase) +FIG01126838 FIG01126839: hypothetical protein +FIG01126848 FIG01126849: hypothetical protein +FIG01126851 FIG01126852: hypothetical protein +FIG01126852 FIG01126854: hypothetical protein +FIG01126855 FIG01126856: hypothetical protein +FIG01126858 FIG01126859: hypothetical protein +FIG01126865 Phosphocarrier protein of PTS system +FIG01126870 FIG01126871: hypothetical protein +FIG01126871 FIG01126874: hypothetical protein +FIG01126880 FIG01126881: hypothetical protein +FIG01126882 FIG01126883: hypothetical protein +FIG01126883 FIG01126886: hypothetical protein +FIG01126890 FIG01126891: hypothetical protein +FIG01126891 FIG01126894: hypothetical protein +FIG01126898 FIG01126903: hypothetical protein +FIG01126903 FIG01126906: hypothetical protein +FIG01126910 FIG01126912: hypothetical protein +FIG01126912 FIG01126913: hypothetical protein +FIG01126913 FIG01126914: hypothetical protein +FIG01126914 FIG01262356: hypothetical protein +FIG01126919 FIG01126920: hypothetical protein +FIG01126920 FIG01126921: hypothetical protein +FIG01126921 FIG01126923: hypothetical protein +FIG01126923 FIG01126926: hypothetical protein +FIG01126926 FIG01126927: hypothetical protein +FIG01126927 TraB protein +FIG01126929 FIG01126930: hypothetical protein +FIG01126930 FIG01126931: hypothetical protein +FIG01126933 FIG01126935: hypothetical protein +FIG01126935 FIG01126936: hypothetical protein +FIG01126944 FIG01126945: hypothetical protein +FIG01126945 FIG01126948: hypothetical protein +FIG01126948 FIG01126949: hypothetical protein +FIG01126952 Ferredoxin-2 (Fd-2) +FIG01126954 FIG01126955: hypothetical protein +FIG01126957 FIG01126960: hypothetical protein +FIG01126960 FIG01126961: hypothetical protein +FIG01126965 FIG01126966: hypothetical protein +FIG01126966 FIG01126967: hypothetical protein +FIG01126967 Glyoxalase PtlL in pentalenolactone biosynthesis +FIG01126969 FIG01126971: hypothetical protein +FIG01126971 FIG01126974: hypothetical protein +FIG01126979 FIG01126980: hypothetical protein +FIG01126981 FIG01126985: hypothetical protein +FIG01126991 FIG01126992: hypothetical protein +FIG01126994 FIG01126996: hypothetical protein +FIG01126999 2SC7G11.13, pat, acetyltransferase, len: 212 aa; previously sequenced as TR:Q9RGW2 (EMBL:AF104994) Streptomyces coelicolor A3(2) puromycin N-acetyltransferase Pat, 210 aa. Contains Pfam match to entry PF00583 Acetyltransf, Acetyltransferase (GNAT) family +FIG01127005 FIG01127006: hypothetical protein +FIG01127010 Acetoacetate decarboxylase +FIG01127012 FIG01127013: hypothetical protein +FIG01127013 FIG01127017: hypothetical protein +FIG01127017 FIG01130103: hypothetical protein +FIG01127018 FIG01127020: hypothetical protein +FIG01127020 FIG01127024: hypothetical protein +FIG01127027 FIG01127031: hypothetical protein +FIG01127032 FIG01127033: hypothetical protein +FIG01127033 FIG01127037: hypothetical protein +FIG01127038 FIG01127040: hypothetical protein +FIG01127045 FIG01127047: hypothetical protein +FIG01127049 FIG01127050: hypothetical protein +FIG01127050 SCP1.155, unknown, len: 318aa +FIG01127053 FIG01127055: hypothetical protein +FIG01127055 tetR-family transcriptional regulator +FIG01127056 FIG01127057: hypothetical protein +FIG01127061 FIG01127063: hypothetical protein +FIG01127063 FIG01127064: hypothetical protein +FIG01127064 FIG01127065: hypothetical protein +FIG01127068 FIG01127071: hypothetical protein +FIG01127071 FIG01127072: hypothetical protein +FIG01127077 FIG01127079: hypothetical protein +FIG01127079 Transcriptional regulator, RpiR family +FIG01127080 FIG01127081: hypothetical protein +FIG01127082 FIG01127085: hypothetical protein +FIG01127085 FIG01127086: hypothetical protein +FIG01127087 FIG01127088: hypothetical protein +FIG01127088 FIG01127091: hypothetical protein +FIG01127091 FIG01127092: hypothetical protein +FIG01127092 FIG01127093: hypothetical protein +FIG01127094 FIG01127095: hypothetical protein +FIG01127095 FIG01127096: hypothetical protein +FIG01127099 FIG01127100: hypothetical protein +FIG01127102 FIG01127103: hypothetical protein +FIG01127105 FIG01127106: hypothetical protein +FIG01127107 FIG01127108: hypothetical protein +FIG01127111 FIG01127113: hypothetical protein +FIG01127115 FIG01127116: hypothetical protein +FIG01127121 FIG01127122: hypothetical protein +FIG01127122 FIG01127123: hypothetical protein +FIG01127124 putative type I polyketide synthase +FIG01127131 FIG01127134: hypothetical protein +FIG01127134 FIG01127135: hypothetical protein +FIG01127135 FIG01127136: hypothetical protein +FIG01127141 FIG01127142: hypothetical protein +FIG01127142 putative secreted sugar hydrolase +FIG01127145 FIG01127146: hypothetical protein +FIG01127147 FIG01127148: hypothetical protein +FIG01127157 FIG01127158: hypothetical protein +FIG01127159 FIG01127162: hypothetical protein +FIG01127164 FIG01127165: hypothetical protein +FIG01127169 FIG01127171: hypothetical protein +FIG01127178 FIG01127181: hypothetical protein +FIG01127182 FIG01127185: hypothetical protein +FIG01127185 FIG01127186: hypothetical protein +FIG01127188 FIG01127189: hypothetical protein +FIG01127190 hypothetical protein SC6D7.26. +FIG01127191 FIG01127192: hypothetical protein +FIG01127192 putative secreted metal-binding protein +FIG01127194 FIG01127197: hypothetical protein +FIG01127198 FIG01127200: hypothetical protein +FIG01127202 putative sugar ABC transporter ATP-binding protein +FIG01127206 Glutamate mutase S-chain +FIG01127208 FIG01127210: hypothetical protein +FIG01127210 FIG01127211: hypothetical protein +FIG01127211 FIG01127212: hypothetical protein +FIG01127212 COG0654: 2-polyprenyl-6-methoxyphenol hydroxylase and related FAD-dependent oxidoreductases +FIG01127217 FIG01127218: hypothetical protein +FIG01127218 FIG01127221: hypothetical protein +FIG01127221 FIG01127223: hypothetical protein +FIG01127223 FIG01127224: hypothetical protein +FIG01127224 Antiseptic resistance protein QacA +FIG01127225 FIG01127226: hypothetical protein +FIG01127227 FIG01127233: hypothetical protein +FIG01127233 FIG01127234: hypothetical protein +FIG01127235 FIG01127236: hypothetical protein +FIG01127237 FIG01127239: hypothetical protein +FIG01127240 possible mutarotase +FIG01127246 FIG01127247: hypothetical protein +FIG01127247 FIG01127248: hypothetical protein +FIG01127248 FIG01127249: hypothetical protein +FIG01127249 FIG01127250: hypothetical protein +FIG01127250 FIG01127251: hypothetical protein +FIG01127252 FIG01127253: hypothetical protein +FIG01127261 putative trypsinogen precursor +FIG01127267 FIG01127268: hypothetical protein +FIG01127268 tyrosinase co-factor +FIG01127269 FIG01127270: hypothetical protein +FIG01127271 FIG01127273: hypothetical protein +FIG01127275 FIG01127276: hypothetical protein +FIG01127279 FIG01127282: hypothetical protein +FIG01127283 putative dehydrogenase +FIG01127288 FIG01127289: hypothetical protein +FIG01127289 FIG01127290: hypothetical protein +FIG01127290 FIG01127292: hypothetical protein +FIG01127294 FIG01127297: hypothetical protein +FIG01127298 FIG01127299: hypothetical protein +FIG01127301 FIG01127302: hypothetical protein +FIG01127303 FIG01127305: hypothetical protein +FIG01127305 FIG01127311: hypothetical protein +FIG01127311 FIG01127312: hypothetical protein +FIG01127312 FIG01127313: hypothetical protein +FIG01127313 FIG01127314: hypothetical protein +FIG01127317 FIG01127320: hypothetical protein +FIG01127321 FIG01127322: hypothetical protein +FIG01127322 FIG01127323: hypothetical protein +FIG01127326 FIG01127327: hypothetical protein +FIG01127340 FIG01127341: hypothetical protein +FIG01127342 FIG01127343: hypothetical protein +FIG01127344 FIG01127346: hypothetical protein +FIG01127346 FIG01127348: hypothetical protein +FIG01127348 FIG01127349: hypothetical protein +FIG01127356 FIG01127360: hypothetical protein +FIG01127360 FIG01127362: hypothetical protein +FIG01127367 FIG01127369: hypothetical protein +FIG01127369 FIG01127370: hypothetical protein +FIG01127375 FIG01127377: hypothetical protein +FIG01127379 FIG01127383: hypothetical protein +FIG01127387 FIG01127389: hypothetical protein +FIG01127389 FIG01127390: hypothetical protein +FIG01127391 FIG01127393: hypothetical protein +FIG01127396 FIG01127398: hypothetical protein +FIG01127398 FIG01127399: hypothetical protein +FIG01127404 FIG01127407: hypothetical protein +FIG01127408 FIG01127409: hypothetical protein +FIG01127409 FIG01127413: hypothetical protein +FIG01127413 FIG01127414: hypothetical protein +FIG01127414 FIG01127415: hypothetical protein +FIG01127415 FIG01127416: hypothetical protein +FIG01127420 probable tranposition function protein +FIG01127423 DTDP-4-DEHYDRORHAMNOSE 3,5-EPIMERASE +FIG01127426 FIG01127427: hypothetical protein +FIG01127428 FIG01127429: hypothetical protein +FIG01127433 FIG01127437: hypothetical protein +FIG01127443 FIG01127448: hypothetical protein +FIG01127450 FIG01127451: hypothetical protein +FIG01127453 FIG01127454: hypothetical protein +FIG01127473 FkbW +FIG01127474 FIG01127475: hypothetical protein +FIG01127475 FIG01127476: hypothetical protein +FIG01127478 FIG01127479: hypothetical protein +FIG01127479 FIG01127483: hypothetical protein +FIG01127485 FIG01127487: hypothetical protein +FIG01127492 FIG01127493: hypothetical protein +FIG01127493 FIG01127494: hypothetical protein +FIG01127499 FIG01127500: hypothetical protein +FIG01127502 FIG01127505: hypothetical protein +FIG01127505 FIG01127507: hypothetical protein +FIG01127510 FIG01127512: hypothetical protein +FIG01127512 Anti-sigma F factor antagonist (spoIIAA-2); Anti-sigma B factor antagonist RsbV +FIG01127519 FIG01127521: hypothetical protein +FIG01127521 FIG01127522: hypothetical protein +FIG01127522 FIG01127523: hypothetical protein +FIG01127525 FIG01127526: hypothetical protein +FIG01127530 FIG01127532: hypothetical protein +FIG01127533 FIG01126474: hypothetical protein +FIG01127538 putative integral membrane permease +FIG01127543 FIG01127547: hypothetical protein +FIG01127553 FIG01127554: hypothetical protein +FIG01127554 FIG01127558: hypothetical protein +FIG01127560 FIG01127563: hypothetical protein +FIG01127564 FIG01127565: hypothetical protein +FIG01127565 FIG01127566: hypothetical protein +FIG01127575 FIG01127576: hypothetical protein +FIG01127576 FIG01127577: hypothetical protein +FIG01127577 FIG01127578: hypothetical protein +FIG01127578 FIG01127579: hypothetical protein +FIG01127579 FIG01127580: hypothetical protein +FIG01127589 FIG01127590: hypothetical protein +FIG01127590 FIG01127591: hypothetical protein +FIG01127594 FIG01127595: hypothetical protein +FIG01127595 FIG01127596: hypothetical protein +FIG01127596 probable tetR family transcriptional regulator +FIG01127599 FIG01127600: hypothetical protein +FIG01127605 FIG01127606: hypothetical protein +FIG01127612 FIG01127613: hypothetical protein +FIG01127613 regulatory protein, AsnC/Lrp family +FIG01127616 FIG01127617: hypothetical protein +FIG01127619 FIG01127620: hypothetical protein +FIG01127622 FIG01127625: hypothetical protein +FIG01127625 FIG01127628: hypothetical protein +FIG01127628 FIG01127629: hypothetical protein +FIG01127629 FIG01127630: hypothetical protein +FIG01127633 FIG01127634: hypothetical protein +FIG01127638 FIG00547443: hypothetical protein +FIG01127639 FIG01127640: hypothetical protein +FIG01127648 FIG01127649: hypothetical protein +FIG01127652 FIG01127653: hypothetical protein +FIG01127653 FIG01127655: hypothetical protein +FIG01127664 FIG01127665: hypothetical protein +FIG01127665 FIG01127667: hypothetical protein +FIG01127667 FIG01127668: hypothetical protein +FIG01127669 FIG01127671: hypothetical protein +FIG01127671 FIG01127672: hypothetical protein +FIG01127672 FIG01127675: hypothetical protein +FIG01127681 FIG01127682: hypothetical protein +FIG01127682 FIG01127683: hypothetical protein +FIG01127684 FIG01127688: hypothetical protein +FIG01127690 FIG01127693: hypothetical protein +FIG01127697 FIG01127698: hypothetical protein +FIG01127698 putative sugar transporter +FIG01127699 FIG01127700: hypothetical protein +FIG01127700 FIG01127702: hypothetical protein +FIG01127703 putative integrase, partial CDS +FIG01127706 FIG01127708: hypothetical protein +FIG01127708 FIG01127714: hypothetical protein +FIG01127720 FIG01127722: hypothetical protein +FIG01127724 FIG01127726: hypothetical protein +FIG01127727 FIG01127728: hypothetical protein +FIG01127730 FIG01127731: hypothetical protein +FIG01127733 FIG01127736: hypothetical protein +FIG01127740 FIG01127742: hypothetical protein +FIG01127745 FIG01127746: hypothetical protein +FIG01127748 resistance protein +FIG01127757 araC family regulatory protein +FIG01127761 FIG01127765: hypothetical protein +FIG01127765 FIG01127768: hypothetical protein +FIG01127768 FIG01127769: hypothetical protein +FIG01127769 FIG01127770: hypothetical protein +FIG01127773 FIG01127774: hypothetical protein +FIG01127778 FIG01127779: hypothetical protein +FIG01127779 FIG01127781: hypothetical protein +FIG01127782 FIG01127784: hypothetical protein +FIG01127786 FIG01127788: hypothetical protein +FIG01127789 FIG01127790: hypothetical protein +FIG01127790 FIG01127791: hypothetical protein +FIG01127793 FIG01127794: hypothetical protein +FIG01127797 FIG01127798: hypothetical protein +FIG01127807 Putative ATP/GTP binding protein (partial match) +FIG01127811 FIG01127814: hypothetical protein +FIG01127816 FIG01127817: hypothetical protein +FIG01127817 FIG01127818: hypothetical protein +FIG01127818 nrps2 gene cluster +FIG01127824 FIG01127825: hypothetical protein +FIG01127829 FIG01127830: hypothetical protein +FIG01127831 putative ABC-transport protein. +FIG01127836 FIG01127837: hypothetical protein +FIG01127837 FIG01127838: hypothetical protein +FIG01127839 FIG01127840: hypothetical protein +FIG01127841 FIG01127844: hypothetical protein +FIG01127844 FIG01127848: hypothetical protein +FIG01127855 FIG01127858: hypothetical protein +FIG01127858 FIG01127860: hypothetical protein +FIG01127860 FIG01127861: hypothetical protein +FIG01127866 FIG01127867: hypothetical protein +FIG01127867 FIG01127869: hypothetical protein +FIG01127870 FIG01127871: hypothetical protein +FIG01127873 FIG01127874: hypothetical protein +FIG01127874 FIG01127877: hypothetical protein +FIG01127878 FIG01127881: hypothetical protein +FIG01127883 FIG01127886: hypothetical protein +FIG01127888 FIG01127890: hypothetical protein +FIG01127890 FIG01127891: hypothetical protein +FIG01127893 FIG01127896: hypothetical protein +FIG01127896 Amidase family protein SACE_5032 +FIG01127901 FIG01127902: hypothetical protein +FIG01127905 FIG01127906: hypothetical protein +FIG01127906 FIG01127907: hypothetical protein +FIG01127907 penicillin amidase family protein +FIG01127908 FIG01127910: hypothetical protein +FIG01127910 FIG01127911: hypothetical protein +FIG01127911 FIG01127912: hypothetical protein +FIG01127912 FIG01127913: hypothetical protein +FIG01127914 FIG01127915: hypothetical protein +FIG01127915 putative cellulose 1,4-beta-cellobiosidase +FIG01127916 FIG01127917: hypothetical protein +FIG01127917 FIG01127919: hypothetical protein +FIG01127921 putative solute-binding protein +FIG01127925 GAF domain-containing protein / Signal transduction response regulator +FIG01127929 multi-component regulatory system-4 +FIG01127930 FIG01127931: hypothetical protein +FIG01127931 FIG01127932: hypothetical protein +FIG01127932 FIG01127934: hypothetical protein +FIG01127934 putative endo-1,4-beta-glucanase +FIG01127935 FIG01127936: hypothetical protein +FIG01127936 Thioesterase in siderophore biosynthesis gene cluster +FIG01127938 FIG01127940: hypothetical protein +FIG01127945 FIG01127946: hypothetical protein +FIG01127946 FIG01127947: hypothetical protein +FIG01127947 Radical SAM protein required for addition of adenosine to hopane skeleton, HpnH +FIG01127954 FIG01127956: hypothetical protein +FIG01127956 FIG01127958: hypothetical protein +FIG01127960 FIG01127962: hypothetical protein +FIG01127966 FIG01127967: hypothetical protein +FIG01127967 FIG01127969: hypothetical protein +FIG01127970 FIG01127973: hypothetical protein +FIG01127974 FIG01127975: hypothetical protein +FIG01127976 FIG01127978: hypothetical protein +FIG01127978 FIG01127979: hypothetical protein +FIG01127979 hypothetical protein SC5C7.11 +FIG01127981 FIG01127984: hypothetical protein +FIG01127987 FIG01127988: hypothetical protein +FIG01127989 FIG01127990: hypothetical protein +FIG01127990 FIG01127991: hypothetical protein +FIG01127991 FIG01127992: hypothetical protein +FIG01127993 FIG01127994: hypothetical protein +FIG01127997 FIG01128000: hypothetical protein +FIG01128000 FIG01128001: hypothetical protein +FIG01128001 FIG01128003: hypothetical protein +FIG01128004 FIG01128005: hypothetical protein +FIG01128007 FIG01128008: hypothetical protein +FIG01128014 FIG01128016: hypothetical protein +FIG01128016 FIG01128019: hypothetical protein +FIG01128019 putative oxidoreductase. +FIG01128023 FIG01128024: hypothetical protein +FIG01128024 FIG01128025: hypothetical protein +FIG01128036 alpha-L-glutamate ligase, RimK family +FIG01128040 FIG01128041: hypothetical protein +FIG01128041 FIG01128042: hypothetical protein +FIG01128044 FIG01128047: hypothetical protein +FIG01128051 extracellular solute-binding domain protein +FIG01128052 FIG059443: hypothetical protein +FIG01128055 FIG01128059: hypothetical protein +FIG01128059 FIG01128061: hypothetical protein +FIG01128061 FIG01128062: hypothetical protein +FIG01128064 FIG01128066: hypothetical protein +FIG01128066 FIG01128067: hypothetical protein +FIG01128071 FIG01128072: hypothetical protein +FIG01128073 putative chloramphenicol 3-O phosphotransferase +FIG01128094 FIG01128097: hypothetical protein +FIG01128106 FIG01128107: hypothetical protein +FIG01128107 FIG01128109: hypothetical protein +FIG01128111 FIG01128112: hypothetical protein +FIG01128116 FIG01128117: hypothetical protein +FIG01128117 FIG01128121: hypothetical protein +FIG01128121 FIG01128122: hypothetical protein +FIG01128122 FIG01128127: hypothetical protein +FIG01128134 FIG01128137: hypothetical protein +FIG01128137 FIG01128139: hypothetical protein +FIG01128148 FIG01128150: hypothetical protein +FIG01128150 putative hygromycin B biosynthetic protein +FIG01128154 beta-lactamase inhibitory protein II +FIG01128155 FIG01128156: hypothetical protein +FIG01128156 FIG01128157: hypothetical protein +FIG01128160 FIG01128163: hypothetical protein +FIG01128163 FIG01128170: hypothetical protein +FIG01128171 FIG01128172: hypothetical protein +FIG01128172 FIG01128175: hypothetical protein +FIG01128175 FIG01128178: hypothetical protein +FIG01128178 FIG01128179: hypothetical protein +FIG01128179 probable GntR-family regulator (secreted protein) +FIG01128181 RidA/YER057c/UK114 superfamily, group 4 +FIG01128183 pyochelin biosynthetic protein PchC +FIG01128184 FIG01128185: hypothetical protein +FIG01128185 FIG01128188: hypothetical protein +FIG01128188 FIG01128190: hypothetical protein +FIG01128191 FIG01128192: hypothetical protein +FIG01128192 FIG01128194: hypothetical protein +FIG01128194 FIG01128196: hypothetical protein +FIG01128196 FIG01128197: hypothetical protein +FIG01128199 FIG01128201: hypothetical protein +FIG01128202 FIG01128203: hypothetical protein +FIG01128203 FIG01128204: hypothetical protein +FIG01128207 FIG01128208: hypothetical protein +FIG01128210 FIG01128211: hypothetical protein +FIG01128215 FIG01128216: hypothetical protein +FIG01128216 FIG01128218: hypothetical protein +FIG01128218 3-oxoacyl-ACP synthase I +FIG01128224 FIG01128225: hypothetical protein +FIG01128225 FIG01128229: hypothetical protein +FIG01128232 FIG01128235: hypothetical protein +FIG01128241 FIG01128243: hypothetical protein +FIG01128243 putative single-strand DNA-binding protein +FIG01128245 FIG01128248: hypothetical protein +FIG01128253 FIG01128254: hypothetical protein +FIG01128255 FIG01128256: hypothetical protein +FIG01128261 FIG01128262: hypothetical protein +FIG01128263 FIG01128266: hypothetical protein +FIG01128266 FIG01128267: hypothetical protein +FIG01128268 FIG01128269: hypothetical protein +FIG01128269 FIG01128270: hypothetical protein +FIG01128272 FIG00665910: hypothetical protein +FIG01128273 putative membrane protein SCJ1.26 +FIG01128282 FIG01128283: hypothetical protein +FIG01128284 FIG01128287: hypothetical protein +FIG01128290 FIG01128291: hypothetical protein +FIG01128291 FIG01128292: hypothetical protein +FIG01128292 FIG01128293: hypothetical protein +FIG01128293 hypothetical protein +FIG01128300 FIG01128301: hypothetical protein +FIG01128303 FIG01128305: hypothetical protein +FIG01128305 FIG01128308: hypothetical protein +FIG01128309 FIG01128310: hypothetical protein +FIG01128315 putative two component sensor +FIG01128318 FIG01128319: hypothetical protein +FIG01128319 FIG01128320: hypothetical protein +FIG01128320 FIG01128321: hypothetical protein +FIG01128322 FIG01128323: hypothetical protein +FIG01128326 FIG01128327: hypothetical protein +FIG01128327 FIG01128328: hypothetical protein +FIG01128336 putative LysR-family transcriptional regulator. +FIG01128354 FIG01128355: hypothetical protein +FIG01128355 FIG01128358: hypothetical protein +FIG01128360 phage related +FIG01128364 FIG01128365: hypothetical protein +FIG01128366 putative beta-glucosidase +FIG01128367 2-phosphosulfolactate phosphatase +FIG01128369 FIG01128371: hypothetical protein +FIG01128374 FIG01128375: hypothetical protein +FIG01128380 FIG01128381: hypothetical protein +FIG01128381 FIG01128382: hypothetical protein +FIG01128387 FIG01128389: hypothetical protein +FIG01128389 FIG01128392: hypothetical protein +FIG01128399 FIG01128400: hypothetical protein +FIG01128400 FIG01128401: hypothetical protein +FIG01128401 FIG01128402: hypothetical protein +FIG01128402 FIG01128404: hypothetical protein +FIG01128404 FIG01128406: hypothetical protein +FIG01128406 FIG01129891: hypothetical protein +FIG01128411 FIG01128413: hypothetical protein +FIG01128413 FIG01128414: hypothetical protein +FIG01128414 haloacid dehalogenase +FIG01128418 FIG01128419: hypothetical protein +FIG01128425 putative N5, N10-methylenetetrahydromethanopterin reductase-related protein +FIG01128431 FIG01128433: hypothetical protein +FIG01128435 FIG01128436: hypothetical protein +FIG01128447 FIG01128448: hypothetical protein +FIG01128448 FIG01128449: hypothetical protein +FIG01128449 FIG01128450: hypothetical protein +FIG01128450 FIG01128451: hypothetical protein +FIG01128451 alpha-galactosidase SCF8502 +FIG01128452 FIG01128454: hypothetical protein +FIG01128454 FIG01128455: hypothetical protein +FIG01128456 FIG01128459: hypothetical protein +FIG01128459 FIG01128460: hypothetical protein +FIG01128467 FIG01128468: hypothetical protein +FIG01128468 FIG01128472: hypothetical protein +FIG01128472 FIG01128475: hypothetical protein +FIG01128475 peptide ABC transporter peptide-binding protein,putative +FIG01128482 FIG01128486: hypothetical protein +FIG01128487 FIG01128491: hypothetical protein +FIG01128492 FIG01128495: hypothetical protein +FIG01128498 putative oligo-1,6-glucosidase +FIG01128501 FIG01128502: hypothetical protein +FIG01128505 FIG01128507: hypothetical protein +FIG01128510 FIG01128511: hypothetical protein +FIG01128511 FIG01128512: hypothetical protein +FIG01128512 FIG01128514: hypothetical protein +FIG01128514 FIG01128515: hypothetical protein +FIG01128516 FIG01128517: hypothetical protein +FIG01128518 FIG01128520: hypothetical protein +FIG01128521 FIG01128524: hypothetical protein +FIG01128527 FIG01128528: hypothetical protein +FIG01128528 FIG01128529: hypothetical protein +FIG01128531 FIG01128532: hypothetical protein +FIG01128532 FIG01128534: hypothetical protein +FIG01128542 FIG01128543: hypothetical protein +FIG01128543 FIG01128545: hypothetical protein +FIG01128545 FIG01128546: hypothetical protein +FIG01128546 FIG01128549: hypothetical protein +FIG01128550 FIG01128551: hypothetical protein +FIG01128551 FIG01128552: hypothetical protein +FIG01128552 FIG01128554: hypothetical protein +FIG01128555 FIG01128556: hypothetical protein +FIG01128563 FIG01128564: hypothetical protein +FIG01128565 FIG01128567: hypothetical protein +FIG01128567 FIG01128568: hypothetical protein +FIG01128568 A-factor receptor protein (A-factor-binding protein) +FIG01128569 FIG01128570: hypothetical protein +FIG01128570 FIG01128572: hypothetical protein +FIG01128572 FIG01128575: hypothetical protein +FIG01128575 FIG01128576: hypothetical protein +FIG01128579 putative aminoglycoside acetyltransferase +FIG01128585 putative monooxygenase FAD-type +FIG01128586 FIG01128587: hypothetical protein +FIG01128587 putative metal-transport protein +FIG01128595 putative oxidoreductase (putative secreted protein) +FIG01128598 FIG01128601: hypothetical protein +FIG01128613 FIG01128614: hypothetical protein +FIG01128614 FIG01128615: hypothetical protein +FIG01128617 FIG01128618: hypothetical protein +FIG01128622 FIG01128623: hypothetical protein +FIG01128627 FIG01128630: hypothetical protein +FIG01128630 FIG01128631: hypothetical protein +FIG01128635 FIG01128636: hypothetical protein +FIG01128637 FIG01128640: hypothetical protein +FIG01128640 FIG01128643: hypothetical protein +FIG01128644 FIG01128645: hypothetical protein +FIG01128645 FIG01128646: hypothetical protein +FIG01128646 hypothetical protein, contains weak similarity to acetyltransferase +FIG01128648 FIG01128649: hypothetical protein +FIG01128651 FIG01128652: hypothetical protein +FIG01128665 FIG01128666: hypothetical protein +FIG01128668 FIG01128669: hypothetical protein +FIG01128672 FIG01128674: hypothetical protein +FIG01128676 FIG01128677: hypothetical protein +FIG01128677 FIG01128678: hypothetical protein +FIG01128681 FIG01128685: hypothetical protein +FIG01128685 FIG01128686: hypothetical protein +FIG01128686 FIG01128687: hypothetical protein +FIG01128690 FIG01128691: hypothetical protein +FIG01128693 FIG01128694: hypothetical protein +FIG01128695 putative DnaK suppressor protein +FIG01128698 FIG01128700: hypothetical protein +FIG01128700 FIG01128701: hypothetical protein +FIG01128705 FIG01128706: hypothetical protein +FIG01128706 FIG01128712: hypothetical protein +FIG01128714 FIG01128716: hypothetical protein +FIG01128720 Crp-family transcriptional regulator +FIG01128724 FIG01128725: hypothetical protein +FIG01128734 FIG01128736: hypothetical protein +FIG01128749 FIG01128750: hypothetical protein +FIG01128750 putative magnesium chelatase +FIG01128753 FIG01128755: hypothetical protein +FIG01128755 FIG01128756: hypothetical protein +FIG01128756 FIG01128758: hypothetical protein +FIG01128758 FIG01128759: hypothetical protein +FIG01128759 FIG01128260: hypothetical protein +FIG01128762 FIG01128765: hypothetical protein +FIG01128765 FIG01128766: hypothetical protein +FIG01128770 FIG01128771: hypothetical protein +FIG01128771 FIG01128772: hypothetical protein +FIG01128776 FIG01128777: hypothetical protein +FIG01128777 FIG01128778: hypothetical protein +FIG01128778 FIG01128779: hypothetical protein +FIG01128779 FIG01128780: hypothetical protein +FIG01128780 FIG01128782: hypothetical protein +FIG01128782 FIG01128788: hypothetical protein +FIG01128790 putative inositol monophosphatase +FIG01128792 FIG01128794: hypothetical protein +FIG01128794 FIG01128795: hypothetical protein +FIG01128795 FIG01128796: hypothetical protein +FIG01128796 FIG01128797: hypothetical protein +FIG01128798 FIG01128799: hypothetical protein +FIG01128799 FIG01128801: hypothetical protein +FIG01128801 FIG01128804: hypothetical protein +FIG01128809 FIG01128811: hypothetical protein +FIG01128811 FIG01128812: hypothetical protein +FIG01128812 FIG01128813: hypothetical protein +FIG01128814 FIG01128818: hypothetical protein +FIG01128819 FIG01128821: hypothetical protein +FIG01128827 FIG01128829: hypothetical protein +FIG01128831 FIG01128833: hypothetical protein +FIG01128837 FIG01128838: hypothetical protein +FIG01128838 FIG01128839: hypothetical protein +FIG01128842 FIG01128843: hypothetical protein +FIG01128843 FIG01128849: hypothetical protein +FIG01128849 putative TmrB-like protein +FIG01128851 FIG01128852: hypothetical protein +FIG01128852 FIG01128853: hypothetical protein +FIG01128853 FIG01128854: hypothetical protein +FIG01128855 FIG01128856: hypothetical protein +FIG01128861 FIG01128862: hypothetical protein +FIG01128865 FIG01128868: hypothetical protein +FIG01128868 FIG01128870: hypothetical protein +FIG01128874 putative rhamnogalacturonase B precursor +FIG01128876 FIG01128877: hypothetical protein +FIG01128878 FIG01128880: hypothetical protein +FIG01128880 FIG01128882: hypothetical protein +FIG01128883 FIG01128884: hypothetical protein +FIG01128885 FIG01128886: hypothetical protein +FIG01128886 FIG01128887: hypothetical protein +FIG01128888 FIG01128892: hypothetical protein +FIG01128896 FIG01128897: hypothetical protein +FIG01128898 FIG01128900: hypothetical protein +FIG01128900 FIG01128901: hypothetical protein +FIG01128902 FIG01128903: hypothetical protein +FIG01128905 FIG01128906: hypothetical protein +FIG01128906 FIG01128909: hypothetical protein +FIG01128909 FIG01128912: hypothetical protein +FIG01128912 FIG01128913: hypothetical protein +FIG01128915 FIG01128918: hypothetical protein +FIG01128919 FIG01128920: hypothetical protein +FIG01128921 FIG01128922: hypothetical protein +FIG01128922 FIG01128923: hypothetical protein +FIG01128924 FIG01128925: hypothetical protein +FIG01128926 FIG01128927: hypothetical protein +FIG01128927 FIG01128929: hypothetical protein +FIG01128929 FIG01128930: hypothetical protein +FIG01128930 FIG01128932: hypothetical protein +FIG01128933 FIG01128934: hypothetical protein +FIG01128936 FIG01128937: hypothetical protein +FIG01128944 multi-component regulatory system-10 +FIG01128946 FIG01128947: hypothetical protein +FIG01128947 FIG01128948: hypothetical protein +FIG01128948 FIG01128949: hypothetical protein +FIG01128957 FIG01128959: hypothetical protein +FIG01128959 FIG01128963: hypothetical protein +FIG01128969 FIG01128971: hypothetical protein +FIG01128973 FIG01128974: hypothetical protein +FIG01128976 FIG01128977: hypothetical protein +FIG01128977 FIG01128979: hypothetical protein +FIG01128979 FIG01128980: hypothetical protein +FIG01128981 FIG01128982: hypothetical protein +FIG01128982 FIG01128983: hypothetical protein +FIG01128985 FIG01128986: hypothetical protein +FIG01128991 FIG01128992: hypothetical protein +FIG01128996 FIG01128998: hypothetical protein +FIG01129002 FIG01129003: hypothetical protein +FIG01129003 FIG01129005: hypothetical protein +FIG01129012 FIG01129014: hypothetical protein +FIG01129014 FIG01129015: hypothetical protein +FIG01129015 FIG01129017: hypothetical protein +FIG01129017 FIG01129019: hypothetical protein +FIG01129019 FIG01129026: hypothetical protein +FIG01129034 FIG01129035: hypothetical protein +FIG01129035 RedV protein +FIG01129038 FIG01129039: hypothetical protein +FIG01129041 putative lacI-family transcriptional regulator +FIG01129043 Possible ATP-binding protein +FIG01129050 FIG01129051: hypothetical protein +FIG01129058 peptidylprolyl isomerase, FKBP-type( EC:5.2.1.8 ) +FIG01129062 FIG01129064: hypothetical protein +FIG01129065 FIG01129072: hypothetical protein +FIG01129072 Intradiol ring-cleavage dioxygenase +FIG01129077 FIG01129078: hypothetical protein +FIG01129078 FIG01129079: hypothetical protein +FIG01129082 FIG01129083: hypothetical protein +FIG01129085 FIG01129087: hypothetical protein +FIG01129087 FIG01129090: hypothetical protein +FIG01129092 FIG01129097: hypothetical protein +FIG01129111 FIG01129113: hypothetical protein +FIG01129116 FIG01129117: hypothetical protein +FIG01129117 FIG01129120: hypothetical protein +FIG01129120 FIG01129122: hypothetical protein +FIG01129122 FIG01129127: hypothetical protein +FIG01129127 FIG01129129: hypothetical protein +FIG01129129 SC5B8.23c, unknown, len: 78 aa +FIG01129130 FIG01129131: hypothetical protein +FIG01129131 putative large alanine-rich protein +FIG01129136 FIG01129137: hypothetical protein +FIG01129137 FIG01129138: hypothetical protein +FIG01129138 FIG01129139: hypothetical protein +FIG01129139 putative ABC transporter membrane protein +FIG01129140 FIG01129141: hypothetical protein +FIG01129143 FIG01129144: hypothetical protein +FIG01129145 FIG01129147: hypothetical protein +FIG01129152 FIG01129153: hypothetical protein +FIG01129160 FIG01129161: hypothetical protein +FIG01129169 FIG01129170: hypothetical protein +FIG01129173 FIG01129174: hypothetical protein +FIG01129174 FIG01129175: hypothetical protein +FIG01129176 acetyltransferase-like protein +FIG01129181 FIG01129183: hypothetical protein +FIG01129183 FIG01129184: hypothetical protein +FIG01129184 FIG01129186: hypothetical protein +FIG01129190 putative intradiol ring-cleavage dioxygenase( EC:1.13.11.- ) +FIG01129191 FIG01129192: hypothetical protein +FIG01129194 FIG01129195: hypothetical protein +FIG01129196 FIG01129200: hypothetical protein +FIG01129202 FIG01129209: hypothetical protein +FIG01129209 FIG01129216: hypothetical protein +FIG01129216 asparagine synthetase +FIG01129221 FIG01129222: hypothetical protein +FIG01129222 FIG01129223: hypothetical protein +FIG01129224 FIG01129227: hypothetical protein +FIG01129230 FIG01129232: hypothetical protein +FIG01129237 FIG01129240: hypothetical protein +FIG01129247 FIG01129248: hypothetical protein +FIG01129249 FIG01129250: hypothetical protein +FIG01129250 FIG01129251: hypothetical protein +FIG01129253 FIG01129255: hypothetical protein +FIG01129255 FIG01129257: hypothetical protein +FIG01129262 FIG01129264: hypothetical protein +FIG01129264 FIG01129265: hypothetical protein +FIG01129266 FIG01129268: hypothetical protein +FIG01129271 FIG01129272: hypothetical protein +FIG01129273 FIG01129274: hypothetical protein +FIG01129283 FIG01129285: hypothetical protein +FIG01129285 FIG01129288: hypothetical protein +FIG01129288 FIG01129289: hypothetical protein +FIG01129289 FIG01129294: hypothetical protein +FIG01129296 FIG01129299: hypothetical protein +FIG01129306 FIG01129307: hypothetical protein +FIG01129307 FIG01129308: hypothetical protein +FIG01129310 FIG01129311: hypothetical protein +FIG01129311 FIG01129312: hypothetical protein +FIG01129312 FIG01129314: hypothetical protein +FIG01129320 FIG01129321: hypothetical protein +FIG01129325 FIG01129326: hypothetical protein +FIG01129327 FIG01129328: hypothetical protein +FIG01129331 FIG01129332: hypothetical protein +FIG01129332 Substrate-binding region of ABC-type glycine betaine transport system +FIG01129334 FIG01129336: hypothetical protein +FIG01129336 FIG01129337: hypothetical protein +FIG01129337 FIG01129338: hypothetical protein +FIG01129338 FIG01129339: hypothetical protein +FIG01129339 FIG01129341: hypothetical protein +FIG01129341 FIG01129342: hypothetical protein +FIG01129345 FIG01129346: hypothetical protein +FIG01129349 FIG01129350: hypothetical protein +FIG01129350 alpha-L-arabinofuranosidase +FIG01129353 FIG01129356: hypothetical protein +FIG01129356 FIG01129357: hypothetical protein +FIG01129358 FIG01129359: hypothetical protein +FIG01129363 putative secreted beta-mannosidase +FIG01129365 FIG01129367: hypothetical protein +FIG01129367 FIG01129371: hypothetical protein +FIG01129374 FIG01129375: hypothetical protein +FIG01129375 putative alpha-amylase +FIG01129378 LuxA-like protein +FIG01129382 FIG01129383: hypothetical protein +FIG01129384 FIG01129386: hypothetical protein +FIG01129386 FIG01129388: hypothetical protein +FIG01129392 FIG01129393: hypothetical protein +FIG01129393 FIG01129396: hypothetical protein +FIG01129396 FIG01129397: hypothetical protein +FIG01129398 FIG01129400: hypothetical protein +FIG01129401 FIG01129402: hypothetical protein +FIG01129402 FIG01129405: hypothetical protein +FIG01129407 FIG01129408: hypothetical protein +FIG01129409 FIG01129410: hypothetical protein +FIG01129417 FIG01129418: hypothetical protein +FIG01129420 FIG01129423: hypothetical protein +FIG01129424 FIG01129427: hypothetical protein +FIG01129428 FIG01129429: hypothetical protein +FIG01129429 FIG01129430: hypothetical protein +FIG01129430 putative nikkomycin biosynthesis protein SanT +FIG01129434 Thiamine pyrophosphate-requiring protein Saci_2281 +FIG01129441 FIG01129620: hypothetical protein +FIG01129443 FIG01129445: hypothetical protein +FIG01129449 FIG01129450: hypothetical protein +FIG01129454 FIG01129456: hypothetical protein +FIG01129460 FIG01129462: hypothetical protein +FIG01129462 FIG01129463: hypothetical protein +FIG01129465 FIG01129467: hypothetical protein +FIG01129467 FIG01129468: hypothetical protein +FIG01129469 FIG01129470: hypothetical protein +FIG01129474 FIG01129475: hypothetical protein +FIG01129484 FIG01129485: hypothetical protein +FIG01129485 FIG01129486: hypothetical protein +FIG01129486 FIG01129488: hypothetical protein +FIG01129488 FIG01129491: hypothetical protein +FIG01129497 FIG01129498: hypothetical protein +FIG01129498 putative lantibiotic precursor +FIG01129500 FIG01129501: hypothetical protein +FIG01129502 FIG01129504: hypothetical protein +FIG01129512 putative endochitinase +FIG01129513 FIG01129515: hypothetical protein +FIG01129522 FIG01129524: hypothetical protein +FIG01129526 FIG01129527: hypothetical protein +FIG01129528 FIG01129529: hypothetical protein +FIG01129529 Inosamine-phosphate amidinotransferase 1 (EC 2.1.4.2) (Inosamine-phosphate amidinotransferase I) (Aminocyclitol amidinotransferase) (ADT) +FIG01129533 putative polyketide cyclase +FIG01129537 FIG01129539: hypothetical protein +FIG01129542 FIG01129543: hypothetical protein +FIG01129543 FIG01129544: hypothetical protein +FIG01129546 FIG01129547: hypothetical protein +FIG01129547 FIG01129548: hypothetical protein +FIG01129548 FIG01129550: hypothetical protein +FIG01129576 FIG01129577: hypothetical protein +FIG01129577 FIG01129579: hypothetical protein +FIG01129579 putative modular polyketide synthase +FIG01129580 FIG01129582: hypothetical protein +FIG01129582 FIG01129583: hypothetical protein +FIG01129583 probable phenazine-specific methyltransferase +FIG01129587 FIG01129589: hypothetical protein +FIG01129590 FIG01129591: hypothetical protein +FIG01129591 FIG01129592: hypothetical protein +FIG01129598 FIG01129599: hypothetical protein +FIG01129599 FIG01129600: hypothetical protein +FIG01129606 FIG01129607: hypothetical protein +FIG01129608 FIG01129609: hypothetical protein +FIG01129618 FIG01129619: hypothetical protein +FIG01129620 FIG01129621: hypothetical protein +FIG01129622 FIG01129623: hypothetical protein +FIG01129625 FIG01129627: hypothetical protein +FIG01129639 FIG01129640: hypothetical protein +FIG01129642 FIG01129647: hypothetical protein +FIG01129647 FIG01129648: hypothetical protein +FIG01129649 FIG01129651: hypothetical protein +FIG01129651 FIG01129654: hypothetical protein +FIG01129654 FIG01129657: hypothetical protein +FIG01129658 guanyl-specific ribonuclease Sa +FIG01129659 FIG01129660: hypothetical protein +FIG01129660 FIG01129661: hypothetical protein +FIG01129661 FIG01129662: hypothetical protein +FIG01129665 FIG01129666: hypothetical protein +FIG01129666 FIG01129667: hypothetical protein +FIG01129667 FIG01129670: hypothetical protein +FIG01129675 FIG01129677: hypothetical protein +FIG01129683 FIG01129684: hypothetical protein +FIG01129684 FIG01129685: hypothetical protein +FIG01129688 FIG01129689: hypothetical protein +FIG01129689 FIG01129690: hypothetical protein +FIG01129690 FIG01129691: hypothetical protein +FIG01129692 FIG01129693: hypothetical protein +FIG01129693 FIG01129694: hypothetical protein +FIG01129694 FIG01129696: hypothetical protein +FIG01129714 FIG01129715: hypothetical protein +FIG01129718 FIG01129722: hypothetical protein +FIG01129723 FIG01129724: hypothetical protein +FIG01129724 FIG01129725: hypothetical protein +FIG01129728 FIG01129730: hypothetical protein +FIG01129730 FIG01129731: hypothetical protein +FIG01129731 FIG01129732: hypothetical protein +FIG01129733 FIG01129735: hypothetical protein +FIG01129736 FIG01129738: hypothetical protein +FIG01129753 FIG01129755: hypothetical protein +FIG01129755 FIG01129757: hypothetical protein +FIG01129757 FIG01129758: hypothetical protein +FIG01129760 FIG01129761: hypothetical protein +FIG01129761 FIG01129762: hypothetical protein +FIG01129775 FMNH2-utilizing oxygenase +FIG01129798 alpha amylase catalytic region +FIG01129801 Putative monooxygenase +FIG01129804 FIG01129807: hypothetical protein +FIG01129814 FIG01129816: hypothetical protein +FIG01129816 FIG01129822: hypothetical protein +FIG01129825 FIG01129826: hypothetical protein +FIG01129829 FIG01129830: hypothetical protein +FIG01129835 FIG01129837: hypothetical protein +FIG01129837 FIG01129839: hypothetical protein +FIG01129841 two component sensor kinase +FIG01129855 putative tyrosinase co-factor protein +FIG01129856 FIG00830454: hypothetical protein +FIG01129862 FIG01129863: hypothetical protein +FIG01129863 FIG01129865: hypothetical protein +FIG01129865 SCP1.74, unknown, len: 361aa +FIG01129866 FIG01129867: hypothetical protein +FIG01129867 FIG01129868: hypothetical protein +FIG01129868 FIG01129869: hypothetical protein +FIG01129869 FIG01129870: hypothetical protein +FIG01129873 FIG01129875: hypothetical protein +FIG01129892 FIG01129893: hypothetical protein +FIG01129899 FIG01129902: hypothetical protein +FIG01129903 StrF +FIG01129912 FIG01129914: hypothetical protein +FIG01129919 FIG01129920: hypothetical protein +FIG01129926 FIG01129927: hypothetical protein +FIG01129927 FIG01129928: hypothetical protein +FIG01129934 FIG01129935: hypothetical protein +FIG01129935 FIG01129936: hypothetical protein +FIG01129942 Mll5046 protein +FIG01129946 FIG01129947: hypothetical protein +FIG01129947 FIG01129948: hypothetical protein +FIG01129955 FIG01129957: hypothetical protein +FIG01129958 FIG01129959: hypothetical protein +FIG01129960 FIG01129961: hypothetical protein +FIG01129962 FIG01129963: hypothetical protein +FIG01129972 FIG01129973: hypothetical protein +FIG01129973 putative AmfS protein +FIG01129976 FIG01129977: hypothetical protein +FIG01129979 putative aminoglycoside phosphotransferase, antibiotic resistance protein +FIG01129981 FIG01129983: hypothetical protein +FIG01129983 FIG01129986: hypothetical protein +FIG01129987 FIG01129988: hypothetical protein +FIG01129988 FIG01129989: hypothetical protein +FIG01129990 FIG01129995: hypothetical protein +FIG01129995 FIG01129998: hypothetical protein +FIG01130000 FIG01130004: hypothetical protein +FIG01130013 FIG01130014: hypothetical protein +FIG01130014 FIG01130015: hypothetical protein +FIG01130015 FIG01130018: hypothetical protein +FIG01130018 FIG01130020: hypothetical protein +FIG01130022 hypothetical hydrophilic protein +FIG01130027 FIG01130028: hypothetical protein +FIG01130033 hypothetical protein test +FIG01130035 FIG01130037: hypothetical protein +FIG01130037 FIG01130039: hypothetical protein +FIG01130039 FIG01130043: hypothetical protein +FIG01130050 FIG01130051: hypothetical protein +FIG01130052 FIG01130054: hypothetical protein +FIG01130054 FIG01130055: hypothetical protein +FIG01130055 FIG01130056: hypothetical protein +FIG01130058 FIG01130059: hypothetical protein +FIG01130065 FIG01130066: hypothetical protein +FIG01130066 FIG01130068: hypothetical protein +FIG01130071 FIG01130072: hypothetical protein +FIG01130072 FIG01130073: hypothetical protein +FIG01130075 Mlr3941 protein +FIG01130081 FIG01130084: hypothetical protein +FIG01130087 FIG01130091: hypothetical protein +FIG01130091 FIG01130093: hypothetical protein +FIG01130093 FIG01130097: hypothetical protein +FIG01130097 FIG01130098: hypothetical protein +FIG01130099 FIG01130100: hypothetical protein +FIG01130103 FIG01130104: hypothetical protein +FIG01130108 FIG01130109: hypothetical protein +FIG01130118 FIG01130119: hypothetical protein +FIG01130119 FIG01130124: hypothetical protein +FIG01130126 FIG01130128: hypothetical protein +FIG01130128 FIG01130129: hypothetical protein +FIG01130130 putative glucose 1-dehydrogenase +FIG01130131 FIG01130132: hypothetical protein +FIG01130132 FIG01130133: hypothetical protein +FIG01130141 FIG01130143: hypothetical protein +FIG01130146 FIG01130148: hypothetical protein +FIG01130148 FIG01130149: hypothetical protein +FIG01130154 two component system sensor kinase +FIG01130156 FIG01130157: hypothetical protein +FIG01130157 FIG01130158: hypothetical protein +FIG01130158 FIG01130160: hypothetical protein +FIG01130164 FIG01130165: hypothetical protein +FIG01130165 FIG01130170: hypothetical protein +FIG01130174 FIG01130175: hypothetical protein +FIG01130179 FIG01130180: hypothetical protein +FIG01130188 FIG01130190: hypothetical protein +FIG01130190 FIG01130191: hypothetical protein +FIG01130193 FIG01130194: hypothetical protein +FIG01130196 FIG01130198: hypothetical protein +FIG01130206 Hydrogenase assembly protein HoxX +FIG01130209 FIG01130211: hypothetical protein +FIG01130220 FIG01130221: hypothetical protein +FIG01130221 FIG01130223: hypothetical protein +FIG01130224 FIG01130225: hypothetical protein +FIG01130230 FIG01130231: hypothetical protein +FIG01130232 FIG01130233: hypothetical protein +FIG01130235 FIG01130237: hypothetical protein +FIG01130238 FIG01130242: hypothetical protein +FIG01130251 FIG01130252: hypothetical protein +FIG01130252 FIG01130253: hypothetical protein +FIG01130254 FIG01130255: hypothetical protein +FIG01130259 FIG01130261: hypothetical protein +FIG01130267 acetyl xylan esterase +FIG01130278 FIG01130279: hypothetical protein +FIG01130280 FIG01130281: hypothetical protein +FIG01130282 FIG01130285: hypothetical protein +FIG01130285 FIG01130286: hypothetical protein +FIG01130286 FIG01130287: hypothetical protein +FIG01130287 FIG01130288: hypothetical protein +FIG01130289 FIG01130290: hypothetical protein +FIG01130290 FIG01130293: hypothetical protein +FIG01130300 FIG01130302: hypothetical protein +FIG01130308 FIG01130309: hypothetical protein +FIG01130322 FIG01130324: hypothetical protein +FIG01130324 FIG01130326: hypothetical protein +FIG01130326 FIG01130327: hypothetical protein +FIG01130334 probable taurine dioxygenase( EC:1.14.11.17 ) +FIG01130335 FIG01130336: hypothetical protein +FIG01130338 cold shock protein +FIG01130344 FIG01130345: hypothetical protein +FIG01130345 FIG01130348: hypothetical protein +FIG01130351 FIG01130353: hypothetical protein +FIG01130353 FIG01130359: hypothetical protein +FIG01130359 FIG01130360: hypothetical protein +FIG01130360 FIG01130361: hypothetical protein +FIG01130361 FIG01130362: hypothetical protein +FIG01130362 FIG01130363: hypothetical protein +FIG01130363 hypothetical protein 2SCK31.13 +FIG01130364 FIG01130365: hypothetical protein +FIG01130365 FIG01130366: hypothetical protein +FIG01130366 FIG01130367: hypothetical protein +FIG01130367 FIG01130369: hypothetical protein +FIG01130372 FIG01130373: hypothetical protein +FIG01130373 FIG01130375: hypothetical protein +FIG01130385 FIG01130386: hypothetical protein +FIG01130386 FIG01130387: hypothetical protein +FIG01130387 FIG01130388: hypothetical protein +FIG01130389 FIG01130390: hypothetical protein +FIG01130392 FIG01130393: hypothetical protein +FIG01130401 FIG01130403: hypothetical protein +FIG01130404 FIG01130405: hypothetical protein +FIG01130406 RedY protein +FIG01130409 FIG01130411: hypothetical protein +FIG01130411 FIG01130414: hypothetical protein +FIG01130415 FIG01130416: hypothetical protein +FIG01130416 FIG01130417: hypothetical protein +FIG01130417 FIG01130420: hypothetical protein +FIG01130424 FIG01130425: hypothetical protein +FIG01130431 DUF89 domain of unknown function +FIG01130435 FIG01130436: hypothetical protein +FIG01130437 FIG01130438: hypothetical protein +FIG01130439 FIG01130441: hypothetical protein +FIG01130442 FIG01130443: hypothetical protein +FIG01130448 FIG01130449: hypothetical protein +FIG01130450 hypothetical protein SC1B2.08 +FIG01130452 FIG01130453: hypothetical protein +FIG01130453 SCBAC20F6.05c, hypothetical protein, len: 130 aa; similar to TR:Q9X8E7 (EMBL:AL049573) Streptomyces coelicolor hypothetical 16.4 kDa protein SCE39.24, 148 aa; fasta scores: opt: 257 Z-score: 327.8 bits: 66.5 E(): 1.1e-10; 39.394% identity in 132 aa overlap +FIG01130455 FIG01130456: hypothetical protein +FIG01130463 FIG01130464: hypothetical protein +FIG01130465 FIG01130467: hypothetical protein +FIG01130472 FIG01130473: hypothetical protein +FIG01130473 FIG01130475: hypothetical protein +FIG01130475 FIG01130476: hypothetical protein +FIG01130476 FIG01130477: hypothetical protein +FIG01130491 FIG01130494: hypothetical protein +FIG01130497 FIG01130498: hypothetical protein +FIG01130501 conserved hypothetical protein SCC24.31c +FIG01130504 chitosanase( EC:3.2.1.132 ) +FIG01130506 putative peptide ABC transporter, substrate-binding protein +FIG01130508 FIG01130510: hypothetical protein +FIG01130513 FIG01130515: hypothetical protein +FIG01130516 FIG01130518: hypothetical protein +FIG01130518 tetR-family transcriptional regulatory protein +FIG01130519 FIG01130520: hypothetical protein +FIG01130523 FIG01130526: hypothetical protein +FIG01130530 FIG01130531: hypothetical protein +FIG01130531 FIG01130532: hypothetical protein +FIG01130538 FIG01130539: hypothetical protein +FIG01130539 FIG01130540: hypothetical protein +FIG01130540 FIG01130541: hypothetical protein +FIG01130550 putative tyrosinase +FIG01130558 FIG01130559: hypothetical protein +FIG01130559 FIG01130560: hypothetical protein +FIG01130564 FIG01130568: hypothetical protein +FIG01130571 FIG01130572: hypothetical protein +FIG01130572 FIG01130575: hypothetical protein +FIG01130575 FIG01130579: hypothetical protein +FIG01130579 FIG01130580: hypothetical protein +FIG01130581 FIG01130584: hypothetical protein +FIG01130584 FIG01130585: hypothetical protein +FIG01130585 FIG01130586: hypothetical protein +FIG01130586 FIG01130590: hypothetical protein +FIG01130590 FIG01130594: hypothetical protein +FIG01130594 FIG01130595: hypothetical protein +FIG01130595 FIG01130597: hypothetical protein +FIG01130597 FIG01130598: hypothetical protein +FIG01130600 FIG01130603: hypothetical protein +FIG01130615 FIG01130616: hypothetical protein +FIG01130619 FIG01130624: hypothetical protein +FIG01130628 putative tetR family transcriptional regulatory protein +FIG01130637 FIG01130638: hypothetical protein +FIG01130639 FIG01130641: hypothetical protein +FIG01130643 FIG01130644: hypothetical protein +FIG01130644 FIG01130648: hypothetical protein +FIG01130657 FIG01130658: hypothetical protein +FIG01130658 N6 adenine-specific DNA methyltransferase, N12 class +FIG01130663 putative ABC transporter solute-binding protein +FIG01130676 FIG01130678: hypothetical protein +FIG01130678 FIG01130683: hypothetical protein +FIG01130690 FIG01130692: hypothetical protein +FIG01130695 FIG01130696: hypothetical protein +FIG01130708 FIG01130710: hypothetical protein +FIG01130711 FIG01130713: hypothetical protein +FIG01130714 FIG01130716: hypothetical protein +FIG01130716 FIG01130717: hypothetical protein +FIG01130717 FIG01130718: hypothetical protein +FIG01130718 FIG01130719: hypothetical protein +FIG01130724 FIG01130725: hypothetical protein +FIG01130732 FIG01130735: hypothetical protein +FIG01130740 ABC transporter related protein +FIG01130742 FIG01130747: hypothetical protein +FIG01130747 TetR family protein transcriptional regulator +FIG01130756 FIG01130757: hypothetical protein +FIG01130764 hypothetical protein SC8D11.22 +FIG01130766 FIG01130767: hypothetical protein +FIG01130772 FIG01130774: hypothetical protein +FIG01130776 FIG01130779: hypothetical protein +FIG01130781 FIG01130782: hypothetical protein +FIG01130782 conserved hypothetical protein SC4A7.31 +FIG01130790 FIG01130792: hypothetical protein +FIG01130799 FIG01130800: hypothetical protein +FIG01130800 xylan 1,4-beta-xylosidase +FIG01130804 FIG01130805: hypothetical protein +FIG01130805 iron utilization protein +FIG01130806 FIG01130807: hypothetical protein +FIG01130807 FIG01130810: hypothetical protein +FIG01130810 FIG01130811: hypothetical protein +FIG01130812 FIG01130815: hypothetical protein +FIG01130818 FIG01130820: hypothetical protein +FIG01130820 FIG01130824: hypothetical protein +FIG01130827 FIG01130829: hypothetical protein +FIG01130835 FIG01130836: hypothetical protein +FIG01130836 FIG01130838: hypothetical protein +FIG01130843 FIG01130847: hypothetical protein +FIG01130850 FIG01130851: hypothetical protein +FIG01130851 Streptomycin biosynthesis operon possible regulatory protein +FIG01130853 FIG01130854: hypothetical protein +FIG01130854 FIG01130855: hypothetical protein +FIG01130857 FIG01130858: hypothetical protein +FIG01130859 FIG01130860: hypothetical protein +FIG01130860 FIG01130862: hypothetical protein +FIG01130870 FIG01130872: hypothetical protein +FIG01130872 FIG01130873: hypothetical protein +FIG01130873 FIG01130874: hypothetical protein +FIG01130877 FIG01130878: hypothetical protein +FIG01130878 FIG01130879: hypothetical protein +FIG01130882 FIG01130883: hypothetical protein +FIG01130888 FIG01130889: hypothetical protein +FIG01130889 FIG01130890: hypothetical protein +FIG01130892 FIG01130893: hypothetical protein +FIG01130893 FIG01130894: hypothetical protein +FIG01130896 FIG01130897: hypothetical protein +FIG01130906 FIG01130907: hypothetical protein +FIG01130912 FIG01130913: hypothetical protein +FIG01130913 FIG01130914: hypothetical protein +FIG01130914 FIG01130917: hypothetical protein +FIG01130918 FIG01130919: hypothetical protein +FIG01130923 FIG01130924: hypothetical protein +FIG01130926 FIG01130927: hypothetical protein +FIG01130928 phosphatidylethanolamine-binding protein +FIG01130937 FIG01130939: hypothetical protein +FIG01130939 FIG01130940: hypothetical protein +FIG01130942 FIG01130944: hypothetical protein +FIG01130944 FIG01130945: hypothetical protein +FIG01130947 FIG01130948: hypothetical protein +FIG01130948 FIG01130949: hypothetical protein +FIG01130949 FIG01130951: hypothetical protein +FIG01130951 FIG01130952: hypothetical protein +FIG01130952 FIG01130954: hypothetical protein +FIG01130954 FIG01130955: hypothetical protein +FIG01130960 FIG01130962: hypothetical protein +FIG01130966 FIG01130967: hypothetical protein +FIG01130969 FIG01130970: hypothetical protein +FIG01130976 FIG01130980: hypothetical protein +FIG01130980 FIG01130981: hypothetical protein +FIG01130982 FIG01130985: hypothetical protein +FIG01130985 FIG01130987: hypothetical protein +FIG01130987 FIG01130988: hypothetical protein +FIG01130988 oxidoreductase, Gfo/Idh/MocA family VCA0099 +FIG01130990 FIG01130991: hypothetical protein +FIG01130996 hypothetical protein SCD95A.33c +FIG01131005 putative hydrolase or acyltransferase +FIG01131006 FIG01131007: hypothetical protein +FIG01131007 FIG01131010: hypothetical protein +FIG01131010 putative epoxide hydrolase( EC:3.3.2.- ) +FIG01131011 MoeGT5 +FIG01131013 FIG01134997: hypothetical protein +FIG01131014 FIG01131016: hypothetical protein +FIG01131018 halogenase +FIG01131022 FIG01131023: hypothetical protein +FIG01131023 FIG01131024: hypothetical protein +FIG01131024 FIG01131025: hypothetical protein +FIG01131030 FIG01131031: hypothetical protein +FIG01131036 FIG01131037: hypothetical protein +FIG01131038 ABC peptide transporter, membrane subunit +FIG01131044 FIG01131046: hypothetical protein +FIG01131047 FIG01131048: hypothetical protein +FIG01131048 FIG01131051: hypothetical protein +FIG01131055 FIG01131056: hypothetical protein +FIG01131056 FIG01131059: hypothetical protein +FIG01131064 FIG01131067: hypothetical protein +FIG01131067 FIG01131068: hypothetical protein +FIG01131070 ABC-type cobalamin/Fe3+-siderophores transport system, ATPase components +FIG01131072 FIG01131074: hypothetical protein +FIG01131076 FIG01131077: hypothetical protein +FIG01131085 FIG01131086: hypothetical protein +FIG01131086 FIG01131088: hypothetical protein +FIG01131091 FIG01131093: hypothetical protein +FIG01131096 FIG01131100: hypothetical protein +FIG01131100 FIG01131101: hypothetical protein +FIG01131101 putative peroxiredoxin +FIG01131108 FIG01131110: hypothetical protein +FIG01131112 FIG01131113: hypothetical protein +FIG01131113 FIG01131118: hypothetical protein +FIG01131118 FIG01131119: hypothetical protein +FIG01131122 binding-protein-dependent transport protein +FIG01131123 FIG01131125: hypothetical protein +FIG01131125 FIG01131126: hypothetical protein +FIG01131127 FIG01131128: hypothetical protein +FIG01131128 FIG01131129: hypothetical protein +FIG01131130 FIG01131132: hypothetical protein +FIG01131139 FIG01131140: hypothetical protein +FIG01131140 FIG01131141: hypothetical protein +FIG01131143 FIG01131147: hypothetical protein +FIG01131147 FIG01131150: hypothetical protein +FIG01131154 FIG01131155: hypothetical protein +FIG01131158 FIG01131159: hypothetical protein +FIG01131178 FIG01131181: hypothetical protein +FIG01131181 FIG01131183: hypothetical protein +FIG01131188 FIG01131189: hypothetical protein +FIG01131189 FIG01131196: hypothetical protein +FIG01131196 FIG01131199: hypothetical protein +FIG01131202 FIG01131204: hypothetical protein +FIG01131204 FIG01131205: hypothetical protein +FIG01131206 FIG01131207: hypothetical protein +FIG01131209 FIG01131213: hypothetical protein +FIG01131216 FIG01131217: hypothetical protein +FIG01131219 FIG01131221: hypothetical protein +FIG01131221 FIG01131222: hypothetical protein +FIG01131222 FIG01131224: hypothetical protein +FIG01131229 FIG01131232: hypothetical protein +FIG01131232 Peptidoglycan-recognition protein-LE +FIG01131233 FIG01131234: hypothetical protein +FIG01131234 hypothetical protein SCD78.02 +FIG01131240 FIG01131241: hypothetical protein +FIG01131242 FIG01131244: hypothetical protein +FIG01131245 FIG01237110: hypothetical protein +FIG01131250 FIG00814508: hypothetical protein +FIG01131252 FIG01131254: hypothetical protein +FIG01131257 FIG01131260: hypothetical protein +FIG01131261 FIG01131266: hypothetical protein +FIG01131271 FIG01131274: hypothetical protein +FIG01131274 putative DNA-binding response regulator +FIG01131275 FIG01131276: hypothetical protein +FIG01131277 FIG01131280: hypothetical protein +FIG01131282 FIG01131283: hypothetical protein +FIG01131288 FIG01131291: hypothetical protein +FIG01131292 Terpene cyclase( EC:4.2.3.7 ) +FIG01131296 FIG01131299: hypothetical protein +FIG01131301 FIG01131304: hypothetical protein +FIG01131304 FIG01131305: hypothetical protein +FIG01131312 FIG01131313: hypothetical protein +FIG01131324 FIG01131325: hypothetical protein +FIG01131327 FIG01131329: hypothetical protein +FIG01131337 FIG01131340: hypothetical protein +FIG01131340 FIG01131341: hypothetical protein +FIG01131341 FIG01131342: hypothetical protein +FIG01131342 FIG01131343: hypothetical protein +FIG01131344 FIG01131345: hypothetical protein +FIG01131348 FIG01131349: hypothetical protein +FIG01131349 FIG01131351: hypothetical protein +FIG01131354 FIG01131357: hypothetical protein +FIG01131357 FIG01131359: hypothetical protein +FIG01131359 FIG01131360: hypothetical protein +FIG01131364 FIG01131365: hypothetical protein +FIG01131366 FIG01131368: hypothetical protein +FIG01131378 FIG01131380: hypothetical protein +FIG01131380 FIG01131381: hypothetical protein +FIG01131381 FIG01131383: hypothetical protein +FIG01131383 FIG01131384: hypothetical protein +FIG01131387 FIG01131388: hypothetical protein +FIG01131390 FIG01131392: hypothetical protein +FIG01131392 FIG01131393: hypothetical protein +FIG01131397 FIG01131400: hypothetical protein +FIG01131400 FIG01131401: hypothetical protein +FIG01131404 FIG01131405: hypothetical protein +FIG01131405 FIG01131406: hypothetical protein +FIG01131409 FIG01131411: hypothetical protein +FIG01131411 FIG01131412: hypothetical protein +FIG01131413 FIG01131414: hypothetical protein +FIG01131414 Sai20 +FIG01131415 FIG01131416: hypothetical protein +FIG01131418 FIG01131419: hypothetical protein +FIG01131427 FIG01131428: hypothetical protein +FIG01131434 Sugar phosphate isomerases/epimerase +FIG01131435 FIG01131437: hypothetical protein +FIG01131440 FIG01131441: hypothetical protein +FIG01131442 FIG01131446: hypothetical protein +FIG01131450 FIG01131451: hypothetical protein +FIG01131455 FIG01131457: hypothetical protein +FIG01131459 FIG01131461: hypothetical protein +FIG01131461 hypothetical protein SCE6.07. +FIG01131462 FIG01131463: hypothetical protein +FIG01131464 FIG01131466: hypothetical protein +FIG01131472 FIG01131473: hypothetical protein +FIG01131473 FIG01131474: hypothetical protein +FIG01131474 SCP1.20c, unknown, len: 260aa +FIG01131475 FIG01131476: hypothetical protein +FIG01131478 FIG01131481: hypothetical protein +FIG01131481 FIG01131484: hypothetical protein +FIG01131491 FIG01131493: hypothetical protein +FIG01131504 Zinc-containing dehydrogenase +FIG01131507 FIG01131508: hypothetical protein +FIG01131511 FIG01131514: hypothetical protein +FIG01131519 FIG01131521: hypothetical protein +FIG01131530 FIG01131531: hypothetical protein +FIG01131531 FIG01131533: hypothetical protein +FIG01131533 FIG01131534: hypothetical protein +FIG01131534 FIG01131535: hypothetical protein +FIG01131536 FIG01131538: hypothetical protein +FIG01131538 deoR-family transcriptional regulator +FIG01131539 FIG01131540: hypothetical protein +FIG01131540 FIG01131541: hypothetical protein +FIG01131542 FIG01131545: hypothetical protein +FIG01131545 FIG01131548: hypothetical protein +FIG01131548 FIG01131549: hypothetical protein +FIG01131549 FIG01131550: hypothetical protein +FIG01131550 FIG01131551: hypothetical protein +FIG01131553 FIG01131555: hypothetical protein +FIG01131555 FIG01131557: hypothetical protein +FIG01131558 TOMM biosynthesis dehydrogenase (protein B) +FIG01131568 FIG01131569: hypothetical protein +FIG01131571 FIG01131573: hypothetical protein +FIG01131579 FIG01131580: hypothetical protein +FIG01131583 FIG01131584: hypothetical protein +FIG01131587 FIG01131591: hypothetical protein +FIG01131603 FIG01131606: hypothetical protein +FIG01131609 FIG01131610: hypothetical protein +FIG01131613 FIG01131615: hypothetical protein +FIG01131619 putative O-methyltransferase. +FIG01131629 FIG01131630: hypothetical protein +FIG01131634 FIG01131637: hypothetical protein +FIG01131637 secreted acetylxylan esterase +FIG01131638 FIG01131640: hypothetical protein +FIG01131641 FIG01131642: hypothetical protein +FIG01131642 FIG01131643: hypothetical protein +FIG01131644 FIG01131645: hypothetical protein +FIG01131649 FIG01131650: hypothetical protein +FIG01131652 FIG01131660: hypothetical protein +FIG01131660 FIG01131661: hypothetical protein +FIG01131661 FIG01131666: hypothetical protein +FIG01131672 putative ABC-transporter ATP-binding protein +FIG01131679 FIG01131680: hypothetical protein +FIG01131687 FIG01131692: hypothetical protein +FIG01131694 A-factor receptor homolog +FIG01131699 FIG01131701: hypothetical protein +FIG01131701 ABC sugar transporter +FIG01131709 putative D-aminoacylase +FIG01131716 FIG01131717: hypothetical protein +FIG01131718 FIG01131719: hypothetical protein +FIG01131720 FIG01131721: hypothetical protein +FIG01131721 peptidoglycan-binding protein +FIG01131725 FIG01131726: hypothetical protein +FIG01131728 FIG01131729: hypothetical protein +FIG01131730 FIG01131731: hypothetical protein +FIG01131733 COG1216: Predicted glycosyltransferases +FIG01131734 FIG01131735: hypothetical protein +FIG01131736 FIG01131738: hypothetical protein +FIG01131738 FIG01131739: hypothetical protein +FIG01131739 FIG01131740: hypothetical protein +FIG01131740 FIG01131741: hypothetical protein +FIG01131741 FIG01131745: hypothetical protein +FIG01131745 FIG01131749: hypothetical protein +FIG01131749 FIG01131751: hypothetical protein +FIG01131752 FIG01131753: hypothetical protein +FIG01131753 FIG01131754: hypothetical protein +FIG01131754 FIG01131755: hypothetical protein +FIG01131755 flavin-containing monooxygenase (putative secreted protein) +FIG01131758 Gene 4 protein (Gp4) +FIG01131760 FIG01131761: hypothetical protein +FIG01131768 FIG01131769: hypothetical protein +FIG01131769 FIG01131770: hypothetical protein +FIG01131771 FIG01131772: hypothetical protein +FIG01131789 FIG01131791: hypothetical protein +FIG01131791 FIG01131792: hypothetical protein +FIG01131795 phosphotransferase +FIG01131801 FIG01131806: hypothetical protein +FIG01131806 FIG01131810: hypothetical protein +FIG01131812 FIG01131814: hypothetical protein +FIG01131816 FIG01131818: hypothetical protein +FIG01131821 FIG01131823: hypothetical protein +FIG01131829 FIG01131830: hypothetical protein +FIG01131832 FIG01131833: hypothetical protein +FIG01131833 FIG01131835: hypothetical protein +FIG01131842 FIG01131843: hypothetical protein +FIG01131843 FIG01131845: hypothetical protein +FIG01131849 FIG01131850: hypothetical protein +FIG01131850 FIG01131851: hypothetical protein +FIG01131852 FIG01131853: hypothetical protein +FIG01131854 FIG01131856: hypothetical protein +FIG01131856 FIG01131857: hypothetical protein +FIG01131862 FIG01131863: hypothetical protein +FIG01131871 FIG01131872: hypothetical protein +FIG01131872 FIG01131873: hypothetical protein +FIG01131884 FIG01131885: hypothetical protein +FIG01131885 FIG01131887: hypothetical protein +FIG01131889 FIG01131890: hypothetical protein +FIG01131892 FIG01131893: hypothetical protein +FIG01131896 FIG01131898: hypothetical protein +FIG01131899 FIG01131901: hypothetical protein +FIG01131901 FIG01131902: hypothetical protein +FIG01131902 FIG01131904: hypothetical protein +FIG01131904 FIG01131905: hypothetical protein +FIG01131905 FIG01131906: hypothetical protein +FIG01131914 FIG01131915: hypothetical protein +FIG01131916 FIG01131917: hypothetical protein +FIG01131917 putative small hydrophilic protein +FIG01131919 FIG01131920: hypothetical protein +FIG01131925 putative peptide transport system substrate-binding protein +FIG01131928 FIG01131929: hypothetical protein +FIG01131933 FIG01131935: hypothetical protein +FIG01131944 FIG01131946: hypothetical protein +FIG01131960 FIG01131961: hypothetical protein +FIG01131962 FIG01131965: hypothetical protein +FIG01131971 FIG01131972: hypothetical protein +FIG01131972 FIG01131973: hypothetical protein +FIG01131973 putative secreted beta-galactosidase +FIG01131974 FIG01131977: hypothetical protein +FIG01131977 FIG01131978: hypothetical protein +FIG01131978 Putative magnesium or manganese-dependent protein phosphatase +FIG01131990 FIG01131991: hypothetical protein +FIG01131999 Rhodanese-related sulfurtransferase +FIG01132004 FIG01132005: hypothetical protein +FIG01132009 FIG01132011: hypothetical protein +FIG01132012 FIG01132014: hypothetical protein +FIG01132023 FIG01132024: hypothetical protein +FIG01132025 FIG01132026: hypothetical protein +FIG01132026 FIG01132028: hypothetical protein +FIG01132028 FIG01132031: hypothetical protein +FIG01132039 FIG01132043: hypothetical protein +FIG01132043 putative dehydratase +FIG01132044 FIG01132045: hypothetical protein +FIG01132046 FIG01132050: hypothetical protein +FIG01132053 FIG01132054: hypothetical protein +FIG01132054 FIG01132056: hypothetical protein +FIG01132056 OSJNBa0016I09.9 protein +FIG01132057 FIG01132059: hypothetical protein +FIG01132062 MutT/NUDIX-family protein +FIG01132067 FIG01132068: hypothetical protein +FIG01132072 FIG01132073: hypothetical protein +FIG01132073 FIG01132075: hypothetical protein +FIG01132075 FIG01132076: hypothetical protein +FIG01132096 FIG01132097: hypothetical protein +FIG01132098 predicted cell surface protein/ lipoprotein +FIG01132099 Methyltransferase SCO0408 +FIG01132100 FIG01132105: hypothetical protein +FIG01132105 FIG01132107: hypothetical protein +FIG01132107 FIG01132109: hypothetical protein +FIG01132122 FIG01132123: hypothetical protein +FIG01132123 FIG01132125: hypothetical protein +FIG01132125 FIG01132126: hypothetical protein +FIG01132126 FIG01132127: hypothetical protein +FIG01132127 FIG01132128: hypothetical protein +FIG01132128 FIG01132129: hypothetical protein +FIG01132132 Pas46 +FIG01132142 FIG01132143: hypothetical protein +FIG01132145 FIG01132147: hypothetical protein +FIG01132155 FIG01132159: hypothetical protein +FIG01132163 FIG01132164: hypothetical protein +FIG01132167 pRL2-7 +FIG01132169 FIG01132172: hypothetical protein +FIG01132172 FIG01132175: hypothetical protein +FIG01132175 FIG01132176: hypothetical protein +FIG01132180 FIG01132183: hypothetical protein +FIG01132196 FIG01132199: hypothetical protein +FIG01132202 FIG01132203: hypothetical protein +FIG01132212 FIG01132213: hypothetical protein +FIG01132216 FIG01132217: hypothetical protein +FIG01132217 FIG01132219: hypothetical protein +FIG01132224 FIG01132225: hypothetical protein +FIG01132228 FIG01132229: hypothetical protein +FIG01132230 FIG01132231: hypothetical protein +FIG01132233 FIG01132239: hypothetical protein +FIG01132239 FIG01132246: hypothetical protein +FIG01132246 FIG01132249: hypothetical protein +FIG01132249 FIG01132250: hypothetical protein +FIG01132251 FIG01132253: hypothetical protein +FIG01132253 FIG01132254: hypothetical protein +FIG01132262 FIG01132266: hypothetical protein +FIG01132266 FIG01132267: hypothetical protein +FIG01132268 FIG01132271: hypothetical protein +FIG01132276 FIG01132279: hypothetical protein +FIG01132279 FIG01132282: hypothetical protein +FIG01132282 FIG01132283: hypothetical protein +FIG01132287 FIG01132288: hypothetical protein +FIG01132292 FIG01132295: hypothetical protein +FIG01132295 FIG01132296: hypothetical protein +FIG01132296 probable response regulator, two-component system +FIG01132298 FIG01132299: hypothetical protein +FIG01132299 MarR-family regulatory protein +FIG01132300 FIG01132303: hypothetical protein +FIG01132310 FIG01132311: hypothetical protein +FIG01132311 FIG01132312: hypothetical protein +FIG01132319 FIG01132321: hypothetical protein +FIG01132322 FIG01132323: hypothetical protein +FIG01132328 FIG01132330: hypothetical protein +FIG01132342 FIG01132343: hypothetical protein +FIG01132343 FIG01132349: hypothetical protein +FIG01132349 FIG01132351: hypothetical protein +FIG01132355 FIG01132356: hypothetical protein +FIG01132360 putative integral membrane efflux protein +FIG01132362 FIG01132363: hypothetical protein +FIG01132363 FIG01132369: hypothetical protein +FIG01132369 FIG01132371: hypothetical protein +FIG01132371 FIG01132373: hypothetical protein +FIG01132374 FIG01132375: hypothetical protein +FIG01132376 FIG01132378: hypothetical protein +FIG01132378 FIG01132379: hypothetical protein +FIG01132389 FIG01132391: hypothetical protein +FIG01132395 FIG01132397: hypothetical protein +FIG01132398 Transcriptional regulator, ROK family +FIG01132403 FIG01132405: hypothetical protein +FIG01132405 FIG01132406: hypothetical protein +FIG01132408 aminoglycoside 6'-N-acetyltransferase +FIG01132411 FIG01132413: hypothetical protein +FIG01132413 FIG01132417: hypothetical protein +FIG01132430 FIG01132431: hypothetical protein +FIG01132432 FIG01132433: hypothetical protein +FIG01132436 FIG01132439: hypothetical protein +FIG01132440 FIG01132442: hypothetical protein +FIG01132442 FIG01132444: hypothetical protein +FIG01132449 FIG01132451: hypothetical protein +FIG01132452 FIG01132454: hypothetical protein +FIG01132477 FIG01132478: hypothetical protein +FIG01132478 FIG01132482: hypothetical protein +FIG01132482 FIG01132483: hypothetical protein +FIG01132486 FIG01132488: hypothetical protein +FIG01132488 FIG01132489: hypothetical protein +FIG01132491 FIG01132492: hypothetical protein +FIG01132492 FIG01132494: hypothetical protein +FIG01132503 FIG01132504: hypothetical protein +FIG01132514 FIG01132516: hypothetical protein +FIG01132518 FIG01132519: hypothetical protein +FIG01132526 FIG01132527: hypothetical protein +FIG01132527 FIG01132528: hypothetical protein +FIG01132532 FIG01132534: hypothetical protein +FIG01132537 FIG01132538: hypothetical protein +FIG01132547 FIG01132548: hypothetical protein +FIG01132548 FIG01132550: hypothetical protein +FIG01132550 FIG01132551: hypothetical protein +FIG01132551 FIG01122132: hypothetical protein +FIG01132553 FIG01132555: hypothetical protein +FIG01132555 FIG01132558: hypothetical protein +FIG01132558 FIG01132559: hypothetical protein +FIG01132559 FIG01132561: hypothetical protein +FIG01132561 FIG01132568: hypothetical protein +FIG01132573 FIG01132574: hypothetical protein +FIG01132576 NADPH:quinone oxidoreductase +FIG01132580 hypothetical protein SCF34.19c +FIG01132590 FIG01132591: hypothetical protein +FIG01132593 FIG01132597: hypothetical protein +FIG01132601 sigma-like protein +FIG01132605 FIG01132607: hypothetical protein +FIG01132608 FIG01132609: hypothetical protein +FIG01132616 FIG01132617: hypothetical protein +FIG01132617 FIG01132622: hypothetical protein +FIG01132623 FIG01132624: hypothetical protein +FIG01132626 FIG01132634: hypothetical protein +FIG01132637 FIG01132638: hypothetical protein +FIG01132638 sporulation-related protein +FIG01132647 FIG01132648: hypothetical protein +FIG01132648 FIG01132649: hypothetical protein +FIG01132653 sugar transport sugar binding protein +FIG01132659 FIG01132664: hypothetical protein +FIG01132664 FIG01132666: hypothetical protein +FIG01132669 putative ABC transport system ATP-binding protein +FIG01132672 FIG01132673: hypothetical protein +FIG01132673 FIG01132675: hypothetical protein +FIG01132675 FIG01132676: hypothetical protein +FIG01132683 FIG01132684: hypothetical protein +FIG01132684 FIG01132685: hypothetical protein +FIG01132685 FIG01132686: hypothetical protein +FIG01132686 FIG01132688: hypothetical protein +FIG01132690 FIG01132694: hypothetical protein +FIG01132696 FIG01132699: hypothetical protein +FIG01132709 FIG01132710: hypothetical protein +FIG01132711 FIG01132712: hypothetical protein +FIG01132713 FIG01132715: hypothetical protein +FIG01132722 addiction module toxin, RelE/StbE +FIG01132725 FIG01132726: hypothetical protein +FIG01132733 FIG01132736: hypothetical protein +FIG01132736 FIG01132737: hypothetical protein +FIG01132737 FIG01132738: hypothetical protein +FIG01132738 FIG01132739: hypothetical protein +FIG01132742 FIG01132744: hypothetical protein +FIG01132755 FIG01132758: hypothetical protein +FIG01132761 FIG01132762: hypothetical protein +FIG01132764 FIG01132765: hypothetical protein +FIG01132765 coagulation factor 5/8 type-like +FIG01132771 FIG01132772: hypothetical protein +FIG01132778 FIG01132779: hypothetical protein +FIG01132780 FIG01132783: hypothetical protein +FIG01132785 FIG01132787: hypothetical protein +FIG01132791 FIG01132792: hypothetical protein +FIG01132794 FIG01132795: hypothetical protein +FIG01132795 FIG01132796: hypothetical protein +FIG01132796 FIG01132798: hypothetical protein +FIG01132799 FIG01132800: hypothetical protein +FIG01132800 FIG01132801: hypothetical protein +FIG01132801 FIG01132804: hypothetical protein +FIG01132807 FIG01132810: hypothetical protein +FIG01132816 FIG01132818: hypothetical protein +FIG01132820 FIG01132824: hypothetical protein +FIG01132827 FIG01132832: hypothetical protein +FIG01132834 FIG01132836: hypothetical protein +FIG01132836 FIG01132837: hypothetical protein +FIG01132844 FIG01132845: hypothetical protein +FIG01132849 FIG01132851: hypothetical protein +FIG01132859 multi-drug efflux transporter +FIG01132865 FIG01132866: hypothetical protein +FIG01132866 FIG01132867: hypothetical protein +FIG01132879 FIG01132880: hypothetical protein +FIG01132883 FIG01132884: hypothetical protein +FIG01132884 FIG01132885: hypothetical protein +FIG01132885 hypothetical protein SC7F9.40 +FIG01132887 FIG01132888: hypothetical protein +FIG01132888 FIG01132889: hypothetical protein +FIG01132889 FIG01132890: hypothetical protein +FIG01132893 FIG01132895: hypothetical protein +FIG01132897 FIG01132898: hypothetical protein +FIG01132903 FIG01132904: hypothetical protein +FIG01132904 FIG01132905: hypothetical protein +FIG01132905 FIG01132908: hypothetical protein +FIG01132908 FIG01132910: hypothetical protein +FIG01132910 FIG01132911: hypothetical protein +FIG01132914 FIG01132918: hypothetical protein +FIG01132928 FIG01132929: hypothetical protein +FIG01132935 FIG01132936: hypothetical protein +FIG01132936 FIG01132937: hypothetical protein +FIG01132937 merR-family transcriptional regulator +FIG01132938 FIG01132939: hypothetical protein +FIG01132951 FIG01132952: hypothetical protein +FIG01132961 FIG01132963: hypothetical protein +FIG01132964 FIG01132967: hypothetical protein +FIG01132978 FIG01132979: hypothetical protein +FIG01132979 hydroxylacyl-CoA dehydrogenase +FIG01132985 Bona fide RidA/YjgF/TdcF/RutC subgroup +FIG01132988 FIG01132989: hypothetical protein +FIG01132993 FIG01132995: hypothetical protein +FIG01133018 FIG01133019: hypothetical protein +FIG01133027 FIG01133031: hypothetical protein +FIG01133031 FIG01133035: hypothetical protein +FIG01133035 FIG01133036: hypothetical protein +FIG01133036 FIG01133038: hypothetical protein +FIG01133039 FIG01133040: hypothetical protein +FIG01133041 FIG01133044: hypothetical protein +FIG01133058 FIG01134137: hypothetical protein +FIG01133059 FIG01133060: hypothetical protein +FIG01133063 FIG01133064: hypothetical protein +FIG01133064 FIG01133066: hypothetical protein +FIG01133067 FIG01133068: hypothetical protein +FIG01133069 FIG01133070: hypothetical protein +FIG01133070 FIG01133071: hypothetical protein +FIG01133071 FIG01133072: hypothetical protein +FIG01133073 FIG01133079: hypothetical protein +FIG01133093 FIG01133094: hypothetical protein +FIG01133094 FIG01133097: hypothetical protein +FIG01133108 FIG01133110: hypothetical protein +FIG01133111 FIG01133117: hypothetical protein +FIG01133117 FIG01133118: hypothetical protein +FIG01133118 FIG01133119: hypothetical protein +FIG01133119 FIG01133120: hypothetical protein +FIG01133120 putative SyrP-like protein +FIG01133126 FIG01133129: hypothetical protein +FIG01133129 FIG01133131: hypothetical protein +FIG01133135 FIG01133136: hypothetical protein +FIG01133136 FIG01133144: hypothetical protein +FIG01133150 FIG01133151: hypothetical protein +FIG01133164 FIG01133165: hypothetical protein +FIG01133165 FIG01133166: hypothetical protein +FIG01133166 FIG01133168: hypothetical protein +FIG01133168 FIG01133170: hypothetical protein +FIG01133171 FIG01133173: hypothetical protein +FIG01133173 FIG01133174: hypothetical protein +FIG01133175 FIG01133178: hypothetical protein +FIG01133187 FIG01133188: hypothetical protein +FIG01133188 FIG01133189: hypothetical protein +FIG01133197 FIG01133199: hypothetical protein +FIG01133199 FIG01133200: hypothetical protein +FIG01133200 FIG01133201: hypothetical protein +FIG01133201 FIG01133202: hypothetical protein +FIG01133209 FIG01133211: hypothetical protein +FIG01133211 FIG01133212: hypothetical protein +FIG01133212 phage major tail protein +FIG01133218 FIG01133219: hypothetical protein +FIG01133219 conserved hypothetical protein; putative ATPase +FIG01133224 FIG01133225: hypothetical protein +FIG01133225 FIG01133226: hypothetical protein +FIG01133231 FIG01133232: hypothetical protein +FIG01133233 hypothetical protein SC7F9.09c +FIG01133236 Lanthionine biosynthesis protein LanL +FIG01133240 Aclacinomycin oxidoreductase +FIG01133249 FIG01133251: hypothetical protein +FIG01133251 FIG01133252: hypothetical protein +FIG01133254 FIG01133257: hypothetical protein +FIG01133257 FIG01133258: hypothetical protein +FIG01133259 FIG01133260: hypothetical protein +FIG01133260 FIG01133261: hypothetical protein +FIG01133262 FIG01133263: hypothetical protein +FIG01133278 FIG01133282: hypothetical protein +FIG01133282 FIG01133284: hypothetical protein +FIG01133286 FIG01133287: hypothetical protein +FIG01133287 FIG01133288: hypothetical protein +FIG01133288 FIG01133289: hypothetical protein +FIG01133292 FIG01133294: hypothetical protein +FIG01133302 putative chitosanase +FIG01133303 2-hydroxyhepta-2,4-diene-1,7-dioate isomerase (EC 5.3.3.-) / 5-carboxymethyl-2-oxo-hex-3- ene-1,7-dioate decarboxylase (EC 4.1.1.68), HPAG2 subunit +FIG01133304 putative transcriptional regulator of the MarR family +FIG01133306 FIG01133307: hypothetical protein +FIG01133307 FIG01133311: hypothetical protein +FIG01133311 Aminoglycoside 3'-phosphotransferase (EC 2.7.1.95) @ Streptomycin 3'-kinase StrA (EC 2.7.1.87) +FIG01133315 FIG01133316: hypothetical protein +FIG01133322 ATP/GTP-binding membrane protein +FIG01133323 FIG01133324: hypothetical protein +FIG01133324 FIG01133326: hypothetical protein +FIG01133326 FIG01133329: hypothetical protein +FIG01133331 FIG01133332: hypothetical protein +FIG01133332 hypothetical protein SC1B2.20 +FIG01133334 sugar-binding integral membrane transport protein +FIG01133336 FIG01133338: hypothetical protein +FIG01133350 FIG01133352: hypothetical protein +FIG01133357 FIG01133358: hypothetical protein +FIG01133358 deoR family transcriptional regulator +FIG01133359 FIG01133361: hypothetical protein +FIG01133363 FIG01133366: hypothetical protein +FIG01133368 FIG01133369: hypothetical protein +FIG01133369 FIG01133373: hypothetical protein +FIG01133373 FIG01133374: hypothetical protein +FIG01133386 FIG01133388: hypothetical protein +FIG01133389 FIG01133390: hypothetical protein +FIG01133390 FIG01133392: hypothetical protein +FIG01133394 FIG01133396: hypothetical protein +FIG01133402 UnbL +FIG01133403 FIG01133405: hypothetical protein +FIG01133405 FIG01133408: hypothetical protein +FIG01133411 FIG01133413: hypothetical protein +FIG01133413 FIG01133416: hypothetical protein +FIG01133420 FIG01133424: hypothetical protein +FIG01133441 phosphotriesterase +FIG01133450 FIG01133451: hypothetical protein +FIG01133451 FIG01133452: hypothetical protein +FIG01133455 FIG01133457: hypothetical protein +FIG01133459 FIG01133460: hypothetical protein +FIG01133463 FIG01133465: hypothetical protein +FIG01133469 actinorhodin cluster activator protein +FIG01133470 FIG01133471: hypothetical protein +FIG01133471 FIG01133473: hypothetical protein +FIG01133473 FIG01133476: hypothetical protein +FIG01133479 FIG01133484: hypothetical protein +FIG01133489 FIG01133490: hypothetical protein +FIG01133490 FIG01133492: hypothetical protein +FIG01133505 FIG01133511: hypothetical protein +FIG01133513 FIG01133514: hypothetical protein +FIG01133520 FIG01133525: hypothetical protein +FIG01133525 FIG01133526: hypothetical protein +FIG01133526 FIG01133527: hypothetical protein +FIG01133529 FIG01133533: hypothetical protein +FIG01133538 FIG01133539: hypothetical protein +FIG01133548 FIG01133554: hypothetical protein +FIG01133554 FIG01133556: hypothetical protein +FIG01133557 FIG01133559: hypothetical protein +FIG01133559 FIG01133562: hypothetical protein +FIG01133562 FIG01133563: hypothetical protein +FIG01133572 aminotransferase, class I and II +FIG01133578 FIG01133584: hypothetical protein +FIG01133586 Amidase family protein MSMEG_4492 +FIG01133590 FIG01133592: hypothetical protein +FIG01133594 FIG01133598: hypothetical protein +FIG01133602 FIG01133605: hypothetical protein +FIG01133608 FIG01133610: hypothetical protein +FIG01133610 FIG01133611: hypothetical protein +FIG01133611 FIG01133612: hypothetical protein +FIG01133615 FIG01133621: hypothetical protein +FIG01133621 FIG01133622: hypothetical protein +FIG01133630 FIG01133632: hypothetical protein +FIG01133637 FIG01133638: hypothetical protein +FIG01133645 FIG01133646: hypothetical protein +FIG01133654 FIG01133659: hypothetical protein +FIG01133659 FIG01133660: hypothetical protein +FIG01133684 FIG01133689: hypothetical protein +FIG01133689 FIG01133691: hypothetical protein +FIG01133691 FIG01133694: hypothetical protein +FIG01133696 FIG01133698: hypothetical protein +FIG01133707 putative aryl-alcohol dehydrogenase +FIG01133710 FIG01133713: hypothetical protein +FIG01133713 FIG01133714: hypothetical protein +FIG01133714 FIG01133715: hypothetical protein +FIG01133715 FIG01133718: hypothetical protein +FIG01133720 FIG01133725: hypothetical protein +FIG01133727 FIG01133730: hypothetical protein +FIG01133730 secreted chitinase +FIG01133731 FIG01133732: hypothetical protein +FIG01133735 FIG01133738: hypothetical protein +FIG01133739 FIG01133744: hypothetical protein +FIG01133747 FIG00820092: hypothetical protein +FIG01133751 FIG01133752: hypothetical protein +FIG01133752 FIG01133753: hypothetical protein +FIG01133758 FIG01133759: hypothetical protein +FIG01133770 FIG01133772: hypothetical protein +FIG01133777 FIG01133782: hypothetical protein +FIG01133785 FIG01133787: hypothetical protein +FIG01133788 FIG01133789: hypothetical protein +FIG01133789 FIG01133791: hypothetical protein +FIG01133796 FIG01133800: hypothetical protein +FIG01133811 FIG01133815: hypothetical protein +FIG01133822 FIG01133823: hypothetical protein +FIG01133827 FIG01133829: hypothetical protein +FIG01133833 FIG01133834: hypothetical protein +FIG01133837 FIG01133838: hypothetical protein +FIG01133840 Ribosomal-protein-serine acetyltransferase( EC:2.3.1.- ) +FIG01133841 FIG01133846: hypothetical protein +FIG01133850 FIG01133852: hypothetical protein +FIG01133857 FIG01133858: hypothetical protein +FIG01133866 FIG01133868: hypothetical protein +FIG01133879 FIG01133881: hypothetical protein +FIG01133881 FIG01133883: hypothetical protein +FIG01133891 FIG01133893: hypothetical protein +FIG01133919 FIG01133923: hypothetical protein +FIG01133927 FIG01133928: hypothetical protein +FIG01133933 FIG01133935: hypothetical protein +FIG01133935 FIG01133936: hypothetical protein +FIG01133936 FIG01133939: hypothetical protein +FIG01133965 FIG01133966: hypothetical protein +FIG01133966 FIG01133970: hypothetical protein +FIG01133970 FIG01133971: hypothetical protein +FIG01133972 FIG01133973: hypothetical protein +FIG01133973 bifunctional protein (secreted sugar binding protein/sugar hydrolase) +FIG01133976 FIG01133977: hypothetical protein +FIG01133977 FIG01133983: hypothetical protein +FIG01133983 tetR family transcriptional regulator +FIG01133985 FIG01133987: hypothetical protein +FIG01133992 FIG01133993: hypothetical protein +FIG01133993 FIG01133994: hypothetical protein +FIG01133994 FIG01133995: hypothetical protein +FIG01133997 FIG01133999: hypothetical protein +FIG01134003 FIG01134004: hypothetical protein +FIG01134012 secreted beta-lactamase +FIG01134013 FIG01134015: hypothetical protein +FIG01134015 Endo-beta-N-acetylglucosaminidase +FIG01134017 FIG01134019: hypothetical protein +FIG01134037 FIG01134038: hypothetical protein +FIG01134041 FIG01134043: hypothetical protein +FIG01134052 FIG01134053: hypothetical protein +FIG01134053 FIG01134054: hypothetical protein +FIG01134077 FIG01134078: hypothetical protein +FIG01134080 containing Cupin doamin and 100% same as SAV878 +FIG01134093 FIG01134094: hypothetical protein +FIG01134098 FIG01134100: hypothetical protein +FIG01134100 FIG01134101: hypothetical protein +FIG01134101 FIG01134104: hypothetical protein +FIG01134105 FIG01134109: hypothetical protein +FIG01134115 FIG01134116: hypothetical protein +FIG01134127 FIG01134128: hypothetical protein +FIG01134128 FIG01134129: hypothetical protein +FIG01134129 FIG01134131: hypothetical protein +FIG01134131 FIG01134134: hypothetical protein +FIG01134140 FIG01134143: hypothetical protein +FIG01134143 FIG01134144: hypothetical protein +FIG01134144 transport integral membrane protein +FIG01134145 FIG01134146: hypothetical protein +FIG01134158 FIG01134159: hypothetical protein +FIG01134165 FIG01134166: hypothetical protein +FIG01134183 glycosyl transferase, family 9 +FIG01134191 TOMM biosynthesis zinc protease +FIG01134194 FIG01134197: hypothetical protein +FIG01134203 putative integral membrane transferase +FIG01134210 FIG01134212: hypothetical protein +FIG01134221 FIG01134224: hypothetical protein +FIG01134224 FIG01134227: hypothetical protein +FIG01134227 FIG01134230: hypothetical protein +FIG01134239 FIG01134240: hypothetical protein +FIG01134249 FIG01134251: hypothetical protein +FIG01134258 FIG01134260: hypothetical protein +FIG01134261 FIG01134262: hypothetical protein +FIG01134267 FIG01134268: hypothetical protein +FIG01134268 FIG01134269: hypothetical protein +FIG01134269 marR-family regulatory protein +FIG01134270 FIG01134271: hypothetical protein +FIG01134271 FIG01134273: hypothetical protein +FIG01134274 FIG01134275: hypothetical protein +FIG01134276 FIG01134277: hypothetical protein +FIG01134282 FIG01134283: hypothetical protein +FIG01134283 FIG01134286: hypothetical protein +FIG01134286 FIG01134288: hypothetical protein +FIG01134294 FIG01134295: hypothetical protein +FIG01134295 FIG01134296: hypothetical protein +FIG01134302 FIG01134303: hypothetical protein +FIG01134320 FIG01134321: hypothetical protein +FIG01134321 Acyl coenzyme A dehydrogenase, BldA, contributes to the proper timing of aerial mycelium formation and antibiotic production +FIG01134324 FIG01134325: hypothetical protein +FIG01134326 FIG01134328: hypothetical protein +FIG01134328 conserved hypothetical protein SCD25.16c +FIG01134330 FIG01134331: hypothetical protein +FIG01134331 FIG01134333: hypothetical protein +FIG01134349 FIG01134350: hypothetical protein +FIG01134352 FIG01134354: hypothetical protein +FIG01134355 FIG01134359: hypothetical protein +FIG01134371 FIG01134373: hypothetical protein +FIG01134380 FIG01134384: hypothetical protein +FIG01134384 FIG01134385: hypothetical protein +FIG01134385 FIG01134386: hypothetical protein +FIG01134393 FIG01134395: hypothetical protein +FIG01134395 FIG01134396: hypothetical protein +FIG01134396 FIG01134398: hypothetical protein +FIG01134400 FIG01134401: hypothetical protein +FIG01134413 FIG01134414: hypothetical protein +FIG01134417 FIG01134420: hypothetical protein +FIG01134423 FIG01134428: hypothetical protein +FIG01134428 putative acid phosphatase( EC:3.1.3.2 ) +FIG01134429 FIG01134431: hypothetical protein +FIG01134438 ABC transport protein membrane component +FIG01134440 FIG01134443: hypothetical protein +FIG01134447 FIG01134448: hypothetical protein +FIG01134456 FIG01134457: hypothetical protein +FIG01134457 FIG01134460: hypothetical protein +FIG01134465 FIG01134466: hypothetical protein +FIG01134473 FIG01134474: hypothetical protein +FIG01134481 FIG01134482: hypothetical protein +FIG01134485 FIG01134488: hypothetical protein +FIG01134488 FIG01134490: hypothetical protein +FIG01134490 FIG01134492: hypothetical protein +FIG01134498 FIG01134499: hypothetical protein +FIG01134500 FIG01134501: hypothetical protein +FIG01134531 FIG01134533: hypothetical protein +FIG01134540 FIG01134541: hypothetical protein +FIG01134541 FIG01134544: hypothetical protein +FIG01134544 FIG01134545: hypothetical protein +FIG01134545 FIG01134549: hypothetical protein +FIG01134552 FIG01134553: hypothetical protein +FIG01134555 FIG01134556: hypothetical protein +FIG01134562 FIG01134564: hypothetical protein +FIG01134564 FIG01134565: hypothetical protein +FIG01134568 FIG01134569: hypothetical protein +FIG01134572 FIG01134575: hypothetical protein +FIG01134582 Chain B, Crystal Structure Of Tem-1 Beta-Lactamase BETA-Lactamase Inhibitor Protein Complex +FIG01134587 FIG01134591: hypothetical protein +FIG01134595 FIG01134596: hypothetical protein +FIG01134596 FIG01134600: hypothetical protein +FIG01134601 FIG01134602: hypothetical protein +FIG01134610 FIG01134613: hypothetical protein +FIG01134615 FIG01134618: hypothetical protein +FIG01134624 FIG01134626: hypothetical protein +FIG01134626 ORF4 +FIG01134628 FIG01134630: hypothetical protein +FIG01134635 ClpX protein +FIG01134636 FIG01134638: hypothetical protein +FIG01134638 FIG01134639: hypothetical protein +FIG01134639 putative metalloproteinase +FIG01134642 FIG01134645: hypothetical protein +FIG01134653 FIG01134654: hypothetical protein +FIG01134654 FIG01134656: hypothetical protein +FIG01134661 FIG01134662: hypothetical protein +FIG01134662 FIG01134664: hypothetical protein +FIG01134664 FIG01134665: hypothetical protein +FIG01134670 FIG01134671: hypothetical protein +FIG01134678 FIG01134679: hypothetical protein +FIG01134679 FIG01134680: hypothetical protein +FIG01134681 FIG01134685: hypothetical protein +FIG01134701 FIG01134706: hypothetical protein +FIG01134707 FIG01134711: hypothetical protein +FIG01134713 FIG01134715: hypothetical protein +FIG01134715 FIG01134716: hypothetical protein +FIG01134717 FIG01134723: hypothetical protein +FIG01134738 FIG01134739: hypothetical protein +FIG01134755 FIG01134756: hypothetical protein +FIG01134756 FIG01134762: hypothetical protein +FIG01134763 FIG01134767: hypothetical protein +FIG01134767 FIG01134768: hypothetical protein +FIG01134780 FIG01134782: hypothetical protein +FIG01134782 FIG01134785: hypothetical protein +FIG01134785 FIG01134789: hypothetical protein +FIG01134789 FIG01134790: hypothetical protein +FIG01134790 FIG01134791: hypothetical protein +FIG01134792 FIG01134794: hypothetical protein +FIG01134801 FIG01134802: hypothetical protein +FIG01134804 FIG01134805: hypothetical protein +FIG01134809 FIG01134812: hypothetical protein +FIG01134814 FIG01134815: hypothetical protein +FIG01134844 FIG01134847: hypothetical protein +FIG01134864 FIG01134865: hypothetical protein +FIG01134870 FIG01134873: hypothetical protein +FIG01134881 FIG01134882: hypothetical protein +FIG01134882 FIG01134885: hypothetical protein +FIG01134885 Tyrosinase cofactor precursor +FIG01134887 FIG01134889: hypothetical protein +FIG01134891 FIG01134894: hypothetical protein +FIG01134894 FIG01134895: hypothetical protein +FIG01134895 FIG01134896: hypothetical protein +FIG01134902 DNA polymerase III, beta chain (EC 2.7.7.7) +FIG01134904 FIG01134906: hypothetical protein +FIG01134912 FIG01134913: hypothetical protein +FIG01134924 FIG01134925: hypothetical protein +FIG01134926 FIG01134928: hypothetical protein +FIG01134932 FIG01134934: hypothetical protein +FIG01134943 FIG01134944: hypothetical protein +FIG01134944 FIG01134945: hypothetical protein +FIG01134948 pentalenene synthase( EC:4.2.3.7 ) +FIG01134950 FIG01134953: hypothetical protein +FIG01134959 FIG01134961: hypothetical protein +FIG01134961 multidrug-efflux transporter protein +FIG01134963 extracellular binding protein +FIG01134968 putative transport system membrane protein +FIG01134970 FIG01134977: hypothetical protein +FIG01134977 FIG01134978: hypothetical protein +FIG01134981 FIG01134982: hypothetical protein +FIG01134997 FIG01134998: hypothetical protein +FIG01135003 FIG01135009: hypothetical protein +FIG01135010 FIG01135011: hypothetical protein +FIG01135011 FIG01135013: hypothetical protein +FIG01135018 FIG01135019: hypothetical protein +FIG01135023 FIG01135024: hypothetical protein +FIG01135031 ABC transporter protein BldKB +FIG01135043 FIG01135045: hypothetical protein +FIG01135053 probable 3-oxoacyl-[acyl-carrier-protein] synthase III( EC:2.3.1.41 ) +FIG01135068 FIG01135070: hypothetical protein +FIG01135090 FIG01135094: hypothetical protein +FIG01135098 FIG01135099: hypothetical protein +FIG01135099 ORFp14 +FIG01135108 FIG01135109: hypothetical protein +FIG01135110 FIG01135112: hypothetical protein +FIG01135120 FIG01135123: hypothetical protein +FIG01135124 FIG01135133: hypothetical protein +FIG01135144 FIG01135145: hypothetical protein +FIG01135145 FIG01134514: hypothetical protein +FIG01135151 glycosyltransferase-like protein +FIG01135152 FIG01135155: hypothetical protein +FIG01135158 FIG01135160: hypothetical protein +FIG01135165 FIG01135172: hypothetical protein +FIG01135172 putative binding protein dependent transport protein. +FIG01135180 FIG01135181: hypothetical protein +FIG01135181 FIG01135182: hypothetical protein +FIG01135200 Uncharacterized protein PA2301 +FIG01135201 FIG01135202: hypothetical protein +FIG01135203 FIG01135204: hypothetical protein +FIG01135208 putative binding protein dependent transport protein +FIG01135215 FIG01135220: hypothetical protein +FIG01135229 FIG01135230: hypothetical protein +FIG01135231 FIG01135232: hypothetical protein +FIG01135232 hsp18 transcriptional regulator +FIG01135242 FIG01135244: hypothetical protein +FIG01135275 FIG01135276: hypothetical protein +FIG01135287 FIG01135289: hypothetical protein +FIG01135308 FIG01135310: hypothetical protein +FIG01135311 FIG01135313: hypothetical protein +FIG01135313 FIG01135314: hypothetical protein +FIG01135314 FIG01135317: hypothetical protein +FIG01135329 FIG01135331: hypothetical protein +FIG01135344 Beta-lactamase inhibitory protein precursor (BLIP) +FIG01135357 Pyruvate carboxyltransferase( EC:2.3.3.14 ) +FIG01135359 FIG01135360: hypothetical protein +FIG01135360 COG3793: Tellurite resistance protein +FIG01135366 hypothetical protein, doubtful CDS +FIG01135370 protocatechuate dioxygenase +FIG01135378 FIG01135382: hypothetical protein +FIG01135382 FIG01135383: hypothetical protein +FIG01135385 FIG01135386: hypothetical protein +FIG01135386 FIG01135387: hypothetical protein +FIG01135388 FIG01135391: hypothetical protein +FIG01135392 FIG01135399: hypothetical protein +FIG01135399 FIG01135400: hypothetical protein +FIG01135414 FIG01135415: hypothetical protein +FIG01135423 FIG01135427: hypothetical protein +FIG01135427 putative short-chain oxidoreductase +FIG01135434 FIG01135439: hypothetical protein +FIG01135449 FIG01135450: hypothetical protein +FIG01135470 FIG01135472: hypothetical protein +FIG01135472 FIG01135473: hypothetical protein +FIG01135478 FIG01135480: hypothetical protein +FIG01135480 FIG01135481: hypothetical protein +FIG01135487 FIG01135488: hypothetical protein +FIG01135490 FIG01135492: hypothetical protein +FIG01135495 FIG01135496: hypothetical protein +FIG01135498 FIG01135500: hypothetical protein +FIG01135508 FIG01135510: hypothetical protein +FIG01135510 putative secreted transglycosylase +FIG01135523 FIG01135526: hypothetical protein +FIG01135539 FIG01135540: hypothetical protein +FIG01135543 FIG01135544: hypothetical protein +FIG01135547 FIG01135548: hypothetical protein +FIG01135556 low temperature requirement A +FIG01135560 FIG01135561: hypothetical protein +FIG01135561 FIG01135562: hypothetical protein +FIG01135567 FIG01135568: hypothetical protein +FIG01135569 FIG01135570: hypothetical protein +FIG01135576 FIG01135578: hypothetical protein +FIG01135587 FIG01135588: hypothetical protein +FIG01135589 FIG01135590: hypothetical protein +FIG01135590 FIG01135592: hypothetical protein +FIG01135596 Alcaligin biosynthesis complex, short chain +FIG01135607 FIG01135609: hypothetical protein +FIG01135614 FIG01135615: hypothetical protein +FIG01135627 FIG01135630: hypothetical protein +FIG01135634 FIG01135636: hypothetical protein +FIG01135637 collagen triple helix repeat domain protein +FIG01135647 FIG01135649: hypothetical protein +FIG01135649 FIG01135650: hypothetical protein +FIG01135651 FIG01135652: hypothetical protein +FIG01135658 FIG01135661: hypothetical protein +FIG01135661 FIG01135666: hypothetical protein +FIG01135667 FIG01135669: hypothetical protein +FIG01135669 FIG01135671: hypothetical protein +FIG01135671 putative conjugal transfer protein +FIG01135681 FIG01135684: hypothetical protein +FIG01135692 FIG01135695: hypothetical protein +FIG01135706 FIG01135707: hypothetical protein +FIG01135708 FIG01135710: hypothetical protein +FIG01135722 FIG01135723: hypothetical protein +FIG01135727 FIG01135728: hypothetical protein +FIG01135728 FIG01135729: hypothetical protein +FIG01135735 FIG01135737: hypothetical protein +FIG01135737 FIG01135739: hypothetical protein +FIG01135739 FIG01135744: hypothetical protein +FIG01135744 FIG01135746: hypothetical protein +FIG01135746 FIG01135748: hypothetical protein +FIG01135748 FIG01135751: hypothetical protein +FIG01135764 FIG01135766: hypothetical protein +FIG01135766 FIG01135767: hypothetical protein +FIG01135783 FIG01135785: hypothetical protein +FIG01135785 FIG01135789: hypothetical protein +FIG01135810 FIG01135811: hypothetical protein +FIG01135824 FIG01135825: hypothetical protein +FIG01135831 FIG01135832: hypothetical protein +FIG01135845 FIG01135848: hypothetical protein +FIG01135851 FIG01135852: hypothetical protein +FIG01135854 FIG01135856: hypothetical protein +FIG01135856 FIG01135857: hypothetical protein +FIG01135863 FIG01135865: hypothetical protein +FIG01135865 FIG01135866: hypothetical protein +FIG01135872 FIG01135873: hypothetical protein +FIG01135874 FIG01135875: hypothetical protein +FIG01135877 FIG01135879: hypothetical protein +FIG01135879 FIG01135880: hypothetical protein +FIG01135881 FIG01135886: hypothetical protein +FIG01135886 FIG01135887: hypothetical protein +FIG01135898 conserved hypothetical protein SCF51.04 +FIG01135899 FIG01135900: hypothetical protein +FIG01135907 FIG01135908: hypothetical protein +FIG01135910 FIG01135911: hypothetical protein +FIG01135917 FIG01135918: hypothetical protein +FIG01135919 FIG01135920: hypothetical protein +FIG01135925 FIG01135926: hypothetical protein +FIG01135926 FIG01135929: hypothetical protein +FIG01135932 FIG01135935: hypothetical protein +FIG01135935 Protein PtlC in pentalenolactone biosynthesis +FIG01135937 FIG01135941: hypothetical protein +FIG01135944 putative substrate binding protein +FIG01135947 FIG01135949: hypothetical protein +FIG01135949 FIG01135952: hypothetical protein +FIG01135957 FIG01135959: hypothetical protein +FIG01135962 FIG01135963: hypothetical protein +FIG01135963 FIG01135967: hypothetical protein +FIG01135971 FIG01135974: hypothetical protein +FIG01135978 FIG01135984: hypothetical protein +FIG01135986 FIG01135987: hypothetical protein +FIG01135994 FIG01135995: hypothetical protein +FIG01135999 FIG01136001: hypothetical protein +FIG01136004 FIG01043754: hypothetical protein +FIG01136006 hypothetical protein SC7H9.05 +FIG01136011 FIG01136012: hypothetical protein +FIG01136012 FIG01136013: hypothetical protein +FIG01136016 FIG01136017: hypothetical protein +FIG01136017 FIG01136019: hypothetical protein +FIG01136019 FIG01136020: hypothetical protein +FIG01136024 FIG01136025: hypothetical protein +FIG01136025 FIG01136029: hypothetical protein +FIG01136029 FIG01126000: hypothetical protein +FIG01136030 FIG01136032: hypothetical protein +FIG01136032 FIG01136033: hypothetical protein +FIG01136038 FIG01136039: hypothetical protein +FIG01136043 FIG01136044: hypothetical protein +FIG01136044 FIG01136045: hypothetical protein +FIG01136051 FIG01136059: hypothetical protein +FIG01136066 FIG01136068: hypothetical protein +FIG01136079 FIG01136080: hypothetical protein +FIG01136080 FIG01136081: hypothetical protein +FIG01136081 putative transport system integral membrane protein +FIG01136091 FIG01136093: hypothetical protein +FIG01136100 FIG01136101: hypothetical protein +FIG01136104 FIG01136105: hypothetical protein +FIG01136110 FIG01136111: hypothetical protein +FIG01136111 FIG01136113: hypothetical protein +FIG01136121 FIG01136122: hypothetical protein +FIG01136128 FIG01136131: hypothetical protein +FIG01136138 metallo-beta-lactamase family protein, putative +FIG01136155 FIG01136156: hypothetical protein +FIG01136175 FIG01136177: hypothetical protein +FIG01136177 FIG01136178: hypothetical protein +FIG01136182 FIG01136185: hypothetical protein +FIG01136186 FIG01136187: hypothetical protein +FIG01136192 FIG01136197: hypothetical protein +FIG01136197 FIG01136198: hypothetical protein +FIG01136214 FIG01136215: hypothetical protein +FIG01136220 solute binding transport lipoprotein +FIG01136223 FIG01136225: hypothetical protein +FIG01136225 FIG01136226: hypothetical protein +FIG01136227 putative solute-binding transport protein +FIG01136231 FIG01136232: hypothetical protein +FIG01136256 FIG01136259: hypothetical protein +FIG01136269 FIG01136270: hypothetical protein +FIG01136273 FIG01136275: hypothetical protein +FIG01136284 erythropoiesis-stimulating protein +FIG01136297 FIG01136299: hypothetical protein +FIG01136300 FIG01136303: hypothetical protein +FIG01136305 FIG01136307: hypothetical protein +FIG01136309 FIG01136315: hypothetical protein +FIG01136340 FIG01136343: hypothetical protein +FIG01136353 putative integrin-like protein +FIG01136355 FIG01136357: hypothetical protein +FIG01136361 FIG01136364: hypothetical protein +FIG01136369 FIG01136371: hypothetical protein +FIG01136374 putative 3-oxoacyl-(acyl-carrier-protein) reductase( EC:1.1.1.100 ) +FIG01136377 FIG01136378: hypothetical protein +FIG01136378 FIG01136379: hypothetical protein +FIG01136397 putative ABC transport system transmembrane protein +FIG01136407 FIG01136408: hypothetical protein +FIG01136415 FIG01136424: hypothetical protein +FIG01136428 FIG01136429: hypothetical protein +FIG01136429 FIG01136432: hypothetical protein +FIG01136438 FIG01136439: hypothetical protein +FIG01136439 FIG01136447: hypothetical protein +FIG01136454 FIG01136456: hypothetical protein +FIG01136463 FIG01136464: hypothetical protein +FIG01136465 FIG01136466: hypothetical protein +FIG01136467 FIG01136469: hypothetical protein +FIG01136470 FIG01136471: hypothetical protein +FIG01136476 FIG01136478: hypothetical protein +FIG01136480 ENSANGP00000024897( EC:3.4.21.1 ) +FIG01136485 FIG01136487: hypothetical protein +FIG01136495 FIG01136496: hypothetical protein +FIG01136498 FIG01136503: hypothetical protein +FIG01136507 FIG01136508: hypothetical protein +FIG01136508 FIG01136510: hypothetical protein +FIG01136511 FIG01136512: hypothetical protein +FIG01136523 FIG01136525: hypothetical protein +FIG01136525 FIG01136528: hypothetical protein +FIG01136528 FIG01136530: hypothetical protein +FIG01136531 FIG01136534: hypothetical protein +FIG01136542 FIG01136543: hypothetical protein +FIG01136549 FIG01136552: hypothetical protein +FIG01136566 FIG01136571: hypothetical protein +FIG01136618 FIG01136619: hypothetical protein +FIG01136620 FIG01136621: hypothetical protein +FIG01136640 FIG01127680: hypothetical protein +FIG01136664 FIG01136666: hypothetical protein +FIG01136679 FIG01136681: hypothetical protein +FIG01136706 FIG01136708: hypothetical protein +FIG01136726 FIG01136727: hypothetical protein +FIG01136727 FIG01136728: hypothetical protein +FIG01136734 FIG01136740: hypothetical protein +FIG01136743 FIG01136745: hypothetical protein +FIG01136750 FIG01136754: hypothetical protein +FIG01136756 Methylamine utilization protein mauE +FIG01136758 FIG01136761: hypothetical protein +FIG01136790 Sugar transport system +FIG01136868 FIG01136876: hypothetical protein +FIG01137185 FIG01137190: hypothetical protein +FIG01137272 luciferase-family protein +FIG01137490 FIG01137493: hypothetical protein +FIG01137493 putative regulatory protein (AfsR-like protein) +FIG01137502 ABC transport system ATP binding protein +FIG01137805 FIG01137813: hypothetical protein +FIG01138054 FIG01138056: hypothetical protein +FIG01138121 FIG01138123: hypothetical protein +FIG01138150 NPL/P60 family secreted protein +FIG01138165 conserved hypothetical protein; putative Glutathione transferase +FIG01138216 FIG01138222: hypothetical protein +FIG01138280 FIG01138286: hypothetical protein +FIG01138479 MoeH5 +FIG01139262 sugar transport membrane protein +FIG01139622 SpdA protein +FIG01140041 FIG01140046: hypothetical protein +FIG01140053 glucose-methanol-choline oxidoreductase +FIG01140083 FIG01140087: hypothetical protein +FIG01140216 integral membrane transferase +FIG01140367 FIG01140379: hypothetical protein +FIG01140448 uncharacterized Gly-rich protein +FIG01140453 no hits +FIG01140486 FIG01140510: hypothetical protein +FIG01140726 Helix-turn-helix regulator +FIG01140766 Oligopeptidase B( EC:3.4.21.83 ) +FIG01141050 putative ABC transporter, ATP-binding subunit +FIG01141089 FIG01141113: hypothetical protein +FIG01141325 FIG01141331: hypothetical protein +FIG01141662 Protein serine-threonine phosphatase +FIG01142039 L-proline 3-hydroxylase +FIG01142533 FIG01142537: hypothetical protein +FIG01142537 FIG01142538: hypothetical protein +FIG01142538 FIG01142539: hypothetical protein +FIG01142539 FIG01142541: hypothetical protein +FIG01142541 FIG01142547: hypothetical protein +FIG01142547 FIG01142549: hypothetical protein +FIG01142549 FIG01142550: hypothetical protein +FIG01142550 FIG01142552: hypothetical protein +FIG01142552 FIG01142553: hypothetical protein +FIG01142553 FIG01142554: hypothetical protein +FIG01142554 FIG01142555: hypothetical protein +FIG01142555 FIG01142558: hypothetical protein +FIG01142559 FIG01142565: hypothetical protein +FIG01142566 FIG01142570: hypothetical protein +FIG01142570 FIG01142572: hypothetical protein +FIG01142573 FIG01142575: hypothetical protein +FIG01142575 FIG01142577: hypothetical protein +FIG01142577 Probable dipeptidase +FIG01142579 FIG01142580: hypothetical protein +FIG01142581 FIG01142584: hypothetical protein +FIG01142584 FIG01142585: hypothetical protein +FIG01142585 FIG01142588: hypothetical protein +FIG01142588 FIG01142590: hypothetical protein +FIG01142595 FIG01142596: hypothetical protein +FIG01142596 FIG01142601: hypothetical protein +FIG01142601 FIG01142603: hypothetical protein +FIG01142604 FIG01142605: hypothetical protein +FIG01142606 FIG01142609: hypothetical protein +FIG01142610 FIG01142611: hypothetical protein +FIG01142611 FIG01142614: hypothetical protein +FIG01142614 FIG01142617: hypothetical protein +FIG01142617 FIG01142618: hypothetical protein +FIG01142618 Carboxyl-terminal protease family protein +FIG01142630 FIG01142631: hypothetical protein +FIG01142631 FIG01142632: hypothetical protein +FIG01142634 FIG01142635: hypothetical protein +FIG01142636 FIG01142637: hypothetical protein +FIG01142643 FIG01142644: hypothetical protein +FIG01142647 FIG01142648: hypothetical protein +FIG01142648 FIG01142649: hypothetical protein +FIG01142649 FIG01142650: hypothetical protein +FIG01142650 FIG01142651: hypothetical protein +FIG01142652 FIG01142653: hypothetical protein +FIG01142657 FIG01142662: hypothetical protein +FIG01142662 FIG01142663: hypothetical protein +FIG01142665 FIG01142666: hypothetical protein +FIG01142666 FIG01142668: hypothetical protein +FIG01142668 FIG01142670: hypothetical protein +FIG01142670 FIG01142672: hypothetical protein +FIG01142672 FIG01142674: hypothetical protein +FIG01142674 FIG01142675: hypothetical protein +FIG01142677 FIG01142679: hypothetical protein +FIG01142679 FIG01142680: hypothetical protein +FIG01142680 FIG01142684: hypothetical protein +FIG01142684 FIG01142685: hypothetical protein +FIG01142685 FIG01142686: hypothetical protein +FIG01142686 FIG01142687: hypothetical protein +FIG01142690 FIG01142691: hypothetical protein +FIG01142691 FIG01142693: hypothetical protein +FIG01142694 FIG01142697: hypothetical protein +FIG01142697 FIG01142701: hypothetical protein +FIG01142701 FIG01142702: hypothetical protein +FIG01142702 FIG01142704: hypothetical protein +FIG01142704 FIG01142706: hypothetical protein +FIG01142714 FIG01142715: hypothetical protein +FIG01142715 FIG01142718: hypothetical protein +FIG01142718 FIG01142720: hypothetical protein +FIG01142720 FIG01142722: hypothetical protein +FIG01142722 FIG01142723: hypothetical protein +FIG01142724 FIG01142725: hypothetical protein +FIG01142725 FIG01142726: hypothetical protein +FIG01142729 FIG01142730: hypothetical protein +FIG01142731 FIG01142736: hypothetical protein +FIG01142739 FIG01142742: hypothetical protein +FIG01142744 FIG01142745: hypothetical protein +FIG01142745 FIG01142746: hypothetical protein +FIG01142746 FIG01142747: hypothetical protein +FIG01142747 FIG01142749: hypothetical protein +FIG01142750 FIG01142752: hypothetical protein +FIG01142766 FIG01142768: hypothetical protein +FIG01142768 FIG01142771: hypothetical protein +FIG01142771 FIG01142772: hypothetical protein +FIG01142774 FIG01142775: hypothetical protein +FIG01142775 GcrA cell cycle regulator +FIG01142776 FIG01142777: hypothetical protein +FIG01142777 conserved hypothetical protein-putative oxidoreductase +FIG01142780 FIG01142782: hypothetical protein +FIG01142783 FIG01142787: hypothetical protein +FIG01142788 FIG01142790: hypothetical protein +FIG01142790 FIG01142791: hypothetical protein +FIG01142793 FIG01142794: hypothetical protein +FIG01142800 FIG01142801: hypothetical protein +FIG01142801 FIG01142805: hypothetical protein +FIG01142805 FIG01142808: hypothetical protein +FIG01142812 FIG01142813: hypothetical protein +FIG01142822 FIG01142824: hypothetical protein +FIG01142824 FIG01142828: hypothetical protein +FIG01142836 FIG01142839: hypothetical protein +FIG01142843 FIG01142849: hypothetical protein +FIG01142849 FIG01142852: hypothetical protein +FIG01142852 FIG01142855: hypothetical protein +FIG01142857 FIG01142858: hypothetical protein +FIG01142858 FIG01142860: hypothetical protein +FIG01142867 FIG01142868: hypothetical protein +FIG01142868 FIG01142869: hypothetical protein +FIG01142869 FIG01142870: hypothetical protein +FIG01142870 FIG01142873: hypothetical protein +FIG01142873 FIG01142874: hypothetical protein +FIG01142877 FIG01142878: hypothetical protein +FIG01142878 Glycerol-3-phosphate dehydrogenase related protein +FIG01142880 FIG01142881: hypothetical protein +FIG01142886 FIG01142888: hypothetical protein +FIG01142889 FIG01142890: hypothetical protein +FIG01142891 FIG01142892: hypothetical protein +FIG01142892 FIG01142894: hypothetical protein +FIG01142894 acyl-CoA thioesterase +FIG01142899 FIG01142901: hypothetical protein +FIG01142912 FIG01142913: hypothetical protein +FIG01142913 Glycosyl transferase-like protein +FIG01142918 FIG01142919: hypothetical protein +FIG01142923 Glutamate/glutamine/aspartate/asparagine-binding protein bztA precursor +FIG01142925 FIG01142926: hypothetical protein +FIG01142927 FIG01142928: hypothetical protein +FIG01142928 FIG01142932: hypothetical protein +FIG01142936 FIG01142938: hypothetical protein +FIG01142938 FIG01142939: hypothetical protein +FIG01142942 FIG01142943: hypothetical protein +FIG01142943 FIG01142944: hypothetical protein +FIG01142944 FIG01142948: hypothetical protein +FIG01142948 FIG01142949: hypothetical protein +FIG01142950 Molybdopterin converting factor, subunit 1 +FIG01142951 FIG01142952: hypothetical protein +FIG01142952 NreA-like protein +FIG01142963 FIG01142964: hypothetical protein +FIG01142974 FIG01142975: hypothetical protein +FIG01142975 FIG01142978: hypothetical protein +FIG01142978 FIG01142979: hypothetical protein +FIG01142980 FIG01142983: hypothetical protein +FIG01142983 FIG01142984: hypothetical protein +FIG01142984 FIG01142985: hypothetical protein +FIG01142988 FIG01142992: hypothetical protein +FIG01142997 FIG01142999: hypothetical protein +FIG01143001 ATP-dependent RNA helicase DOB1 +FIG01143003 FIG01143004: hypothetical protein +FIG01143008 FIG01143009: hypothetical protein +FIG01143012 FIG01143013: hypothetical protein +FIG01143013 FIG01143014: hypothetical protein +FIG01143014 FIG01143016: hypothetical protein +FIG01143016 FIG01143017: hypothetical protein +FIG01143026 FIG01143028: hypothetical protein +FIG01143028 FIG01143029: hypothetical protein +FIG01143031 FIG01143035: hypothetical protein +FIG01143041 FIG01143043: hypothetical protein +FIG01143043 Capsular polysaccharide export protein KpsS +FIG01143044 FIG01143045: hypothetical protein +FIG01143052 FIG01143054: hypothetical protein +FIG01143057 FIG01143058: hypothetical protein +FIG01143059 ripening-induced protein-putative Zn-containing oxidoreductase +FIG01143060 FIG01143061: hypothetical protein +FIG01143062 FIG01143063: hypothetical protein +FIG01143063 FIG01143065: hypothetical protein +FIG01143067 FIG01143071: hypothetical protein +FIG01143078 FIG01143079: hypothetical protein +FIG01143083 FIG01143087: hypothetical protein +FIG01143088 FIG01143089: hypothetical protein +FIG01143091 FIG01143093: hypothetical protein +FIG01143103 FIG01143104: hypothetical protein +FIG01143105 FIG01143109: hypothetical protein +FIG01143109 FIG01143110: hypothetical protein +FIG01143116 FIG01143118: hypothetical protein +FIG01143127 FIG01143128: hypothetical protein +FIG01143128 FIG01143130: hypothetical protein +FIG01143136 peptidoglycan binding protein (LysM domain) +FIG01143139 FIG01143141: hypothetical protein +FIG01143145 FIG01143147: hypothetical protein +FIG01143147 FIG01143148: hypothetical protein +FIG01143154 Probable ABC transporter, periplasmic binding protein +FIG01143156 FIG01143157: hypothetical protein +FIG01143157 FIG01143159: hypothetical protein +FIG01143159 FIG01143162: hypothetical protein +FIG01143164 FIG01143165: hypothetical protein +FIG01143165 FIG01143166: hypothetical protein +FIG01143166 FIG01143167: hypothetical protein +FIG01143167 FIG01143168: hypothetical protein +FIG01143168 FIG01143169: hypothetical protein +FIG01143169 FIG01143170: hypothetical protein +FIG01143170 FIG01143173: hypothetical protein +FIG01143174 FIG01143175: hypothetical protein +FIG01143178 FIG01143181: hypothetical protein +FIG01143182 FIG01143183: hypothetical protein +FIG01143193 FIG01143196: hypothetical protein +FIG01143199 FIG01143200: hypothetical protein +FIG01143200 FIG01143201: hypothetical protein +FIG01143204 FIG01143206: hypothetical protein +FIG01143210 FIG01143215: hypothetical protein +FIG01143220 FIG01143226: hypothetical protein +FIG01143227 FIG01143231: hypothetical protein +FIG01143233 FIG01143239: hypothetical protein +FIG01143239 FIG01143242: hypothetical protein +FIG01143244 FIG01143247: hypothetical protein +FIG01143247 Msl0703 protein +FIG01143259 Serine protease DO-like protease +FIG01143260 FIG01143261: hypothetical protein +FIG01143261 FIG01143263: hypothetical protein +FIG01143263 FIG01143264: hypothetical protein +FIG01143264 FIG01143265: hypothetical protein +FIG01143265 FIG01143266: hypothetical protein +FIG01143270 FIG01143272: hypothetical protein +FIG01143272 FIG01143274: hypothetical protein +FIG01143276 FIG01143277: hypothetical protein +FIG01143277 FIG01143278: hypothetical protein +FIG01143279 FIG01143280: hypothetical protein +FIG01143281 FIG01143284: hypothetical protein +FIG01143287 FIG01143288: hypothetical protein +FIG01143290 FIG01143292: hypothetical protein +FIG01143299 FIG01143300: hypothetical protein +FIG01143300 FIG01143301: hypothetical protein +FIG01143301 FIG01143303: hypothetical protein +FIG01143313 FIG01143315: hypothetical protein +FIG01143317 FIG01143319: hypothetical protein +FIG01143334 FIG01143335: hypothetical protein +FIG01143335 FIG01143336: hypothetical protein +FIG01143336 FIG01143337: hypothetical protein +FIG01143339 Abortive phage resistance protein +FIG01143343 FIG01143345: hypothetical protein +FIG01143345 FIG01143347: hypothetical protein +FIG01143347 FIG01143348: hypothetical protein +FIG01143352 FIG01143355: hypothetical protein +FIG01143355 Msr8615 protein +FIG01143358 FIG01143359: hypothetical protein +FIG01143359 FIG00918707: hypothetical protein +FIG01143375 FIG01143377: hypothetical protein +FIG01143379 FIG01143380: hypothetical protein +FIG01143380 FIG01143383: hypothetical protein +FIG01143383 FIG01143385: hypothetical protein +FIG01143385 FIG01143388: hypothetical protein +FIG01143388 FIG01143390: hypothetical protein +FIG01143394 FIG01143396: hypothetical protein +FIG01143396 FIG01143397: hypothetical protein +FIG01143402 Riorf47 protein +FIG01143406 FIG01143408: hypothetical protein +FIG01143411 FIG01143412: hypothetical protein +FIG01143412 FIG01143413: hypothetical protein +FIG01143413 FIG01143414: hypothetical protein +FIG01143415 FIG01143416: hypothetical protein +FIG01143416 FIG01143421: hypothetical protein +FIG01143423 FIG01143424: hypothetical protein +FIG01143424 FIG01143431: hypothetical protein +FIG01143431 FIG01143432: hypothetical protein +FIG01143437 FIG01143438: hypothetical protein +FIG01143440 FIG01143443: hypothetical protein +FIG01143443 FIG01143444: hypothetical protein +FIG01143465 FIG01143466: hypothetical protein +FIG01143466 FIG01143471: hypothetical protein +FIG01143476 FIG01143479: hypothetical protein +FIG01143484 Phage-related replication protein +FIG01143487 FIG01143488: hypothetical protein +FIG01143504 FIG01143508: hypothetical protein +FIG01143513 FIG01143514: hypothetical protein +FIG01143518 FIG01143521: hypothetical protein +FIG01143522 FIG01143525: hypothetical protein +FIG01143530 FIG01143531: hypothetical protein +FIG01143555 FIG01143559: hypothetical protein +FIG01143572 Mll2895 protein +FIG01143588 Ferripyochelin binding protein +FIG01143589 Uncharacterized protein MJ0535 +FIG01143596 CBS-domain-containing protein +FIG01143610 Conserved Archaeal protein +FIG01143612 SSO0251 family +FIG01143614 115aa long hypothetical protein +FIG01143615 267aa long hypothetical protein +FIG01143617 Conserved Archaeal CBS domain protein +FIG01143629 164aa long conserved hypothetical protein +FIG01143664 65aa long conserved hypothetical protein +FIG01143667 Phosphoglycolate phosphatase 2 (EC 3.1.3.18) +FIG01143668 Sarcosine oxidase, subunit alpha related (soxA), putative (soxA-like) +FIG01143673 ABC transport system ATP-binding protein PA +FIG01143674 Acetolactate synthase large subunit homolog (IlvB-1) (EC 2.2.1.6) +FIG01143681 136aa long hypothetical protein +FIG01143688 489aa long conserved hypothetical protein +FIG01143693 Amino acid permease related protein +FIG01143696 Uncharacterized protein MJ0935 +FIG01143697 331aa long hypothetical protein +FIG01143699 possible circadian clock protein KaiC +FIG01143700 HTH-type transcriptional regulator lrs14 +FIG01143707 494aa long hypothetical protein +FIG01143708 94aa long conserved hypothetical protein +FIG01143711 379aa long hypothetical protein +FIG01143715 288aa long hypothetical protein +FIG01143721 111aa long hypothetical protein +FIG01143723 Tbp-interacting protein tip49 +FIG01143726 238aa long hypothetical protein +FIG01143731 11_1030, PROTEASOME REGULATORY SUBUNIT YTA6 OF THE AAA FAMILY OF ATPASES, TBP6_yeast, SAP1_yeast, gene found by Glimmer +FIG01143735 381aa long hypothetical protein +FIG01143736 General stress protein, oxireductase +FIG01143741 mRNA 3-end processing exonuclease +FIG01143742 Integral membrane protein 1 +FIG01143751 360aa long hypothetical protein +FIG01143758 326aa long hypothetical protein +FIG01143759 212aa long hypothetical protein +FIG01143760 Acryloyl-CoA Reductase +FIG01143763 316aa long hypothetical protein +FIG01143776 242aa long conserved hypothetical protein +FIG01143782 216aa long hypothetical protein +FIG01143783 252aa long hypothetical protein +FIG01143801 275aa long hypothetical protein +FIG01143810 107aa long hypothetical protein +FIG01143812 152aa long hypothetical protein +FIG01143815 Mannose-1-phosphate guanyltransferase (EC 2.7.7.13) (ATP-mannose-1-phosphate guanylyltransferase) (GDP-mannose pyrophosphorylase) (CASRB1) +FIG01143816 93aa long conserved hypothetical protein +FIG01143819 Conserved TPR domain protein +FIG01143822 195aa long hypothetical protein +FIG01143824 Transcriptional regulator, putative +FIG01143827 3-oxoacyl-(Acyl carrier protein) reductase (FabG-1) (EC 1.1.1.100) +FIG01143834 270aa long hypothetical thiosulfate reductase electron transport protein phsB +FIG01143843 Heat shock protein (htpX-2) +FIG01143856 199aa long hypothetical protein +FIG01143859 411aa long hypothetical protein +FIG01143860 Probable brix-domain ribosomal biogenesis protein +FIG01143877 BPS2 protein homolog (bps2) +FIG01143880 277aa long hypothetical protein +FIG01143882 protein derived from threonyl-tRNA synthetase +FIG01143885 Molybdopterin biosynthesis protein +FIG01143891 hypothetical protein SSO2344 +FIG01143893 125aa long hypothetical protein +FIG01143911 163aa long hypothetical protein +FIG01143919 131aa long hypothetical protein +FIG01143925 273aa long conserved hypothetical protein +FIG01143926 132aa long hypothetical protein +FIG01143947 143aa long hypothetical protein +FIG01143957 GMP synthase [glutamine-hydrolyzing], ATP pyrophosphatase subunit (EC 6.3.5.2) +FIG01143960 Alcohol dehydrogenase (Zn containing) (Adh-7) (EC 1.1.1.1) +FIG01143961 351aa long hypothetical protein +FIG01143967 220aa long hypothetical protein +FIG01143980 112aa long hypothetical protein +FIG01143983 Acyl-CoA thioesterase +FIG01143985 Single-stranded DNA binding protein +FIG01143988 Chlorite dismutase precursor +FIG01143990 DNA-directed RNA polymerase, putative subunit M (RpoM-like) (EC 2.7.7.6) +FIG01143991 114aa long hypothetical protein +FIG01143994 Conserved Archaeal 4Fe-4S binding domain protein +FIG01143995 Cytochrome c oxidase assembly factor +FIG01144002 151aa long hypothetical protein +FIG01144004 1082aa long hypothetical protein +FIG01144008 122aa long hypothetical protein +FIG01144011 DNA repair protein rad25 +FIG01144019 Thermopsine related protein (EC 3.4.23.42) +FIG01144021 Quinol oxidase-2, putative subunit (SoxI-like) (soxI-like) +FIG01144034 Conserved Archaeal HTH-domain protein +FIG01144039 Ribosome biogenesis protein TSR3 +FIG01144045 146aa long hypothetical protein +FIG01144051 GMP synthase [glutamine-hydrolyzing], amidotransferase subunit (EC 6.3.5.2) +FIG01144058 184aa long conserved hypothetical protein +FIG01144061 139aa long hypothetical protein +FIG01144065 Glycosyltransferase (EC 2.4.-.-) +FIG01144068 110aa long hypothetical protein +FIG01144070 263aa long hypothetical protein +FIG01144071 206aa long conserved hypothetical protein +FIG01144075 TVG1210382 protein +FIG01144076 103aa long hypothetical protein +FIG01144080 300aa long hypothetical protein +FIG01144085 Bacterio-opsin activator domain-containing protein +FIG01144093 544aa long hypothetical protein +FIG01144099 137aa long hypothetical protein +FIG01144100 193aa long hypothetical 2-hydroxy-6-oxo-6-phenylhexa-2,4-dienoate hydrolase +FIG01144106 153aa long conserved hypothetical protein +FIG01144113 241aa long conserved hypothetical protein +FIG01144114 168aa long hypothetical protein +FIG01144120 DNA polymerase sliding clamp B +FIG01144121 156aa long hypothetical protein +FIG01144125 450aa long hypothetical protein +FIG01144127 Acetyl CoA synthase (Acetyl-CoA c-acetyltransferase) (EC 2.3.1.9) +FIG01144133 Nickel ABC transporter, periplasmic nickel-binding protein nikA2 (TC 3.A.1.5.3) +FIG01144137 321aa long hypothetical protein +FIG01144142 126aa long hypothetical protein +FIG01144153 154aa long hypothetical protein +FIG01144171 203aa long hypothetical protein +FIG01144182 Conserved protein associated with acetyl-CoA C-acyltransferase +FIG01144189 FIG01144199: hypothetical protein +FIG01144203 FIG01144204: hypothetical protein +FIG01144204 Flagellar basal body P-ring biosynthesis protein-like protein +FIG01144209 FIG01144215: hypothetical protein +FIG01144215 FIG01144218: hypothetical protein +FIG01144218 FIG01144220: hypothetical protein +FIG01144221 FIG01144225: hypothetical protein +FIG01144225 FIG01144235: hypothetical protein +FIG01144235 FIG01144236: hypothetical protein +FIG01144236 FIG01144238: hypothetical protein +FIG01144242 FIG01144243: hypothetical protein +FIG01144243 Cell division topological specificity factor MinE +FIG01144260 FIG01144262: hypothetical protein +FIG01144267 FIG01144268: hypothetical protein +FIG01144275 FIG01144284: hypothetical protein +FIG01144284 FIG01144285: hypothetical protein +FIG01144303 FIG01144306: hypothetical protein +FIG01144318 FIG01144323: hypothetical protein +FIG01144324 transcriptional regulator (DegT/DnrJ/Eryc1 family) +FIG01144325 flagellar motor switch protein FliN/FliY +FIG01144352 FIG01144357: hypothetical protein +FIG01144357 gamma-subunit of ethylbenzene dehydrogenase +FIG01144359 FIG01144364: hypothetical protein +FIG01144364 FIG01144378: hypothetical protein +FIG01144392 FIG01144393: hypothetical protein +FIG01144393 FIG01144395: hypothetical protein +FIG01144405 transcriptional regulator (NtrC family) +FIG01144409 FIG01144413: hypothetical protein +FIG01144413 FIG01144419: hypothetical protein +FIG01144440 FIG01144441: hypothetical protein +FIG01144441 FIG01144444: hypothetical protein +FIG01144444 FIG01144446: hypothetical protein +FIG01144446 glycosyltransferase, family 4 +FIG01144447 FIG01144448: hypothetical protein +FIG01144448 FIG01144449: hypothetical protein +FIG01144456 FIG01144458: hypothetical protein +FIG01144458 FIG01144461: hypothetical protein +FIG01144461 FIG01144469: hypothetical protein +FIG01144470 FIG01144472: hypothetical protein +FIG01144472 FIG01144476: hypothetical protein +FIG01144478 FIG01144483: hypothetical protein +FIG01144483 FIG01144485: hypothetical protein +FIG01144508 FIG01144509: hypothetical protein +FIG01144513 FIG01144515: hypothetical protein +FIG01144515 FIG01144518: hypothetical protein +FIG01144531 FIG01144537: hypothetical protein +FIG01144544 Probable polysaccharide transport system component transmembrane protein +FIG01144549 FIG01144556: hypothetical protein +FIG01144556 FIG01144558: hypothetical protein +FIG01144558 FIG01144572: hypothetical protein +FIG01144572 FIG01144574: hypothetical protein +FIG01144575 FIG01144579: hypothetical protein +FIG01144579 FIG01144585: hypothetical protein +FIG01144589 FIG01144597: hypothetical protein +FIG01144597 FIG01144599: hypothetical protein +FIG01144610 FIG01144611: hypothetical protein +FIG01144611 FIG01144612: hypothetical protein +FIG01144617 FIG01144620: hypothetical protein +FIG01144620 FIG01144625: hypothetical protein +FIG01144625 FIG01144626: hypothetical protein +FIG01144646 FIG01144652: hypothetical protein +FIG01144652 Dolichol-phosphate mannosyltransferase (EC 2.4.1.83) +FIG01144666 FIG01144667: hypothetical protein +FIG01144671 FIG01144684: hypothetical protein +FIG01144690 FIG01144694: hypothetical protein +FIG01144705 FIG01144710: hypothetical protein +FIG01144710 FIG01144711: hypothetical protein +FIG01144723 FIG01144725: hypothetical protein +FIG01144726 FIG01144730: hypothetical protein +FIG01144730 FIG01144731: hypothetical protein +FIG01144731 FIG01144732: hypothetical protein +FIG01144732 FIG01144743: hypothetical protein +FIG01144743 FIG01144746: hypothetical protein +FIG01144746 FIG01144754: hypothetical protein +FIG01144771 FIG01144782: hypothetical protein +FIG01144802 FIG01144807: hypothetical protein +FIG01144807 FIG01144809: hypothetical protein +FIG01144820 FIG01144823: hypothetical protein +FIG01144823 FIG01144826: hypothetical protein +FIG01144827 FIG01144828: hypothetical protein +FIG01144838 flagellar basal-body rod protein FlgF +FIG01144845 FIG01144846: hypothetical protein +FIG01144856 FIG01144858: hypothetical protein +FIG01144858 putative chemotaxis phosphatase, CheZ +FIG01144863 FIG01144870: hypothetical protein +FIG01144870 FIG01144871: hypothetical protein +FIG01144874 FIG01144875: hypothetical protein +FIG01144875 FIG01144888: hypothetical protein +FIG01144889 FIG01144890: hypothetical protein +FIG01144890 FIG01144891: hypothetical protein +FIG01144901 FIG01144903: hypothetical protein +FIG01144903 HlpA protein +FIG01144906 FIG01144907: hypothetical protein +FIG01144909 FIG01144919: hypothetical protein +FIG01144919 FIG01144928: hypothetical protein +FIG01144928 FIG01144932: hypothetical protein +FIG01144932 deacetylase-like protein +FIG01144937 FIG01144942: hypothetical protein +FIG01144959 FIG01144971: hypothetical protein +FIG01144971 FIG01144973: hypothetical protein +FIG01144973 FIG01144976: hypothetical protein +FIG01144976 FIG01144982: hypothetical protein +FIG01144997 prokaryotic N-terminal methylation motif domain protein +FIG01145008 FIG01145010: hypothetical protein +FIG01145027 FIG01145050: hypothetical protein +FIG01145050 TATA-binding-protein-associated factor 172 +FIG01145063 FIG01145064: hypothetical protein +FIG01145064 FIG01145066: hypothetical protein +FIG01145066 FIG01145081: hypothetical protein +FIG01145085 FIG01145086: hypothetical protein +FIG01145086 FIG01145087: hypothetical protein +FIG01145087 FIG01145088: hypothetical protein +FIG01145099 FIG01145101: hypothetical protein +FIG01145101 FIG01145103: hypothetical protein +FIG01145103 Sulfide:quinone oxidoreductase +FIG01145105 FIG01145106: hypothetical protein +FIG01145113 FIG01145135: hypothetical protein +FIG01145153 FIG01145159: hypothetical protein +FIG01145167 FIG01145168: hypothetical protein +FIG01145168 FIG01145204: hypothetical protein +FIG01145204 FIG01145221: hypothetical protein +FIG01145279 putative +FIG01145281 FIG01145298: hypothetical protein +FIG01145427 TRANSDUCER +FIG01145714 Purine nucleoside phosphorylase +FIG01145756 Related to 2-hydroxyglutaryl-CoA dehydratase, beta subunit +FIG01146271 Chlorohydrolase/deaminase family protein +FIG01146287 Putative ATP /GTP binding protein +FIG01146404 FIG01146407: hypothetical protein +FIG01146407 FIG01146408: hypothetical protein +FIG01146784 uncharacterized conserved protein, putative +FIG01146828 FIG01146831: hypothetical protein +FIG01147055 FIG01147061: hypothetical protein +FIG01147156 FIG01147157: hypothetical protein +FIG01147389 FIG01147391: hypothetical protein +FIG01147401 hypothetical protein +FIG01147455 FIG01147456: hypothetical protein +FIG01147516 probable transcription regulator Cj0571 +FIG01147520 Dihydroneopterin triphosphate pyrophosphohydrolase type 2 (nudB) +FIG01147625 COG1836 / Phytol kinase +FIG01147768 putative cyclase/dehydrase +FIG01147868 hypothetical protein, alanine-rich +FIG01147895 Aldehyde ferredoxin oxidoreductase +FIG01148451 FIG01148453: hypothetical protein +FIG01148592 protein of unknown function DUF342 +FIG01149194 FIG01149195: hypothetical protein +FIG01149196 possible oxidoreductase +FIG01149197 FIG01149198: hypothetical protein +FIG01149199 FIG01149200: hypothetical protein +FIG01149200 FIG01149201: hypothetical protein +FIG01149201 FIG01149203: hypothetical protein +FIG01149203 Predicted methyltransferases +FIG01149204 conserved hypotheticals +FIG01149205 Chloride channel protein-related protein +FIG01149206 FIG01149207: hypothetical protein +FIG01149207 FIG01149208: hypothetical protein +FIG01149208 FIG01149211: hypothetical protein +FIG01149212 possible Arginine repressor, C-terminal domain +FIG01149215 FIG01149216: hypothetical protein +FIG01149218 phycobilisome 8.9 kDa linker polypeptide, phycocyanin-associated, rod +FIG01149221 ABC-type metal ion transport system, ATPase component +FIG01149223 FIG01149224: hypothetical protein +FIG01149224 FIG01149226: hypothetical protein +FIG01149227 FIG01149228: hypothetical protein +FIG01149228 FIG01149229: hypothetical protein +FIG01149229 FIG01149230: hypothetical protein +FIG01149230 FIG01149231: hypothetical protein +FIG01149231 FIG01149232: hypothetical protein +FIG01149235 FIG01149237: hypothetical protein +FIG01149243 FIG01149245: hypothetical protein +FIG01149245 FIG01149248: hypothetical protein +FIG01149248 FIG01149250: hypothetical protein +FIG01149250 Permease protein of sugar ABC transporter +FIG01149252 FIG01149255: hypothetical protein +FIG01149255 Phosphopantetheinyl transferase-like +FIG01149258 FIG01149261: hypothetical protein +FIG01149261 FIG01149262: hypothetical protein +FIG01149262 FIG01149264: hypothetical protein +FIG01149264 FIG01149265: hypothetical protein +FIG01149265 FIG01149266: hypothetical protein +FIG01149268 FIG01149269: hypothetical protein +FIG01149269 Possible multidrug efflux transporter, MFS family precursor +FIG01149271 Asr2387 protein +FIG01149272 FIG01149273: hypothetical protein +FIG01149273 FIG01149274: hypothetical protein +FIG01149274 FIG01149277: hypothetical protein +FIG01149278 FIG01149279: hypothetical protein +FIG01149279 FIG01149280: hypothetical protein +FIG01149280 FIG01149281: hypothetical protein +FIG01149281 FIG01149282: hypothetical protein +FIG01149282 FIG01149285: hypothetical protein +FIG01149285 FIG01149286: hypothetical protein +FIG01149286 FIG01149289: hypothetical protein +FIG01149289 FIG01149290: hypothetical protein +FIG01149290 FIG01149291: hypothetical protein +FIG01149291 FIG01149294: hypothetical protein +FIG01149294 FIG01149297: hypothetical protein +FIG01149297 FIG01149302: hypothetical protein +FIG01149305 FIG01149306: hypothetical protein +FIG01149306 FIG01149307: hypothetical protein +FIG01149307 FIG01149308: hypothetical protein +FIG01149309 FIG01149310: hypothetical protein +FIG01149310 FIG01149311: hypothetical protein +FIG01149311 Zn-dependent peptidase +FIG01149317 FIG01149318: hypothetical protein +FIG01149318 FIG01149320: hypothetical protein +FIG01149321 FIG01149322: hypothetical protein +FIG01149322 FIG01149323: hypothetical protein +FIG01149323 Possible rare lipoprotein A precursor +FIG01149324 FIG01149328: hypothetical protein +FIG01149328 FIG01149329: hypothetical protein +FIG01149329 FIG01149330: hypothetical protein +FIG01149330 FIG01149331: hypothetical protein +FIG01149331 FIG01149332: hypothetical protein +FIG01149332 FIG01149334: hypothetical protein +FIG01149336 FIG01149337: hypothetical protein +FIG01149337 FIG01149338: hypothetical protein +FIG01149343 FIG01149344: hypothetical protein +FIG01149344 FIG01149347: hypothetical protein +FIG01149347 FIG01149351: hypothetical protein +FIG01149351 ABC transporter for amino acids, membrane component +FIG01149352 FIG01149356: hypothetical protein +FIG01149357 FIG01149358: hypothetical protein +FIG01149358 FIG01149361: hypothetical protein +FIG01149361 Possible Ligand-binding domain of nuclear horm +FIG01149362 FIG01149364: hypothetical protein +FIG01149364 FIG01149366: hypothetical protein +FIG01149366 FIG01149369: hypothetical protein +FIG01149369 FIG01149370: hypothetical protein +FIG01149370 FIG01149371: hypothetical protein +FIG01149371 FIG01149376: hypothetical protein +FIG01149376 FIG01149378: hypothetical protein +FIG01149378 FIG01149379: hypothetical protein +FIG01149379 FIG01149382: hypothetical protein +FIG01149382 FIG01149383: hypothetical protein +FIG01149383 FIG01149384: hypothetical protein +FIG01149384 FIG01149385: hypothetical protein +FIG01149386 FIG01149387: hypothetical protein +FIG01149387 FIG01149388: possible membrane protein +FIG01149388 Hydrophobic amino acid ABC transporter (HAAT) family, periplasmic amino acid-binding protein +FIG01149389 FIG01149390: hypothetical protein +FIG01149390 FIG01149392: hypothetical protein +FIG01149392 FIG01149393: hypothetical protein +FIG01149393 FIG01149395: hypothetical protein +FIG01149396 FIG01149397: hypothetical protein +FIG01149397 hypothetical protein, possible cyclic nucleotide-binding domain +FIG01149400 Alr3388 protein +FIG01149404 FIG01149405: hypothetical protein +FIG01149406 FIG01149409: hypothetical protein +FIG01149410 FIG01149411: hypothetical protein +FIG01149411 FIG01149412: hypothetical protein +FIG01149412 FIG01149415: hypothetical protein +FIG01149415 FIG01149421: hypothetical protein +FIG01149422 FIG01149423: hypothetical protein +FIG01149426 Serine proteases, trypsin family:Chymotrypsin serine protease... +FIG01149430 FIG01149432: hypothetical protein +FIG01149433 FIG01149435: hypothetical protein +FIG01149437 FIG01149438: hypothetical protein +FIG01149438 Selenophosphate synthetase-related protein MJ0640 +FIG01149442 FIG01149443: hypothetical protein +FIG01149443 FIG01149444: hypothetical protein +FIG01149444 FIG01149445: hypothetical protein +FIG01149447 FIG01149449: hypothetical protein +FIG01149449 FIG01149450: hypothetical protein +FIG01149450 FIG01149452: hypothetical protein +FIG01149453 FIG01149456: hypothetical protein +FIG01149456 FIG01149458: hypothetical protein +FIG01149459 FIG01149465: hypothetical protein +FIG01149465 FIG01149466: hypothetical protein +FIG01149467 Cell division protein FtsH4 (EC 3.4.24.-) +FIG01149469 FIG01149473: hypothetical protein +FIG01149474 FIG01149475: hypothetical protein +FIG01149477 protein kinase domain/TPR repeat protein +FIG01149481 FIG01149482: hypothetical protein +FIG01149482 FIG01149483: hypothetical protein +FIG01149483 FIG01149484: hypothetical protein +FIG01149484 FIG01149485: hypothetical protein +FIG01149485 FIG01149486: hypothetical protein +FIG01149486 FIG01149487: hypothetical protein +FIG01149487 FIG01149488: hypothetical protein +FIG01149488 FIG01149489: hypothetical protein +FIG01149489 Alpha-mannosidase +FIG01149493 FIG01149494: hypothetical protein +FIG01149494 FIG01149497: hypothetical protein +FIG01149497 FIG01149499: hypothetical protein +FIG01149499 FIG01149500: hypothetical protein +FIG01149500 FIG01149501: hypothetical protein +FIG01149501 FIG01149503: hypothetical protein +FIG01149503 FIG01149504: hypothetical protein +FIG01149504 possible LytR-membrane bound transcriptional regulator +FIG01149510 FIG01149512: hypothetical protein +FIG01149515 FIG01149519: hypothetical protein +FIG01149519 FIG01149520: hypothetical protein +FIG01149520 syc1048_c +FIG01149523 FIG01149527: hypothetical protein +FIG01149527 FIG01149528: hypothetical protein +FIG01149528 peptidase, M23B family( EC:3.4.24.- ) +FIG01149529 FIG01149530: hypothetical protein +FIG01149530 FIG01149531: hypothetical protein +FIG01149531 FIG01149533: hypothetical protein +FIG01149536 FIG01149538: hypothetical protein +FIG01149538 Dolichyl-phosphate-mannose-protein mannosyltransferase +FIG01149541 Possible homeobox domain +FIG01149542 Multidrug efflux RND transporter MexF +FIG01149543 FIG01149544: hypothetical protein +FIG01149544 FIG01149545: hypothetical protein +FIG01149545 FIG01149548: hypothetical protein +FIG01149548 FIG01149549: hypothetical protein +FIG01149549 FIG01149550: hypothetical protein +FIG01149550 FIG01149553: hypothetical protein +FIG01149553 FIG01149556: hypothetical protein +FIG01149559 Possible muramidase, COG4678 precursor +FIG01149562 FIG01149563: hypothetical protein +FIG01149563 hypothetical protein +FIG01149566 FIG01149568: hypothetical protein +FIG01149568 FIG01149569: hypothetical protein +FIG01149569 FIG01149570: hypothetical protein +FIG01149570 FIG01149571: hypothetical protein +FIG01149571 FIG01149572: hypothetical protein +FIG01149572 FIG01149573: hypothetical protein +FIG01149579 Type IV pilus biogenesis protein PilM +FIG01149580 FIG01149581: hypothetical protein +FIG01149582 FIG01149583: hypothetical protein +FIG01149584 Pentapeptide repeats +FIG01149587 FIG01149590: hypothetical protein +FIG01149590 FIG01149591: hypothetical protein +FIG01149592 VapC toxin protein +FIG01149593 FIG01149594: hypothetical protein +FIG01149594 FIG01149596: hypothetical protein +FIG01149596 UbiE/COQ5 methyltransferase( EC:2.1.1.17 ) +FIG01149597 FIG01149599: hypothetical protein +FIG01149600 FIG01149601: hypothetical protein +FIG01149602 FIG01149604: hypothetical protein +FIG01149604 FIG01149605: hypothetical protein +FIG01149605 FIG01149607: hypothetical protein +FIG01149607 probable arylesterase protein +FIG01149608 FIG01149612: hypothetical protein +FIG01149612 FIG01149613: hypothetical protein +FIG01149613 FIG01149614: hypothetical protein +FIG01149614 FIG01149617: hypothetical protein +FIG01149617 FIG01149618: hypothetical protein +FIG01149618 FIG01149619: hypothetical protein +FIG01149619 FIG01149620: hypothetical protein +FIG01149620 FIG01149621: hypothetical protein +FIG01149623 FIG01149624: hypothetical protein +FIG01149624 FIG01149626: hypothetical protein +FIG01149627 FIG01149629: hypothetical protein +FIG01149629 FIG01149630: hypothetical protein +FIG01149632 FIG01149634: hypothetical protein +FIG01149634 FIG01149635: hypothetical protein +FIG01149639 FIG01149643: hypothetical protein +FIG01149643 FIG01149644: hypothetical protein +FIG01149644 FIG01149647: hypothetical protein +FIG01149647 possible ABC transporter ATP-binding protein +FIG01149648 FIG01149649: hypothetical protein +FIG01149649 FIG01149651: hypothetical protein +FIG01149651 FIG01149652: hypothetical protein +FIG01149653 FIG01149654: hypothetical protein +FIG01149654 FIG01149655: hypothetical protein +FIG01149655 FIG01149663: hypothetical protein +FIG01149663 FIG01149664: hypothetical protein +FIG01149666 FIG01149667: hypothetical protein +FIG01149667 FIG01149668: hypothetical protein +FIG01149668 Lipid A disaccharide synthetase related enzyme +FIG01149669 FIG01149670: hypothetical protein +FIG01149670 FIG01149671: hypothetical protein +FIG01149671 FIG01149672: hypothetical protein +FIG01149674 FIG01149675: hypothetical protein +FIG01149675 FIG01149676: hypothetical protein +FIG01149676 FIG01149679: hypothetical protein +FIG01149685 FIG01149686: hypothetical protein +FIG01149689 FIG01149690: hypothetical protein +FIG01149691 FIG01149692: hypothetical protein +FIG01149692 FIG01149697: hypothetical protein +FIG01149697 hypothetical protein +FIG01149698 FIG01149702: hypothetical protein +FIG01149702 FIG01149703: hypothetical protein +FIG01149703 FIG01149704: hypothetical protein +FIG01149704 FIG01149705: hypothetical protein +FIG01149706 FIG01149708: hypothetical protein +FIG01149708 FIG01149712: hypothetical protein +FIG01149712 FIG01149714: hypothetical protein +FIG01149714 Creatinine amidohydrolase related enzyme +FIG01149715 FIG01149716: hypothetical protein +FIG01149716 FIG01149717: hypothetical protein +FIG01149717 FIG01149718: hypothetical protein +FIG01149718 FIG01149719: hypothetical protein +FIG01149719 FIG01149720: hypothetical protein +FIG01149722 FIG01149724: hypothetical protein +FIG01149724 FIG01149725: hypothetical protein +FIG01149735 FIG01149736: hypothetical protein +FIG01149736 FIG01149738: hypothetical protein +FIG01149740 FIG01149742: hypothetical protein +FIG01149743 FIG01149745: hypothetical protein +FIG01149745 FIG01149748: hypothetical protein +FIG01149748 Hypothetical membrane protein, PMM1568 homolog +FIG01149752 FIG01149753: hypothetical protein +FIG01149753 FIG01149754: hypothetical protein +FIG01149754 FIG01149755: hypothetical protein +FIG01149755 FIG01149756: hypothetical protein +FIG01149756 FIG01149764: hypothetical protein +FIG01149764 FIG01149766: hypothetical protein +FIG01149766 FIG01149768: hypothetical protein +FIG01149769 Rhamnosyltransferase +FIG01149772 FIG01149774: hypothetical protein +FIG01149774 possible Extracellular link domain protein +FIG01149776 FIG01149778: hypothetical protein +FIG01149778 Sll1835 protein +FIG01149781 FIG01149782: hypothetical protein +FIG01149782 FIG01149783: hypothetical protein +FIG01149783 FIG01149787: hypothetical protein +FIG01149787 FIG01149791: hypothetical protein +FIG01149791 FIG01149792: hypothetical protein +FIG01149792 FIG01149793: hypothetical protein +FIG01149796 FIG01149797: hypothetical protein +FIG01149797 FIG01149799: hypothetical protein +FIG01149799 cob(I)alamin adenosyltransferase +FIG01149805 FIG01149807: hypothetical protein +FIG01149807 FIG01149810: hypothetical protein +FIG01149810 FIG01149811: hypothetical protein +FIG01149811 possible ABC transporter, solute binding protein +FIG01149817 FIG01149819: hypothetical protein +FIG01149820 FIG01149822: hypothetical protein +FIG01149830 FIG01149833: hypothetical protein +FIG01149833 FIG01149834: hypothetical protein +FIG01149834 FIG01149840: hypothetical protein +FIG01149840 FIG01149841: hypothetical protein +FIG01149841 FIG01149845: hypothetical protein +FIG01149845 FIG01149846: hypothetical protein +FIG01149847 Possible Bacterial type II secretion system pr precursor +FIG01149849 FIG01149851: hypothetical protein +FIG01149851 FIG01149852: hypothetical protein +FIG01149852 FIG01149853: hypothetical protein +FIG01149855 Rho termination factor, N-terminal +FIG01149856 Possible ABC transporter involved in polysaccharide efflux +FIG01149859 FIG01149863: hypothetical protein +FIG01149863 FIG01149864: hypothetical protein +FIG01149864 FIG01149866: hypothetical protein +FIG01149866 FIG01149867: hypothetical protein +FIG01149867 FIG01149870: hypothetical protein +FIG01149870 glucose transport protein +FIG01149873 FIG01149874: hypothetical protein +FIG01149876 FIG01149877: hypothetical protein +FIG01149878 FIG01149880: hypothetical protein +FIG01149880 FIG01149882: hypothetical protein +FIG01149882 FIG01149883: hypothetical protein +FIG01149883 FIG01149887: hypothetical protein +FIG01149887 FIG01149888: hypothetical protein +FIG01149890 FIG01149891: hypothetical protein +FIG01149895 Putative multicomponent Na+:H+ antiporter subunit B +FIG01149900 FIG01149901: hypothetical protein +FIG01149901 FIG01149904: hypothetical protein +FIG01149905 FIG01149907: hypothetical protein +FIG01149908 FIG01149910: hypothetical protein +FIG01149910 FIG01149914: hypothetical protein +FIG01149914 FIG01149916: hypothetical protein +FIG01149917 FIG01149919: hypothetical protein +FIG01149919 FIG01149920: hypothetical protein +FIG01149920 FIG01149923: hypothetical protein +FIG01149923 FIG01149925: hypothetical protein +FIG01149925 Cytochrome C +FIG01149927 FIG01149929: hypothetical protein +FIG01149929 FIG01149931: hypothetical protein +FIG01149931 FIG01149932: hypothetical protein +FIG01149932 possible Occludin/ELL family protein +FIG01149936 FIG01149943: hypothetical protein +FIG01149943 FIG01149944: hypothetical protein +FIG01149944 FIG01149945: hypothetical protein +FIG01149947 FIG01149949: hypothetical protein +FIG01149951 FIG01149953: hypothetical protein +FIG01149953 FIG01149955: hypothetical protein +FIG01149955 FIG01149957: hypothetical protein +FIG01149958 FIG01149960: hypothetical protein +FIG01149961 FIG01149963: hypothetical protein +FIG01149963 FIG01149964: hypothetical protein +FIG01149968 FIG01149969: hypothetical protein +FIG01149969 FIG01149970: hypothetical protein +FIG01149970 FIG01149971: hypothetical protein +FIG01149971 FIG01149973: hypothetical protein +FIG01149973 N(2),N(2)-dimethylguanosine tRNA methyltransferase (EC 2.1.1.32) +FIG01149974 putative ABC transporter, multidrug efflux family +FIG01149977 FIG01149978: hypothetical protein +FIG01149982 Type IV pilus biogenesis protein PilM / Type IV pilus biogenesis protein PilN +FIG01149984 FIG01149987: hypothetical protein +FIG01149990 TRNA/rRNA methyltransferase (SpoU) (EC 2.1.1.-) +FIG01149993 FIG01149994: hypothetical protein +FIG01149994 FIG01149996: hypothetical protein +FIG01149996 FIG01149997: hypothetical protein +FIG01149997 FIG01149998: hypothetical protein +FIG01149998 FIG01150000: hypothetical protein +FIG01150001 FIG01150003: hypothetical protein +FIG01150011 FIG01150012: hypothetical protein +FIG01150015 FIG01150017: hypothetical protein +FIG01150017 FIG01150018: hypothetical protein +FIG01150018 FIG01150020: hypothetical protein +FIG01150020 FIG01150023: hypothetical protein +FIG01150023 Possible peptidase family M20/M25/M40 precursor +FIG01150025 FIG01150026: hypothetical protein +FIG01150026 FIG01150027: hypothetical protein +FIG01150027 FIG01150028: hypothetical protein +FIG01150030 FIG01150032: hypothetical protein +FIG01150032 FIG01150034: hypothetical protein +FIG01150034 FIG01150038: hypothetical protein +FIG01150040 FIG01150043: hypothetical protein +FIG01150043 FIG01150044: hypothetical protein +FIG01150044 FIG01150045: hypothetical protein +FIG01150045 FIG01150046: hypothetical protein +FIG01150046 FIG01150050: hypothetical protein +FIG01150050 FIG01150051: hypothetical protein +FIG01150051 FIG01150053: hypothetical protein +FIG01150053 FIG01150054: hypothetical protein +FIG01150054 FIG01150055: hypothetical protein +FIG01150055 FIG01150056: hypothetical protein +FIG01150056 FIG01150057: hypothetical protein +FIG01150057 Slr0867 protein +FIG01150058 FIG01150059: hypothetical protein +FIG01150059 FIG01150063: hypothetical protein +FIG01150063 FIG01150064: hypothetical protein +FIG01150064 FIG01150065: hypothetical protein +FIG01150066 FIG01150069: hypothetical protein +FIG01150069 FIG01150070: hypothetical protein +FIG01150070 FIG01150072: hypothetical protein +FIG01150072 Membrane protein PxcA, involved in light-induced proton extrusion +FIG01150073 FIG01150075: hypothetical protein +FIG01150075 FIG01150077: hypothetical protein +FIG01150077 FIG01150078: hypothetical protein +FIG01150078 FIG01150079: hypothetical protein +FIG01150079 FIG01150080: possible membrane protein +FIG01150080 FIG01150084: hypothetical protein +FIG01150084 FIG01150085: hypothetical protein +FIG01150085 FIG01150086: hypothetical protein +FIG01150086 FIG01150087: hypothetical protein +FIG01150087 possible ligand gated channel (GIC family) +FIG01150090 FIG01150092: hypothetical protein +FIG01150094 FIG01150103: hypothetical protein +FIG01150103 FIG01150107: hypothetical protein +FIG01150108 FIG01150110: hypothetical protein +FIG01150110 FIG01150112: hypothetical protein +FIG01150112 FIG01150114: hypothetical protein +FIG01150114 FIG01150116: hypothetical protein +FIG01150116 4'-phosphopantetheinyl transferase related protein +FIG01150117 Copper resistance protein CopC / Copper resistance protein CopD +FIG01150119 FIG01150122: hypothetical protein +FIG01150132 FIG01150133: hypothetical protein +FIG01150133 FIG01150134: hypothetical protein +FIG01150135 FIG01273856: hypothetical protein +FIG01150137 FIG01150138: hypothetical protein +FIG01150138 FIG01150139: hypothetical protein +FIG01150139 FIG01150140: hypothetical protein +FIG01150143 Possible Insulin-like growth factor binding pr +FIG01150145 FIG01150146: hypothetical protein +FIG01150146 FIG01150147: hypothetical protein +FIG01150147 FIG01150149: hypothetical protein +FIG01150152 FIG01150153: hypothetical protein +FIG01150153 FIG01150155: hypothetical protein +FIG01150155 FIG01150156: hypothetical protein +FIG01150156 FIG01150158: hypothetical protein +FIG01150158 FIG01150161: hypothetical protein +FIG01150170 FIG01150171: hypothetical protein +FIG01150171 FIG01150174: hypothetical protein +FIG01150174 FIG01150176: hypothetical protein +FIG01150176 possible sporulation protein SpoIID +FIG01150178 Domain of unknown function DUF1537 +FIG01150179 FIG01150182: hypothetical protein +FIG01150183 FIG01150184: hypothetical protein +FIG01150184 Type IV pilus biogenesis protein PilO +FIG01150187 FIG01150188: hypothetical protein +FIG01150188 FIG01150190: hypothetical protein +FIG01150190 FIG01150191: hypothetical protein +FIG01150191 FIG01150192: hypothetical protein +FIG01150192 FIG01150194: hypothetical protein +FIG01150197 FIG01150199: hypothetical protein +FIG01150199 FIG01150203: hypothetical protein +FIG01150203 FIG01150204: hypothetical protein +FIG01150206 FIG01150208: hypothetical protein +FIG01150208 FIG01150211: hypothetical protein +FIG01150215 FIG01150216: hypothetical protein +FIG01150216 FIG01150217: hypothetical protein +FIG01150218 FIG01150222: hypothetical protein +FIG01150222 FIG01150225: hypothetical protein +FIG01150225 FIG01150226: hypothetical protein +FIG01150226 FIG01150229: hypothetical protein +FIG01150229 FIG01150231: hypothetical protein +FIG01150236 FIG01150237: hypothetical protein +FIG01150240 FIG01150241: hypothetical protein +FIG01150246 Tlr0841 protein +FIG01150247 FIG01150251: hypothetical protein +FIG01150251 FIG01150252: hypothetical protein +FIG01150252 FIG01150253: hypothetical protein +FIG01150254 FIG01150255: hypothetical protein +FIG01150255 FIG01150256: hypothetical protein +FIG01150256 FIG01150259: hypothetical protein +FIG01150259 FIG01150261: hypothetical protein +FIG01150261 FIG01150262: hypothetical protein +FIG01150266 FIG01150267: hypothetical protein +FIG01150268 FIG01150271: hypothetical protein +FIG01150271 FIG01150273: hypothetical protein +FIG01150273 putative zinc ABC transporter, periplasmic zinc-binding protein +FIG01150276 FIG01150277: hypothetical protein +FIG01150277 FIG01150278: hypothetical protein +FIG01150278 FIG01150280: hypothetical protein +FIG01150280 FIG01150282: hypothetical protein +FIG01150282 FIG01150285: hypothetical protein +FIG01150285 FIG01150289: hypothetical protein +FIG01150289 FIG01150291: hypothetical protein +FIG01150291 FIG01150295: hypothetical protein +FIG01150295 FIG01150297: hypothetical protein +FIG01150297 FIG01150299: hypothetical protein +FIG01150299 FIG01150300: hypothetical protein +FIG01150300 FIG01150302: hypothetical protein +FIG01150303 FIG01150304: hypothetical protein +FIG01150309 FIG01150314: hypothetical protein +FIG01150314 Nutrient-stress induced DNA binding protein +FIG01150315 FIG01150316: hypothetical protein +FIG01150316 Possible DNA polymerase III beta subunit, C-te +FIG01150317 FIG01150319: hypothetical protein +FIG01150319 FIG01150321: hypothetical protein +FIG01150321 FIG01150325: hypothetical protein +FIG01150329 possible DNA mismatch repair proteins, MutS fa +FIG01150331 FIG01150332: hypothetical protein +FIG01150332 Tll2362 protein +FIG01150337 FIG01150338: hypothetical protein +FIG01150338 Mg2+ transport ATPase +FIG01150339 FIG01150340: hypothetical protein +FIG01150341 FIG01150342: hypothetical protein +FIG01150342 FIG01150344: hypothetical protein +FIG01150344 ABC exporter ATP-binding subunit, DevA family +FIG01150346 FIG01150348: hypothetical protein +FIG01150349 FIG01150354: hypothetical protein +FIG01150357 FIG01150358: hypothetical protein +FIG01150358 FIG01150360: hypothetical protein +FIG01150360 FIG01150363: hypothetical protein +FIG01150363 FIG01150365: hypothetical protein +FIG01150365 FIG01150366: hypothetical protein +FIG01150366 gas vesicle protein GvpN +FIG01150368 FIG01150369: hypothetical protein +FIG01150373 Thermonuclease homolog +FIG01150375 FIG01150377: hypothetical protein +FIG01150378 FIG01150381: hypothetical protein +FIG01150381 FIG01150382: hypothetical protein +FIG01150392 FIG01150393: hypothetical protein +FIG01150393 FIG01150394: hypothetical protein +FIG01150394 FIG01150395: hypothetical protein +FIG01150395 FIG01150402: hypothetical protein +FIG01150402 FIG01150403: hypothetical protein +FIG01150404 FIG01150405: hypothetical protein +FIG01150405 FIG01150407: hypothetical protein +FIG01150408 FIG01150409: hypothetical protein +FIG01150415 FIG01150416: hypothetical protein +FIG01150417 FIG01150420: hypothetical protein +FIG01150422 possible muramidase +FIG01150424 FIG01150427: hypothetical protein +FIG01150427 FIG01150429: hypothetical protein +FIG01150429 FIG01150432: hypothetical protein +FIG01150432 FIG01150433: hypothetical protein +FIG01150433 FIG01150435: hypothetical protein +FIG01150435 FIG01150439: hypothetical protein +FIG01150439 FIG01150443: hypothetical protein +FIG01150446 FIG01150448: hypothetical protein +FIG01150448 FIG01150449: hypothetical protein +FIG01150449 trunctated cyclic nucleotide-binding protein +FIG01150452 FIG01150453: hypothetical protein +FIG01150453 Type IV pilus biogenesis protein PilO +FIG01150454 FIG01150457: hypothetical protein +FIG01150457 FIG01150459: hypothetical protein +FIG01150459 FIG01150460: hypothetical protein +FIG01150461 conserved membrane protein, multidrug efflux associated +FIG01150462 FIG01150465: hypothetical protein +FIG01150465 FIG01150466: hypothetical protein +FIG01150466 RNA methyltransferase TrmH, group 1 +FIG01150468 cystine ABC transporter, cystine-binding protein +FIG01150469 FIG01150470: hypothetical protein +FIG01150470 FIG01150471: hypothetical protein +FIG01150471 FIG01150472: hypothetical protein +FIG01150472 FIG01150476: hypothetical protein +FIG01150477 FIG01150479: hypothetical protein +FIG01150479 FIG01150480: hypothetical protein +FIG01150486 FIG01150487: hypothetical protein +FIG01150489 Type IV pilus biogenesis protein PilQ +FIG01150492 FIG01150493: hypothetical protein +FIG01150493 ROK family sugar kinase +FIG01150495 FIG01150499: hypothetical protein +FIG01150499 FIG01150500: hypothetical protein +FIG01150500 FIG01150502: hypothetical protein +FIG01150505 FIG01150506: hypothetical protein +FIG01150506 FIG01150508: hypothetical protein +FIG01150508 FIG01150511: hypothetical protein +FIG01150511 HI0933-like protein +FIG01150515 FIG01150517: hypothetical protein +FIG01150517 FIG01150519: hypothetical protein +FIG01150519 phycobilisome degradation protein nblA, putative +FIG01150521 FIG01150523: hypothetical protein +FIG01150523 FIG01150524: hypothetical protein +FIG01150524 Alr1360 protein +FIG01150526 FIG01150531: hypothetical protein +FIG01150531 Putative multicomponent Na+:H+ antiporter subunit C +FIG01150534 FIG01150535: hypothetical protein +FIG01150535 FIG01150537: hypothetical protein +FIG01150537 FIG01150538: hypothetical protein +FIG01150538 Hypothetical protein, AT1G64980 homolog +FIG01150539 FIG01150542: hypothetical protein +FIG01150542 FIG01150543: hypothetical protein +FIG01150543 FIG01150544: hypothetical protein +FIG01150544 FIG01150546: hypothetical protein +FIG01150547 FIG01150548: hypothetical protein +FIG01150548 FIG01150551: hypothetical protein +FIG01150551 FIG01150556: hypothetical protein +FIG01150556 FIG01150557: hypothetical protein +FIG01150558 FIG01150560: hypothetical protein +FIG01150560 FIG01150561: hypothetical protein +FIG01150561 FIG01150562: hypothetical protein +FIG01150571 FIG01150573: hypothetical protein +FIG01150573 FIG01150574: hypothetical protein +FIG01150574 Putative 6-O-methylguanine DNA methyltransferase family protein +FIG01150575 FIG01150576: hypothetical protein +FIG01150576 FIG01150577: hypothetical protein +FIG01150577 FIG01150580: hypothetical protein +FIG01150580 FIG01150581: hypothetical protein +FIG01150581 Possible transcriptional regulator, luxR family +FIG01150584 Domain of unknown function DUF1537 +FIG01150588 possible Hepatitis C virus core protein +FIG01150589 FIG01150590: hypothetical protein +FIG01150591 Slr1307 protein +FIG01150599 FIG01150601: hypothetical protein +FIG01150601 FIG01150604: hypothetical protein +FIG01150613 FIG01150615: hypothetical protein +FIG01150615 FIG01150619: hypothetical protein +FIG01150621 FIG01150623: hypothetical protein +FIG01150623 FIG01150625: hypothetical protein +FIG01150626 Lactoylglutathione lyase family enzyme +FIG01150631 FIG01150634: hypothetical protein +FIG01150634 FIG01150635: hypothetical protein +FIG01150636 Possible DNA-binding response regulator +FIG01150641 FIG01150645: hypothetical protein +FIG01150645 FIG01150646: hypothetical protein +FIG01150649 FIG01150652: hypothetical protein +FIG01150652 FIG01150653: hypothetical protein +FIG01150659 heterocyst specific ABC-transporter, membrane fusion protein DevB homolog +FIG01150662 FIG01150664: hypothetical protein +FIG01150664 FIG01150666: hypothetical protein +FIG01150667 FIG01150668: hypothetical protein +FIG01150668 FIG01150669: hypothetical protein +FIG01150672 FIG01150673: hypothetical protein +FIG01150673 FIG01150676: hypothetical protein +FIG01150676 FIG01150677: hypothetical protein +FIG01150677 FIG01150678: hypothetical protein +FIG01150678 FIG01150679: hypothetical protein +FIG01150679 FIG01150682: hypothetical protein +FIG01150687 FIG01150688: hypothetical protein +FIG01150689 possible integrase/recombinase +FIG01150696 FIG01150701: hypothetical protein +FIG01150701 FIG01150703: hypothetical protein +FIG01150704 FIG01150706: hypothetical protein +FIG01150706 FIG01150708: hypothetical protein +FIG01150708 FIG01150709: hypothetical protein +FIG01150709 FIG01150713: hypothetical protein +FIG01150714 FIG01150715: hypothetical protein +FIG01150715 FIG01150718: hypothetical protein +FIG01150718 FIG01150719: hypothetical protein +FIG01150719 protein of unknown function DUF1036 +FIG01150720 FIG01150721: hypothetical protein +FIG01150723 FIG01150724: hypothetical protein +FIG01150731 Short-chain dehydrogenase/reductase family enzyme +FIG01150736 FIG01150737: hypothetical protein +FIG01150737 FIG01150739: hypothetical protein +FIG01150740 FIG01150741: hypothetical protein +FIG01150741 FIG01150744: hypothetical protein +FIG01150744 FIG01150745: hypothetical protein +FIG01150747 Gll1258 protein +FIG01150748 FIG01150750: hypothetical protein +FIG01150750 Sucrose-phosphate synthase (EC 2.4.1.14) +FIG01150752 FIG01150753: hypothetical protein +FIG01150754 Phage integrase family domain protein +FIG01150755 FIG01150756: hypothetical protein +FIG01150756 FIG01150757: hypothetical protein +FIG01150757 FIG01150760: hypothetical protein +FIG01150760 FIG01150761: hypothetical protein +FIG01150761 FIG01150769: hypothetical protein +FIG01150769 putative small GTP-binding protein +FIG01150770 Tll0580 protein +FIG01150785 FIG01150787: hypothetical protein +FIG01150787 Multisubunit Na+/H+ antiporter, MnhB subunit +FIG01150791 FIG01150795: hypothetical protein +FIG01150800 FIG01150802: hypothetical protein +FIG01150804 FIG01150805: hypothetical protein +FIG01150805 FIG01150808: hypothetical protein +FIG01150808 FIG01150809: hypothetical protein +FIG01150809 FIG01150811: hypothetical protein +FIG01150811 FIG01150812: hypothetical protein +FIG01150813 FIG01150814: hypothetical protein +FIG01150818 FIG01150819: hypothetical protein +FIG01150819 FIG01150820: hypothetical protein +FIG01150820 DNA-binding protein (EC 1.14.-.-) +FIG01150821 FIG01150825: hypothetical protein +FIG01150825 FIG01150827: hypothetical protein +FIG01150827 FIG01150829: hypothetical protein +FIG01150830 FIG01150834: hypothetical protein +FIG01150835 FIG01150838: hypothetical protein +FIG01150838 FIG01150840: hypothetical protein +FIG01150846 FIG01150852: hypothetical protein +FIG01150852 FIG01150854: hypothetical protein +FIG01150854 FIG01150858: hypothetical protein +FIG01150860 hypothetical protein +FIG01150863 Possible Villin headpiece domain +FIG01150864 FIG01150872: hypothetical protein +FIG01150872 FIG01150873: hypothetical protein +FIG01150873 CsoS1D +FIG01150874 FIG01150875: hypothetical protein +FIG01150875 All1763 protein +FIG01150876 FIG01150877: hypothetical protein +FIG01150880 FIG01150881: hypothetical protein +FIG01150884 Two-component response regulator, CheY-like receiver and wHTH DNA-binding domains +FIG01150886 FIG01150888: hypothetical protein +FIG01150890 FIG01150892: hypothetical protein +FIG01150892 FIG01150893: hypothetical protein +FIG01150893 FIG01150896: hypothetical protein +FIG01150896 FIG01150898: hypothetical protein +FIG01150898 FIG01150902: hypothetical protein +FIG01150908 FIG01150910: hypothetical protein +FIG01150910 FIG01150912: hypothetical protein +FIG01150912 FIG01150916: hypothetical protein +FIG01150916 FIG01150917: hypothetical protein +FIG01150917 FIG01150919: hypothetical protein +FIG01150919 FIG01150920: hypothetical protein +FIG01150920 Phycoerythrin beta chain; C-phycoerythrin class II beta chain +FIG01150921 FIG01150922: hypothetical protein +FIG01150927 Possible LysM domain precursor +FIG01150929 syc0111_d +FIG01150931 FIG01150932: hypothetical protein +FIG01150932 FIG01150933: hypothetical protein +FIG01150933 FIG01150936: hypothetical protein +FIG01150936 FIG01150939: hypothetical protein +FIG01150939 FIG01150940: hypothetical protein +FIG01150945 polar amino amino acid ABC transporter (PAAT) family, permease protein +FIG01150946 FIG01150947: hypothetical protein +FIG01150947 FIG01150948: hypothetical protein +FIG01150948 FIG01150949: hypothetical protein +FIG01150949 FIG01150951: hypothetical protein +FIG01150956 FIG01150957: hypothetical protein +FIG01150957 FIG01150959: hypothetical protein +FIG01150959 FIG01150961: hypothetical protein +FIG01150961 FIG01150963: hypothetical protein +FIG01150964 FIG01150965: hypothetical protein +FIG01150965 FIG01150967: hypothetical protein +FIG01150967 FIG01150970: hypothetical protein +FIG01150970 FIG01150971: hypothetical protein +FIG01150972 FIG01150976: hypothetical protein +FIG01150976 FIG01150978: hypothetical protein +FIG01150982 FIG01150983: hypothetical protein +FIG01150984 FIG01150987: hypothetical protein +FIG01150989 FIG01150990: hypothetical protein +FIG01150995 FIG01150996: hypothetical protein +FIG01150996 FIG01150997: hypothetical protein +FIG01150997 Metal-dependent protease of the PAD1/JAB1 superfamily +FIG01151000 FIG01151008: hypothetical protein +FIG01151008 FIG01151009: hypothetical protein +FIG01151009 Type IV pilus biogenesis protein PilN +FIG01151010 FIG01151013: hypothetical protein +FIG01151013 FIG01151015: hypothetical protein +FIG01151015 FIG01151016: hypothetical protein +FIG01151016 FIG01151020: hypothetical protein +FIG01151020 FIG01151025: hypothetical protein +FIG01151025 FIG01151026: hypothetical protein +FIG01151027 Sodium:galactoside symporter +FIG01151030 FIG01151032: hypothetical protein +FIG01151032 FIG01151034: hypothetical protein +FIG01151034 FIG01151038: hypothetical protein +FIG01151043 FIG01151046: hypothetical protein +FIG01151047 FIG01151049: hypothetical protein +FIG01151049 FIG01151051: hypothetical protein +FIG01151051 FIG01151057: hypothetical protein +FIG01151058 FIG01151060: hypothetical protein +FIG01151060 FIG01151063: hypothetical protein +FIG01151063 FIG01151065: hypothetical protein +FIG01151065 FIG01151068: hypothetical protein +FIG01151072 FIG01151075: hypothetical protein +FIG01151075 FIG01151078: hypothetical protein +FIG01151078 FIG01151079: hypothetical protein +FIG01151079 FIG01151085: hypothetical protein +FIG01151086 FIG01151088: hypothetical protein +FIG01151088 FIG01151089: hypothetical protein +FIG01151089 FIG01151092: hypothetical protein +FIG01151092 FIG01151094: hypothetical protein +FIG01151100 FIG01151101: hypothetical protein +FIG01151101 FIG01151102: hypothetical protein +FIG01151109 FIG01151111: hypothetical protein +FIG01151111 putative phycobilisome protein +FIG01151114 FIG01151115: hypothetical protein +FIG01151115 FIG01151116: hypothetical protein +FIG01151116 FIG01151118: hypothetical protein +FIG01151118 FIG01151119: hypothetical protein +FIG01151119 FIG01151121: hypothetical protein +FIG01151121 possible Ribosomal protein L36 +FIG01151127 FIG01151129: hypothetical protein +FIG01151129 FIG01151131: hypothetical protein +FIG01151132 FIG01151133: hypothetical protein +FIG01151135 possible N-acetylmuramoyl-L-alanine amidase +FIG01151141 FIG01151143: hypothetical protein +FIG01151143 FIG01151144: hypothetical protein +FIG01151144 FIG01151145: hypothetical protein +FIG01151146 FIG01151148: hypothetical protein +FIG01151148 FIG01151153: hypothetical protein +FIG01151159 FIG01151164: hypothetical protein +FIG01151167 Crp family transcriptional regulatory protein +FIG01151168 FIG01151172: hypothetical protein +FIG01151172 DnaK family protein +FIG01151174 FIG01151175: hypothetical protein +FIG01151184 FIG01151185: hypothetical protein +FIG01151185 FIG01151187: hypothetical protein +FIG01151200 FIG01151201: hypothetical protein +FIG01151201 FIG01151202: hypothetical protein +FIG01151205 FIG01151209: hypothetical protein +FIG01151209 Possible Helix-turn-helix protein, copG family +FIG01151211 FIG01151212: hypothetical protein +FIG01151213 GUN4-like protein Sll0558 +FIG01151218 FIG01151220: hypothetical protein +FIG01151220 FIG01151225: hypothetical protein +FIG01151225 FIG01151226: hypothetical protein +FIG01151226 FIG01151228: hypothetical protein +FIG01151229 FIG01151230: hypothetical protein +FIG01151230 FIG01151235: hypothetical protein +FIG01151235 FIG01151240: hypothetical protein +FIG01151240 Alr2768 protein +FIG01151244 FIG01151249: hypothetical protein +FIG01151249 FIG01151250: hypothetical protein +FIG01151252 FIG01151261: hypothetical protein +FIG01151261 FIG01151262: hypothetical protein +FIG01151262 FIG01151263: hypothetical protein +FIG01151264 FIG01151267: hypothetical protein +FIG01151267 FIG01151268: hypothetical protein +FIG01151270 All0852 protein +FIG01151273 Possible HAMP domain +FIG01151275 FIG01151280: hypothetical protein +FIG01151280 FIG01151281: hypothetical protein +FIG01151287 FIG01151288: hypothetical protein +FIG01151293 FIG01151294: possible membrane protein +FIG01151294 FIG01151296: hypothetical protein +FIG01151296 FIG01151297: hypothetical protein +FIG01151297 FIG01151298: hypothetical protein +FIG01151298 FIG01151299: hypothetical protein +FIG01151306 FIG01151310: hypothetical protein +FIG01151310 FIG01151312: hypothetical protein +FIG01151313 FIG01151314: hypothetical protein +FIG01151319 FIG01151321: hypothetical protein +FIG01151324 Bacterial regulatory proteins, ArsR family +FIG01151327 Inactivated Zn-dependent hydrolase of the beta-lactamase fold +FIG01151328 FIG01151330: hypothetical protein +FIG01151332 FIG01151334: hypothetical protein +FIG01151334 FIG01151338: hypothetical protein +FIG01151339 FIG01151340: hypothetical protein +FIG01151340 FIG01151348: hypothetical protein +FIG01151348 FIG01151353: hypothetical protein +FIG01151353 FIG01151356: hypothetical protein +FIG01151359 FIG01151362: hypothetical protein +FIG01151362 FIG01151364: hypothetical protein +FIG01151364 FIG01151366: hypothetical protein +FIG01151366 FIG01151367: hypothetical protein +FIG01151367 FIG01151368: hypothetical protein +FIG01151372 FIG01151375: hypothetical protein +FIG01151375 FIG01151376: hypothetical protein +FIG01151376 FIG01154502: hypothetical protein +FIG01151383 FIG01151385: hypothetical protein +FIG01151385 FIG01151393: hypothetical protein +FIG01151393 FIG01151395: hypothetical protein +FIG01151400 FIG01151403: hypothetical protein +FIG01151403 FIG01151406: hypothetical protein +FIG01151411 FIG01151413: hypothetical protein +FIG01151414 D-beta-hydroxybutyrate dehydrogenase (EC 1.1.1.30) +FIG01151417 FIG01151419: hypothetical protein +FIG01151419 Cellulase (EC 3.2.1.4) +FIG01151423 FIG01151425: hypothetical protein +FIG01151425 FIG01151427: hypothetical protein +FIG01151427 FIG01151428: hypothetical protein +FIG01151428 FIG01151429: hypothetical protein +FIG01151430 FIG01151433: hypothetical protein +FIG01151433 FIG01151434: hypothetical protein +FIG01151435 FIG01151436: hypothetical protein +FIG01151437 FIG01151438: hypothetical protein +FIG01151455 FIG01151456: hypothetical protein +FIG01151465 FIG01151469: hypothetical protein +FIG01151469 FIG01151470: hypothetical protein +FIG01151476 FIG01151477: hypothetical protein +FIG01151477 FIG01151478: hypothetical protein +FIG01151478 FIG01151479: hypothetical protein +FIG01151479 FIG01151485: hypothetical protein +FIG01151485 FIG01151490: hypothetical protein +FIG01151495 FIG01151500: hypothetical protein +FIG01151500 FIG01151501: hypothetical protein +FIG01151501 FIG01151503: hypothetical protein +FIG01151503 FIG01151504: hypothetical protein +FIG01151504 FIG01151505: hypothetical protein +FIG01151506 FIG01151508: hypothetical protein +FIG01151508 FIG01151510: hypothetical protein +FIG01151511 FIG01151512: hypothetical protein +FIG01151514 FIG01151520: hypothetical protein +FIG01151530 FIG01151531: hypothetical protein +FIG01151531 Bacterial regulatory proteins, Crp family +FIG01151533 cellulose synthase, catalytic subunit-like protein +FIG01151535 FIG01151537: hypothetical protein +FIG01151542 FIG01151547: hypothetical protein +FIG01151547 FIG01151551: hypothetical protein +FIG01151557 Tlr1838 protein +FIG01151558 FIG01151563: hypothetical protein +FIG01151565 FIG01151569: hypothetical protein +FIG01151569 FIG01151570: hypothetical protein +FIG01151570 FIG01151576: hypothetical protein +FIG01151576 FIG01151578: hypothetical protein +FIG01151584 FIG01151585: hypothetical protein +FIG01151585 FIG01151586: hypothetical protein +FIG01151586 FIG01151591: hypothetical protein +FIG01151591 FIG01151592: hypothetical protein +FIG01151592 FIG01151593: hypothetical protein +FIG01151593 Alr7636 protein +FIG01151594 FIG01151596: hypothetical protein +FIG01151597 FIG01151598: hypothetical protein +FIG01151599 FIG01151602: hypothetical protein +FIG01151602 Alr3505 protein +FIG01151603 FIG01151604: hypothetical protein +FIG01151609 FIG01151617: hypothetical protein +FIG01151617 FIG01151618: hypothetical protein +FIG01151620 FIG01151621: hypothetical protein +FIG01151621 Aluminum resistance protein homolog +FIG01151623 FIG01151624: hypothetical protein +FIG01151624 FIG01151630: hypothetical protein +FIG01151630 FIG01151631: hypothetical protein +FIG01151631 FIG01151632: hypothetical protein +FIG01151632 syc0016_d +FIG01151635 FIG01151638: hypothetical protein +FIG01151639 FIG01151640: hypothetical protein +FIG01151640 FIG01151641: hypothetical protein +FIG01151641 FIG01151645: hypothetical protein +FIG01151648 FIG01151650: hypothetical protein +FIG01151650 FIG01151651: hypothetical protein +FIG01151651 FIG01151653: hypothetical protein +FIG01151657 FIG01151663: hypothetical protein +FIG01151663 FIG01151667: hypothetical protein +FIG01151667 FIG01151669: hypothetical protein +FIG01151669 FIG01151671: hypothetical protein +FIG01151673 FIG01151676: hypothetical protein +FIG01151677 FIG01151681: hypothetical protein +FIG01151681 Response regulator receiver domain +FIG01151685 FIG01151686: hypothetical protein +FIG01151686 FIG01151687: hypothetical protein +FIG01151690 FIG01151691: hypothetical protein +FIG01151691 FIG01151693: hypothetical protein +FIG01151702 FIG01151704: hypothetical protein +FIG01151707 FIG01151709: hypothetical protein +FIG01151709 FIG01151713: hypothetical protein +FIG01151713 FIG01151714: hypothetical protein +FIG01151715 FIG01151720: hypothetical protein +FIG01151720 small mechanosensitive ion channel, MscS family protein +FIG01151724 FIG01151728: hypothetical protein +FIG01151728 FIG01151729: hypothetical protein +FIG01151729 FIG01151733: hypothetical protein +FIG01151734 FIG01151742: hypothetical protein +FIG01151742 FIG01151743: hypothetical protein +FIG01151743 Polysaccharide biosynthesis protein CapD +FIG01151746 FIG01151747: hypothetical protein +FIG01151749 FIG01151750: hypothetical protein +FIG01151750 FIG01151751: hypothetical protein +FIG01151754 transcriptional regulator, AraC family protein +FIG01151759 FIG01151761: hypothetical protein +FIG01151761 FIG01151762: hypothetical protein +FIG01151767 FIG01151768: hypothetical protein +FIG01151768 FIG01151770: hypothetical protein +FIG01151774 FIG01151775: hypothetical protein +FIG01151778 FIG01151781: hypothetical protein +FIG01151784 FIG01151785: hypothetical protein +FIG01151785 FIG01151788: hypothetical protein +FIG01151788 FIG01151791: hypothetical protein +FIG01151791 FIG01151795: hypothetical protein +FIG01151796 FIG01151797: hypothetical protein +FIG01151798 FIG01151803: hypothetical protein +FIG01151806 FIG01151811: hypothetical protein +FIG01151811 FIG01151812: hypothetical protein +FIG01151814 FIG01151815: hypothetical protein +FIG01151815 FIG01151818: hypothetical protein +FIG01151818 FIG01151820: hypothetical protein +FIG01151820 FIG01151824: hypothetical protein +FIG01151825 All3939 protein +FIG01151826 Putative Multisubunit sodium/proton antiporter, MrpE subunit +FIG01151828 FIG01151831: hypothetical protein +FIG01151832 FIG01151834: hypothetical protein +FIG01151835 FIG01151836: hypothetical protein +FIG01151836 FIG01151838: hypothetical protein +FIG01151838 FIG01151839: hypothetical protein +FIG01151839 FIG01151840: hypothetical protein +FIG01151840 FIG01151843: hypothetical protein +FIG01151843 FIG01151847: hypothetical protein +FIG01151849 FIG01151853: hypothetical protein +FIG01151853 FIG01151854: hypothetical protein +FIG01151858 FIG01151860: hypothetical protein +FIG01151860 FIG01151861: hypothetical protein +FIG01151861 FIG01151866: hypothetical protein +FIG01151866 FIG01151868: hypothetical protein +FIG01151869 FIG01151872: hypothetical protein +FIG01151872 FIG01151876: hypothetical protein +FIG01151876 FIG01151877: hypothetical protein +FIG01151877 FIG01151879: hypothetical protein +FIG01151883 FIG01151885: hypothetical protein +FIG01151885 FIG01151886: hypothetical protein +FIG01151886 FIG01151890: hypothetical protein +FIG01151890 FIG01151892: hypothetical protein +FIG01151893 FIG01151894: hypothetical protein +FIG01151894 FIG01151898: hypothetical protein +FIG01151898 FIG01151904: hypothetical protein +FIG01151905 FIG01151909: hypothetical protein +FIG01151909 FIG01151910: hypothetical protein +FIG01151915 FIG01151916: hypothetical protein +FIG01151917 FIG01151918: hypothetical protein +FIG01151918 FIG01151921: hypothetical protein +FIG01151921 FIG01151922: hypothetical protein +FIG01151928 FIG01151929: hypothetical protein +FIG01151931 FIG01151934: hypothetical protein +FIG01151934 FIG01151935: hypothetical protein +FIG01151935 FIG01151942: hypothetical protein +FIG01151942 FIG01151948: hypothetical protein +FIG01151948 FIG01151952: hypothetical protein +FIG01151954 FIG01151956: hypothetical protein +FIG01151956 All1587 protein +FIG01151959 FIG01151960: hypothetical protein +FIG01151960 FIG01151961: hypothetical protein +FIG01151962 FIG01151966: hypothetical protein +FIG01151966 FIG01151967: hypothetical protein +FIG01151967 FIG01151975: hypothetical protein +FIG01151979 FIG01151981: hypothetical protein +FIG01151983 FIG01151987: hypothetical protein +FIG01151987 FIG01151988: hypothetical protein +FIG01151991 FIG01151992: hypothetical protein +FIG01151992 FIG01151996: hypothetical protein +FIG01151996 FIG01152000: hypothetical protein +FIG01152000 FIG01152003: hypothetical protein +FIG01152003 Protein yhhW +FIG01152004 FIG01152006: hypothetical protein +FIG01152006 FIG01152007: hypothetical protein +FIG01152007 FIG01152009: hypothetical protein +FIG01152009 FIG01152012: hypothetical protein +FIG01152014 FIG01152016: hypothetical protein +FIG01152016 FIG01152018: hypothetical protein +FIG01152018 FIG01152019: hypothetical protein +FIG01152019 anti-sigma-factor antagonist +FIG01152024 FIG01152025: hypothetical protein +FIG01152025 FIG01152029: hypothetical protein +FIG01152034 FIG01152036: hypothetical protein +FIG01152036 FIG01152038: possible membrane protein +FIG01152038 FIG01152040: hypothetical protein +FIG01152040 FIG01152043: hypothetical protein +FIG01152067 FIG01152070: hypothetical protein +FIG01152070 FIG01152073: hypothetical protein +FIG01152073 FIG01152077: hypothetical protein +FIG01152077 FIG01152079: hypothetical protein +FIG01152079 FIG01152080: hypothetical protein +FIG01152082 Iron(III)-transport ATP-binding protein sfuC +FIG01152092 FIG01152098: hypothetical protein +FIG01152104 FIG01152107: hypothetical protein +FIG01152107 FIG01152109: hypothetical protein +FIG01152109 FIG01152111: hypothetical protein +FIG01152111 Carbon dioxide concentrating mechanism protein CcmK homolog +FIG01152117 FIG01152118: hypothetical protein +FIG01152118 product possible regulatory protein, luxR family +FIG01152120 FIG01152121: hypothetical protein +FIG01152123 FIG01152124: hypothetical protein +FIG01152125 FIG01152127: hypothetical protein +FIG01152128 FIG01152131: hypothetical protein +FIG01152131 FIG01152133: hypothetical protein +FIG01152133 COG5483: Uncharacterized conserved protein +FIG01152137 FIG01152141: hypothetical protein +FIG01152143 FIG01152144: hypothetical protein +FIG01152144 FIG01152145: hypothetical protein +FIG01152145 FIG01152147: hypothetical protein +FIG01152147 Protein tyrosine phosphatase, catalytic region +FIG01152155 FIG01152158: hypothetical protein +FIG01152158 FIG01152159: hypothetical protein +FIG01152159 FIG01152160: hypothetical protein +FIG01152160 FIG01152164: hypothetical protein +FIG01152164 FIG01152165: hypothetical protein +FIG01152165 FIG01152166: hypothetical protein +FIG01152171 FIG01152172: hypothetical protein +FIG01152172 FIG01152173: hypothetical protein +FIG01152175 FIG01152176: hypothetical protein +FIG01152176 FIG01152183: hypothetical protein +FIG01152186 FIG01152188: hypothetical protein +FIG01152190 FIG01152191: hypothetical protein +FIG01152191 FIG01152197: hypothetical protein +FIG01152197 FIG01152199: hypothetical protein +FIG01152201 FIG01152204: hypothetical protein +FIG01152204 Pyridoxamine 5'-phosphate oxidase (EC 1.4.3.5) +FIG01152205 FIG01152206: hypothetical protein +FIG01152208 FIG01152209: hypothetical protein +FIG01152209 FIG01152210: hypothetical protein +FIG01152210 FIG01152211: hypothetical protein +FIG01152211 FIG01152213: hypothetical protein +FIG01152213 FIG01152218: hypothetical protein +FIG01152220 FIG01152221: hypothetical protein +FIG01152221 syc0062_c +FIG01152222 FIG01152223: hypothetical protein +FIG01152223 syc1984_c +FIG01152226 FIG01152232: hypothetical protein +FIG01152232 FIG01152236: hypothetical protein +FIG01152238 FIG01152239: hypothetical protein +FIG01152239 All5102 protein +FIG01152240 FIG01152249: hypothetical protein +FIG01152249 FIG01152253: hypothetical protein +FIG01152253 FIG01152254: hypothetical protein +FIG01152259 FIG01152261: hypothetical protein +FIG01152261 Possible Zinc finger, C3HC4 type (RING finger) precursor +FIG01152262 FIG01152264: hypothetical protein +FIG01152264 FIG01152266: hypothetical protein +FIG01152266 FIG01152267: hypothetical protein +FIG01152267 FIG01152269: hypothetical protein +FIG01152269 FIG01152271: hypothetical protein +FIG01152273 FIG01152276: hypothetical protein +FIG01152277 FIG01152278: hypothetical protein +FIG01152278 FIG01152281: hypothetical protein +FIG01152281 FIG01152285: hypothetical protein +FIG01152285 FIG01152287: hypothetical protein +FIG01152289 Phosphate transporter related protein +FIG01152290 FIG01152293: hypothetical protein +FIG01152318 FIG01152319: hypothetical protein +FIG01152320 FIG01152325: hypothetical protein +FIG01152331 FIG01152334: hypothetical protein +FIG01152340 FIG01152341: hypothetical protein +FIG01152342 Phycobilisome linker polypeptide +FIG01152345 FIG01152346: hypothetical protein +FIG01152346 FIG01152348: hypothetical protein +FIG01152353 FIG01152355: hypothetical protein +FIG01152360 All3087 protein +FIG01152369 FIG01152371: hypothetical protein +FIG01152371 FIG01152375: hypothetical protein +FIG01152375 CBS:Protein of unknown function DUF21 +FIG01152376 FIG01152379: hypothetical protein +FIG01152380 FIG01152386: hypothetical protein +FIG01152386 FIG01152390: hypothetical protein +FIG01152390 FIG01152391: hypothetical protein +FIG01152391 FIG01152392: hypothetical protein +FIG01152392 FIG01152395: hypothetical protein +FIG01152398 FIG01152399: hypothetical protein +FIG01152404 FIG01152407: hypothetical protein +FIG01152410 FIG01152411: hypothetical protein +FIG01152411 FIG01152412: hypothetical protein +FIG01152412 FIG01152416: hypothetical protein +FIG01152416 FIG01152417: hypothetical protein +FIG01152419 FIG01152420: hypothetical protein +FIG01152420 Pyridoxamine 5'-phosphate oxidase (EC 1.4.3.5) +FIG01152422 FIG01152424: hypothetical protein +FIG01152427 FIG01152428: hypothetical protein +FIG01152428 FIG01152429: hypothetical protein +FIG01152429 FIG01152433: hypothetical protein +FIG01152433 FIG01152439: hypothetical protein +FIG01152439 FIG01152440: hypothetical protein +FIG01152440 FIG01152442: hypothetical protein +FIG01152443 FIG01152445: hypothetical protein +FIG01152451 FIG01152457: hypothetical protein +FIG01152458 FIG01152465: hypothetical protein +FIG01152465 FIG01152466: hypothetical protein +FIG01152470 FIG01152471: hypothetical protein +FIG01152471 FIG01152474: hypothetical protein +FIG01152474 FIG01152476: hypothetical protein +FIG01152476 FIG01152480: hypothetical protein +FIG01152480 FIG01152483: hypothetical protein +FIG01152483 FIG01152486: hypothetical protein +FIG01152486 FIG01152487: hypothetical protein +FIG01152487 FIG01152490: hypothetical protein +FIG01152490 hypothetical protein +FIG01152497 FIG01152498: hypothetical protein +FIG01152498 FIG01152501: hypothetical protein +FIG01152507 FIG01152510: hypothetical protein +FIG01152514 FIG01152515: hypothetical protein +FIG01152516 FIG01152517: hypothetical protein +FIG01152517 FIG01152518: hypothetical protein +FIG01152518 FIG01152519: hypothetical protein +FIG01152519 Amylo-alpha-1,6-glucosidase +FIG01152527 FIG01152529: hypothetical protein +FIG01152529 FIG01152530: hypothetical protein +FIG01152530 FIG01152534: hypothetical protein +FIG01152535 FIG01152539: hypothetical protein +FIG01152539 FIG01152547: hypothetical protein +FIG01152547 FIG01152550: hypothetical protein +FIG01152550 FIG01152553: hypothetical protein +FIG01152553 FIG01152554: hypothetical protein +FIG01152554 FIG01152556: hypothetical protein +FIG01152564 FIG01152565: hypothetical protein +FIG01152565 FIG01152566: hypothetical protein +FIG01152578 FIG01152583: hypothetical protein +FIG01152583 FIG01152585: hypothetical protein +FIG01152591 FIG01155130: hypothetical protein +FIG01152599 FIG01152602: hypothetical protein +FIG01152602 FIG01152604: hypothetical protein +FIG01152606 FIG01152613: hypothetical protein +FIG01152613 FIG01152614: hypothetical protein +FIG01152618 FIG01152620: hypothetical protein +FIG01152620 FIG01152627: hypothetical protein +FIG01152633 DnaJ domain containing protein +FIG01152647 FIG01152650: hypothetical protein +FIG01152650 FIG01152652: hypothetical protein +FIG01152654 FIG01152655: hypothetical protein +FIG01152661 FIG01152662: hypothetical protein +FIG01152668 FIG01152673: hypothetical protein +FIG01152677 gas vesicle protein J +FIG01152680 carotenoid binding protein +FIG01152687 FIG01152690: hypothetical protein +FIG01152695 FIG01152698: hypothetical protein +FIG01152698 FIG01152703: hypothetical protein +FIG01152703 FIG01152709: hypothetical protein +FIG01152711 FIG01152712: hypothetical protein +FIG01152712 FIG01152714: hypothetical protein +FIG01152715 FIG01152716: hypothetical protein +FIG01152716 FIG01152717: hypothetical protein +FIG01152717 FIG01152722: hypothetical protein +FIG01152722 FIG01152724: hypothetical protein +FIG01152724 FIG01152726: hypothetical protein +FIG01152726 FIG01152729: hypothetical protein +FIG01152732 FIG01152733: hypothetical protein +FIG01152738 FIG01152740: hypothetical protein +FIG01152741 FIG01152743: hypothetical protein +FIG01152743 FIG01152744: hypothetical protein +FIG01152744 FIG01152747: hypothetical protein +FIG01152747 FIG01152750: hypothetical protein +FIG01152750 FIG01152751: hypothetical protein +FIG01152754 FIG01152755: hypothetical protein +FIG01152755 FIG01152756: hypothetical protein +FIG01152756 superfamily I DNA/RNA helicase +FIG01152757 FIG01152759: hypothetical protein +FIG01152759 FIG01152762: hypothetical protein +FIG01152762 FIG01152767: hypothetical protein +FIG01152767 FIG01152768: hypothetical protein +FIG01152768 FIG01152769: hypothetical protein +FIG01152771 FIG01152774: hypothetical protein +FIG01152776 FIG01152777: hypothetical protein +FIG01152780 Sll0858 protein +FIG01152781 FIG01152782: hypothetical protein +FIG01152782 FIG01152783: hypothetical protein +FIG01152787 FIG01152788: hypothetical protein +FIG01152788 FIG01152789: hypothetical protein +FIG01152789 FIG01152790: hypothetical protein +FIG01152790 FIG01152793: hypothetical protein +FIG01152794 FIG01152796: hypothetical protein +FIG01152796 FIG01152798: hypothetical protein +FIG01152798 FIG01152801: hypothetical protein +FIG01152801 FIG01152802: hypothetical protein +FIG01152802 FIG01152804: hypothetical protein +FIG01152804 FIG01152807: hypothetical protein +FIG01152807 FIG01152809: hypothetical protein +FIG01152809 FIG01152811: hypothetical protein +FIG01152811 FIG01152812: hypothetical protein +FIG01152812 FIG01152813: hypothetical protein +FIG01152817 Aldo/keto reductase family +FIG01152827 FIG01152828: hypothetical protein +FIG01152828 transporter, auxin efflux carrier (AEC) family +FIG01152833 FIG01152836: hypothetical protein +FIG01152843 FIG01152844: hypothetical protein +FIG01152847 FIG01152849: hypothetical protein +FIG01152849 syc2115_d +FIG01152851 YCF9, conserved hypothetical protein +FIG01152859 FIG01152863: hypothetical protein +FIG01152863 FIG01152864: hypothetical protein +FIG01152864 nuclease (SNase-like) protein +FIG01152870 FIG01152871: hypothetical protein +FIG01152873 FIG01152876: hypothetical protein +FIG01152876 FIG01152883: hypothetical protein +FIG01152883 FIG01152889: hypothetical protein +FIG01152889 Uncharacterized protein AF2050 (similar to YjbQ) +FIG01152890 FIG01152893: hypothetical protein +FIG01152897 syc1025_d +FIG01152900 Slr0482 protein +FIG01152904 FIG01152907: hypothetical protein +FIG01152908 FIG01152910: hypothetical protein +FIG01152910 FIG01152913: hypothetical protein +FIG01152915 FIG01152920: hypothetical protein +FIG01152920 FIG01152921: hypothetical protein +FIG01152921 probable serine protease inhibitor +FIG01152923 possible Histidine kinase-, DNA gyrase B-, phy +FIG01152927 FIG01152930: hypothetical protein +FIG01152930 FIG01152933: hypothetical protein +FIG01152933 FIG01152934: hypothetical protein +FIG01152934 FIG01152935: hypothetical protein +FIG01152938 FIG01152941: hypothetical protein +FIG01152943 Protein often near L-alanine-DL-glutamate epimerase (cell wall recycling) +FIG01152946 FIG01152948: hypothetical protein +FIG01152949 Tlr1926 protein +FIG01152951 putative dGTP pyrophosphohydrolase, mutT +FIG01152953 FIG01152954: hypothetical protein +FIG01152954 FIG01152956: hypothetical protein +FIG01152963 FIG01152966: hypothetical protein +FIG01152966 FIG01152967: hypothetical protein +FIG01152967 FIG01152969: hypothetical protein +FIG01152969 FIG01152970: hypothetical protein +FIG01152970 FIG01152974: hypothetical protein +FIG01152977 FIG01152978: hypothetical protein +FIG01152978 FIG01152985: hypothetical protein +FIG01152985 syc1901_d +FIG01152987 FIG01152995: hypothetical protein +FIG01153001 FIG01153004: hypothetical protein +FIG01153004 FIG01153005: hypothetical protein +FIG01153005 FIG01153009: hypothetical protein +FIG01153009 FIG01153015: hypothetical protein +FIG01153015 FIG01153016: hypothetical protein +FIG01153016 Glycerol uptake facilitator and related permeases (Major Intrinsic Protein Family) +FIG01153017 FIG01153018: hypothetical protein +FIG01153018 FIG01153020: hypothetical protein +FIG01153020 Slr1413 protein +FIG01153022 FIG01153025: hypothetical protein +FIG01153030 Possible copper binding proteins, plastocyanin +FIG01153036 FIG01153037: hypothetical protein +FIG01153039 FIG01153040: hypothetical protein +FIG01153040 possible DNA-binding response regulator +FIG01153042 FIG01153044: hypothetical protein +FIG01153045 CpcD/allophycocyanin linker domain protein +FIG01153047 FIG01153048: hypothetical protein +FIG01153052 FIG01153053: hypothetical protein +FIG01153053 FIG01153055: hypothetical protein +FIG01153061 FIG01153065: hypothetical protein +FIG01153071 FIG01153075: hypothetical protein +FIG01153079 FIG01153081: hypothetical protein +FIG01153081 FIG01153083: hypothetical protein +FIG01153083 FIG01153087: hypothetical protein +FIG01153089 FIG01153091: hypothetical protein +FIG01153091 FIG01153092: hypothetical protein +FIG01153105 FIG01153110: hypothetical protein +FIG01153110 FIG01153114: hypothetical protein +FIG01153114 FIG01153115: hypothetical protein +FIG01153116 FIG01153119: hypothetical protein +FIG01153119 FIG01153125: hypothetical protein +FIG01153125 FIG01153127: hypothetical protein +FIG01153145 FIG01153146: hypothetical protein +FIG01153148 FIG01153149: hypothetical protein +FIG01153150 FIG01153152: hypothetical protein +FIG01153152 FIG01153156: hypothetical protein +FIG01153156 FIG01153158: hypothetical protein +FIG01153158 FIG01153162: hypothetical protein +FIG01153174 FIG01153181: hypothetical protein +FIG01153182 FIG01153183: hypothetical protein +FIG01153183 FIG01153185: hypothetical protein +FIG01153185 FIG01153186: hypothetical protein +FIG01153186 FIG01153190: hypothetical protein +FIG01153190 FIG01153192: hypothetical protein +FIG01153192 FIG01153193: hypothetical protein +FIG01153193 FIG01153203: hypothetical protein +FIG01153208 FIG01153211: hypothetical protein +FIG01153211 FIG01153212: hypothetical protein +FIG01153212 FIG01153214: hypothetical protein +FIG01153214 FIG01153215: hypothetical protein +FIG01153215 FIG01153216: hypothetical protein +FIG01153216 FIG01153217: hypothetical protein +FIG01153230 SPINDLY protein +FIG01153239 FIG01153241: hypothetical protein +FIG01153241 Putative PAS domain protein +FIG01153246 FIG01153248: hypothetical protein +FIG01153250 FIG01153254: hypothetical protein +FIG01153257 FIG01153259: hypothetical protein +FIG01153259 FIG01153261: hypothetical protein +FIG01153261 FIG01153262: hypothetical protein +FIG01153262 FIG01153267: hypothetical protein +FIG01153272 Lipase/esterase (EC 3.1.1.-) +FIG01153273 FIG01153276: hypothetical protein +FIG01153286 Pyridoxamine 5'-phosphate oxidase (EC 1.4.3.5) +FIG01153288 FIG01153291: hypothetical protein +FIG01153301 FIG01153302: hypothetical protein +FIG01153302 FIG01153304: hypothetical protein +FIG01153305 FIG01153306: hypothetical protein +FIG01153306 FIG01153310: hypothetical protein +FIG01153321 FIG01153323: hypothetical protein +FIG01153323 type IV pilin, putative +FIG01153328 FIG01153329: hypothetical protein +FIG01153329 FIG01153330: hypothetical protein +FIG01153330 FIG01153335: hypothetical protein +FIG01153344 FIG01153346: hypothetical protein +FIG01153346 Slr1794 protein +FIG01153350 FIG01153353: hypothetical protein +FIG01153360 FIG01153365: hypothetical protein +FIG01153369 FIG01153374: hypothetical protein +FIG01153374 FIG01153376: hypothetical protein +FIG01153376 FIG01153377: hypothetical protein +FIG01153384 FIG01153385: hypothetical protein +FIG01153387 FIG01153391: hypothetical protein +FIG01153395 FIG01153398: hypothetical protein +FIG01153398 FIG01153399: hypothetical protein +FIG01153399 FIG01153403: hypothetical protein +FIG01153403 Tlr1563 protein +FIG01153405 FIG01153407: hypothetical protein +FIG01153407 FIG01153408: hypothetical protein +FIG01153409 FIG01153410: hypothetical protein +FIG01153410 FIG01153411: hypothetical protein +FIG01153411 FIG01153413: hypothetical protein +FIG01153414 Predicted ester cyclase +FIG01153417 FIG01153418: hypothetical protein +FIG01153424 FIG01153426: hypothetical protein +FIG01153428 FIG01153429: hypothetical protein +FIG01153441 FIG01153444: hypothetical protein +FIG01153444 FIG01153445: hypothetical protein +FIG01153445 FIG01153447: hypothetical protein +FIG01153453 FIG01153455: hypothetical protein +FIG01153455 FIG01153457: hypothetical protein +FIG01153457 FIG01153460: hypothetical protein +FIG01153462 FIG01153464: hypothetical protein +FIG01153480 Glr1754 protein +FIG01153481 FIG01153485: hypothetical protein +FIG01153493 FIG01153496: hypothetical protein +FIG01153497 FIG01153498: hypothetical protein +FIG01153498 FIG01153499: hypothetical protein +FIG01153499 FIG01153500: hypothetical protein +FIG01153500 FIG01153502: hypothetical protein +FIG01153507 FIG01153514: hypothetical protein +FIG01153515 FIG01153520: hypothetical protein +FIG01153520 FIG01153522: hypothetical protein +FIG01153525 FIG01153531: hypothetical protein +FIG01153543 FIG01153544: hypothetical protein +FIG01153545 hypothetical protein +FIG01153561 FIG01153564: hypothetical protein +FIG01153565 FIG01153570: hypothetical protein +FIG01153570 FIG01153571: hypothetical protein +FIG01153571 FIG01153575: hypothetical protein +FIG01153575 FIG01153577: hypothetical protein +FIG01153577 FIG01153582: hypothetical protein +FIG01153589 FIG01153591: hypothetical protein +FIG01153591 FIG01153595: hypothetical protein +FIG01153597 All0405 protein +FIG01153605 FIG01153607: hypothetical protein +FIG01153608 FIG01153609: hypothetical protein +FIG01153609 FIG01153610: hypothetical protein +FIG01153610 Major membrane protein I +FIG01153615 FIG01153618: hypothetical protein +FIG01153618 FIG01153620: hypothetical protein +FIG01153630 FIG01153632: hypothetical protein +FIG01153634 FIG01153639: hypothetical protein +FIG01153642 FIG01153646: hypothetical protein +FIG01153646 FIG01153649: hypothetical protein +FIG01153649 FIG01153652: hypothetical protein +FIG01153660 FIG01153661: hypothetical protein +FIG01153665 FIG01153669: hypothetical protein +FIG01153678 FIG01153682: hypothetical protein +FIG01153682 FIG01153686: hypothetical protein +FIG01153686 possible transporter, MFS family protein +FIG01153691 FIG01153694: hypothetical protein +FIG01153707 FIG01153710: hypothetical protein +FIG01153710 FIG01153711: hypothetical protein +FIG01153711 FIG01153712: hypothetical protein +FIG01153716 FIG01153718: hypothetical protein +FIG01153718 FIG01153719: hypothetical protein +FIG01153719 FIG01153720: hypothetical protein +FIG01153720 FIG01153722: hypothetical protein +FIG01153722 FIG01153724: hypothetical protein +FIG01153724 FIG01153725: hypothetical protein +FIG01153758 FIG01153760: hypothetical protein +FIG01153775 FIG01153776: hypothetical protein +FIG01153776 FIG01153777: hypothetical protein +FIG01153783 Protein serine/threonine phosphatase( EC:3.1.3.16 ) +FIG01153790 FIG01153802: hypothetical protein +FIG01153816 FIG01153818: hypothetical protein +FIG01153818 FIG01153820: hypothetical protein +FIG01153821 FIG01153822: hypothetical protein +FIG01153822 FIG01153823: hypothetical protein +FIG01153823 Slr0841 protein +FIG01153826 FIG01153832: hypothetical protein +FIG01153840 FIG01153842: hypothetical protein +FIG01153853 FIG01153854: hypothetical protein +FIG01153854 PAP fibrillin +FIG01153872 REG-2-like, HAD superfamily (subfamily IA) hydrolase +FIG01153873 FIG01153876: hypothetical protein +FIG01153888 FIG01153893: hypothetical protein +FIG01153893 FIG01153895: hypothetical protein +FIG01153898 FIG01153900: hypothetical protein +FIG01153901 Tsr0968 protein +FIG01153908 partial phage integrase +FIG01153909 FIG01153914: hypothetical protein +FIG01153920 possible rare lipoprotein A +FIG01153926 FIG01153927: hypothetical protein +FIG01153940 FIG01153941: hypothetical protein +FIG01153941 FIG01153943: hypothetical protein +FIG01153944 FIG01153945: hypothetical protein +FIG01153948 FIG01153952: hypothetical protein +FIG01153952 FIG01153953: hypothetical protein +FIG01153953 FIG01153960: hypothetical protein +FIG01153961 FIG01153966: hypothetical protein +FIG01153966 FIG01153967: hypothetical protein +FIG01153973 FIG01153976: hypothetical protein +FIG01154004 FIG01154006: hypothetical protein +FIG01154020 FIG01154024: hypothetical protein +FIG01154024 FIG01154031: hypothetical protein +FIG01154061 FIG01154065: hypothetical protein +FIG01154067 FIG01154068: hypothetical protein +FIG01154068 FIG01154070: hypothetical protein +FIG01154086 FIG01154092: hypothetical protein +FIG01154095 FIG01154099: hypothetical protein +FIG01154100 FIG01154101: hypothetical protein +FIG01154101 FIG01154102: hypothetical protein +FIG01154104 FIG01154107: hypothetical protein +FIG01154107 FIG01154109: hypothetical protein +FIG01154109 FIG01154111: hypothetical protein +FIG01154111 FIG01154112: hypothetical protein +FIG01154119 FIG01154120: hypothetical protein +FIG01154120 FIG01154121: hypothetical protein +FIG01154121 FIG01154124: hypothetical protein +FIG01154124 FIG01154126: hypothetical protein +FIG01154128 FIG01154132: hypothetical protein +FIG01154132 FIG038648: MoaD and/or ThiS families +FIG01154136 FIG01154149: hypothetical protein +FIG01154153 FIG01154154: hypothetical protein +FIG01154154 FIG01154155: hypothetical protein +FIG01154155 FIG01154159: hypothetical protein +FIG01154162 FIG01154163: hypothetical protein +FIG01154166 FIG01154167: hypothetical protein +FIG01154167 Tll1304 protein +FIG01154184 FIG01154185: hypothetical protein +FIG01154187 FIG01154188: hypothetical protein +FIG01154192 FIG01154194: hypothetical protein +FIG01154194 FIG01154195: hypothetical protein +FIG01154195 manganese/zinc/iron chelate ABC ransporter (MZT) family, ATP-binding protein +FIG01154201 FIG01154202: hypothetical protein +FIG01154202 FIG01154204: hypothetical protein +FIG01154204 FIG01154206: hypothetical protein +FIG01154208 ORF_ID:tlr0678 unknown protein +FIG01154220 FIG01154228: hypothetical protein +FIG01154228 FIG01154231: hypothetical protein +FIG01154233 FIG01154235: hypothetical protein +FIG01154235 All0899 protein +FIG01154236 FIG01154242: hypothetical protein +FIG01154242 FIG01154247: hypothetical protein +FIG01154249 FIG01154254: hypothetical protein +FIG01154254 FIG01154257: hypothetical protein +FIG01154264 FIG01154266: hypothetical protein +FIG01154274 FIG01154275: hypothetical protein +FIG01154275 FIG01154280: hypothetical protein +FIG01154280 FIG01154281: hypothetical protein +FIG01154303 FIG01154306: hypothetical protein +FIG01154306 FIG01154309: hypothetical protein +FIG01154311 FIG01154315: hypothetical protein +FIG01154315 FIG01154317: hypothetical protein +FIG01154320 FIG01154324: hypothetical protein +FIG01154324 FIG01154325: hypothetical protein +FIG01154329 FIG01154330: hypothetical protein +FIG01154335 FIG01154339: hypothetical protein +FIG01154339 FIG01154341: hypothetical protein +FIG01154343 FIG01154344: hypothetical protein +FIG01154363 FIG01154365: hypothetical protein +FIG01154365 FIG01154369: hypothetical protein +FIG01154369 FIG01154377: hypothetical protein +FIG01154377 FIG01154382: hypothetical protein +FIG01154384 FIG01154385: hypothetical protein +FIG01154385 FIG01154386: hypothetical protein +FIG01154386 FIG01154408: hypothetical protein +FIG01154408 FIG01154412: hypothetical protein +FIG01154424 FIG01154426: hypothetical protein +FIG01154426 FIG01154429: hypothetical protein +FIG01154429 FIG01154430: hypothetical protein +FIG01154431 FIG01154433: hypothetical protein +FIG01154433 FIG01154434: hypothetical protein +FIG01154434 All1211 protein +FIG01154436 FIG01154439: hypothetical protein +FIG01154442 FIG01154445: hypothetical protein +FIG01154445 FIG01154448: hypothetical protein +FIG01154454 FIG01154455: hypothetical protein +FIG01154462 FIG01154467: hypothetical protein +FIG01154467 FIG01154469: hypothetical protein +FIG01154472 FIG01154474: hypothetical protein +FIG01154474 FIG01154476: hypothetical protein +FIG01154476 FIG01154477: hypothetical protein +FIG01154479 FIG01154481: hypothetical protein +FIG01154481 FIG01154482: hypothetical protein +FIG01154482 FIG01154483: hypothetical protein +FIG01154483 FIG01154484: hypothetical protein +FIG01154484 FIG01154485: hypothetical protein +FIG01154489 Tlr1425 protein +FIG01154497 FIG01154500: hypothetical protein +FIG01154502 FIG01154512: hypothetical protein +FIG01154520 FIG01154524: hypothetical protein +FIG01154529 FIG01154531: hypothetical protein +FIG01154531 FIG01154532: hypothetical protein +FIG01154532 Nickel-binding accessory protein UreJ-HupE +FIG01154540 FIG01154548: hypothetical protein +FIG01154548 FIG01154550: hypothetical protein +FIG01154550 FIG01154553: hypothetical protein +FIG01154553 FIG01154555: hypothetical protein +FIG01154555 FIG01154558: hypothetical protein +FIG01154564 FIG01154567: hypothetical protein +FIG01154585 FIG01154589: hypothetical protein +FIG01154591 FIG01154595: hypothetical protein +FIG01154595 FIG01154596: hypothetical protein +FIG01154602 FIG01154608: hypothetical protein +FIG01154608 FIG01154609: hypothetical protein +FIG01154610 FIG01154612: hypothetical protein +FIG01154612 FIG01154614: hypothetical protein +FIG01154626 FIG01154631: hypothetical protein +FIG01154636 FIG01154638: hypothetical protein +FIG01154638 FIG01154645: hypothetical protein +FIG01154648 DnaK family protein +FIG01154652 FIG01154653: hypothetical protein +FIG01154653 FIG01154655: hypothetical protein +FIG01154673 FIG01154679: hypothetical protein +FIG01154700 FIG01154702: hypothetical protein +FIG01154702 FIG01154706: hypothetical protein +FIG01154710 Metallo-beta-lactamase superfamily hydrolase +FIG01154715 macrocin-O-methyltransferase domain protein +FIG01154717 FIG01154719: hypothetical protein +FIG01154719 FIG01154723: hypothetical protein +FIG01154724 FIG01154727: hypothetical protein +FIG01154730 FIG01154736: hypothetical protein +FIG01154740 FIG01154746: hypothetical protein +FIG01154753 FIG01154758: hypothetical protein +FIG01154758 FIG01154762: hypothetical protein +FIG01154762 FIG01154765: hypothetical protein +FIG01154777 FIG01154779: hypothetical protein +FIG01154787 FIG01154789: hypothetical protein +FIG01154789 FIG01154791: hypothetical protein +FIG01154791 FIG01154793: hypothetical protein +FIG01154793 FIG01154801: hypothetical protein +FIG01154801 FIG01154804: hypothetical protein +FIG01154805 FIG01154808: hypothetical protein +FIG01154808 FIG01154809: hypothetical protein +FIG01154814 FIG01154815: hypothetical protein +FIG01154819 FIG01154822: hypothetical protein +FIG01154825 FIG01154829: hypothetical protein +FIG01154832 FIG01154833: hypothetical protein +FIG01154841 FIG01154844: hypothetical protein +FIG01154844 FIG01154849: hypothetical protein +FIG01154849 FIG01154851: hypothetical protein +FIG01154855 FIG01154856: hypothetical protein +FIG01154860 FIG01154861: hypothetical protein +FIG01154867 FIG01154869: hypothetical protein +FIG01154872 Alr3959 protein +FIG01154882 FIG01154886: hypothetical protein +FIG01154890 FIG01154895: hypothetical protein +FIG01154895 FIG01154896: hypothetical protein +FIG01154896 FIG01154898: hypothetical protein +FIG01154898 FIG01154899: hypothetical protein +FIG01154899 FIG01154905: hypothetical protein +FIG01154909 FIG01154918: hypothetical protein +FIG01154919 FIG01154924: hypothetical protein +FIG01154928 FIG01154932: hypothetical protein +FIG01154932 FIG01154933: hypothetical protein +FIG01154933 FIG01154939: hypothetical protein +FIG01154939 FIG01154940: hypothetical protein +FIG01154952 gas vesicle synthesis protein GvpF +FIG01154961 FIG01154965: hypothetical protein +FIG01154972 FIG01154973: hypothetical protein +FIG01154974 possible fatty acid desaturase +FIG01154978 FIG01154979: hypothetical protein +FIG01154983 FIG01154984: hypothetical protein +FIG01154984 All3173 protein +FIG01154999 Tll0394 protein +FIG01155001 FIG01155008: hypothetical protein +FIG01155009 FIG01155012: hypothetical protein +FIG01155013 FIG01155018: hypothetical protein +FIG01155018 FIG01155027: hypothetical protein +FIG01155032 FIG01155036: hypothetical protein +FIG01155036 FIG01155039: hypothetical protein +FIG01155039 FIG01155040: hypothetical protein +FIG01155040 FIG01155042: hypothetical protein +FIG01155044 FIG01155048: hypothetical protein +FIG01155048 FIG01155049: hypothetical protein +FIG01155052 COG0385 sodium-dependent transporter +FIG01155053 possible Carboxylesterase +FIG01155082 putative glutamate synthetase +FIG01155106 FIG01155110: hypothetical protein +FIG01155110 FIG01155115: hypothetical protein +FIG01155115 FIG01155117: hypothetical protein +FIG01155124 FIG01155125: hypothetical protein +FIG01155125 Ap-4-A phosphorylase II-like protein +FIG01155130 Ycf65-like protein +FIG01155149 FIG01155152: hypothetical protein +FIG01155156 FIG01155157: hypothetical protein +FIG01155157 FIG01155158: hypothetical protein +FIG01155158 FIG01155164: hypothetical protein +FIG01155169 FIG01155170: hypothetical protein +FIG01155173 FIG01155175: hypothetical protein +FIG01155184 FIG01155190: hypothetical protein +FIG01155192 FIG01155193: hypothetical protein +FIG01155193 FIG01155195: hypothetical protein +FIG01155195 FIG01155198: hypothetical protein +FIG01155198 FIG01155199: hypothetical protein +FIG01155199 FIG01155208: hypothetical protein +FIG01155208 All1164 protein +FIG01155222 FIG01155224: hypothetical protein +FIG01155231 FIG01155232: hypothetical protein +FIG01155232 FIG01155236: hypothetical protein +FIG01155236 FIG01155251: hypothetical protein +FIG01155251 FIG01155253: hypothetical protein +FIG01155256 FIG01155258: hypothetical protein +FIG01155258 FIG01155262: hypothetical protein +FIG01155263 WD40-like beta propeller repeat protein +FIG01155268 FIG01155269: hypothetical protein +FIG01155274 FIG01155279: hypothetical protein +FIG01155279 FIG01155286: hypothetical protein +FIG01155290 FIG01155294: hypothetical protein +FIG01155294 FIG01155295: hypothetical protein +FIG01155295 FIG01155300: hypothetical protein +FIG01155310 FIG01155314: hypothetical protein +FIG01155317 FIG01155321: hypothetical protein +FIG01155323 FIG01155330: hypothetical protein +FIG01155330 FIG01155332: hypothetical protein +FIG01155333 FIG01155334: hypothetical protein +FIG01155339 Alr0559 protein +FIG01155343 FIG01155344: hypothetical protein +FIG01155347 FIG01155348: hypothetical protein +FIG01155349 FIG01155351: hypothetical protein +FIG01155351 Alr3379 protein +FIG01155358 FIG01155359: hypothetical protein +FIG01155359 FIG01155363: hypothetical protein +FIG01155363 FIG01155372: hypothetical protein +FIG01155372 RelE/StbE replicon stabilization toxin +FIG01155382 FIG01155384: hypothetical protein +FIG01155384 FIG01155386: hypothetical protein +FIG01155386 FIG01155389: hypothetical protein +FIG01155389 Calcium/proton exchanger +FIG01155397 FIG01155398: hypothetical protein +FIG01155401 FIG01155403: hypothetical protein +FIG01155416 FIG01155420: hypothetical protein +FIG01155423 FIG01155424: hypothetical protein +FIG01155424 FIG01155425: hypothetical protein +FIG01155425 FIG01155427: hypothetical protein +FIG01155429 FIG01155431: hypothetical protein +FIG01155431 FIG01155433: hypothetical protein +FIG01155435 FIG01155436: hypothetical protein +FIG01155436 Slr1826 protein +FIG01155454 FIG01155455: hypothetical protein +FIG01155456 FIG01155457: hypothetical protein +FIG01155457 FIG01155459: hypothetical protein +FIG01155461 peptidase, S1C (protease Do) family( EC:3.4.21.- ) +FIG01155471 FIG01155479: hypothetical protein +FIG01155480 FIG01155484: hypothetical protein +FIG01155484 FIG01155486: hypothetical protein +FIG01155486 weak similarity to phage integrase family +FIG01155487 FIG01155488: hypothetical protein +FIG01155488 FIG01155500: hypothetical protein +FIG01155500 Gll3754 protein +FIG01155505 FIG01155506: hypothetical protein +FIG01155514 FIG01155515: hypothetical protein +FIG01155520 Possible fumarate reductase subunit D +FIG01155522 FIG01155529: hypothetical protein +FIG01155529 polar amino acid ABC transporter (PAAT) family, periplasmic amino acid-binding protein +FIG01155534 FIG01155535: hypothetical protein +FIG01155535 TrkA-N:Ion transport protein +FIG01155536 FIG01155539: hypothetical protein +FIG01155539 FIG01155542: hypothetical protein +FIG01155542 FIG01155548: hypothetical protein +FIG01155548 FIG01155555: hypothetical protein +FIG01155555 FIG01155556: hypothetical protein +FIG01155556 FIG01155558: hypothetical protein +FIG01155561 FIG01155572: hypothetical protein +FIG01155572 FIG01155574: hypothetical protein +FIG01155575 FIG01155577: hypothetical protein +FIG01155577 FIG01155578: hypothetical protein +FIG01155578 FIG01155581: hypothetical protein +FIG01155584 FIG01155588: hypothetical protein +FIG01155588 FIG01155589: hypothetical protein +FIG01155591 FIG01155594: hypothetical protein +FIG01155598 FIG01155599: hypothetical protein +FIG01155599 FIG01155600: hypothetical protein +FIG01155614 FIG01155615: hypothetical protein +FIG01155620 FIG01155624: hypothetical protein +FIG01155659 FIG01155661: hypothetical protein +FIG01155671 signal peptide peptidase SppA (protease IV)( EC:3.4.21.- ) +FIG01155677 protein of unknown function DUF683 +FIG01155680 FIG01155682: hypothetical protein +FIG01155686 FIG01155687: hypothetical protein +FIG01155687 FIG01155689: hypothetical protein +FIG01155697 FIG01155703: hypothetical protein +FIG01155711 FIG01155714: hypothetical protein +FIG01155714 FIG01155716: hypothetical protein +FIG01155718 Tlr2402 protein +FIG01155723 FIG01155726: hypothetical protein +FIG01155727 FIG01155730: hypothetical protein +FIG01155730 FIG01155731: hypothetical protein +FIG01155753 FIG01155768: hypothetical protein +FIG01155768 FIG01155772: hypothetical protein +FIG01155772 ABC transporter, periplasmic iron-binding lipoprotein +FIG01155799 Alr0511 protein +FIG01155821 FIG01155825: hypothetical protein +FIG01155827 FIG01155832: hypothetical protein +FIG01155832 FIG01155839: hypothetical protein +FIG01155850 FIG01155851: hypothetical protein +FIG01155851 Cellulose synthase catalytic subunit [UDP-forming] +FIG01155860 FIG01155864: hypothetical protein +FIG01155864 FIG01155873: hypothetical protein +FIG01155873 syc0112_d +FIG01155877 FIG01155884: hypothetical protein +FIG01155900 FIG01155901: hypothetical protein +FIG01155904 FIG01155907: hypothetical protein +FIG01155907 FIG01155910: hypothetical protein +FIG01155939 FIG01155942: hypothetical protein +FIG01155942 FIG01155943: hypothetical protein +FIG01155944 FIG01155947: hypothetical protein +FIG01155947 FIG01155951: hypothetical protein +FIG01155956 FIG01155957: hypothetical protein +FIG01155963 FIG01155976: hypothetical protein +FIG01155976 FIG01155977: hypothetical protein +FIG01155977 FIG01155984: hypothetical protein +FIG01155984 FIG01155985: hypothetical protein +FIG01155985 FIG01155988: hypothetical protein +FIG01155996 FIG01156001: hypothetical protein +FIG01156001 FIG01156003: hypothetical protein +FIG01156008 FIG01156010: hypothetical protein +FIG01156011 FIG01156016: hypothetical protein +FIG01156016 FIG01156018: hypothetical protein +FIG01156019 FIG01156025: hypothetical protein +FIG01156058 FIG01156062: hypothetical protein +FIG01156068 FIG01156069: hypothetical protein +FIG01156071 FIG01156073: hypothetical protein +FIG01156073 FIG01156077: hypothetical protein +FIG01156077 FIG01156078: hypothetical protein +FIG01156091 FIG01156093: hypothetical protein +FIG01156118 FIG01156120: hypothetical protein +FIG01156120 FIG022199: FAD-binding protein +FIG01156129 FIG01156132: hypothetical protein +FIG01156150 FIG01156154: hypothetical protein +FIG01156157 FIG01156168: hypothetical protein +FIG01156173 FIG01156174: hypothetical protein +FIG01156175 FIG01156176: hypothetical protein +FIG01156176 FIG01156177: hypothetical protein +FIG01156177 FIG01156178: hypothetical protein +FIG01156181 FIG01156182: hypothetical protein +FIG01156204 FIG01156207: hypothetical protein +FIG01156209 FIG01156217: hypothetical protein +FIG01156228 FIG01156230: hypothetical protein +FIG01156230 FIG01156234: hypothetical protein +FIG01156241 FIG01156242: hypothetical protein +FIG01156242 FIG01156243: hypothetical protein +FIG01156243 FIG01156244: hypothetical protein +FIG01156262 Carotenoid binding protein +FIG01156265 FIG01156268: hypothetical protein +FIG01156271 FIG01156278: hypothetical protein +FIG01156278 FIG01156280: hypothetical protein +FIG01156280 FIG01156282: hypothetical protein +FIG01156282 FIG01156288: hypothetical protein +FIG01156304 FIG01156309: hypothetical protein +FIG01156309 FIG01156310: hypothetical protein +FIG01156326 FIG01156327: hypothetical protein +FIG01156327 FIG01156328: hypothetical protein +FIG01156329 FIG01156337: hypothetical protein +FIG01156339 FIG01156351: hypothetical protein +FIG01156351 transcriptional regulator, BlaI/MecI/CopY family +FIG01156362 FIG01156363: hypothetical protein +FIG01156378 FIG01156388: hypothetical protein +FIG01156393 Slr0789 protein +FIG01156408 FIG01156413: hypothetical protein +FIG01156418 ABC transporter,ATP binding component, possibly zinc transport +FIG01156434 FIG01156436: hypothetical protein +FIG01156440 FIG01156442: hypothetical protein +FIG01156448 FIG01156454: hypothetical protein +FIG01156454 FIG01156455: hypothetical protein +FIG01156470 FIG01156473: hypothetical protein +FIG01156482 FIG01156484: hypothetical protein +FIG01156485 FIG01156487: hypothetical protein +FIG01156492 FIG01156502: hypothetical protein +FIG01156502 FIG01156503: hypothetical protein +FIG01156505 FIG01156510: hypothetical protein +FIG01156510 FIG01156517: hypothetical protein +FIG01156530 FIG01156531: hypothetical protein +FIG01156533 hydrolase, metallo-beta-lactamase family +FIG01156544 FIG01156549: hypothetical protein +FIG01156549 FIG01156557: hypothetical protein +FIG01156559 Glycosyltransferase of family GT4 +FIG01156567 FIG01156568: hypothetical protein +FIG01156568 FIG01156577: hypothetical protein +FIG01156577 FIG01156581: hypothetical protein +FIG01156583 FIG01156590: hypothetical protein +FIG01156590 syc1430_d +FIG01156598 FIG01156602: hypothetical protein +FIG01156620 FIG01156621: hypothetical protein +FIG01156633 FIG01156634: hypothetical protein +FIG01156634 FIG01156637: hypothetical protein +FIG01156640 FIG01156642: hypothetical protein +FIG01156642 FIG01156648: hypothetical protein +FIG01156649 FIG01156651: hypothetical protein +FIG01156657 FIG01156667: hypothetical protein +FIG01156684 FIG01156693: hypothetical protein +FIG01156700 FIG01156713: hypothetical protein +FIG01156716 FIG01156728: hypothetical protein +FIG01156728 FIG01156729: hypothetical protein +FIG01156733 FIG01156736: hypothetical protein +FIG01156736 FIG01156737: hypothetical protein +FIG01156737 FIG01156738: hypothetical protein +FIG01156741 Chalcone synthase +FIG01156743 FIG01156744: hypothetical protein +FIG01156750 FIG01156753: hypothetical protein +FIG01156753 Sodium:alanine symporter family +FIG01156759 FIG01156760: hypothetical protein +FIG01156760 FIG01156763: hypothetical protein +FIG01156778 FIG01156783: hypothetical protein +FIG01156783 FIG01156784: hypothetical protein +FIG01156791 FIG001196: Membrane protein YedZ +FIG01156795 FIG01156807: hypothetical protein +FIG01156851 FIG01156855: hypothetical protein +FIG01156889 FIG01156896: hypothetical protein +FIG01156904 FIG01156907: hypothetical protein +FIG01156915 Possible AraC-type regulatory protein +FIG01156920 FIG01156923: hypothetical protein +FIG01156931 FIG01156952: hypothetical protein +FIG01156952 FIG01156959: hypothetical protein +FIG01156959 FIG01156968: hypothetical protein +FIG01156968 transporter, stomatin/podocin/band 7/nephrosis.2/SPFH (Stomatin) family +FIG01156971 FIG01156973: hypothetical protein +FIG01156978 FIG01156979: hypothetical protein +FIG01156982 DUF98 family +FIG01156990 FIG01156992: hypothetical protein +FIG01156992 FIG01156994: hypothetical protein +FIG01157018 FIG01157023: hypothetical protein +FIG01157023 FIG01157029: hypothetical protein +FIG01157033 FIG01157034: hypothetical protein +FIG01157034 FIG01157039: hypothetical protein +FIG01157045 FIG01157055: hypothetical protein +FIG01157055 FIG01157061: hypothetical protein +FIG01157061 FIG01157062: hypothetical protein +FIG01157069 FIG01157076: hypothetical protein +FIG01157076 FIG01157080: hypothetical protein +FIG01157080 FIG01157082: hypothetical protein +FIG01157084 FIG01157090: hypothetical protein +FIG01157095 FIG01157096: hypothetical protein +FIG01157105 FIG01157108: hypothetical protein +FIG01157118 FIG01157121: hypothetical protein +FIG01157124 FIG01157125: hypothetical protein +FIG01157125 FIG01157129: hypothetical protein +FIG01157130 FIG01157133: hypothetical protein +FIG01157143 FIG01157152: hypothetical protein +FIG01157159 FIG01157165: hypothetical protein +FIG01157170 FIG01157173: hypothetical protein +FIG01157188 FIG01157197: hypothetical protein +FIG01157200 FIG01157201: hypothetical protein +FIG01157211 FIG01157213: hypothetical protein +FIG01157226 FIG01157227: hypothetical protein +FIG01157227 Asl4395 protein +FIG01157230 FIG01157231: hypothetical protein +FIG01157231 FIG01157232: hypothetical protein +FIG01157232 FIG01157234: hypothetical protein +FIG01157234 putative transcriptional regulatory protein RstA +FIG01157244 phage integrase family +FIG01157270 FIG01157280: hypothetical protein +FIG01157304 Glycosyltransferase of family GT41 +FIG01157310 Tlr1154 protein +FIG01157335 FIG01157338: hypothetical protein +FIG01157338 FIG01157340: hypothetical protein +FIG01157340 FIG01157341: hypothetical protein +FIG01157344 FIG01157349: hypothetical protein +FIG01157357 FIG01157369: hypothetical protein +FIG01157405 FIG01157409: hypothetical protein +FIG01157416 FIG01157422: hypothetical protein +FIG01157442 FIG01157450: hypothetical protein +FIG01157453 FIG01157457: hypothetical protein +FIG01157459 FIG01157462: hypothetical protein +FIG01157476 FIG01157480: hypothetical protein +FIG01157508 FIG01157510: hypothetical protein +FIG01157516 FIG01157518: hypothetical protein +FIG01157518 FIG01157526: hypothetical protein +FIG01157542 FIG01157543: hypothetical protein +FIG01157597 FIG01157603: hypothetical protein +FIG01157606 virulence factor MviN homolog. +FIG01157673 FIG01157677: hypothetical protein +FIG01157756 FIG01157759: hypothetical protein +FIG01157776 Related to serine protease +FIG01157820 FIG01157827: hypothetical protein +FIG01157829 FIG01157833: hypothetical protein +FIG01157846 possible Neuromedin U +FIG01157881 FIG01157884: hypothetical protein +FIG01157934 O-antigen polymerase family protein +FIG01157958 FIG01157975: hypothetical protein +FIG01157976 FIG01157983: hypothetical protein +FIG01158227 ORF_ID:slr6058 hypothetical protein +FIG01158374 FIG01158381: hypothetical protein +FIG01158414 ORF_ID:sll6010 +FIG01158431 PatA subfamily +FIG01158574 Carbon dioxide concentrating mechanism protein ccmK homolog 4 +FIG01158702 ORF_ID:sll5084 probable plasmid partitioning protein, ParB +FIG01158926 FIG01158930: hypothetical protein +FIG01158969 "Cell wall endopeptidase, family M23/M37" +FIG01159443 Type IV pilus biogenesis protein PilQ +FIG01159514 FIG01159515: hypothetical protein +FIG01159533 FIG00561183: hypothetical protein +FIG01159686 FIG01159697: hypothetical protein +FIG01159921 ORF_ID:slr6022 +FIG01159939 two-component system, regulatory protein +FIG01160266 tRNA nucleotidyltransferase related protein +FIG01160308 FIG01160309: hypothetical protein +FIG01160370 FIG01160382: hypothetical protein +FIG01160459 ABC-type transport systems, involved in lipoprotein release, permease components +FIG01160523 Adenine specific DNA methylase (Mod-related) +FIG01160542 FIG01160543: hypothetical protein +FIG01160591 Organosulfonate ABC transporter substrate-binding protein +FIG01160675 FIG01160677: hypothetical protein +FIG01160783 ferritin, putative +FIG01160834 FIG01160836: hypothetical protein +FIG01160838 TRANSCRIPTIONAL REGULATOR (NIFA FAMILY) +FIG01160862 FIG01160864: hypothetical protein +FIG01160879 FIG01160883: hypothetical protein +FIG01161107 FIG01161108: hypothetical protein +FIG01161111 (R)-2-hydroxyglutaryl-CoA dehydratase beta-subunit (EC 4.2.1.-) +FIG01161152 dinitrogenase iron-molybdenum cofactor protein +FIG01161235 sensory box/HDIG domain protein +FIG01161419 FIG01161420: hypothetical protein +FIG01161433 FIG01161434: hypothetical protein +FIG01161434 FIG01161435: hypothetical protein +FIG01161559 FIG01161560: hypothetical protein +FIG01161563 periplasmic ligand-binding sensor domain-like protein +FIG01161634 Mu-like prophage I protein +FIG01161750 FIG01161751: hypothetical protein +FIG01161941 Modification methylase PstI (EC 2.1.1.72) +FIG01162011 FIG01162012: hypothetical protein +FIG01162153 UPF0280 protein MJ1526 +FIG01162257 FIG01162265: hypothetical protein +FIG01162406 FIG01162410: hypothetical protein +FIG01162448 FIG01228187: hypothetical protein +FIG01162479 FIG01162480: hypothetical protein +FIG01162511 ABC-type transporter permease protein +FIG01162545 FIG01162561: hypothetical protein +FIG01162718 putative chelatase +FIG01162909 Putative sensory transducer protein +FIG01163099 FIG01235548: hypothetical protein +FIG01163248 putative ferredoxin-type protein +FIG01163515 mu-like prophage Flumu F protein +FIG01163534 radical SAM superfamily protein +FIG01163674 Methylmalonyl CoA epimerase (EC 5.1.99.1) +FIG01163723 FIG01163724: hypothetical protein +FIG01163803 DNA polymerase X family/PHP domain protein +FIG01164026 COG0744: Membrane carboxypeptidase (penicillin-binding protein) +FIG01164177 rare lipoprotein A domain protein +FIG01164190 TOMM biosynthesis dehydrogenase (protein B) +FIG01164491 Glutamate formiminotransferase (EC 2.1.2.5) +FIG01164540 o-antigen polymerase +FIG01164739 FIG01164754: hypothetical protein +FIG01164801 Transcription attenuation protein mtrB +FIG01164821 predicted phosphatase +FIG01164984 fumarate hydratase +FIG01165095 FIG01165116: hypothetical protein +FIG01165272 Membrane protein FdrA +FIG01165337 FIG01165338: hypothetical protein +FIG01165338 FIG01165340: hypothetical protein +FIG01165340 FIG01165343: hypothetical protein +FIG01165343 FIG01165344: hypothetical protein +FIG01165344 FIG01165345: hypothetical protein +FIG01165345 FIG01165346: hypothetical protein +FIG01165348 FIG01165349: hypothetical protein +FIG01165353 FIG01165354: hypothetical protein +FIG01165357 FIG01165359: hypothetical protein +FIG01165359 FIG01165362: hypothetical protein +FIG01165362 FIG01165363: hypothetical protein +FIG01165364 FIG01165366: hypothetical protein +FIG01165366 FIG01165367: hypothetical protein +FIG01165367 FIG01165368: hypothetical protein +FIG01165372 FIG01165374: hypothetical protein +FIG01165376 FIG01165377: hypothetical protein +FIG01165378 FIG01165381: hypothetical protein +FIG01165383 FIG01165384: hypothetical protein +FIG01165385 PTS system, gluconate-specific IIB component (EC 2.7.1.69) +FIG01165387 FIG01165388: hypothetical protein +FIG01165388 FIG01165389: hypothetical protein +FIG01165391 FIG01165396: hypothetical protein +FIG01165396 FIG01165397: hypothetical protein +FIG01165397 FIG01165400: hypothetical protein +FIG01165400 FIG01165404: hypothetical protein +FIG01165405 FIG01165406: hypothetical protein +FIG01165408 FIG01165411: hypothetical protein +FIG01165411 NAD(FAD)-utilizing dehydrogenase +FIG01165413 FIG01165415: hypothetical protein +FIG01165415 FIG01165416: hypothetical protein +FIG01165416 FIG01165417: hypothetical protein +FIG01165417 FIG01165418: hypothetical protein +FIG01165418 FIG01165420: hypothetical protein +FIG01165420 FIG01165421: hypothetical protein +FIG01165424 FIG01165425: hypothetical protein +FIG01165425 FIG01165426: hypothetical protein +FIG01165426 FIG01165427: hypothetical protein +FIG01165427 FIG01165430: hypothetical protein +FIG01165430 FIG01165432: hypothetical protein +FIG01165432 predicted nucleic acid-binding protein, contains PIN domain +FIG01165433 FIG01165435: hypothetical protein +FIG01165438 FIG01165440: hypothetical protein +FIG01165444 FIG01165446: hypothetical protein +FIG01165446 FIG01165447: hypothetical protein +FIG01165447 Sensor protein cssS (EC 2.7.13.3) +FIG01165448 FIG01165450: hypothetical protein +FIG01165451 FIG01165453: hypothetical protein +FIG01165453 FIG01165454: hypothetical protein +FIG01165454 FIG01165455: hypothetical protein +FIG01165455 FIG01165456: hypothetical protein +FIG01165459 FIG01165460: hypothetical protein +FIG01165460 FIG01165461: hypothetical protein +FIG01165461 FIG01165464: hypothetical protein +FIG01165464 FIG01165468: hypothetical protein +FIG01165468 FIG01165469: hypothetical protein +FIG01165469 FIG01165470: hypothetical protein +FIG01165476 FIG01165477: hypothetical protein +FIG01165477 FIG01165480: hypothetical protein +FIG01165480 FIG01165484: hypothetical protein +FIG01165486 Type IV fimbrial biogenesis protein FimT +FIG01165488 FIG01165492: hypothetical protein +FIG01165492 FIG01165493: hypothetical protein +FIG01165493 FIG01165494: hypothetical protein +FIG01165494 FIG01165495: hypothetical protein +FIG01165495 FIG01165497: hypothetical protein +FIG01165497 FIG01165498: hypothetical protein +FIG01165498 FIG01165500: hypothetical protein +FIG01165500 FIG01165504: hypothetical protein +FIG01165506 FIG01165507: hypothetical protein +FIG01165507 FIG01165508: hypothetical protein +FIG01165511 FIG01165516: hypothetical protein +FIG01165516 FIG01165517: hypothetical protein +FIG01165517 FIG01165520: hypothetical protein +FIG01165520 FIG01165521: hypothetical protein +FIG01165521 FIG01165522: hypothetical protein +FIG01165522 FIG01165524: hypothetical protein +FIG01165528 FIG01165529: hypothetical protein +FIG01165547 FIG01165548: hypothetical protein +FIG01165548 FIG01165550: hypothetical protein +FIG01165552 FIG01165553: hypothetical protein +FIG01165553 FIG01165554: hypothetical protein +FIG01165556 FIG01165558: hypothetical protein +FIG01165562 FIG01165564: hypothetical protein +FIG01165567 FIG01165569: hypothetical protein +FIG01165569 putative sodium dependent transporter +FIG01165572 FIG01165573: hypothetical protein +FIG01165574 FIG01165575: hypothetical protein +FIG01165575 FIG01165579: hypothetical protein +FIG01165579 Small, acid-soluble spore proteins, alpha/be +FIG01165580 FIG01165581: hypothetical protein +FIG01165581 FIG01165583: hypothetical protein +FIG01165583 FIG01165584: hypothetical protein +FIG01165587 FIG01165588: hypothetical protein +FIG01165590 FIG01165591: hypothetical protein +FIG01165593 FIG01165594: hypothetical protein +FIG01165595 FIG01165596: hypothetical protein +FIG01165602 FIG01165604: hypothetical protein +FIG01165604 FIG01165605: hypothetical protein +FIG01165605 FIG01165608: hypothetical protein +FIG01165608 FIG01165611: hypothetical protein +FIG01165611 FIG01165614: hypothetical protein +FIG01165614 FIG01165622: hypothetical protein +FIG01165622 FIG01165625: hypothetical protein +FIG01165625 FIG01165626: hypothetical protein +FIG01165626 peptidase S8 and S53, subtilisin, kexin, sedolisin +FIG01165627 FIG01165628: hypothetical protein +FIG01165629 FIG01165630: hypothetical protein +FIG01165630 FIG01165631: hypothetical protein +FIG01165631 FIG01165634: hypothetical protein +FIG01165641 FIG01165643: hypothetical protein +FIG01165644 FIG01165645: hypothetical protein +FIG01165645 FIG01165647: hypothetical protein +FIG01165647 Response regulators consisting of a CheY-like receiver domain and a HTH DNA-binding domain +FIG01165651 NADH dehydrogenase (quinone)( EC:1.6.99.5 ) +FIG01165653 FIG01165655: hypothetical protein +FIG01165655 FIG01165657: hypothetical protein +FIG01165657 FIG01165658: hypothetical protein +FIG01165658 FIG01165659: hypothetical protein +FIG01165659 FIG01165660: hypothetical protein +FIG01165660 FIG01165665: hypothetical protein +FIG01165665 FIG01165667: hypothetical protein +FIG01165667 FIG01165669: hypothetical protein +FIG01165669 FIG01165671: hypothetical protein +FIG01165671 FIG01165672: hypothetical protein +FIG01165672 FIG01165673: hypothetical protein +FIG01165673 FIG01165675: hypothetical protein +FIG01165676 FIG01165679: hypothetical protein +FIG01165682 FIG01165684: hypothetical protein +FIG01165686 FIG01165687: hypothetical protein +FIG01165687 FIG01165689: hypothetical protein +FIG01165689 FIG01165690: hypothetical protein +FIG01165695 FIG01165699: hypothetical protein +FIG01165712 FIG01165713: hypothetical protein +FIG01165713 FIG01165714: hypothetical protein +FIG01165714 FIG01165719: hypothetical protein +FIG01165722 FIG01165723: hypothetical protein +FIG01165723 FIG01165725: hypothetical protein +FIG01165726 FIG01165727: hypothetical protein +FIG01165727 FIG01165734: hypothetical protein +FIG01165734 FIG01165735: hypothetical protein +FIG01165735 FIG01165738: hypothetical protein +FIG01165738 FIG01165739: hypothetical protein +FIG01165741 FIG01165742: hypothetical protein +FIG01165743 FIG01165746: hypothetical protein +FIG01165750 FIG01165752: hypothetical protein +FIG01165752 FIG01165753: hypothetical protein +FIG01165753 FIG01165760: hypothetical protein +FIG01165760 FIG01165761: hypothetical protein +FIG01165761 FIG01165766: hypothetical protein +FIG01165766 FIG01165767: hypothetical protein +FIG01165768 FIG01165769: hypothetical protein +FIG01165769 FIG01165773: hypothetical protein +FIG01165774 FIG01165775: hypothetical protein +FIG01165776 FIG01165779: hypothetical protein +FIG01165779 FIG01165784: hypothetical protein +FIG01165785 FIG01165787: hypothetical protein +FIG01165787 FIG01165788: hypothetical protein +FIG01165788 FIG01165789: hypothetical protein +FIG01165790 FIG01165792: hypothetical protein +FIG01165792 FIG01166794: hypothetical protein +FIG01165795 FIG01165797: hypothetical protein +FIG01165797 FIG01165805: hypothetical protein +FIG01165805 FIG00528973: hypothetical protein +FIG01165806 FIG01165808: hypothetical protein +FIG01165809 FIG01165811: hypothetical protein +FIG01165811 FIG01165815: hypothetical protein +FIG01165815 FIG01165817: hypothetical protein +FIG01165817 Type IV pilin PilA +FIG01165819 FIG01165821: hypothetical protein +FIG01165827 FIG01165828: hypothetical protein +FIG01165830 FIG01165832: hypothetical protein +FIG01165833 FIG01165834: hypothetical protein +FIG01165834 FIG01165838: hypothetical protein +FIG01165838 FIG01165840: hypothetical protein +FIG01165841 FIG01165842: hypothetical protein +FIG01165842 FIG01165843: hypothetical protein +FIG01165850 FIG01165853: hypothetical protein +FIG01165853 FIG01165854: hypothetical protein +FIG01165855 FIG01165856: hypothetical protein +FIG01165856 FIG01165859: hypothetical protein +FIG01165859 FIG01165862: hypothetical protein +FIG01165863 FIG01165864: hypothetical protein +FIG01165867 FIG01165868: hypothetical protein +FIG01165868 Modification methylase MjaIII (EC 2.1.1.72) +FIG01165876 FIG01165877: hypothetical protein +FIG01165878 RNA polymerase sigma factor sigX +FIG01165881 FIG01165882: hypothetical protein +FIG01165882 FIG01165885: hypothetical protein +FIG01165885 FIG01165886: hypothetical protein +FIG01165886 FIG01165887: hypothetical protein +FIG01165887 FIG01165893: hypothetical protein +FIG01165896 AzlC-like +FIG01165899 CRISPR-associated RAMP Cmr2 +FIG01165908 FIG01165911: hypothetical protein +FIG01165911 FIG01165912: hypothetical protein +FIG01165912 FIG01165915: hypothetical protein +FIG01165916 FIG01165918: hypothetical protein +FIG01165918 FIG01165920: hypothetical protein +FIG01165920 FIG01165921: hypothetical protein +FIG01165921 FIG01165924: hypothetical protein +FIG01165924 FIG01165925: hypothetical protein +FIG01165928 FIG01165930: hypothetical protein +FIG01165930 FIG01165932: hypothetical protein +FIG01165932 FIG01165934: hypothetical protein +FIG01165938 FIG01165943: hypothetical protein +FIG01165946 FIG01165947: hypothetical protein +FIG01165970 FIG01165971: hypothetical protein +FIG01165971 cellulose biosynthesis protein +FIG01165975 FIG01165977: hypothetical protein +FIG01165977 FIG01165983: hypothetical protein +FIG01165984 FIG01165985: hypothetical protein +FIG01165985 FIG01165991: hypothetical protein +FIG01165991 FIG01165997: hypothetical protein +FIG01165997 FIG01165999: hypothetical protein +FIG01165999 FIG01166000: hypothetical protein +FIG01166000 Uncharacterized protein TM0723 +FIG01166001 FIG01166002: hypothetical protein +FIG01166005 FIG01166012: hypothetical protein +FIG01166013 FIG01166016: hypothetical protein +FIG01166016 FIG01166020: hypothetical protein +FIG01166020 Streptolysin S export transmembrane permease (SagH) +FIG01166023 FIG01166026: hypothetical protein +FIG01166033 FIG01166037: hypothetical protein +FIG01166037 FIG01166038: hypothetical protein +FIG01166038 FIG01166039: hypothetical protein +FIG01166040 FIG01166043: hypothetical protein +FIG01166043 FIG01166045: hypothetical protein +FIG01166045 Bacterial regulatory proteins +FIG01166047 FIG01166048: hypothetical protein +FIG01166050 FIG01166056: hypothetical protein +FIG01166056 FIG01166060: hypothetical protein +FIG01166062 FIG01166063: hypothetical protein +FIG01166069 FIG01166071: hypothetical protein +FIG01166071 Uncharacterized protein AF_2201 +FIG01166074 FIG01166075: hypothetical protein +FIG01166084 FIG01166086: hypothetical protein +FIG01166086 FIG01166094: hypothetical protein +FIG01166094 FIG01166095: hypothetical protein +FIG01166096 FIG01166097: hypothetical protein +FIG01166097 FIG01166100: hypothetical protein +FIG01166100 FIG01166102: hypothetical protein +FIG01166102 FIG01166104: hypothetical protein +FIG01166105 FIG01166107: hypothetical protein +FIG01166115 putative regulator of acetoin metabolism +FIG01166117 FIG01166631: hypothetical protein +FIG01166121 FIG01166123: hypothetical protein +FIG01166123 FIG01166126: hypothetical protein +FIG01166127 Uncharacterized protein MJ1383 precursor +FIG01166131 FIG01166134: hypothetical protein +FIG01166141 FIG01166142: hypothetical protein +FIG01166144 FIG01166145: hypothetical protein +FIG01166154 FIG01166156: hypothetical protein +FIG01166157 FIG01166159: hypothetical protein +FIG01166161 FIG01166162: hypothetical protein +FIG01166163 FIG01166164: hypothetical protein +FIG01166165 FIG01166166: hypothetical protein +FIG01166166 FIG01166169: hypothetical protein +FIG01166169 FIG01166184: hypothetical protein +FIG01166184 FIG01166187: hypothetical protein +FIG01166187 FIG01166194: hypothetical protein +FIG01166194 FIG01166198: hypothetical protein +FIG01166199 FIG01166202: hypothetical protein +FIG01166204 FIG01166207: hypothetical protein +FIG01166207 105aa long hypothetical protein +FIG01166211 FIG01166214: hypothetical protein +FIG01166214 FIG01166215: hypothetical protein +FIG01166215 FIG01166217: hypothetical protein +FIG01166224 Ferritin-like di-iron-carboxylate protein +FIG01166225 FIG01166229: hypothetical protein +FIG01166231 FIG01166237: hypothetical protein +FIG01166237 multiple resistance and pH regulation protein F +FIG01166239 Multi antimicrobial extrusion protein MatE +FIG01166243 FIG01166244: hypothetical protein +FIG01166244 FIG01166245: hypothetical protein +FIG01166245 FIG01166250: hypothetical protein +FIG01166261 FIG01166265: hypothetical protein +FIG01166265 FIG01166268: hypothetical protein +FIG01166268 FIG01166269: hypothetical protein +FIG01166269 FIG01166270: hypothetical protein +FIG01166270 FIG01166273: hypothetical protein +FIG01166273 FIG01166274: hypothetical protein +FIG01166274 FIG01166275: hypothetical protein +FIG01166275 FIG01166276: hypothetical protein +FIG01166276 FIG01166277: hypothetical protein +FIG01166288 FIG01166291: hypothetical protein +FIG01166291 FIG01166292: hypothetical protein +FIG01166292 FIG01166293: hypothetical protein +FIG01166296 FIG01166298: hypothetical protein +FIG01166298 FIG01166299: hypothetical protein +FIG01166304 FIG01166307: hypothetical protein +FIG01166308 CRISPR-associated RecB family exonuclease Cas4 +FIG01166312 FIG01166313: hypothetical protein +FIG01166324 FIG01166325: hypothetical protein +FIG01166330 FIG01166334: hypothetical protein +FIG01166335 FIG01166336: hypothetical protein +FIG01166336 FIG01166337: hypothetical protein +FIG01166337 FIG01166338: hypothetical protein +FIG01166338 FIG01166344: hypothetical protein +FIG01166344 Protein of unknown function DUF205 +FIG01166345 FIG01166351: hypothetical protein +FIG01166359 FIG01166360: hypothetical protein +FIG01166360 FIG01166361: hypothetical protein +FIG01166361 FIG01166362: hypothetical protein +FIG01166362 FIG01166368: hypothetical protein +FIG01166372 FIG01166376: hypothetical protein +FIG01166376 FIG01166377: hypothetical protein +FIG01166377 FIG01166378: hypothetical protein +FIG01166379 FIG01166380: hypothetical protein +FIG01166380 FIG01166386: hypothetical protein +FIG01166393 FIG01166395: hypothetical protein +FIG01166400 FIG01166401: hypothetical protein +FIG01166401 FIG01166402: hypothetical protein +FIG01166403 FIG01166406: hypothetical protein +FIG01166406 FIG01166412: hypothetical protein +FIG01166419 PTS system fructose-specific II component +FIG01166426 FIG01166428: hypothetical protein +FIG01166429 FIG01166431: hypothetical protein +FIG01166434 FIG01166435: hypothetical protein +FIG01166435 FIG01166439: hypothetical protein +FIG01166439 FIG01166440: hypothetical protein +FIG01166452 FIG01166454: hypothetical protein +FIG01166454 FIG01166457: hypothetical protein +FIG01166457 FIG01166461: hypothetical protein +FIG01166461 FIG01166463: hypothetical protein +FIG01166463 FIG01166465: hypothetical protein +FIG01166471 FIG01166475: hypothetical protein +FIG01166481 FIG01166482: hypothetical protein +FIG01166482 FIG01166485: hypothetical protein +FIG01166485 FIG01166488: hypothetical protein +FIG01166490 FIG01166506: hypothetical protein +FIG01166513 FIG01166514: hypothetical protein +FIG01166527 FIG01166528: hypothetical protein +FIG01166528 FIG01166529: hypothetical protein +FIG01166529 FIG01166531: hypothetical protein +FIG01166543 FIG01166546: hypothetical protein +FIG01166551 FIG01166552: hypothetical protein +FIG01166558 FIG01166559: hypothetical protein +FIG01166562 FIG01166563: hypothetical protein +FIG01166563 FIG01166567: hypothetical protein +FIG01166570 FIG01166571: hypothetical protein +FIG01166576 FIG01166577: hypothetical protein +FIG01166589 FIG01166593: hypothetical protein +FIG01166597 histidine kinase internal region +FIG01166601 FIG01166605: hypothetical protein +FIG01166605 FIG01166613: hypothetical protein +FIG01166613 FIG01166614: hypothetical protein +FIG01166614 FIG01166616: hypothetical protein +FIG01166616 FIG01166617: hypothetical protein +FIG01166618 FIG01166621: hypothetical protein +FIG01166621 FIG01166623: hypothetical protein +FIG01166637 FIG01166643: hypothetical protein +FIG01166643 FIG01166645: hypothetical protein +FIG01166656 Domain of unknown function DUF1537 +FIG01166657 FIG01166663: hypothetical protein +FIG01166666 FIG01166667: hypothetical protein +FIG01166667 FIG01166674: hypothetical protein +FIG01166674 FIG002343: hypothetical protein +FIG01166691 FIG01166692: hypothetical protein +FIG01166694 FIG01166698: hypothetical protein +FIG01166700 FIG01166710: hypothetical protein +FIG01166710 helix-turn-helix +FIG01166718 FIG01166719: hypothetical protein +FIG01166736 FIG01166737: hypothetical protein +FIG01166737 FIG01166739: hypothetical protein +FIG01166739 FIG01166744: hypothetical protein +FIG01166744 FIG01166749: hypothetical protein +FIG01166769 FIG01166775: hypothetical protein +FIG01166797 FIG01166798: hypothetical protein +FIG01166800 CheY-like receiver domains +FIG01166803 FIG01166804: hypothetical protein +FIG01166804 FIG01166806: hypothetical protein +FIG01166826 hypothetical protein +FIG01166864 FIG01166866: hypothetical protein +FIG01166866 FIG01166867: hypothetical protein +FIG01166874 Transcriptional regulatory protein cssR +FIG01166875 FIG01166878: hypothetical protein +FIG01166882 COG1131: ABC-type multidrug transport system, ATPase component +FIG01166888 FIG01166889: hypothetical protein +FIG01166889 FIG01166890: hypothetical protein +FIG01166890 FIG01166891: hypothetical protein +FIG01166904 FIG01166915: hypothetical protein +FIG01166915 FIG01166922: hypothetical protein +FIG01166922 FIG01166923: hypothetical protein +FIG01166923 FIG01166926: hypothetical protein +FIG01166926 FIG01166931: hypothetical protein +FIG01166931 putative membrane protein TraL +FIG01166934 FIG01166941: hypothetical protein +FIG01166941 FIG01166942: hypothetical protein +FIG01166948 acetyltransferases +FIG01166949 helicase (Snf2/Rad54 family) +FIG01166981 FIG01166984: hypothetical protein +FIG01166984 FIG01166986: hypothetical protein +FIG01166988 Arabinose operon protein araM +FIG01167013 FIG01167016: hypothetical protein +FIG01167028 helicase family member +FIG01167056 FIG01167057: hypothetical protein +FIG01167064 FIG01167065: hypothetical protein +FIG01167070 methylaspartate mutase +FIG01167089 oxidoreductase domain protein +FIG01167147 FIG01167148: hypothetical protein +FIG01167149 FIG01164982: hypothetical protein +FIG01167157 FIG01167158: hypothetical protein +FIG01167167 FIG01167171: hypothetical protein +FIG01167171 FIG01167172: hypothetical protein +FIG01167190 FIG01167196: hypothetical protein +FIG01167204 FIG01167210: hypothetical protein +FIG01167245 FIG01167246: hypothetical protein +FIG01167256 DEAD/DEAH box helicase-like protein +FIG01167269 FIG01167270: hypothetical protein +FIG01167289 FIG01167149: hypothetical protein +FIG01167471 protein of unknown function DUF1156 +FIG01167575 FIG01167600: hypothetical protein +FIG01168007 Permease for cytosine/purines, uracil, thiamine, allantoin +FIG01168300 acetylglutamate kinase +FIG01168596 secreted sugar-binding protein +FIG01169310 FIG01169311: hypothetical protein +FIG01169385 FIG01169386: hypothetical protein +FIG01169391 PAS/Protein phosphatase 2C-like +FIG01169419 FIG01169420: hypothetical protein +FIG01169431 FIG01169433: hypothetical protein +FIG01169438 similar to Coenzyme F420-dependent N5 N10-methylene tetrahydromethanopterin reductase and related flavin-dependent oxidoreductase +FIG01169447 FIG01169449: hypothetical protein +FIG01169496 FIG01169498: hypothetical protein +FIG01169545 FIG01169549: hypothetical protein +FIG01169552 Sulfite oxidase and related enzymes +FIG01169576 FIG01169578: hypothetical protein +FIG01169650 FIG01169653: hypothetical protein +FIG01169732 FIG01169735: hypothetical protein +FIG01169797 putative rhamnogalacturonan lyase +FIG01169807 FIG01169812: hypothetical protein +FIG01169908 FIG01169910: hypothetical protein +FIG01169934 FIG01169941: hypothetical protein +FIG01169959 sugar ABC transporter, permease protein +FIG01169985 FIG01169991: hypothetical protein +FIG01170017 FIG01170018: hypothetical protein +FIG01170045 FIG01170048: hypothetical protein +FIG01170052 FIG01170055: hypothetical protein +FIG01170057 peptidase M15B and M15C, D,D-carboxypeptidase VanY/endolysins +FIG01170102 FIG01170108: hypothetical protein +FIG01170165 FIG01170169: hypothetical protein +FIG01170173 FIG01170174: hypothetical protein +FIG01170213 hypothetical protein; putative SMAD/FHA domain +FIG01170234 FIG01170235: hypothetical protein +FIG01170315 FIG01170317: hypothetical protein +FIG01170341 PTS system sugar phosphotransferase component IIA +FIG01170384 FIG01170389: hypothetical protein +FIG01170427 FIG01170428: hypothetical protein +FIG01170547 two-component system sensor kinase +FIG01170567 peptidase S49, protease IV:Peptidase S49, SppA +FIG01170585 Salivary proline-rich protein +FIG01170605 sugar transporter family protein +FIG01170671 FIG01170672: hypothetical protein +FIG01170689 similar to Cell wall-associated hydrolase (invasion-associated proteins) +FIG01170705 aldehyde dehydrogenase (NAD+) +FIG01170706 Glucoamylase TGA +FIG01170734 FIG01170741: hypothetical protein +FIG01170786 similar to Membrane-bound lytic murein transglycosylase B +FIG01170838 FIG01170841: hypothetical protein +FIG01170878 FIG01170886: hypothetical protein +FIG01171149 FIG01171167: hypothetical protein +FIG01171177 sugar ABC-transporter integral membrane protein +FIG01171183 FIG01171190: hypothetical protein +FIG01171488 FIG01171489: hypothetical protein +FIG01171537 FIG01171543: hypothetical protein +FIG01171587 putative type I restriction system adenine methylase +FIG01171643 SecD paralog / SecF paralog +FIG01171851 FIG01171871: hypothetical protein +FIG01171871 FIG00821686: hypothetical protein +FIG01172080 plasmid transfer protein +FIG01172405 Enzymatic protein of unknown function +FIG01172760 Oligosaccharyl transferase, STT3 subunit +FIG01172823 FIG01179327: hypothetical protein +FIG01172835 Iron ABC transporter ATP-binding protein +FIG01172879 Lipoate-protein ligase A, C-terminal 25 percent +FIG01172955 putative Na(+) H(+) antiporter subunit E +FIG01173048 diptheria toxin resistance protein required for diphthamide biosynthesis (Saccharomyces)-like 1 +FIG01173113 Preprotein translocase secG subunit +FIG01173151 PAB2272 methyltransferase homolog +FIG01173180 LPS biosynthesis RfbU related protein +FIG01173296 FIG01173307: hypothetical protein +FIG01173386 excisionase/Xis, DNA-binding +FIG01173569 FIG01173588: hypothetical protein +FIG01173625 DNA hydrolase with mutT domain +FIG01173645 FIG01173646: hypothetical protein +FIG01173874 FIG01173881: hypothetical protein +FIG01173940 FIG01173952: hypothetical protein +FIG01173978 FIG01173979: hypothetical protein +FIG01174668 helicase-like +FIG01174729 protein of unknown function DUF1116 +FIG01175432 FIG01175459: hypothetical protein +FIG01175524 ABC transporter ATP-binding membrane translocator, AmfB +FIG01175776 FIG01175778: hypothetical protein +FIG01176055 Predicted transcription regulator +FIG01176107 Predicted transcription regulator (HTH) +FIG01176130 weak similarity to known protein +FIG01176219 Sugar-binding protein +FIG01176221 Permease (major facilitator superfamily) +FIG01176264 Multidrug efflux permease +FIG01176311 DNA-binding protein HTa +FIG01176328 DNA polymerase (PolB) related protein +FIG01176346 "Serine/threonine-protein kinase RIO1 " +FIG01176420 aspartate aminotransferase related protein +FIG01176423 Glucose-fructose oxidoreductase related protein +FIG01176444 FIG01176451: hypothetical protein +FIG01176451 FIG01176452: hypothetical protein +FIG01176455 FIG01176458: hypothetical protein +FIG01176459 FIG01176460: hypothetical protein +FIG01176463 FIG01176468: hypothetical protein +FIG01176481 FIG01176485: hypothetical protein +FIG01176487 FIG01176492: hypothetical protein +FIG01176492 NADH oxidase +FIG01176493 FIG01176494: hypothetical protein +FIG01176494 FIG01176502: hypothetical protein +FIG01176503 FIG01176505: hypothetical protein +FIG01176512 FIG01179443: hypothetical protein +FIG01176519 FIG01176520: hypothetical protein +FIG01176520 FIG01176523: hypothetical protein +FIG01176528 FIG01176529: hypothetical protein +FIG01176532 FIG01176533: hypothetical protein +FIG01176536 FIG01176537: hypothetical protein +FIG01176539 FIG01176540: hypothetical protein +FIG01176541 FIG01176542: hypothetical protein +FIG01176547 FIG01176549: hypothetical protein +FIG01176553 FIG01176554: hypothetical protein +FIG01176558 FIG01176559: hypothetical protein +FIG01176563 FIG01176569: hypothetical protein +FIG01176569 FIG01176571: hypothetical protein +FIG01176571 FIG01176573: hypothetical protein +FIG01176573 FIG01176575: hypothetical protein +FIG01176575 FIG01176579: hypothetical protein +FIG01176579 FIG01176580: hypothetical protein +FIG01176599 FIG01176605: hypothetical protein +FIG01176609 HAD-superfamily hydrolase subfamily IIIA +FIG01176611 FIG01176616: hypothetical protein +FIG01176616 FIG01176618: hypothetical protein +FIG01176618 FIG01176619: hypothetical protein +FIG01176619 FIG01176623: hypothetical protein +FIG01176623 FIG01176624: hypothetical protein +FIG01176624 FIG01176628: hypothetical protein +FIG01176628 FIG01176631: hypothetical protein +FIG01176631 protein of unknown function DUF375 +FIG01176632 FIG01176633: hypothetical protein +FIG01176633 FIG01176634: hypothetical protein +FIG01176634 FIG01176636: hypothetical protein +FIG01176636 FIG01176637: hypothetical protein +FIG01176637 FIG01176640: hypothetical protein +FIG01176640 FIG01176641: hypothetical protein +FIG01176641 FIG01176642: hypothetical protein +FIG01176642 FIG01176644: hypothetical protein +FIG01176647 FIG01176649: hypothetical protein +FIG01176649 FIG01176652: hypothetical protein +FIG01176654 FIG01176655: hypothetical protein +FIG01176655 FIG01176657: hypothetical protein +FIG01176658 FIG01176665: hypothetical protein +FIG01176665 FIG01176666: hypothetical protein +FIG01176666 FIG01176667: hypothetical protein +FIG01176667 FIG01176668: hypothetical protein +FIG01176668 FIG01176671: hypothetical protein +FIG01176672 FIG01176674: hypothetical protein +FIG01176674 FIG01176676: hypothetical protein +FIG01176689 FIG01176692: hypothetical protein +FIG01176692 ferritin +FIG01176693 FIG01176695: hypothetical protein +FIG01176695 FIG01176699: hypothetical protein +FIG01176699 FIG01176700: hypothetical protein +FIG01176700 FIG01176701: hypothetical protein +FIG01176707 FIG01176712: hypothetical protein +FIG01176712 FIG01176714: hypothetical protein +FIG01176714 FIG01176718: hypothetical protein +FIG01176719 FIG01176721: hypothetical protein +FIG01176721 FIG01176723: hypothetical protein +FIG01176723 FIG01176732: hypothetical protein +FIG01176732 FIG01176735: hypothetical protein +FIG01176736 FIG01176738: hypothetical protein +FIG01176738 FIG01176741: hypothetical protein +FIG01176741 FIG01176742: hypothetical protein +FIG01176748 FIG01176749: hypothetical protein +FIG01176751 FIG01176752: hypothetical protein +FIG01176752 FIG01176753: hypothetical protein +FIG01176758 FIG01176761: hypothetical protein +FIG01176763 FIG01176764: hypothetical protein +FIG01176768 FIG01176772: hypothetical protein +FIG01176772 FIG01176773: hypothetical protein +FIG01176776 FIG01176779: hypothetical protein +FIG01176779 FIG01176782: hypothetical protein +FIG01176782 FIG01176783: hypothetical protein +FIG01176783 FIG01176784: hypothetical protein +FIG01176784 FIG01176785: hypothetical protein +FIG01176786 FIG01176788: hypothetical protein +FIG01176788 FIG01176789: hypothetical protein +FIG01176789 General secretion pathway protein D +FIG01176793 FIG01176798: hypothetical protein +FIG01176802 FIG01176803: hypothetical protein +FIG01176803 FIG01176804: hypothetical protein +FIG01176805 FIG01176806: hypothetical protein +FIG01176807 Xanthine dehydrogenase, FAD binding subunit (EC 1.17.1.4) +FIG01176810 FIG01176813: hypothetical protein +FIG01176813 FIG01176815: hypothetical protein +FIG01176815 FIG01176818: hypothetical protein +FIG01176819 FIG01176820: hypothetical protein +FIG01176825 FIG01176827: hypothetical protein +FIG01176827 FIG01176828: hypothetical protein +FIG01176828 Esterase +FIG01176834 Sugar ABC transporter permease +FIG01176836 FIG01176842: hypothetical protein +FIG01176842 FIG01176845: hypothetical protein +FIG01176845 FIG01176846: hypothetical protein +FIG01176848 FIG01176849: hypothetical protein +FIG01176849 FIG01176854: hypothetical protein +FIG01176860 FIG01176863: hypothetical protein +FIG01176863 FIG01176865: hypothetical protein +FIG01176867 FIG01176872: hypothetical protein +FIG01176872 FIG01176874: hypothetical protein +FIG01176883 FIG01179939: hypothetical protein +FIG01176889 putative, Na(+) H(+) antiporter subunit C +FIG01176892 FIG01176895: hypothetical protein +FIG01176895 FIG01176899: hypothetical protein +FIG01176899 FIG01176900: hypothetical protein +FIG01176900 FIG01176901: hypothetical protein +FIG01176901 FIG01176902: hypothetical protein +FIG01176902 FIG01176909: hypothetical protein +FIG01176909 protein of unknown function DUF39 +FIG01176910 FIG01176912: hypothetical protein +FIG01176919 FIG01176926: hypothetical protein +FIG01176945 FIG01176952: hypothetical protein +FIG01176954 FIG01176955: hypothetical protein +FIG01176955 FIG01176956: hypothetical protein +FIG01176956 FIG01176958: hypothetical protein +FIG01176958 FIG01176959: hypothetical protein +FIG01176959 FIG01176960: hypothetical protein +FIG01176960 FIG01176964: hypothetical protein +FIG01176964 FIG01176967: hypothetical protein +FIG01176968 FIG01176969: hypothetical protein +FIG01176969 FIG01176973: hypothetical protein +FIG01176975 Predicted chitobiose ABC transport system II, permease protein 1 +FIG01176976 FIG01176985: hypothetical protein +FIG01176992 FIG01176994: hypothetical protein +FIG01177003 FIG01177004: hypothetical protein +FIG01177005 FIG01177006: hypothetical protein +FIG01177006 FIG01177007: hypothetical protein +FIG01177007 FIG01177008: hypothetical protein +FIG01177008 FIG01177012: hypothetical protein +FIG01177012 FIG01177015: hypothetical protein +FIG01177015 FIG01177017: hypothetical protein +FIG01177017 FIG01177018: hypothetical protein +FIG01177019 FIG01177022: hypothetical protein +FIG01177025 FIG01177026: hypothetical protein +FIG01177034 FIG01177036: hypothetical protein +FIG01177046 FIG01177051: hypothetical protein +FIG01177054 FIG01177058: hypothetical protein +FIG01177059 FIG01177063: hypothetical protein +FIG01177070 FIG01177073: hypothetical protein +FIG01177074 FIG01177076: hypothetical protein +FIG01177076 cation antiporter +FIG01177079 FIG01177081: hypothetical protein +FIG01177081 FIG01177084: hypothetical protein +FIG01177084 FIG01177085: hypothetical protein +FIG01177085 FIG01177087: hypothetical protein +FIG01177087 FIG01177091: hypothetical protein +FIG01177091 FIG01177094: hypothetical protein +FIG01177094 FIG01177098: hypothetical protein +FIG01177099 FIG01177101: hypothetical protein +FIG01177101 FIG01177103: hypothetical protein +FIG01177103 FIG01177110: hypothetical protein +FIG01177118 FIG01177120: hypothetical protein +FIG01177121 FIG01177123: hypothetical protein +FIG01177125 FIG01177126: hypothetical protein +FIG01177127 FIG01177129: hypothetical protein +FIG01177136 FIG01177137: hypothetical protein +FIG01177137 FIG01177138: hypothetical protein +FIG01177138 FIG01177139: hypothetical protein +FIG01177139 FIG01177141: hypothetical protein +FIG01177145 putative RNA methylase +FIG01177149 nuclease (RecB family)-like protein +FIG01177151 FIG01177152: hypothetical protein +FIG01177153 FIG01177154: hypothetical protein +FIG01177158 FIG01177159: hypothetical protein +FIG01177159 FIG01177160: hypothetical protein +FIG01177162 Dehydrase +FIG01177165 FIG01177166: hypothetical protein +FIG01177166 FIG01177173: hypothetical protein +FIG01177176 FIG01177177: hypothetical protein +FIG01177182 FIG01177185: hypothetical protein +FIG01177201 FIG01177203: hypothetical protein +FIG01177204 FIG01177205: hypothetical protein +FIG01177209 FIG01177212: hypothetical protein +FIG01177212 FIG01177217: hypothetical protein +FIG01177221 FIG01177226: hypothetical protein +FIG01177226 FIG01177227: hypothetical protein +FIG01177227 NAD/NADP octopine/nopaline dehydrogenase +FIG01177241 FIG01177244: hypothetical protein +FIG01177244 FIG01177247: hypothetical protein +FIG01177247 FIG01177250: hypothetical protein +FIG01177262 FIG01177263: hypothetical protein +FIG01177266 FIG01177267: hypothetical protein +FIG01177275 FIG01177277: hypothetical protein +FIG01177279 FIG01177294: hypothetical protein +FIG01177295 bacterioferritin comigratory protein, ahpC/TSA family +FIG01177300 flagellar biosynthesis-related protein +FIG01177302 FIG01177305: hypothetical protein +FIG01177310 FIG01177312: hypothetical protein +FIG01177312 FIG01177313: hypothetical protein +FIG01177318 FIG01177319: hypothetical protein +FIG01177324 FIG01177326: hypothetical protein +FIG01177326 FIG01177328: hypothetical protein +FIG01177328 FIG01177330: hypothetical protein +FIG01177341 FIG01177342: hypothetical protein +FIG01177342 FIG01177343: hypothetical protein +FIG01177343 FIG01177344: hypothetical protein +FIG01177344 FIG01177349: hypothetical protein +FIG01177349 FIG01177354: hypothetical protein +FIG01177354 FIG01177357: hypothetical protein +FIG01177358 FIG01177361: hypothetical protein +FIG01177367 FIG01177368: hypothetical protein +FIG01177374 FIG01177375: hypothetical protein +FIG01177375 Sarcosine oxidase, subunit beta +FIG01177383 FIG004853: possible toxin to DivIC +FIG01177384 FIG01177386: hypothetical protein +FIG01177396 FIG01177398: hypothetical protein +FIG01177398 protein of unknown function DUF71, ATP-binding region +FIG01177399 FIG01177400: hypothetical protein +FIG01177405 FIG01177407: hypothetical protein +FIG01177408 FIG01177409: hypothetical protein +FIG01177409 FIG01177410: hypothetical protein +FIG01177421 FIG01177428: hypothetical protein +FIG01177428 FIG01177432: hypothetical protein +FIG01177434 Bifunctional aspartokinase/homoserine dehydrogenase (AK-HD) [Includes: Aspartokinase (EC 2.7.2.4); Homoserine dehydrogenase (EC 1.1.1.3)] +FIG01177439 FIG01177440: hypothetical protein +FIG01177441 FIG01177446: hypothetical protein +FIG01177473 nucleic acid binding OB-fold tRNA/helicase-type +FIG01177477 FIG01177481: hypothetical protein +FIG01177487 FIG01177488: hypothetical protein +FIG01177499 Protein-glutamate methylesterase CheB (EC 3.1.1.61) +FIG01177500 UPF0173 metal-dependent hydrolase TM_1162 +FIG01177502 FIG01177508: hypothetical protein +FIG01177512 FIG01177518: hypothetical protein +FIG01177525 FIG01177532: hypothetical protein +FIG01177538 FIG01177541: hypothetical protein +FIG01177541 FIG01177543: hypothetical protein +FIG01177545 FIG01177546: hypothetical protein +FIG01177548 FIG01177550: hypothetical protein +FIG01177562 FIG01177563: hypothetical protein +FIG01177565 FIG01177566: hypothetical protein +FIG01177577 FIG01177578: hypothetical protein +FIG01177615 FIG01177622: hypothetical protein +FIG01177645 FIG01177649: hypothetical protein +FIG01177657 FIG01177666: hypothetical protein +FIG01177673 FIG01177675: hypothetical protein +FIG01177751 FIG01177756: hypothetical protein +FIG01177764 FIG01177767: hypothetical protein +FIG01177771 FIG01177781: hypothetical protein +FIG01177906 FIG01177907: hypothetical protein +FIG01178075 FIG01178078: hypothetical protein +FIG01178197 ORF_ID:tll0135 hypothetical protein +FIG01178233 FIG01178238: hypothetical protein +FIG01178314 FIG01178315: hypothetical protein +FIG01178349 ORF_ID:tll1023 hypothetical protein +FIG01178388 FIG01178389: hypothetical protein +FIG01178473 ORF_ID:tlr0320 unknown protein +FIG01178494 Deoxyhypusine synthase (EC 2.5.1.46) +FIG01178500 ORF_ID:tlr2258 hypothetical protein +FIG01178516 FIG01178519: hypothetical protein +FIG01178667 putative thiol-specific antioxidant protein +FIG01178738 CheY subfamily +FIG01178751 ORF_ID:tlr1644 probable protein phosphatase +FIG01179133 FIG01179135: hypothetical protein +FIG01179135 FIG01179137: hypothetical protein +FIG01179140 Xylose isomerase +FIG01179145 FIG01179146: hypothetical protein +FIG01179147 dehydrase-related protein +FIG01179149 FIG01179150: hypothetical protein +FIG01179151 astB/chuR-related protein +FIG01179152 FIG01179153: hypothetical protein +FIG01179153 FIG01179154: hypothetical protein +FIG01179155 FIG01179156: hypothetical protein +FIG01179156 FIG01179157: hypothetical protein +FIG01179158 FIG01179159: hypothetical protein +FIG01179159 UPF0348 protein CPE1726 +FIG01179160 FIG01179165: hypothetical protein +FIG01179165 FIG01179167: hypothetical protein +FIG01179167 FIG01179168: hypothetical protein +FIG01179168 FIG01179171: hypothetical protein +FIG01179171 FIG01179173: hypothetical protein +FIG01179173 FIG01179174: hypothetical protein +FIG01179179 FIG01179181: hypothetical protein +FIG01179181 FIG01179183: hypothetical protein +FIG01179183 FIG01179185: hypothetical protein +FIG01179185 FIG01179187: hypothetical protein +FIG01179188 FIG01179189: hypothetical protein +FIG01179189 FIG01179192: hypothetical protein +FIG01179199 Inositol-related sugar-phosphate epimerase +FIG01179201 Novel inositol-related kinase, PfkB family (EC 2.7.1.12) +FIG01179206 FIG01179207: hypothetical protein +FIG01179208 FIG01179209: hypothetical protein +FIG01179210 FIG01179211: hypothetical protein +FIG01179211 FIG01179212: hypothetical protein +FIG01179212 UPF0166 protein TM_0021 +FIG01179220 FIG01179221: hypothetical protein +FIG01179222 FIG01179223: hypothetical protein +FIG01179226 FIG01179227: hypothetical protein +FIG01179227 Predicted regulator of alpha-mannoside utilization, LacI family +FIG01179229 FIG01179231: hypothetical protein +FIG01179232 FIG01179233: hypothetical protein +FIG01179233 FIG01179234: hypothetical protein +FIG01179235 FIG01179236: hypothetical protein +FIG01179239 FIG01179242: hypothetical protein +FIG01179242 FIG01179247: hypothetical protein +FIG01179249 Iron(III) dicitrate-binding protein +FIG01179251 FIG01179253: hypothetical protein +FIG01179253 FIG01179254: hypothetical protein +FIG01179254 FIG01179257: hypothetical protein +FIG01179257 FIG01179258: hypothetical protein +FIG01179260 FIG01179261: hypothetical protein +FIG01179267 FIG01179269: hypothetical protein +FIG01179271 FIG01179272: hypothetical protein +FIG01179274 FIG01179276: hypothetical protein +FIG01179276 FIG01179278: hypothetical protein +FIG01179285 FIG01179286: hypothetical protein +FIG01179287 FIG01179288: hypothetical protein +FIG01179290 Thermostable mannitol dehydrogenase +FIG01179292 FIG01179294: hypothetical protein +FIG01179295 FIG01179299: hypothetical protein +FIG01179299 FIG01179301: hypothetical protein +FIG01179302 FIG01179303: hypothetical protein +FIG01179303 FIG01179304: hypothetical protein +FIG01179304 FIG01179305: hypothetical protein +FIG01179309 FIG01179310: hypothetical protein +FIG01179310 FIG01179313: hypothetical protein +FIG01179314 FIG01179318: hypothetical protein +FIG01179318 methyl-accepting chemotaxis-related protein +FIG01179319 FIG01179320: hypothetical protein +FIG01179320 FIG01179322: hypothetical protein +FIG01179322 protein of unknown function DUF322 +FIG01179328 S-layer-like array protein +FIG01179329 FIG004853: possible toxin to DivIC +FIG01179331 FIG01179332: hypothetical protein +FIG01179332 FIG01179334: hypothetical protein +FIG01179335 FIG01179336: hypothetical protein +FIG01179336 FIG01179338: hypothetical protein +FIG01179338 FIG01179339: hypothetical protein +FIG01179342 FIG01179343: hypothetical protein +FIG01179346 Predicted aldo/keto reductase in CelR regulon, COG4989 +FIG01179348 Endo-mannanase (EC 3.2.1.78) +FIG01179349 FIG01179350: hypothetical protein +FIG01179350 FIG01179351: hypothetical protein +FIG01179354 FIG01179356: hypothetical protein +FIG01179356 FIG01179357: hypothetical protein +FIG01179361 FIG01179363: hypothetical protein +FIG01179363 FIG01179364: hypothetical protein +FIG01179364 FIG01179366: hypothetical protein +FIG01179369 FIG01179370: hypothetical protein +FIG01179371 FIG01179373: hypothetical protein +FIG01179373 FIG01179375: hypothetical protein +FIG01179376 Acetamidase/formamidase (EC 3.5.1.49) +FIG01179381 FIG01179384: hypothetical protein +FIG01179387 FIG01179388: hypothetical protein +FIG01179388 FIG01179390: hypothetical protein +FIG01179390 FIG01179391: hypothetical protein +FIG01179393 FIG01179396: hypothetical protein +FIG01179399 FIG01179400: hypothetical protein +FIG01179400 FIG01179401: hypothetical protein +FIG01179401 FIG01179404: hypothetical protein +FIG01179404 FIG01179406: hypothetical protein +FIG01179409 FIG01179411: hypothetical protein +FIG01179411 FIG01179413: hypothetical protein +FIG01179413 FIG01179414: hypothetical protein +FIG01179418 FIG01179421: hypothetical protein +FIG01179421 FIG01179422: hypothetical protein +FIG01179422 FIG01179423: hypothetical protein +FIG01179428 Uncharacterized protein TM_0562.1 +FIG01179430 FIG01179431: hypothetical protein +FIG01179431 Hypothetical protein TM0063 +FIG01179433 transcriptional regulator, metal-sensing +FIG01179435 integrase-recombinase protein +FIG01179437 FIG01179438: hypothetical protein +FIG01179439 FIG01179441: hypothetical protein +FIG01179441 FIG01179442: hypothetical protein +FIG01179444 FIG01179445: hypothetical protein +FIG01179447 FIG01179448: hypothetical protein +FIG01179448 Hypothetical protein TM0026, BglR regulon +FIG01179449 FIG01179450: hypothetical protein +FIG01179450 FIG01179451: hypothetical protein +FIG01179451 FIG01179455: hypothetical protein +FIG01179455 Putative unsaturated glucuronyl hydrolase +FIG01179456 FIG01179457: hypothetical protein +FIG01179457 FIG01179458: hypothetical protein +FIG01179458 FIG01179460: hypothetical protein +FIG01179460 FIG01179461: hypothetical protein +FIG01179462 FIG01179467: hypothetical protein +FIG01179467 DNA-directed RNA polymerase omega chain (EC 2.7.7.6) +FIG01179470 FIG01179471: hypothetical protein +FIG01179477 NADH-ubiquinone oxidoreductase chain N (EC 1.6.5.3) +FIG01179481 FIG01179484: hypothetical protein +FIG01179486 FIG01179488: hypothetical protein +FIG01179488 FIG01179489: hypothetical protein +FIG01179489 FIG01179490: hypothetical protein +FIG01179492 FIG01179494: hypothetical protein +FIG01179496 FIG01179497: hypothetical protein +FIG01179497 FIG01179499: hypothetical protein +FIG01179499 FIG01179502: hypothetical protein +FIG01179508 FIG01179509: hypothetical protein +FIG01179510 FIG01179512: hypothetical protein +FIG01179512 FIG01179515: hypothetical protein +FIG01179515 FIG01179516: hypothetical protein +FIG01179516 hypothetical protein +FIG01179518 FIG01179521: hypothetical protein +FIG01179522 FIG01179523: hypothetical protein +FIG01179523 FIG01179524: hypothetical protein +FIG01179524 FIG01179525: hypothetical protein +FIG01179525 FIG01179527: hypothetical protein +FIG01179527 Hypothetical protein TM0950 +FIG01179531 Alpha-1,4-digalacturonate ABC transporter, permease protein 2 +FIG01179540 FIG01179541: hypothetical protein +FIG01179541 FIG01179542: hypothetical protein +FIG01179542 FIG01179543: hypothetical protein +FIG01179543 FIG01179544: hypothetical protein +FIG01179545 FIG01179549: hypothetical protein +FIG01179549 FIG01179550: hypothetical protein +FIG01179555 FIG01179556: hypothetical protein +FIG01179558 FIG01179559: hypothetical protein +FIG01179559 FIG01179561: hypothetical protein +FIG01179563 FIG01179564: hypothetical protein +FIG01179564 FIG01179566: hypothetical protein +FIG01179566 FIG01179568: hypothetical protein +FIG01179568 FIG01179572: hypothetical protein +FIG01179572 ubiquinone/menaquinone biosynthesis methyltransferase-related protein +FIG01179576 Arsenite permease +FIG01179577 Predicted galactoside ABC transporter, sugar-binding protein +FIG01179581 FIG01179583: hypothetical protein +FIG01179583 FIG01179584: hypothetical protein +FIG01179585 FIG01179589: hypothetical protein +FIG01179592 FIG01179593: hypothetical protein +FIG01179593 FIG01179594: hypothetical protein +FIG01179595 FIG01179596: hypothetical protein +FIG01179597 FIG01179598: hypothetical protein +FIG01179610 FIG01179614: hypothetical protein +FIG01179615 FIG01179616: hypothetical protein +FIG01179616 FIG01179617: hypothetical protein +FIG01179619 FIG01179620: hypothetical protein +FIG01179622 FIG01179623: hypothetical protein +FIG01179637 Hypothetical protein, no COGs +FIG01179642 FIG01179643: hypothetical protein +FIG01179646 FIG01179648: hypothetical protein +FIG01179648 FIG01179649: hypothetical protein +FIG01179649 FIG01179652: hypothetical protein +FIG01179654 FIG01179658: hypothetical protein +FIG01179658 FIG01179659: hypothetical protein +FIG01179659 FIG01179664: hypothetical protein +FIG01179664 FIG01179665: hypothetical protein +FIG01179666 FIG01179668: hypothetical protein +FIG01179668 Uncharacterized ATP-dependent helicase MJ0104 +FIG01179669 FIG01179670: hypothetical protein +FIG01179670 FIG01179671: hypothetical protein +FIG01179671 FIG01179673: hypothetical protein +FIG01179673 FIG01179675: hypothetical protein +FIG01179676 Maltodextrin glycosyltransferase MmtA +FIG01179679 FIG01179680: hypothetical protein +FIG01179683 Putative NADH dehydrogenase/NAD(P)H nitroreductase (EC 1.-.-.-) +FIG01179684 FIG01179685: hypothetical protein +FIG01179685 FIG01179686: hypothetical protein +FIG01179686 FIG01179688: hypothetical protein +FIG01179691 FIG01179692: hypothetical protein +FIG01179692 S-layer domain protein +FIG01179693 FIG01179695: hypothetical protein +FIG01179695 FIG01179696: hypothetical protein +FIG01179696 FIG01179697: hypothetical protein +FIG01179697 Uncharacterized protein TM_0929 +FIG01179700 FIG01179701: hypothetical protein +FIG01179703 FIG01179706: hypothetical protein +FIG01179706 Antilisterial bacteriocin subtilosin biosynthesis protein albA +FIG01179710 FIG01179712: hypothetical protein +FIG01179712 FIG01179713: hypothetical protein +FIG01179713 FIG01179715: hypothetical protein +FIG01179715 FIG01179720: hypothetical protein +FIG01179724 FIG01179726: hypothetical protein +FIG01179726 FIG01179727: hypothetical protein +FIG01179727 FIG01179729: hypothetical protein +FIG01179731 FIG01179736: hypothetical protein +FIG01179737 FIG01179738: hypothetical protein +FIG01179738 FIG01179743: hypothetical protein +FIG01179743 FIG01179745: hypothetical protein +FIG01179745 FIG01179746: hypothetical protein +FIG01179746 FIG01179747: hypothetical protein +FIG01179747 FIG01179749: hypothetical protein +FIG01179749 FIG01179750: hypothetical protein +FIG01179751 FIG01179755: hypothetical protein +FIG01179755 FIG01179757: hypothetical protein +FIG01179758 FIG01179760: hypothetical protein +FIG01179763 FIG01179764: hypothetical protein +FIG01179764 motif=ATP/GTP-binding site motif A (P-loop); G-protein coupled receptors signature +FIG01179775 FIG01179776: hypothetical protein +FIG01179777 FIG01179779: hypothetical protein +FIG01179779 FIG01179782: hypothetical protein +FIG01179782 Predicted galactoside ABC transporter, ATP-binding protein 2 +FIG01179783 FIG01179786: hypothetical protein +FIG01179787 FIG01179789: hypothetical protein +FIG01179789 FIG01179791: hypothetical protein +FIG01179792 FIG01179794: hypothetical protein +FIG01179795 FIG01179796: hypothetical protein +FIG01179796 FIG01179797: hypothetical protein +FIG01179799 FIG01179801: hypothetical protein +FIG01179802 FIG01179803: hypothetical protein +FIG01179808 Na(+) H(+) antiporter subunit E (TC 2.A.63.1.2) +FIG01179810 Alpha-mannosidase-related protein, family 38 +FIG01179811 FIG01179813: hypothetical protein +FIG01179817 FIG01179822: hypothetical protein +FIG01179826 FIG01179827: hypothetical protein +FIG01179830 HI0933 family protein +FIG01179831 FIG01179832: hypothetical protein +FIG01179832 FIG01179833: hypothetical protein +FIG01179833 Protein often near L-alanine-DL-glutamate epimerase (cell wall recycling) +FIG01179834 FIG01179837: hypothetical protein +FIG01179839 FIG01179844: hypothetical protein +FIG01179844 FIG01179845: hypothetical protein +FIG01179845 FIG01179846: hypothetical protein +FIG01179847 FIG01179849: hypothetical protein +FIG01179853 FIG01179855: hypothetical protein +FIG01179855 FIG01179856: hypothetical protein +FIG01179861 FIG01179863: hypothetical protein +FIG01179865 FIG01179866: hypothetical protein +FIG01179868 FIG01179869: hypothetical protein +FIG01179869 FIG01179870: hypothetical protein +FIG01179870 FIG01179871: hypothetical protein +FIG01179871 FIG01179873: hypothetical protein +FIG01179873 FIG01179874: hypothetical protein +FIG01179874 FIG01179879: hypothetical protein +FIG01179879 FIG01179881: hypothetical protein +FIG01179881 FIG01179882: hypothetical protein +FIG01179888 FIG01179889: hypothetical protein +FIG01179890 FIG01179892: hypothetical protein +FIG01179894 FIG01179896: hypothetical protein +FIG01179900 FIG01179903: hypothetical protein +FIG01179903 FIG01179905: hypothetical protein +FIG01179908 FIG01179909: hypothetical protein +FIG01179912 FIG01179914: hypothetical protein +FIG01179917 FIG01179919: hypothetical protein +FIG01179919 FIG01179921: hypothetical protein +FIG01179922 FIG01179924: hypothetical protein +FIG01179924 FIG01179925: hypothetical protein +FIG01179925 Uncharacterized protein MJ1426 +FIG01179928 FIG01179932: hypothetical protein +FIG01179934 FIG01179935: hypothetical protein +FIG01179939 FIG01179940: hypothetical protein +FIG01179940 FIG01179941: hypothetical protein +FIG01179944 FIG01179946: hypothetical protein +FIG01179948 FIG01179949: hypothetical protein +FIG01179949 FIG01179951: hypothetical protein +FIG01179952 FIG01179960: hypothetical protein +FIG01179961 FIG01179962: hypothetical protein +FIG01179968 FIG01179970: hypothetical protein +FIG01179973 FIG01179974: hypothetical protein +FIG01179974 FIG01179975: hypothetical protein +FIG01179976 FIG01179977: hypothetical protein +FIG01179977 FIG01179979: hypothetical protein +FIG01179984 FIG01179986: hypothetical protein +FIG01179991 FIG01179993: hypothetical protein +FIG01180003 FIG01180004: hypothetical protein +FIG01180008 CRISPR-associated protein Cas5 +FIG01180012 Hypothetical protein TM0101 in cluster with unspecified monosaccharide ABC transport system +FIG01180013 FIG028593: membrane protein +FIG01180019 FIG01180021: hypothetical protein +FIG01180021 FIG01180024: hypothetical protein +FIG01180024 FIG01180026: hypothetical protein +FIG01180028 FIG01180031: hypothetical protein +FIG01180032 FIG01180037: hypothetical protein +FIG01180045 FIG01180046: hypothetical protein +FIG01180046 FIG01180052: hypothetical protein +FIG01180052 Xylose oligosaccharides ABC transporter, sugar-binding protein +FIG01180053 FIG01180054: hypothetical protein +FIG01180054 FIG01180056: hypothetical protein +FIG01180056 FIG01180062: hypothetical protein +FIG01180068 FIG01180071: hypothetical protein +FIG01180071 FIG01180072: hypothetical protein +FIG01180072 FIG01180073: hypothetical protein +FIG01180073 clostripain-related protein +FIG01180078 FIG01180081: hypothetical protein +FIG01180081 FIG01180082: hypothetical protein +FIG01180083 FIG01180084: hypothetical protein +FIG01180085 FIG01180086: hypothetical protein +FIG01180086 Uncharacterized oxidoreductase TM_0019 +FIG01180093 FIG01180094: hypothetical protein +FIG01180095 FIG01180097: hypothetical protein +FIG01180106 FIG01180107: hypothetical protein +FIG01180112 hypothetical protein +FIG01180116 FIG01180117: hypothetical protein +FIG01180118 FIG01180119: hypothetical protein +FIG01180122 FIG01180124: hypothetical protein +FIG01180124 protein of unknown function DUF205 +FIG01180126 FIG01180131: hypothetical protein +FIG01180136 FIG01180141: hypothetical protein +FIG01180141 FIG01180142: hypothetical protein +FIG01180142 FIG01180145: hypothetical protein +FIG01180150 FIG01180153: hypothetical protein +FIG01180153 FIG01180154: hypothetical protein +FIG01180154 FIG01180157: hypothetical protein +FIG01180162 DUF1015 domain-containing protein +FIG01180164 Unknown carbohydrate utilization transcriptional regulator UctR, RpiR family +FIG01180168 FIG01180169: hypothetical protein +FIG01180178 Probable N-glycosylase/DNA lyase [Includes: 8-oxoguanine DNA glycosylase (EC 3.2.2.-); DNA-(apurinic or apyrimidinic site) lyase (EC 4.2.99.18) (AP lyase)] +FIG01180180 FIG01180183: hypothetical protein +FIG01180188 FIG01180190: hypothetical protein +FIG01180199 FIG01180200: hypothetical protein +FIG01180211 FIG01180212: hypothetical protein +FIG01180215 FIG01180219: hypothetical protein +FIG01180219 FIG01180221: hypothetical protein +FIG01180222 FIG01180225: hypothetical protein +FIG01180230 heavy metal resistance transcriptional regulator +FIG01180238 FIG01180239: hypothetical protein +FIG01180240 FIG01180244: hypothetical protein +FIG01180250 Predicted rhamnose oligosaccharide ABC transporter, ATP-binding component 2 +FIG01180257 FIG01180258: hypothetical protein +FIG01180258 FIG01180260: hypothetical protein +FIG01180273 FIG01180275: hypothetical protein +FIG01180285 FIG01180286: hypothetical protein +FIG01180301 m4C-methyltransferase +FIG01180303 FIG01180305: hypothetical protein +FIG01180313 FIG01180315: hypothetical protein +FIG01180325 FIG01180326: hypothetical protein +FIG01180353 FIG01180354: hypothetical protein +FIG01180354 Carbohydrate-binding, CenC domain protein +FIG01180376 FIG01180377: hypothetical protein +FIG01180382 FIG01180383: hypothetical protein +FIG01180388 FIG01180393: hypothetical protein +FIG01180400 FIG01180401: hypothetical protein +FIG01180412 FIG01180416: hypothetical protein +FIG01180431 FIG01180432: hypothetical protein +FIG01180445 FIG01180446: hypothetical protein +FIG01180451 FIG01180454: hypothetical protein +FIG01180486 FIG01180489: hypothetical protein +FIG01180495 FIG01180496: hypothetical protein +FIG01180496 Predicted galactoside ABC transporter type II, permease protein 1 +FIG01180498 FIG01180499: hypothetical protein +FIG01180509 Periplasmic ribose-binding protein, sugar ABC transporter +FIG01180528 FIG01180529: hypothetical protein +FIG01180530 FIG01180531: hypothetical protein +FIG01180531 FIG01180532: hypothetical protein +FIG01180539 FIG01180540: hypothetical protein +FIG01180541 FIG01180542: hypothetical protein +FIG01180559 FIG01180563: hypothetical protein +FIG01180582 FIG01180584: hypothetical protein +FIG01180598 FIG01180604: hypothetical protein +FIG01180644 FIG01180647: hypothetical protein +FIG01180653 FIG01180657: hypothetical protein +FIG01180668 FIG01180670: hypothetical protein +FIG01180695 FIG01180696: hypothetical protein +FIG01180701 FIG01180702: hypothetical protein +FIG01180708 FIG01180711: hypothetical protein +FIG01180730 FIG01180731: hypothetical protein +FIG01180735 FIG01180738: hypothetical protein +FIG01180763 helicase-related protein +FIG01180767 FIG01180768: hypothetical protein +FIG01180768 Putative sugar isomerase +FIG01180785 FIG01180789: hypothetical protein +FIG01180844 FIG01180845: hypothetical protein +FIG01180846 FIG01180847: hypothetical protein +FIG01180847 FIG01180848: hypothetical protein +FIG01180849 FIG01180852: hypothetical protein +FIG01180853 heat-stable protein +FIG01180856 Serine/threonine-protein kinase pkn2 (EC 2.7.11.1) +FIG01180857 FIG01180858: hypothetical protein +FIG01180858 FIG01180859: hypothetical protein +FIG01180859 FIG01180861: hypothetical protein +FIG01180864 FIG01180865: hypothetical protein +FIG01180865 FIG01180866: hypothetical protein +FIG01180866 FIG01180867: hypothetical protein +FIG01180867 corticosteroid 11-beta-dehydrogenase +FIG01180869 FIG01180870: hypothetical protein +FIG01180870 FIG01180871: hypothetical protein +FIG01180871 FIG01180872: hypothetical protein +FIG01180872 FIG01180873: hypothetical protein +FIG01180873 prepilin-like protein +FIG01180874 FIG01180875: hypothetical protein +FIG01180877 FIG01180880: hypothetical protein +FIG01180880 Zinc protease (EC 3.4.99.-) +FIG01180882 FIG01180884: hypothetical protein +FIG01180885 FIG01180887: hypothetical protein +FIG01180890 FIG01180892: hypothetical protein +FIG01180892 FIG01180894: hypothetical protein +FIG01180894 FIG01180895: hypothetical protein +FIG01180895 FIG01180896: hypothetical protein +FIG01180896 mannosyl-3-phosphogylcerate synthase +FIG01180899 FIG01180900: hypothetical protein +FIG01180900 putative phosphoribosyl transferase +FIG01180903 FIG01180904: hypothetical protein +FIG01180905 FIG01180907: hypothetical protein +FIG01180907 FIG01180908: hypothetical protein +FIG01180908 FIG01180912: hypothetical protein +FIG01180917 FIG01180918: hypothetical protein +FIG01180918 FIG01180920: hypothetical protein +FIG01180923 FIG01180924: hypothetical protein +FIG01180925 FIG01180926: hypothetical protein +FIG01180927 FIG01180928: hypothetical protein +FIG01180930 FIG01180931: hypothetical protein +FIG01180932 FIG01180933: hypothetical protein +FIG01180933 sulfite dehydrogenase +FIG01180935 FIG01180936: hypothetical protein +FIG01180936 Glucosyl-3-phosphoglycerate phosphatase (EC 3.1.3.85) @ Mannosyl-3-phosphoglycerate phosphatase (EC 3.1.3.70) +FIG01180937 FIG01180938: hypothetical protein +FIG01180939 FIG01180940: hypothetical protein +FIG01180940 FIG01180941: hypothetical protein +FIG01180941 FIG01180944: hypothetical protein +FIG01180945 FIG01180946: hypothetical protein +FIG01180947 FIG01180949: hypothetical protein +FIG01180949 FIG01180951: hypothetical protein +FIG01180951 FIG01180954: hypothetical protein +FIG01180954 FIG01180955: hypothetical protein +FIG01180955 chromosome partition protein smc +FIG01180958 glucose-1-phosphate adenylyltransferase( EC:2.7.7.27 ) +FIG01180959 FIG01180963: hypothetical protein +FIG01180963 putative carbohydrate binding protein +FIG01180965 FIG01180967: hypothetical protein +FIG01180969 FIG01180970: hypothetical protein +FIG01180970 FIG01180971: hypothetical protein +FIG01180972 Tungsten-containing aldehyde ferredoxin oxidoreductase (EC 1.2.7.5) +FIG01180973 FIG01180975: hypothetical protein +FIG01180977 FIG01180978: hypothetical protein +FIG01180978 FIG01180980: hypothetical protein +FIG01180981 FIG01180982: hypothetical protein +FIG01180990 Type B carboxylesterase +FIG01180998 competence protein dprA +FIG01181000 FIG01181001: hypothetical protein +FIG01181001 FIG01181003: hypothetical protein +FIG01181004 FIG01181005: hypothetical protein +FIG01181005 FIG01181008: hypothetical protein +FIG01181008 FIG01181009: hypothetical protein +FIG01181010 FIG01181012: hypothetical protein +FIG01181012 FIG01181013: hypothetical protein +FIG01181013 FIG01181014: hypothetical protein +FIG01181014 FIG01181016: hypothetical protein +FIG01181016 FIG01181017: hypothetical protein +FIG01181017 FIG01181019: hypothetical protein +FIG01181022 FIG01181023: hypothetical protein +FIG01181023 FIG01181024: hypothetical protein +FIG01181024 FIG01181025: hypothetical protein +FIG01181025 FIG01181029: hypothetical protein +FIG01181031 FIG01181033: hypothetical protein +FIG01181033 FIG01181034: hypothetical protein +FIG01181034 FIG01181035: hypothetical protein +FIG01181035 FIG01181036: hypothetical protein +FIG01181036 FIG01181037: hypothetical protein +FIG01181037 FIG01181039: hypothetical protein +FIG01181039 metallo-beta-lactamase protein +FIG01181040 FIG01181041: hypothetical protein +FIG01181041 FIG01181042: hypothetical protein +FIG01181045 FIG01181046: hypothetical protein +FIG01181046 FIG01181047: hypothetical protein +FIG01181047 FIG01181048: hypothetical protein +FIG01181048 FIG01181049: hypothetical protein +FIG01181051 FIG01181052: hypothetical protein +FIG01181053 FIG01181054: hypothetical protein +FIG01181054 FIG01181056: hypothetical protein +FIG01181056 FIG01181058: hypothetical protein +FIG01181061 FIG01181062: hypothetical protein +FIG01181063 FIG01181064: hypothetical protein +FIG01181064 FIG01181065: hypothetical protein +FIG01181065 FIG01181066: hypothetical protein +FIG01181066 FIG01181067: hypothetical protein +FIG01181067 FIG01181068: hypothetical protein +FIG01181072 FIG01181073: hypothetical protein +FIG01181078 FIG01181081: hypothetical protein +FIG01181085 FIG01181087: hypothetical protein +FIG01181087 Response regulator receiver protein in cluster with DNA polymerase III epsilon subunit +FIG01181089 FIG01181091: hypothetical protein +FIG01181091 FIG01181092: hypothetical protein +FIG01181092 FIG01181093: hypothetical protein +FIG01181094 Periplasmic serine protease, HtrA/DegQ/DegS family +FIG01181095 FIG01181096: hypothetical protein +FIG01181097 FIG01181098: hypothetical protein +FIG01181098 FIG01181101: hypothetical protein +FIG01181101 glutaredoxin-like protein +FIG01181103 FIG01181105: hypothetical protein +FIG01181106 FIG01181107: hypothetical protein +FIG01181107 FIG01181108: hypothetical protein +FIG01181108 FIG01181111: hypothetical protein +FIG01181111 NAD(FAD)-utilizing enzyme +FIG01181116 FIG01181117: hypothetical protein +FIG01181121 FIG01181124: hypothetical protein +FIG01181124 FIG01181125: hypothetical protein +FIG01181125 zrk system potassium uptake protein trkA +FIG01181126 FIG01181127: hypothetical protein +FIG01181127 FIG01181128: hypothetical protein +FIG01181128 FIG01181129: hypothetical protein +FIG01181131 FIG01181132: hypothetical protein +FIG01181132 ATP-dependent DNA helicase RecG-related protein +FIG01181133 FIG01181134: hypothetical protein +FIG01181135 FIG01181137: hypothetical protein +FIG01181137 FIG01181139: hypothetical protein +FIG01181140 FIG01181141: hypothetical protein +FIG01181141 Glycosyl transferase group 1 +FIG01181147 FIG01181148: hypothetical protein +FIG01181151 FIG01181153: hypothetical protein +FIG01181155 Modification methylase TaqI (EC 2.1.1.72) +FIG01181156 Tlr1989 protein +FIG01181157 FIG01181158: hypothetical protein +FIG01181158 FIG01181159: hypothetical protein +FIG01181159 FIG01181160: hypothetical protein +FIG01181160 FIG01181161: hypothetical protein +FIG01181161 FIG01181162: hypothetical protein +FIG01181162 zinc protease( EC:3.4.99.- ) +FIG01181163 FIG01181164: hypothetical protein +FIG01181164 FIG01181165: hypothetical protein +FIG01181167 FIG01181169: hypothetical protein +FIG01181171 FIG01181172: hypothetical protein +FIG01181172 FIG01181173: hypothetical protein +FIG01181173 FIG01181174: hypothetical protein +FIG01181174 acriflavin resistance protein B +FIG01181175 comA operon protein 2 +FIG01181182 trk system potassium uptake protein trkA +FIG01181184 FIG01181187: hypothetical protein +FIG01181187 FIG01181188: hypothetical protein +FIG01181188 FIG01181189: hypothetical protein +FIG01181189 FIG01181190: hypothetical protein +FIG01181190 FIG01181194: hypothetical protein +FIG01181194 probable methylmalonyl-coA epimerase +FIG01181197 FIG01181198: hypothetical protein +FIG01181198 FIG01181199: hypothetical protein +FIG01181199 FIG01181200: hypothetical protein +FIG01181204 FIG01181205: hypothetical protein +FIG01181205 soluble hydrogenase, small subunit +FIG01181206 FIG01181209: hypothetical protein +FIG01181209 FIG01181210: hypothetical protein +FIG01181211 Probable tetratricopeptide repeat family protein +FIG01181214 FIG01181215: hypothetical protein +FIG01181215 FIG01181216: hypothetical protein +FIG01181216 FIG01181217: hypothetical protein +FIG01181217 FIG01181218: hypothetical protein +FIG01181218 FIG01181220: hypothetical protein +FIG01181220 FIG01181221: hypothetical protein +FIG01181224 FIG01181225: hypothetical protein +FIG01181226 FIG01181227: hypothetical protein +FIG01181227 FIG01181228: hypothetical protein +FIG01181228 FIG01181230: hypothetical protein +FIG01181232 FIG01181233: hypothetical protein +FIG01181233 FIG01181234: hypothetical protein +FIG01181234 FIG01181235: hypothetical protein +FIG01181237 inosine-5'-monophosphate dehydrogenase related protein IX +FIG01181241 FIG01181242: hypothetical protein +FIG01181242 TenA2, thiaminase II (EC 3.5.99.2) homolog involved in salvage of thiamin pyrimidine moiety +FIG01181243 Probable nucleotidyltransferase +FIG01181244 FIG01181245: hypothetical protein +FIG01181246 FIG01181249: hypothetical protein +FIG01181249 FIG01181251: hypothetical protein +FIG01181251 Alr3469 protein +FIG01181256 FIG01181258: hypothetical protein +FIG01181258 FIG01181259: hypothetical protein +FIG01181259 small heat shock protein +FIG01181260 FIG01181262: hypothetical protein +FIG01181264 FIG01181265: hypothetical protein +FIG01181265 dipeptide-binding protein +FIG01181267 FIG01181270: hypothetical protein +FIG01181270 plasmid stability protein stbB +FIG01181271 FIG01181273: hypothetical protein +FIG01181274 FIG01181275: hypothetical protein +FIG01181275 FIG01181276: hypothetical protein +FIG01181279 FIG01181280: hypothetical protein +FIG01181280 FIG01181281: hypothetical protein +FIG01181281 FIG01181282: hypothetical protein +FIG01181282 FIG01181288: hypothetical protein +FIG01181288 FIG01181290: hypothetical protein +FIG01181291 FIG01181293: hypothetical protein +FIG01181294 FIG01181295: hypothetical protein +FIG01181296 putative divalent heavy-metal cations transporter +FIG01181298 FIG01181299: hypothetical protein +FIG01181299 FIG01181300: hypothetical protein +FIG01181303 FIG01181305: hypothetical protein +FIG01181306 6-carboxyhexanoate-CoA ligase +FIG01181307 FIG01181308: hypothetical protein +FIG01181308 FIG01181310: hypothetical protein +FIG01181310 FIG01181311: hypothetical protein +FIG01181311 Carboxypeptidase G2 (EC 3.4.17.11) +FIG01181314 FIG01181316: hypothetical protein +FIG01181317 FIG01181318: hypothetical protein +FIG01181318 FIG01181319: hypothetical protein +FIG01181319 FIG01181320: hypothetical protein +FIG01181320 GTPase SAR1 and related small G proteins +FIG01181322 FIG01181323: hypothetical protein +FIG01181323 Glr1707 protein +FIG01181325 FIG01181326: hypothetical protein +FIG01181326 ABC transporter substrate-binding protein (taurine) +FIG01181327 FIG01181328: hypothetical protein +FIG01181328 FIG01181331: hypothetical protein +FIG01181331 FIG01181333: hypothetical protein +FIG01181333 FIG01181334: hypothetical protein +FIG01181338 FIG01181339: hypothetical protein +FIG01181339 Zn-ribbon-containing, possibly RNA-binding protein and truncated derivatives +FIG01181341 FIG01181343: hypothetical protein +FIG01181343 probable transcriptional regulator, merR family +FIG01181345 FIG01181346: hypothetical protein +FIG01181346 FIG01181347: hypothetical protein +FIG01181348 FIG01181349: hypothetical protein +FIG01181349 FIG01181350: hypothetical protein +FIG01181350 FIG01181351: hypothetical protein +FIG01181352 FIG01181353: hypothetical protein +FIG01181353 TPR repeat:TPR repeat:TPR repeat precursor +FIG01181354 putative oxidoreductase-like protein +FIG01181355 Putative uncharacterized protein TTHB069 +FIG01181357 FIG01181360: hypothetical protein +FIG01181360 FIG01181361: hypothetical protein +FIG01181361 FIG01181362: hypothetical protein +FIG01181362 Putative uncharacterized protein TTHB071 +FIG01181365 FIG01181367: hypothetical protein +FIG01181367 Alr0728 protein +FIG01181370 FIG01181372: hypothetical protein +FIG01181372 FIG01181373: hypothetical protein +FIG01181373 FIG01181375: hypothetical protein +FIG01181377 FIG01181378: hypothetical protein +FIG01181378 FIG01181380: hypothetical protein +FIG01181384 FIG01181385: hypothetical protein +FIG01181385 FIG01181387: hypothetical protein +FIG01181389 N5,N10-methylenetetrahydromethanopterin reductase +FIG01181391 FIG01181392: hypothetical protein +FIG01181392 FIG01181393: hypothetical protein +FIG01181394 FIG01181395: hypothetical protein +FIG01181395 FIG01181396: hypothetical protein +FIG01181396 FIG01181397: hypothetical protein +FIG01181400 hypothetical protein TTHA0555 +FIG01181401 FIG01181402: hypothetical protein +FIG01181402 oxygen-insesitive NAD(P)H nitroreductase/dihydropteridine reductase +FIG01181403 FIG01181404: hypothetical protein +FIG01181404 FIG01181408: hypothetical protein +FIG01181411 FIG01181412: hypothetical protein +FIG01181412 Phage shock protein A homolog +FIG01181414 FIG01181415: hypothetical protein +FIG01181415 Peptidyl-prolyl cis-trans isomerse, PpiC family +FIG01181421 FIG01181424: hypothetical protein +FIG01181424 FIG01181425: hypothetical protein +FIG01181425 FIG01181426: hypothetical protein +FIG01181428 FIG01181429: hypothetical protein +FIG01181429 Glycosyl transferase, family 2 precursor +FIG01181434 FIG01181435: hypothetical protein +FIG01181435 FIG01181436: hypothetical protein +FIG01181436 FIG01181437: hypothetical protein +FIG01181437 FIG01181439: hypothetical protein +FIG01181439 FIG01181440: hypothetical protein +FIG01181440 FIG01181442: hypothetical protein +FIG01181444 FIG01181446: hypothetical protein +FIG01181446 putative glycolate oxidase subunit E +FIG01181451 FIG01181453: hypothetical protein +FIG01181454 omega-(3) fatty acid desaturase +FIG01181456 FIG01181457: hypothetical protein +FIG01181457 FIG01181458: hypothetical protein +FIG01181460 FIG01181462: hypothetical protein +FIG01181462 FIG01181465: hypothetical protein +FIG01181465 FIG01181466: hypothetical protein +FIG01181467 FIG01181468: hypothetical protein +FIG01181470 FIG01181472: hypothetical protein +FIG01181472 deacetylase +FIG01181473 FIG01181474: hypothetical protein +FIG01181474 FIG01181482: hypothetical protein +FIG01181484 Serine--pyruvate transaminase (EC 2.6.1.51) +FIG01181487 FIG01181488: hypothetical protein +FIG01181488 FIG01181491: hypothetical protein +FIG01181491 FIG01181492: hypothetical protein +FIG01181493 FIG01181495: hypothetical protein +FIG01181495 FIG01181496: hypothetical protein +FIG01181501 FIG01181502: hypothetical protein +FIG01181502 Protease IV (Signal peptide peptidase) (EC 3.4.21.-) +FIG01181504 FIG01181505: hypothetical protein +FIG01181505 FIG01181506: hypothetical protein +FIG01181506 FIG01181507: hypothetical protein +FIG01181513 FIG01181515: hypothetical protein +FIG01181519 Sll1225 protein +FIG01181521 FIG01181522: hypothetical protein +FIG01181522 OrfE +FIG01181523 molybdopterin converting factor, small subunit +FIG01181525 FIG01181526: hypothetical protein +FIG01181526 putative acid phosphatase precursor +FIG01181531 FIG01181533: hypothetical protein +FIG01181533 FIG01181536: hypothetical protein +FIG01181536 FIG01181544: hypothetical protein +FIG01181546 FIG01181548: hypothetical protein +FIG01181549 FIG01181552: hypothetical protein +FIG01181552 FIG01181553: hypothetical protein +FIG01181557 FIG01181560: hypothetical protein +FIG01181562 FIG01181563: hypothetical protein +FIG01181564 FIG01181565: hypothetical protein +FIG01181566 23S rRNA methyltransferase +FIG01181568 Competence protein/comEA-related protein +FIG01181569 FIG01181574: hypothetical protein +FIG01181574 FIG01181575: hypothetical protein +FIG01181575 FIG01181576: hypothetical protein +FIG01181579 Probable cysteinyl-tRNA synthetase (EC 6.1.1.16) +FIG01181580 FIG01181583: hypothetical protein +FIG01181583 plectin 1 isoform 8 +FIG01181587 FIG01181588: hypothetical protein +FIG01181588 Dipeptidyl aminopeptidases/acylaminoacyl-peptidase +FIG01181590 FIG01181591: hypothetical protein +FIG01181591 FIG01181592: hypothetical protein +FIG01181594 FIG01181595: hypothetical protein +FIG01181595 FIG01181597: hypothetical protein +FIG01181597 FIG01181601: hypothetical protein +FIG01181601 FIG01181602: hypothetical protein +FIG01181604 FIG01181605: hypothetical protein +FIG01181605 putative Permease +FIG01181608 FIG01181609: hypothetical protein +FIG01181610 FIG01181613: hypothetical protein +FIG01181613 FIG01181614: hypothetical protein +FIG01181614 FIG01181616: hypothetical protein +FIG01181616 FIG01181618: hypothetical protein +FIG01181618 FIG01181619: hypothetical protein +FIG01181619 FIG01181623: hypothetical protein +FIG01181623 FIG01181624: hypothetical protein +FIG01181628 FIG01181629: hypothetical protein +FIG01181629 FIG01181630: hypothetical protein +FIG01181633 FIG01181635: hypothetical protein +FIG01181640 FIG01181641: hypothetical protein +FIG01181642 FIG01181645: hypothetical protein +FIG01181645 FIG01181646: hypothetical protein +FIG01181648 FIG01181649: hypothetical protein +FIG01181659 FIG01181661: hypothetical protein +FIG01181661 FIG01181662: hypothetical protein +FIG01181662 FIG01181663: hypothetical protein +FIG01181663 FIG01181664: hypothetical protein +FIG01181665 FIG01181667: hypothetical protein +FIG01181669 FIG01181671: hypothetical protein +FIG01181672 FIG01181674: hypothetical protein +FIG01181674 FIG01181675: hypothetical protein +FIG01181675 FIG01181676: hypothetical protein +FIG01181676 FIG01181677: hypothetical protein +FIG01181682 FIG01181683: hypothetical protein +FIG01181683 FIG01181684: hypothetical protein +FIG01181684 Fe-S binding reductase, putative +FIG01181687 stage II sporulation protein D +FIG01181694 FIG01181701: hypothetical protein +FIG01181701 FIG01181702: hypothetical protein +FIG01181702 FIG01181705: hypothetical protein +FIG01181705 FIG01181707: hypothetical protein +FIG01181707 FIG01181708: hypothetical protein +FIG01181709 FIG01181710: hypothetical protein +FIG01181710 PpiC-type peptidyl-prolyl cis-trans isomerase precursor +FIG01181711 lmbE-related protein +FIG01181712 FIG01181713: hypothetical protein +FIG01181713 FIG01181715: hypothetical protein +FIG01181721 FIG01181723: hypothetical protein +FIG01181728 FIG01181730: hypothetical protein +FIG01181736 FIG00673898: hypothetical protein +FIG01181747 All2685 protein +FIG01181748 FIG01181749: hypothetical protein +FIG01181756 FIG01181758: hypothetical protein +FIG01181758 FIG01181761: hypothetical protein +FIG01181762 protease Do +FIG01181765 FIG01181767: hypothetical protein +FIG01181771 manganese transport system ATP-binding protein mntA +FIG01181773 FIG01181777: hypothetical protein +FIG01181784 AttH protein +FIG01181786 probable macrolide-efflux transmembrane protein +FIG01181789 Alr3825 protein +FIG01181792 Putative uncharacterized protein TTHA1602 +FIG01181793 FIG01181798: hypothetical protein +FIG01181806 FIG01181808: hypothetical protein +FIG01181811 FIG01181815: hypothetical protein +FIG01181817 Transcriptional repressor of the xylose operon +FIG01181824 FIG01181825: hypothetical protein +FIG01181832 FIG01181834: hypothetical protein +FIG01181844 FIG01181847: hypothetical protein +FIG01181852 FIG01181853: hypothetical protein +FIG01181860 FIG01181862: hypothetical protein +FIG01181866 FIG01181869: hypothetical protein +FIG01181869 phosphatidylethanolamine N-methyltransferase +FIG01181889 FIG01181890: hypothetical protein +FIG01181890 FIG01181891: hypothetical protein +FIG01181904 FIG01181905: hypothetical protein +FIG01181910 FIG01181912: hypothetical protein +FIG01181919 FIG01181921: hypothetical protein +FIG01181930 FIG01181932: hypothetical protein +FIG01181950 Protein SlyX +FIG01181964 peptidoglycan-associated lipoprotein +FIG01181980 FIG01181985: hypothetical protein +FIG01181985 FIG01181988: hypothetical protein +FIG01182043 Type cbb3 cytochrome oxidase biogenesis protein CcoH +FIG01182051 FIG01182052: hypothetical protein +FIG01182052 FIG01182056: hypothetical protein +FIG01182056 FIG01182057: hypothetical protein +FIG01182062 Isochorismatase hydrolase +FIG01182092 Drug resistance transporter Bcr/CflA subfamily protein +FIG01182116 FIG01182119: hypothetical protein +FIG01182119 FIG01182126: hypothetical protein +FIG01182142 FIG01182144: hypothetical protein +FIG01182144 FIG01182146: hypothetical protein +FIG01182155 FIG01182162: hypothetical protein +FIG01182165 FIG01182173: hypothetical protein +FIG01182180 FIG01182185: hypothetical protein +FIG01182186 FIG01182189: hypothetical protein +FIG01182189 FIG01182193: hypothetical protein +FIG01182201 NADH/Ubiquinone/plastoquinone (complex I) +FIG01182203 ortholog of Bordetella pertussis (BX470248) BP2475 +FIG01182227 FIG01182231: hypothetical protein +FIG01182248 FIG01182250: hypothetical protein +FIG01182266 protein containing CheW-like domain +FIG01182269 FIG01182272: hypothetical protein +FIG01182272 FIG01182275: hypothetical protein +FIG01182280 Two-component sensor CbrB: intrcellular carbon:nitrogen balance +FIG01182281 FIG01182287: hypothetical protein +FIG01182294 FIG01182298: hypothetical protein +FIG01182314 FIG01182316: hypothetical protein +FIG01182320 FIG01182326: hypothetical protein +FIG01182327 neutral invertase +FIG01182337 FIG01182352: hypothetical protein +FIG01182352 FIG01182354: hypothetical protein +FIG01182367 FIG01182371: hypothetical protein +FIG01182371 FIG01182375: hypothetical protein +FIG01182375 bacterioferritin possible associated with carboxysome +FIG01182379 Flavoprotein WrbA +FIG01182386 FIG01182399: hypothetical protein +FIG01182408 FIG01182413: hypothetical protein +FIG01182433 FIG01182436: hypothetical protein +FIG01182439 FIG01182442: hypothetical protein +FIG01182442 FIG01182446: hypothetical protein +FIG01182457 FIG01182460: hypothetical protein +FIG01182464 FIG01182465: hypothetical protein +FIG01182469 FIG01182476: hypothetical protein +FIG01182476 Uncharacterized 41.3 kDa protein in phbC-phbA intergenic region +FIG01182480 RND multidrug efflux membrane fusion protein MexE precursor +FIG01182494 FIG01182495: hypothetical protein +FIG01182495 FIG01182497: hypothetical protein +FIG01182606 FIG01182611: hypothetical protein +FIG01182638 FIG01182641: hypothetical protein +FIG01182641 FIG01182643: hypothetical protein +FIG01182643 FIG01182646: hypothetical protein +FIG01182649 N-carbamoyl-L-amino acid amidohydrolase( EC:3.5.1.87 ) +FIG01182675 FIG01182687: hypothetical protein +FIG01182711 FIG01182717: hypothetical protein +FIG01182717 FIG01182722: hypothetical protein +FIG01182745 FIG01182751: hypothetical protein +FIG01182751 FIG01182762: hypothetical protein +FIG01182792 FIG01182802: hypothetical protein +FIG01182815 FIG01182817: hypothetical protein +FIG01182828 FIG01182837: hypothetical protein +FIG01182847 FIG01182850: hypothetical protein +FIG01182851 FIG01182859: hypothetical protein +FIG01182871 FIG01182874: hypothetical protein +FIG01182892 FIG01182895: hypothetical protein +FIG01182904 staphylococcal nuclease homologue( EC:3.1.- ) +FIG01182913 FIG01182915: hypothetical protein +FIG01182918 FIG01182919: hypothetical protein +FIG01182980 FIG01182984: hypothetical protein +FIG01182995 FIG01183000: hypothetical protein +FIG01183000 FIG01183004: hypothetical protein +FIG01183013 predicted RNA-binding protein containing KH domain, possibly ribosomal protein +FIG01183064 FIG01183065: hypothetical protein +FIG01183087 FIG01183089: hypothetical protein +FIG01183089 CRISPR-associated protein, Csx3 family +FIG01183321 Blr5909 protein +FIG01183328 FIG01183352: hypothetical protein +FIG01183860 poly-gamma-glutamate synthesis protein / capsule biosynthesis protein capA +FIG01183920 Serine proteases, subtilase family +FIG01184081 FIG01184090: hypothetical protein +FIG01184113 FIG01184114: hypothetical protein +FIG01184116 Alx protein +FIG01184124 NLP/P60 precursor +FIG01184221 FIG01184226: hypothetical protein +FIG01184373 FIG01184376: hypothetical protein +FIG01184534 Outer membrane lipoprotein-sorting protein +FIG01185449 LemA family protein +FIG01185489 Fatty acid desaturase (EC 1.14.19.1); Delta-9 fatty acid desaturase (EC 1.14.19.1) +FIG01185656 Predicted transcriptional regulator for fatty acid degradation FadP, TetR family +FIG01185898 FIG01185905: hypothetical protein +FIG01186059 FIG01186064: hypothetical protein +FIG01186356 FIG01186387: hypothetical protein +FIG01186701 DNA topoisomerase III, Burkholderia type (EC 5.99.1.2) +FIG01186863 cell division protein FtsL, putative +FIG01186867 FIG01186869: hypothetical protein +FIG01186895 FIG01186896: hypothetical protein +FIG01186896 FIG01186898: hypothetical protein +FIG01186898 FIG01186900: hypothetical protein +FIG01186901 Uncharacterized protein TP_0150 precursor +FIG01186904 AMP-binding enzyme/acyltransferase +FIG01186907 T. pallidum predicted coding region TP0315 +FIG01186915 FIG01186919: hypothetical protein +FIG01186919 zinc carboxypeptidase family protein +FIG01186926 FIG01186932: hypothetical protein +FIG01186932 FIG01186936: hypothetical protein +FIG01186936 FIG01186940: hypothetical protein +FIG01186947 FIG01186950: hypothetical protein +FIG01186950 FIG01186955: hypothetical protein +FIG01186957 FIG01186958: hypothetical protein +FIG01186958 FIG01186963: hypothetical protein +FIG01186963 FIG01186965: hypothetical protein +FIG01186965 phosphoglycolate phosphatase (gph-1) +FIG01186967 FIG01186969: hypothetical protein +FIG01186969 Manganese ABC transporter, inner membrane permease protein SitC; Zinc ABC transporter, inner membrane permease protein ZnuB +FIG01186973 Ham1 family protein +FIG01186982 flagellar filament outer layer protein FlaA, putative +FIG01186989 FIG01186990: hypothetical protein +FIG01186990 FIG01186991: hypothetical protein +FIG01186993 carboxypeptidase, 47 kDa +FIG01186997 FIG01187002: hypothetical protein +FIG01187012 tpr protein L (tprL) +FIG01187013 FIG01187018: hypothetical protein +FIG01187018 FIG01187020: hypothetical protein +FIG01187027 FIG01187028: hypothetical protein +FIG01187031 FIG01187033: hypothetical protein +FIG01187033 FIG01187036: hypothetical protein +FIG01187036 Uncharacterized lipoprotein TP_0133 precursor +FIG01187046 amino acid ABC transporter, periplasmic binding protein (hisJ) +FIG01187048 FIG01187056: hypothetical protein +FIG01187056 FIG01187057: hypothetical protein +FIG01187069 FIG01187070: hypothetical protein +FIG01187070 FIG01187076: hypothetical protein +FIG01187076 FIG01187083: hypothetical protein +FIG01187083 FIG01187087: hypothetical protein +FIG01187087 carboxylesterase, putative +FIG01187089 V-type ATPase, subunit F, putative +FIG01187097 methyl-accepting chemotaxis protein (mcp2-3) +FIG01187104 FIG01187105: hypothetical protein +FIG01187105 FIG01187107: hypothetical protein +FIG01187111 FIG01187112: hypothetical protein +FIG01187115 FIG01187116: hypothetical protein +FIG01187119 pathogen-specific surface antigen, putative +FIG01187120 FIG01187125: hypothetical protein +FIG01187125 FIG01187126: hypothetical protein +FIG01187134 FIG01187135: hypothetical protein +FIG01187138 Uncharacterized protein TP_0335 +FIG01187150 FIG01187152: hypothetical protein +FIG01187155 FIG01187156: hypothetical protein +FIG01187156 FIG01187165: hypothetical protein +FIG01187166 Uncharacterized protein TP_0483 precursor +FIG01187174 acetyl hydrolase, putative +FIG01187201 FIG01187204: hypothetical protein +FIG01187204 probable extracellular nuclease +FIG01187210 oligopeptide/dipeptide ABC transporter, peptide-binding protein +FIG01187219 FIG01187222: hypothetical protein +FIG01187222 hemolysin, putative +FIG01187261 FIG01187266: hypothetical protein +FIG01187266 FIG01187267: hypothetical protein +FIG01187267 ABC transporter, ATP-binding protein (natA) +FIG01187272 FIG01187277: hypothetical protein +FIG01187277 FIG01187278: hypothetical protein +FIG01187301 branched-chain amino acid ABC transporter, permease protein +FIG01187308 FIG01187312: hypothetical protein +FIG01187315 FIG01187316: hypothetical protein +FIG01187316 FIG01187317: hypothetical protein +FIG01187327 ortholog to Borrelia burgdorferi BB0058 +FIG01187342 FIG01187344: hypothetical protein +FIG01187346 Uncharacterized protein TP_0535 +FIG01187348 FIG01187349: hypothetical protein +FIG01187357 oxygen-independent coproporphyrinogen III oxidase, putative +FIG01187360 FAD-binding protein, putative +FIG01187363 FIG01187373: hypothetical protein +FIG01187373 FIG01187374: hypothetical protein +FIG01187374 TrapT dctQ-M fusion permease, dicarboxylate transport +FIG01187375 FIG01187376: hypothetical protein +FIG01187377 sodium/proton-dependent alanine transporter +FIG01187387 FIG01187388: hypothetical protein +FIG01187388 chaperonin, 33 kDa family +FIG01187401 Uncharacterized protein TP_0128 +FIG01187404 FIG01187406: hypothetical protein +FIG01187407 FIG01187408: hypothetical protein +FIG01187408 Uncharacterized protein TP_0473 +FIG01187420 FIG01187421: hypothetical protein +FIG01187424 FIG01187429: hypothetical protein +FIG01187429 FIG01187430: hypothetical protein +FIG01187431 FIG01187433: hypothetical protein +FIG01187434 FIG01187437: hypothetical protein +FIG01187437 Uncharacterized lipoprotein TP_0248 precursor +FIG01187438 FIG01187441: hypothetical protein +FIG01187441 FIG01187443: hypothetical protein +FIG01187446 FIG01187447: hypothetical protein +FIG01187448 FIG01187451: hypothetical protein +FIG01187451 Uncharacterized protein TP_0266 +FIG01187456 FIG01187457: hypothetical protein +FIG01187462 FIG01187463: hypothetical protein +FIG01187463 FIG01187468: hypothetical protein +FIG01187472 FIG01187473: hypothetical protein +FIG01187480 FIG01187481: hypothetical protein +FIG01187481 protease IV (sppA) +FIG01187482 FIG01187484: hypothetical protein +FIG01187485 FIG01187492: hypothetical protein +FIG01187501 amino acid ABC transporter, periplasmic binding protein +FIG01187507 FIG01187508: hypothetical protein +FIG01187511 FIG01187516: hypothetical protein +FIG01187521 FIG01187527: hypothetical protein +FIG01187534 FIG01187540: hypothetical protein +FIG01187540 FIG01187543: hypothetical protein +FIG01187544 FIG01187545: hypothetical protein +FIG01187545 FIG01187548: hypothetical protein +FIG01187548 FIG01187565: hypothetical protein +FIG01187568 Uncharacterized protein TP_0833 precursor +FIG01187569 FIG01187572: hypothetical protein +FIG01187572 FIG01187574: hypothetical protein +FIG01187575 FIG01187586: hypothetical protein +FIG01187589 Uncharacterized protein TP_0772 +FIG01187592 Uncharacterized protein TP_0910 +FIG01187598 FIG01187600: hypothetical protein +FIG01187612 FIG01187616: hypothetical protein +FIG01187616 FIG01187631: hypothetical protein +FIG01187631 recX protein (recX) +FIG01187633 FIG01187634: hypothetical protein +FIG01187634 FIG01187637: hypothetical protein +FIG01187638 Uncharacterized protein TP_0625 +FIG01187646 Uncharacterized protein TP_0246 +FIG01187653 FIG01187654: hypothetical protein +FIG01187654 FIG01187655: hypothetical protein +FIG01187655 FIG01187656: hypothetical protein +FIG01187656 FIG01187660: hypothetical protein +FIG01187660 FIG01187661: hypothetical protein +FIG01187668 Uncharacterized protein TP_0690 precursor +FIG01187669 Uncharacterized protein TP_0324 +FIG01187674 FIG01187678: hypothetical protein +FIG01187687 RNA-binding protein, putative +FIG01187693 FIG01187694: hypothetical protein +FIG01187694 Uncharacterized protein TP_0432 +FIG01187697 Uncharacterized protein TP_0299 +FIG01187703 Uncharacterized protein TP_0825 +FIG01187713 FIG01187718: hypothetical protein +FIG01187718 ortholog to Borrelia burgdorferi BB0794 +FIG01187724 FIG01187725: hypothetical protein +FIG01187725 FIG01187727: hypothetical protein +FIG01187729 FIG01187733: hypothetical protein +FIG01187734 Uncharacterized protein TP_0132 +FIG01187736 FIG01187737: hypothetical protein +FIG01187744 76K protein +FIG01187753 sigma-54 dependent transcriptional regulator, putative +FIG01187757 FIG01187759: hypothetical protein +FIG01187759 FIG01187761: hypothetical protein +FIG01187761 FIG01187763: hypothetical protein +FIG01187763 FIG01187767: hypothetical protein +FIG01187767 B. burgdorferi predicted coding region BB0714 +FIG01187770 FIG01187773: hypothetical protein +FIG01187779 FIG01187791: hypothetical protein +FIG01187791 FIG01187795: hypothetical protein +FIG01187795 Manganese ABC transporter, inner membrane permease protein SitD; Zinc ABC transporter, inner membrane permease protein ZnuB +FIG01187802 FIG01187807: hypothetical protein +FIG01187815 lipoprotein, 17 kDa (tpp17) +FIG01187817 sugar ABC transporter, permease protein (y4oR) +FIG01187820 flagellar protein FliL-related protein +FIG01187828 FIG01187835: hypothetical protein +FIG01187839 FIG01187840: hypothetical protein +FIG01187844 FIG01187845: hypothetical protein +FIG01187845 Uncharacterized protein TP_0577 +FIG01187846 Uncharacterized protein TP_0173 +FIG01187851 FIG01187859: hypothetical protein +FIG01187859 FIG01187860: hypothetical protein +FIG01187882 Uncharacterized protein TP_0707 +FIG01187883 FIG01187885: hypothetical protein +FIG01187888 FIG01187893: hypothetical protein +FIG01187910 sn-1,2-diacylglycerol cholinephosphotransferase, putative +FIG01187911 FIG01187913: hypothetical protein +FIG01187921 FIG01187922: hypothetical protein +FIG01187922 FIG01187923: hypothetical protein +FIG01187923 FIG01187926: hypothetical protein +FIG01187926 FIG01187927: hypothetical protein +FIG01187940 PTS system, nitrogen regulatory IIA component (ptsN-2) +FIG01187953 Zinc ABC transporter, periplasmic-binding protein ZnuA; Manganese ABC transporter, periplasmic-binding protein SitA +FIG01187958 cytoplasmic filament protein A (cfpA) +FIG01187960 FIG01187961: hypothetical protein +FIG01187961 FIG01187965: hypothetical protein +FIG01187969 FIG01187974: hypothetical protein +FIG01187979 FIG01187980: hypothetical protein +FIG01187990 Uncharacterized protein TP_0273 +FIG01188003 FIG01188009: hypothetical protein +FIG01188009 FIG01188010: hypothetical protein +FIG01188017 FIG01188020: hypothetical protein +FIG01188023 Uncharacterized protein TP_1000 +FIG01188030 FIG01188033: hypothetical protein +FIG01188041 FIG01188042: hypothetical protein +FIG01188042 FIG01188045: hypothetical protein +FIG01188049 FIG01188050: hypothetical protein +FIG01188052 FIG01188054: hypothetical protein +FIG01188054 Uncharacterized protein TP_0723 +FIG01188055 oxidoreductase, NAD-binding +FIG01188078 FIG01188080: hypothetical protein +FIG01188108 FIG01188109: hypothetical protein +FIG01188109 FIG01188117: hypothetical protein +FIG01188124 FIG01188125: hypothetical protein +FIG01188127 FIG01188140: hypothetical protein +FIG01188147 Uncharacterized protein TP_0968 precursor +FIG01188155 FIG01188156: hypothetical protein +FIG01188162 FIG01188168: hypothetical protein +FIG01188177 FIG01188183: hypothetical protein +FIG01188186 FIG01188188: hypothetical protein +FIG01188201 ATP-binding protein (ylxH-2) +FIG01188203 FIG01188208: hypothetical protein +FIG01188214 Uncharacterized protein TP_0175 +FIG01188231 FIG028593: membrane protein +FIG01188250 Uncharacterized protein TP_0783 +FIG01188251 FIG01188254: hypothetical protein +FIG01188264 FIG01188265: hypothetical protein +FIG01188276 FIG01188278: hypothetical protein +FIG01188293 FIG01188302: hypothetical protein +FIG01188316 FIG01188320: hypothetical protein +FIG01188320 FIG01188322: hypothetical protein +FIG01188322 V-type ATP synthase subunit E +FIG01188331 UPF0164 protein TP_0865 precursor +FIG01188334 FIG01188339: hypothetical protein +FIG01188341 FIG01188345: hypothetical protein +FIG01188345 FIG01188355: hypothetical protein +FIG01188372 FIG01188376: hypothetical protein +FIG01188376 large secreted protein +FIG01188392 glycosyl hydrolase, family 57 +FIG01188394 femA protein, putative +FIG01188404 FIG01188405: hypothetical protein +FIG01188406 FIG01188409: hypothetical protein +FIG01188427 FIG01188430: hypothetical protein +FIG01188435 FIG01188441: hypothetical protein +FIG01188449 FIG01188450: hypothetical protein +FIG01188451 FIG01188460: hypothetical protein +FIG01188471 Uncharacterized protein TP_0381 +FIG01188482 basic membrane protein, putative +FIG01188484 FIG01188489: hypothetical protein +FIG01188491 Uncharacterized protein TP_0465 +FIG01188510 FIG01188514: hypothetical protein +FIG01188516 FIG01188519: hypothetical protein +FIG01188527 FIG01188529: hypothetical protein +FIG01188537 Uncharacterized protein TP_0149 +FIG01188542 Uncharacterized protein TP_0787 +FIG01188546 Uncharacterized lipoprotein TP_0503 precursor +FIG01188562 FIG01188563: hypothetical protein +FIG01188594 FIG01188595: hypothetical protein +FIG01188595 FIG01188607: hypothetical protein +FIG01188614 FIG01188617: hypothetical protein +FIG01188651 FIG01188653: hypothetical protein +FIG01188653 Uncharacterized protein TP_0534 +FIG01188677 FIG01188679: hypothetical protein +FIG01188694 FIG01188695: hypothetical protein +FIG01188700 FIG01188704: hypothetical protein +FIG01188711 racemase, Asp/Glu/Hydantoin family +FIG01188714 Uncharacterized protein TP_0174 precursor +FIG01188722 FIG01188724: hypothetical protein +FIG01188724 TprA +FIG01188778 FIG01188779: hypothetical protein +FIG01188785 FIG01188786: hypothetical protein +FIG01188811 FIG01188814: hypothetical protein +FIG01188830 FIG01188835: hypothetical protein +FIG01188835 FIG01188837: hypothetical protein +FIG01188837 FIG01188839: hypothetical protein +FIG01188839 FIG01188856: hypothetical protein +FIG01188856 FIG01188860: hypothetical protein +FIG01188865 FIG01188867: hypothetical protein +FIG01188868 choline/carnitine/betaine transporter family protein +FIG01188886 FIG01188887: hypothetical protein +FIG01188892 FIG01188896: hypothetical protein +FIG01188953 FIG01188971: hypothetical protein +FIG01188972 FIG01188975: hypothetical protein +FIG01189041 FIG01189046: hypothetical protein +FIG01189069 FIG01189071: hypothetical protein +FIG01189075 FIG01189081: hypothetical protein +FIG01189244 Circadian oscillating polypeptide COP23 precursor +FIG01189490 putative dihydropteridine reductase +FIG01189502 FIG01189504: hypothetical protein +FIG01189511 FIG01189522: hypothetical protein +FIG01189574 FIG01189575: hypothetical protein +FIG01189626 FIG00561522: hypothetical protein +FIG01189631 FIG01189632: hypothetical protein +FIG01189663 FIG01189674: hypothetical protein +FIG01189774 FIG01189780: hypothetical protein +FIG01189781 FIG01189787: hypothetical protein +FIG01189857 FIG01189871: hypothetical protein +FIG01189919 FIG01189920: hypothetical protein +FIG01189923 FIG01189927: hypothetical protein +FIG01189962 FIG01189967: hypothetical protein +FIG01190149 Heterocyst differentiation control protein (EC 3.4.21.-) +FIG01190316 Phosphotransferase system, fructose-specific IIC component +FIG01190394 FIG01190399: hypothetical protein +FIG01190425 FIG01190429: hypothetical protein +FIG01190463 Clumping factor B +FIG01190668 FIG01190680: hypothetical protein +FIG01190692 FIG01190694: hypothetical protein +FIG01190854 FIG01190858: hypothetical protein +FIG01190919 FIG01190929: hypothetical protein +FIG01190960 FIG01190980: hypothetical protein +FIG01190980 nuclease (SNase-like) +FIG01191119 FIG01191120: hypothetical protein +FIG01191210 Nucleoside phosphorylase-like +FIG01191320 FIG01191331: hypothetical protein +FIG01191344 FIG01191346: hypothetical protein +FIG01191412 DndB-like protein +FIG01191477 FIG01191479: hypothetical protein +FIG01191479 FIG01191482: hypothetical protein +FIG01191494 FIG01191501: hypothetical protein +FIG01191505 FIG01191506: hypothetical protein +FIG01191517 FIG01191522: hypothetical protein +FIG01191603 FIG01191613: hypothetical protein +FIG01191710 FIG01191712: hypothetical protein +FIG01191751 FIG01191752: hypothetical protein +FIG01191981 FIG01191986: hypothetical protein +FIG01192045 FIG01192047: hypothetical protein +FIG01192350 cytochrome AA3 controlling prrotein +FIG01192359 FIG01192360: hypothetical protein +FIG01192360 tellurium resistence protein TerC-like protein +FIG01192363 COG0824: Predicted thioesterase +FIG01192366 FIG01192367: hypothetical protein +FIG01192371 FIG01192372: hypothetical protein +FIG01192372 FIG01192373: hypothetical protein +FIG01192373 FIG01192374: hypothetical protein +FIG01192374 FIG027937: secreted protein +FIG01192380 FIG01192382: hypothetical protein +FIG01192383 FIG01192384: hypothetical protein +FIG01192384 FIG01192387: hypothetical protein +FIG01192387 FIG01192388: hypothetical protein +FIG01192389 FIG01192391: hypothetical protein +FIG01192394 Doubtful CDS. No significant database matches. Note possible doubtful CDS on opposite strand. +FIG01192395 putative drug efflux protein +FIG01192399 iron ABC transporter ATP-binding protein +FIG01192400 FIG01192401: hypothetical protein +FIG01192405 FIG01192407: hypothetical protein +FIG01192409 protein kinase C inhibitor +FIG01192411 putative ABC-transporter periplasmic solute-binding subunit +FIG01192412 FIG01192413: hypothetical protein +FIG01192413 ribonuclease G +FIG01192423 putative DNA uptake protein +FIG01192424 FIG01192425: hypothetical protein +FIG01192425 putative integral membrane sugar transport protein +FIG01192429 FIG01192431: hypothetical protein +FIG01192432 comF operon protein 3 +FIG01192443 sporulation initiation inhibitor SOJ-like protein +FIG01192449 WiSP family protein +FIG01192460 alanine racemase-like protein +FIG01192465 putative iron-siderophore uptake system ATP-binding component +FIG01192467 Uncharacterized protein SCO5199 +FIG01192468 putative sugar ABC transporter substrate-binding lipoprotein subunit +FIG01192472 putative sugar ABC transporter ATP-binding subunit +FIG01192477 FIG01192479: hypothetical protein +FIG01192479 conserved hypothetical protein (putative ATP-binding) +FIG01192485 FIG01192487: hypothetical protein +FIG01192487 glycosyltransferase domain containing protein +FIG01192491 putative sugar ABC transporter permease subunit +FIG01192502 UPF0182 protein AF1421 +FIG01192509 FIG01192510: hypothetical protein +FIG01192515 multidrug efflux protein +FIG01192518 comE operon protein 3-like protein +FIG01192519 FIG01192520: hypothetical protein +FIG01192520 lysophospholipase/serine esterase fusion protein +FIG01192522 putative ABC transporter (ATP-binding and integral membrane) +FIG01192529 FIG01192530: hypothetical protein +FIG01192530 FIG01192531: hypothetical protein +FIG01192531 FIG01192533: hypothetical protein +FIG01192553 FIG01192560: hypothetical protein +FIG01192560 FIG01192561: hypothetical protein +FIG01192570 putative helicase regulator +FIG01192586 putative MRP-family ATP-binding protein +FIG01192590 TadA-like protein +FIG01192594 protease II +FIG01192600 FIG01192601: hypothetical protein +FIG01192601 probable serine/threonine protein kinase +FIG01192608 FIG01192611: hypothetical protein +FIG01192624 putative type II/type IV pathway secretion protein +FIG01192639 metalloendopeptidase +FIG01192649 FIG01192654: hypothetical protein +FIG01192671 Twin-arginine translocation protein TatA +FIG01192672 FIG01192673: hypothetical protein +FIG01192680 FIG01192688: hypothetical protein +FIG01192714 FIG01192722: hypothetical protein +FIG01192722 FIG01192728: hypothetical protein +FIG01192728 FIG01192735: hypothetical protein +FIG01192735 FIG01192744: hypothetical protein +FIG01192744 FIG01192768: hypothetical protein +FIG01192769 FIG01192774: hypothetical protein +FIG01192774 FIG01192776: hypothetical protein +FIG01192776 FIG01192790: hypothetical protein +FIG01192794 FIG01192804: hypothetical protein +FIG01192827 Phenyloxazoline synthase MbtB (EC 6.3.2.-) [mycobactin] siderophore +FIG01192832 FIG01192855: hypothetical protein +FIG01192855 FIG01192866: hypothetical protein +FIG01192895 FIG01192904: hypothetical protein +FIG01192917 FIG01192923: hypothetical protein +FIG01192956 FIG01192969: hypothetical protein +FIG01192969 FIG01192975: hypothetical protein +FIG01193004 Multimeric flavodoxin WrbA +FIG01193008 FIG01193015: hypothetical protein +FIG01193015 FIG01193021: hypothetical protein +FIG01193066 FIG01193071: hypothetical protein +FIG01193096 FIG01193104: hypothetical protein +FIG01193104 FIG01193105: hypothetical protein +FIG01193105 FIG01193111: hypothetical protein +FIG01193120 FIG01193130: hypothetical protein +FIG01193130 FIG01193134: hypothetical protein +FIG01193134 FIG01193146: hypothetical protein +FIG01193146 FIG01193150: hypothetical protein +FIG01193157 FIG01193164: hypothetical protein +FIG01193164 FIG01193165: hypothetical protein +FIG01193165 FIG01193174: hypothetical protein +FIG01193174 TetR-family protein transcriptional regulator, putative +FIG01193177 FIG01193179: hypothetical protein +FIG01193179 ABC-type sugar transport system ATPase component +FIG01193190 FIG01193210: hypothetical protein +FIG01193219 FIG01193220: hypothetical protein +FIG01193234 FIG01193242: hypothetical protein +FIG01193242 FIG01193246: hypothetical protein +FIG01193246 FIG01193250: hypothetical protein +FIG01193283 FIG01193290: hypothetical protein +FIG01193290 FIG01193291: hypothetical protein +FIG01193293 FIG01193294: hypothetical protein +FIG01193299 Uncharacterized protein Mb0093 +FIG01193326 FIG01193335: hypothetical protein +FIG01193343 kinase, pfkB family protein +FIG01193355 FIG01193363: hypothetical protein +FIG01193377 FIG01193380: hypothetical protein +FIG01193380 FIG01193381: hypothetical protein +FIG01193381 FIG01193384: hypothetical protein +FIG01193394 FIG01193396: hypothetical protein +FIG01193400 FIG01193406: hypothetical protein +FIG01193406 FIG01193413: hypothetical protein +FIG01193414 FIG01193431: hypothetical protein +FIG01193442 FIG01193443: hypothetical protein +FIG01193443 FIG01193450: hypothetical protein +FIG01193460 FIG01193466: hypothetical protein +FIG01193466 FIG01193470: hypothetical protein +FIG01193496 Glycosyltransferase (EC 2.4.1.-) +FIG01193513 FIG01193517: hypothetical protein +FIG01193517 FIG01193529: hypothetical protein +FIG01193529 FIG01193531: hypothetical protein +FIG01193561 FIG01193564: hypothetical protein +FIG01193564 FIG01193566: hypothetical protein +FIG01193572 Aha1 domain protein +FIG01193578 FIG01193582: hypothetical protein +FIG01193582 glycosyl transferase, group 1, putative +FIG01193584 FIG01193586: hypothetical protein +FIG01193589 FIG01193598: hypothetical protein +FIG01193614 FIG01193618: hypothetical protein +FIG01193618 probable CoA-transferase +FIG01193626 lipoprotein LppP +FIG01193648 FIG01193652: hypothetical protein +FIG01193653 ppe family protein +FIG01193682 FIG01193686: hypothetical protein +FIG01193698 FIG01193707: hypothetical protein +FIG01193707 FIG01193752: hypothetical protein +FIG01193752 FIG01193754: hypothetical protein +FIG01193754 FIG01193759: hypothetical protein +FIG01193759 FIG01193762: hypothetical protein +FIG01193781 FIG01193788: hypothetical protein +FIG01193788 FIG01193795: hypothetical protein +FIG01193795 FIG01193796: hypothetical protein +FIG01193798 FIG01193823: hypothetical protein +FIG01193823 FIG01193834: hypothetical protein +FIG01193847 FIG01193849: hypothetical protein +FIG01193857 FIG00820963: Predicted deacetylase +FIG01193871 FIG01193879: hypothetical protein +FIG01193879 metallo-beta-lactamase superfamily protein +FIG01193891 FIG01193896: hypothetical protein +FIG01193896 FIG01193910: hypothetical protein +FIG01193938 FIG01193943: hypothetical protein +FIG01193948 FIG01193953: hypothetical protein +FIG01193963 FIG01193967: hypothetical protein +FIG01194003 FIG01194007: hypothetical protein +FIG01194019 RNA polymerase sigma-E factor +FIG01194025 FIG01194034: hypothetical protein +FIG01194034 FIG01194036: hypothetical protein +FIG01194040 FIG01194041: hypothetical protein +FIG01194047 FIG01194057: hypothetical protein +FIG01194069 FIG01194070: hypothetical protein +FIG01194071 FIG01194084: hypothetical protein +FIG01194084 FIG01194091: hypothetical protein +FIG01194091 Na(+) H(+) antiporter subunit F +FIG01194114 FIG01194117: hypothetical protein +FIG01194162 FIG01194164: hypothetical protein +FIG01194202 FIG01194208: hypothetical protein +FIG01194210 uncharacterized membrane protein +FIG01194221 FIG01194223: hypothetical protein +FIG01194223 FIG01194224: hypothetical protein +FIG01194229 FIG01194247: hypothetical protein +FIG01194247 FIG01194256: hypothetical protein +FIG01194290 FIG01194299: hypothetical protein +FIG01194299 Glucosyl-3-phosphoglycerate phosphatase (EC 3.1.3.85) +FIG01194302 FIG01194309: hypothetical protein +FIG01194309 FIG01194310: hypothetical protein +FIG01194310 FIG01194321: hypothetical protein +FIG01194351 FIG01194355: hypothetical protein +FIG01194355 FIG01194359: hypothetical protein +FIG01194359 FIG01194366: hypothetical protein +FIG01194366 ABC transporter sugar-binding protein +FIG01194370 isochorismatase hydrolase( EC:3.3.2.1 ) +FIG01194376 COG2388: Predicted acetyltransferase +FIG01194380 hypothetical alanine arginine proline rich protein +FIG01194385 FIG01194393: hypothetical protein +FIG01194400 Carboxylate-amine ligase +FIG01194406 FIG01194407: hypothetical protein +FIG01194414 PROBABLE ACYL-COA DEHYDROGENASE FADE34 (EC 1.3.99.-) +FIG01194436 major facilitator family protein transporter +FIG01194465 FIG01194466: hypothetical protein +FIG01194466 FIG01194469: hypothetical protein +FIG01194480 streptothricin-acteyl-transferase +FIG01194495 FIG01194501: hypothetical protein +FIG01194506 FIG01194507: hypothetical protein +FIG01194556 putative protein of unknown function (DUF718) +FIG01194558 FIG01194560: hypothetical protein +FIG01194560 FIG01121868: Possible secreted protein +FIG01194565 FIG01194566: hypothetical protein +FIG01194576 FIG01194585: hypothetical protein +FIG01194585 FIG01194586: hypothetical protein +FIG01194590 FIG01194591: hypothetical protein +FIG01194591 FIG01194630: hypothetical protein +FIG01194630 FIG01194651: hypothetical protein +FIG01194667 COG3511: Phospholipase C +FIG01194680 FIG01194699: hypothetical protein +FIG01194699 probable 2-nitropropane dioxygenase +FIG01194744 FIG01194758: hypothetical protein +FIG01194758 FIG01194764: hypothetical protein +FIG01194775 FIG01194797: hypothetical protein +FIG01194797 FIG01194803: hypothetical protein +FIG01194803 FIG01194814: hypothetical protein +FIG01194831 FIG01194834: hypothetical protein +FIG01194834 FIG01194837: hypothetical protein +FIG01194837 FIG01194840: hypothetical protein +FIG01194840 probable branched chain amino acid transport protein +FIG01194841 FIG01194845: hypothetical protein +FIG01194845 FIG01194848: hypothetical protein +FIG01194848 FIG01194855: hypothetical protein +FIG01194872 FIG01194883: hypothetical protein +FIG01194883 FIG01194885: hypothetical protein +FIG01194899 FIG01194906: hypothetical protein +FIG01194906 FIG01194911: hypothetical protein +FIG01194934 FIG01194935: hypothetical protein +FIG01194935 FIG01194940: hypothetical protein +FIG01194940 FIG01194946: hypothetical protein +FIG01194946 FIG01194950: hypothetical protein +FIG01194950 possible alpha/beta hydrolase +FIG01194957 FIG01194958: hypothetical protein +FIG01194958 FIG01194959: hypothetical protein +FIG01194963 FIG01194968: hypothetical protein +FIG01194972 FIG01194977: hypothetical protein +FIG01194977 FIG01194979: hypothetical protein +FIG01194979 FIG01194994: hypothetical protein +FIG01194994 polyamine ABC transporter, ATP-binding protein( EC:3.6.3.31 ) +FIG01195044 Acetyltransferase (EC 2.3.1.-) +FIG01195045 FIG01195047: hypothetical protein +FIG01195060 chitinase, class I +FIG01195063 FIG01195064: hypothetical protein +FIG01195076 putative guanyl-specific ribonuclease +FIG01195106 FIG01195115: hypothetical protein +FIG01195115 FIG01195121: hypothetical protein +FIG01195121 FIG01195122: hypothetical protein +FIG01195122 FIG01195131: hypothetical protein +FIG01195155 DGPFAETKE family protein +FIG01195166 FIG01195178: hypothetical protein +FIG01195202 possible Zn-containing alcohol dehydrogenase, N-terminal +FIG01195218 FIG01195221: hypothetical protein +FIG01195251 FIG01195256: hypothetical protein +FIG01195264 FIG01195266: hypothetical protein +FIG01195271 FIG01195277: hypothetical protein +FIG01195277 FIG01195281: hypothetical protein +FIG01195296 FIG01195297: hypothetical protein +FIG01195302 FIG01195303: hypothetical protein +FIG01195303 FIG01195306: hypothetical protein +FIG01195306 FIG01195308: hypothetical protein +FIG01195309 FIG01195318: hypothetical protein +FIG01195322 FIG01195325: hypothetical protein +FIG01195351 23S rRNA N-6-methyltransferase ErmCX +FIG01195359 FIG01195362: hypothetical protein +FIG01195362 FIG01195373: hypothetical protein +FIG01195373 acetyltransferase, gnat family protein +FIG01195401 FIG01195404: hypothetical protein +FIG01195417 FIG01195418: hypothetical protein +FIG01195418 Putative glycosyl transferase +FIG01195428 FIG01195430: hypothetical protein +FIG01195431 FIG01195433: hypothetical protein +FIG01195435 FIG01195436: hypothetical protein +FIG01195440 FIG01195441: hypothetical protein +FIG01195444 FIG01195446: hypothetical protein +FIG01195450 FIG01195451: hypothetical protein +FIG01195456 unique hypothetical membrane lipoprotein +FIG01195457 FIG01195459: hypothetical protein +FIG01195459 FIG01195460: hypothetical protein +FIG01195460 Ribose/galactose ABC transporter +FIG01195464 FIG01195466: hypothetical protein +FIG01195466 FIG01195467: hypothetical protein +FIG01195469 FIG01195470: hypothetical protein +FIG01195480 FIG01195481: hypothetical protein +FIG01195481 conserved hypothetical - cytochrome b +FIG01195488 FIG01195489: hypothetical protein +FIG01195489 FIG01195490: hypothetical protein +FIG01195492 FIG01195493: hypothetical protein +FIG01195494 Protein ycf2 +FIG01195497 FIG01195498: hypothetical protein +FIG01195498 streptococcal hemagglutinin protein +FIG01195500 MEMBRANE NUCLEASE +FIG01195503 FIG01195506: hypothetical protein +FIG01195506 FIG01195507: hypothetical protein +FIG01195507 FIG01195510: hypothetical protein +FIG01195512 putative ABC substrate-binding protein - iron +FIG01195514 FIG01195515: hypothetical protein +FIG01195515 M. genitalium predicted coding region MG335.1 +FIG01195526 hypothetical protein +FIG01195527 Unique hypothetical protein UU387 +FIG01195529 FIG01195530: hypothetical protein +FIG01195530 protein kinase, putative +FIG01195533 FIG01195534: hypothetical protein +FIG01195534 FIG01195536: hypothetical protein +FIG01195539 FIG01195541: hypothetical protein +FIG01195546 UPF0230 protein MG450 homolog +FIG01195548 ESTERASE/LIPASE 1 +FIG01195551 FIG01195553: hypothetical protein +FIG01195556 FIG01195557: hypothetical protein +FIG01195561 FIG01195562: hypothetical protein +FIG01195566 FIG01195567: hypothetical protein +FIG01195574 FIG01195632: hypothetical protein +FIG01195579 ABC Transporter +FIG01195586 FIG01195587: hypothetical protein +FIG01195587 FIG01195588: hypothetical protein +FIG01195588 FIG01195589: hypothetical protein +FIG01195593 ORF28 +FIG01195598 FIG01195599: hypothetical protein +FIG01195601 FIG01195602: hypothetical protein +FIG01195602 FIG01195603: hypothetical protein +FIG01195604 FIG01195605: hypothetical protein +FIG01195607 FIG01195609: hypothetical protein +FIG01195613 FIG01195614: hypothetical protein +FIG01195616 FIG01195617: hypothetical protein +FIG01195620 FIG01195622: hypothetical protein +FIG01195627 FIG01195628: hypothetical protein +FIG01195628 FIG01195629: hypothetical protein +FIG01195634 FIG01195635: hypothetical protein +FIG01195635 FIG01195636: hypothetical protein +FIG01195640 FIG01195641: hypothetical protein +FIG01195664 FIG01195665: hypothetical protein +FIG01195665 FIG01195667: hypothetical protein +FIG01195668 FIG01195670: hypothetical protein +FIG01195670 FIG01195671: hypothetical protein +FIG01195671 FIG01195672: hypothetical protein +FIG01195672 Cytoplasmic hypothetical protein DUF199 +FIG01195679 Hypothetical protein UU308 +FIG01195683 FIG01195685: hypothetical protein +FIG01195686 FIG01195687: hypothetical protein +FIG01195688 Recombination protein U homolog +FIG01195690 FIG01195691: hypothetical protein +FIG01195691 Protein of unknown function DUF262 family +FIG01195696 FIG01195697: hypothetical protein +FIG01195697 FIG01195698: hypothetical protein +FIG01195701 ABC transporter, permease component +FIG01195702 FIG01195703: hypothetical protein +FIG01195706 FIG01195707: hypothetical protein +FIG01195707 FIG01195708: hypothetical protein +FIG01195710 FIG01195711: hypothetical protein +FIG01195711 FIG01195714: hypothetical protein +FIG01195721 FIG01195722: hypothetical protein +FIG01195723 FIG01195726: hypothetical protein +FIG01195728 FIG01195732: hypothetical protein +FIG01195732 FIG01195733: hypothetical protein +FIG01195740 FIG01195741: hypothetical protein +FIG01195743 FIG01195744: hypothetical protein +FIG01195744 FIG01195745: hypothetical protein +FIG01195745 Type II restriction enzyme Bsp6I (EC 3.1.21.4) +FIG01195751 putative ABC substrate-binding protein - iron +FIG01195753 FIG01195755: hypothetical protein +FIG01195763 MBA N-terminal paralog +FIG01195764 PTS system glucose-specific enzyme IIB component +FIG01195768 FIG01195769: hypothetical protein +FIG01195773 FIG01195775: hypothetical protein +FIG01195777 FIG01195778: hypothetical protein +FIG01195778 FIG01195782: hypothetical protein +FIG01195792 Siderophore-mediated iron transport protein +FIG01195802 Ferrichrome ABC transporter +FIG01195803 FIG01195805: hypothetical protein +FIG01195805 FIG01195810: hypothetical protein +FIG01195812 FIG01195813: hypothetical protein +FIG01195813 FIG01195816: hypothetical protein +FIG01195820 FIG01195822: hypothetical protein +FIG01195822 unique hypothetical +FIG01195832 FIG01195834: hypothetical protein +FIG01195838 Possible prophage ps3 protein01-like protein +FIG01195844 Holo-[acyl-carrier-protein] synthase (EC 2.7.8.7) +FIG01195846 Unidentified iron compound ABC uptake transporter permease protein +FIG01195852 unique hypothetical ATP/GTP-binding protein +FIG01195855 FIG01195857: hypothetical protein +FIG01195857 hypothetical protein +FIG01195864 FIG01195869: hypothetical protein +FIG01195869 Tyrosine recombinase xerD +FIG01195871 FIG01195872: hypothetical protein +FIG01195872 FIG01195873: hypothetical protein +FIG01195877 FIG01195878: hypothetical protein +FIG01195878 FIG01195880: hypothetical protein +FIG01195880 FIG01195881: hypothetical protein +FIG01195893 FIG01195894: hypothetical protein +FIG01195900 Ferritin-like protein Rsg +FIG01195902 FIG01195904: hypothetical protein +FIG01195908 FIG01195909: hypothetical protein +FIG01195909 FIG01195910: hypothetical protein +FIG01195916 FIG01195918: hypothetical protein +FIG01195920 Probable DNA polymerase III +FIG01195922 ORF MSV156 hypothetical protein +FIG01195925 FIG01195928: hypothetical protein +FIG01195933 FIG01195935: hypothetical protein +FIG01195945 FIG01195946: hypothetical protein +FIG01195946 FIG01195947: hypothetical protein +FIG01195954 Flagellar hook-length control protein FliK +FIG01195955 FIG01195957: hypothetical protein +FIG01195958 FIG01195960: hypothetical protein +FIG01195960 ABC transporter, permease component (Na+?) +FIG01195971 FIG01195973: hypothetical protein +FIG01195975 FIG01195979: hypothetical protein +FIG01195979 FIG01195980: hypothetical protein +FIG01195987 FIG01195989: hypothetical protein +FIG01195989 FIG01195993: hypothetical protein +FIG01195994 Multiple banded antigen +FIG01196001 protein kinase, putative +FIG01196012 FIG01196013: hypothetical protein +FIG01196020 FIG01196021: hypothetical protein +FIG01196023 DNA processing protein SMF +FIG01196026 FIG01196028: hypothetical protein +FIG01196039 Ferrichrome transport system permease protein FhuG +FIG01196047 Choline kinase family +FIG01196050 FIG01196053: hypothetical protein +FIG01196078 FIG01196080: hypothetical protein +FIG01196080 FIG01196082: hypothetical protein +FIG01196102 Unknown protein +FIG01196111 FIG01196112: hypothetical protein +FIG01196114 Unique hypothetical membrane lipoprotein +FIG01196116 FIG01196117: hypothetical protein +FIG01196120 FIG01196122: hypothetical protein +FIG01196126 Spermidine Putrescine transport ATP-binding protein potA (TC_3.A.1.11.1) +FIG01196127 FIG01196128: hypothetical protein +FIG01196145 probably ABC transporter membrane protein +FIG01196152 FIG01196153: hypothetical protein +FIG01196158 Uncharacterized ATP-binding protein UU034 +FIG01196166 FIG01196167: hypothetical protein +FIG01196176 FIG01196178: hypothetical protein +FIG01196178 hypothetical protein +FIG01196179 FIG01196183: hypothetical protein +FIG01196186 reticulocyte binding protein 2 homolog a +FIG01196187 FIG01196196: hypothetical protein +FIG01196199 FIG01196200: hypothetical protein +FIG01196209 FIG01196212: hypothetical protein +FIG01196222 FIG01196225: hypothetical protein +FIG01196258 Probable protein-export membrane protein secG +FIG01196260 FIG01196262: hypothetical protein +FIG01196265 Ferrichrome transport ATP-binding protein FhuC (TC 3.A.1.14.3) +FIG01196266 hypothetical protein +FIG01196280 FIG01196281: hypothetical protein +FIG01196281 FIG01196282: hypothetical protein +FIG01196294 FIG01196295: hypothetical protein +FIG01196301 FIG01196303: hypothetical protein +FIG01196334 unique hypothetical +FIG01196340 FIG01196344: hypothetical protein +FIG01196345 FIG01196350: hypothetical protein +FIG01196351 FIG01196354: hypothetical protein +FIG01196354 glutathione peroxidase +FIG01196359 LSU ribosomal protein L33p +FIG01196377 Flagellar hook-length control protein FliK +FIG01196422 FIG01196424: hypothetical protein +FIG01196478 FIG01196479: hypothetical protein +FIG01196484 FIG01196486: hypothetical protein +FIG01196486 Topoisomerase IV subunit B fragment +FIG01196488 FIG01196489: hypothetical protein +FIG01196506 FIG01196507: hypothetical protein +FIG01196583 FIG01196587: hypothetical protein +FIG01196628 TYPE III RESTRICTION-MODIFICATION SYSTEM: METHYLASE (EC 2.1.1.72) +FIG01196648 Modification methylase HinfI (EC 2.1.1.72) +FIG01196723 Mitochondrial ribosomal protein VAR1 +FIG01196751 reticulocyte binding protein 2 homolog a +FIG01196761 Type III restriction-modification system: methylase (EC 2.1.1.72) +FIG01196764 FIG01196769: hypothetical protein +FIG01196830 Modification methylase ScrFIB (EC 2.1.1.37) +FIG01196837 FIG01196839: hypothetical protein +FIG01196839 FIG01196840: hypothetical protein +FIG01196840 Tyrosine-protein kinase wzc (EC 2.7.10.2) +FIG01196843 FIG01196844: hypothetical protein +FIG01196844 FIG01196845: hypothetical protein +FIG01196845 FIG01196846: hypothetical protein +FIG01196846 FIG01196847: hypothetical protein +FIG01196847 FIG01196848: hypothetical protein +FIG01196851 FIG01196853: hypothetical protein +FIG01196854 FIG01196855: hypothetical protein +FIG01196855 PHP C-terminal domain protein +FIG01196857 S-layer domain protein domain protein +FIG01196858 FIG01196859: hypothetical protein +FIG01196859 FIG01196860: hypothetical protein +FIG01196860 FIG01196861: hypothetical protein +FIG01196861 FIG01196862: hypothetical protein +FIG01196862 Zn-dependent peptidase, insulinase family +FIG01196865 FIG01196866: hypothetical protein +FIG01196867 FIG01196868: hypothetical protein +FIG01196869 FIG01196870: hypothetical protein +FIG01196870 FIG01196871: hypothetical protein +FIG01196871 FIG01196872: hypothetical protein +FIG01196875 FIG01196876: hypothetical protein +FIG01196878 FIG01196879: hypothetical protein +FIG01196879 FIG01196880: hypothetical protein +FIG01196880 FIG01196881: hypothetical protein +FIG01196884 FIG01196886: hypothetical protein +FIG01196886 FIG01196887: hypothetical protein +FIG01196887 FIG01196888: hypothetical protein +FIG01196890 FIG01196891: hypothetical protein +FIG01196891 FIG01196894: hypothetical protein +FIG01196896 FIG01196898: hypothetical protein +FIG01196899 Fe(III) dicitrate ABC transporter, ATP-binding protein +FIG01196901 FIG01196902: hypothetical protein +FIG01196906 FIG01196907: hypothetical protein +FIG01196907 FIG01196908: hypothetical protein +FIG01196908 Hemin-binding periplasmic protein hmuT precursor +FIG01196910 FIG01196911: hypothetical protein +FIG01196911 FIG01196912: hypothetical protein +FIG01196912 FIG01196914: hypothetical protein +FIG01196914 Uncharacterized membrane protein, YCGQ B. subtilis homolog +FIG01196919 FIG01196920: hypothetical protein +FIG01196920 FIG01196921: hypothetical protein +FIG01196921 FIG01196922: hypothetical protein +FIG01196922 FIG01196923: hypothetical protein +FIG01196925 FIG01196926: hypothetical protein +FIG01196929 FIG01196931: hypothetical protein +FIG01196931 FIG01196932: hypothetical protein +FIG01196932 FIG01196933: hypothetical protein +FIG01196934 FIG01196935: hypothetical protein +FIG01196937 FIG01196938: hypothetical protein +FIG01196938 S-adenosylmethionine decarboxylase related +FIG01196939 FIG01196941: hypothetical protein +FIG01196941 DNA polymerase III, delta prime subunit( EC:2.7.7.7 ) +FIG01196942 FIG01196943: hypothetical protein +FIG01196943 FIG01196944: hypothetical protein +FIG01196944 amino acid ABC transproter, permease protein +FIG01196945 Acetyl-CoA hydrolase( EC:3.1.2.1 ) +FIG01196946 FIG01196947: hypothetical protein +FIG01196947 FIG01196948: hypothetical protein +FIG01196949 Mammalian cell entry related domain protein +FIG01196950 sulfatase +FIG01196951 FIG01196952: hypothetical protein +FIG01196954 iron compound ABC transporter, periplasmic iron compound-binding protein +FIG01196956 OstA family protein +FIG01196957 FIG01196959: hypothetical protein +FIG01196961 FIG01196964: hypothetical protein +FIG01196964 FIG01196966: hypothetical protein +FIG01196966 FIG01196967: hypothetical protein +FIG01196967 FIG01196968: hypothetical protein +FIG01196968 FIG01196969: hypothetical protein +FIG01196969 Glutamine transport ATP-binding protein GlnQ (TC 3.A.1.3.2) +FIG01196971 FIG01196973: hypothetical protein +FIG01196973 FIG01196974: hypothetical protein +FIG01196974 FIG01196975: hypothetical protein +FIG01196977 FIG01196978: hypothetical protein +FIG01196978 FIG01196979: hypothetical protein +FIG01196979 FIG01196980: hypothetical protein +FIG01196980 FIG01196982: hypothetical protein +FIG01196983 FIG01196984: hypothetical protein +FIG01196984 FIG01196986: hypothetical protein +FIG01196987 FIG01196988: hypothetical protein +FIG01196988 FIG01196989: hypothetical protein +FIG01196990 FIG01196991: hypothetical protein +FIG01196993 FIG01196994: hypothetical protein +FIG01196995 Zn-ribbon-containing, possibly RNA-binding protein and truncated derivatives +FIG01196997 FIG01196998: hypothetical protein +FIG01196999 DedA +FIG01197002 FIG01197003: hypothetical protein +FIG01197005 FIG01197006: hypothetical protein +FIG01197006 ProP protein +FIG01197009 protein of unknown function DUF105 +FIG01197010 FIG01197011: hypothetical protein +FIG01197012 FIG01197013: hypothetical protein +FIG01197013 FIG01197014: hypothetical protein +FIG01197016 FIG01197020: hypothetical protein +FIG01197022 FIG01197023: hypothetical protein +FIG01197027 FIG01197028: hypothetical protein +FIG01197028 FIG01197029: hypothetical protein +FIG01197030 protein of unknown function DUF6, transmembrane +FIG01197031 FIG01197032: hypothetical protein +FIG01197034 cobalt transport protein +FIG01197043 FIG01197044: hypothetical protein +FIG01197048 FIG01197049: hypothetical protein +FIG01197049 copper ion binding protein +FIG01197051 FIG01197052: hypothetical protein +FIG01197054 FIG01197056: hypothetical protein +FIG01197056 FIG01197059: hypothetical protein +FIG01197061 FIG01197062: hypothetical protein +FIG01197063 FIG01197064: hypothetical protein +FIG01197064 FIG01197066: hypothetical protein +FIG01197069 FIG01197070: hypothetical protein +FIG01197070 FIG01197073: hypothetical protein +FIG01197073 FIG01197074: hypothetical protein +FIG01197077 PTS system IIB component +FIG01197080 FIG01197081: hypothetical protein +FIG01197081 FIG01197082: hypothetical protein +FIG01197083 FIG01197084: hypothetical protein +FIG01197084 repeat unit transporter +FIG01197086 FIG01197087: hypothetical protein +FIG01197087 FIG01197088: hypothetical protein +FIG01197088 FIG01197089: hypothetical protein +FIG01197089 FIG01197090: hypothetical protein +FIG01197090 FIG01197091: hypothetical protein +FIG01197091 FIG01197092: hypothetical protein +FIG01197096 FIG01197097: hypothetical protein +FIG01197097 Selenide,water dikinase (EC 2.7.9.3) @ selenocysteine-containing +FIG01197098 FIG01197100: hypothetical protein +FIG01197100 FIG01197102: hypothetical protein +FIG01197103 FIG01197104: hypothetical protein +FIG01197104 FIG01197106: hypothetical protein +FIG01197108 FIG01197110: hypothetical protein +FIG01197110 oligopeptide ABC transporter ATP-binding protein +FIG01197113 UPF0342 protein in lrpR 3'region +FIG01197115 FIG01197116: hypothetical protein +FIG01197116 FIG01197118: hypothetical protein +FIG01197118 FIG01197119: hypothetical protein +FIG01197119 FIG01197121: hypothetical protein +FIG01197122 protein of unknown function DUF805 +FIG01197125 FIG01197126: hypothetical protein +FIG01197126 FIG01197128: hypothetical protein +FIG01197129 FIG01197130: hypothetical protein +FIG01197131 Oxidoreductase( EC:1.1.1.- ) +FIG01197133 FIG01197135: hypothetical protein +FIG01197135 FIG01197137: hypothetical protein +FIG01197144 FIG01197146: hypothetical protein +FIG01197146 FIG01197147: hypothetical protein +FIG01197148 FIG01197149: hypothetical protein +FIG01197149 probable amino acid carrier protein +FIG01197151 FIG01197152: hypothetical protein +FIG01197152 FIG01197153: hypothetical protein +FIG01197153 FIG01197154: hypothetical protein +FIG01197155 FIG01197157: hypothetical protein +FIG01197159 FIG01197160: hypothetical protein +FIG01197161 FIG01197162: hypothetical protein +FIG01197162 FIG01197164: hypothetical protein +FIG01197164 FIG01197165: hypothetical protein +FIG01197168 Two-component response regulator yycF +FIG01197170 FIG01197171: hypothetical protein +FIG01197171 FIG01197172: hypothetical protein +FIG01197172 nitroimidazole resistance protein, putative +FIG01197174 FIG01197175: hypothetical protein +FIG01197175 FIG01197176: hypothetical protein +FIG01197178 FIG01197179: hypothetical protein +FIG01197179 FIG01197181: hypothetical protein +FIG01197183 FIG01197184: hypothetical protein +FIG01197188 FIG01197189: hypothetical protein +FIG01197192 NAD(P)H-nitrite reductase +FIG01197194 FIG01197195: hypothetical protein +FIG01197195 Resolvase, RNase H domain protein fold +FIG01197196 FIG01197197: hypothetical protein +FIG01197204 FIG01197205: hypothetical protein +FIG01197205 FIG01197207: hypothetical protein +FIG01197207 FIG01197208: hypothetical protein +FIG01197209 FIG01197212: hypothetical protein +FIG01197212 Molybdopterin biosynthesis protein A +FIG01197213 OrfX +FIG01197217 protein of unknown function DUF140 +FIG01197218 FIG01197219: hypothetical protein +FIG01197219 FIG01197220: hypothetical protein +FIG01197220 FIG01197221: hypothetical protein +FIG01197221 FIG01197222: hypothetical protein +FIG01197223 4-oxalocrotonate tautomerase( EC:5.3.2.- ) +FIG01197227 protein of unknown function DUF445 +FIG01197228 FIG01197229: hypothetical protein +FIG01197229 FIG01197230: hypothetical protein +FIG01197231 FIG01197233: hypothetical protein +FIG01197233 FIG01197234: hypothetical protein +FIG01197234 FIG01197235: hypothetical protein +FIG01197235 FIG01197236: hypothetical protein +FIG01197237 FIG01197238: hypothetical protein +FIG01197238 FIG01197239: hypothetical protein +FIG01197240 FIG01197241: hypothetical protein +FIG01197247 Shikimate kinase (EC 2.7.1.71) +FIG01197249 protein of unknown function DUF541 +FIG01197250 alpha 1,2 N-acetylglucosamine transferase +FIG01197252 FIG01197253: hypothetical protein +FIG01197253 FIG01197254: hypothetical protein +FIG01197258 iron ABC transporter substrate-binding protein +FIG01197260 FIG01197261: hypothetical protein +FIG01197261 FIG01197262: hypothetical protein +FIG01197264 FIG01197265: hypothetical protein +FIG01197267 FIG01197269: hypothetical protein +FIG01197270 FIG01197271: hypothetical protein +FIG01197272 FIG01197273: hypothetical protein +FIG01197274 FIG01197275: hypothetical protein +FIG01197275 FIG01197276: hypothetical protein +FIG01197277 1,3-propanediol dehydrogenase (EC 1.1.1.202) +FIG01197283 FIG01197284: hypothetical protein +FIG01197285 FIG01197286: hypothetical protein +FIG01197289 FIG01197291: hypothetical protein +FIG01197293 FIG01197294: hypothetical protein +FIG01197294 DNA polymerase III subunit delta +FIG01197295 FIG01197297: hypothetical protein +FIG01197297 FIG01197298: hypothetical protein +FIG01197299 FIG01197300: hypothetical protein +FIG01197300 FIG01197301: hypothetical protein +FIG01197301 FIG01197303: hypothetical protein +FIG01197303 FIG01197304: hypothetical protein +FIG01197305 FIG01197307: hypothetical protein +FIG01197309 FIG01197310: hypothetical protein +FIG01197310 FIG01197311: hypothetical protein +FIG01197311 FIG01197312: hypothetical protein +FIG01197313 FIG01197314: hypothetical protein +FIG01197314 FIG01197315: hypothetical protein +FIG01197315 FIG01197316: hypothetical protein +FIG01197317 FIG01197318: hypothetical protein +FIG01197322 FIG01197323: hypothetical protein +FIG01197323 FIG01197324: hypothetical protein +FIG01197324 protein of unknown function DUF1239 +FIG01197325 polysaccharide export protein +FIG01197326 FIG01197327: hypothetical protein +FIG01197329 FIG01197330: hypothetical protein +FIG01197330 FIG01197332: hypothetical protein +FIG01197332 FIG01197333: hypothetical protein +FIG01197334 FIG01197337: hypothetical protein +FIG01197337 FIG01197338: hypothetical protein +FIG01197338 FIG01197339: hypothetical protein +FIG01197341 histidine triad (HIT) protein +FIG01197343 FIG01197344: hypothetical protein +FIG01197344 FIG01197347: hypothetical protein +FIG01197350 putative metal dependent hydrolase +FIG01197351 FIG01197352: hypothetical protein +FIG01197352 FIG01197353: hypothetical protein +FIG01197353 FIG01197354: hypothetical protein +FIG01197354 FIG01197357: hypothetical protein +FIG01197357 FIG01197359: hypothetical protein +FIG01197360 bacterial type II/III secretion system protein +FIG01197361 FIG01197362: hypothetical protein +FIG01197364 Ferredoxin-nitrite reductase +FIG01197367 DNA recombination and repair protein RecO +FIG01197370 FIG01197371: hypothetical protein +FIG01197372 FIG01197374: hypothetical protein +FIG01197375 FIG01197377: hypothetical protein +FIG01197381 FIG01197382: hypothetical protein +FIG01197384 COGs COG2843 +FIG01197385 FIG01197388: hypothetical protein +FIG01197388 FIG01197389: hypothetical protein +FIG01197389 FIG01197390: hypothetical protein +FIG01197390 FIG01197391: hypothetical protein +FIG01197397 methylmalonyl-CoA decarboxylase delta-subunit +FIG01197399 FIG01197400: hypothetical protein +FIG01197400 FIG01197401: hypothetical protein +FIG01197403 FIG01197404: hypothetical protein +FIG01197405 FIG01197406: hypothetical protein +FIG01197406 protein of unknown function DUF1121 +FIG01197409 FIG01197412: hypothetical protein +FIG01197413 twin-arginine translocation protein, TatA/E family subunit +FIG01197416 FIG01197418: hypothetical protein +FIG01197418 FIG01197420: hypothetical protein +FIG01197423 FIG01197424: hypothetical protein +FIG01197424 FIG01197426: hypothetical protein +FIG01197431 Putative RND family drug transporter +FIG01197432 FIG01197433: hypothetical protein +FIG01197433 FIG01197434: hypothetical protein +FIG01197435 Channel-forming transporter/cytolysins activator of TpsB family +FIG01197436 protein of unknown function DUF951 +FIG01197437 FIG01197438: hypothetical protein +FIG01197441 FIG01197442: hypothetical protein +FIG01197447 FIG01197449: hypothetical protein +FIG01197449 FIG01197451: hypothetical protein +FIG01197454 Uncharacterized MobA-related protein-like +FIG01197456 FIG01197457: hypothetical protein +FIG01197458 FIG01197460: hypothetical protein +FIG01197460 FIG01197461: hypothetical protein +FIG01197462 FIG01197463: hypothetical protein +FIG01197464 FIG01197466: hypothetical protein +FIG01197466 FIG01197467: hypothetical protein +FIG01197470 FIG01197471: hypothetical protein +FIG01197473 FIG01197474: hypothetical protein +FIG01197474 FIG01197475: hypothetical protein +FIG01197476 FIG01197477: hypothetical protein +FIG01197478 FIG01197479: hypothetical protein +FIG01197480 outer membrane chaperone Skp (OmpH) +FIG01197481 FIG01197482: hypothetical protein +FIG01197482 FIG01197483: hypothetical protein +FIG01197483 FIG01197484: hypothetical protein +FIG01197490 FIG01197491: hypothetical protein +FIG01197492 FIG01197493: hypothetical protein +FIG01197493 FIG01197494: hypothetical protein +FIG01197494 PTS system, 3-keto-L-gulonate/L-ascorbate specific IIA component (PtxA) +FIG01197495 FIG01197496: hypothetical protein +FIG01197496 FIG01197497: hypothetical protein +FIG01197497 FIG01197498: hypothetical protein +FIG01197499 FIG01197500: hypothetical protein +FIG01197500 Ni/Fe-hydrogenase, b-type cytochrome subunit +FIG01197502 FIG01197503: hypothetical protein +FIG01197508 FIG01197509: hypothetical protein +FIG01197510 FIG01197511: hypothetical protein +FIG01197511 2',3'-cyclic nucleotide 3'-phosphodiesterase( EC:3.1.4.37 ) +FIG01197515 Na+/H+ antiporter, ortholog YQKI B.subtilis +FIG01197518 FIG01197519: hypothetical protein +FIG01197519 FIG01197520: hypothetical protein +FIG01197520 FIG01197524: hypothetical protein +FIG01197524 FIG01197525: hypothetical protein +FIG01197525 putative aminopeptidase 2 +FIG01197526 FIG01197528: hypothetical protein +FIG01197528 FIG01197529: hypothetical protein +FIG01197529 FIG01197530: hypothetical protein +FIG01197531 FIG01197532: hypothetical protein +FIG01197532 FIG01197533: hypothetical protein +FIG01197538 FIG01197539: hypothetical protein +FIG01197539 FIG01197540: hypothetical protein +FIG01197540 FIG01197541: hypothetical protein +FIG01197543 FIG01197544: hypothetical protein +FIG01197544 FIG01197545: hypothetical protein +FIG01197548 FIG01197549: hypothetical protein +FIG01197549 FIG01197550: hypothetical protein +FIG01197550 FIG01197551: hypothetical protein +FIG01197551 L(+)-tartrate dehydratase beta subunit (EC 4.2.1.32) +FIG01197554 FIG01197555: hypothetical protein +FIG01197557 FIG01197558: hypothetical protein +FIG01197558 FIG01197559: hypothetical protein +FIG01197559 purple acid phosphatase +FIG01197561 spore germination protein-like +FIG01197564 FIG01197566: hypothetical protein +FIG01197566 FIG01197567: hypothetical protein +FIG01197569 UPF0213 protein CPE1444 +FIG01197570 FIG01197571: hypothetical protein +FIG01197571 FIG01197572: hypothetical protein +FIG01197576 FIG01197577: hypothetical protein +FIG01197577 Magnesium and cobalt transport protein CorA +FIG01197578 FIG01197579: hypothetical protein +FIG01197579 FIG01197580: hypothetical protein +FIG01197581 LktC +FIG01197588 FIG01197589: hypothetical protein +FIG01197589 FIG01197590: hypothetical protein +FIG01197591 FIG01197592: hypothetical protein +FIG01197598 type IV prepilin peptidase +FIG01197599 FIG01197600: hypothetical protein +FIG01197601 FIG01197602: hypothetical protein +FIG01197602 FIG01197603: hypothetical protein +FIG01197603 FIG01197604: hypothetical protein +FIG01197604 FIG01197606: hypothetical protein +FIG01197606 DedA family inner membrane protein YdjZ +FIG01197611 FIG01197612: hypothetical protein +FIG01197612 FIG01197613: hypothetical protein +FIG01197614 FIG01197615: hypothetical protein +FIG01197615 FIG01197616: hypothetical protein +FIG01197616 Dipeptide transport ATP-binding protein dppD +FIG01197618 FIG01197621: hypothetical protein +FIG01197622 FIG01197625: hypothetical protein +FIG01197625 FIG01197626: hypothetical protein +FIG01197629 FIG01197633: hypothetical protein +FIG01197633 FIG01197634: hypothetical protein +FIG01197634 FIG01197637: hypothetical protein +FIG01197637 FIG01197638: hypothetical protein +FIG01197641 FIG01197645: hypothetical protein +FIG01197645 FIG01197646: hypothetical protein +FIG01197648 FIG01197650: hypothetical protein +FIG01197650 FIG01197651: hypothetical protein +FIG01197651 FIG01197652: hypothetical protein +FIG01197652 FIG01197653: hypothetical protein +FIG01197657 FIG01197659: hypothetical protein +FIG01197659 FIG01197660: hypothetical protein +FIG01197662 acyltransferase 3 +FIG01197663 FIG01197664: hypothetical protein +FIG01197664 FIG01197665: hypothetical protein +FIG01197666 FIG01197667: hypothetical protein +FIG01197667 FIG01197668: hypothetical protein +FIG01197673 anion transporter family protein +FIG01197675 4-diphosphocytidyl-2C-methyl-D-erythritol synthase +FIG01197676 FIG01197677: hypothetical protein +FIG01197678 putative signal transduction histidine kinase +FIG01197680 FIG01197681: hypothetical protein +FIG01197681 FIG01197682: hypothetical protein +FIG01197685 FIG01197686: hypothetical protein +FIG01197686 FIG01197687: hypothetical protein +FIG01197687 FIG01197690: hypothetical protein +FIG01197690 Ferrichrome ABC transporter, ATP-binding protein, fhuC +FIG01197696 FIG01197697: hypothetical protein +FIG01197697 FIG01197700: hypothetical protein +FIG01197705 YcfA family protein +FIG01197706 FIG01197709: hypothetical protein +FIG01197709 Ethanolamine utilization protein EutN/carboxysome structural protein Ccml +FIG01197710 Epsilon-subunit,methylmalonyl-CoA decarboxylase +FIG01197716 FIG01197717: hypothetical protein +FIG01197720 FIG01197721: hypothetical protein +FIG01197721 FIG01197722: hypothetical protein +FIG01197722 FIG01197724: hypothetical protein +FIG01197724 Integrase/recombinase xerD homolog +FIG01197727 FIG01197729: hypothetical protein +FIG01197729 FIG01197731: hypothetical protein +FIG01197731 Competence protein F, interruption-N +FIG01197734 FIG01197735: hypothetical protein +FIG01197735 FIG01197740: hypothetical protein +FIG01197741 FIG01197743: hypothetical protein +FIG01197761 Heat shock protein (HtpX) protease (EC 3.4.24.-) +FIG01197765 FIG01197768: hypothetical protein +FIG01197768 FIG01197774: hypothetical protein +FIG01197829 FIG01197831: hypothetical protein +FIG01197960 FIG01197961: hypothetical protein +FIG01197971 ABC protein +FIG01197992 Probable lexA repressor (EC 3.4.21.88) +FIG01198032 Transcriptional regulators, LysR family +FIG01198044 FIG01198047: hypothetical protein +FIG01198074 Transcriptional activator ampR family +FIG01198106 Glucosamine ABC transport system, permease protein 2 +FIG01198149 FIG01198151: hypothetical protein +FIG01198164 Probable major facilitator superfamily (MFS) transporter +FIG01198241 Probable LacI-family transcriptional regulator +FIG01198254 Lipase-like enzyme +FIG01198273 oxidoreductase-related protein +FIG01198274 FIG01198276: hypothetical protein +FIG01198281 FIG01198285: hypothetical protein +FIG01198294 FIG01198295: hypothetical protein +FIG01198307 FIG01198312: hypothetical protein +FIG01198320 cystine ABC tranporter, permease protein, putative +FIG01198343 FIG01198345: hypothetical protein +FIG01198360 FIG01198362: hypothetical protein +FIG01198415 Uncharacterized protein UPF0065 +FIG01198426 FIG01198430: hypothetical protein +FIG01198442 Hemolysin-type calcium-binding region:Haemolysin-type calcium binding related +FIG01198466 FIG01198471: hypothetical protein +FIG01198516 FIG01198523: hypothetical protein +FIG01198542 putative subunit of succinyl-CoA:benzylsuccinate CoA-transferase +FIG01198628 FIG01198632: hypothetical protein +FIG01198652 FIG01198654: hypothetical protein +FIG01198655 FIG01198658: hypothetical protein +FIG01198682 FIG01198686: hypothetical protein +FIG01198693 MxaJ, protein involved in methanol oxidation +FIG01198697 FIG01198699: hypothetical protein +FIG01198775 TonB, C-terminal precursor +FIG01198792 FIG01198795: hypothetical protein +FIG01198846 Opine oxidase subunit A +FIG01198861 Opine oxidase subunit A +FIG01198931 FIG01198937: hypothetical protein +FIG01198946 ABC-2 type transporter, NodJ +FIG01198948 Msl8646 protein +FIG01198971 Restriction enzymes type I helicase subunits and related helicases (EC 3.1.21.3) +FIG01198980 FIG01198981: hypothetical protein +FIG01198997 FIG00432255: hypothetical protein +FIG01199101 probable ABC transporter permease protein +FIG01199120 Branched-chain amino acid ABC transporter, periplasmic amino acid- binding protein +FIG01199177 Methanol dehydrogenase, small subunit (EC 1.1.99.8) +FIG01199184 putative ABC transporter subunit +FIG01199186 Nonspecific lipid-transfer protein (EC 2.3.1.176) (Propanoyl-CoA C-acyltransferase) (NSL-TP) (Sterol carrier protein 2) (SCP-2) (Sterol carrier protein X) (SCP-X) (SCP-chi) (SCPX) (Fragment) +FIG01199197 FIG01199202: hypothetical protein +FIG01199222 FIG01199223: hypothetical protein +FIG01199241 TRANSCRIPTIONAL REGULATORY PROTEIN +FIG01199253 FIG01199254: hypothetical protein +FIG01199327 FIG01199329: hypothetical protein +FIG01199329 FIG00387820: hypothetical protein +FIG01199337 Beta-lactamase-like precursor +FIG01199341 FIG01199342: hypothetical protein +FIG01199354 FIG01199357: hypothetical protein +FIG01199373 SmpA/OmlA domain protein +FIG01199387 FIG00388189: hypothetical protein +FIG01199446 protein of unknown function DUF1111 +FIG01199484 FIG01199485: hypothetical protein +FIG01199485 FIG01199495: hypothetical protein +FIG01199495 FIG01199507: hypothetical protein +FIG01199522 FIG01199523: hypothetical protein +FIG01199527 FIG01199528: hypothetical protein +FIG01199528 FIG01199530: hypothetical protein +FIG01199533 FIG01199534: hypothetical protein +FIG01199535 FIG01199536: hypothetical protein +FIG01199536 FIG01199537: hypothetical protein +FIG01199538 FIG01199540: hypothetical protein +FIG01199540 FIG01199541: hypothetical protein +FIG01199541 FIG01199542: hypothetical protein +FIG01199543 FIG01199544: hypothetical protein +FIG01199547 FIG01199548: hypothetical protein +FIG01199548 FIG01199549: hypothetical protein +FIG01199549 FIG01199550: hypothetical protein +FIG01199550 FIG01199551: hypothetical protein +FIG01199551 FIG01199553: hypothetical protein +FIG01199553 FIG01199554: hypothetical protein +FIG01199554 FIG01199556: hypothetical protein +FIG01199556 FIG01199557: hypothetical protein +FIG01199557 FIG01199558: hypothetical protein +FIG01199558 Hypothetical protein in cluster with HutR, VCA0066 homolog +FIG01199560 FIG01199561: hypothetical protein +FIG01199561 FIG01199562: hypothetical protein +FIG01199562 FIG01199563: hypothetical protein +FIG01199563 FIG01199564: hypothetical protein +FIG01199565 FIG01199567: hypothetical protein +FIG01199567 FIG01199570: hypothetical protein +FIG01199570 hypothetical protein +FIG01199573 FIG01199577: hypothetical protein +FIG01199577 FIG01199578: hypothetical protein +FIG01199578 FIG01199579: hypothetical protein +FIG01199579 FIG01199582: hypothetical protein +FIG01199582 FIG01199583: hypothetical protein +FIG01199583 FIG01199584: hypothetical protein +FIG01199584 FIG01199585: hypothetical protein +FIG01199586 FIG01199587: hypothetical protein +FIG01199587 FIG01199588: hypothetical protein +FIG01199590 FIG01199591: hypothetical protein +FIG01199593 FIG01199594: hypothetical protein +FIG01199594 FIG01199595: hypothetical protein +FIG01199595 FIG01199596: hypothetical protein +FIG01199596 FIG01199597: hypothetical protein +FIG01199597 FIG01199598: hypothetical protein +FIG01199598 FIG01199599: hypothetical protein +FIG01199599 FIG01199600: hypothetical protein +FIG01199600 FIG01199601: hypothetical protein +FIG01199601 FIG01199602: hypothetical protein +FIG01199602 FIG01199603: hypothetical protein +FIG01199603 FIG01199604: hypothetical protein +FIG01199604 FIG01199605: hypothetical protein +FIG01199605 FIG01199606: hypothetical protein +FIG01199606 FIG01199607: hypothetical protein +FIG01199608 FIG01199609: hypothetical protein +FIG01199609 FIG01199610: hypothetical protein +FIG01199610 FIG01199611: hypothetical protein +FIG01199611 FIG01199615: hypothetical protein +FIG01199615 FIG01199617: hypothetical protein +FIG01199619 FIG01199620: hypothetical protein +FIG01199620 FIG01199621: hypothetical protein +FIG01199623 FIG01199625: hypothetical protein +FIG01199625 FIG01199626: hypothetical protein +FIG01199626 FIG01199627: hypothetical protein +FIG01199627 FIG01199628: hypothetical protein +FIG01199628 FIG01199629: hypothetical protein +FIG01199630 lipopeptide +FIG01199631 FIG01199632: hypothetical protein +FIG01199632 FIG01199633: hypothetical protein +FIG01199635 FIG01199636: hypothetical protein +FIG01199637 FIG01199641: hypothetical protein +FIG01199641 FIG01199642: hypothetical protein +FIG01199642 FIG01199643: hypothetical protein +FIG01199643 FIG01199644: hypothetical protein +FIG01199644 FIG01199645: hypothetical protein +FIG01199645 FIG01199646: hypothetical protein +FIG01199646 FIG01199649: hypothetical protein +FIG01199649 FIG01199650: hypothetical protein +FIG01199652 FIG01199653: hypothetical protein +FIG01199653 FIG01199654: hypothetical protein +FIG01199655 FIG01199656: hypothetical protein +FIG01199658 FIG01199659: hypothetical protein +FIG01199659 phage transcriptional regulator, AlpA +FIG01199660 FIG01199661: hypothetical protein +FIG01199663 FIG01199664: hypothetical protein +FIG01199664 FIG01199665: hypothetical protein +FIG01199665 FIG01199666: hypothetical protein +FIG01199666 FIG01199667: hypothetical protein +FIG01199667 FIG01199668: hypothetical protein +FIG01199668 FIG01199669: hypothetical protein +FIG01199670 FIG01199671: hypothetical protein +FIG01199671 FIG01199672: hypothetical protein +FIG01199672 FIG01199673: hypothetical protein +FIG01199673 FIG01199674: hypothetical protein +FIG01199674 FIG01199677: hypothetical protein +FIG01199678 FIG01199680: hypothetical protein +FIG01199682 FIG01199683: hypothetical protein +FIG01199683 FIG01199685: hypothetical protein +FIG01199685 FIG01199686: hypothetical protein +FIG01199687 FIG01199688: hypothetical protein +FIG01199688 FIG01199689: hypothetical protein +FIG01199689 FIG01199690: hypothetical protein +FIG01199690 FIG01199691: hypothetical protein +FIG01199692 FIG01199693: hypothetical protein +FIG01199693 FIG01199695: hypothetical protein +FIG01199696 FIG01199697: hypothetical protein +FIG01199697 FIG01199698: hypothetical protein +FIG01199698 FIG01199699: hypothetical protein +FIG01199699 FIG01199700: hypothetical protein +FIG01199700 FIG01199703: hypothetical protein +FIG01199703 FIG01199704: hypothetical protein +FIG01199704 FIG01199705: hypothetical protein +FIG01199705 FIG01199706: hypothetical protein +FIG01199706 FIG01199707: hypothetical protein +FIG01199710 FIG01199711: hypothetical protein +FIG01199711 FIG01199712: hypothetical protein +FIG01199712 FIG01199713: hypothetical protein +FIG01199713 FIG01199714: hypothetical protein +FIG01199716 FIG01199717: hypothetical protein +FIG01199717 FIG01199719: hypothetical protein +FIG01199720 FIG01199722: hypothetical protein +FIG01199722 FIG01199723: hypothetical protein +FIG01199723 FIG01199724: hypothetical protein +FIG01199724 FIG01199727: hypothetical protein +FIG01199727 FIG01199729: hypothetical protein +FIG01199730 FIG01199731: hypothetical protein +FIG01199731 FIG01199732: hypothetical protein +FIG01199732 FIG01199734: hypothetical protein +FIG01199735 FIG01199736: hypothetical protein +FIG01199736 FIG01199737: hypothetical protein +FIG01199737 FIG01199738: hypothetical protein +FIG01199738 FIG01199739: hypothetical protein +FIG01199739 putative rhs-related protein +FIG01199740 FIG01199741: hypothetical protein +FIG01199741 FIG01199743: hypothetical protein +FIG01199743 FIG01199744: hypothetical protein +FIG01199744 FIG01199745: hypothetical protein +FIG01199746 FIG01199747: hypothetical protein +FIG01199749 FIG01199752: hypothetical protein +FIG01199752 FIG01199753: hypothetical protein +FIG01199753 FIG01199754: hypothetical protein +FIG01199754 FIG01199755: hypothetical protein +FIG01199755 FIG01199758: hypothetical protein +FIG01199758 FIG01199759: hypothetical protein +FIG01199759 FIG01199761: hypothetical protein +FIG01199761 FIG01199765: hypothetical protein +FIG01199766 FIG01199767: hypothetical protein +FIG01199767 FIG01199770: hypothetical protein +FIG01199770 FIG01199771: hypothetical protein +FIG01199771 FIG01199772: hypothetical protein +FIG01199774 FIG01199775: hypothetical protein +FIG01199775 FIG01199776: hypothetical protein +FIG01199776 FIG01199777: hypothetical protein +FIG01199777 FIG01199778: hypothetical protein +FIG01199780 FIG01199781: hypothetical protein +FIG01199781 FIG01199782: hypothetical protein +FIG01199782 FIG01199783: hypothetical protein +FIG01199786 FIG01199787: hypothetical protein +FIG01199788 FIG01199790: hypothetical protein +FIG01199790 FIG01199791: hypothetical protein +FIG01199791 FIG01199792: hypothetical protein +FIG01199794 FIG01199795: hypothetical protein +FIG01199795 COG3306: Glycosyltransferase involved in LPS biosynthesis +FIG01199798 FIG01199799: hypothetical protein +FIG01199802 FIG01199803: hypothetical protein +FIG01199806 FIG01199808: hypothetical protein +FIG01199808 FIG01199811: hypothetical protein +FIG01199811 FIG01199812: hypothetical protein +FIG01199812 FIG01199814: hypothetical protein +FIG01199814 FIG01199818: hypothetical protein +FIG01199818 FIG01199820: hypothetical protein +FIG01199820 FIG01199822: hypothetical protein +FIG01199822 FIG01199823: hypothetical protein +FIG01199823 FIG01199824: hypothetical protein +FIG01199824 Predicted polymerase, ortholog to Borrelia burgdorferi BB0267 +FIG01199827 FIG01199828: hypothetical protein +FIG01199828 FIG01199829: hypothetical protein +FIG01199829 FIG01199830: hypothetical protein +FIG01199830 FIG01199831: hypothetical protein +FIG01199831 FIG01199888: hypothetical protein +FIG01199836 FIG01199837: hypothetical protein +FIG01199837 FIG01199841: hypothetical protein +FIG01199841 FIG01199843: hypothetical protein +FIG01199843 FIG01199844: hypothetical protein +FIG01199846 FIG01199847: hypothetical protein +FIG01199848 FIG01199849: hypothetical protein +FIG01199849 FIG01199850: hypothetical protein +FIG01199850 FIG01199851: hypothetical protein +FIG01199851 hypothetical protein +FIG01199852 FIG01199853: hypothetical protein +FIG01199853 FIG01199855: hypothetical protein +FIG01199855 FIG01199858: hypothetical protein +FIG01199858 FIG01199861: hypothetical protein +FIG01199861 FIG01199863: hypothetical protein +FIG01199863 FIG01199864: hypothetical protein +FIG01199864 FIG01199865: hypothetical protein +FIG01199865 FIG01199866: hypothetical protein +FIG01199866 FIG01199867: hypothetical protein +FIG01199868 FIG01199869: hypothetical protein +FIG01199870 FIG01199871: hypothetical protein +FIG01199871 FIG01199872: hypothetical protein +FIG01199872 FIG01199876: hypothetical protein +FIG01199876 FIG01199877: hypothetical protein +FIG01199877 FIG01199878: hypothetical protein +FIG01199881 FIG01199882: hypothetical protein +FIG01199882 FIG01199884: hypothetical protein +FIG01199884 FIG01199885: hypothetical protein +FIG01199885 FIG01199887: hypothetical protein +FIG01199888 FIG01199889: hypothetical protein +FIG01199889 FIG01199890: hypothetical protein +FIG01199890 FIG01199891: hypothetical protein +FIG01199895 FIG01199896: hypothetical protein +FIG01199896 FIG01199897: hypothetical protein +FIG01199897 FIG01199898: hypothetical protein +FIG01199898 FIG01199900: hypothetical protein +FIG01199900 FIG01199901: hypothetical protein +FIG01199901 FIG01199902: hypothetical protein +FIG01199903 FIG01199906: hypothetical protein +FIG01199906 FIG01199908: hypothetical protein +FIG01199908 FIG01199909: hypothetical protein +FIG01199909 FIG01199912: hypothetical protein +FIG01199912 FIG01199913: hypothetical protein +FIG01199913 FIG01199914: hypothetical protein +FIG01199914 FIG01199915: hypothetical protein +FIG01199916 FIG01199917: hypothetical protein +FIG01199917 FIG01199918: hypothetical protein +FIG01199918 FIG01199919: hypothetical protein +FIG01199919 FIG01199920: hypothetical protein +FIG01199920 FIG01199925: hypothetical protein +FIG01199925 FIG01199926: hypothetical protein +FIG01199926 FIG01199927: hypothetical protein +FIG01199927 FIG01199928: hypothetical protein +FIG01199928 FIG01199929: hypothetical protein +FIG01199929 FIG01199930: hypothetical protein +FIG01199930 FIG01199933: hypothetical protein +FIG01199933 FIG01199934: hypothetical protein +FIG01199934 FIG01199935: hypothetical protein +FIG01199935 FIG01199937: hypothetical protein +FIG01199937 FIG01199938: hypothetical protein +FIG01199938 FIG01199939: hypothetical protein +FIG01199939 FIG01199940: hypothetical protein +FIG01199940 FIG01199942: hypothetical protein +FIG01199942 FIG01199943: hypothetical protein +FIG01199943 FIG01199944: hypothetical protein +FIG01199944 FIG01199945: hypothetical protein +FIG01199945 Hypothetical with regulatory P domain of a subtilisin-like proprotein convertase +FIG01199947 FIG01199948: hypothetical protein +FIG01199950 FIG01199952: hypothetical protein +FIG01199952 FIG01199953: hypothetical protein +FIG01199953 FIG01199954: hypothetical protein +FIG01199954 FIG01199955: hypothetical protein +FIG01199955 FIG01199956: hypothetical protein +FIG01199956 FIG01199957: hypothetical protein +FIG01199957 Diguanylate cyclase/phosphodiesterase domain 2 (EAL) +FIG01199958 FIG01199959: hypothetical protein +FIG01199960 COG1059: Thermostable 8-oxoguanine DNA glycosylase +FIG01199961 FIG01199962: hypothetical protein +FIG01199962 FIG01199963: hypothetical protein +FIG01199963 FIG01199964: hypothetical protein +FIG01199966 FIG01199967: hypothetical protein +FIG01199967 FIG01199969: hypothetical protein +FIG01199969 FIG01199970: hypothetical protein +FIG01199970 FIG01199972: hypothetical protein +FIG01199972 FIG01199973: hypothetical protein +FIG01199973 FIG01199974: hypothetical protein +FIG01199975 FIG01199976: hypothetical protein +FIG01199976 FIG01199977: hypothetical protein +FIG01199977 FIG01199978: hypothetical protein +FIG01199979 FIG01199982: hypothetical protein +FIG01199982 FIG01199983: hypothetical protein +FIG01199983 FIG01199985: hypothetical protein +FIG01199985 Phage-related baseplate assembly protein +FIG01199986 FIG01199987: hypothetical protein +FIG01199987 Na+ driven multidrug efflux pump +FIG01199989 FIG01199990: hypothetical protein +FIG01199990 FIG01199991: hypothetical protein +FIG01199993 FIG01199995: hypothetical protein +FIG01199995 FIG01199998: hypothetical protein +FIG01199998 FIG01200001: hypothetical protein +FIG01200001 FIG01200002: hypothetical protein +FIG01200004 Putative TonB-dependent heme receptor HasR +FIG01200005 FIG01200006: hypothetical protein +FIG01200006 FIG01200007: hypothetical protein +FIG01200007 FIG01200010: hypothetical protein +FIG01200010 FIG01200012: hypothetical protein +FIG01200015 FIG01200017: hypothetical protein +FIG01200017 FIG01200018: hypothetical protein +FIG01200018 FIG01200021: hypothetical protein +FIG01200023 FIG01200024: hypothetical protein +FIG01200030 FIG01200031: hypothetical protein +FIG01200031 FIG01200033: hypothetical protein +FIG01200034 FIG01200035: hypothetical protein +FIG01200035 FIG01200037: hypothetical protein +FIG01200037 FIG01200038: hypothetical protein +FIG01200038 FIG01200040: hypothetical protein +FIG01200040 FIG01200041: hypothetical protein +FIG01200041 FIG01200042: hypothetical protein +FIG01200042 FIG01200046: hypothetical protein +FIG01200046 FIG01200048: hypothetical protein +FIG01200048 FIG01200049: hypothetical protein +FIG01200051 FIG01200052: hypothetical protein +FIG01200052 FIG01200053: hypothetical protein +FIG01200054 FIG01200055: hypothetical protein +FIG01200057 FIG01200060: hypothetical protein +FIG01200060 FIG01200063: hypothetical protein +FIG01200063 FIG01200064: hypothetical protein +FIG01200064 FIG01200065: hypothetical protein +FIG01200065 FIG01200066: hypothetical protein +FIG01200068 FIG01200069: hypothetical protein +FIG01200069 FIG01200071: hypothetical protein +FIG01200071 FIG01200074: hypothetical protein +FIG01200075 FIG01200078: hypothetical protein +FIG01200078 FIG01200080: hypothetical protein +FIG01200080 FIG01200081: hypothetical protein +FIG01200081 FIG01200083: hypothetical protein +FIG01200083 FIG01200084: hypothetical protein +FIG01200084 FxsA protein +FIG01200086 FIG01200087: hypothetical protein +FIG01200089 FIG01200090: hypothetical protein +FIG01200092 FIG01200093: hypothetical protein +FIG01200093 FIG01200094: hypothetical protein +FIG01200094 FIG01200096: hypothetical protein +FIG01200101 FIG01200102: hypothetical protein +FIG01200103 FIG01200104: hypothetical protein +FIG01200104 FIG01200105: hypothetical protein +FIG01200105 FIG01200109: hypothetical protein +FIG01200109 FIG01200110: hypothetical protein +FIG01200112 FIG152265: Sodium:solute symporter associated protein +FIG01200116 FIG01200117: hypothetical protein +FIG01200118 FIG01200119: hypothetical protein +FIG01200119 FIG01200120: hypothetical protein +FIG01200120 putative traA protein +FIG01200121 FIG01200123: hypothetical protein +FIG01200123 FIG01200124: hypothetical protein +FIG01200125 FIG01200127: hypothetical protein +FIG01200127 FIG01200128: hypothetical protein +FIG01200128 FIG01200129: hypothetical protein +FIG01200129 FIG01200130: hypothetical protein +FIG01200131 FIG01200132: hypothetical protein +FIG01200136 FIG01200137: hypothetical protein +FIG01200137 FIG01200138: hypothetical protein +FIG01200138 FIG01200140: hypothetical protein +FIG01200140 FIG01200141: hypothetical protein +FIG01200141 FIG01200142: hypothetical protein +FIG01200144 FIG01200145: hypothetical protein +FIG01200145 FIG01200146: hypothetical protein +FIG01200146 FIG01200147: hypothetical protein +FIG01200147 FIG01200148: hypothetical protein +FIG01200148 FIG01200150: hypothetical protein +FIG01200150 FIG01200152: hypothetical protein +FIG01200152 FIG01200153: hypothetical protein +FIG01200153 FIG01200155: hypothetical protein +FIG01200155 FIG01200156: hypothetical protein +FIG01200156 FIG01200157: hypothetical protein +FIG01200157 FIG01200158: hypothetical protein +FIG01200158 Methyl coenzyme M reductase system component A2 +FIG01200160 FIG01200162: hypothetical protein +FIG01200162 FIG01200163: hypothetical protein +FIG01200163 FIG01200165: hypothetical protein +FIG01200165 FIG01200167: hypothetical protein +FIG01200167 FIG01200169: hypothetical protein +FIG01200169 FIG01200170: hypothetical protein +FIG01200173 FIG01200174: hypothetical protein +FIG01200174 Fermentation/respiration switch protein +FIG01200175 FIG01200176: hypothetical protein +FIG01200176 FIG01200177: hypothetical protein +FIG01200177 FIG01200178: hypothetical protein +FIG01200178 FIG01200180: hypothetical protein +FIG01200180 FIG01200181: hypothetical protein +FIG01200181 FIG01200185: hypothetical protein +FIG01200185 Signal transduction histidine kinase regulating citrate/malate metabolism +FIG01200187 FIG01200188: hypothetical protein +FIG01200190 FIG01200191: hypothetical protein +FIG01200191 FIG01200193: hypothetical protein +FIG01200193 FIG01200194: hypothetical protein +FIG01200194 FIG01200195: hypothetical protein +FIG01200195 FIG01200197: hypothetical protein +FIG01200197 FIG01200199: hypothetical protein +FIG01200199 FIG01200201: hypothetical protein +FIG01200207 FIG01200209: hypothetical protein +FIG01200209 FIG01200210: hypothetical protein +FIG01200210 FIG01200211: hypothetical protein +FIG01200211 FIG01200212: hypothetical protein +FIG01200212 FIG01200213: hypothetical protein +FIG01200219 lipoprotein Blc +FIG01200220 FIG01200221: hypothetical protein +FIG01200221 FIG01200222: hypothetical protein +FIG01200225 FIG01200226: hypothetical protein +FIG01200226 FIG01200227: hypothetical protein +FIG01200227 FIG01200228: hypothetical protein +FIG01200228 FIG01200232: hypothetical protein +FIG01200232 FIG01200233: hypothetical protein +FIG01200234 FIG01200235: hypothetical protein +FIG01200235 FIG01200236: hypothetical protein +FIG01200236 FIG01200237: hypothetical protein +FIG01200237 FIG01200238: hypothetical protein +FIG01200240 FIG01200241: hypothetical protein +FIG01200241 FIG01200243: hypothetical protein +FIG01200243 FIG01200245: hypothetical protein +FIG01200245 FIG01200246: hypothetical protein +FIG01200246 FIG01200247: hypothetical protein +FIG01200247 FIG01200248: hypothetical protein +FIG01200248 FIG01200249: hypothetical protein +FIG01200249 FIG01200250: hypothetical protein +FIG01200250 FIG01200252: hypothetical protein +FIG01200254 FIG01200255: hypothetical protein +FIG01200256 FIG01200257: hypothetical protein +FIG01200259 FIG01200260: hypothetical protein +FIG01200260 FIG01200261: hypothetical protein +FIG01200261 FIG01200262: hypothetical protein +FIG01200263 FIG01200264: hypothetical protein +FIG01200264 FIG01200265: hypothetical protein +FIG01200265 FIG00920623: hypothetical protein +FIG01200266 FIG01200268: hypothetical protein +FIG01200268 FIG01200271: hypothetical protein +FIG01200273 FIG01200274: hypothetical protein +FIG01200277 FIG01200278: hypothetical protein +FIG01200278 FIG01200279: hypothetical protein +FIG01200279 FIG01200281: hypothetical protein +FIG01200283 FIG01200286: hypothetical protein +FIG01200286 FIG01200287: hypothetical protein +FIG01200287 FIG01200288: hypothetical protein +FIG01200288 FIG01200289: hypothetical protein +FIG01200289 FIG01200290: hypothetical protein +FIG01200290 FIG01200291: hypothetical protein +FIG01200291 FIG01200292: hypothetical protein +FIG01200292 FIG01200295: hypothetical protein +FIG01200295 FIG01200297: hypothetical protein +FIG01200297 FIG01200298: hypothetical protein +FIG01200299 FIG01200301: hypothetical protein +FIG01200302 FIG01200305: hypothetical protein +FIG01200305 FIG01200306: hypothetical protein +FIG01200307 FIG01200308: hypothetical protein +FIG01200308 FIG01200309: hypothetical protein +FIG01200309 FIG01200310: hypothetical protein +FIG01200310 FIG01200311: hypothetical protein +FIG01200314 FIG01200315: hypothetical protein +FIG01200315 FIG01200318: hypothetical protein +FIG01200318 FIG01200320: hypothetical protein +FIG01200320 FIG01200323: hypothetical protein +FIG01200323 FIG01204717: hypothetical protein +FIG01200326 FIG01200327: hypothetical protein +FIG01200327 FIG01200329: hypothetical protein +FIG01200331 FIG01202936: hypothetical protein +FIG01200332 FIG01200333: hypothetical protein +FIG01200333 FIG01200334: hypothetical protein +FIG01200334 FIG01200336: hypothetical protein +FIG01200336 FIG01200339: hypothetical protein +FIG01200340 FIG01200342: hypothetical protein +FIG01200342 FIG01200345: hypothetical protein +FIG01200345 FIG01200346: hypothetical protein +FIG01200347 FIG01200348: hypothetical protein +FIG01200348 FIG01200349: hypothetical protein +FIG01200350 FIG01200352: hypothetical protein +FIG01200352 FIG01200353: hypothetical protein +FIG01200358 FIG01200359: hypothetical protein +FIG01200359 putative histidinol phosphatase and related hydrolases of the PHP family +FIG01200361 FIG01200362: hypothetical protein +FIG01200362 FIG01200365: hypothetical protein +FIG01200367 FIG01200368: hypothetical protein +FIG01200368 FIG01200369: hypothetical protein +FIG01200369 FIG01200370: hypothetical protein +FIG01200370 FIG01200371: hypothetical protein +FIG01200371 FIG01200372: hypothetical protein +FIG01200372 FIG01200373: hypothetical protein +FIG01200374 FIG01200375: hypothetical protein +FIG01200376 FIG01200377: hypothetical protein +FIG01200377 FIG01200378: hypothetical protein +FIG01200378 FIG01200380: hypothetical protein +FIG01200381 FIG01200382: hypothetical protein +FIG01200382 Homoserine/homoserine lactone efflux protein +FIG01200383 FIG01200385: hypothetical protein +FIG01200385 FIG01200386: hypothetical protein +FIG01200389 FIG01200390: hypothetical protein +FIG01200391 FIG01200392: hypothetical protein +FIG01200392 FIG01200393: hypothetical protein +FIG01200393 FIG01200395: hypothetical protein +FIG01200395 FIG01200397: hypothetical protein +FIG01200397 FIG01200398: hypothetical protein +FIG01200398 FIG01200399: hypothetical protein +FIG01200399 FIG01200400: hypothetical protein +FIG01200400 FIG01200401: hypothetical protein +FIG01200402 FIG01200405: hypothetical protein +FIG01200405 FIG01200406: hypothetical protein +FIG01200407 FIG01200410: hypothetical protein +FIG01200410 FIG01200411: hypothetical protein +FIG01200411 FIG01200413: hypothetical protein +FIG01200419 FIG01200420: hypothetical protein +FIG01200421 FIG01200423: hypothetical protein +FIG01200423 FIG01200424: hypothetical protein +FIG01200424 FIG01200426: hypothetical protein +FIG01200426 FIG01200427: hypothetical protein +FIG01200427 FIG01200428: hypothetical protein +FIG01200428 FIG01200429: hypothetical protein +FIG01200429 FIG01200431: hypothetical protein +FIG01200431 extracellular solute-binding protein, family 3/GGDEF domain protein +FIG01200434 FIG01200435: hypothetical protein +FIG01200437 FIG01200438: hypothetical protein +FIG01200439 FIG01200440: hypothetical protein +FIG01200440 FIG01200441: hypothetical protein +FIG01200443 FIG01200444: hypothetical protein +FIG01200444 FIG01200445: hypothetical protein +FIG01200445 FIG01200446: hypothetical protein +FIG01200447 FIG01200448: hypothetical protein +FIG01200448 FIG01200450: hypothetical protein +FIG01200450 FIG01200453: hypothetical protein +FIG01200454 FIG01200456: hypothetical protein +FIG01200456 FIG01200457: hypothetical protein +FIG01200457 FIG01200459: hypothetical protein +FIG01200459 FIG01200460: hypothetical protein +FIG01200461 FIG01200462: hypothetical protein +FIG01200462 FIG01200463: hypothetical protein +FIG01200464 FIG01200465: hypothetical protein +FIG01200465 FIG01200466: hypothetical protein +FIG01200467 FIG01200469: hypothetical protein +FIG01200472 FIG01200473: hypothetical protein +FIG01200473 FIG01200474: hypothetical protein +FIG01200476 FIG01200477: hypothetical protein +FIG01200477 FIG01200478: hypothetical protein +FIG01200479 FIG01200481: hypothetical protein +FIG01200481 FIG01200482: hypothetical protein +FIG01200482 FIG01200485: hypothetical protein +FIG01200485 FIG01200486: hypothetical protein +FIG01200486 FIG01200487: hypothetical protein +FIG01200490 FIG01200491: hypothetical protein +FIG01200491 FIG01200492: hypothetical protein +FIG01200494 FIG01200495: hypothetical protein +FIG01200495 FIG01200496: hypothetical protein +FIG01200496 FIG01200499: hypothetical protein +FIG01200499 FIG01200502: hypothetical protein +FIG01200502 FIG01200504: hypothetical protein +FIG01200504 FIG01200505: hypothetical protein +FIG01200505 FIG01200506: hypothetical protein +FIG01200507 FIG01200510: hypothetical protein +FIG01200510 FIG01200511: hypothetical protein +FIG01200511 FIG01200512: hypothetical protein +FIG01200517 FIG01200518: hypothetical protein +FIG01200519 FIG01200523: hypothetical protein +FIG01200524 FIG01200525: hypothetical protein +FIG01200525 FIG01200526: hypothetical protein +FIG01200526 FIG01200528: hypothetical protein +FIG01200528 FIG01200530: hypothetical protein +FIG01200530 FIG01200531: hypothetical protein +FIG01200533 FIG01200535: hypothetical protein +FIG01200536 FIG01200537: hypothetical protein +FIG01200537 FIG01200538: hypothetical protein +FIG01200538 FIG01200539: hypothetical protein +FIG01200539 FIG01200540: hypothetical protein +FIG01200540 Cation ABC transporter, periplasmic cation-binding protein +FIG01200542 FIG01200543: hypothetical protein +FIG01200543 FIG01200545: hypothetical protein +FIG01200545 FIG01200547: hypothetical protein +FIG01200547 FIG01200548: hypothetical protein +FIG01200548 ABC-type transporter, ATPase component +FIG01200550 FIG01200551: hypothetical protein +FIG01200551 FIG01200552: hypothetical protein +FIG01200556 FIG01200557: hypothetical protein +FIG01200557 FIG01200559: hypothetical protein +FIG01200559 FIG01200560: hypothetical protein +FIG01200560 FIG01200561: hypothetical protein +FIG01200561 FIG01200562: hypothetical protein +FIG01200562 FIG01200563: hypothetical protein +FIG01200564 FIG01200565: hypothetical protein +FIG01200565 FIG01200567: hypothetical protein +FIG01200567 FIG01200568: hypothetical protein +FIG01200570 FIG01200572: hypothetical protein +FIG01200578 FIG01200579: hypothetical protein +FIG01200579 FIG01200580: hypothetical protein +FIG01200580 FIG01200581: hypothetical protein +FIG01200581 FIG01200582: hypothetical protein +FIG01200582 FIG01200583: hypothetical protein +FIG01200587 FIG01200588: hypothetical protein +FIG01200590 FIG01200592: hypothetical protein +FIG01200592 FIG01200593: hypothetical protein +FIG01200593 FIG01200595: hypothetical protein +FIG01200595 FIG01200599: hypothetical protein +FIG01200599 FIG01200600: hypothetical protein +FIG01200600 FIG01200601: hypothetical protein +FIG01200601 FIG01200602: hypothetical protein +FIG01200602 FIG01200603: hypothetical protein +FIG01200604 FIG01200605: hypothetical protein +FIG01200605 FIG01200606: hypothetical protein +FIG01200606 FIG01200607: hypothetical protein +FIG01200607 FIG01200609: hypothetical protein +FIG01200609 FIG01200611: hypothetical protein +FIG01200611 FIG01200614: hypothetical protein +FIG01200614 FIG01200617: hypothetical protein +FIG01200619 FIG01200621: hypothetical protein +FIG01200621 FIG01200622: hypothetical protein +FIG01200622 FIG01200623: hypothetical protein +FIG01200627 FIG01200628: hypothetical protein +FIG01200628 FIG01200630: hypothetical protein +FIG01200630 FIG01200631: hypothetical protein +FIG01200632 FIG01200633: hypothetical protein +FIG01200633 FIG01200634: hypothetical protein +FIG01200635 FIG01200637: hypothetical protein +FIG01200640 FIG01200641: hypothetical protein +FIG01200641 hypothetical protein +FIG01200643 FIG01200644: hypothetical protein +FIG01200644 FIG01200645: hypothetical protein +FIG01200645 FIG01200646: hypothetical protein +FIG01200646 FIG01200647: hypothetical protein +FIG01200650 FIG01200652: hypothetical protein +FIG01200652 FIG01200653: hypothetical protein +FIG01200653 FIG01200654: hypothetical protein +FIG01200654 FIG01200656: hypothetical protein +FIG01200656 FIG01200659: hypothetical protein +FIG01200659 FIG01200661: hypothetical protein +FIG01200661 FIG01200663: hypothetical protein +FIG01200663 FIG01200664: hypothetical protein +FIG01200664 FIG01200665: hypothetical protein +FIG01200665 FIG01200667: hypothetical protein +FIG01200667 FIG01200668: hypothetical protein +FIG01200668 FIG01200669: hypothetical protein +FIG01200669 FIG01200673: hypothetical protein +FIG01200673 FIG01200675: hypothetical protein +FIG01200675 FIG01200676: hypothetical protein +FIG01200676 FIG01200677: hypothetical protein +FIG01200677 FIG01200678: hypothetical protein +FIG01200678 FIG01200679: hypothetical protein +FIG01200679 FIG01200680: hypothetical protein +FIG01200681 FIG01200682: hypothetical protein +FIG01200682 FIG01200683: hypothetical protein +FIG01200683 FIG01200684: hypothetical protein +FIG01200687 FIG01200690: hypothetical protein +FIG01200690 FIG01200691: hypothetical protein +FIG01200693 FIG01200694: hypothetical protein +FIG01200694 FIG01200695: hypothetical protein +FIG01200695 FIG01200697: hypothetical protein +FIG01200698 FIG01200699: hypothetical protein +FIG01200699 FIG01200701: hypothetical protein +FIG01200701 FIG01200701: possible membrane protein +FIG01200703 FIG01200704: hypothetical protein +FIG01200704 FIG01200706: hypothetical protein +FIG01200706 FIG01200707: hypothetical protein +FIG01200708 FIG01200709: hypothetical protein +FIG01200710 FIG01200711: hypothetical protein +FIG01200711 Outer membrane lipoprotein precursor, OmpA family +FIG01200713 FIG01200715: hypothetical protein +FIG01200715 FIG01200716: hypothetical protein +FIG01200716 FIG01200718: hypothetical protein +FIG01200720 FIG01200721: hypothetical protein +FIG01200721 FIG01200722: hypothetical protein +FIG01200722 FIG01200723: hypothetical protein +FIG01200723 FIG01200724: hypothetical protein +FIG01200724 FIG01200725: hypothetical protein +FIG01200726 FIG01200728: hypothetical protein +FIG01200728 FIG01200729: hypothetical protein +FIG01200729 FIG01200730: hypothetical protein +FIG01200732 FIG01200733: hypothetical protein +FIG01200733 FIG01200735: hypothetical protein +FIG01200735 FIG01200737: hypothetical protein +FIG01200737 FIG01200738: hypothetical protein +FIG01200740 FIG01200741: hypothetical protein +FIG01200741 FIG01200742: hypothetical protein +FIG01200742 FIG01201713: hypothetical protein +FIG01200745 FIG01200746: hypothetical protein +FIG01200746 FIG01200748: hypothetical protein +FIG01200753 3-oxoacyl-[acyl-carrier protein] reductase (EC 1.1.1.100), paralog +FIG01200754 FIG01200755: hypothetical protein +FIG01200755 FIG01200757: hypothetical protein +FIG01200757 FIG01200758: hypothetical protein +FIG01200758 FIG01200759: hypothetical protein +FIG01200759 FIG01200760: hypothetical protein +FIG01200761 FIG01200762: hypothetical protein +FIG01200762 FIG01200764: hypothetical protein +FIG01200766 FIG01200767: hypothetical protein +FIG01200767 FIG01200768: hypothetical protein +FIG01200768 FIG01200770: hypothetical protein +FIG01200770 FIG01200771: hypothetical protein +FIG01200771 FIG01200772: hypothetical protein +FIG01200772 FIG01200775: hypothetical protein +FIG01200775 FIG01200776: hypothetical protein +FIG01200777 FIG01200778: hypothetical protein +FIG01200778 FIG01200779: hypothetical protein +FIG01200779 FIG01200780: hypothetical protein +FIG01200780 FIG01200781: hypothetical protein +FIG01200783 FIG01200784: hypothetical protein +FIG01200785 FIG01200786: hypothetical protein +FIG01200786 FIG01200787: hypothetical protein +FIG01200787 FIG01200788: hypothetical protein +FIG01200788 FIG01200789: hypothetical protein +FIG01200789 FIG01200790: hypothetical protein +FIG01200790 FIG01200791: hypothetical protein +FIG01200792 FIG00920510: hypothetical protein +FIG01200793 FIG01200794: hypothetical protein +FIG01200794 FIG01200795: hypothetical protein +FIG01200795 FIG01200796: hypothetical protein +FIG01200796 FIG01200798: hypothetical protein +FIG01200798 FIG01200802: hypothetical protein +FIG01200802 FIG01200803: hypothetical protein +FIG01200803 hypothetical protein +FIG01200806 FIG01200807: hypothetical protein +FIG01200808 FIG01200809: hypothetical protein +FIG01200810 FIG01200811: hypothetical protein +FIG01200812 FIG01200813: hypothetical protein +FIG01200813 FIG01200814: hypothetical protein +FIG01200814 FIG01200815: hypothetical protein +FIG01200815 FIG01200816: hypothetical protein +FIG01200817 FIG01200820: hypothetical protein +FIG01200820 FIG01200821: hypothetical protein +FIG01200821 FIG01200822: hypothetical protein +FIG01200822 FIG01200823: hypothetical protein +FIG01200823 FIG01200824: hypothetical protein +FIG01200825 Fimbrial protein precursor +FIG01200828 FIG01200829: hypothetical protein +FIG01200829 FIG01200830: hypothetical protein +FIG01200831 FIG01200832: hypothetical protein +FIG01200832 FIG01200833: hypothetical protein +FIG01200833 FIG01200834: hypothetical protein +FIG01200834 FIG01200836: hypothetical protein +FIG01200836 FIG01200841: hypothetical protein +FIG01200842 FIG01200843: hypothetical protein +FIG01200843 FIG01200844: hypothetical protein +FIG01200845 FIG01200847: hypothetical protein +FIG01200847 FIG01200849: hypothetical protein +FIG01200849 FIG01200850: hypothetical protein +FIG01200850 FIG01200851: hypothetical protein +FIG01200851 FIG01200852: hypothetical protein +FIG01200852 FIG01200853: hypothetical protein +FIG01200856 FIG01200857: hypothetical protein +FIG01200858 Phage tail protein I +FIG01200861 FIG01200862: hypothetical protein +FIG01200864 FIG01200865: hypothetical protein +FIG01200865 FIG01200869: hypothetical protein +FIG01200869 FIG01200871: hypothetical protein +FIG01200872 FIG01200875: hypothetical protein +FIG01200877 FIG01200878: hypothetical protein +FIG01200878 FIG01200879: hypothetical protein +FIG01200879 FIG01200880: hypothetical protein +FIG01200880 FIG01200881: hypothetical protein +FIG01200882 FIG01200883: hypothetical protein +FIG01200883 FIG01200885: hypothetical protein +FIG01200885 FIG01200887: hypothetical protein +FIG01200887 FIG01200888: hypothetical protein +FIG01200892 FIG01200894: hypothetical protein +FIG01200894 FIG01200896: hypothetical protein +FIG01200896 FIG01200898: hypothetical protein +FIG01200898 FIG01200899: hypothetical protein +FIG01200899 FIG01200900: hypothetical protein +FIG01200900 FIG01200901: hypothetical protein +FIG01200901 FIG01200903: hypothetical protein +FIG01200903 FIG01200904: hypothetical protein +FIG01200905 FIG01200906: hypothetical protein +FIG01200908 FIG01200909: hypothetical protein +FIG01200909 FIG01200910: hypothetical protein +FIG01200910 FIG01200911: hypothetical protein +FIG01200911 FIG01200913: hypothetical protein +FIG01200913 FIG01200914: hypothetical protein +FIG01200914 FIG01200915: hypothetical protein +FIG01200915 FIG01200916: hypothetical protein +FIG01200916 FIG01200917: hypothetical protein +FIG01200917 FIG01200918: hypothetical protein +FIG01200919 FIG01200920: hypothetical protein +FIG01200920 FIG01200921: hypothetical protein +FIG01200923 FIG01200924: hypothetical protein +FIG01200926 Outer membrane protein OmpT +FIG01200929 FIG01200930: hypothetical protein +FIG01200931 FIG01200935: hypothetical protein +FIG01200935 FIG01200937: hypothetical protein +FIG01200938 FIG01200939: hypothetical protein +FIG01200939 FIG01200940: hypothetical protein +FIG01200940 FIG01200941: hypothetical protein +FIG01200941 FIG01200943: hypothetical protein +FIG01200943 Rhombosortase +FIG01200944 FIG01200945: hypothetical protein +FIG01200946 FIG01200948: hypothetical protein +FIG01200948 FIG01200949: hypothetical protein +FIG01200949 FIG01200951: hypothetical protein +FIG01200951 FIG01200952: hypothetical protein +FIG01200952 FIG01200954: hypothetical protein +FIG01200958 FIG01200959: hypothetical protein +FIG01200959 FIG01200960: hypothetical protein +FIG01200960 FIG01200961: hypothetical protein +FIG01200961 FIG01200964: hypothetical protein +FIG01200964 FIG01200966: hypothetical protein +FIG01200966 FIG01200967: hypothetical protein +FIG01200967 FIG01200968: hypothetical protein +FIG01200968 FIG01200969: hypothetical protein +FIG01200969 FIG01200970: hypothetical protein +FIG01200970 FIG01200972: hypothetical protein +FIG01200972 FIG01200973: hypothetical protein +FIG01200973 Ig-like, group 2 precursor +FIG01200981 FIG01200982: hypothetical protein +FIG01200983 FIG01200986: hypothetical protein +FIG01200986 FIG01200987: hypothetical protein +FIG01200987 FIG01200988: hypothetical protein +FIG01200988 FIG01200989: hypothetical protein +FIG01200989 FIG01200994: hypothetical protein +FIG01200994 FIG01057153: hypothetical protein +FIG01200997 FIG01200999: hypothetical protein +FIG01200999 FIG01201000: hypothetical protein +FIG01201001 FIG01201002: hypothetical protein +FIG01201003 FIG01201004: hypothetical protein +FIG01201004 FIG01201006: hypothetical protein +FIG01201006 FIG01201007: hypothetical protein +FIG01201007 FIG01201008: hypothetical protein +FIG01201008 FIG01201009: hypothetical protein +FIG01201009 FIG01201011: hypothetical protein +FIG01201011 FIG01201012: hypothetical protein +FIG01201012 FIG01201014: hypothetical protein +FIG01201015 FIG01201016: hypothetical protein +FIG01201016 FIG01201017: hypothetical protein +FIG01201020 FIG01201023: hypothetical protein +FIG01201023 FIG01201025: hypothetical protein +FIG01201025 FIG01201026: hypothetical protein +FIG01201027 FIG01201028: hypothetical protein +FIG01201028 FIG01201029: hypothetical protein +FIG01201029 FIG01201031: hypothetical protein +FIG01201031 Phage protein +FIG01201032 FIG01201033: hypothetical protein +FIG01201035 FIG01201036: hypothetical protein +FIG01201037 FIG01201038: hypothetical protein +FIG01201038 FIG01201039: hypothetical protein +FIG01201040 FIG01201041: hypothetical protein +FIG01201041 FIG01201042: hypothetical protein +FIG01201042 FIG01201044: hypothetical protein +FIG01201045 FIG01201046: hypothetical protein +FIG01201046 FIG01201047: hypothetical protein +FIG01201050 FIG01201051: hypothetical protein +FIG01201051 FIG01201052: hypothetical protein +FIG01201052 FIG01201053: hypothetical protein +FIG01201053 FIG01201054: hypothetical protein +FIG01201054 FIG01201055: hypothetical protein +FIG01201055 FIG01201057: hypothetical protein +FIG01201057 FIG01201058: hypothetical protein +FIG01201059 FIG01201060: hypothetical protein +FIG01201063 FIG01201064: hypothetical protein +FIG01201066 FIG01201067: hypothetical protein +FIG01201071 FIG01201073: hypothetical protein +FIG01201073 FIG01201076: hypothetical protein +FIG01201076 FIG01201078: hypothetical protein +FIG01201078 FIG01201079: hypothetical protein +FIG01201079 FIG01201080: hypothetical protein +FIG01201080 FIG01201081: hypothetical protein +FIG01201082 FIG01201083: hypothetical protein +FIG01201083 FIG01201084: hypothetical protein +FIG01201087 FIG01201088: hypothetical protein +FIG01201088 FIG01201089: hypothetical protein +FIG01201089 FIG01201091: hypothetical protein +FIG01201094 FIG01201095: hypothetical protein +FIG01201095 FIG01201097: hypothetical protein +FIG01201097 FIG01201098: hypothetical protein +FIG01201098 FIG01201099: hypothetical protein +FIG01201099 FIG01201100: hypothetical protein +FIG01201100 FIG01201101: hypothetical protein +FIG01201101 FIG01201102: hypothetical protein +FIG01201102 FIG01201103: hypothetical protein +FIG01201103 FIG01201104: hypothetical protein +FIG01201104 FIG01201105: hypothetical protein +FIG01201108 FIG01201109: hypothetical protein +FIG01201109 Tn7-like transposition protein TnsC +FIG01201114 FIG01201115: hypothetical protein +FIG01201115 FIG01201116: hypothetical protein +FIG01201117 FIG01201118: hypothetical protein +FIG01201121 FIG01201122: hypothetical protein +FIG01201122 FIG01201123: hypothetical protein +FIG01201125 FIG01201126: hypothetical protein +FIG01201126 FIG01201127: hypothetical protein +FIG01201127 FIG01201128: hypothetical protein +FIG01201128 Hypothetical transcription regulator +FIG01201129 FIG01201131: hypothetical protein +FIG01201131 FIG01201132: hypothetical protein +FIG01201132 FIG01201133: hypothetical protein +FIG01201133 FIG01201134: hypothetical protein +FIG01201134 FIG01201135: hypothetical protein +FIG01201136 FIG01201137: hypothetical protein +FIG01201137 FIG01201138: hypothetical protein +FIG01201138 FIG01201143: hypothetical protein +FIG01201143 FIG01201145: hypothetical protein +FIG01201145 FIG01201146: hypothetical protein +FIG01201148 FIG01201149: hypothetical protein +FIG01201149 FIG01201150: hypothetical protein +FIG01201152 FIG01201156: hypothetical protein +FIG01201156 FIG01201158: hypothetical protein +FIG01201158 FIG01201159: hypothetical protein +FIG01201161 FIG01201162: hypothetical protein +FIG01201162 FIG01201163: hypothetical protein +FIG01201163 FIG01201164: hypothetical protein +FIG01201164 DNA polymerase III, epsilon subunit-like protein +FIG01201165 FIG01201166: hypothetical protein +FIG01201166 FIG01201167: hypothetical protein +FIG01201167 FIG01201168: hypothetical protein +FIG01201169 FIG01201170: hypothetical protein +FIG01201171 FIG01201172: hypothetical protein +FIG01201175 FIG01201176: hypothetical protein +FIG01201176 FIG01201177: hypothetical protein +FIG01201177 FIG01201178: hypothetical protein +FIG01201180 FIG01201181: hypothetical protein +FIG01201184 FIG01201188: hypothetical protein +FIG01201188 hypothetical protein +FIG01201189 FIG01201192: hypothetical protein +FIG01201192 FIG01201193: hypothetical protein +FIG01201193 FIG01201196: hypothetical protein +FIG01201196 FIG01201197: hypothetical protein +FIG01201197 FIG01201199: hypothetical protein +FIG01201199 FIG01201200: hypothetical protein +FIG01201205 FIG01201206: hypothetical protein +FIG01201206 FIG01201207: hypothetical protein +FIG01201207 FIG01201208: hypothetical protein +FIG01201210 FIG01201212: hypothetical protein +FIG01201212 FIG01201213: hypothetical protein +FIG01201216 FIG01201218: hypothetical protein +FIG01201218 FIG01201220: hypothetical protein +FIG01201220 FIG01201221: hypothetical protein +FIG01201223 FIG061186: hypothetical protein +FIG01201227 FIG01201229: hypothetical protein +FIG01201231 FIG01201234: hypothetical protein +FIG01201234 FIG01201235: hypothetical protein +FIG01201235 FIG01201236: hypothetical protein +FIG01201238 FIG01201242: hypothetical protein +FIG01201244 FIG01201245: hypothetical protein +FIG01201245 FIG01201247: hypothetical protein +FIG01201247 FIG01201248: hypothetical protein +FIG01201248 FIG01201249: hypothetical protein +FIG01201252 FIG01201254: hypothetical protein +FIG01201254 FIG01201256: hypothetical protein +FIG01201256 FIG01201257: hypothetical protein +FIG01201257 FIG01201258: hypothetical protein +FIG01201258 FIG01201261: hypothetical protein +FIG01201263 FIG01201264: hypothetical protein +FIG01201267 Alpha-galactosidase +FIG01201272 FIG01201275: hypothetical protein +FIG01201275 FIG01201276: hypothetical protein +FIG01201278 FIG01201279: hypothetical protein +FIG01201279 FIG01201282: hypothetical protein +FIG01201282 FIG01201285: hypothetical protein +FIG01201285 FIG01201286: hypothetical protein +FIG01201286 FIG01201288: hypothetical protein +FIG01201290 FIG01201291: hypothetical protein +FIG01201291 FIG01201294: hypothetical protein +FIG01201294 FIG01201295: hypothetical protein +FIG01201295 FIG01201296: hypothetical protein +FIG01201296 FIG01201297: hypothetical protein +FIG01201297 FIG01201299: hypothetical protein +FIG01201299 FIG01201300: hypothetical protein +FIG01201301 FIG01201302: hypothetical protein +FIG01201302 FIG01201304: hypothetical protein +FIG01201304 FIG01201305: hypothetical protein +FIG01201306 inner membrane protein, putative +FIG01201309 FIG01201310: hypothetical protein +FIG01201310 FIG01201311: hypothetical protein +FIG01201311 FIG01201312: hypothetical protein +FIG01201312 Bacterial leucyl aminopeptidase precursor (EC 3.4.11.10) +FIG01201315 FIG01201316: hypothetical protein +FIG01201316 FIG01201318: hypothetical protein +FIG01201318 FIG01201320: hypothetical protein +FIG01201321 FIG01201322: hypothetical protein +FIG01201322 FIG01201323: hypothetical protein +FIG01201323 FIG01201325: hypothetical protein +FIG01201326 FIG01201327: hypothetical protein +FIG01201327 FIG01201329: hypothetical protein +FIG01201329 FIG01201330: hypothetical protein +FIG01201334 FIG01201336: hypothetical protein +FIG01201337 FIG01201338: hypothetical protein +FIG01201338 FIG01201340: hypothetical protein +FIG01201340 FIG01201344: hypothetical protein +FIG01201344 FIG01201346: hypothetical protein +FIG01201346 FIG01201347: hypothetical protein +FIG01201348 FIG01201351: hypothetical protein +FIG01201351 FIG01201352: hypothetical protein +FIG01201352 FIG01201354: hypothetical protein +FIG01201356 FIG01201357: hypothetical protein +FIG01201360 FIG01201362: hypothetical protein +FIG01201362 FIG01201363: hypothetical protein +FIG01201363 FIG01201364: hypothetical protein +FIG01201364 FIG01201365: hypothetical protein +FIG01201366 FIG01201367: hypothetical protein +FIG01201367 FIG01201369: hypothetical protein +FIG01201371 FIG01201373: hypothetical protein +FIG01201373 FIG01201374: hypothetical protein +FIG01201374 FIG01201377: hypothetical protein +FIG01201379 FIG01201380: hypothetical protein +FIG01201382 FIG01201384: hypothetical protein +FIG01201384 FIG01201386: hypothetical protein +FIG01201386 FIG01201388: hypothetical protein +FIG01201388 FIG01201389: hypothetical protein +FIG01201389 FIG01201391: hypothetical protein +FIG01201391 FIG01201392: hypothetical protein +FIG01201392 FIG01201395: hypothetical protein +FIG01201396 NADPH-flavin oxidoreductase (EC 1.6.99.-) +FIG01201399 FIG01201400: hypothetical protein +FIG01201400 FIG01201401: hypothetical protein +FIG01201401 FIG01201403: hypothetical protein +FIG01201403 FIG01201404: hypothetical protein +FIG01201412 FIG01201413: hypothetical protein +FIG01201413 FIG01201414: hypothetical protein +FIG01201417 FIG01201418: hypothetical protein +FIG01201418 FIG01201419: hypothetical protein +FIG01201419 FIG01201420: hypothetical protein +FIG01201423 FIG01201424: hypothetical protein +FIG01201424 FIG01201425: hypothetical protein +FIG01201425 FIG01201426: hypothetical protein +FIG01201426 Twin-arginine translocation pathway signal +FIG01201427 FIG01201430: hypothetical protein +FIG01201430 FIG01201431: hypothetical protein +FIG01201433 FIG01201435: hypothetical protein +FIG01201435 FIG01201438: hypothetical protein +FIG01201438 FIG01201439: hypothetical protein +FIG01201439 FIG01201441: hypothetical protein +FIG01201441 FIG01201442: hypothetical protein +FIG01201442 FIG01201443: hypothetical protein +FIG01201443 FIG01201445: hypothetical protein +FIG01201445 FIG01201446: hypothetical protein +FIG01201446 FIG01201447: hypothetical protein +FIG01201448 2,3-dihydro-2,3-dihydroxybenzoate dehydrogenase (EC 1.3.1.28) +FIG01201450 FIG01201452: hypothetical protein +FIG01201452 FIG01201453: hypothetical protein +FIG01201453 FIG01201457: hypothetical protein +FIG01201457 FIG01201458: hypothetical protein +FIG01201458 FIG01201460: hypothetical protein +FIG01201462 FIG01201463: hypothetical protein +FIG01201464 FIG01201465: hypothetical protein +FIG01201465 FIG01201466: hypothetical protein +FIG01201466 FIG01201467: hypothetical protein +FIG01201473 FIG01201474: hypothetical protein +FIG01201474 FIG01201475: hypothetical protein +FIG01201475 FIG01201476: hypothetical protein +FIG01201476 FIG01201478: hypothetical protein +FIG01201478 FIG01201480: hypothetical protein +FIG01201481 glycosyltransferase( EC:2.4.- ) +FIG01201483 FIG01201484: hypothetical protein +FIG01201484 FIG01201487: hypothetical protein +FIG01201488 FIG01201490: hypothetical protein +FIG01201493 FIG01201494: hypothetical protein +FIG01201494 FIG01201495: hypothetical protein +FIG01201495 FIG01201497: hypothetical protein +FIG01201497 FIG01201498: hypothetical protein +FIG01201498 FIG01201500: hypothetical protein +FIG01201501 FIG01201502: hypothetical protein +FIG01201502 FIG054117: hypothetical protein +FIG01201503 FIG01201506: hypothetical protein +FIG01201506 FIG01201511: hypothetical protein +FIG01201511 FIG01201512: hypothetical protein +FIG01201512 FIG01201513: hypothetical protein +FIG01201513 FIG01201514: hypothetical protein +FIG01201522 FIG01201525: hypothetical protein +FIG01201527 FIG01201528: hypothetical protein +FIG01201530 FIG01201534: hypothetical protein +FIG01201534 FIG01201535: hypothetical protein +FIG01201535 FIG01201536: hypothetical protein +FIG01201536 FIG01201537: hypothetical protein +FIG01201537 FIG01201538: hypothetical protein +FIG01201538 putative transcriptional activator ToxR +FIG01201540 FIG01201542: hypothetical protein +FIG01201542 FIG01201543: hypothetical protein +FIG01201543 FIG01201545: hypothetical protein +FIG01201545 FIG01201546: hypothetical protein +FIG01201546 FIG01201547: hypothetical protein +FIG01201548 FIG01201550: hypothetical protein +FIG01201550 FIG01201551: hypothetical protein +FIG01201551 FIG01201553: hypothetical protein +FIG01201553 FIG01201554: hypothetical protein +FIG01201554 FIG01201555: hypothetical protein +FIG01201555 FIG01201556: hypothetical protein +FIG01201561 FIG01201562: hypothetical protein +FIG01201564 FIG01201567: hypothetical protein +FIG01201567 FIG01201569: hypothetical protein +FIG01201569 FIG01201570: hypothetical protein +FIG01201570 FIG01201571: hypothetical protein +FIG01201571 FIG01201575: hypothetical protein +FIG01201575 FIG01201576: hypothetical protein +FIG01201577 FIG01201580: hypothetical protein +FIG01201580 FIG01201582: hypothetical protein +FIG01201582 FIG01201585: hypothetical protein +FIG01201587 FIG01201588: hypothetical protein +FIG01201590 FIG01201591: hypothetical protein +FIG01201591 FIG01201594: hypothetical protein +FIG01201598 FIG01201599: hypothetical protein +FIG01201599 FIG01201600: hypothetical protein +FIG01201600 FIG01201601: hypothetical protein +FIG01201601 FIG063674: hypothetical protein +FIG01201602 Protein often near L-alanine-DL-glutamate epimerase (cell wall recycling) +FIG01201603 FIG01201604: hypothetical protein +FIG01201604 FIG01201606: hypothetical protein +FIG01201606 FIG01201609: hypothetical protein +FIG01201609 FIG01201610: hypothetical protein +FIG01201610 FIG01201612: hypothetical protein +FIG01201612 FIG01201616: hypothetical protein +FIG01201619 FIG01201620: hypothetical protein +FIG01201620 FIG01201621: hypothetical protein +FIG01201621 FIG01201624: hypothetical protein +FIG01201625 FIG01201630: hypothetical protein +FIG01201630 FIG01201631: hypothetical protein +FIG01201632 FIG01201636: hypothetical protein +FIG01201637 FIG01201639: hypothetical protein +FIG01201639 FIG01201640: hypothetical protein +FIG01201640 FIG01201641: hypothetical protein +FIG01201641 FIG01201642: hypothetical protein +FIG01201642 FIG01201643: hypothetical protein +FIG01201643 FIG01201644: hypothetical protein +FIG01201644 FIG01201645: hypothetical protein +FIG01201645 FIG01201646: hypothetical protein +FIG01201649 FIG01201650: hypothetical protein +FIG01201650 FIG01201651: hypothetical protein +FIG01201651 FIG01201654: hypothetical protein +FIG01201658 Isochorismate pyruvate-lyase of siderophore biosynthesis +FIG01201660 FIG01201661: hypothetical protein +FIG01201663 3-demethylubiquinone-9 3-methyltransferase domain protein +FIG01201666 FIG01201668: hypothetical protein +FIG01201668 FIG01201669: hypothetical protein +FIG01201669 FIG01201670: hypothetical protein +FIG01201671 FIG01201672: hypothetical protein +FIG01201672 FIG01201673: hypothetical protein +FIG01201680 hypothetical protein +FIG01201681 FIG01201683: hypothetical protein +FIG01201683 FIG01201684: hypothetical protein +FIG01201684 FIG01201685: hypothetical protein +FIG01201685 FIG01201686: hypothetical protein +FIG01201686 FIG01201687: hypothetical protein +FIG01201687 FIG01201688: hypothetical protein +FIG01201690 FIG01201692: hypothetical protein +FIG01201692 FIG01201693: hypothetical protein +FIG01201697 FIG01201698: hypothetical protein +FIG01201701 FIG01201706: hypothetical protein +FIG01201706 FIG01201707: hypothetical protein +FIG01201708 FIG01201709: hypothetical protein +FIG01201709 FIG01201710: hypothetical protein +FIG01201710 FIG01201712: hypothetical protein +FIG01201714 FIG01201715: hypothetical protein +FIG01201717 Phage protein +FIG01201721 FIG01201722: hypothetical protein +FIG01201722 FIG01201724: hypothetical protein +FIG01201724 FIG01201725: hypothetical protein +FIG01201725 FIG01201726: hypothetical protein +FIG01201726 FIG01201727: hypothetical protein +FIG01201728 FIG01201729: hypothetical protein +FIG01201729 FIG01201730: hypothetical protein +FIG01201730 FIG01201731: hypothetical protein +FIG01201731 FIG01201732: hypothetical protein +FIG01201732 FIG01201733: hypothetical protein +FIG01201734 FIG01201735: hypothetical protein +FIG01201735 FIG01201738: hypothetical protein +FIG01201738 FIG01201743: hypothetical protein +FIG01201743 FIG01201744: hypothetical protein +FIG01201745 FIG01201746: hypothetical protein +FIG01201746 FIG01201747: hypothetical protein +FIG01201747 FIG01201749: hypothetical protein +FIG01201750 FIG01201756: hypothetical protein +FIG01201758 Anticodon nuclease +FIG01201760 FIG01201761: hypothetical protein +FIG01201763 FIG01201764: hypothetical protein +FIG01201766 FIG01201767: hypothetical protein +FIG01201768 FIG01201769: hypothetical protein +FIG01201769 FIG01201770: hypothetical protein +FIG01201770 Cytochrome c554 +FIG01201772 FIG01201774: hypothetical protein +FIG01201774 FIG01201776: hypothetical protein +FIG01201781 FIG01201782: hypothetical protein +FIG01201786 FIG01201787: hypothetical protein +FIG01201787 FIG01201788: hypothetical protein +FIG01201791 FIG01201794: hypothetical protein +FIG01201794 FIG01201795: hypothetical protein +FIG01201795 FIG01201796: hypothetical protein +FIG01201796 FIG01201797: hypothetical protein +FIG01201797 FIG01201798: hypothetical protein +FIG01201798 FIG01201799: hypothetical protein +FIG01201799 FIG01201805: hypothetical protein +FIG01201805 FIG01201809: hypothetical protein +FIG01201809 FIG01201810: hypothetical protein +FIG01201812 FIG01201814: hypothetical protein +FIG01201814 FIG01201816: hypothetical protein +FIG01201819 FIG01201820: hypothetical protein +FIG01201820 FIG01201821: hypothetical protein +FIG01201822 FIG01201824: hypothetical protein +FIG01201829 FIG01201830: hypothetical protein +FIG01201830 FIG01201832: hypothetical protein +FIG01201832 FIG01201833: hypothetical protein +FIG01201834 hypothetical protein +FIG01201835 FIG01201836: hypothetical protein +FIG01201839 FIG01201840: hypothetical protein +FIG01201840 FIG01201841: hypothetical protein +FIG01201841 FIG01201844: hypothetical protein +FIG01201844 FIG01201846: hypothetical protein +FIG01201846 FIG01201849: hypothetical protein +FIG01201849 FIG01201850: hypothetical protein +FIG01201850 FIG01201851: hypothetical protein +FIG01201851 FIG01201852: hypothetical protein +FIG01201852 FIG01201854: hypothetical protein +FIG01201854 FIG01201856: hypothetical protein +FIG01201856 FIG01201857: hypothetical protein +FIG01201857 Retron reverse transcriptase +FIG01201858 FIG01201859: hypothetical protein +FIG01201859 FIG01201861: hypothetical protein +FIG01201861 FIG01201862: hypothetical protein +FIG01201862 FIG01201863: hypothetical protein +FIG01201863 FIG01201865: hypothetical protein +FIG01201866 FIG01201868: hypothetical protein +FIG01201868 FIG01201870: hypothetical protein +FIG01201873 FIG054324: hypothetical protein +FIG01201876 FIG01201879: hypothetical protein +FIG01201879 FIG01201881: hypothetical protein +FIG01201882 FIG01201883: hypothetical protein +FIG01201887 FIG01201888: hypothetical protein +FIG01201889 FIG01201890: hypothetical protein +FIG01201891 FIG01201892: hypothetical protein +FIG01201892 FIG01201894: hypothetical protein +FIG01201894 FIG01201895: hypothetical protein +FIG01201897 FIG01201900: hypothetical protein +FIG01201900 FIG01201902: hypothetical protein +FIG01201902 FIG01201903: hypothetical protein +FIG01201905 FIG01201906: hypothetical protein +FIG01201906 putative tail component of prophage CP-933O +FIG01201908 FIG01201910: hypothetical protein +FIG01201910 FIG01201911: hypothetical protein +FIG01201911 FIG01201913: hypothetical protein +FIG01201913 FIG01201914: hypothetical protein +FIG01201916 FIG01201917: hypothetical protein +FIG01201919 FIG01201921: hypothetical protein +FIG01201921 FIG01201922: hypothetical protein +FIG01201923 FIG01201925: hypothetical protein +FIG01201925 FIG01201927: hypothetical protein +FIG01201929 FIG01201930: hypothetical protein +FIG01201930 FIG01201931: hypothetical protein +FIG01201931 FIG01201933: hypothetical protein +FIG01201933 FIG01201934: hypothetical protein +FIG01201934 FIG01201936: hypothetical protein +FIG01201936 FIG01201937: hypothetical protein +FIG01201937 FIG01201938: hypothetical protein +FIG01201939 FIG01201940: hypothetical protein +FIG01201940 FIG01201941: hypothetical protein +FIG01201941 FIG01201943: hypothetical protein +FIG01201943 FIG221619: putative chaperone +FIG01201944 FIG01201945: hypothetical protein +FIG01201945 FIG01201946: hypothetical protein +FIG01201948 FIG01201949: hypothetical protein +FIG01201952 FIG01201953: hypothetical protein +FIG01201954 FIG01201956: hypothetical protein +FIG01201956 FIG01201958: hypothetical protein +FIG01201958 FIG01201961: hypothetical protein +FIG01201961 FIG01201962: hypothetical protein +FIG01201962 FIG01201963: hypothetical protein +FIG01201963 FIG01201964: hypothetical protein +FIG01201964 FIG01201965: hypothetical protein +FIG01201965 FIG01201966: hypothetical protein +FIG01201967 FIG01201968: hypothetical protein +FIG01201974 FIG01201975: hypothetical protein +FIG01201975 FIG01201976: hypothetical protein +FIG01201976 FIG01201977: hypothetical protein +FIG01201977 FIG01201978: hypothetical protein +FIG01201978 FIG01201980: hypothetical protein +FIG01201980 FIG01201981: hypothetical protein +FIG01201981 FIG01201983: hypothetical protein +FIG01201983 FIG01201984: hypothetical protein +FIG01201984 FIG01201985: hypothetical protein +FIG01201985 FIG01201986: hypothetical protein +FIG01201989 FIG01201990: hypothetical protein +FIG01201990 FIG01201992: hypothetical protein +FIG01201995 FIG01201996: hypothetical protein +FIG01201996 FIG01201997: hypothetical protein +FIG01201997 FIG01201998: hypothetical protein +FIG01202000 putative transporter protein +FIG01202002 FIG01202003: hypothetical protein +FIG01202004 FIG01202005: hypothetical protein +FIG01202005 FIG01202007: hypothetical protein +FIG01202007 FIG01202009: hypothetical protein +FIG01202009 FIG01202010: hypothetical protein +FIG01202010 FIG01202011: hypothetical protein +FIG01202013 FIG01202014: hypothetical protein +FIG01202016 COG4453: Uncharacterized protein conserved in bacteria +FIG01202020 FIG01202021: hypothetical protein +FIG01202021 FIG01202023: hypothetical protein +FIG01202027 FIG01202028: hypothetical protein +FIG01202028 FIG01202029: hypothetical protein +FIG01202031 FIG01202033: hypothetical protein +FIG01202033 FIG01202034: hypothetical protein +FIG01202034 FIG01202036: hypothetical protein +FIG01202038 FIG01202039: hypothetical protein +FIG01202039 FIG01202040: hypothetical protein +FIG01202040 FIG01202043: hypothetical protein +FIG01202043 FIG01202044: hypothetical protein +FIG01202044 FIG01202045: hypothetical protein +FIG01202046 FIG01202047: hypothetical protein +FIG01202047 FIG01202048: hypothetical protein +FIG01202049 FIG01202050: hypothetical protein +FIG01202050 FIG01202052: hypothetical protein +FIG01202057 FIG01202058: hypothetical protein +FIG01202067 FIG01202069: hypothetical protein +FIG01202069 FIG01202070: hypothetical protein +FIG01202075 FIG01202077: hypothetical protein +FIG01202077 FIG01202078: hypothetical protein +FIG01202082 FIG068703: hypothetical protein +FIG01202087 FIG01202088: hypothetical protein +FIG01202088 FIG01202089: hypothetical protein +FIG01202089 FIG01202092: hypothetical protein +FIG01202095 FIG01202096: hypothetical protein +FIG01202096 FIG01202100: hypothetical protein +FIG01202101 FIG01202103: hypothetical protein +FIG01202103 FIG01202104: hypothetical protein +FIG01202106 FIG01202107: hypothetical protein +FIG01202111 FIG01202112: hypothetical protein +FIG01202112 FIG01202113: hypothetical protein +FIG01202114 FIG01202116: hypothetical protein +FIG01202119 FIG01202120: hypothetical protein +FIG01202122 FIG01202124: hypothetical protein +FIG01202124 FIG01202125: hypothetical protein +FIG01202125 hydrolase (HAD superfamily)-like +FIG01202126 FIG181673: hypothetical protein +FIG01202128 FIG01202129: hypothetical protein +FIG01202135 FIG01202136: hypothetical protein +FIG01202136 FIG01202137: hypothetical protein +FIG01202137 FIG01202138: hypothetical protein +FIG01202138 FIG01202139: hypothetical protein +FIG01202139 FIG01202141: hypothetical protein +FIG01202141 FIG01202142: hypothetical protein +FIG01202142 FIG01202144: hypothetical protein +FIG01202144 FIG01202148: hypothetical protein +FIG01202148 FIG01202149: hypothetical protein +FIG01202149 FIG01202150: hypothetical protein +FIG01202150 FIG01202151: hypothetical protein +FIG01202151 FIG01202152: hypothetical protein +FIG01202152 FIG01202153: hypothetical protein +FIG01202153 FIG01202154: hypothetical protein +FIG01202154 FIG01202155: hypothetical protein +FIG01202157 FIG01202158: hypothetical protein +FIG01202158 FIG01202159: hypothetical protein +FIG01202160 FIG01202162: hypothetical protein +FIG01202163 FIG01202164: hypothetical protein +FIG01202164 FIG01202166: hypothetical protein +FIG01202166 FIG01202168: hypothetical protein +FIG01202168 FIG01202169: hypothetical protein +FIG01202170 FIG01202173: hypothetical protein +FIG01202173 FIG01202174: hypothetical protein +FIG01202174 FIG01202175: hypothetical protein +FIG01202176 FIG01202178: hypothetical protein +FIG01202178 FIG01202179: hypothetical protein +FIG01202179 FIG01202182: hypothetical protein +FIG01202186 Outer membrane protein ImpK/VasF, OmpA/MotB domain +FIG01202188 FIG01202189: hypothetical protein +FIG01202189 FIG01202190: hypothetical protein +FIG01202193 FIG01202195: hypothetical protein +FIG01202197 FIG01202200: hypothetical protein +FIG01202202 FIG01202204: hypothetical protein +FIG01202204 FIG01202205: hypothetical protein +FIG01202208 FIG01202209: hypothetical protein +FIG01202209 FIG01202210: hypothetical protein +FIG01202210 FIG01202211: hypothetical protein +FIG01202211 FIG01202214: hypothetical protein +FIG01202214 FIG01202215: hypothetical protein +FIG01202215 FIG01202216: hypothetical protein +FIG01202216 FIG01202219: hypothetical protein +FIG01202219 FIG01202222: hypothetical protein +FIG01202224 FIG01202226: hypothetical protein +FIG01202226 FIG01202227: hypothetical protein +FIG01202227 FIG01202229: hypothetical protein +FIG01202229 FIG01202230: hypothetical protein +FIG01202230 FIG01202231: hypothetical protein +FIG01202231 FIG01202233: hypothetical protein +FIG01202237 Bona fide RidA/YjgF/TdcF/RutC subgroup +FIG01202238 FIG01202239: hypothetical protein +FIG01202240 FIG01202242: hypothetical protein +FIG01202242 FIG01202244: hypothetical protein +FIG01202246 FIG01202249: hypothetical protein +FIG01202249 FIG01202252: hypothetical protein +FIG01202252 FIG01202255: hypothetical protein +FIG01202255 FIG01202256: hypothetical protein +FIG01202256 FIG01202257: hypothetical protein +FIG01202260 FIG01202261: hypothetical protein +FIG01202261 FIG01202262: hypothetical protein +FIG01202265 FIG01202267: hypothetical protein +FIG01202267 FIG01202270: hypothetical protein +FIG01202274 FIG01202278: hypothetical protein +FIG01202282 FIG01202284: hypothetical protein +FIG01202284 FIG01202285: hypothetical protein +FIG01202285 FIG01202289: hypothetical protein +FIG01202289 FIG01202290: hypothetical protein +FIG01202293 hypothetical protein +FIG01202304 FIG01202308: hypothetical protein +FIG01202309 hypothetical protein +FIG01202312 FIG01202313: hypothetical protein +FIG01202313 FIG01202316: hypothetical protein +FIG01202316 FIG01202317: hypothetical protein +FIG01202317 FIG01202318: hypothetical protein +FIG01202318 FIG01202325: hypothetical protein +FIG01202325 FIG01202327: hypothetical protein +FIG01202327 FIG01202328: hypothetical protein +FIG01202332 FIG01202333: hypothetical protein +FIG01202333 FIG01202336: hypothetical protein +FIG01202336 FIG01202337: hypothetical protein +FIG01202337 FIG01202338: hypothetical protein +FIG01202338 FIG01202339: hypothetical protein +FIG01202340 FIG01202343: hypothetical protein +FIG01202344 FIG01202345: hypothetical protein +FIG01202345 FIG01202347: hypothetical protein +FIG01202347 FIG01202349: hypothetical protein +FIG01202350 FIG01202352: hypothetical protein +FIG01202352 histidinol phosphatase +FIG01202354 FIG01202355: hypothetical protein +FIG01202355 FIG01202356: hypothetical protein +FIG01202356 FIG01202357: hypothetical protein +FIG01202365 FIG01202366: hypothetical protein +FIG01202369 FIG01202371: hypothetical protein +FIG01202371 FIG01202373: hypothetical protein +FIG01202373 FIG01202374: hypothetical protein +FIG01202374 FIG01202375: hypothetical protein +FIG01202375 FIG01202377: hypothetical protein +FIG01202377 FIG01202379: hypothetical protein +FIG01202382 FIG01202383: hypothetical protein +FIG01202383 FIG01202384: hypothetical protein +FIG01202384 FIG01202386: hypothetical protein +FIG01202386 FIG01202388: hypothetical protein +FIG01202388 FIG01202392: hypothetical protein +FIG01202393 FIG01202397: hypothetical protein +FIG01202397 FIG01202401: hypothetical protein +FIG01202403 FIG01202404: hypothetical protein +FIG01202404 FIG01202407: hypothetical protein +FIG01202407 FIG01202409: hypothetical protein +FIG01202409 FIG01202410: hypothetical protein +FIG01202410 FIG01202411: hypothetical protein +FIG01202416 FIG01202418: hypothetical protein +FIG01202418 FIG01202419: hypothetical protein +FIG01202419 FIG01202420: hypothetical protein +FIG01202420 FIG01202425: hypothetical protein +FIG01202425 FIG01202426: hypothetical protein +FIG01202427 FIG01202428: hypothetical protein +FIG01202428 FIG01202431: hypothetical protein +FIG01202431 FIG01202432: hypothetical protein +FIG01202432 FIG01202433: hypothetical protein +FIG01202433 FIG01202435: hypothetical protein +FIG01202438 FIG01202439: hypothetical protein +FIG01202439 FIG01202440: hypothetical protein +FIG01202440 putative phage R protein +FIG01202441 FIG01202442: hypothetical protein +FIG01202443 FIG01202445: hypothetical protein +FIG01202447 FIG01202449: hypothetical protein +FIG01202449 FIG01202450: hypothetical protein +FIG01202450 FIG01202452: hypothetical protein +FIG01202455 FIG01202458: hypothetical protein +FIG01202459 FIG01202460: hypothetical protein +FIG01202460 FIG01204240: hypothetical protein +FIG01202470 FIG01202475: hypothetical protein +FIG01202476 FIG01202478: hypothetical protein +FIG01202478 FIG01202479: hypothetical protein +FIG01202479 FIG01202482: hypothetical protein +FIG01202482 FIG01202483: hypothetical protein +FIG01202483 FIG01202485: hypothetical protein +FIG01202492 FIG01202496: hypothetical protein +FIG01202496 FIG01202497: hypothetical protein +FIG01202498 FIG01202500: hypothetical protein +FIG01202500 FIG01202502: hypothetical protein +FIG01202502 FIG01202503: hypothetical protein +FIG01202503 FIG01202504: hypothetical protein +FIG01202509 FIG01202511: hypothetical protein +FIG01202511 FIG01202512: hypothetical protein +FIG01202512 FIG01202516: hypothetical protein +FIG01202516 FIG01202517: hypothetical protein +FIG01202517 FIG01202518: hypothetical protein +FIG01202518 FIG01202519: hypothetical protein +FIG01202519 FIG01202521: hypothetical protein +FIG01202521 FIG01202522: hypothetical protein +FIG01202524 hypothetical protein +FIG01202525 FIG01202531: hypothetical protein +FIG01202532 FIG01202535: hypothetical protein +FIG01202537 FIG01202538: hypothetical protein +FIG01202538 FIG01202539: hypothetical protein +FIG01202539 FIG01202540: hypothetical protein +FIG01202540 FIG01202541: hypothetical protein +FIG01202543 FIG01202545: hypothetical protein +FIG01202545 FIG01202547: hypothetical protein +FIG01202547 FIG01202548: hypothetical protein +FIG01202548 FIG01202549: hypothetical protein +FIG01202551 FIG01202554: hypothetical protein +FIG01202554 FIG01202557: hypothetical protein +FIG01202557 FIG01202558: hypothetical protein +FIG01202558 FIG01202560: hypothetical protein +FIG01202560 FIG01202561: hypothetical protein +FIG01202561 FIG01202564: hypothetical protein +FIG01202565 FIG01202566: hypothetical protein +FIG01202566 FIG01202568: hypothetical protein +FIG01202569 FIG01202571: hypothetical protein +FIG01202571 FIG01202572: hypothetical protein +FIG01202572 FIG01202573: hypothetical protein +FIG01202573 FIG01202574: hypothetical protein +FIG01202574 FIG01202575: hypothetical protein +FIG01202575 FIG01202576: hypothetical protein +FIG01202580 FIG01202582: hypothetical protein +FIG01202582 FIG01202583: hypothetical protein +FIG01202595 FIG01202596: hypothetical protein +FIG01202596 FIG01202598: hypothetical protein +FIG01202598 FIG01202599: hypothetical protein +FIG01202599 FIG01202600: hypothetical protein +FIG01202602 FIG01202604: hypothetical protein +FIG01202604 FIG01202607: hypothetical protein +FIG01202607 FIG01202609: hypothetical protein +FIG01202609 FIG002003: Protein YdjA +FIG01202612 FIG01202615: hypothetical protein +FIG01202615 FIG01202616: hypothetical protein +FIG01202616 FIG01202617: hypothetical protein +FIG01202620 FIG01202621: hypothetical protein +FIG01202621 FIG01202622: hypothetical protein +FIG01202622 FIG01202623: hypothetical protein +FIG01202623 FIG01202624: hypothetical protein +FIG01202624 FIG01202625: hypothetical protein +FIG01202625 FIG01202626: hypothetical protein +FIG01202633 FIG01202636: hypothetical protein +FIG01202636 FIG01202639: hypothetical protein +FIG01202639 FIG01202640: hypothetical protein +FIG01202640 FIG01202641: hypothetical protein +FIG01202641 FIG01202643: hypothetical protein +FIG01202643 FIG01202647: hypothetical protein +FIG01202647 FIG071908: hypothetical protein +FIG01202651 Phage protein +FIG01202654 FIG01202655: hypothetical protein +FIG01202655 FIG01202656: hypothetical protein +FIG01202658 FIG01202659: hypothetical protein +FIG01202659 FIG01202660: hypothetical protein +FIG01202662 FIG01202669: hypothetical protein +FIG01202671 FIG01202672: hypothetical protein +FIG01202672 FIG01202673: hypothetical protein +FIG01202673 FIG01202674: hypothetical protein +FIG01202676 FIG01202678: hypothetical protein +FIG01202678 FIG01202679: hypothetical protein +FIG01202681 FIG01202682: hypothetical protein +FIG01202682 FIG01202685: hypothetical protein +FIG01202685 DNA-binding response regulator GltR +FIG01202687 FIG01202690: hypothetical protein +FIG01202690 FIG01202692: hypothetical protein +FIG01202692 FIG01202693: hypothetical protein +FIG01202694 FIG01202695: hypothetical protein +FIG01202695 FIG01202696: hypothetical protein +FIG01202697 prophage MuSo2, portal protein, putative +FIG01202698 FIG01202700: hypothetical protein +FIG01202700 FIG01202701: hypothetical protein +FIG01202701 FIG01202702: hypothetical protein +FIG01202702 FIG01202703: hypothetical protein +FIG01202703 FIG01202704: hypothetical protein +FIG01202704 FIG01202705: hypothetical protein +FIG01202706 FIG01202707: hypothetical protein +FIG01202708 FIG01202709: hypothetical protein +FIG01202710 FIG01202714: hypothetical protein +FIG01202714 FIG01202715: hypothetical protein +FIG01202715 FIG01202717: hypothetical protein +FIG01202717 FIG01202720: hypothetical protein +FIG01202720 FIG01202721: hypothetical protein +FIG01202721 FIG01202722: hypothetical protein +FIG01202722 FIG01202723: hypothetical protein +FIG01202723 FIG01202724: hypothetical protein +FIG01202724 FIG01202725: hypothetical protein +FIG01202725 FIG01202727: hypothetical protein +FIG01202730 FIG01202731: hypothetical protein +FIG01202732 FIG01202733: hypothetical protein +FIG01202733 FIG01202734: hypothetical protein +FIG01202738 FIG01202740: hypothetical protein +FIG01202740 FIG01202742: hypothetical protein +FIG01202744 FIG01202745: hypothetical protein +FIG01202745 FIG01202746: hypothetical protein +FIG01202746 FIG01202747: hypothetical protein +FIG01202747 FIG01202748: hypothetical protein +FIG01202748 FIG01202752: hypothetical protein +FIG01202752 FIG01202753: hypothetical protein +FIG01202753 FIG01202754: hypothetical protein +FIG01202754 FIG01202755: hypothetical protein +FIG01202756 FIG01202760: hypothetical protein +FIG01202760 FIG01202763: hypothetical protein +FIG01202763 FIG01202765: hypothetical protein +FIG01202765 FIG01202766: hypothetical protein +FIG01202767 FIG01202768: hypothetical protein +FIG01202768 FIG01202769: hypothetical protein +FIG01202769 FIG01202770: hypothetical protein +FIG01202770 FIG01202771: hypothetical protein +FIG01202771 FIG01202772: hypothetical protein +FIG01202772 FIG01202776: hypothetical protein +FIG01202790 FIG01202793: hypothetical protein +FIG01202795 FIG01202796: hypothetical protein +FIG01202800 FIG01202802: hypothetical protein +FIG01202802 FIG01202803: hypothetical protein +FIG01202803 FIG01202805: hypothetical protein +FIG01202805 FIG01202810: hypothetical protein +FIG01202815 FIG01202818: hypothetical protein +FIG01202818 FIG01202819: hypothetical protein +FIG01202827 FIG01202829: hypothetical protein +FIG01202829 FIG01202831: hypothetical protein +FIG01202831 FIG01202832: hypothetical protein +FIG01202832 FIG01202833: hypothetical protein +FIG01202833 FIG01202836: hypothetical protein +FIG01202836 FIG01202837: hypothetical protein +FIG01202838 FIG01202839: hypothetical protein +FIG01202839 FIG01202842: hypothetical protein +FIG01202842 FIG01202843: hypothetical protein +FIG01202844 FIG01202848: hypothetical protein +FIG01202849 FIG01202850: hypothetical protein +FIG01202851 FIG01202852: hypothetical protein +FIG01202852 FIG01202853: hypothetical protein +FIG01202862 FIG01202864: hypothetical protein +FIG01202864 FIG01202865: hypothetical protein +FIG01202865 FIG01202867: hypothetical protein +FIG01202868 FIG01202870: hypothetical protein +FIG01202873 FIG01202875: hypothetical protein +FIG01202881 FIG01202882: hypothetical protein +FIG01202882 FIG01202883: hypothetical protein +FIG01202884 FIG01202888: hypothetical protein +FIG01202889 FIG01202890: hypothetical protein +FIG01202894 FIG01202895: hypothetical protein +FIG01202895 FIG01202896: hypothetical protein +FIG01202898 FIG01202899: hypothetical protein +FIG01202901 FIG01202903: hypothetical protein +FIG01202908 FIG01202913: hypothetical protein +FIG01202914 hypothetical protein +FIG01202916 FIG01202917: hypothetical protein +FIG01202921 FIG01202922: hypothetical protein +FIG01202922 FIG01202923: hypothetical protein +FIG01202923 FIG01202925: hypothetical protein +FIG01202925 FIG01202926: hypothetical protein +FIG01202927 FIG01202929: hypothetical protein +FIG01202929 FIG01202933: hypothetical protein +FIG01202933 FIG01202934: hypothetical protein +FIG01202934 FIG01202935: hypothetical protein +FIG01202935 FIG01202936: hypothetical protein +FIG01202936 FIG01202938: hypothetical protein +FIG01202938 FIG01202941: hypothetical protein +FIG01202941 FIG01202942: hypothetical protein +FIG01202942 FIG01202943: hypothetical protein +FIG01202943 FIG01202944: hypothetical protein +FIG01202944 FIG01202945: hypothetical protein +FIG01202945 FIG01202948: hypothetical protein +FIG01202948 FIG01202949: hypothetical protein +FIG01202949 FIG01202950: hypothetical protein +FIG01202950 FIG01202951: hypothetical protein +FIG01202951 FIG01202952: hypothetical protein +FIG01202952 FIG01202954: hypothetical protein +FIG01202954 FIG01202955: hypothetical protein +FIG01202955 FIG01202956: hypothetical protein +FIG01202956 hypothetical protein +FIG01202958 FIG01202962: hypothetical protein +FIG01202964 putative nonspecific acid phosphatase precursor +FIG01202965 FIG01202968: hypothetical protein +FIG01202973 FIG01202974: hypothetical protein +FIG01202974 FIG01202977: hypothetical protein +FIG01202977 FIG01202978: hypothetical protein +FIG01202980 FIG01202981: hypothetical protein +FIG01202982 FIG01202986: hypothetical protein +FIG01202989 FIG01202992: hypothetical protein +FIG01202995 FIG01202997: hypothetical protein +FIG01202998 FIG01203000: hypothetical protein +FIG01203000 FIG01203002: hypothetical protein +FIG01203003 FIG01203004: hypothetical protein +FIG01203004 FIG01203007: hypothetical protein +FIG01203007 FIG01203009: hypothetical protein +FIG01203009 FIG01203010: hypothetical protein +FIG01203011 FIG01203012: hypothetical protein +FIG01203012 FIG01203013: hypothetical protein +FIG01203013 polysaccharide pyruvyl transferase +FIG01203015 FIG01203016: hypothetical protein +FIG01203017 FIG01203022: hypothetical protein +FIG01203028 FIG01203030: hypothetical protein +FIG01203031 FIG01203035: hypothetical protein +FIG01203035 FIG01203036: hypothetical protein +FIG01203036 FIG01203037: hypothetical protein +FIG01203047 FIG01203048: hypothetical protein +FIG01203049 FIG01203050: hypothetical protein +FIG01203050 FIG01203052: hypothetical protein +FIG01203054 FIG01203055: hypothetical protein +FIG01203055 FIG01203060: hypothetical protein +FIG01203061 FIG01203063: hypothetical protein +FIG01203063 FIG01203064: hypothetical protein +FIG01203064 FIG01203065: hypothetical protein +FIG01203066 FIG01203067: hypothetical protein +FIG01203071 FIG01203072: hypothetical protein +FIG01203072 FIG01203073: hypothetical protein +FIG01203077 FIG01203079: hypothetical protein +FIG01203082 FIG01203083: hypothetical protein +FIG01203083 FIG01203084: hypothetical protein +FIG01203084 FIG01203085: hypothetical protein +FIG01203085 putative type II restriction enzyme methylase subunit +FIG01203086 FIG01203087: hypothetical protein +FIG01203087 FIG01203088: hypothetical protein +FIG01203088 FIG01203092: hypothetical protein +FIG01203092 FIG01203093: hypothetical protein +FIG01203095 FIG01203097: hypothetical protein +FIG01203097 Resolvase-like +FIG01203102 FIG01203104: hypothetical protein +FIG01203108 FIG01203109: hypothetical protein +FIG01203109 FIG01203110: hypothetical protein +FIG01203110 FIG01203111: hypothetical protein +FIG01203111 FIG01203113: hypothetical protein +FIG01203113 FIG01203114: hypothetical protein +FIG01203114 FIG01203115: hypothetical protein +FIG01203120 FIG01203123: hypothetical protein +FIG01203123 FIG01203125: hypothetical protein +FIG01203126 FIG01203127: hypothetical protein +FIG01203127 FIG01203128: hypothetical protein +FIG01203129 FIG01203130: hypothetical protein +FIG01203130 FIG01203131: hypothetical protein +FIG01203140 FIG01203141: hypothetical protein +FIG01203141 FIG01203142: hypothetical protein +FIG01203142 FIG01203144: hypothetical protein +FIG01203144 FIG01203145: hypothetical protein +FIG01203146 Phage P2 baseplate assembly protein gpV +FIG01203147 FIG01203148: hypothetical protein +FIG01203148 FIG01203151: hypothetical protein +FIG01203152 FIG01203154: hypothetical protein +FIG01203156 FIG01203158: hypothetical protein +FIG01203158 FIG01203159: hypothetical protein +FIG01203159 FIG01203160: hypothetical protein +FIG01203163 FIG01203164: hypothetical protein +FIG01203164 FIG01203168: hypothetical protein +FIG01203168 FIG01203169: hypothetical protein +FIG01203170 FIG01203171: hypothetical protein +FIG01203173 FIG01203174: hypothetical protein +FIG01203175 FIG01203176: hypothetical protein +FIG01203178 FIG01203179: hypothetical protein +FIG01203183 FIG01203184: hypothetical protein +FIG01203184 FIG01203186: hypothetical protein +FIG01203186 FIG01203187: hypothetical protein +FIG01203187 FIG01203188: hypothetical protein +FIG01203192 FIG01203193: hypothetical protein +FIG01203193 FIG01203194: hypothetical protein +FIG01203200 FIG01203201: hypothetical protein +FIG01203202 FIG01203203: hypothetical protein +FIG01203206 FIG01205025: hypothetical protein +FIG01203209 FIG01203210: hypothetical protein +FIG01203210 FIG01203211: hypothetical protein +FIG01203211 Type III secretion negative regulator (LscZ) +FIG01203212 FIG01203213: hypothetical protein +FIG01203217 FIG01203218: hypothetical protein +FIG01203219 FIG01203220: hypothetical protein +FIG01203220 FIG01203221: hypothetical protein +FIG01203221 FIG01203222: hypothetical protein +FIG01203223 FIG01203224: hypothetical protein +FIG01203224 FIG01203225: hypothetical protein +FIG01203225 FIG01203228: hypothetical protein +FIG01203229 FIG01203232: hypothetical protein +FIG01203233 FIG01203235: hypothetical protein +FIG01203235 FIG01203240: hypothetical protein +FIG01203242 FIG01203243: hypothetical protein +FIG01203245 FIG01203248: hypothetical protein +FIG01203251 FIG01203252: hypothetical protein +FIG01203252 FIG01203253: hypothetical protein +FIG01203260 FIG01203263: hypothetical protein +FIG01203263 FIG01203265: hypothetical protein +FIG01203265 FIG01203268: hypothetical protein +FIG01203268 FIG01203269: hypothetical protein +FIG01203269 FIG01203271: hypothetical protein +FIG01203271 FIG01203274: hypothetical protein +FIG01203274 FIG01203276: hypothetical protein +FIG01203278 FIG01203279: hypothetical protein +FIG01203279 FIG01203280: hypothetical protein +FIG01203280 FIG01203282: hypothetical protein +FIG01203282 FIG01203283: hypothetical protein +FIG01203283 FIG01203284: hypothetical protein +FIG01203290 FIG01203291: hypothetical protein +FIG01203291 FIG01203293: hypothetical protein +FIG01203293 FIG01203294: hypothetical protein +FIG01203295 FIG01203296: hypothetical protein +FIG01203296 FIG01203297: hypothetical protein +FIG01203297 FIG01203299: hypothetical protein +FIG01203301 FIG01203304: hypothetical protein +FIG01203304 FIG01203308: hypothetical protein +FIG01203311 probable transposase VC0185 +FIG01203313 FIG01203317: hypothetical protein +FIG01203317 FIG01203320: hypothetical protein +FIG01203320 hypothetical protein +FIG01203323 FIG01203325: hypothetical protein +FIG01203336 FIG01203338: hypothetical protein +FIG01203340 FIG01203341: hypothetical protein +FIG01203341 FIG01203342: hypothetical protein +FIG01203343 FIG01203345: hypothetical protein +FIG01203350 FIG01203353: hypothetical protein +FIG01203353 FIG01203354: hypothetical protein +FIG01203354 FIG01203355: hypothetical protein +FIG01203355 FnlB +FIG01203356 FIG01203363: hypothetical protein +FIG01203363 FIG01203364: hypothetical protein +FIG01203364 hypothetical protein +FIG01203365 FIG01203366: hypothetical protein +FIG01203366 hypothetical protein +FIG01203367 FIG01203368: hypothetical protein +FIG01203368 FIG01203371: hypothetical protein +FIG01203371 FIG01203373: hypothetical protein +FIG01203376 FIG01203377: hypothetical protein +FIG01203382 FIG01203383: hypothetical protein +FIG01203383 FIG01203384: hypothetical protein +FIG01203387 FIG01203390: hypothetical protein +FIG01203390 FIG066966: hypothetical protein +FIG01203398 FIG01203403: hypothetical protein +FIG01203404 FIG01203407: hypothetical protein +FIG01203415 FIG01203416: hypothetical protein +FIG01203422 FIG01203425: hypothetical protein +FIG01203425 FIG01203426: hypothetical protein +FIG01203427 FIG01203429: hypothetical protein +FIG01203429 FIG01203432: hypothetical protein +FIG01203436 FIG01203438: hypothetical protein +FIG01203438 FIG01203441: hypothetical protein +FIG01203443 FIG01203444: hypothetical protein +FIG01203444 FIG01203446: hypothetical protein +FIG01203449 FIG01203450: hypothetical protein +FIG01203450 FIG01203452: hypothetical protein +FIG01203457 FIG01203458: hypothetical protein +FIG01203458 FIG01203465: hypothetical protein +FIG01203465 FIG01203466: hypothetical protein +FIG01203466 FIG01203469: hypothetical protein +FIG01203469 FIG01203471: hypothetical protein +FIG01203471 FIG01203472: hypothetical protein +FIG01203472 FIG01203473: hypothetical protein +FIG01203473 FIG01203474: hypothetical protein +FIG01203474 FIG01203477: hypothetical protein +FIG01203477 FIG01203478: hypothetical protein +FIG01203480 FIG01203481: hypothetical protein +FIG01203481 FIG01203482: hypothetical protein +FIG01203488 FIG01203491: hypothetical protein +FIG01203491 FIG01203497: hypothetical protein +FIG01203498 FIG01203500: hypothetical protein +FIG01203500 FIG01203501: hypothetical protein +FIG01203506 FIG01203507: hypothetical protein +FIG01203507 COG4388: Mu-like prophage I protein +FIG01203513 FIG01203514: hypothetical protein +FIG01203514 FIG01203515: hypothetical protein +FIG01203515 FIG01203519: hypothetical protein +FIG01203520 FIG054937: hypothetical protein +FIG01203525 FIG01203526: hypothetical protein +FIG01203526 FIG01203527: hypothetical protein +FIG01203527 FIG01203528: hypothetical protein +FIG01203533 FIG01203536: hypothetical protein +FIG01203536 FIG01203537: hypothetical protein +FIG01203537 FIG01203538: hypothetical protein +FIG01203538 FIG01203539: hypothetical protein +FIG01203544 FIG01203546: hypothetical protein +FIG01203546 FIG01203548: hypothetical protein +FIG01203549 FIG01203550: hypothetical protein +FIG01203550 FIG01203551: hypothetical protein +FIG01203552 FIG01203553: hypothetical protein +FIG01203554 FIG01203557: hypothetical protein +FIG01203557 FIG01203559: hypothetical protein +FIG01203559 FIG01203560: hypothetical protein +FIG01203560 FIG01203562: hypothetical protein +FIG01203563 FIG01203568: hypothetical protein +FIG01203570 FIG01203572: hypothetical protein +FIG01203573 FIG01203574: hypothetical protein +FIG01203574 FIG01203577: hypothetical protein +FIG01203577 FIG01203578: hypothetical protein +FIG01203578 FIG01203580: hypothetical protein +FIG01203582 FIG01203583: hypothetical protein +FIG01203584 FIG01203586: hypothetical protein +FIG01203586 FIG01203588: hypothetical protein +FIG01203597 FIG01203598: hypothetical protein +FIG01203598 FIG01203599: hypothetical protein +FIG01203604 FIG01203605: hypothetical protein +FIG01203605 FIG01203606: hypothetical protein +FIG01203614 FIG01203618: hypothetical protein +FIG01203618 FIG01203621: hypothetical protein +FIG01203621 FIG01203622: hypothetical protein +FIG01203626 transcriptional regulator, Ner family +FIG01203627 FIG01203630: hypothetical protein +FIG01203630 FIG01203631: hypothetical protein +FIG01203631 FIG01203633: hypothetical protein +FIG01203635 FIG01203636: hypothetical protein +FIG01203636 FIG01203638: hypothetical protein +FIG01203640 FIG01203641: hypothetical protein +FIG01203646 FIG01203647: hypothetical protein +FIG01203647 FIG01203649: hypothetical protein +FIG01203651 FIG01203652: hypothetical protein +FIG01203654 FIG01203657: hypothetical protein +FIG01203657 FIG01203661: hypothetical protein +FIG01203661 FIG01203662: hypothetical protein +FIG01203662 FIG01203663: hypothetical protein +FIG01203664 FIG01203665: hypothetical protein +FIG01203665 FIG01203666: hypothetical protein +FIG01203669 FIG01203671: hypothetical protein +FIG01203673 FIG01203676: hypothetical protein +FIG01203676 FIG01203677: hypothetical protein +FIG01203683 minor curlin subunit CsgB +FIG01203689 FIG01203690: hypothetical protein +FIG01203691 FIG01203692: hypothetical protein +FIG01203692 FIG01203693: hypothetical protein +FIG01203693 FIG01203695: hypothetical protein +FIG01203695 FIG01203696: hypothetical protein +FIG01203700 FIG01203701: hypothetical protein +FIG01203702 FIG01203704: hypothetical protein +FIG01203706 FIG01203708: hypothetical protein +FIG01203716 FIG01203717: hypothetical protein +FIG01203717 FIG01199766: hypothetical protein +FIG01203718 FIG01203727: hypothetical protein +FIG01203731 FIG01203733: hypothetical protein +FIG01203733 FIG01203734: hypothetical protein +FIG01203735 FIG01203736: hypothetical protein +FIG01203736 FIG01203738: hypothetical protein +FIG01203738 FIG01203742: hypothetical protein +FIG01203742 FIG01203743: hypothetical protein +FIG01203746 FIG01203747: hypothetical protein +FIG01203748 FIG01203752: hypothetical protein +FIG01203755 FIG01203756: hypothetical protein +FIG01203761 FIG01203762: hypothetical protein +FIG01203762 FIG01203764: hypothetical protein +FIG01203764 FIG01203766: hypothetical protein +FIG01203766 structural protein P5 +FIG01203771 ATPase component of ABC transporter +FIG01203772 FIG01203773: hypothetical protein +FIG01203773 FIG01203778: hypothetical protein +FIG01203778 DNA-damage-inducible protein +FIG01203779 FIG01203783: hypothetical protein +FIG01203783 FIG01203785: hypothetical protein +FIG01203785 Cell wall-associated hydrolase +FIG01203791 FIG01203793: hypothetical protein +FIG01203801 FIG01203803: hypothetical protein +FIG01203810 FIG01203811: hypothetical protein +FIG01203815 FIG01203817: hypothetical protein +FIG01203819 FIG01203822: hypothetical protein +FIG01203822 FIG01203823: hypothetical protein +FIG01203823 FIG01203824: hypothetical protein +FIG01203824 FIG01203825: hypothetical protein +FIG01203825 COG4925: Uncharacterized conserved protein +FIG01203826 FIG01203830: hypothetical protein +FIG01203834 FIG01203836: hypothetical protein +FIG01203839 FIG01203840: hypothetical protein +FIG01203840 FIG01203841: hypothetical protein +FIG01203842 FIG01203843: hypothetical protein +FIG01203843 FIG01203844: hypothetical protein +FIG01203844 FIG01203845: hypothetical protein +FIG01203845 FIG01203846: hypothetical protein +FIG01203851 Surface protein Lk90-like protein +FIG01203853 FIG01203854: hypothetical protein +FIG01203855 FIG01203856: hypothetical protein +FIG01203856 FIG01203857: hypothetical protein +FIG01203857 FIG01203860: hypothetical protein +FIG01203860 FIG01203861: hypothetical protein +FIG01203862 FIG01203863: hypothetical protein +FIG01203868 FIG01203869: hypothetical protein +FIG01203869 FIG01203871: hypothetical protein +FIG01203871 FIG01203873: hypothetical protein +FIG01203873 COG5492: Bacterial surface proteins containing Ig-like domains +FIG01203877 FIG01203878: hypothetical protein +FIG01203879 FIG01203881: hypothetical protein +FIG01203885 FIG01203891: hypothetical protein +FIG01203891 FIG01203892: hypothetical protein +FIG01203894 FIG01203895: hypothetical protein +FIG01203896 FIG01203901: hypothetical protein +FIG01203901 FIG01203905: hypothetical protein +FIG01203905 FIG01203910: hypothetical protein +FIG01203910 FIG01203911: hypothetical protein +FIG01203911 FIG01203912: hypothetical protein +FIG01203912 FIG01203918: hypothetical protein +FIG01203918 FIG01203920: hypothetical protein +FIG01203920 FIG00060015: hypothetical protein +FIG01203934 FIG01203935: hypothetical protein +FIG01203935 FIG01203936: hypothetical protein +FIG01203936 FIG01203937: hypothetical protein +FIG01203940 FIG01203941: hypothetical protein +FIG01203941 FIG01203943: hypothetical protein +FIG01203943 FIG01203944: hypothetical protein +FIG01203946 FIG01203947: hypothetical protein +FIG01203953 FIG01203955: hypothetical protein +FIG01203956 putative traA protein +FIG01203960 FIG01203961: hypothetical protein +FIG01203961 RTX toxin, putative +FIG01203964 FIG01203966: hypothetical protein +FIG01203966 FIG01203970: hypothetical protein +FIG01203974 FIG01203975: hypothetical protein +FIG01203977 FIG01203978: hypothetical protein +FIG01203979 FIG01203980: hypothetical protein +FIG01203980 FIG01203982: hypothetical protein +FIG01203982 FIG01203983: hypothetical protein +FIG01203986 FIG01203988: hypothetical protein +FIG01203988 FIG01203990: hypothetical protein +FIG01203990 FIG01203991: hypothetical protein +FIG01203991 thermostable direct hemolysin +FIG01203997 FIG01203999: hypothetical protein +FIG01203999 FIG01204000: hypothetical protein +FIG01204000 FIG01204002: hypothetical protein +FIG01204002 FIG01204004: hypothetical protein +FIG01204004 FIG01204006: hypothetical protein +FIG01204006 FIG01204007: hypothetical protein +FIG01204007 FIG01204009: hypothetical protein +FIG01204010 FIG01204012: hypothetical protein +FIG01204018 FIG01204020: hypothetical protein +FIG01204020 FIG01204021: hypothetical protein +FIG01204021 FIG01204022: hypothetical protein +FIG01204028 FIG01204029: hypothetical protein +FIG01204029 FIG01204030: hypothetical protein +FIG01204030 FIG01204032: hypothetical protein +FIG01204032 FIG01204034: hypothetical protein +FIG01204034 FIG01204035: hypothetical protein +FIG01204035 FIG01204041: hypothetical protein +FIG01204041 FIG01204042: hypothetical protein +FIG01204042 FIG01204043: hypothetical protein +FIG01204043 FIG01204044: hypothetical protein +FIG01204044 FIG01204047: hypothetical protein +FIG01204047 FIG01204050: hypothetical protein +FIG01204051 FIG01204052: hypothetical protein +FIG01204052 FIG01204437: hypothetical protein +FIG01204055 FIG01204057: hypothetical protein +FIG01204057 FIG01204058: hypothetical protein +FIG01204062 FIG01204063: hypothetical protein +FIG01204063 FIG01204064: hypothetical protein +FIG01204066 FIG01204072: hypothetical protein +FIG01204072 FIG01204073: hypothetical protein +FIG01204076 FIG01204077: hypothetical protein +FIG01204077 FIG01204079: hypothetical protein +FIG01204080 FIG01204081: hypothetical protein +FIG01204086 FIG01204088: hypothetical protein +FIG01204088 FIG01204089: hypothetical protein +FIG01204089 FIG01204090: hypothetical protein +FIG01204090 FIG01204092: hypothetical protein +FIG01204092 FIG01204095: hypothetical protein +FIG01204095 FIG01204097: hypothetical protein +FIG01204097 FIG01204098: hypothetical protein +FIG01204098 FIG01204100: hypothetical protein +FIG01204100 FIG01204101: hypothetical protein +FIG01204103 FIG01204104: hypothetical protein +FIG01204104 FIG01204105: hypothetical protein +FIG01204108 FIG01204109: hypothetical protein +FIG01204109 FIG01204112: hypothetical protein +FIG01204112 FIG01204113: hypothetical protein +FIG01204113 FIG01204114: hypothetical protein +FIG01204114 FIG01204116: hypothetical protein +FIG01204116 FIG01204117: hypothetical protein +FIG01204119 FIG01204120: hypothetical protein +FIG01204122 FIG01204123: hypothetical protein +FIG01204123 FIG01204124: hypothetical protein +FIG01204131 FIG01204132: hypothetical protein +FIG01204132 FIG01204133: hypothetical protein +FIG01204139 FIG01204140: hypothetical protein +FIG01204140 FIG01204141: hypothetical protein +FIG01204141 FIG01204142: hypothetical protein +FIG01204142 FIG01204144: hypothetical protein +FIG01204144 FIG01204145: hypothetical protein +FIG01204145 FIG01204150: hypothetical protein +FIG01204150 FIG01204151: hypothetical protein +FIG01204154 FIG01204155: hypothetical protein +FIG01204157 FIG01204158: hypothetical protein +FIG01204159 Mll4618 protein +FIG01204164 FIG01204165: hypothetical protein +FIG01204165 FIG01204166: hypothetical protein +FIG01204169 FIG01204170: hypothetical protein +FIG01204172 FIG01204173: hypothetical protein +FIG01204179 FIG01204183: hypothetical protein +FIG01204183 FIG01204186: hypothetical protein +FIG01204186 FIG01204190: hypothetical protein +FIG01204193 FIG01204194: hypothetical protein +FIG01204199 FIG01204201: hypothetical protein +FIG01204203 FIG01204204: hypothetical protein +FIG01204204 FIG01204205: hypothetical protein +FIG01204205 FIG01204206: hypothetical protein +FIG01204207 FIG01204208: hypothetical protein +FIG01204208 FIG01204209: hypothetical protein +FIG01204209 FIG01204210: hypothetical protein +FIG01204210 cholera toxin transcriptional activator +FIG01204215 FIG01204216: hypothetical protein +FIG01204218 FIG01204221: hypothetical protein +FIG01204221 FIG01204223: hypothetical protein +FIG01204226 FIG01204228: hypothetical protein +FIG01204228 FIG01204229: hypothetical protein +FIG01204230 FIG01204237: hypothetical protein +FIG01204237 FIG01204238: hypothetical protein +FIG01204243 FIG01204248: hypothetical protein +FIG01204254 FIG01204258: hypothetical protein +FIG01204258 FIG01204259: hypothetical protein +FIG01204259 FIG01204260: hypothetical protein +FIG01204269 FIG01204270: hypothetical protein +FIG01204270 FIG01204272: hypothetical protein +FIG01204272 FIG01204274: hypothetical protein +FIG01204274 FIG01204275: hypothetical protein +FIG01204275 FIG01204277: hypothetical protein +FIG01204277 FIG01204278: hypothetical protein +FIG01204280 FIG01204282: hypothetical protein +FIG01204282 FIG01204283: hypothetical protein +FIG01204287 FIG01204290: hypothetical protein +FIG01204292 FIG01204295: hypothetical protein +FIG01204295 FIG01204296: hypothetical protein +FIG01204296 FIG01204297: hypothetical protein +FIG01204298 FIG01204302: hypothetical protein +FIG01204308 FIG01204309: hypothetical protein +FIG01204316 FIG01204318: hypothetical protein +FIG01204318 FIG01204320: hypothetical protein +FIG01204320 FIG01204325: hypothetical protein +FIG01204325 FIG01204326: hypothetical protein +FIG01204329 FIG01204330: hypothetical protein +FIG01204330 FIG01204331: hypothetical protein +FIG01204337 FIG01204338: hypothetical protein +FIG01204346 FIG01204347: hypothetical protein +FIG01204347 FIG01204351: hypothetical protein +FIG01204351 FIG01204357: hypothetical protein +FIG01204362 FIG01204364: hypothetical protein +FIG01204365 FIG01204370: hypothetical protein +FIG01204370 FIG01204372: hypothetical protein +FIG01204372 FIG01204374: hypothetical protein +FIG01204376 FIG01204381: hypothetical protein +FIG01204395 FIG01204400: hypothetical protein +FIG01204400 FIG01204401: hypothetical protein +FIG01204407 FIG01204408: hypothetical protein +FIG01204410 FIG01204411: hypothetical protein +FIG01204411 FIG01204413: hypothetical protein +FIG01204414 FIG01204417: hypothetical protein +FIG01204417 FIG01204421: hypothetical protein +FIG01204421 FIG01204422: hypothetical protein +FIG01204426 putative adhesin +FIG01204428 FIG01204429: hypothetical protein +FIG01204429 FIG01204432: hypothetical protein +FIG01204432 FIG01204433: hypothetical protein +FIG01204433 FIG01204434: hypothetical protein +FIG01204437 FIG01204442: hypothetical protein +FIG01204442 FIG01204443: hypothetical protein +FIG01204445 FIG01204447: hypothetical protein +FIG01204447 FIG01204449: hypothetical protein +FIG01204452 FIG01204453: hypothetical protein +FIG01204458 FIG01204460: hypothetical protein +FIG01204461 FIG01204462: hypothetical protein +FIG01204465 Bacteriophage P2-related tail formation protein +FIG01204472 FIG01204474: hypothetical protein +FIG01204474 FIG01204476: hypothetical protein +FIG01204476 FIG01204479: hypothetical protein +FIG01204479 FIG01204480: hypothetical protein +FIG01204483 FIG01204484: hypothetical protein +FIG01204484 FIG01204486: hypothetical protein +FIG01204486 DNA polymerase +FIG01204489 FIG01204490: hypothetical protein +FIG01204493 FIG01204495: hypothetical protein +FIG01204497 FIG01204499: hypothetical protein +FIG01204499 FIG01204501: hypothetical protein +FIG01204501 FIG01204502: hypothetical protein +FIG01204503 FIG01204504: hypothetical protein +FIG01204506 FIG01204509: hypothetical protein +FIG01204513 FIG01204514: hypothetical protein +FIG01204517 FIG01204518: hypothetical protein +FIG01204518 FIG01204520: hypothetical protein +FIG01204529 FIG01204532: hypothetical protein +FIG01204536 FIG01204537: hypothetical protein +FIG01204538 FIG01204539: hypothetical protein +FIG01204549 FIG01204550: hypothetical protein +FIG01204550 FIG01204553: hypothetical protein +FIG01204553 FIG01204560: hypothetical protein +FIG01204562 FIG01204563: hypothetical protein +FIG01204563 FIG01204564: hypothetical protein +FIG01204564 FIG01204567: hypothetical protein +FIG01204567 FIG01204569: hypothetical protein +FIG01204569 FIG01204570: hypothetical protein +FIG01204573 FIG01204576: hypothetical protein +FIG01204576 FIG01204579: hypothetical protein +FIG01204579 FIG01204580: hypothetical protein +FIG01204581 FIG01204584: hypothetical protein +FIG01204584 FIG01204586: hypothetical protein +FIG01204586 hypothetical protein +FIG01204587 FIG01204588: hypothetical protein +FIG01204599 FIG01204604: hypothetical protein +FIG01204604 FIG01204607: hypothetical protein +FIG01204607 FIG01204610: hypothetical protein +FIG01204612 thioredoxin-dependent thiol peroxidase +FIG01204613 FIG01204614: hypothetical protein +FIG01204623 FIG01204624: hypothetical protein +FIG01204631 FIG01204632: hypothetical protein +FIG01204632 FIG01204635: hypothetical protein +FIG01204636 FIG01204638: hypothetical protein +FIG01204654 FIG01204656: hypothetical protein +FIG01204661 FIG01204663: hypothetical protein +FIG01204672 FIG01204674: hypothetical protein +FIG01204678 FIG01204680: hypothetical protein +FIG01204680 FIG01204690: hypothetical protein +FIG01204691 FIG01204696: hypothetical protein +FIG01204696 FIG01204699: hypothetical protein +FIG01204701 FIG01204702: hypothetical protein +FIG01204702 FIG01204703: hypothetical protein +FIG01204703 FIG01204706: hypothetical protein +FIG01204707 FIG01204708: hypothetical protein +FIG01204708 FIG01204709: hypothetical protein +FIG01204711 FIG01204716: hypothetical protein +FIG01204717 FIG01204718: hypothetical protein +FIG01204718 FIG01204719: hypothetical protein +FIG01204735 FIG01204739: hypothetical protein +FIG01204741 FIG01204743: hypothetical protein +FIG01204743 FIG01204744: hypothetical protein +FIG01204744 FIG01204746: hypothetical protein +FIG01204749 FIG01204750: hypothetical protein +FIG01204753 FIG01204755: hypothetical protein +FIG01204758 FIG01204759: hypothetical protein +FIG01204771 FIG01204772: hypothetical protein +FIG01204772 OmpA family outer membrane lipoprotein +FIG01204774 FIG01204777: hypothetical protein +FIG01204777 FIG01204780: hypothetical protein +FIG01204782 FIG01204783: hypothetical protein +FIG01204783 FIG01204784: hypothetical protein +FIG01204784 FIG01204786: hypothetical protein +FIG01204788 FIG01204790: hypothetical protein +FIG01204790 FIG01204792: hypothetical protein +FIG01204792 FIG01204794: hypothetical protein +FIG01204794 FIG01204796: hypothetical protein +FIG01204796 FIG01204799: hypothetical protein +FIG01204807 FIG01204808: hypothetical protein +FIG01204808 FIG01204809: hypothetical protein +FIG01204809 FIG01204811: hypothetical protein +FIG01204811 FIG01204813: hypothetical protein +FIG01204813 FIG01204814: hypothetical protein +FIG01204814 FIG01204816: hypothetical protein +FIG01204816 FIG01204817: hypothetical protein +FIG01204819 hypothetical protein +FIG01204821 FIG01204823: hypothetical protein +FIG01204823 FIG01204826: hypothetical protein +FIG01204827 FIG01204829: hypothetical protein +FIG01204829 FIG01204830: hypothetical protein +FIG01204830 FIG01204831: hypothetical protein +FIG01204831 FIG01204832: hypothetical protein +FIG01204832 hypothetical protein +FIG01204834 FIG01204835: hypothetical protein +FIG01204838 FIG01204839: hypothetical protein +FIG01204839 FIG01204840: hypothetical protein +FIG01204840 FIG01204843: hypothetical protein +FIG01204845 FIG01204846: hypothetical protein +FIG01204846 FIG01204848: hypothetical protein +FIG01204861 FIG01204869: hypothetical protein +FIG01204870 FIG01204871: hypothetical protein +FIG01204875 FIG01204876: hypothetical protein +FIG01204878 FIG01204879: hypothetical protein +FIG01204879 Uncharacterized 37.8 kDa protein in gpa 5'region +FIG01204882 FIG01204884: hypothetical protein +FIG01204886 FIG01204889: hypothetical protein +FIG01204889 FIG01204890: hypothetical protein +FIG01204892 FIG01204896: hypothetical protein +FIG01204900 FIG01204903: hypothetical protein +FIG01204903 adenylate kinase +FIG01204904 FIG01204906: hypothetical protein +FIG01204906 FIG01204907: hypothetical protein +FIG01204908 FIG01204910: hypothetical protein +FIG01204912 FIG01204914: hypothetical protein +FIG01204916 FIG01204917: hypothetical protein +FIG01204917 Transcriptional activator ChrR +FIG01204920 FIG01204921: hypothetical protein +FIG01204921 FIG01204922: hypothetical protein +FIG01204922 FIG01204923: hypothetical protein +FIG01204928 FIG01204929: hypothetical protein +FIG01204931 FIG01204932: hypothetical protein +FIG01204933 FIG01204937: hypothetical protein +FIG01204941 FIG01204942: hypothetical protein +FIG01204944 FIG01204949: hypothetical protein +FIG01204953 FIG01204954: hypothetical protein +FIG01204957 FIG01204958: hypothetical protein +FIG01204958 FIG01204960: hypothetical protein +FIG01204962 conserved protein of unknown function; putative YcgN protein +FIG01204963 FIG01204964: hypothetical protein +FIG01204964 FIG01204965: hypothetical protein +FIG01204968 FIG01204969: hypothetical protein +FIG01204971 FIG01204972: hypothetical protein +FIG01204972 FIG01204974: hypothetical protein +FIG01204974 FIG01204977: hypothetical protein +FIG01204977 FIG01204978: hypothetical protein +FIG01204983 FIG01204984: hypothetical protein +FIG01204984 FIG01204986: hypothetical protein +FIG01204992 FIG01204993: hypothetical protein +FIG01204993 FIG01204994: hypothetical protein +FIG01204994 FIG01204995: hypothetical protein +FIG01204995 FIG01204997: hypothetical protein +FIG01204998 FIG01205000: hypothetical protein +FIG01205003 FIG01205007: hypothetical protein +FIG01205007 FIG01205008: hypothetical protein +FIG01205012 FIG01205015: hypothetical protein +FIG01205016 FIG01205018: hypothetical protein +FIG01205018 FIG01205019: hypothetical protein +FIG01205021 FIG01205024: hypothetical protein +FIG01205026 FIG01205028: hypothetical protein +FIG01205028 GTPase +FIG01205029 FIG01205032: hypothetical protein +FIG01205032 FIG01205034: hypothetical protein +FIG01205043 Uncharacterized protein ygiV +FIG01205045 Predicted amino acid racemase +FIG01205047 FIG01205048: hypothetical protein +FIG01205060 FIG01205061: hypothetical protein +FIG01205064 FIG01205068: hypothetical protein +FIG01205068 FIG01205069: hypothetical protein +FIG01205077 FIG01205080: hypothetical protein +FIG01205082 FIG01205087: hypothetical protein +FIG01205087 FIG01205094: hypothetical protein +FIG01205101 FIG01205102: hypothetical protein +FIG01205103 FIG01205104: hypothetical protein +FIG01205105 FIG01205106: hypothetical protein +FIG01205106 FIG01205111: hypothetical protein +FIG01205111 FIG01205112: hypothetical protein +FIG01205112 FIG01205113: hypothetical protein +FIG01205113 FIG01205115: hypothetical protein +FIG01205118 FIG01205119: hypothetical protein +FIG01205125 FIG01205128: hypothetical protein +FIG01205128 FIG01205129: hypothetical protein +FIG01205139 FIG01205142: hypothetical protein +FIG01205145 FIG01205148: hypothetical protein +FIG01205148 FIG01205150: hypothetical protein +FIG01205150 FIG01205152: hypothetical protein +FIG01205153 FIG01205154: hypothetical protein +FIG01205154 FIG01205155: hypothetical protein +FIG01205168 FIG01205172: hypothetical protein +FIG01205172 Tn7-like transposase TnsA +FIG01205173 FIG01205175: hypothetical protein +FIG01205175 FIG01205176: hypothetical protein +FIG01205176 FIG01205180: hypothetical protein +FIG01205190 FIG01205192: hypothetical protein +FIG01205194 FIG01205197: hypothetical protein +FIG01205197 FIG01205200: hypothetical protein +FIG01205200 FIG01205202: hypothetical protein +FIG01205204 FIG01205205: hypothetical protein +FIG01205205 FIG01205207: hypothetical protein +FIG01205210 FIG01205212: hypothetical protein +FIG01205219 FIG01205221: hypothetical protein +FIG01205221 FIG01205227: hypothetical protein +FIG01205227 FIG01205228: hypothetical protein +FIG01205233 FIG01205235: hypothetical protein +FIG01205235 FIG01205237: hypothetical protein +FIG01205240 FIG01205241: hypothetical protein +FIG01205241 FIG01205245: hypothetical protein +FIG01205245 FIG01205246: hypothetical protein +FIG01205251 pectinesterase A( EC:3.1.1.11 ) +FIG01205259 FIG01205260: hypothetical protein +FIG01205261 FIG01205262: hypothetical protein +FIG01205264 FIG01205270: hypothetical protein +FIG01205270 FIG01205272: hypothetical protein +FIG01205272 FIG01205273: hypothetical protein +FIG01205275 FIG01205277: hypothetical protein +FIG01205283 hypothetical protein +FIG01205285 FIG01205287: hypothetical protein +FIG01205287 FIG01205289: hypothetical protein +FIG01205289 FIG01205290: hypothetical protein +FIG01205290 FIG01205296: hypothetical protein +FIG01205296 FIG01205297: hypothetical protein +FIG01205298 FIG01205299: hypothetical protein +FIG01205299 FIG01205302: hypothetical protein +FIG01205302 FIG01205303: hypothetical protein +FIG01205303 FIG01205306: hypothetical protein +FIG01205306 FIG01205307: hypothetical protein +FIG01205307 FIG01205308: hypothetical protein +FIG01205311 FIG01205315: hypothetical protein +FIG01205315 FIG01205320: hypothetical protein +FIG01205320 FIG01205321: hypothetical protein +FIG01205321 FIG01205322: hypothetical protein +FIG01205322 FIG01205325: hypothetical protein +FIG01205325 FIG01205326: hypothetical protein +FIG01205326 FIG01205329: hypothetical protein +FIG01205329 FIG078759: hypothetical protein +FIG01205330 FIG01205331: hypothetical protein +FIG01205331 FIG115691: hypothetical protein +FIG01205334 FIG01205335: hypothetical protein +FIG01205337 FIG01205338: hypothetical protein +FIG01205342 FIG01205343: hypothetical protein +FIG01205343 FIG01205345: hypothetical protein +FIG01205345 FIG01205346: hypothetical protein +FIG01205346 FIG01205347: hypothetical protein +FIG01205347 FIG01205348: hypothetical protein +FIG01205348 FIG01205349: hypothetical protein +FIG01205349 FIG01205353: hypothetical protein +FIG01205362 FIG01205366: hypothetical protein +FIG01205366 FIG01205367: hypothetical protein +FIG01205368 CPS-53 (KpLE1) prophage +FIG01205374 FIG01205378: hypothetical protein +FIG01205379 FIG01205380: hypothetical protein +FIG01205380 FIG01205381: hypothetical protein +FIG01205381 FIG01205385: hypothetical protein +FIG01205386 FIG01205388: hypothetical protein +FIG01205390 dTDP-4-dehydrorhamnose reductase +FIG01205393 FIG01205396: hypothetical protein +FIG01205398 FIG01205399: hypothetical protein +FIG01205410 FIG01205412: hypothetical protein +FIG01205418 FIG01205419: hypothetical protein +FIG01205419 FIG01205425: hypothetical protein +FIG01205425 FIG01205426: hypothetical protein +FIG01205426 hypothetical protein +FIG01205427 FIG01205430: hypothetical protein +FIG01205430 FIG01205433: hypothetical protein +FIG01205436 FIG01205437: hypothetical protein +FIG01205441 FIG01205442: hypothetical protein +FIG01205444 FIG01205446: hypothetical protein +FIG01205446 protein of unknown function DUF1294 +FIG01205451 FIG01205453: hypothetical protein +FIG01205453 FIG01205455: hypothetical protein +FIG01205456 glycosyl hydrolase, family 31/fibronectin type III domain protein +FIG01205457 FIG01205458: hypothetical protein +FIG01205458 COG4529 +FIG01205462 FIG01205464: hypothetical protein +FIG01205470 FIG01205472: hypothetical protein +FIG01205474 FIG01205476: hypothetical protein +FIG01205476 FIG01205478: hypothetical protein +FIG01205484 FIG01205485: hypothetical protein +FIG01205492 FIG01205500: hypothetical protein +FIG01205500 FIG01205501: hypothetical protein +FIG01205509 FIG01205513: hypothetical protein +FIG01205517 FIG01205520: hypothetical protein +FIG01205521 FIG01205522: hypothetical protein +FIG01205522 FIG01205523: hypothetical protein +FIG01205525 FIG01205527: hypothetical protein +FIG01205527 FIG01205528: hypothetical protein +FIG01205528 FIG01205529: hypothetical protein +FIG01205540 hypothetical protein +FIG01205541 FIG01205542: hypothetical protein +FIG01205542 FIG01205546: hypothetical protein +FIG01205547 FIG01205549: hypothetical protein +FIG01205549 FIG01205553: hypothetical protein +FIG01205555 FIG01205557: hypothetical protein +FIG01205557 FIG01205558: hypothetical protein +FIG01205559 FIG01205562: hypothetical protein +FIG01205562 FIG01205563: hypothetical protein +FIG01205566 FIG01205568: hypothetical protein +FIG01205570 FIG01205572: hypothetical protein +FIG01205574 FIG01205575: hypothetical protein +FIG01205576 FIG01205578: hypothetical protein +FIG01205578 FIG01205580: hypothetical protein +FIG01205591 FIG01205596: hypothetical protein +FIG01205607 FIG01205609: hypothetical protein +FIG01205609 FIG01205612: hypothetical protein +FIG01205614 FIG01205615: hypothetical protein +FIG01205617 FIG01205618: hypothetical protein +FIG01205618 COG2176: DNA polymerase III, alpha subunit (gram-positive type) +FIG01205621 FIG01205622: hypothetical protein +FIG01205625 FIG01205627: hypothetical protein +FIG01205627 FIG01205628: hypothetical protein +FIG01205630 FIG01205632: hypothetical protein +FIG01205641 FIG01205644: hypothetical protein +FIG01205644 FIG01205645: hypothetical protein +FIG01205645 diguanylate cyclase/phosphodiesterase (GGDEF & EAL domains) with PAS/PAC sensor(s) +FIG01205656 FIG01205657: hypothetical protein +FIG01205657 FIG01205660: hypothetical protein +FIG01205675 FIG01205679: hypothetical protein +FIG01205681 FIG01205682: hypothetical protein +FIG01205682 FIG01205684: hypothetical protein +FIG01205687 FIG01205688: hypothetical protein +FIG01205691 FIG01205692: hypothetical protein +FIG01205692 FIG01205693: hypothetical protein +FIG01205694 FIG01205696: hypothetical protein +FIG01205696 FIG01205699: hypothetical protein +FIG01205712 FIG01205715: hypothetical protein +FIG01205737 FIG01205738: hypothetical protein +FIG01205738 FIG01205739: hypothetical protein +FIG01205739 FIG01205740: hypothetical protein +FIG01205741 FIG01205744: hypothetical protein +FIG01205744 FIG01205745: hypothetical protein +FIG01205745 FIG01205746: hypothetical protein +FIG01205746 FIG01205748: hypothetical protein +FIG01205748 FIG01205749: hypothetical protein +FIG01205753 FIG01205755: hypothetical protein +FIG01205766 FIG01205768: hypothetical protein +FIG01205768 FIG01205770: hypothetical protein +FIG01205770 FIG01205771: hypothetical protein +FIG01205771 FIG01205772: hypothetical protein +FIG01205775 FIG01205777: hypothetical protein +FIG01205778 FIG01205779: hypothetical protein +FIG01205794 FIG01205795: hypothetical protein +FIG01205798 tail sheath protein +FIG01205811 FIG01205812: hypothetical protein +FIG01205813 FIG01205814: hypothetical protein +FIG01205814 FIG01205815: hypothetical protein +FIG01205818 FIG01205819: hypothetical protein +FIG01205819 FIG01205820: hypothetical protein +FIG01205820 hypothetical protein +FIG01205824 FIG01205825: hypothetical protein +FIG01205829 Uncharacterised protein family UPF0157 (COG2320) +FIG01205837 FIG01205839: hypothetical protein +FIG01205843 FIG01205844: hypothetical protein +FIG01205857 FIG01205859: hypothetical protein +FIG01205859 FIG01205862: hypothetical protein +FIG01205867 FIG01205870: hypothetical protein +FIG01205872 FIG01205880: hypothetical protein +FIG01205880 FIG01205881: hypothetical protein +FIG01205900 FIG01205904: hypothetical protein +FIG01205907 FIG01205912: hypothetical protein +FIG01205912 FIG01205913: hypothetical protein +FIG01205913 FIG01205916: hypothetical protein +FIG01205918 FIG01205919: hypothetical protein +FIG01205922 FIG01205924: hypothetical protein +FIG01205924 FIG01205926: hypothetical protein +FIG01205936 FIG01205937: hypothetical protein +FIG01205953 FIG01205957: hypothetical protein +FIG01205957 FIG01205958: hypothetical protein +FIG01205962 FIG01205963: hypothetical protein +FIG01205963 FIG01205965: hypothetical protein +FIG01205969 hypothetical protein +FIG01205970 FIG01205972: hypothetical protein +FIG01205972 FIG01205974: hypothetical protein +FIG01205983 FIG01205985: hypothetical protein +FIG01205985 FIG01205986: hypothetical protein +FIG01205987 FIG01205988: hypothetical protein +FIG01205988 probable transcription regulator protein +FIG01205995 FIG01205996: hypothetical protein +FIG01206003 FIG01206005: hypothetical protein +FIG01206008 FIG01206011: hypothetical protein +FIG01206018 FIG01206019: hypothetical protein +FIG01206019 FIG01206021: hypothetical protein +FIG01206025 FIG01206026: hypothetical protein +FIG01206029 FIG01206033: hypothetical protein +FIG01206033 FIG01206035: hypothetical protein +FIG01206037 FIG01206039: hypothetical protein +FIG01206039 FIG01206041: hypothetical protein +FIG01206042 FIG01206043: hypothetical protein +FIG01206044 FIG01206045: hypothetical protein +FIG01206046 Probable endonuclease +FIG01206050 FIG01206051: hypothetical protein +FIG01206056 FIG01206060: hypothetical protein +FIG01206060 putative glycoporin +FIG01206068 FIG01206069: hypothetical protein +FIG01206069 FIG01206070: hypothetical protein +FIG01206072 FIG01206074: hypothetical protein +FIG01206083 FIG01206084: hypothetical protein +FIG01206085 FIG01206090: hypothetical protein +FIG01206095 FIG01206096: hypothetical protein +FIG01206096 FIG01206099: hypothetical protein +FIG01206099 FIG01204436: hypothetical protein +FIG01206102 FIG01206103: hypothetical protein +FIG01206103 FIG01206106: hypothetical protein +FIG01206106 FIG01206107: hypothetical protein +FIG01206110 FIG01206114: hypothetical protein +FIG01206114 FIG01206122: hypothetical protein +FIG01206127 LuxR, transcriptional regulator +FIG01206136 FIG01206137: hypothetical protein +FIG01206137 FIG01206140: hypothetical protein +FIG01206143 FIG01206147: hypothetical protein +FIG01206150 FIG01206151: hypothetical protein +FIG01206151 transcriptional regulator, araC family protein +FIG01206168 FIG01206169: hypothetical protein +FIG01206169 FIG01206171: hypothetical protein +FIG01206176 FIG01206180: hypothetical protein +FIG01206184 FIG01206185: hypothetical protein +FIG01206187 FIG01206188: hypothetical protein +FIG01206201 FIG01206202: hypothetical protein +FIG01206202 FIG01206203: hypothetical protein +FIG01206203 gene 3 protein-related protein +FIG01206204 FIG01206208: hypothetical protein +FIG01206216 FIG01206219: hypothetical protein +FIG01206219 FIG01206222: hypothetical protein +FIG01206225 FIG01206227: hypothetical protein +FIG01206231 FIG01206232: hypothetical protein +FIG01206233 FIG01206234: hypothetical protein +FIG01206235 FIG01206240: hypothetical protein +FIG01206249 FIG01206250: hypothetical protein +FIG01206252 FIG01206255: hypothetical protein +FIG01206258 FIG01206264: hypothetical protein +FIG01206264 transcriptional regulator, PaiB-like +FIG01206269 FIG01206273: hypothetical protein +FIG01206274 FIG01206275: hypothetical protein +FIG01206275 FIG01206276: hypothetical protein +FIG01206279 FIG01206283: hypothetical protein +FIG01206283 FIG01206284: hypothetical protein +FIG01206287 FIG01206288: hypothetical protein +FIG01206293 FIG01206294: hypothetical protein +FIG01206294 FIG01206295: hypothetical protein +FIG01206297 FIG01206298: hypothetical protein +FIG01206314 FIG01206315: hypothetical protein +FIG01206320 FIG01206321: hypothetical protein +FIG01206333 FIG01206335: hypothetical protein +FIG01206364 FIG01206365: hypothetical protein +FIG01206365 FIG01206366: hypothetical protein +FIG01206368 FIG01206370: hypothetical protein +FIG01206370 FIG01206372: hypothetical protein +FIG01206374 FIG01206376: hypothetical protein +FIG01206377 Protein YgiW precursor +FIG01206381 FIG01206383: hypothetical protein +FIG01206394 FIG01206397: hypothetical protein +FIG01206405 Putative phage lysozyme precursor (EC 3.2.1.17) +FIG01206416 FIG01206417: hypothetical protein +FIG01206425 FIG01206427: hypothetical protein +FIG01206440 FIG01206444: hypothetical protein +FIG01206445 FIG01206446: hypothetical protein +FIG01206446 FIG01206449: hypothetical protein +FIG01206449 glutathione S-transfersae-related protein +FIG01206451 FIG01206452: hypothetical protein +FIG01206453 FIG01206455: hypothetical protein +FIG01206455 FIG01206457: hypothetical protein +FIG01206457 FIG01206459: hypothetical protein +FIG01206464 FIG01206466: hypothetical protein +FIG01206466 FIG01206467: hypothetical protein +FIG01206479 FIG01206481: hypothetical protein +FIG01206484 FIG01206485: hypothetical protein +FIG01206486 FIG01206488: hypothetical protein +FIG01206488 FIG01206490: hypothetical protein +FIG01206493 FIG01206494: hypothetical protein +FIG01206498 FIG01206499: hypothetical protein +FIG01206510 FIG01206511: hypothetical protein +FIG01206535 FIG01206536: hypothetical protein +FIG01206537 FIG01206539: hypothetical protein +FIG01206540 FIG01206541: hypothetical protein +FIG01206541 FIG01206543: hypothetical protein +FIG01206548 FIG01206549: hypothetical protein +FIG01206550 FIG01206558: hypothetical protein +FIG01206577 FIG01206580: hypothetical protein +FIG01206586 FIG01206589: hypothetical protein +FIG01206598 FIG01206602: hypothetical protein +FIG01206602 FIG01206603: hypothetical protein +FIG01206606 FIG01206607: hypothetical protein +FIG01206613 FIG01206615: hypothetical protein +FIG01206619 FIG01206621: hypothetical protein +FIG01206621 Zn-dependent hydrolase (EC 3.-.-.-) +FIG01206622 FIG01206623: hypothetical protein +FIG01206631 predicted lipase +FIG01206634 FIG01206637: hypothetical protein +FIG01206641 hypothetical protein, mmyd +FIG01206646 FIG01206651: hypothetical protein +FIG01206651 FIG01206652: hypothetical protein +FIG01206652 hypothetical protein +FIG01206655 FIG01206656: hypothetical protein +FIG01206665 FIG01206666: hypothetical protein +FIG01206667 FIG01206675: hypothetical protein +FIG01206678 FIG01206681: hypothetical protein +FIG01206681 Choloylglycine hydrolase family +FIG01206686 FIG01206689: hypothetical protein +FIG01206689 FIG01206694: hypothetical protein +FIG01206710 FIG01206714: hypothetical protein +FIG01206723 polysaccharide biosynthesis +FIG01206729 FIG01206731: hypothetical protein +FIG01206731 FIG01206733: hypothetical protein +FIG01206756 FIG01206759: hypothetical protein +FIG01206759 FIG01206761: hypothetical protein +FIG01206763 FIG01206765: hypothetical protein +FIG01206765 FIG01206768: hypothetical protein +FIG01206769 Component of multidrug efflux system +FIG01206771 FIG01206773: hypothetical protein +FIG01206792 FIG01206793: hypothetical protein +FIG01206794 FIG01206795: hypothetical protein +FIG01206797 FIG01206800: hypothetical protein +FIG01206815 FIG01206817: hypothetical protein +FIG01206851 FIG01206853: hypothetical protein +FIG01206853 FIG01206854: hypothetical protein +FIG01206859 FIG01206865: hypothetical protein +FIG01206881 FIG01206884: hypothetical protein +FIG01206889 FIG01206894: hypothetical protein +FIG01206894 FIG01206895: hypothetical protein +FIG01206901 FIG01206903: hypothetical protein +FIG01206903 FIG01206908: hypothetical protein +FIG01206910 FIG01206916: hypothetical protein +FIG01206947 FIG01206948: hypothetical protein +FIG01206950 FIG01206951: hypothetical protein +FIG01206960 FIG01206963: hypothetical protein +FIG01206963 FIG01206964: hypothetical protein +FIG01206965 FIG01206967: hypothetical protein +FIG01206970 FIG01206971: hypothetical protein +FIG01206973 LuxI +FIG01206976 FIG01206978: hypothetical protein +FIG01206981 FIG01206982: hypothetical protein +FIG01206986 FIG01206989: hypothetical protein +FIG01206997 FIG01206998: hypothetical protein +FIG01206998 FIG01206999: hypothetical protein +FIG01207000 FIG01207008: hypothetical protein +FIG01207017 FIG01207019: hypothetical protein +FIG01207028 FIG01207031: hypothetical protein +FIG01207035 FIG01207036: hypothetical protein +FIG01207036 FIG01207038: hypothetical protein +FIG01207038 FIG01207039: hypothetical protein +FIG01207056 Type II restriction-modification system methylation subunit +FIG01207063 transcriptional regulator, AraC family( EC:2.1.1.63 ) +FIG01207064 FIG01207066: hypothetical protein +FIG01207066 FIG01207067: hypothetical protein +FIG01207068 FIG01207075: hypothetical protein +FIG01207088 FIG01207091: hypothetical protein +FIG01207091 MoxR-like ATPase +FIG01207103 FIG01207106: hypothetical protein +FIG01207140 FIG01207143: hypothetical protein +FIG01207145 FIG01207146: hypothetical protein +FIG01207157 FIG01207159: hypothetical protein +FIG01207163 dTDP-glucose pyrophosphorylase +FIG01207180 FIG01207182: hypothetical protein +FIG01207187 FIG01207191: hypothetical protein +FIG01207193 Cytochrome c-type protein NapC +FIG01207214 FIG01207217: hypothetical protein +FIG01207217 FIG01207220: hypothetical protein +FIG01207230 FIG01207231: hypothetical protein +FIG01207233 FIG01207235: hypothetical protein +FIG01207263 FIG01207264: hypothetical protein +FIG01207286 FIG01207287: hypothetical protein +FIG01207297 FIG01207299: hypothetical protein +FIG01207302 FIG01207303: hypothetical protein +FIG01207306 FIG01207307: hypothetical protein +FIG01207307 FIG01207309: hypothetical protein +FIG01207321 FIG01207322: hypothetical protein +FIG01207367 FIG01207368: hypothetical protein +FIG01207417 FIG01207421: hypothetical protein +FIG01207428 Transport and binding proteins +FIG01207431 Protein fate +FIG01207522 FIG01207523: hypothetical protein +FIG01207523 FIG01207524: hypothetical protein +FIG01207524 FIG01207525: hypothetical protein +FIG01207525 FIG01207526: hypothetical protein +FIG01207526 FIG01207528: hypothetical protein +FIG01207528 Putative minor capsid protein c +FIG01207534 FIG01207536: hypothetical protein +FIG01207536 FIG01207537: hypothetical protein +FIG01207537 FIG01207540: hypothetical protein +FIG01207540 FIG01207541: hypothetical protein +FIG01207542 cytochrome c-1 +FIG01207543 Putative 3-methyladenine DNA glycosylase +FIG01207546 FIG01207547: hypothetical protein +FIG01207553 FIG01207557: hypothetical protein +FIG01207559 FIG01207561: hypothetical protein +FIG01207562 FIG01207565: hypothetical protein +FIG01207565 FIG01207567: hypothetical protein +FIG01207567 FIG01207568: hypothetical protein +FIG01207568 lipolytic enzyme, GDSL family +FIG01207570 membrane protein, TerC family +FIG01207571 FIG01207574: hypothetical protein +FIG01207574 FIG01207575: hypothetical protein +FIG01207579 FIG01207580: hypothetical protein +FIG01207587 glycosyl transferase, group 1 family protein / moaA/nifB/pqqE family protein +FIG01207591 vrlC protein - Dichelobacter nodosus +FIG01207596 inversin protein alternative isoform, putative +FIG01207600 FIG01207601: hypothetical protein +FIG01207601 FIG01207603: hypothetical protein +FIG01207603 FIG01207604: hypothetical protein +FIG01207604 FIG01207606: hypothetical protein +FIG01207606 FIG01207608: hypothetical protein +FIG01207608 FIG01207609: hypothetical protein +FIG01207609 FIG01207610: hypothetical protein +FIG01207610 FIG01207616: hypothetical protein +FIG01207620 FIG01207622: hypothetical protein +FIG01207622 FIG01207624: hypothetical protein +FIG01207624 Phage uncharacterized protein +FIG01207627 FIG01207629: hypothetical protein +FIG01207629 FIG01207630: hypothetical protein +FIG01207630 FIG01207633: hypothetical protein +FIG01207633 FIG01207635: hypothetical protein +FIG01207639 Cytochrome c-type biogenesis protein cycL precursor +FIG01207642 FIG01207643: hypothetical protein +FIG01207643 FIG01207644: hypothetical protein +FIG01207644 FIG01207646: hypothetical protein +FIG01207647 FIG01207649: hypothetical protein +FIG01207649 FIG01207651: hypothetical protein +FIG01207653 Ribulose-5-phosphate 4-epimerase and related epimerases and aldolases +FIG01207659 FIG01207660: hypothetical protein +FIG01207676 Sodium/proton antiporter shaA (EC 1.6.5.3) +FIG01207677 FIG01207680: hypothetical protein +FIG01207680 FIG01207685: hypothetical protein +FIG01207685 FIG01207687: hypothetical protein +FIG01207687 FIG01207688: hypothetical protein +FIG01207689 FIG01207693: hypothetical protein +FIG01207694 FIG01207695: hypothetical protein +FIG01207695 FIG01207696: hypothetical protein +FIG01207698 FIG01207701: hypothetical protein +FIG01207705 FIG01207706: hypothetical protein +FIG01207712 prophage LambdaW1, ankyrin repeat domain protein +FIG01207715 FIG01207718: hypothetical protein +FIG01207719 FIG01207720: hypothetical protein +FIG01207720 FIG01207721: hypothetical protein +FIG01207723 FIG01207724: hypothetical protein +FIG01207724 FIG01207726: hypothetical protein +FIG01207726 FIG01207727: hypothetical protein +FIG01207730 FIG01207731: hypothetical protein +FIG01207732 FIG01207735: hypothetical protein +FIG01207735 FIG01207736: hypothetical protein +FIG01207741 RelE/StbE replicon stabilization toxin +FIG01207744 prophage P2W3, tail protein X, putative +FIG01207745 FIG01207753: hypothetical protein +FIG01207753 FIG01207758: hypothetical protein +FIG01207759 FIG01207761: hypothetical protein +FIG01207763 FIG01207764: hypothetical protein +FIG01207769 Phage related DNA methylase +FIG01207778 Phage terminase, large subunit @ intein-containing +FIG01207780 FIG01207781: hypothetical protein +FIG01207781 FIG01207782: hypothetical protein +FIG01207782 prophage LambdaW5, minor tail protein Z, putative +FIG01207783 FIG01207785: hypothetical protein +FIG01207791 FIG01207792: hypothetical protein +FIG01207792 prophage LambdaW1, baseplate assembly protein J, putative +FIG01207794 FIG01207796: hypothetical protein +FIG01207801 11L protein +FIG01207807 FIG01207810: hypothetical protein +FIG01207810 FIG01207812: hypothetical protein +FIG01207812 FIG01207814: hypothetical protein +FIG01207815 Dihydrolipoamide dehydrogenase (EC 1.8.1.4); Dihydrolipoamide dehydrogenase of 2-oxoglutarate dehydrogenase (EC 1.8.1.4) +FIG01207822 FIG01207824: hypothetical protein +FIG01207831 FIG01207832: hypothetical protein +FIG01207832 FIG01207833: hypothetical protein +FIG01207833 FIG01207835: hypothetical protein +FIG01207835 FIG01207837: hypothetical protein +FIG01207844 FIG01207846: hypothetical protein +FIG01207846 FIG01207847: hypothetical protein +FIG01207851 FIG01207853: hypothetical protein +FIG01207853 FIG01207854: hypothetical protein +FIG01207862 FIG01207870: hypothetical protein +FIG01207870 FIG01207873: hypothetical protein +FIG01207873 FIG01207874: hypothetical protein +FIG01207874 FIG01207875: hypothetical protein +FIG01207878 FIG01207879: hypothetical protein +FIG01207879 FIG01207881: hypothetical protein +FIG01207881 FIG01207883: hypothetical protein +FIG01207883 FIG01207884: hypothetical protein +FIG01207885 FIG01207886: hypothetical protein +FIG01207888 FIG01207889: hypothetical protein +FIG01207894 surface antigen Wsp +FIG01207898 FIG01207900: hypothetical protein +FIG01207900 FIG01207901: hypothetical protein +FIG01207902 FIG01207903: hypothetical protein +FIG01207906 FIG01207914: hypothetical protein +FIG01207914 FIG01207915: hypothetical protein +FIG01207916 FIG01207917: hypothetical protein +FIG01207917 FIG01207920: hypothetical protein +FIG01207923 FIG01207924: hypothetical protein +FIG01207924 FIG01207925: hypothetical protein +FIG01207929 FIG01207930: hypothetical protein +FIG01207930 FIG01207933: hypothetical protein +FIG01207933 FIG01207934: hypothetical protein +FIG01207934 FIG01207935: hypothetical protein +FIG01207935 FIG01207936: hypothetical protein +FIG01207940 FIG01207941: hypothetical protein +FIG01207941 FIG01207942: hypothetical protein +FIG01207942 FIG01207944: hypothetical protein +FIG01207944 FIG01207947: hypothetical protein +FIG01207947 FIG01207950: hypothetical protein +FIG01207951 FIG01207955: hypothetical protein +FIG01207955 FIG01207956: hypothetical protein +FIG01207956 FIG01207959: hypothetical protein +FIG01207959 putative phage related protein +FIG01207965 FIG01207968: hypothetical protein +FIG01207975 FIG01207977: hypothetical protein +FIG01207977 FIG01207978: hypothetical protein +FIG01207981 amino acid ABC transporter, ATP-binding protein, putative +FIG01207984 RelE/StbE replicon stabilization toxin +FIG01207987 SdbB protein (putative substrate of the Dot/Icm system) +FIG01207989 FIG01207997: hypothetical protein +FIG01207997 DsbA-like disulfide oxidoreductase +FIG01208004 FIG01208005: hypothetical protein +FIG01208006 FIG01208010: hypothetical protein +FIG01208018 FIG01208020: hypothetical protein +FIG01208020 FIG01208022: hypothetical protein +FIG01208022 FIG01208025: hypothetical protein +FIG01208025 prophage LambdaW1, site-specific recombinase, resolvase family +FIG01208027 FIG01208028: hypothetical protein +FIG01208029 FIG01208030: hypothetical protein +FIG01208036 FIG01208037: hypothetical protein +FIG01208039 FIG01208044: hypothetical protein +FIG01208044 FIG01208047: hypothetical protein +FIG01208058 FIG01208059: hypothetical protein +FIG01208059 FIG01208063: hypothetical protein +FIG01208064 multidrug resistance protein D +FIG01208065 FIG01208070: hypothetical protein +FIG01208070 FIG01208071: hypothetical protein +FIG01208071 FIG01208072: hypothetical protein +FIG01208072 ankyrin repeat domain protein, putative +FIG01208078 Putative bacteriophage-related protein +FIG01208088 FIG01208089: hypothetical protein +FIG01208089 FIG01208090: hypothetical protein +FIG01208096 FIG01208097: hypothetical protein +FIG01208097 phospholipase A2, group VI +FIG01208103 FIG01208104: hypothetical protein +FIG01208104 hypothetical protein +FIG01208106 FIG01208107: hypothetical protein +FIG01208107 FIG01208110: hypothetical protein +FIG01208114 FIG01208115: hypothetical protein +FIG01208118 FIG01208119: hypothetical protein +FIG01208121 FIG01208126: hypothetical protein +FIG01208126 FIG01208128: hypothetical protein +FIG01208128 AAA ATPase family protein +FIG01208131 patatin family protein +FIG01208137 FIG01208142: hypothetical protein +FIG01208142 FIG01208147: hypothetical protein +FIG01208147 FIG01208151: hypothetical protein +FIG01208151 FIG01208154: hypothetical protein +FIG01208155 FIG01208156: hypothetical protein +FIG01208157 FIG01208161: hypothetical protein +FIG01208172 FIG01208173: hypothetical protein +FIG01208175 FIG01208176: hypothetical protein +FIG01208176 FIG01208179: hypothetical protein +FIG01208179 FIG01208187: hypothetical protein +FIG01208192 RelB/StbD replicon stabilization protein (antitoxin to RelE/StbE) +FIG01208202 Head-tail preconnector protein GP5 +FIG01208229 FIG01208231: hypothetical protein +FIG01208232 FIG01208233: hypothetical protein +FIG01208237 FIG01208240: hypothetical protein +FIG01208240 FIG01208241: hypothetical protein +FIG01208241 FIG01208245: hypothetical protein +FIG01208245 FIG01208246: hypothetical protein +FIG01208246 FIG01208253: hypothetical protein +FIG01208256 FIG01208258: hypothetical protein +FIG01208258 FIG01208259: hypothetical protein +FIG01208259 FIG01208260: hypothetical protein +FIG01208261 FIG01208263: hypothetical protein +FIG01208265 FIG01208267: hypothetical protein +FIG01208267 FIG01208269: hypothetical protein +FIG01208273 FIG01208280: hypothetical protein +FIG01208280 FIG01208599: hypothetical protein +FIG01208302 FIG01208305: hypothetical protein +FIG01208311 FIG01208314: hypothetical protein +FIG01208314 FIG01208317: hypothetical protein +FIG01208317 Putative endonuclease +FIG01208327 FIG01208330: hypothetical protein +FIG01208330 FIG01208332: hypothetical protein +FIG01208332 FIG01208336: hypothetical protein +FIG01208338 FIG01208339: hypothetical protein +FIG01208339 FIG01208341: hypothetical protein +FIG01208341 FIG01208342: hypothetical protein +FIG01208345 surface antigen Wsp paralog +FIG01208360 FIG01208363: hypothetical protein +FIG01208365 FIG01208366: hypothetical protein +FIG01208369 FIG01208372: hypothetical protein +FIG01208379 FIG01208381: hypothetical protein +FIG01208382 amino acid (glutamine) ABC transporter, periplasmic amino acid binding protein +FIG01208389 FIG01208391: hypothetical protein +FIG01208394 FIG01208403: hypothetical protein +FIG01208414 FIG01208416: hypothetical protein +FIG01208417 FIG01208418: hypothetical protein +FIG01208418 Capsid protein +FIG01208419 FIG01208420: hypothetical protein +FIG01208431 FIG01208433: hypothetical protein +FIG01208435 FIG01208437: hypothetical protein +FIG01208441 FIG01208444: hypothetical protein +FIG01208450 FIG01208453: hypothetical protein +FIG01208453 FIG01208460: hypothetical protein +FIG01208460 FIG01208462: hypothetical protein +FIG01208471 FIG01208475: hypothetical protein +FIG01208475 FIG01208476: hypothetical protein +FIG01208476 FIG01208477: hypothetical protein +FIG01208477 FIG01208479: hypothetical protein +FIG01208479 FIG01208485: hypothetical protein +FIG01208485 FIG01208493: hypothetical protein +FIG01208493 FIG01208495: hypothetical protein +FIG01208505 FIG01208582: hypothetical protein +FIG01208511 FIG01208520: hypothetical protein +FIG01208523 FIG01208525: hypothetical protein +FIG01208529 FIG01208536: hypothetical protein +FIG01208539 FIG01208542: hypothetical protein +FIG01208548 uncharacterized phage protein, putative +FIG01208555 FIG01208557: hypothetical protein +FIG01208557 FIG01208558: hypothetical protein +FIG01208562 FIG01208564: hypothetical protein +FIG01208564 FIG01208565: hypothetical protein +FIG01208565 FIG01208566: hypothetical protein +FIG01208567 FIG01208568: hypothetical protein +FIG01208579 FIG01208581: hypothetical protein +FIG01208586 FIG01208589: hypothetical protein +FIG01208600 FIG01208608: hypothetical protein +FIG01208608 FIG01208610: hypothetical protein +FIG01208610 FIG01208612: hypothetical protein +FIG01208617 FIG01208632: hypothetical protein +FIG01208637 FIG01208642: hypothetical protein +FIG01208642 FIG01208644: hypothetical protein +FIG01208644 FIG01208647: hypothetical protein +FIG01208647 FIG01208648: hypothetical protein +FIG01208666 Heme exporter protein B +FIG01208667 FIG01208670: hypothetical protein +FIG01208674 FIG01208677: hypothetical protein +FIG01208678 FIG01208683: hypothetical protein +FIG01208685 FIG01208690: hypothetical protein +FIG01208692 FIG01208694: hypothetical protein +FIG01208694 FIG01208695: hypothetical protein +FIG01208698 FIG01208700: hypothetical protein +FIG01208702 FIG01208710: hypothetical protein +FIG01208716 FIG01208719: hypothetical protein +FIG01208723 FIG01208745: hypothetical protein +FIG01208745 nuclease-related protein +FIG01208787 ABC-TYPE IRON (III) TRANSPORT SYSTEM +FIG01208861 FIG01208864: hypothetical protein +FIG01208921 protease IV (PspA) +FIG01208928 thiamine phosphate synthase +FIG01209011 FIG01209012: hypothetical protein +FIG01209039 conserved hypothetical protein-Predicted Fe-S-cluster oxidoreductase +FIG01209125 FIG01209130: hypothetical protein +FIG01209141 Putative carboxyl-terminal protease (EC 3.4.21.-) +FIG01209244 FIG01209247: hypothetical protein +FIG01209350 WBGX PROTEIN +FIG01209435 FIG01209442: hypothetical protein +FIG01209446 FIG01209456: hypothetical protein +FIG01209525 sulfate adenylyltransferase +FIG01209576 PUTATIVE COMPETENCE PROTEIN +FIG01209578 FIG01209588: hypothetical protein +FIG01209655 cellulase S +FIG01209660 FIG01209662: hypothetical protein +FIG01209662 FIG01209663: hypothetical protein +FIG01209663 FIG01209664: hypothetical protein +FIG01209664 FIG01209666: hypothetical protein +FIG01209666 sodium:galactoside family symporter +FIG01209668 FIG01209670: hypothetical protein +FIG01209670 FIG01209673: hypothetical protein +FIG01209673 FIG01209674: hypothetical protein +FIG01209674 FIG01209675: hypothetical protein +FIG01209675 FIG01209676: hypothetical protein +FIG01209676 FIG01209678: hypothetical protein +FIG01209678 FIG01209679: hypothetical protein +FIG01209680 Transcriptional regulator protein +FIG01209683 FIG01209684: hypothetical protein +FIG01209684 FIG01209685: hypothetical protein +FIG01209685 FIG01209686: hypothetical protein +FIG01209686 FIG01209687: hypothetical protein +FIG01209687 Transcriptional regulator lacI family +FIG01209688 FIG01209689: hypothetical protein +FIG01209690 FIG01209691: hypothetical protein +FIG01209691 Hyaluronidase +FIG01209694 tail-specific protease +FIG01209697 FIG01209698: hypothetical protein +FIG01209698 FIG01209699: hypothetical protein +FIG01209699 FIG01209701: hypothetical protein +FIG01209701 FIG01209702: hypothetical protein +FIG01209702 FIG01209703: hypothetical protein +FIG01209705 FIG01209707: hypothetical protein +FIG01209710 FIG01209712: hypothetical protein +FIG01209712 FIG01209715: hypothetical protein +FIG01209715 FIG01209718: hypothetical protein +FIG01209718 FIG01209720: hypothetical protein +FIG01209721 FIG01209723: hypothetical protein +FIG01209724 FIG01209725: hypothetical protein +FIG01209725 FIG01209726: hypothetical protein +FIG01209726 FIG01209727: hypothetical protein +FIG01209727 FIG01209728: hypothetical protein +FIG01209729 FIG01209733: hypothetical protein +FIG01209733 Response regulator protein +FIG01209734 FIG01209735: hypothetical protein +FIG01209738 Cation/H+ antiporter +FIG01209740 Glutaredoxin-like protein +FIG01209742 Histidine kinase/response regulator hybrid protein +FIG01209749 FIG01209750: hypothetical protein +FIG01209750 FIG01209751: hypothetical protein +FIG01209751 FIG01209754: hypothetical protein +FIG01209754 FIG01209757: hypothetical protein +FIG01209757 FIG01209759: hypothetical protein +FIG01209759 FIG01209760: hypothetical protein +FIG01209761 FIG01209762: hypothetical protein +FIG01209762 FIG01209764: hypothetical protein +FIG01209764 FIG01209765: hypothetical protein +FIG01209768 Hypothetical protein ass w/ COG3533Xanth +FIG01209769 FIG01209770: hypothetical protein +FIG01209771 virulence plasmid protein +FIG01209772 FIG01209773: hypothetical protein +FIG01209773 FIG01209774: hypothetical protein +FIG01209774 FIG01209775: hypothetical protein +FIG01209776 FIG01209778: hypothetical protein +FIG01209778 FIG01209779: hypothetical protein +FIG01209779 FIG01209781: hypothetical protein +FIG01209784 permease +FIG01209785 FIG01209787: hypothetical protein +FIG01209787 FIG01209789: hypothetical protein +FIG01209789 C-type cytochrome biogenesis protein +FIG01209793 synthetase/amidase +FIG01209796 FIG01209798: hypothetical protein +FIG01209798 FIG01209800: hypothetical protein +FIG01209800 FIG01209801: hypothetical protein +FIG01209801 FIG01209802: hypothetical protein +FIG01209804 FIG01209806: hypothetical protein +FIG01209808 FIG01209809: hypothetical protein +FIG01209809 FIG01209810: hypothetical protein +FIG01209810 FIG01209811: hypothetical protein +FIG01209811 FIG01209813: hypothetical protein +FIG01209813 flavodoxin +FIG01209814 FIG01209815: hypothetical protein +FIG01209815 FIG01209817: hypothetical protein +FIG01209820 FIG01209821: hypothetical protein +FIG01209821 FIG01209826: hypothetical protein +FIG01209828 FIG01209829: hypothetical protein +FIG01209829 FIG01209831: hypothetical protein +FIG01209831 FIG01209832: hypothetical protein +FIG01209833 FIG01209836: hypothetical protein +FIG01209836 FIG01209837: hypothetical protein +FIG01209837 FIG01209841: hypothetical protein +FIG01209841 FIG01209842: hypothetical protein +FIG01209842 FIG01209843: hypothetical protein +FIG01209845 FIG01213140: hypothetical protein +FIG01209846 FIG01209847: hypothetical protein +FIG01209848 FIG01209849: hypothetical protein +FIG01209849 FIG01209850: hypothetical protein +FIG01209850 Chemotaxis response regulator containing a CheY-like receiver domain and a methylesterase domain +FIG01209853 RecA-superfamily ATPases implicated in signal transduction +FIG01209854 FIG01209855: hypothetical protein +FIG01209856 FIG01209858: hypothetical protein +FIG01209863 FIG01209864: hypothetical protein +FIG01209865 FIG01209867: hypothetical protein +FIG01209867 FIG01209868: hypothetical protein +FIG01209868 FIG01209869: hypothetical protein +FIG01209869 FIG01209870: hypothetical protein +FIG01209874 FIG01209877: hypothetical protein +FIG01209877 FIG01209878: hypothetical protein +FIG01209878 FIG01209879: hypothetical protein +FIG01209879 FIG01209881: hypothetical protein +FIG01209881 FIG01209882: hypothetical protein +FIG01209882 FIG01209884: hypothetical protein +FIG01209884 FIG01209885: hypothetical protein +FIG01209885 Minor pilin of type IV secretion complex, VirB5 +FIG01209886 FIG01209887: hypothetical protein +FIG01209889 FIG01209890: hypothetical protein +FIG01209890 FIG01209891: hypothetical protein +FIG01209893 FIG01209895: hypothetical protein +FIG01209895 Sensory/regulatory protein rpfC (EC 2.7.3.-) +FIG01209897 FIG01209898: hypothetical protein +FIG01209898 FIG01209899: hypothetical protein +FIG01209899 FIG01209901: hypothetical protein +FIG01209902 FIG01209903: hypothetical protein +FIG01209903 FIG01209905: hypothetical protein +FIG01209905 FIG01209907: hypothetical protein +FIG01209910 FIG01209914: hypothetical protein +FIG01209914 Peptidase S33, tricorn interacting factor 1 (EC 3.4.11.5) +FIG01209916 XmnI methyltransferase +FIG01209917 FIG01209918: hypothetical protein +FIG01209919 FIG01209920: hypothetical protein +FIG01209921 FIG01209922: hypothetical protein +FIG01209922 FIG01209923: hypothetical protein +FIG01209923 FIG01209924: hypothetical protein +FIG01209925 FIG01209926: hypothetical protein +FIG01209926 FIG01209927: hypothetical protein +FIG01209927 FIG01209928: hypothetical protein +FIG01209930 FIG01209931: hypothetical protein +FIG01209931 FIG01209934: hypothetical protein +FIG01209934 FIG01209938: hypothetical protein +FIG01209938 FIG01209939: hypothetical protein +FIG01209939 FIG01209941: hypothetical protein +FIG01209941 FIG01209943: hypothetical protein +FIG01209944 FIG01209945: hypothetical protein +FIG01209945 FIG01209946: hypothetical protein +FIG01209948 FIG01209949: hypothetical protein +FIG01209950 FIG01209954: hypothetical protein +FIG01209954 FIG01209955: hypothetical protein +FIG01209955 FIG01209956: hypothetical protein +FIG01209956 FIG01209959: hypothetical protein +FIG01209959 FIG01209960: hypothetical protein +FIG01209960 FIG01209961: hypothetical protein +FIG01209961 FIG01209962: hypothetical protein +FIG01209962 FIG01209963: hypothetical protein +FIG01209963 FIG01209964: hypothetical protein +FIG01209964 FIG01209965: hypothetical protein +FIG01209965 Transmembrane protein +FIG01209966 FIG01209967: hypothetical protein +FIG01209967 FIG01209968: hypothetical protein +FIG01209968 FIG01209970: hypothetical protein +FIG01209970 FIG01209971: hypothetical protein +FIG01209974 FIG01209975: hypothetical protein +FIG01209975 FIG01209976: hypothetical protein +FIG01209976 FIG01209977: hypothetical protein +FIG01209977 FIG01209978: hypothetical protein +FIG01209982 FIG01209985: hypothetical protein +FIG01209989 FIG01209990: hypothetical protein +FIG01209990 FIG01209991: hypothetical protein +FIG01209991 FIG01209993: hypothetical protein +FIG01209994 FIG01209995: hypothetical protein +FIG01209995 FIG01209996: hypothetical protein +FIG01209996 FIG01209997: hypothetical protein +FIG01209997 FIG01209998: hypothetical protein +FIG01209998 phosphoprotein phosphatase +FIG01210000 cation efflux system protein +FIG01210002 FIG01210004: hypothetical protein +FIG01210005 FIG01210006: hypothetical protein +FIG01210006 degenerated pectate lyase +FIG01210008 FIG01210009: hypothetical protein +FIG01210010 FIG01210012: hypothetical protein +FIG01210012 FIG01210014: hypothetical protein +FIG01210014 FIG01210016: hypothetical protein +FIG01210016 FIG01210018: hypothetical protein +FIG01210019 FIG01210021: hypothetical protein +FIG01210021 FIG01210022: hypothetical protein +FIG01210022 FIG01210023: hypothetical protein +FIG01210024 FIG01210025: hypothetical protein +FIG01210025 FIG01210026: hypothetical protein +FIG01210026 FIG01210028: hypothetical protein +FIG01210028 FIG01210029: hypothetical protein +FIG01210029 FIG01210031: hypothetical protein +FIG01210039 FIG01210040: hypothetical protein +FIG01210040 tryptophan repressor binding protein +FIG01210041 FIG01210042: hypothetical protein +FIG01210042 FIG01210044: hypothetical protein +FIG01210046 Two-component system regulatory protein +FIG01210047 FIG01210050: hypothetical protein +FIG01210050 FIG01210051: hypothetical protein +FIG01210051 FIG01210052: hypothetical protein +FIG01210052 FIG01210053: hypothetical protein +FIG01210054 FIG01210056: hypothetical protein +FIG01210057 FIG01210059: hypothetical protein +FIG01210059 FIG01210061: hypothetical protein +FIG01210061 FIG01210062: hypothetical protein +FIG01210062 sialic acid-specific 9-O-acetylesterase +FIG01210063 FIG01210064: hypothetical protein +FIG01210064 Sigma-70 factor precursor +FIG01210069 FIG01214195: hypothetical protein +FIG01210070 FIG01210071: hypothetical protein +FIG01210072 FIG01210076: hypothetical protein +FIG01210076 FIG01210078: hypothetical protein +FIG01210080 FIG01210081: hypothetical protein +FIG01210083 Mlr3171 protein +FIG01210085 FIG01210086: hypothetical protein +FIG01210086 FIG01210089: hypothetical protein +FIG01210089 FIG01210090: hypothetical protein +FIG01210090 FIG01210092: hypothetical protein +FIG01210092 FIG01210093: hypothetical protein +FIG01210093 FIG01210094: hypothetical protein +FIG01210098 FIG01210100: hypothetical protein +FIG01210100 FIG01210103: hypothetical protein +FIG01210103 FIG01210106: hypothetical protein +FIG01210106 FIG01210108: hypothetical protein +FIG01210108 FIG01210109: hypothetical protein +FIG01210110 FIG023937: hypothetical protein in ureide degradation cluster +FIG01210112 FIG01210114: hypothetical protein +FIG01210118 Toxin secretion ABC transporter ATP-binding protein +FIG01210120 FIG01210121: hypothetical protein +FIG01210121 chlorohydrolase family protein +FIG01210122 FIG01210123: hypothetical protein +FIG01210124 FIG01210126: hypothetical protein +FIG01210129 FIG01210133: hypothetical protein +FIG01210133 pilus biogenesis protein +FIG01210136 Transcriptional regulator, XRE family protein +FIG01210139 FIG01210140: hypothetical protein +FIG01210140 TfoX C-terminal domain superfamily +FIG01210144 FIG01210145: hypothetical protein +FIG01210146 FIG01210147: hypothetical protein +FIG01210149 FIG01210151: hypothetical protein +FIG01210151 FIG01210152: hypothetical protein +FIG01210153 FIG01210154: hypothetical protein +FIG01210154 FIG01210155: hypothetical protein +FIG01210155 FIG01210156: hypothetical protein +FIG01210156 FIG01210157: hypothetical protein +FIG01210157 transport protein +FIG01210158 cardiolipin synthetase +FIG01210161 FIG01210164: hypothetical protein +FIG01210164 FIG01210165: hypothetical protein +FIG01210165 FIG01210167: hypothetical protein +FIG01210167 FIG01210168: hypothetical protein +FIG01210168 Alkaline phosphatase D +FIG01210169 FIG01210170: hypothetical protein +FIG01210172 FIG01210173: hypothetical protein +FIG01210173 Drug resistance translocase +FIG01210174 FIG01210175: hypothetical protein +FIG01210175 FIG01210176: hypothetical protein +FIG01210176 FIG01210178: hypothetical protein +FIG01210178 FIG01210179: hypothetical protein +FIG01210179 Alr1013 protein +FIG01210182 FIG01210184: hypothetical protein +FIG01210184 FIG01210186: hypothetical protein +FIG01210187 FIG01210189: hypothetical protein +FIG01210189 FIG01210190: hypothetical protein +FIG01210190 FIG01210192: hypothetical protein +FIG01210192 FIG01210197: hypothetical protein +FIG01210201 FIG01210202: hypothetical protein +FIG01210202 FIG01210205: hypothetical protein +FIG01210205 FIG01210206: hypothetical protein +FIG01210208 FIG01210211: hypothetical protein +FIG01210212 FIG01210215: hypothetical protein +FIG01210224 FIG01210225: hypothetical protein +FIG01210225 putative; ORF located using Glimmer/GeneMark +FIG01210228 FIG01210229: hypothetical protein +FIG01210229 FIG01210230: hypothetical protein +FIG01210233 FIG01210234: hypothetical protein +FIG01210234 FIG01210235: hypothetical protein +FIG01210235 FIG01210236: hypothetical protein +FIG01210236 FIG01210237: hypothetical protein +FIG01210240 FIG01210241: hypothetical protein +FIG01210241 FIG01210243: hypothetical protein +FIG01210244 FIG01210246: hypothetical protein +FIG01210248 FIG01210249: hypothetical protein +FIG01210249 outer membrane lipoprotein Blc +FIG01210251 FIG01210252: hypothetical protein +FIG01210252 FIG01210255: hypothetical protein +FIG01210255 Sensor kinase +FIG01210257 FIG01210258: hypothetical protein +FIG01210259 FIG01210260: hypothetical protein +FIG01210263 FIG01210264: hypothetical protein +FIG01210265 FIG01210267: hypothetical protein +FIG01210267 FIG01210269: hypothetical protein +FIG01210272 FIG01210273: hypothetical protein +FIG01210273 FIG01210275: hypothetical protein +FIG01210276 FIG01210277: hypothetical protein +FIG01210277 FIG01210278: hypothetical protein +FIG01210279 FIG01210281: hypothetical protein +FIG01210285 FIG01210286: hypothetical protein +FIG01210287 FIG01210288: hypothetical protein +FIG01210298 FIG01210301: hypothetical protein +FIG01210301 FIG01210302: hypothetical protein +FIG01210303 FIG01210304: hypothetical protein +FIG01210305 FIG01210306: hypothetical protein +FIG01210306 FIG01210307: hypothetical protein +FIG01210315 FIG01210319: hypothetical protein +FIG01210322 FIG01210323: hypothetical protein +FIG01210324 FIG01210327: hypothetical protein +FIG01210327 FIG01210329: hypothetical protein +FIG01210329 FIG01210332: hypothetical protein +FIG01210332 FIG01210333: hypothetical protein +FIG01210333 FIG01210334: hypothetical protein +FIG01210338 FIG01210339: hypothetical protein +FIG01210339 FIG01210340: hypothetical protein +FIG01210340 FIG01210341: hypothetical protein +FIG01210341 FIG01210342: hypothetical protein +FIG01210342 entericidin A +FIG01210347 FIG01210349: hypothetical protein +FIG01210349 FIG01210350: hypothetical protein +FIG01210350 FIG01210351: hypothetical protein +FIG01210351 FIG01210352: hypothetical protein +FIG01210353 FIG01210354: hypothetical protein +FIG01210354 FIG01210356: hypothetical protein +FIG01210356 FIG01210357: hypothetical protein +FIG01210357 FIG01210358: hypothetical protein +FIG01210358 FIG01210359: hypothetical protein +FIG01210359 FIG01210360: hypothetical protein +FIG01210366 FIG01210368: hypothetical protein +FIG01210368 cardiolipin synthase +FIG01210369 FIG01210371: hypothetical protein +FIG01210371 FIG01210372: hypothetical protein +FIG01210372 FIG01210375: hypothetical protein +FIG01210375 FIG01210376: hypothetical protein +FIG01210376 FIG01210377: hypothetical protein +FIG01210379 FIG01210380: hypothetical protein +FIG01210381 FIG01210382: hypothetical protein +FIG01210383 FIG01210385: hypothetical protein +FIG01210385 FIG01210386: hypothetical protein +FIG01210386 high-affinity choline transport +FIG01210387 FIG01210389: hypothetical protein +FIG01210389 transmembrane protein +FIG01210390 Hydrolase or peptidase +FIG01210394 FIG01210395: hypothetical protein +FIG01210395 FIG01210396: hypothetical protein +FIG01210398 FIG01210399: hypothetical protein +FIG01210399 FIG01210401: hypothetical protein +FIG01210405 FIG01210406: hypothetical protein +FIG01210406 FIG01210409: hypothetical protein +FIG01210411 FIG01210413: hypothetical protein +FIG01210413 FIG01210420: hypothetical protein +FIG01210420 FIG01210422: hypothetical protein +FIG01210422 FIG01210423: hypothetical protein +FIG01210423 FIG01210424: hypothetical protein +FIG01210428 FIG01210430: hypothetical protein +FIG01210433 FIG01210434: hypothetical protein +FIG01210434 PMID: 12024217 +FIG01210437 FIG01210438: hypothetical protein +FIG01210438 FIG01210439: hypothetical protein +FIG01210440 FIG01210441: hypothetical protein +FIG01210441 FIG01210443: hypothetical protein +FIG01210443 Ferric-pseudobactin M114 receptor pbuA precursor +FIG01210444 FIG01210445: hypothetical protein +FIG01210447 FIG01210448: hypothetical protein +FIG01210448 FIG01210449: hypothetical protein +FIG01210449 FIG01210451: hypothetical protein +FIG01210452 FIG01210453: hypothetical protein +FIG01210455 FIG01210456: hypothetical protein +FIG01210456 FIG01210457: hypothetical protein +FIG01210458 FIG01210460: hypothetical protein +FIG01210460 FIG01210461: hypothetical protein +FIG01210461 FIG01210462: hypothetical protein +FIG01210462 FIG01210463: hypothetical protein +FIG01210463 FIG01210465: hypothetical protein +FIG01210465 Cation:proton antiporter +FIG01210471 FIG01210473: hypothetical protein +FIG01210473 partition protein +FIG01210474 FIG01212678: hypothetical protein +FIG01210476 FIG01210478: hypothetical protein +FIG01210479 FIG01210480: hypothetical protein +FIG01210480 FIG01210482: hypothetical protein +FIG01210482 FIG01210483: hypothetical protein +FIG01210484 FIG01210486: hypothetical protein +FIG01210486 FIG01210487: hypothetical protein +FIG01210487 FIG01210488: hypothetical protein +FIG01210488 FIG01210489: hypothetical protein +FIG01210489 FIG01210490: hypothetical protein +FIG01210490 Conditioned medium factor +FIG01210491 FIG01210492: hypothetical protein +FIG01210492 FIG01210495: hypothetical protein +FIG01210495 FIG01210497: hypothetical protein +FIG01210498 FIG01210500: hypothetical protein +FIG01210500 FIG01210504: hypothetical protein +FIG01210507 FIG01210508: hypothetical protein +FIG01210508 FIG01210509: hypothetical protein +FIG01210509 FIG01210510: hypothetical protein +FIG01210510 FIG01210511: hypothetical protein +FIG01210511 FIG01210512: hypothetical protein +FIG01210516 Cellulase S +FIG01210518 FIG01210521: hypothetical protein +FIG01210521 FIG01210523: hypothetical protein +FIG01210523 FIG01210528: hypothetical protein +FIG01210528 FIG01210530: hypothetical protein +FIG01210531 sugar translocase +FIG01210534 transcriptional regulator lysR family +FIG01210536 FIG01210539: hypothetical protein +FIG01210539 FIG01210540: hypothetical protein +FIG01210540 FIG01210541: hypothetical protein +FIG01210543 FIG01210546: hypothetical protein +FIG01210546 FIG01210548: hypothetical protein +FIG01210549 FIG01210552: hypothetical protein +FIG01210552 FIG01210555: hypothetical protein +FIG01210555 Transcriptional regulator NtrC family +FIG01210563 FIG01210566: hypothetical protein +FIG01210566 FIG01210567: hypothetical protein +FIG01210567 RhsD protein +FIG01210571 ring canal kelch-like protein +FIG01210573 FIG01210574: hypothetical protein +FIG01210574 FIG01210575: hypothetical protein +FIG01210575 FIG01210576: hypothetical protein +FIG01210576 Flavin monoamine oxidase-related protein +FIG01210580 Glucan 1,4-beta-glucosidase +FIG01210581 FIG01210582: hypothetical protein +FIG01210586 FIG01210587: hypothetical protein +FIG01210587 FIG01210588: hypothetical protein +FIG01210588 FIG01210590: hypothetical protein +FIG01210590 FIG01210591: hypothetical protein +FIG01210592 FIG01210593: hypothetical protein +FIG01210593 FIG01210595: hypothetical protein +FIG01210595 sensor protein +FIG01210597 FIG01210598: hypothetical protein +FIG01210599 FIG01210600: hypothetical protein +FIG01210600 FIG01210602: hypothetical protein +FIG01210603 FIG01210604: hypothetical protein +FIG01210604 FIG01210607: hypothetical protein +FIG01210607 FIG01210608: hypothetical protein +FIG01210611 FIG01210612: hypothetical protein +FIG01210618 FIG01210619: hypothetical protein +FIG01210619 FIG01210620: hypothetical protein +FIG01210620 FIG01210621: hypothetical protein +FIG01210621 FIG01210625: hypothetical protein +FIG01210628 FIG01210629: hypothetical protein +FIG01210635 FIG01210636: hypothetical protein +FIG01210638 FIG01210639: hypothetical protein +FIG01210640 FIG01210642: hypothetical protein +FIG01210642 FIG01210643: hypothetical protein +FIG01210643 FIG01210644: hypothetical protein +FIG01210644 FIG01210646: hypothetical protein +FIG01210646 FIG01210647: hypothetical protein +FIG01210647 iron receptor +FIG01210652 FIG01210654: hypothetical protein +FIG01210654 FIG01210655: hypothetical protein +FIG01210655 FIG01210656: hypothetical protein +FIG01210656 FIG01210657: hypothetical protein +FIG01210657 FIG01210658: hypothetical protein +FIG01210658 FIG01210662: hypothetical protein +FIG01210662 FIG01210663: hypothetical protein +FIG01210663 FIG01210664: hypothetical protein +FIG01210669 alanyl dipeptidyl peptidase +FIG01210671 FIG01210672: hypothetical protein +FIG01210676 FIG01210677: hypothetical protein +FIG01210677 FIG01210679: hypothetical protein +FIG01210679 FIG01210680: hypothetical protein +FIG01210680 FIG01210681: hypothetical protein +FIG01210681 Xanthomonadin biosynthesis related protein +FIG01210686 TPR domain/sulfotransferase domain protein +FIG01210689 FIG01210690: hypothetical protein +FIG01210690 FIG01210691: hypothetical protein +FIG01210691 FIG01210693: hypothetical protein +FIG01210696 FIG01210697: hypothetical protein +FIG01210698 Possible GRAM domain +FIG01210702 FIG01210704: hypothetical protein +FIG01210704 FIG01210705: hypothetical protein +FIG01210705 FIG01210706: hypothetical protein +FIG01210706 FIG01210707: hypothetical protein +FIG01210707 FIG01210708: hypothetical protein +FIG01210709 FIG01210710: hypothetical protein +FIG01210714 Glycosyltransferase family A (GT-A) +FIG01210715 FIG01210716: hypothetical protein +FIG01210716 FIG01210717: hypothetical protein +FIG01210717 ATP dependent RNA helicase +FIG01210718 Regulatory protein virG +FIG01210720 Mlr6856 protein +FIG01210721 FIG01210722: hypothetical protein +FIG01210722 FIG01210725: hypothetical protein +FIG01210725 FIG01210726: hypothetical protein +FIG01210730 FIG01210733: hypothetical protein +FIG01210734 FIG01210735: hypothetical protein +FIG01210736 FIG01210737: hypothetical protein +FIG01210737 FIG01210738: hypothetical protein +FIG01210738 multidrug resistance efflux pump +FIG01210739 hypothetical protein +FIG01210740 FIG01210741: hypothetical protein +FIG01210741 FIG01210742: hypothetical protein +FIG01210742 transcriptional regulator lacI family +FIG01210743 FIG01210744: hypothetical protein +FIG01210744 FIG01210746: hypothetical protein +FIG01210746 FIG01210747: hypothetical protein +FIG01210748 Cell filamentation protein Fic +FIG01210750 FIG01210751: hypothetical protein +FIG01210754 FIG01210755: hypothetical protein +FIG01210755 FIG01210756: hypothetical protein +FIG01210756 FIG01210757: hypothetical protein +FIG01210757 FIG01210758: hypothetical protein +FIG01210759 FIG01210760: hypothetical protein +FIG01210763 FIG01210764: hypothetical protein +FIG01210766 FIG01210768: hypothetical protein +FIG01210768 Cyclomaltodextrin glucanotransferase +FIG01210769 endonuclease precursor +FIG01210770 Mlr4646 protein +FIG01210772 FIG01210773: hypothetical protein +FIG01210773 FIG01210774: hypothetical protein +FIG01210774 FIG01210775: hypothetical protein +FIG01210775 FIG01210776: hypothetical protein +FIG01210776 FIG01210777: hypothetical protein +FIG01210777 FIG01210778: hypothetical protein +FIG01210778 sulfur deprivation response regulator +FIG01210779 FIG01210780: hypothetical protein +FIG01210780 FIG01210781: hypothetical protein +FIG01210783 FIG01210784: hypothetical protein +FIG01210784 Dihydrokaempferol 4-reductase (EC 1.1.1.219) +FIG01210786 FIG01210787: hypothetical protein +FIG01210790 FIG01210791: hypothetical protein +FIG01210791 transcriptional regulator uid family +FIG01210792 FIG01210796: hypothetical protein +FIG01210797 FIG01210799: hypothetical protein +FIG01210802 FIG01210803: hypothetical protein +FIG01210803 FIG01210804: hypothetical protein +FIG01210811 FIG01210813: hypothetical protein +FIG01210815 aklaviketone reductase +FIG01210816 FIG01210817: hypothetical protein +FIG01210819 FIG01210820: hypothetical protein +FIG01210820 FIG01210821: hypothetical protein +FIG01210821 FIG01210822: hypothetical protein +FIG01210822 FIG01210824: hypothetical protein +FIG01210825 FIG01210826: hypothetical protein +FIG01210826 FIG01210827: hypothetical protein +FIG01210827 FIG01210828: hypothetical protein +FIG01210828 FIG01210829: hypothetical protein +FIG01210830 FIG01210832: hypothetical protein +FIG01210833 FIG01210834: hypothetical protein +FIG01210835 hypothetical protein +FIG01210836 FIG00958223: hypothetical protein +FIG01210840 FIG01210842: hypothetical protein +FIG01210842 FIG01210843: hypothetical protein +FIG01210847 FIG01210848: hypothetical protein +FIG01210848 phosphatidylserine decarboxylase +FIG01210850 FIG01210851: hypothetical protein +FIG01210851 FIG01210852: hypothetical protein +FIG01210852 FIG01210853: hypothetical protein +FIG01210853 FIG01210854: hypothetical protein +FIG01210854 cath1 +FIG01210855 FIG01210856: hypothetical protein +FIG01210856 FIG01210860: hypothetical protein +FIG01210861 FIG01210862: hypothetical protein +FIG01210862 FIG01210863: hypothetical protein +FIG01210863 FIG01210864: hypothetical protein +FIG01210865 FIG01210866: hypothetical protein +FIG01210866 FIG01210868: hypothetical protein +FIG01210868 FIG01210869: hypothetical protein +FIG01210869 protease IV +FIG01210870 FIG01210871: hypothetical protein +FIG01210873 FIG01210875: hypothetical protein +FIG01210875 FIG01210876: hypothetical protein +FIG01210876 FIG01210877: hypothetical protein +FIG01210878 FIG01210879: hypothetical protein +FIG01210879 FIG01210880: hypothetical protein +FIG01210880 outer membrane protein +FIG01210882 FIG01210884: hypothetical protein +FIG01210884 FIG01210885: hypothetical protein +FIG01210885 Transducer protein car +FIG01210886 FIG01210888: hypothetical protein +FIG01210890 FIG01210891: hypothetical protein +FIG01210899 FIG01210903: hypothetical protein +FIG01210903 FIG01210904: hypothetical protein +FIG01210905 FIG01210906: hypothetical protein +FIG01210906 FIG01210907: hypothetical protein +FIG01210910 FIG01210913: hypothetical protein +FIG01210913 FIG01210916: hypothetical protein +FIG01210919 FIG01210920: hypothetical protein +FIG01210922 FIG01210923: hypothetical protein +FIG01210923 FIG01210924: hypothetical protein +FIG01210924 FIG01210925: hypothetical protein +FIG01210927 FIG01210928: hypothetical protein +FIG01210929 FIG01210931: hypothetical protein +FIG01210934 FIG01210935: hypothetical protein +FIG01210942 FIG01210943: hypothetical protein +FIG01210943 FIG01210947: hypothetical protein +FIG01210947 FIG01210949: hypothetical protein +FIG01210949 FIG01210950: hypothetical protein +FIG01210950 Flagellar motor protein +FIG01210951 FIG01210954: hypothetical protein +FIG01210954 FIG01210955: hypothetical protein +FIG01210958 FIG01210959: hypothetical protein +FIG01210959 FIG01210960: hypothetical protein +FIG01210960 FIG01210964: hypothetical protein +FIG01210965 FIG01210966: hypothetical protein +FIG01210966 FIG01210967: hypothetical protein +FIG01210967 FIG01210969: hypothetical protein +FIG01210973 ferric enterobactin receptor +FIG01210978 FIG01210979: hypothetical protein +FIG01210979 FIG01210980: hypothetical protein +FIG01210981 FIG01210984: hypothetical protein +FIG01210984 FIG01210986: hypothetical protein +FIG01210986 FIG01210987: hypothetical protein +FIG01210987 FIG01210989: hypothetical protein +FIG01210989 FIG01210990: hypothetical protein +FIG01210990 FIG01210993: hypothetical protein +FIG01210993 FIG01210995: hypothetical protein +FIG01210995 FIG01210998: hypothetical protein +FIG01210998 FIG01210999: hypothetical protein +FIG01210999 FIG01211000: hypothetical protein +FIG01211000 FIG01211001: hypothetical protein +FIG01211001 FIG01211002: hypothetical protein +FIG01211002 FIG01211003: hypothetical protein +FIG01211003 quinone reductase +FIG01211005 FIG01211006: hypothetical protein +FIG01211011 FIG01211013: hypothetical protein +FIG01211013 FIG01211014: hypothetical protein +FIG01211015 FIG01211016: hypothetical protein +FIG01211017 FIG01211019: hypothetical protein +FIG01211020 FIG01211021: hypothetical protein +FIG01211021 FIG01211022: hypothetical protein +FIG01211023 Transcriptional regulator pbsX family +FIG01211027 FIG01211029: hypothetical protein +FIG01211030 FIG01211031: hypothetical protein +FIG01211031 FIG01211032: hypothetical protein +FIG01211032 FIG01211035: hypothetical protein +FIG01211035 FIG01211036: hypothetical protein +FIG01211036 FIG01211038: hypothetical protein +FIG01211038 FIG01211039: hypothetical protein +FIG01211041 FIG01211042: hypothetical protein +FIG01211042 FIG01211043: hypothetical protein +FIG01211046 FIG01211048: hypothetical protein +FIG01211049 FIG01211050: hypothetical protein +FIG01211054 FIG01211055: hypothetical protein +FIG01211055 FIG01211056: hypothetical protein +FIG01211057 FIG01211058: hypothetical protein +FIG01211058 FIG01211061: hypothetical protein +FIG01211061 FIG01211062: hypothetical protein +FIG01211064 FIG01211065: hypothetical protein +FIG01211065 FIG01211066: hypothetical protein +FIG01211066 FIG01211067: hypothetical protein +FIG01211067 FIG01211068: hypothetical protein +FIG01211068 FIG01211069: hypothetical protein +FIG01211073 FIG01211074: hypothetical protein +FIG01211076 FIG01211077: hypothetical protein +FIG01211077 FIG01211080: hypothetical protein +FIG01211083 FIG01211085: hypothetical protein +FIG01211085 FIG01211086: hypothetical protein +FIG01211086 FIG01211087: hypothetical protein +FIG01211087 FIG01211089: hypothetical protein +FIG01211089 Ferredoxin II +FIG01211090 FIG01211091: hypothetical protein +FIG01211091 FIG01211092: hypothetical protein +FIG01211092 FIG01211096: hypothetical protein +FIG01211096 FIG01211097: hypothetical protein +FIG01211097 FIG01211101: hypothetical protein +FIG01211102 FIG01211103: hypothetical protein +FIG01211103 FIG01211104: hypothetical protein +FIG01211104 FIG01211108: hypothetical protein +FIG01211113 FIG01211114: hypothetical protein +FIG01211114 Gll1489 protein +FIG01211116 FIG01211119: hypothetical protein +FIG01211119 FIG01211120: hypothetical protein +FIG01211120 FIG01211121: hypothetical protein +FIG01211123 FIG01211124: hypothetical protein +FIG01211124 ferrous iron transport protein +FIG01211128 FIG01211129: hypothetical protein +FIG01211129 FIG01211130: hypothetical protein +FIG01211134 FIG01211136: hypothetical protein +FIG01211138 FIG01211140: hypothetical protein +FIG01211141 FIG01211142: hypothetical protein +FIG01211142 FIG01211145: hypothetical protein +FIG01211148 FIG01211150: hypothetical protein +FIG01211150 FIG01211151: hypothetical protein +FIG01211151 FIG01211153: hypothetical protein +FIG01211153 FIG01211154: hypothetical protein +FIG01211154 FIG01211155: hypothetical protein +FIG01211155 FIG01211156: hypothetical protein +FIG01211156 FIG01211160: hypothetical protein +FIG01211163 FIG01211164: hypothetical protein +FIG01211164 Possible monoamine oxidase +FIG01211165 sensor kinase +FIG01211167 FIG01211168: hypothetical protein +FIG01211169 FIG01211170: hypothetical protein +FIG01211172 FIG01211173: hypothetical protein +FIG01211173 bleomycin resistance protein +FIG01211175 FIG01211176: hypothetical protein +FIG01211179 FIG01211180: hypothetical protein +FIG01211180 FIG01211182: hypothetical protein +FIG01211184 FIG01211186: hypothetical protein +FIG01211190 FIG01211191: hypothetical protein +FIG01211191 sal operon transcriptional repressor +FIG01211198 Rhamnogalacturonate lyase precursor (EC 4.2.2.-) +FIG01211201 FIG01211203: hypothetical protein +FIG01211203 Mannan endo-1,4-beta-mannosidase +FIG01211204 FIG01211207: hypothetical protein +FIG01211207 FIG01211208: hypothetical protein +FIG01211208 FIG01211209: hypothetical protein +FIG01211209 FIG01211211: hypothetical protein +FIG01211212 FIG01211213: hypothetical protein +FIG01211213 FIG01211216: hypothetical protein +FIG01211219 FIG01211220: hypothetical protein +FIG01211220 FIG01211221: hypothetical protein +FIG01211221 FIG01211222: hypothetical protein +FIG01211222 FIG01211223: hypothetical protein +FIG01211228 cytochrome C biogenesis protein +FIG01211231 FIG01211232: hypothetical protein +FIG01211232 FIG01211233: hypothetical protein +FIG01211233 FIG01211236: hypothetical protein +FIG01211236 FIG01211238: hypothetical protein +FIG01211238 FIG01211240: hypothetical protein +FIG01211240 VirP protein +FIG01211241 FIG01211242: hypothetical protein +FIG01211242 FIG01211243: hypothetical protein +FIG01211243 FIG01211244: hypothetical protein +FIG01211244 FIG01211245: hypothetical protein +FIG01211245 FIG01211249: hypothetical protein +FIG01211249 Magnesium and cobalt transport protein CorA +FIG01211252 FIG01211253: hypothetical protein +FIG01211256 FIG01117206: hypothetical protein +FIG01211257 FIG01211258: hypothetical protein +FIG01211258 FIG01211259: hypothetical protein +FIG01211259 FIG01211260: hypothetical protein +FIG01211260 FIG01211261: hypothetical protein +FIG01211261 FIG01211262: hypothetical protein +FIG01211263 FIG01211269: hypothetical protein +FIG01211271 FIG01211273: hypothetical protein +FIG01211273 FIG01211274: hypothetical protein +FIG01211274 FIG01211278: hypothetical protein +FIG01211278 FIG01211280: hypothetical protein +FIG01211280 FIG01211282: hypothetical protein +FIG01211282 ribonuclease +FIG01211285 FIG01211287: hypothetical protein +FIG01211287 FIG01211288: hypothetical protein +FIG01211289 FIG01211290: hypothetical protein +FIG01211290 leucin rich protein +FIG01211302 histone +FIG01211303 FIG01211305: hypothetical protein +FIG01211307 FIG01211308: hypothetical protein +FIG01211310 Staphylolytic protease preproenzyme LasA +FIG01211312 Macrophage infectivity potentiator +FIG01211313 FIG01211315: hypothetical protein +FIG01211315 FIG01211317: hypothetical protein +FIG01211317 UptF protein +FIG01211318 FIG01211319: hypothetical protein +FIG01211319 FIG01211321: hypothetical protein +FIG01211327 FIG01211328: hypothetical protein +FIG01211328 FIG01211329: hypothetical protein +FIG01211329 FIG01211332: hypothetical protein +FIG01211334 two-component system regulatory protein +FIG01211336 FIG01211340: hypothetical protein +FIG01211342 FIG01211343: hypothetical protein +FIG01211343 FIG01211346: hypothetical protein +FIG01211346 FIG01211347: hypothetical protein +FIG01211347 FIG01211351: hypothetical protein +FIG01211352 FIG01211353: hypothetical protein +FIG01211354 FIG01211355: hypothetical protein +FIG01211355 FIG01211357: hypothetical protein +FIG01211357 FIG01211359: hypothetical protein +FIG01211361 Peptide synthase +FIG01211364 FIG01211365: hypothetical protein +FIG01211366 FIG01211368: hypothetical protein +FIG01211371 FIG01211373: hypothetical protein +FIG01211373 FIG01211374: hypothetical protein +FIG01211374 FIG01211375: hypothetical protein +FIG01211381 FIG01211383: hypothetical protein +FIG01211383 FIG01211385: hypothetical protein +FIG01211385 FIG01211386: hypothetical protein +FIG01211386 FIG01211388: hypothetical protein +FIG01211388 FIG01211390: hypothetical protein +FIG01211390 FIG01211391: hypothetical protein +FIG01211393 FIG01211394: hypothetical protein +FIG01211398 FIG01211400: hypothetical protein +FIG01211400 FIG01211401: hypothetical protein +FIG01211401 FIG01211403: hypothetical protein +FIG01211403 FIG01211404: hypothetical protein +FIG01211404 FIG01211407: hypothetical protein +FIG01211410 FIG01211412: hypothetical protein +FIG01211414 FIG01211415: hypothetical protein +FIG01211420 FIG01211421: hypothetical protein +FIG01211421 Nodulation protein L (EC 2.3.1.-) +FIG01211423 FIG01211425: hypothetical protein +FIG01211425 putative membrane fusion protein RaxA +FIG01211427 FIG01211428: hypothetical protein +FIG01211428 FIG01211429: hypothetical protein +FIG01211435 FIG01211436: hypothetical protein +FIG01211438 FIG01211439: hypothetical protein +FIG01211445 FIG01211446: hypothetical protein +FIG01211448 FIG01211451: hypothetical protein +FIG01211453 FIG01211454: hypothetical protein +FIG01211454 FIG01211456: hypothetical protein +FIG01211458 acetoin utilization family protein +FIG01211459 dipeptidyl peptidase IV +FIG01211462 FIG01211464: hypothetical protein +FIG01211469 FIG01211470: hypothetical protein +FIG01211472 FIG01211473: hypothetical protein +FIG01211473 FIG01211474: hypothetical protein +FIG01211478 FIG01211480: hypothetical protein +FIG01211481 FIG01211482: hypothetical protein +FIG01211482 FIG01211483: hypothetical protein +FIG01211483 FIG01211485: hypothetical protein +FIG01211485 FIG01211486: hypothetical protein +FIG01211486 metabolite/H symporter, major facilitator superfamily (MFS) +FIG01211490 FIG01211492: hypothetical protein +FIG01211495 FIG01211497: hypothetical protein +FIG01211497 FIG01211498: hypothetical protein +FIG01211499 FIG01211500: hypothetical protein +FIG01211503 FIG01211504: hypothetical protein +FIG01211505 FIG01211507: hypothetical protein +FIG01211507 FIG01211508: hypothetical protein +FIG01211508 hypothetical protein +FIG01211512 methylated-DNA-protein-cysteine S-methyltransferase related protein +FIG01211513 FIG01211514: hypothetical protein +FIG01211522 FIG01211524: hypothetical protein +FIG01211524 FIG01211525: hypothetical protein +FIG01211525 tryptophan-rich sensory protein +FIG01211528 FIG01211529: hypothetical protein +FIG01211530 FIG01211532: hypothetical protein +FIG01211532 FIG01211536: hypothetical protein +FIG01211536 cytochrome like B561 +FIG01211538 FIG01211539: hypothetical protein +FIG01211539 FIG01211540: hypothetical protein +FIG01211541 FIG01211544: hypothetical protein +FIG01211546 FIG01211547: hypothetical protein +FIG01211551 FIG01211553: hypothetical protein +FIG01211562 FIG01211564: hypothetical protein +FIG01211564 FIG01211567: hypothetical protein +FIG01211567 FIG01211572: hypothetical protein +FIG01211572 outer membrane lipoprotein +FIG01211575 FIG01211576: hypothetical protein +FIG01211577 FIG01211579: hypothetical protein +FIG01211581 fusaric acid resistance protein +FIG01211582 FIG01211583: hypothetical protein +FIG01211583 FIG01211586: hypothetical protein +FIG01211587 FIG01211588: hypothetical protein +FIG01211588 FIG01211589: hypothetical protein +FIG01211590 FIG01211591: hypothetical protein +FIG01211595 FIG01211597: hypothetical protein +FIG01211597 FIG01211598: hypothetical protein +FIG01211598 FIG01211599: hypothetical protein +FIG01211600 FIG01211603: hypothetical protein +FIG01211603 FIG01211604: hypothetical protein +FIG01211604 FIG01211605: hypothetical protein +FIG01211605 FIG01211606: hypothetical protein +FIG01211606 FIG01211607: hypothetical protein +FIG01211607 FIG01211609: hypothetical protein +FIG01211609 FIG01211610: hypothetical protein +FIG01211614 FIG01211615: hypothetical protein +FIG01211615 FIG01211616: hypothetical protein +FIG01211616 FIG01211617: hypothetical protein +FIG01211619 FIG01211621: hypothetical protein +FIG01211621 carboxylesterase type B +FIG01211626 FIG01211627: hypothetical protein +FIG01211629 FIG01211631: hypothetical protein +FIG01211635 FIG01211636: hypothetical protein +FIG01211636 FIG01211637: hypothetical protein +FIG01211639 nucleotidyl transferase +FIG01211641 FIG01211643: hypothetical protein +FIG01211643 FIG01211644: hypothetical protein +FIG01211644 FIG01211646: hypothetical protein +FIG01211646 FIG01211647: hypothetical protein +FIG01211647 dicarboxylate transport protein +FIG01211648 FIG01211650: hypothetical protein +FIG01211650 FIG01211652: hypothetical protein +FIG01211653 FIG01211658: hypothetical protein +FIG01211658 FIG01211660: hypothetical protein +FIG01211660 FIG01211662: hypothetical protein +FIG01211662 FIG01211663: hypothetical protein +FIG01211664 FIG01211665: hypothetical protein +FIG01211665 FIG01211666: hypothetical protein +FIG01211667 FIG01211668: hypothetical protein +FIG01211673 FIG00952399: hypothetical protein +FIG01211676 FIG01211678: hypothetical protein +FIG01211678 photolyase protein family +FIG01211679 FIG01211680: hypothetical protein +FIG01211681 FIG01211682: hypothetical protein +FIG01211682 FIG01211683: hypothetical protein +FIG01211685 FIG01211686: hypothetical protein +FIG01211686 FIG01211687: hypothetical protein +FIG01211687 FIG01211689: hypothetical protein +FIG01211690 FIG01211692: hypothetical protein +FIG01211693 NapD +FIG01211694 putative hexuronate transporter +FIG01211696 acetylxylan esterase +FIG01211699 FIG01211701: hypothetical protein +FIG01211702 FIG01211703: hypothetical protein +FIG01211707 FIG01211711: hypothetical protein +FIG01211712 FIG01211713: hypothetical protein +FIG01211713 Trypsin-like serine proteases, typically periplasmic, contain C-terminal PDZ domain +FIG01211717 FIG01211718: hypothetical protein +FIG01211718 FIG01211719: hypothetical protein +FIG01211726 FIG01211728: hypothetical protein +FIG01211728 FIG01211730: hypothetical protein +FIG01211730 Anti-sigma F factor antagonist (spoIIAA-2); Anti-sigma B factor antagonist RsbV +FIG01211733 FIG01211734: hypothetical protein +FIG01211735 FIG01211736: hypothetical protein +FIG01211742 FIG01211745: hypothetical protein +FIG01211745 FIG01211748: hypothetical protein +FIG01211748 FIG01211750: hypothetical protein +FIG01211750 FIG01211751: hypothetical protein +FIG01211751 FIG01211755: hypothetical protein +FIG01211755 hypothetical protein +FIG01211757 FIG01211758: hypothetical protein +FIG01211761 phospholipase A1 +FIG01211763 FIG01211764: hypothetical protein +FIG01211764 FIG01211765: hypothetical protein +FIG01211769 FIG01211770: hypothetical protein +FIG01211772 FIG01211775: hypothetical protein +FIG01211777 FIG01211780: hypothetical protein +FIG01211786 FIG01211788: hypothetical protein +FIG01211789 FIG01211790: hypothetical protein +FIG01211791 FIG01211792: hypothetical protein +FIG01211792 biotin synthesis protein +FIG01211794 FIG01211796: hypothetical protein +FIG01211796 FIG01211797: hypothetical protein +FIG01211799 FIG01211801: hypothetical protein +FIG01211801 FhuE receptor precursor +FIG01211804 FIG01211805: hypothetical protein +FIG01211805 lactoylglutathione lyase +FIG01211817 FIG01211818: hypothetical protein +FIG01211818 FIG01211819: hypothetical protein +FIG01211820 FIG01211822: hypothetical protein +FIG01211822 FIG01211823: hypothetical protein +FIG01211827 FIG01211831: hypothetical protein +FIG01211835 FIG01211837: hypothetical protein +FIG01211837 FIG01211838: hypothetical protein +FIG01211838 FIG01211841: hypothetical protein +FIG01211842 FIG01211846: hypothetical protein +FIG01211846 FIG01211847: hypothetical protein +FIG01211847 FIG01211848: hypothetical protein +FIG01211849 FIG01211850: hypothetical protein +FIG01211850 FIG01211851: hypothetical protein +FIG01211851 FIG01211852: hypothetical protein +FIG01211853 FIG01211854: hypothetical protein +FIG01211856 FIG01211857: hypothetical protein +FIG01211857 FIG01211859: hypothetical protein +FIG01211860 FIG01211861: hypothetical protein +FIG01211873 Transport protein +FIG01211876 FIG01211880: hypothetical protein +FIG01211881 probable vgr-related protein +FIG01211885 FIG01211889: hypothetical protein +FIG01211889 FIG01211894: hypothetical protein +FIG01211894 FIG01211898: hypothetical protein +FIG01211898 FIG01211899: hypothetical protein +FIG01211906 FIG01211909: hypothetical protein +FIG01211909 FIG01211910: hypothetical protein +FIG01211910 FIG01211911: hypothetical protein +FIG01211920 FIG01211924: hypothetical protein +FIG01211924 FIG01211927: hypothetical protein +FIG01211928 FIG01211929: hypothetical protein +FIG01211930 FIG01211934: hypothetical protein +FIG01211934 Acyl-CoA thioester hydrolase +FIG01211940 FIG01211941: hypothetical protein +FIG01211943 FIG01211946: hypothetical protein +FIG01211946 FIG01211949: hypothetical protein +FIG01211959 FIG01211960: hypothetical protein +FIG01211960 FIG01211961: hypothetical protein +FIG01211962 FIG01211963: hypothetical protein +FIG01211963 FIG01211965: hypothetical protein +FIG01211966 FIG01211968: hypothetical protein +FIG01211976 FIG01211979: hypothetical protein +FIG01211979 ice nucleation protein +FIG01211980 FIG01211984: hypothetical protein +FIG01211984 FIG01211985: hypothetical protein +FIG01211985 FIG01211988: hypothetical protein +FIG01211988 FIG01211989: hypothetical protein +FIG01211994 PROBABLE HEMAGGLUTININ-RELATED PROTEIN +FIG01211999 FIG01212003: hypothetical protein +FIG01212003 FIG01212004: hypothetical protein +FIG01212006 FIG01212009: hypothetical protein +FIG01212015 FIG01212019: hypothetical protein +FIG01212020 FIG01212021: hypothetical protein +FIG01212021 FIG01212022: hypothetical protein +FIG01212029 FIG01212030: hypothetical protein +FIG01212031 FIG01212033: hypothetical protein +FIG01212033 FIG01212034: hypothetical protein +FIG01212039 FIG01212040: hypothetical protein +FIG01212040 FIG01212044: hypothetical protein +FIG01212044 FIG01212049: hypothetical protein +FIG01212054 FIG01212056: hypothetical protein +FIG01212056 FIG01212058: hypothetical protein +FIG01212058 FIG01212062: hypothetical protein +FIG01212062 FIG01212063: hypothetical protein +FIG01212063 FIG01212065: hypothetical protein +FIG01212071 FIG01212073: hypothetical protein +FIG01212073 FIG01212074: hypothetical protein +FIG01212075 FIG01212077: hypothetical protein +FIG01212077 FIG01212081: hypothetical protein +FIG01212081 FIG01212086: hypothetical protein +FIG01212086 FIG01212087: hypothetical protein +FIG01212087 FIG01212088: hypothetical protein +FIG01212088 accessory protein +FIG01212091 FIG01212093: hypothetical protein +FIG01212093 membrane protein WxcD +FIG01212095 FIG01212096: hypothetical protein +FIG01212096 FIG01212098: hypothetical protein +FIG01212098 FIG01212099: hypothetical protein +FIG01212099 FIG01212100: hypothetical protein +FIG01212105 FIG01212106: hypothetical protein +FIG01212106 FIG01212107: hypothetical protein +FIG01212111 FIG01212112: hypothetical protein +FIG01212114 FIG01212115: hypothetical protein +FIG01212117 FIG01212121: hypothetical protein +FIG01212121 FIG01212122: hypothetical protein +FIG01212126 FIG01212127: hypothetical protein +FIG01212127 FIG01212128: hypothetical protein +FIG01212134 FIG01212138: hypothetical protein +FIG01212139 FIG01212144: hypothetical protein +FIG01212147 FIG01212148: hypothetical protein +FIG01212151 Cellulase +FIG01212153 FIG01212155: hypothetical protein +FIG01212155 FIG01212157: hypothetical protein +FIG01212161 FIG01212163: hypothetical protein +FIG01212165 FIG01212167: hypothetical protein +FIG01212168 FIG01212169: hypothetical protein +FIG01212169 FIG01212171: hypothetical protein +FIG01212177 FIG01212179: hypothetical protein +FIG01212179 FIG01212180: hypothetical protein +FIG01212180 FIG01212181: hypothetical protein +FIG01212190 CDP-diacylglycerol-glycerol-3-phosphate 3-phosphatidyltransferase-related protein +FIG01212193 FIG01212194: hypothetical protein +FIG01212195 FIG01212196: hypothetical protein +FIG01212196 FIG01212198: hypothetical protein +FIG01212198 FIG01212201: hypothetical protein +FIG01212201 FIG01212203: hypothetical protein +FIG01212203 Pheromone shutdown protein +FIG01212207 FIG01212208: hypothetical protein +FIG01212208 FIG01212210: hypothetical protein +FIG01212216 FIG01212223: hypothetical protein +FIG01212223 FIG01212224: hypothetical protein +FIG01212224 FIG01212226: hypothetical protein +FIG01212229 FIG01212230: hypothetical protein +FIG01212230 FIG01212231: hypothetical protein +FIG01212231 FIG01212236: hypothetical protein +FIG01212236 GDB1 like ass w/ COG3533Xanth +FIG01212237 FIG01212239: hypothetical protein +FIG01212239 FIG01212240: hypothetical protein +FIG01212240 histidine kinase-response regulator hybrid protein +FIG01212242 FIG01212244: hypothetical protein +FIG01212244 FIG01212247: hypothetical protein +FIG01212247 FIG01212248: hypothetical protein +FIG01212249 FIG01212251: hypothetical protein +FIG01212251 FIG01212253: hypothetical protein +FIG01212253 FIG01212254: hypothetical protein +FIG01212254 FIG01212258: hypothetical protein +FIG01212258 FIG01212260: hypothetical protein +FIG01212260 FIG01212263: hypothetical protein +FIG01212263 FIG01212264: hypothetical protein +FIG01212264 FIG01212265: hypothetical protein +FIG01212265 FIG01212267: hypothetical protein +FIG01212271 FIG01212272: hypothetical protein +FIG01212272 FIG01212274: hypothetical protein +FIG01212274 FIG01212275: hypothetical protein +FIG01212280 FIG01212281: hypothetical protein +FIG01212286 FIG01212287: hypothetical protein +FIG01212291 export protein +FIG01212297 membrane-bound lytic murein transglycosylase D precursor +FIG01212305 Transcriptional regulator marR family +FIG01212306 FIG01212307: hypothetical protein +FIG01212307 FIG01212308: hypothetical protein +FIG01212309 FIG01212313: hypothetical protein +FIG01212313 FIG01212314: hypothetical protein +FIG01212314 FIG01212315: hypothetical protein +FIG01212315 FIG01212316: hypothetical protein +FIG01212318 Stability protein StdB +FIG01212322 FIG01212323: hypothetical protein +FIG01212323 FIG01212324: hypothetical protein +FIG01212324 FIG01212326: hypothetical protein +FIG01212326 FIG01212330: hypothetical protein +FIG01212330 FIG01212331: hypothetical protein +FIG01212331 FIG01212333: hypothetical protein +FIG01212334 FIG01212335: hypothetical protein +FIG01212338 FIG01212339: hypothetical protein +FIG01212339 Taurine transporter substrate-binding protein +FIG01212343 FIG01212344: hypothetical protein +FIG01212344 FIG01212349: hypothetical protein +FIG01212349 FIG01212351: hypothetical protein +FIG01212363 FIG01212366: hypothetical protein +FIG01212368 FIG01212370: hypothetical protein +FIG01212371 FIG01212373: hypothetical protein +FIG01212377 FIG01212380: hypothetical protein +FIG01212398 FIG01212400: hypothetical protein +FIG01212403 FIG01212404: hypothetical protein +FIG01212410 FIG01212411: hypothetical protein +FIG01212420 FIG01212424: hypothetical protein +FIG01212425 FIG01212427: hypothetical protein +FIG01212428 FIG01212429: hypothetical protein +FIG01212433 FIG01212434: hypothetical protein +FIG01212434 FIG01212435: hypothetical protein +FIG01212435 FIG01212436: hypothetical protein +FIG01212436 FIG01212438: hypothetical protein +FIG01212438 FIG01212439: hypothetical protein +FIG01212439 FIG01212444: hypothetical protein +FIG01212454 FIG01212455: hypothetical protein +FIG01212457 FIG01212458: hypothetical protein +FIG01212462 FIG01212465: hypothetical protein +FIG01212470 FIG01212471: hypothetical protein +FIG01212471 FIG01212472: hypothetical protein +FIG01212472 FIG01212474: hypothetical protein +FIG01212480 FIG01212484: hypothetical protein +FIG01212484 FIG01212486: hypothetical protein +FIG01212486 FIG01212489: hypothetical protein +FIG01212490 FIG01212492: hypothetical protein +FIG01212492 FIG01212494: hypothetical protein +FIG01212496 FIG01212501: hypothetical protein +FIG01212507 FIG01212508: hypothetical protein +FIG01212508 FIG01212511: hypothetical protein +FIG01212513 FIG01212514: hypothetical protein +FIG01212514 FIG01212515: hypothetical protein +FIG01212515 FIG01212516: hypothetical protein +FIG01212516 FIG01212518: hypothetical protein +FIG01212522 FIG01212524: hypothetical protein +FIG01212524 FIG01212525: hypothetical protein +FIG01212526 FIG01212528: hypothetical protein +FIG01212537 transcriptional regulator protein Pai2 +FIG01212539 FIG01212540: hypothetical protein +FIG01212543 FIG01212546: hypothetical protein +FIG01212546 FIG01212547: hypothetical protein +FIG01212551 FIG01212552: hypothetical protein +FIG01212561 FIG01212563: hypothetical protein +FIG01212564 FIG01212567: hypothetical protein +FIG01212567 FIG01212568: hypothetical protein +FIG01212571 FIG01212576: hypothetical protein +FIG01212576 Outer membrane protein GumB, involved in the export of xanthan +FIG01212582 FIG01212583: hypothetical protein +FIG01212601 FIG01212604: hypothetical protein +FIG01212605 protein-glutamate methylesterase +FIG01212608 FIG01212609: hypothetical protein +FIG01212609 FIG01212614: hypothetical protein +FIG01212615 FIG01212616: hypothetical protein +FIG01212616 FIG01212617: hypothetical protein +FIG01212619 hypothetical protein +FIG01212621 FIG01212623: hypothetical protein +FIG01212623 FIG01212624: hypothetical protein +FIG01212624 FIG01212627: hypothetical protein +FIG01212637 FIG01212639: hypothetical protein +FIG01212646 FIG01212647: hypothetical protein +FIG01212648 FIG01212650: hypothetical protein +FIG01212650 FIG01212652: hypothetical protein +FIG01212659 FIG01212664: hypothetical protein +FIG01212670 FIG01212672: hypothetical protein +FIG01212683 FIG01212686: hypothetical protein +FIG01212689 FIG01212690: hypothetical protein +FIG01212691 FIG01212692: hypothetical protein +FIG01212692 xanthomonadin biosynthesis related protein 1 +FIG01212697 FIG01212698: hypothetical protein +FIG01212699 FIG01212701: hypothetical protein +FIG01212701 FIG01212702: hypothetical protein +FIG01212702 tetracenomycin polyketide synthesis protein +FIG01212708 FIG01212709: hypothetical protein +FIG01212713 FIG01212715: hypothetical protein +FIG01212715 FIG01212716: hypothetical protein +FIG01212716 FIG01212717: hypothetical protein +FIG01212717 FIG01212719: hypothetical protein +FIG01212720 FIG01212725: hypothetical protein +FIG01212728 FIG01212731: hypothetical protein +FIG01212735 FIG01212736: hypothetical protein +FIG01212738 FIG01212745: hypothetical protein +FIG01212745 glycosyl hydrolase +FIG01212746 FIG01212747: hypothetical protein +FIG01212755 FIG01212757: hypothetical protein +FIG01212759 FIG01212761: hypothetical protein +FIG01212761 FIG01212762: hypothetical protein +FIG01212762 FIG01212767: hypothetical protein +FIG01212770 FIG01212773: hypothetical protein +FIG01212775 Maf/YceF/YhdE family protein +FIG01212776 FIG01212778: hypothetical protein +FIG01212787 FIG01212791: hypothetical protein +FIG01212792 putative TraA protein +FIG01212796 FIG01212082: hypothetical protein +FIG01212798 FIG01212801: hypothetical protein +FIG01212814 FIG01212816: hypothetical protein +FIG01212816 FIG01212817: hypothetical protein +FIG01212817 Histone acetyltransferase HPA2 and related acetyltransferase +FIG01212818 FIG01212821: hypothetical protein +FIG01212823 FIG01212824: hypothetical protein +FIG01212824 FIG01212826: hypothetical protein +FIG01212826 FIG01212827: hypothetical protein +FIG01212827 FIG01212828: hypothetical protein +FIG01212828 Glycosyl hydrolase +FIG01212832 FIG01212834: hypothetical protein +FIG01212835 FIG01212836: hypothetical protein +FIG01212836 FIG01212838: hypothetical protein +FIG01212838 FIG01212839: hypothetical protein +FIG01212842 FIG01212844: hypothetical protein +FIG01212846 FIG01212847: hypothetical protein +FIG01212847 FIG01212848: hypothetical protein +FIG01212848 FIG01212850: hypothetical protein +FIG01212859 FIG01212860: hypothetical protein +FIG01212860 FIG01212861: hypothetical protein +FIG01212861 FIG01212862: hypothetical protein +FIG01212863 Isopenicillin N epimerase (EC 5.1.1.17) +FIG01212883 FIG01212884: hypothetical protein +FIG01212889 FIG01212891: hypothetical protein +FIG01212899 FIG01212901: hypothetical protein +FIG01212901 FIG01212902: hypothetical protein +FIG01212902 FIG01212903: hypothetical protein +FIG01212907 Serine peptidase +FIG01212909 FIG01212910: hypothetical protein +FIG01212910 FIG01212911: hypothetical protein +FIG01212911 FIG01212913: hypothetical protein +FIG01212916 FIG01212917: hypothetical protein +FIG01212919 FIG01212920: hypothetical protein +FIG01212920 FIG01212921: hypothetical protein +FIG01212925 FIG01212927: hypothetical protein +FIG01212929 FIG01212930: hypothetical protein +FIG01212932 FIG01212933: hypothetical protein +FIG01212933 FIG01212935: hypothetical protein +FIG01212939 FIG01212944: hypothetical protein +FIG01212952 FIG01212953: hypothetical protein +FIG01212961 FIG01212962: hypothetical protein +FIG01212965 endo-1,3-beta-glucanase precursor +FIG01212967 FIG01212968: hypothetical protein +FIG01212970 FIG01212972: hypothetical protein +FIG01212972 FIG01212975: hypothetical protein +FIG01212975 FIG01212976: hypothetical protein +FIG01212976 FIG01212978: hypothetical protein +FIG01212978 FIG01212980: hypothetical protein +FIG01212980 FIG01212982: hypothetical protein +FIG01212983 FIG01212985: hypothetical protein +FIG01212985 FIG01212986: hypothetical protein +FIG01212986 FIG01212993: hypothetical protein +FIG01212997 FIG01212998: hypothetical protein +FIG01212998 FIG01213001: hypothetical protein +FIG01213001 FIG01213002: hypothetical protein +FIG01213003 FIG01213006: hypothetical protein +FIG01213009 cointegrate resolution protein T +FIG01213012 putative anaerobic transcriptional regulatory protein +FIG01213017 FIG01213020: hypothetical protein +FIG01213020 FIG01213021: hypothetical protein +FIG01213023 FIG01213027: hypothetical protein +FIG01213027 FIG01213029: hypothetical protein +FIG01213029 FIG01213031: hypothetical protein +FIG01213031 FIG01213032: hypothetical protein +FIG01213041 FIG01213045: hypothetical protein +FIG01213045 FIG01213046: hypothetical protein +FIG01213046 peptidyl-Asp metalloendopeptidase +FIG01213047 FIG01213048: hypothetical protein +FIG01213056 FIG01213057: hypothetical protein +FIG01213069 FIG01213070: hypothetical protein +FIG01213079 FIG01213081: hypothetical protein +FIG01213082 FIG01213086: hypothetical protein +FIG01213087 FIG01213088: hypothetical protein +FIG01213088 FIG01213094: hypothetical protein +FIG01213101 FIG01213103: hypothetical protein +FIG01213104 FIG01213106: hypothetical protein +FIG01213117 FIG01213118: hypothetical protein +FIG01213123 pectate lyase E +FIG01213126 FIG01213127: hypothetical protein +FIG01213127 FIG01213131: hypothetical protein +FIG01213134 Phosphoanhydride phosphohydrolase +FIG01213157 FIG01213161: hypothetical protein +FIG01213161 FIG01213162: hypothetical protein +FIG01213163 VGR-related protein +FIG01213166 FIG01213168: hypothetical protein +FIG01213171 FIG01213172: hypothetical protein +FIG01213175 FIG01213181: hypothetical protein +FIG01213186 FIG01213190: hypothetical protein +FIG01213194 Putative transmembrane oxidoreductase protein +FIG01213195 FIG01213196: hypothetical protein +FIG01213196 FIG01213199: hypothetical protein +FIG01213204 FIG01213206: hypothetical protein +FIG01213206 FIG01213207: hypothetical protein +FIG01213213 Metallopeptidase +FIG01213214 FIG01213217: hypothetical protein +FIG01213220 FIG01213221: hypothetical protein +FIG01213224 FIG01213225: hypothetical protein +FIG01213233 Phi-Lf prophage-derived helix-destabilizing protein +FIG01213240 FIG01213241: hypothetical protein +FIG01213243 FIG01213245: hypothetical protein +FIG01213247 FIG01213248: hypothetical protein +FIG01213256 FIG01213257: hypothetical protein +FIG01213258 FIG01213259: hypothetical protein +FIG01213269 FIG01213271: hypothetical protein +FIG01213271 FIG01213272: hypothetical protein +FIG01213290 FIG01213300: hypothetical protein +FIG01213300 FIG01213304: hypothetical protein +FIG01213304 FIG01213307: hypothetical protein +FIG01213307 cytochrome P450 hydroxylase +FIG01213313 FIG01213315: hypothetical protein +FIG01213329 FIG01213330: hypothetical protein +FIG01213332 FIG01213333: hypothetical protein +FIG01213337 FIG01213341: hypothetical protein +FIG01213341 FIG01213346: hypothetical protein +FIG01213346 FIG01213350: hypothetical protein +FIG01213352 FIG01213354: hypothetical protein +FIG01213354 FIG01213355: hypothetical protein +FIG01213355 FIG01213357: hypothetical protein +FIG01213357 FIG01213358: hypothetical protein +FIG01213362 FIG01213367: hypothetical protein +FIG01213379 XamI DNA methyltransferase +FIG01213384 FIG01213386: hypothetical protein +FIG01213387 FIG01213388: hypothetical protein +FIG01213394 FIG01213399: hypothetical protein +FIG01213399 FIG01213402: hypothetical protein +FIG01213411 FIG01213414: hypothetical protein +FIG01213420 FIG01213421: hypothetical protein +FIG01213427 FIG01213429: hypothetical protein +FIG01213433 FIG01213435: hypothetical protein +FIG01213435 FIG01213437: hypothetical protein +FIG01213439 FIG01213440: hypothetical protein +FIG01213440 FIG01213443: hypothetical protein +FIG01213445 FIG01213448: hypothetical protein +FIG01213452 FIG01213454: hypothetical protein +FIG01213458 FIG01213460: hypothetical protein +FIG01213470 FIG01213474: hypothetical protein +FIG01213478 FIG01213480: hypothetical protein +FIG01213484 FIG01213485: hypothetical protein +FIG01213488 FIG01213490: hypothetical protein +FIG01213501 FIG01213502: hypothetical protein +FIG01213502 FIG01213506: hypothetical protein +FIG01213507 FIG01213510: hypothetical protein +FIG01213510 FIG01213513: hypothetical protein +FIG01213513 FIG01213514: hypothetical protein +FIG01213528 FIG01213529: hypothetical protein +FIG01213529 hypothetical protein +FIG01213530 FIG01213532: hypothetical protein +FIG01213547 FIG01219358: hypothetical protein +FIG01213567 FIG01213569: hypothetical protein +FIG01213569 FIG01213571: hypothetical protein +FIG01213571 FIG01213574: hypothetical protein +FIG01213589 FIG01213594: hypothetical protein +FIG01213594 FIG01213595: hypothetical protein +FIG01213598 FIG01213599: hypothetical protein +FIG01213600 FIG01213603: hypothetical protein +FIG01213603 FIG01213604: hypothetical protein +FIG01213605 FIG01213608: hypothetical protein +FIG01213608 FIG01213612: hypothetical protein +FIG01213615 FIG01213620: hypothetical protein +FIG01213622 FIG01213626: hypothetical protein +FIG01213626 FIG01213627: hypothetical protein +FIG01213634 FIG01213635: hypothetical protein +FIG01213637 FIG01213638: hypothetical protein +FIG01213638 FIG01213639: hypothetical protein +FIG01213651 FIG01213653: hypothetical protein +FIG01213653 FIG01213654: hypothetical protein +FIG01213663 FIG01213664: hypothetical protein +FIG01213664 FIG01213665: hypothetical protein +FIG01213666 FIG01213668: hypothetical protein +FIG01213669 FIG01213670: hypothetical protein +FIG01213670 FIG01213671: hypothetical protein +FIG01213671 FIG01213672: hypothetical protein +FIG01213683 Renal dipeptidase family protein +FIG01213689 FIG01213692: hypothetical protein +FIG01213696 FIG01213697: hypothetical protein +FIG01213698 Leucine-rich-repeat protein +FIG01213710 FIG01213713: hypothetical protein +FIG01213713 FIG01213714: hypothetical protein +FIG01213722 FIG01213725: hypothetical protein +FIG01213725 FIG01213727: hypothetical protein +FIG01213733 FIG01213735: hypothetical protein +FIG01213739 FIG01213741: hypothetical protein +FIG01213749 FIG01213750: hypothetical protein +FIG01213750 FIG01213751: hypothetical protein +FIG01213751 FIG01213753: hypothetical protein +FIG01213754 FIG01213755: hypothetical protein +FIG01213755 FIG01213756: hypothetical protein +FIG01213757 FIG01213758: hypothetical protein +FIG01213758 FIG01213761: hypothetical protein +FIG01213763 FIG01213768: hypothetical protein +FIG01213777 FIG01211659: hypothetical protein +FIG01213780 FIG01213781: hypothetical protein +FIG01213781 FIG01213782: hypothetical protein +FIG01213796 FIG01213797: hypothetical protein +FIG01213797 FIG01213803: hypothetical protein +FIG01213807 FIG01213809: hypothetical protein +FIG01213817 FIG01213819: hypothetical protein +FIG01213819 FIG01213820: hypothetical protein +FIG01213825 FIG01213826: hypothetical protein +FIG01213866 FIG01213870: hypothetical protein +FIG01213872 FIG01213873: hypothetical protein +FIG01213874 FIG01213878: hypothetical protein +FIG01213885 FIG01213888: hypothetical protein +FIG01213888 FIG01213894: hypothetical protein +FIG01213907 FIG01213909: hypothetical protein +FIG01213911 FIG01213912: hypothetical protein +FIG01213915 FIG01213917: hypothetical protein +FIG01213923 FIG01213925: hypothetical protein +FIG01213947 FIG01213948: hypothetical protein +FIG01213960 FIG01213962: hypothetical protein +FIG01213964 FIG01213967: hypothetical protein +FIG01213967 FIG01213976: hypothetical protein +FIG01213994 FIG01213998: hypothetical protein +FIG01214008 FIG01214009: hypothetical protein +FIG01214009 FIG01214012: hypothetical protein +FIG01214020 FIG01214022: hypothetical protein +FIG01214038 FIG01214042: hypothetical protein +FIG01214042 FIG01214043: hypothetical protein +FIG01214045 avirulence protein +FIG01214062 FIG01214064: hypothetical protein +FIG01214085 serine peptidase +FIG01214091 FIG01214097: hypothetical protein +FIG01214104 FIG01214108: hypothetical protein +FIG01214126 wall associated protein +FIG01214151 Lysyl-lysine 2,3-aminomutase +FIG01214154 FIG01214159: hypothetical protein +FIG01214159 long-chain acyl-CoA synthetase +FIG01214164 FIG01214167: hypothetical protein +FIG01214170 FIG01214172: hypothetical protein +FIG01214179 FIG01214182: hypothetical protein +FIG01214199 fumarate and nitrate reduction regulatory protein +FIG01214200 FIG01214202: hypothetical protein +FIG01214202 FIG01214203: hypothetical protein +FIG01214216 FIG01214218: hypothetical protein +FIG01214221 FIG01214222: hypothetical protein +FIG01214230 Periplasmic iron-binding protein +FIG01214232 D-Glucuronolactone:NAD+ oxidoreductase (EC 1.2.1.3) +FIG01214234 FIG01214235: hypothetical protein +FIG01214240 FIG01214241: hypothetical protein +FIG01214243 FIG01214245: hypothetical protein +FIG01214245 FIG01214251: hypothetical protein +FIG01214254 peptidase, M20/M25/M40 family +FIG01214257 FIG01214262: hypothetical protein +FIG01214262 FIG01214263: hypothetical protein +FIG01214272 FIG01214273: hypothetical protein +FIG01214285 FIG01214289: hypothetical protein +FIG01214293 FIG01214294: hypothetical protein +FIG01214302 component of multidrug efflux system +FIG01214321 FIG01211760: hypothetical protein +FIG01214329 FIG01214332: hypothetical protein +FIG01214335 FIG01214340: hypothetical protein +FIG01214354 FIG01214360: hypothetical protein +FIG01214369 hypothetical protein +FIG01214403 FIG01214404: hypothetical protein +FIG01214409 Phage-related protein +FIG01214410 FIG01214411: hypothetical protein +FIG01214413 FIG01214415: hypothetical protein +FIG01214429 FIG01214432: hypothetical protein +FIG01214436 FIG01214439: hypothetical protein +FIG01214473 FIG01214474: hypothetical protein +FIG01214479 FIG01214481: hypothetical protein +FIG01214482 FIG01214485: hypothetical protein +FIG01214485 FIG01214486: hypothetical protein +FIG01214489 FIG01214491: hypothetical protein +FIG01214494 FIG01214495: hypothetical protein +FIG01214523 FIG01214524: hypothetical protein +FIG01214526 FIG01214531: hypothetical protein +FIG01214551 FIG01214553: hypothetical protein +FIG01214575 FIG01214576: hypothetical protein +FIG01214579 FIG01214584: hypothetical protein +FIG01214591 FIG01214592: hypothetical protein +FIG01214616 Filamentous haemagglutinin +FIG01214627 FIG01214632: hypothetical protein +FIG01214662 FIG01214663: hypothetical protein +FIG01214663 transcriptional regulator araC family +FIG01214666 FIG01214671: hypothetical protein +FIG01214678 FIG01214681: hypothetical protein +FIG01214693 FIG01214694: hypothetical protein +FIG01214709 FIG01214712: hypothetical protein +FIG01214722 FIG01214723: hypothetical protein +FIG01214723 FIG01214726: hypothetical protein +FIG01214728 FIG01214730: hypothetical protein +FIG01214749 FIG01214750: hypothetical protein +FIG01214755 FIG01214761: hypothetical protein +FIG01214770 FIG01214776: hypothetical protein +FIG01214779 FIG01214780: hypothetical protein +FIG01214783 FIG01214788: hypothetical protein +FIG01214826 FIG01214827: hypothetical protein +FIG01214836 FIG01214838: hypothetical protein +FIG01214845 FIG01214846: hypothetical protein +FIG01214881 FIG01214886: hypothetical protein +FIG01214886 FIG01214888: hypothetical protein +FIG01214907 FIG01214908: hypothetical protein +FIG01214916 FIG01214917: hypothetical protein +FIG01214923 FIG01214928: hypothetical protein +FIG01214961 VirB6 protein +FIG01214987 FIG01214991: hypothetical protein +FIG01214997 FIG01214998: hypothetical protein +FIG01214998 FIG01214999: hypothetical protein +FIG01215005 FIG01215006: hypothetical protein +FIG01215006 FIG01215007: hypothetical protein +FIG01215028 FIG01215033: hypothetical protein +FIG01215038 putative SAM-dependent methyltransferase( EC:2.1.1.- ) +FIG01215040 TraU protein +FIG01215059 FIG01215060: hypothetical protein +FIG01215128 FIG01215189: hypothetical protein +FIG01215192 FIG01215212: hypothetical protein +FIG01215282 possible CBS domain-containing protein +FIG01215408 Toxin 1, PIN domain +FIG01215737 putative cupin domain protein +FIG01215777 flagellar motor protein +FIG01216043 Maf-like protein +FIG01216345 FIG01216376: hypothetical protein +FIG01216483 two-component sensor protein +FIG01216558 Exoglucanase A precursor (EC 3.2.1.91) (Exocellobiohydrolase A) (1,4-beta-cellobiohydrolase A) (CBP95) +FIG01217055 FIG01217056: hypothetical protein +FIG01217058 FIG01217060: hypothetical protein +FIG01217060 FIG01217063: hypothetical protein +FIG01217063 FIG01217064: hypothetical protein +FIG01217064 FIG01217065: hypothetical protein +FIG01217067 FIG01217068: hypothetical protein +FIG01217070 FIG01217072: hypothetical protein +FIG01217072 FIG01217074: hypothetical protein +FIG01217074 FIG01217075: hypothetical protein +FIG01217075 FIG01217076: hypothetical protein +FIG01217078 FIG01217080: hypothetical protein +FIG01217080 FIG01217081: hypothetical protein +FIG01217081 FIG01217082: hypothetical protein +FIG01217086 FIG01217087: hypothetical protein +FIG01217087 FIG01217088: hypothetical protein +FIG01217089 FIG01217090: hypothetical protein +FIG01217090 FIG01217092: hypothetical protein +FIG01217094 FIG01217095: hypothetical protein +FIG01217095 FIG01217096: hypothetical protein +FIG01217096 FIG01217099: hypothetical protein +FIG01217099 FIG01217100: hypothetical protein +FIG01217100 FIG01217102: hypothetical protein +FIG01217102 FIG01217105: hypothetical protein +FIG01217105 FIG01217109: hypothetical protein +FIG01217109 FIG01217111: hypothetical protein +FIG01217111 FIG01217112: hypothetical protein +FIG01217112 FIG01217114: hypothetical protein +FIG01217114 FIG01217117: hypothetical protein +FIG01217119 UDP-3-O-[3-hydroxymyristoyl] glucosamine N-acyltransferase +FIG01217122 FIG01217123: hypothetical protein +FIG01217123 FIG01217126: hypothetical protein +FIG01217126 FIG01217128: hypothetical protein +FIG01217128 FIG01217129: hypothetical protein +FIG01217130 hypothetical protein +FIG01217131 FIG01217132: hypothetical protein +FIG01217138 FIG01217140: hypothetical protein +FIG01217140 FIG01217145: hypothetical protein +FIG01217146 FIG01217147: hypothetical protein +FIG01217148 FIG01217149: hypothetical protein +FIG01217150 Endoglucanase +FIG01217151 FIG01217152: hypothetical protein +FIG01217156 FIG01217158: hypothetical protein +FIG01217158 FIG01217160: hypothetical protein +FIG01217160 FIG01217161: hypothetical protein +FIG01217161 FIG01217162: hypothetical protein +FIG01217162 FIG01217163: hypothetical protein +FIG01217163 FIG01217164: hypothetical protein +FIG01217164 FIG01217165: hypothetical protein +FIG01217165 FIG01217166: hypothetical protein +FIG01217166 FIG01217167: hypothetical protein +FIG01217167 FIG01217168: hypothetical protein +FIG01217168 FIG01217169: hypothetical protein +FIG01217170 phage-related integrase +FIG01217173 FIG01217174: hypothetical protein +FIG01217174 FIG01217175: hypothetical protein +FIG01217177 FIG01217178: hypothetical protein +FIG01217179 FIG01217180: hypothetical protein +FIG01217183 FIG01217184: hypothetical protein +FIG01217184 FIG01217185: hypothetical protein +FIG01217186 FIG01217189: hypothetical protein +FIG01217189 FIG01217190: hypothetical protein +FIG01217190 FIG01217191: hypothetical protein +FIG01217191 FIG01217192: hypothetical protein +FIG01217192 FIG01217193: hypothetical protein +FIG01217193 FIG01217194: hypothetical protein +FIG01217194 FIG01217197: hypothetical protein +FIG01217197 FIG01217200: hypothetical protein +FIG01217205 FIG01217206: hypothetical protein +FIG01217209 FIG01217211: hypothetical protein +FIG01217211 FIG01217217: hypothetical protein +FIG01217217 FIG01217220: hypothetical protein +FIG01217220 hypothetical protein +FIG01217223 FIG01217225: hypothetical protein +FIG01217226 FIG01218670: hypothetical protein +FIG01217227 FIG01217229: hypothetical protein +FIG01217229 FIG01217230: hypothetical protein +FIG01217230 FIG01217231: hypothetical protein +FIG01217233 FIG01217236: hypothetical protein +FIG01217236 FIG01217237: hypothetical protein +FIG01217237 FIG01217241: hypothetical protein +FIG01217242 FIG01217245: hypothetical protein +FIG01217245 FIG01217246: hypothetical protein +FIG01217246 FIG01217247: hypothetical protein +FIG01217248 FIG01217249: hypothetical protein +FIG01217253 FIG01217254: hypothetical protein +FIG01217255 FIG01217256: hypothetical protein +FIG01217257 FIG01217260: hypothetical protein +FIG01217260 FIG01217261: hypothetical protein +FIG01217261 FIG01217262: hypothetical protein +FIG01217263 FIG01217264: hypothetical protein +FIG01217272 FIG01217275: hypothetical protein +FIG01217275 FIG01217276: hypothetical protein +FIG01217276 FIG01217277: hypothetical protein +FIG01217277 FIG01217279: hypothetical protein +FIG01217279 FIG01217280: hypothetical protein +FIG01217280 FIG01217281: hypothetical protein +FIG01217281 FIG01217282: hypothetical protein +FIG01217282 FIG01217284: hypothetical protein +FIG01217285 FIG01217287: hypothetical protein +FIG01217287 FIG01217290: hypothetical protein +FIG01217290 FIG01217293: hypothetical protein +FIG01217293 FIG01217294: hypothetical protein +FIG01217294 FIG01217295: hypothetical protein +FIG01217295 FIG01217297: hypothetical protein +FIG01217297 FIG01217299: hypothetical protein +FIG01217299 FIG01217300: hypothetical protein +FIG01217300 FIG01217301: hypothetical protein +FIG01217304 FIG01217306: hypothetical protein +FIG01217306 coenzyme F390 synthetase +FIG01217311 FIG01217313: hypothetical protein +FIG01217313 FIG01217314: hypothetical protein +FIG01217314 FIG01217315: hypothetical protein +FIG01217315 FIG01217317: hypothetical protein +FIG01217317 FIG01217318: hypothetical protein +FIG01217318 FIG01217319: hypothetical protein +FIG01217321 phage-related lysozyme +FIG01217322 FIG01217323: hypothetical protein +FIG01217324 FIG01217327: hypothetical protein +FIG01217327 FIG01217328: hypothetical protein +FIG01217328 FIG01217329: hypothetical protein +FIG01217331 FIG01217332: hypothetical protein +FIG01217335 FIG01217336: hypothetical protein +FIG01217336 FIG01217337: hypothetical protein +FIG01217337 FIG01217338: hypothetical protein +FIG01217338 FIG01217339: hypothetical protein +FIG01217340 FIG01217341: hypothetical protein +FIG01217341 FIG01217342: hypothetical protein +FIG01217342 FIG01217344: hypothetical protein +FIG01217344 FIG01217347: hypothetical protein +FIG01217347 FIG01217348: hypothetical protein +FIG01217348 FIG01217349: hypothetical protein +FIG01217351 Superoxide dismutase +FIG01217360 FIG01217252: hypothetical protein +FIG01217363 FIG01217364: hypothetical protein +FIG01217365 FIG01217367: hypothetical protein +FIG01217368 FIG01217369: hypothetical protein +FIG01217369 FIG01217371: hypothetical protein +FIG01217375 FIG01217376: hypothetical protein +FIG01217376 FIG01217379: hypothetical protein +FIG01217381 FIG01217382: hypothetical protein +FIG01217383 FIG01217384: hypothetical protein +FIG01217384 FIG01217386: hypothetical protein +FIG01217386 FIG01217387: hypothetical protein +FIG01217387 FIG01217388: hypothetical protein +FIG01217388 FIG01217392: hypothetical protein +FIG01217392 FIG01217395: hypothetical protein +FIG01217397 FIG01217401: hypothetical protein +FIG01217403 FIG01217406: hypothetical protein +FIG01217406 FIG01217922: hypothetical protein +FIG01217407 FIG01217408: hypothetical protein +FIG01217410 FIG01217412: hypothetical protein +FIG01217414 FIG01217415: hypothetical protein +FIG01217415 FIG01217416: hypothetical protein +FIG01217429 FIG01217430: hypothetical protein +FIG01217430 FIG01217431: hypothetical protein +FIG01217431 FIG01217432: hypothetical protein +FIG01217432 FIG01217437: hypothetical protein +FIG01217440 FIG01217442: hypothetical protein +FIG01217442 FIG01217444: hypothetical protein +FIG01217444 FIG01217445: hypothetical protein +FIG01217451 FIG01217452: hypothetical protein +FIG01217452 FIG01217453: hypothetical protein +FIG01217453 FIG01217454: hypothetical protein +FIG01217454 FIG01217455: hypothetical protein +FIG01217456 FIG01217457: hypothetical protein +FIG01217462 FIG01217464: hypothetical protein +FIG01217464 FIG01217465: hypothetical protein +FIG01217465 FIG01217466: hypothetical protein +FIG01217466 FIG01217468: hypothetical protein +FIG01217469 FIG01217470: hypothetical protein +FIG01217470 FIG01217471: hypothetical protein +FIG01217471 FIG01217473: hypothetical protein +FIG01217473 FIG01217474: hypothetical protein +FIG01217477 FIG01217479: hypothetical protein +FIG01217479 FIG01217480: hypothetical protein +FIG01217480 FIG01217481: hypothetical protein +FIG01217483 FIG01217485: hypothetical protein +FIG01217485 DNA transport competence protein +FIG01217486 FIG01217487: hypothetical protein +FIG01217489 FIG01217492: hypothetical protein +FIG01217492 FIG01217493: hypothetical protein +FIG01217494 FIG01217495: hypothetical protein +FIG01217495 FIG01217496: hypothetical protein +FIG01217500 FIG01217501: hypothetical protein +FIG01217501 FIG01217504: hypothetical protein +FIG01217505 FIG01217506: hypothetical protein +FIG01217506 FIG01217507: hypothetical protein +FIG01217508 FIG01217509: hypothetical protein +FIG01217509 FIG01217510: hypothetical protein +FIG01217510 probable bacteriophage protein STY1048 +FIG01217511 FIG01217512: hypothetical protein +FIG01217514 FIG01217515: hypothetical protein +FIG01217515 FIG01217516: hypothetical protein +FIG01217516 FIG01217517: hypothetical protein +FIG01217517 FIG01217518: hypothetical protein +FIG01217518 FIG01217519: hypothetical protein +FIG01217519 FIG01217520: hypothetical protein +FIG01217520 FIG01217525: hypothetical protein +FIG01217525 FIG01217528: hypothetical protein +FIG01217533 very large tegument protein +FIG01217534 FIG01217535: hypothetical protein +FIG01217535 FIG01272934: hypothetical protein +FIG01217544 FIG01217545: hypothetical protein +FIG01217545 FIG01217546: hypothetical protein +FIG01217546 FIG01217547: hypothetical protein +FIG01217547 FIG01217548: hypothetical protein +FIG01217549 FIG01217550: hypothetical protein +FIG01217550 FIG01217551: hypothetical protein +FIG01217551 FIG01217554: hypothetical protein +FIG01217554 FIG01217555: hypothetical protein +FIG01217555 FIG01217557: hypothetical protein +FIG01217557 FIG01217559: hypothetical protein +FIG01217563 FIG01217565: hypothetical protein +FIG01217570 FIG01217572: hypothetical protein +FIG01217574 FIG01217575: hypothetical protein +FIG01217575 FIG01217579: hypothetical protein +FIG01217579 FIG01217581: hypothetical protein +FIG01217582 FIG01217584: hypothetical protein +FIG01217584 FIG01217585: hypothetical protein +FIG01217585 FIG01217586: hypothetical protein +FIG01217588 FIG01217589: hypothetical protein +FIG01217589 FIG01217590: hypothetical protein +FIG01217593 FIG01217597: hypothetical protein +FIG01217597 FIG01217598: hypothetical protein +FIG01217598 FIG01217600: hypothetical protein +FIG01217600 FIG01217601: hypothetical protein +FIG01217601 FIG01217603: hypothetical protein +FIG01217605 phage-related protein +FIG01217616 FIG01217617: hypothetical protein +FIG01217617 FIG01217618: hypothetical protein +FIG01217622 FIG01217623: hypothetical protein +FIG01217625 FIG01217627: hypothetical protein +FIG01217627 FIG01217630: hypothetical protein +FIG01217630 FIG01217631: hypothetical protein +FIG01217632 FIG01217634: hypothetical protein +FIG01217635 modification methylase NspV +FIG01217636 FIG01217637: hypothetical protein +FIG01217642 FIG01217645: hypothetical protein +FIG01217645 FIG01217654: hypothetical protein +FIG01217655 FIG01217656: hypothetical protein +FIG01217656 FIG01217657: hypothetical protein +FIG01217658 FIG01217660: hypothetical protein +FIG01217660 FIG01217661: hypothetical protein +FIG01217664 FIG01217665: hypothetical protein +FIG01217665 FIG01217668: hypothetical protein +FIG01217668 FIG01217669: hypothetical protein +FIG01217669 Membrane protein required for beta-lactamase induction +FIG01217673 FIG01217677: hypothetical protein +FIG01217677 FIG01217679: hypothetical protein +FIG01217682 FIG01217684: hypothetical protein +FIG01217684 FIG01217686: hypothetical protein +FIG01217686 FIG01217687: hypothetical protein +FIG01217687 plasmid stabilization protein +FIG01217688 FIG01217689: hypothetical protein +FIG01217689 FIG01217690: hypothetical protein +FIG01217694 FIG01217695: hypothetical protein +FIG01217695 FIG01217696: hypothetical protein +FIG01217697 FIG01217698: hypothetical protein +FIG01217698 FIG01217699: hypothetical protein +FIG01217699 FIG01217700: hypothetical protein +FIG01217700 FIG01217701: hypothetical protein +FIG01217701 FIG01217703: hypothetical protein +FIG01217703 FIG01217704: hypothetical protein +FIG01217704 FIG01217705: hypothetical protein +FIG01217705 FIG01217706: hypothetical protein +FIG01217706 histidine kinase/response regulator hybrid protein +FIG01217707 FIG01217709: hypothetical protein +FIG01217709 FIG01217711: hypothetical protein +FIG01217713 FIG01217714: hypothetical protein +FIG01217716 FIG01217717: hypothetical protein +FIG01217717 FIG01217718: hypothetical protein +FIG01217718 FIG01217719: hypothetical protein +FIG01217719 FIG01217721: hypothetical protein +FIG01217721 FIG01217722: hypothetical protein +FIG01217722 FIG01217724: hypothetical protein +FIG01217724 FIG01217725: hypothetical protein +FIG01217725 surface-exposed outer membrane protein +FIG01217726 FIG01217727: hypothetical protein +FIG01217727 FIG01217728: hypothetical protein +FIG01217728 FIG01217729: hypothetical protein +FIG01217729 FIG01217731: hypothetical protein +FIG01217731 FIG01217732: hypothetical protein +FIG01217734 FIG01217735: hypothetical protein +FIG01217735 FIG01217736: hypothetical protein +FIG01217736 FIG01217737: hypothetical protein +FIG01217737 FIG01217738: hypothetical protein +FIG01217738 FIG01217742: hypothetical protein +FIG01217742 Cinnamyl alcohol dehydrogenase/reductase (EC 1.1.1.195) @ Alcohol dehydrogenase (EC 1.1.1.1) +FIG01217744 FIG01217745: hypothetical protein +FIG01217745 FIG01217746: hypothetical protein +FIG01217746 FIG01217747: hypothetical protein +FIG01217747 FIG01217788: hypothetical protein +FIG01217749 bll5504; putative polyvinyl-alcohol dehydrogenase (EC 1.1.99.23) +FIG01217750 FIG01217751: hypothetical protein +FIG01217751 FIG01217752: hypothetical protein +FIG01217752 FIG01217753: hypothetical protein +FIG01217754 FIG01217755: hypothetical protein +FIG01217756 FIG01217757: hypothetical protein +FIG01217757 FIG01217759: hypothetical protein +FIG01217759 FIG01217762: hypothetical protein +FIG01217765 FIG01217766: hypothetical protein +FIG01217768 FIG01217770: hypothetical protein +FIG01217770 cell division protein +FIG01217771 FIG01217772: hypothetical protein +FIG01217774 FIG01217776: hypothetical protein +FIG01217776 FIG01217777: hypothetical protein +FIG01217777 FIG01217782: hypothetical protein +FIG01217782 FIG01217783: hypothetical protein +FIG01217792 FIG01217794: hypothetical protein +FIG01217794 hypothetical protein +FIG01217799 FIG01217800: hypothetical protein +FIG01217803 FIG01217804: hypothetical protein +FIG01217804 FIG01217805: hypothetical protein +FIG01217805 FIG01217808: hypothetical protein +FIG01217808 FIG01217809: hypothetical protein +FIG01217810 FIG01217811: hypothetical protein +FIG01217811 FIG01217813: hypothetical protein +FIG01217813 FIG01217814: hypothetical protein +FIG01217814 FIG01217816: hypothetical protein +FIG01217816 FIG01217818: hypothetical protein +FIG01217818 FIG01217820: hypothetical protein +FIG01217821 FIG01218337: hypothetical protein +FIG01217825 FIG01217826: hypothetical protein +FIG01217830 FIG01217831: hypothetical protein +FIG01217836 FIG01217837: hypothetical protein +FIG01217837 FIG01217838: hypothetical protein +FIG01217838 FIG01217840: hypothetical protein +FIG01217840 FIG01217841: hypothetical protein +FIG01217841 FIG01217843: hypothetical protein +FIG01217843 RelE/StbE replicon stabilization toxin +FIG01217846 FIG01217847: hypothetical protein +FIG01217847 FIG01217848: hypothetical protein +FIG01217848 FIG01217849: hypothetical protein +FIG01217849 FIG01217850: hypothetical protein +FIG01217850 FIG01217853: hypothetical protein +FIG01217853 FIG01217854: hypothetical protein +FIG01217854 FIG01217855: hypothetical protein +FIG01217855 FIG01217858: hypothetical protein +FIG01217858 FIG01217859: hypothetical protein +FIG01217859 FIG01217861: hypothetical protein +FIG01217861 FIG01217863: hypothetical protein +FIG01217863 FIG01217865: hypothetical protein +FIG01217865 FIG01217867: hypothetical protein +FIG01217867 FIG01217868: hypothetical protein +FIG01217870 FIG01217871: hypothetical protein +FIG01217871 FIG01217874: hypothetical protein +FIG01217875 FIG01217876: hypothetical protein +FIG01217876 FIG01217877: hypothetical protein +FIG01217882 FIG01217883: hypothetical protein +FIG01217891 FIG01217893: hypothetical protein +FIG01217893 FIG01217897: hypothetical protein +FIG01217898 FIG01217899: hypothetical protein +FIG01217899 FIG01217903: hypothetical protein +FIG01217904 FIG01217905: hypothetical protein +FIG01217905 FIG01217906: hypothetical protein +FIG01217906 FIG01217907: hypothetical protein +FIG01217907 FIG01217908: hypothetical protein +FIG01217908 FIG01217909: hypothetical protein +FIG01217909 FIG01217910: hypothetical protein +FIG01217910 FIG01217911: hypothetical protein +FIG01217914 FIG01217916: hypothetical protein +FIG01217918 FIG01217919: hypothetical protein +FIG01217922 FIG01217924: hypothetical protein +FIG01217926 FIG01217927: hypothetical protein +FIG01217932 FIG01217933: hypothetical protein +FIG01217933 FIG01217934: hypothetical protein +FIG01217934 FIG01217936: hypothetical protein +FIG01217936 FIG01217938: hypothetical protein +FIG01217938 FIG01217940: hypothetical protein +FIG01217940 FIG01217943: hypothetical protein +FIG01217943 FIG01217944: hypothetical protein +FIG01217945 FIG01217948: hypothetical protein +FIG01217948 autolytic lysozyme +FIG01217949 FIG01217951: hypothetical protein +FIG01217951 D-alanyl-D-alanine carboxypeptidase (penicillin-binding protein 4) +FIG01217952 FIG01217955: hypothetical protein +FIG01217956 FIG01217957: hypothetical protein +FIG01217957 FIG01217958: hypothetical protein +FIG01217962 FIG01217964: hypothetical protein +FIG01217966 FIG01217967: hypothetical protein +FIG01217967 FIG01217968: hypothetical protein +FIG01217969 Phage-related lysozyme (muraminidase) +FIG01217971 FIG01217972: hypothetical protein +FIG01217972 FIG01217974: hypothetical protein +FIG01217974 FIG01217975: hypothetical protein +FIG01217975 FIG01217976: hypothetical protein +FIG01217976 FIG01217980: hypothetical protein +FIG01217980 FIG01217982: hypothetical protein +FIG01217982 FIG01217983: hypothetical protein +FIG01217983 FIG01217984: hypothetical protein +FIG01217984 FIG01217991: hypothetical protein +FIG01217991 FIG01217993: hypothetical protein +FIG01217993 FIG01217994: hypothetical protein +FIG01217994 FIG01217995: hypothetical protein +FIG01217995 FIG01217996: hypothetical protein +FIG01217998 FIG01218000: hypothetical protein +FIG01218000 FIG01218002: hypothetical protein +FIG01218003 FIG01218005: hypothetical protein +FIG01218005 FIG01218008: hypothetical protein +FIG01218008 FIG01218010: hypothetical protein +FIG01218010 FIG01218012: hypothetical protein +FIG01218012 FIG01218014: hypothetical protein +FIG01218015 FIG01218016: hypothetical protein +FIG01218016 FIG01218018: hypothetical protein +FIG01218018 FIG01218019: hypothetical protein +FIG01218020 FIG01218021: hypothetical protein +FIG01218026 FIG01218027: hypothetical protein +FIG01218027 FIG01218028: hypothetical protein +FIG01218028 FIG01218029: hypothetical protein +FIG01218029 FIG01218030: hypothetical protein +FIG01218033 FIG01218034: hypothetical protein +FIG01218034 FIG01218035: hypothetical protein +FIG01218036 FIG01218038: hypothetical protein +FIG01218039 FIG01218042: hypothetical protein +FIG01218046 FIG01218048: hypothetical protein +FIG01218048 FIG01218049: hypothetical protein +FIG01218049 FIG01218050: hypothetical protein +FIG01218050 FIG01218051: hypothetical protein +FIG01218051 FIG01218056: hypothetical protein +FIG01218056 FIG01218058: hypothetical protein +FIG01218058 FIG01218059: hypothetical protein +FIG01218059 Type II restriction enzyme NspV (EC 3.1.21.4) (Endonuclease NspV) (R.NspV) +FIG01218060 FIG01218065: hypothetical protein +FIG01218066 FIG01218067: hypothetical protein +FIG01218068 FIG01218069: hypothetical protein +FIG01218072 FIG01218073: hypothetical protein +FIG01218073 FIG01218074: hypothetical protein +FIG01218074 FIG01218075: hypothetical protein +FIG01218079 FIG01218080: hypothetical protein +FIG01218081 FIG01218083: hypothetical protein +FIG01218083 FIG01218085: hypothetical protein +FIG01218086 FIG01218087: hypothetical protein +FIG01218087 lipase modulator +FIG01218089 FIG01218090: hypothetical protein +FIG01218090 FIG01218091: hypothetical protein +FIG01218091 FIG01218092: hypothetical protein +FIG01218092 FIG01218094: hypothetical protein +FIG01218098 FIG01218099: hypothetical protein +FIG01218099 FIG01218102: hypothetical protein +FIG01218104 FIG01218105: hypothetical protein +FIG01218107 FIG01218110: hypothetical protein +FIG01218110 FIG01218111: hypothetical protein +FIG01218111 FIG01218113: hypothetical protein +FIG01218115 FIG01218116: hypothetical protein +FIG01218116 FIG01219004: hypothetical protein +FIG01218121 FIG01218122: hypothetical protein +FIG01218124 FIG01218125: hypothetical protein +FIG01218127 FIG01218129: hypothetical protein +FIG01218129 FIG01218130: hypothetical protein +FIG01218130 FIG01218132: hypothetical protein +FIG01218132 FIG01218133: hypothetical protein +FIG01218133 FIG01218134: hypothetical protein +FIG01218135 FIG01218136: hypothetical protein +FIG01218136 FIG01218137: hypothetical protein +FIG01218144 FIG01218145: hypothetical protein +FIG01218145 pathogenicity-related protein +FIG01218151 FIG01218152: hypothetical protein +FIG01218152 FIG01218153: hypothetical protein +FIG01218153 FIG01218156: hypothetical protein +FIG01218159 Minor coat protein +FIG01218160 FIG01218161: hypothetical protein +FIG01218161 FIG01263570: hypothetical protein +FIG01218163 FIG01218164: hypothetical protein +FIG01218164 FIG01218168: hypothetical protein +FIG01218168 FIG01218170: hypothetical protein +FIG01218170 FIG01218174: hypothetical protein +FIG01218178 FIG01218180: hypothetical protein +FIG01218180 FIG01218181: hypothetical protein +FIG01218183 FIG01218184: hypothetical protein +FIG01218184 FIG01218185: hypothetical protein +FIG01218185 FIG01218186: hypothetical protein +FIG01218186 FIG01218187: hypothetical protein +FIG01218194 FIG00644317: hypothetical protein +FIG01218201 FIG01218202: hypothetical protein +FIG01218202 FIG01218205: hypothetical protein +FIG01218205 FIG01218207: hypothetical protein +FIG01218207 Zn-finger, CHC2 type +FIG01218210 FIG01218211: hypothetical protein +FIG01218217 FIG01218220: hypothetical protein +FIG01218220 FIG01218221: hypothetical protein +FIG01218221 FIG01218222: hypothetical protein +FIG01218222 FIG01218226: hypothetical protein +FIG01218226 FIG01218228: hypothetical protein +FIG01218229 FIG01218231: hypothetical protein +FIG01218231 FIG01218233: hypothetical protein +FIG01218233 transcriptional regulator (PbsX family) +FIG01218236 FIG01218238: hypothetical protein +FIG01218241 FIG01218242: hypothetical protein +FIG01218242 FIG01218243: hypothetical protein +FIG01218245 FIG01218246: hypothetical protein +FIG01218247 FIG01218250: hypothetical protein +FIG01218251 FIG01218252: hypothetical protein +FIG01218252 FIG01218253: hypothetical protein +FIG01218253 hypothetical protein +FIG01218256 FIG01218257: hypothetical protein +FIG01218257 FIG01218258: hypothetical protein +FIG01218258 FIG01218259: hypothetical protein +FIG01218259 FIG01218260: hypothetical protein +FIG01218260 FIG01218262: hypothetical protein +FIG01218262 FIG01218263: hypothetical protein +FIG01218266 FIG01218267: hypothetical protein +FIG01218272 FIG01218273: hypothetical protein +FIG01218273 FIG01218176: hypothetical protein +FIG01218274 FIG01218275: hypothetical protein +FIG01218275 FIG01218277: hypothetical protein +FIG01218277 hypothetical protein +FIG01218278 FIG01218279: hypothetical protein +FIG01218280 FIG01218281: hypothetical protein +FIG01218281 FIG01218282: hypothetical protein +FIG01218284 FIG01218285: hypothetical protein +FIG01218297 FIG01218298: hypothetical protein +FIG01218300 FIG01218302: hypothetical protein +FIG01218302 FIG01218305: hypothetical protein +FIG01218306 FIG01218308: hypothetical protein +FIG01218308 FIG01218309: hypothetical protein +FIG01218313 FIG01218314: hypothetical protein +FIG01218314 FIG01218315: hypothetical protein +FIG01218315 FIG01218316: hypothetical protein +FIG01218316 FIG01218318: hypothetical protein +FIG01218321 FIG01218322: hypothetical protein +FIG01218324 FIG01218327: hypothetical protein +FIG01218327 FIG01218328: hypothetical protein +FIG01218330 FIG01218331: hypothetical protein +FIG01218331 FIG01218332: hypothetical protein +FIG01218332 FIG01218335: hypothetical protein +FIG01218337 FIG01218339: hypothetical protein +FIG01218339 FIG01218341: hypothetical protein +FIG01218341 FIG01218343: hypothetical protein +FIG01218346 FIG01218347: hypothetical protein +FIG01218347 FIG01218348: hypothetical protein +FIG01218348 FIG01218349: hypothetical protein +FIG01218349 fimbrial subunit precursor +FIG01218350 FIG01218351: hypothetical protein +FIG01218351 FIG01218352: hypothetical protein +FIG01218352 FIG01218353: hypothetical protein +FIG01218353 FIG01218356: hypothetical protein +FIG01218357 FIG01218360: hypothetical protein +FIG01218360 FIG01218361: hypothetical protein +FIG01218361 FIG01218363: hypothetical protein +FIG01218363 FIG01218364: hypothetical protein +FIG01218364 FIG01218366: hypothetical protein +FIG01218366 hypothetical protein +FIG01218371 FIG01218372: hypothetical protein +FIG01218372 FIG01218373: hypothetical protein +FIG01218377 FIG01218378: hypothetical protein +FIG01218378 FIG01218381: hypothetical protein +FIG01218381 FIG01218384: hypothetical protein +FIG01218386 FIG01218389: hypothetical protein +FIG01218389 FIG01218390: hypothetical protein +FIG01218395 FIG01218397: hypothetical protein +FIG01218397 dolichol-phosphate mannosyltransferase +FIG01218398 FIG01218399: hypothetical protein +FIG01218402 fimbrial adhesin precursor +FIG01218408 FIG01218410: hypothetical protein +FIG01218413 FIG01218414: hypothetical protein +FIG01218415 FIG01218417: hypothetical protein +FIG01218417 FIG01218419: hypothetical protein +FIG01218421 FIG01218422: hypothetical protein +FIG01218437 FIG01218438: hypothetical protein +FIG01218438 FIG01218440: hypothetical protein +FIG01218440 phage-related DNA polymerase +FIG01218443 FIG01218444: hypothetical protein +FIG01218444 FIG01218445: hypothetical protein +FIG01218445 FIG01218447: hypothetical protein +FIG01218447 FIG01218450: hypothetical protein +FIG01218450 FIG01218451: hypothetical protein +FIG01218451 FIG01218452: hypothetical protein +FIG01218452 FIG01218455: hypothetical protein +FIG01218455 FIG01218459: hypothetical protein +FIG01218459 FIG01218461: hypothetical protein +FIG01218462 FIG01218463: hypothetical protein +FIG01218463 FIG01218465: hypothetical protein +FIG01218467 FIG01218468: hypothetical protein +FIG01218468 FIG01218469: hypothetical protein +FIG01218472 FIG01218473: hypothetical protein +FIG01218475 FIG01218476: hypothetical protein +FIG01218476 FIG01218478: hypothetical protein +FIG01218484 FIG01218485: hypothetical protein +FIG01218487 FIG01218488: hypothetical protein +FIG01218492 FIG01218493: hypothetical protein +FIG01218494 hypothetical protein +FIG01218496 FIG01218497: hypothetical protein +FIG01218497 FIG01218499: hypothetical protein +FIG01218502 FIG01218504: hypothetical protein +FIG01218507 FIG01218510: hypothetical protein +FIG01218510 FIG01218511: hypothetical protein +FIG01218511 FIG01218514: hypothetical protein +FIG01218514 FIG01218515: hypothetical protein +FIG01218515 FIG01218517: hypothetical protein +FIG01218519 hypothetical protein +FIG01218520 FIG01218521: hypothetical protein +FIG01218521 FIG01218523: hypothetical protein +FIG01218523 FIG01218524: hypothetical protein +FIG01218527 FIG01218530: hypothetical protein +FIG01218533 FIG01218535: hypothetical protein +FIG01218537 FIG01218540: hypothetical protein +FIG01218540 FIG01218542: hypothetical protein +FIG01218542 Fimbrial protein precursor +FIG01218543 FIG01218544: hypothetical protein +FIG01218548 FIG01218549: hypothetical protein +FIG01218549 FIG01218551: hypothetical protein +FIG01218551 FIG01218552: hypothetical protein +FIG01218552 FIG01218554: hypothetical protein +FIG01218554 FIG01218555: hypothetical protein +FIG01218555 hypothetical protein +FIG01218556 FIG01218558: hypothetical protein +FIG01218558 FIG01218559: hypothetical protein +FIG01218561 FIG01218562: hypothetical protein +FIG01218562 FIG01218563: hypothetical protein +FIG01218570 FIG01218571: hypothetical protein +FIG01218571 FIG01218573: hypothetical protein +FIG01218575 FIG01218576: hypothetical protein +FIG01218576 FIG01218577: hypothetical protein +FIG01218577 hemagglutinin-like secreted protein +FIG01218579 FIG01218581: hypothetical protein +FIG01218581 FIG01218585: hypothetical protein +FIG01218585 B. burgdorferi predicted coding region BB0646 +FIG01218588 hypothetical protein +FIG01218590 FIG01218591: hypothetical protein +FIG01218596 FIG01218597: hypothetical protein +FIG01218597 FIG01218598: hypothetical protein +FIG01218598 FIG01218600: hypothetical protein +FIG01218600 FIG01218601: hypothetical protein +FIG01218601 FIG01218604: hypothetical protein +FIG01218608 FIG01218610: hypothetical protein +FIG01218614 hypothetical protein +FIG01218615 FIG01218616: hypothetical protein +FIG01218619 FIG01218623: hypothetical protein +FIG01218623 FIG01218624: hypothetical protein +FIG01218626 FIG01218627: hypothetical protein +FIG01218630 FIG01218631: hypothetical protein +FIG01218632 FIG01218634: hypothetical protein +FIG01218642 FIG01218643: hypothetical protein +FIG01218645 FIG01218646: hypothetical protein +FIG01218646 FIG01218648: hypothetical protein +FIG01218648 FIG01218650: hypothetical protein +FIG01218657 FIG01218658: hypothetical protein +FIG01218658 FIG01218662: hypothetical protein +FIG01218662 FIG01218663: hypothetical protein +FIG01218663 FIG01218665: hypothetical protein +FIG01218666 FIG01218669: hypothetical protein +FIG01218676 FIG01218677: hypothetical protein +FIG01218678 FIG01218679: hypothetical protein +FIG01218682 FIG01218683: hypothetical protein +FIG01218690 FIG01218691: hypothetical protein +FIG01218691 FIG01218693: hypothetical protein +FIG01218693 hypothetical protein +FIG01218694 FIG01218695: hypothetical protein +FIG01218705 FIG01218707: hypothetical protein +FIG01218707 FIG01218710: hypothetical protein +FIG01218712 FIG01218713: hypothetical protein +FIG01218713 FIG01218714: hypothetical protein +FIG01218714 FIG01218715: hypothetical protein +FIG01218715 FIG01218716: hypothetical protein +FIG01218717 FIG01218718: hypothetical protein +FIG01218721 FIG01218723: hypothetical protein +FIG01218723 FIG01218726: hypothetical protein +FIG01218731 FIG01218732: hypothetical protein +FIG01218743 Type IV pilus biogenesis protein PilZ +FIG01218748 FIG01218749: hypothetical protein +FIG01218749 FIG01218752: hypothetical protein +FIG01218752 FIG01217191: hypothetical protein +FIG01218754 FIG01218757: hypothetical protein +FIG01218759 FIG01218761: hypothetical protein +FIG01218763 Predicted aminopeptidases +FIG01218767 FIG01218774: hypothetical protein +FIG01218774 FIG01218775: hypothetical protein +FIG01218775 FIG01218777: hypothetical protein +FIG01218778 FIG01218779: hypothetical protein +FIG01218785 FIG01218788: hypothetical protein +FIG01218788 FIG01218789: hypothetical protein +FIG01218789 FIG01218791: hypothetical protein +FIG01218791 FIG01218792: hypothetical protein +FIG01218793 FIG01218795: hypothetical protein +FIG01218795 FIG01218796: hypothetical protein +FIG01218802 FIG01218803: hypothetical protein +FIG01218803 FIG01218805: hypothetical protein +FIG01218805 FIG01218807: hypothetical protein +FIG01218807 FIG01218808: hypothetical protein +FIG01218808 FIG01218810: hypothetical protein +FIG01218812 Phage transcriptional regulator with helix-turn-helix motif +FIG01218816 FIG01218817: hypothetical protein +FIG01218817 FIG01218818: hypothetical protein +FIG01218818 FIG01218819: hypothetical protein +FIG01218820 FIG01218822: hypothetical protein +FIG01218822 FIG01218823: hypothetical protein +FIG01218823 UDP-3-O-(R-3-hydroxymyristoyl)-glucosamine N-acyltransferase +FIG01218832 FIG01218833: hypothetical protein +FIG01218833 FIG01218834: hypothetical protein +FIG01218834 FIG01218835: hypothetical protein +FIG01218843 FIG01218844: hypothetical protein +FIG01218844 FIG01218847: hypothetical protein +FIG01218847 conservde hypothetical protein +FIG01218849 FIG01218851: hypothetical protein +FIG01218851 FIG01218852: hypothetical protein +FIG01218852 FIG01218854: hypothetical protein +FIG01218855 FIG01218857: hypothetical protein +FIG01218857 FIG01218858: hypothetical protein +FIG01218868 FIG01218869: hypothetical protein +FIG01218870 FIG01218871: hypothetical protein +FIG01218873 FIG01218875: hypothetical protein +FIG01218876 FIG01218878: hypothetical protein +FIG01218878 FIG01218880: hypothetical protein +FIG01218880 FIG01218882: hypothetical protein +FIG01218885 FIG01218886: hypothetical protein +FIG01218886 FIG01218887: hypothetical protein +FIG01218900 FIG01218901: hypothetical protein +FIG01218901 IncP-type DNA transfer protein TraD +FIG01218903 FIG01218905: hypothetical protein +FIG01218905 FIG01218908: hypothetical protein +FIG01218913 FIG01218915: hypothetical protein +FIG01218915 IncP-type entry exclusion protein TrbK +FIG01218919 FIG01218921: hypothetical protein +FIG01218928 FIG01218929: hypothetical protein +FIG01218943 FIG01218948: hypothetical protein +FIG01218948 FIG01218950: hypothetical protein +FIG01218950 FIG01218954: hypothetical protein +FIG01218957 FIG01218958: hypothetical protein +FIG01218959 FIG01218961: hypothetical protein +FIG01218961 FIG01218962: hypothetical protein +FIG01218977 FIG01218978: hypothetical protein +FIG01218978 FIG01218980: hypothetical protein +FIG01218980 FIG01218983: hypothetical protein +FIG01218983 FIG01218985: hypothetical protein +FIG01218985 hemolysin-type calcium binding protein +FIG01218986 FIG01218987: hypothetical protein +FIG01218987 FIG01218988: hypothetical protein +FIG01218988 FIG01218989: hypothetical protein +FIG01218989 FIG01218990: hypothetical protein +FIG01218994 FIG01218997: hypothetical protein +FIG01218997 FIG01218999: hypothetical protein +FIG01219006 FIG01219009: hypothetical protein +FIG01219009 hypothetical protein +FIG01219014 FIG01219016: hypothetical protein +FIG01219021 FIG01219022: hypothetical protein +FIG01219027 FIG01219031: hypothetical protein +FIG01219031 FIG01219033: hypothetical protein +FIG01219033 FIG01219034: hypothetical protein +FIG01219034 FIG01219035: hypothetical protein +FIG01219042 FIG01219044: hypothetical protein +FIG01219047 FIG01219051: hypothetical protein +FIG01219051 FIG01219054: hypothetical protein +FIG01219057 phage-related tail fiber protein +FIG01219064 FIG01219065: hypothetical protein +FIG01219065 FIG01219068: hypothetical protein +FIG01219068 FIG01219070: hypothetical protein +FIG01219070 FIG01219071: hypothetical protein +FIG01219073 FIG01219074: hypothetical protein +FIG01219089 FIG01219090: hypothetical protein +FIG01219092 FIG01219093: hypothetical protein +FIG01219099 FIG01219101: hypothetical protein +FIG01219102 FIG01219106: hypothetical protein +FIG01219108 FIG01219109: hypothetical protein +FIG01219113 FIG01219116: hypothetical protein +FIG01219116 FIG01219119: hypothetical protein +FIG01219119 FIG01219121: hypothetical protein +FIG01219121 FIG01219127: hypothetical protein +FIG01219130 FIG01219131: hypothetical protein +FIG01219135 FIG01219136: hypothetical protein +FIG01219136 FIG01219138: hypothetical protein +FIG01219140 FIG01219143: hypothetical protein +FIG01219143 FIG01219145: hypothetical protein +FIG01219145 IncP-type DNA relaxase TraI +FIG01219147 FIG01219150: hypothetical protein +FIG01219150 FIG01219153: hypothetical protein +FIG01219154 FIG01219156: hypothetical protein +FIG01219156 FIG01219160: hypothetical protein +FIG01219160 FIG01219162: hypothetical protein +FIG01219188 FIG01219190: hypothetical protein +FIG01219190 FIG01219191: hypothetical protein +FIG01219196 FIG01219198: hypothetical protein +FIG01219198 FIG01219199: hypothetical protein +FIG01219199 hypothetical protein +FIG01219205 FIG01219207: hypothetical protein +FIG01219220 FIG01219226: hypothetical protein +FIG01219234 FIG01219235: hypothetical protein +FIG01219235 FIG01219236: hypothetical protein +FIG01219236 FIG01219237: hypothetical protein +FIG01219237 FIG01219238: hypothetical protein +FIG01219248 FIG01219251: hypothetical protein +FIG01219264 FIG01219267: hypothetical protein +FIG01219268 FIG01219269: hypothetical protein +FIG01219269 FIG01219271: hypothetical protein +FIG01219273 FIG01219276: hypothetical protein +FIG01219279 FIG01219280: hypothetical protein +FIG01219280 V8-like Glu-specific endopeptidase +FIG01219281 FIG01219282: hypothetical protein +FIG01219282 FIG01219284: hypothetical protein +FIG01219306 FIG01219307: hypothetical protein +FIG01219312 FIG01219315: hypothetical protein +FIG01219317 FIG01219318: hypothetical protein +FIG01219319 FIG01219323: hypothetical protein +FIG01219324 FIG01219326: hypothetical protein +FIG01219338 FIG01219341: hypothetical protein +FIG01219343 FIG01219345: hypothetical protein +FIG01219345 hypothetical protein +FIG01219348 FIG01219349: hypothetical protein +FIG01219359 FIG01219361: hypothetical protein +FIG01219369 FIG01219373: hypothetical protein +FIG01219373 FIG01219374: hypothetical protein +FIG01219380 FIG01219385: hypothetical protein +FIG01219386 FIG01219388: hypothetical protein +FIG01219388 FIG01219397: hypothetical protein +FIG01219400 FIG01219402: hypothetical protein +FIG01219402 PhoP/Q-regulated protein PqaA +FIG01219406 FIG01219413: hypothetical protein +FIG01219413 FIG01219414: hypothetical protein +FIG01219421 FIG01219422: hypothetical protein +FIG01219422 FIG01219423: hypothetical protein +FIG01219423 FIG01219427: hypothetical protein +FIG01219435 FIG01219441: hypothetical protein +FIG01219443 FIG01219445: hypothetical protein +FIG01219458 FIG01219465: hypothetical protein +FIG01219466 FIG01219467: hypothetical protein +FIG01219489 FIG01219490: hypothetical protein +FIG01219505 FIG01219510: hypothetical protein +FIG01219532 FIG01219541: hypothetical protein +FIG01219543 similar to Lipase chaperone +FIG01219566 FIG01219570: hypothetical protein +FIG01219570 FIG01219574: hypothetical protein +FIG01219574 hypothetical protein +FIG01219578 FIG01219580: hypothetical protein +FIG01219615 FIG01219616: hypothetical protein +FIG01219616 FIG01219619: hypothetical protein +FIG01219620 FIG01219631: hypothetical protein +FIG01219636 sugar-phosphate dehydrogenase +FIG01219637 FIG01219638: hypothetical protein +FIG01219638 FIG01219640: hypothetical protein +FIG01219649 FIG01219652: hypothetical protein +FIG01219652 FIG01219655: hypothetical protein +FIG01219655 FIG01219656: hypothetical protein +FIG01219656 FIG01219661: hypothetical protein +FIG01219661 FIG01219662: hypothetical protein +FIG01219662 FIG01219663: hypothetical protein +FIG01219665 FIG01219668: hypothetical protein +FIG01219668 FIG01219669: hypothetical protein +FIG01219669 FIG01219670: hypothetical protein +FIG01219670 FIG01219675: hypothetical protein +FIG01219675 FIG01219677: hypothetical protein +FIG01219677 FIG01219678: hypothetical protein +FIG01219679 FIG01219681: hypothetical protein +FIG01219683 FIG01219690: hypothetical protein +FIG01219691 FIG01219693: hypothetical protein +FIG01219693 FIG00904966: hypothetical protein +FIG01219694 Raffinose operon transcriptional regulatory protein RafR +FIG01219695 FIG01219697: hypothetical protein +FIG01219697 FIG01219700: hypothetical protein +FIG01219700 FIG01219707: hypothetical protein +FIG01219708 FIG01219709: hypothetical protein +FIG01219709 FIG01219710: hypothetical protein +FIG01219710 FIG01219711: hypothetical protein +FIG01219711 FIG01219712: hypothetical protein +FIG01219713 FIG01219714: hypothetical protein +FIG01219714 FIG01219716: hypothetical protein +FIG01219716 FIG01219717: hypothetical protein +FIG01219717 FIG01219720: hypothetical protein +FIG01219722 hypothetical protein +FIG01219725 FIG01219726: hypothetical protein +FIG01219726 FIG01219727: hypothetical protein +FIG01219728 FIG01219730: hypothetical protein +FIG01219730 FIG01219733: hypothetical protein +FIG01219738 Putative ABC iron siderophore transporter, fused permease and ATPase domains +FIG01219740 FIG01219742: hypothetical protein +FIG01219742 CRISPR-associated protein, Csy3 family +FIG01219752 FIG01219753: hypothetical protein +FIG01219754 FIG01219756: hypothetical protein +FIG01219756 FIG01219757: hypothetical protein +FIG01219757 FIG01219758: hypothetical protein +FIG01219758 FIG01219759: hypothetical protein +FIG01219759 FIG01219760: hypothetical protein +FIG01219760 FIG01219762: hypothetical protein +FIG01219762 FIG01219763: hypothetical protein +FIG01219763 FIG01219764: hypothetical protein +FIG01219764 FIG01219765: hypothetical protein +FIG01219765 FIG01219766: hypothetical protein +FIG01219766 FIG01219767: hypothetical protein +FIG01219769 FIG01219770: hypothetical protein +FIG01219770 FIG01219771: hypothetical protein +FIG01219771 FIG01219775: hypothetical protein +FIG01219776 FIG01219780: hypothetical protein +FIG01219780 FIG01219782: hypothetical protein +FIG01219782 Uncharacterized protein yqiC +FIG01219785 FIG01219786: hypothetical protein +FIG01219786 FIG01219787: hypothetical protein +FIG01219787 FIG01219788: hypothetical protein +FIG01219789 FIG01219795: hypothetical protein +FIG01219796 FIG01219797: hypothetical protein +FIG01219797 FIG01219798: hypothetical protein +FIG01219804 FIG01219805: hypothetical protein +FIG01219805 FIG01219807: hypothetical protein +FIG01219807 FIG01219811: hypothetical protein +FIG01219814 FIG01219816: hypothetical protein +FIG01219819 FIG01219821: hypothetical protein +FIG01219821 FIG01219825: hypothetical protein +FIG01219825 FIG01219826: hypothetical protein +FIG01219827 ElaB protein +FIG01219829 FIG01219830: hypothetical protein +FIG01219831 FIG01219832: hypothetical protein +FIG01219832 FIG01219833: hypothetical protein +FIG01219833 FIG01219834: hypothetical protein +FIG01219834 FIG01219837: hypothetical protein +FIG01219837 FIG01219838: hypothetical protein +FIG01219839 FIG01219840: hypothetical protein +FIG01219840 FIG01219842: hypothetical protein +FIG01219842 FIG01219843: hypothetical protein +FIG01219843 FIG01219844: hypothetical protein +FIG01219844 FIG01219849: hypothetical protein +FIG01219849 FIG01219850: hypothetical protein +FIG01219850 putative virG protein +FIG01219855 FIG01219856: hypothetical protein +FIG01219856 Phage shock protein G +FIG01219857 FIG01219858: hypothetical protein +FIG01219860 FIG01219862: hypothetical protein +FIG01219868 Uncharacterized protein ygiD +FIG01219873 FIG01219875: hypothetical protein +FIG01219877 FIG01219878: hypothetical protein +FIG01219878 FIG01219879: hypothetical protein +FIG01219879 FIG01219880: hypothetical protein +FIG01219880 FIG01219882: hypothetical protein +FIG01219882 COG3728: Phage terminase, small subunit +FIG01219883 FIG01219884: hypothetical protein +FIG01219884 FIG01219886: hypothetical protein +FIG01219889 FIG01219894: hypothetical protein +FIG01219896 FIG01219897: hypothetical protein +FIG01219897 FIG01219898: hypothetical protein +FIG01219898 FIG01219901: hypothetical protein +FIG01219901 FIG01219902: hypothetical protein +FIG01219902 FIG01219903: hypothetical protein +FIG01219903 FIG01219904: hypothetical protein +FIG01219904 FIG01219907: hypothetical protein +FIG01219910 Putative pyocin S2 (EC 3.1.21.1) +FIG01219911 FIG01219913: hypothetical protein +FIG01219913 FIG01219916: hypothetical protein +FIG01219916 FIG01219917: hypothetical protein +FIG01219922 FIG01219923: hypothetical protein +FIG01219923 FIG01219924: hypothetical protein +FIG01219924 hemolysin activator protein +FIG01219926 Putative uncharacterized protein YiiQ +FIG01219928 FIG01219929: hypothetical protein +FIG01219929 FIG01219930: hypothetical protein +FIG01219930 Putative reductoisomerase in siderophore biosynthesis gene cluster +FIG01219932 FIG01219933: hypothetical protein +FIG01219933 FIG01219935: hypothetical protein +FIG01219937 FIG01219938: hypothetical protein +FIG01219938 FIG01219939: hypothetical protein +FIG01219940 FIG01219941: hypothetical protein +FIG01219941 FIG01219943: hypothetical protein +FIG01219943 FIG01219947: hypothetical protein +FIG01219947 FIG01219949: hypothetical protein +FIG01219950 FIG01219952: hypothetical protein +FIG01219952 FIG01219954: hypothetical protein +FIG01219954 Arylesterase precursor (EC 3.1.1.2) +FIG01219959 FIG01219960: hypothetical protein +FIG01219960 FIG01219961: hypothetical protein +FIG01219961 FIG01219966: hypothetical protein +FIG01219972 FIG01219973: hypothetical protein +FIG01219973 FIG01219974: hypothetical protein +FIG01219975 Probable lipoprotein +FIG01219977 FIG01219979: hypothetical protein +FIG01219979 FIG01219980: hypothetical protein +FIG01219980 FIG029138: Type III secretion protein +FIG01219983 FIG01219984: hypothetical protein +FIG01219984 FIG01219988: hypothetical protein +FIG01219989 FIG01219992: hypothetical protein +FIG01219992 Probable outer membrane protein +FIG01219993 FIG01221613: hypothetical protein +FIG01220001 FIG01220002: hypothetical protein +FIG01220002 FIG01220003: hypothetical protein +FIG01220004 FIG01220006: hypothetical protein +FIG01220006 Type III secretion system protein BsaR +FIG01220008 FIG01220011: hypothetical protein +FIG01220011 COG3788: Uncharacterized relative of glutathione S-transferase, MAPEG superfamily +FIG01220012 FIG01220013: hypothetical protein +FIG01220018 FIG01220019: hypothetical protein +FIG01220020 FIG01220021: hypothetical protein +FIG01220022 FIG01220029: hypothetical protein +FIG01220030 FIG01220031: hypothetical protein +FIG01220032 FIG01220036: hypothetical protein +FIG01220036 FIG01220037: hypothetical protein +FIG01220037 FIG01220040: hypothetical protein +FIG01220040 FIG01220041: hypothetical protein +FIG01220041 Glutamine transport ATP-binding protein glnQ (TC 3.A.1.3.2) +FIG01220048 FIG01220051: hypothetical protein +FIG01220051 FIG01220054: hypothetical protein +FIG01220054 FIG01220056: hypothetical protein +FIG01220056 FIG01220062: hypothetical protein +FIG01220062 FIG01220063: hypothetical protein +FIG01220063 FIG01220066: hypothetical protein +FIG01220069 FIG01220070: hypothetical protein +FIG01220070 FIG01220073: hypothetical protein +FIG01220073 FIG01220074: hypothetical protein +FIG01220074 FIG01220075: hypothetical protein +FIG01220075 hypothetical protein +FIG01220076 FIG01220077: hypothetical protein +FIG01220077 FIG01220079: hypothetical protein +FIG01220079 FIG01220080: hypothetical protein +FIG01220080 FIG01220081: hypothetical protein +FIG01220081 FIG01220082: hypothetical protein +FIG01220085 FIG01220087: hypothetical protein +FIG01220087 Virulence sensor protein bvgS precursor (EC 2.7.3.-) +FIG01220089 FIG01220090: hypothetical protein +FIG01220095 FIG01220096: hypothetical protein +FIG01220096 FIG01220097: hypothetical protein +FIG01220097 FIG01220099: hypothetical protein +FIG01220099 FIG01220101: hypothetical protein +FIG01220101 FIG01220102: hypothetical protein +FIG01220105 FIG01220106: hypothetical protein +FIG01220106 FIG01220107: hypothetical protein +FIG01220111 FIG01220112: hypothetical protein +FIG01220112 FIG01220113: hypothetical protein +FIG01220114 FIG01220115: hypothetical protein +FIG01220115 FIG01220116: hypothetical protein +FIG01220118 FIG01220119: hypothetical protein +FIG01220119 hypothetical protein +FIG01220124 FIG01220125: hypothetical protein +FIG01220126 FIG01220127: hypothetical protein +FIG01220127 FIG01220128: hypothetical protein +FIG01220128 FIG01220129: hypothetical protein +FIG01220129 FIG01220130: hypothetical protein +FIG01220130 hypothetical protein +FIG01220131 FIG01220133: hypothetical protein +FIG01220133 FIG01220135: hypothetical protein +FIG01220136 FIG01220138: hypothetical protein +FIG01220138 FIG01220140: hypothetical protein +FIG01220142 FIG01220143: hypothetical protein +FIG01220143 FIG01220145: hypothetical protein +FIG01220145 FIG01220146: hypothetical protein +FIG01220149 FIG003145: Surface protein +FIG01220151 FIG01220152: hypothetical protein +FIG01220163 FIG01220164: hypothetical protein +FIG01220164 FIG01220166: hypothetical protein +FIG01220166 FIG01220168: hypothetical protein +FIG01220168 FIG01220170: hypothetical protein +FIG01220170 FIG01220171: hypothetical protein +FIG01220171 FIG01220172: hypothetical protein +FIG01220172 FIG01220173: hypothetical protein +FIG01220173 FIG01220177: hypothetical protein +FIG01220177 FIG01220178: hypothetical protein +FIG01220178 FIG01220182: hypothetical protein +FIG01220183 FIG01220184: hypothetical protein +FIG01220184 FIG01220188: hypothetical protein +FIG01220189 FIG01220190: hypothetical protein +FIG01220190 FIG01220192: hypothetical protein +FIG01220192 FIG01220196: hypothetical protein +FIG01220196 FIG01220197: hypothetical protein +FIG01220197 FIG01220198: hypothetical protein +FIG01220198 FIG01220199: hypothetical protein +FIG01220199 FIG01220201: hypothetical protein +FIG01220201 FIG01220202: hypothetical protein +FIG01220202 FIG01220203: hypothetical protein +FIG01220203 FIG01220204: hypothetical protein +FIG01220204 FIG01220207: hypothetical protein +FIG01220207 FIG01220208: hypothetical protein +FIG01220210 FIG01220212: hypothetical protein +FIG01220213 FIG01220214: hypothetical protein +FIG01220214 outer membrane fimbrial usher protein +FIG01220216 FIG01220220: hypothetical protein +FIG01220222 Hemolysin activation/secretion protein +FIG01220229 FIG01220232: hypothetical protein +FIG01220237 FIG01220239: hypothetical protein +FIG01220239 FIG01220240: hypothetical protein +FIG01220240 FIG01220245: hypothetical protein +FIG01220245 FIG01220251: hypothetical protein +FIG01220255 FIG01220256: hypothetical protein +FIG01220259 FIG01220261: hypothetical protein +FIG01220261 FIG01220263: hypothetical protein +FIG01220263 FIG01220264: hypothetical protein +FIG01220264 FIG01220266: hypothetical protein +FIG01220274 FIG01220275: hypothetical protein +FIG01220275 prophage p2 ogr protein +FIG01220276 rRNA small subunit methyltransferase J +FIG01220283 FIG01220284: hypothetical protein +FIG01220284 FIG01220285: hypothetical protein +FIG01220285 FIG01220290: hypothetical protein +FIG01220290 FIG01220291: hypothetical protein +FIG01220295 FIG01220297: hypothetical protein +FIG01220299 FIG01220301: hypothetical protein +FIG01220301 RNase E specificity factor CsrD +FIG01220302 Putative cell envelope opacity-associated protein A +FIG01220304 FIG01220305: hypothetical protein +FIG01220305 FIG01220306: hypothetical protein +FIG01220306 FIG01220307: hypothetical protein +FIG01220307 FIG00896075: hypothetical protein +FIG01220308 FIG01220309: hypothetical protein +FIG01220309 Putative lipoprotein yceB precursor +FIG01220310 FIG01220311: hypothetical protein +FIG01220311 FIG01220312: hypothetical protein +FIG01220312 hypothetical protein +FIG01220313 FIG01220315: hypothetical protein +FIG01220317 FIG01220318: hypothetical protein +FIG01220318 FIG01220319: hypothetical protein +FIG01220319 FIG01220323: hypothetical protein +FIG01220325 FIG01220326: hypothetical protein +FIG01220329 FIG01220331: hypothetical protein +FIG01220331 FIG01220334: hypothetical protein +FIG01220335 spermidine/putrescine transport ATP-binding protein +FIG01220338 FIG01220339: hypothetical protein +FIG01220339 FIG01220342: hypothetical protein +FIG01220342 FIG01220343: hypothetical protein +FIG01220343 FIG01220344: hypothetical protein +FIG01220347 FIG01220350: hypothetical protein +FIG01220350 FIG01220351: hypothetical protein +FIG01220351 FIG01220352: hypothetical protein +FIG01220353 FIG01220354: hypothetical protein +FIG01220354 FIG01220358: hypothetical protein +FIG01220359 FIG01220360: hypothetical protein +FIG01220362 FIG01220363: hypothetical protein +FIG01220363 doubtful CDS with no significant database hits +FIG01220365 uncharacterized protein SCO0976 +FIG01220371 FIG01220376: hypothetical protein +FIG01220377 FIG01220379: hypothetical protein +FIG01220379 FIG01220380: hypothetical protein +FIG01220380 FIG01220381: hypothetical protein +FIG01220381 FIG01220382: hypothetical protein +FIG01220382 FIG01220383: hypothetical protein +FIG01220383 FIG01220384: hypothetical protein +FIG01220384 FIG01220385: hypothetical protein +FIG01220385 FIG01220387: hypothetical protein +FIG01220387 CRISPR-associated protein, Csy1 family +FIG01220390 FIG01220391: hypothetical protein +FIG01220391 DNA damage-inducible gene in SOS regulon, dependent on cyclic AMP and H-NS +FIG01220392 FIG01220394: hypothetical protein +FIG01220394 FIG01220395: hypothetical protein +FIG01220396 FIG01220397: hypothetical protein +FIG01220397 FIG01222391: hypothetical protein +FIG01220399 FIG01220401: hypothetical protein +FIG01220401 FIG01220403: hypothetical protein +FIG01220403 Putative regulator protein +FIG01220405 FIG00628819: hypothetical protein +FIG01220408 FIG01220410: hypothetical protein +FIG01220410 FIG01220411: hypothetical protein +FIG01220411 FIG01220412: hypothetical protein +FIG01220412 FIG01220414: hypothetical protein +FIG01220414 FIG01220417: hypothetical protein +FIG01220417 FIG01220418: hypothetical protein +FIG01220419 FIG00613040: hypothetical protein +FIG01220420 FIG01220422: hypothetical protein +FIG01220422 FIG01220424: hypothetical protein +FIG01220424 FIG01220425: hypothetical protein +FIG01220425 FIG01220427: hypothetical protein +FIG01220428 FIG01220431: hypothetical protein +FIG01220431 FIG01220432: hypothetical protein +FIG01220434 FIG01220439: hypothetical protein +FIG01220440 FIG01220442: hypothetical protein +FIG01220442 FIG01220443: hypothetical protein +FIG01220445 FIG01220448: hypothetical protein +FIG01220449 hypothetical protein +FIG01220450 FIG01220453: hypothetical protein +FIG01220454 FIG01220455: hypothetical protein +FIG01220455 FIG01220457: hypothetical protein +FIG01220457 FIG01220461: hypothetical protein +FIG01220461 FIG01220464: hypothetical protein +FIG01220466 FIG01220470: hypothetical protein +FIG01220470 FIG01220472: hypothetical protein +FIG01220472 FIG01220473: hypothetical protein +FIG01220473 FIG01220474: hypothetical protein +FIG01220474 FIG01220475: hypothetical protein +FIG01220476 FIG01220481: hypothetical protein +FIG01220481 FIG01220482: hypothetical protein +FIG01220482 FIG01220486: hypothetical protein +FIG01220490 FIG01220491: hypothetical protein +FIG01220491 FIG01220492: hypothetical protein +FIG01220492 hypothetical protein +FIG01220494 FIG01220495: hypothetical protein +FIG01220498 FIG01220501: hypothetical protein +FIG01220502 FIG01220503: hypothetical protein +FIG01220503 FIG01220504: hypothetical protein +FIG01220504 FIG01220507: hypothetical protein +FIG01220509 FIG01220510: hypothetical protein +FIG01220510 FIG01220511: hypothetical protein +FIG01220511 FIG01220513: hypothetical protein +FIG01220513 FIG01220514: hypothetical protein +FIG01220514 FIG01220515: hypothetical protein +FIG01220515 FIG01220518: hypothetical protein +FIG01220518 FIG01220519: hypothetical protein +FIG01220519 FIG01220522: hypothetical protein +FIG01220522 FIG01220523: hypothetical protein +FIG01220523 FIG01220527: hypothetical protein +FIG01220527 FIG01220528: hypothetical protein +FIG01220528 FIG01220529: hypothetical protein +FIG01220529 FIG01220530: hypothetical protein +FIG01220530 FIG01220532: hypothetical protein +FIG01220532 FIG01220535: hypothetical protein +FIG01220536 FIG01220538: hypothetical protein +FIG01220539 FIG01220540: hypothetical protein +FIG01220540 FIG01220541: hypothetical protein +FIG01220541 FIG01220542: hypothetical protein +FIG01220543 FIG01220544: hypothetical protein +FIG01220544 FIG01220545: hypothetical protein +FIG01220545 FIG01220547: hypothetical protein +FIG01220549 FIG01220551: hypothetical protein +FIG01220551 FIG01220552: hypothetical protein +FIG01220558 Putative symport protein +FIG01220561 FIG01220562: hypothetical protein +FIG01220562 FIG01220563: hypothetical protein +FIG01220563 FIG01220564: hypothetical protein +FIG01220564 FIG01220565: hypothetical protein +FIG01220565 FIG01220566: hypothetical protein +FIG01220567 FIG01220568: hypothetical protein +FIG01220568 FIG01220569: hypothetical protein +FIG01220575 FIG01220576: hypothetical protein +FIG01220576 FIG01220577: hypothetical protein +FIG01220577 FIG01220578: hypothetical protein +FIG01220578 FIG01220579: hypothetical protein +FIG01220579 FIG01220580: hypothetical protein +FIG01220582 FIG01220583: hypothetical protein +FIG01220583 FIG01220584: hypothetical protein +FIG01220584 FIG01220585: hypothetical protein +FIG01220585 FIG01220586: hypothetical protein +FIG01220586 FIG01220587: hypothetical protein +FIG01220587 FIG01220588: hypothetical protein +FIG01220589 FIG01220590: hypothetical protein +FIG01220590 FIG01220591: hypothetical protein +FIG01220591 FIG01220592: hypothetical protein +FIG01220592 FIG017723: Putative cI prophage repressor protein +FIG01220593 FIG01220595: hypothetical protein +FIG01220595 FIG01220596: hypothetical protein +FIG01220596 FIG01220600: hypothetical protein +FIG01220600 FIG01220601: hypothetical protein +FIG01220608 FIG01220609: hypothetical protein +FIG01220610 putative outer membrane lipoprotein Pcp precursor +FIG01220611 FIG01220612: hypothetical protein +FIG01220620 FIG01220621: hypothetical protein +FIG01220631 FIG01220632: hypothetical protein +FIG01220632 FIG01220633: hypothetical protein +FIG01220638 FIG01220639: hypothetical protein +FIG01220639 FIG01220640: hypothetical protein +FIG01220641 FIG01220643: hypothetical protein +FIG01220643 FIG01220644: hypothetical protein +FIG01220644 ABC transporter, ATP-binding protein +FIG01220650 FIG01220653: hypothetical protein +FIG01220653 FIG01220654: hypothetical protein +FIG01220654 FIG01220655: hypothetical protein +FIG01220655 FIG01220657: hypothetical protein +FIG01220657 FIG01220658: hypothetical protein +FIG01220661 FIG01220664: hypothetical protein +FIG01220664 FIG01220672: hypothetical protein +FIG01220675 FIG01220676: hypothetical protein +FIG01220676 FIG01220678: hypothetical protein +FIG01220680 FIG01220681: hypothetical protein +FIG01220681 FIG01222146: hypothetical protein +FIG01220683 FIG01220684: hypothetical protein +FIG01220684 FIG01220685: hypothetical protein +FIG01220685 FIG01220686: hypothetical protein +FIG01220686 FIG01220687: hypothetical protein +FIG01220687 FIG01220689: hypothetical protein +FIG01220690 FIG01220691: hypothetical protein +FIG01220691 FIG01220693: hypothetical protein +FIG01220693 FIG01220694: hypothetical protein +FIG01220694 4-oxalmesaconate hydratase (EC 4.2.1.83) +FIG01220698 Rtn protein +FIG01220703 probable transcription regulator PA1347 +FIG01220706 FIG01220708: hypothetical protein +FIG01220708 FIG01220709: hypothetical protein +FIG01220710 FIG01220711: hypothetical protein +FIG01220712 Protein yecM +FIG01220716 FIG01220717: hypothetical protein +FIG01220717 FIG01220718: hypothetical protein +FIG01220718 FIG01220719: hypothetical protein +FIG01220721 FIG01220724: hypothetical protein +FIG01220725 FIG00905700: hypothetical protein +FIG01220728 FIG01220730: hypothetical protein +FIG01220733 FIG01220734: hypothetical protein +FIG01220736 FIG01220738: hypothetical protein +FIG01220739 FIG01220741: hypothetical protein +FIG01220743 FIG01220745: hypothetical protein +FIG01220745 FIG01220748: hypothetical protein +FIG01220751 FIG01220753: hypothetical protein +FIG01220753 hypothetical protein +FIG01220755 FIG01220756: hypothetical protein +FIG01220756 FIG01220758: hypothetical protein +FIG01220758 FIG01220760: hypothetical protein +FIG01220760 FIG01220763: hypothetical protein +FIG01220765 FIG01220766: hypothetical protein +FIG01220768 FIG01220769: hypothetical protein +FIG01220770 FIG01220771: hypothetical protein +FIG01220774 FIG01220777: hypothetical protein +FIG01220777 FIG01220778: hypothetical protein +FIG01220778 hypothetical protein +FIG01220781 FIG01220782: hypothetical protein +FIG01220782 FIG01220783: hypothetical protein +FIG01220786 FIG01220787: hypothetical protein +FIG01220787 FIG01220788: hypothetical protein +FIG01220788 FIG01220790: hypothetical protein +FIG01220790 FIG01220791: hypothetical protein +FIG01220791 FIG01220799: hypothetical protein +FIG01220799 hypothetical protein +FIG01220800 FIG01220801: hypothetical protein +FIG01220804 FIG01220805: hypothetical protein +FIG01220805 FIG01220808: hypothetical protein +FIG01220809 FIG01220810: hypothetical protein +FIG01220810 FIG01220811: hypothetical protein +FIG01220813 FIG01220814: hypothetical protein +FIG01220817 FIG01220819: hypothetical protein +FIG01220819 ABC-type amino acid transport system, permease component +FIG01220824 FIG01220825: hypothetical protein +FIG01220827 ABC transporter, ATP-binding protein +FIG01220831 FIG01220834: hypothetical protein +FIG01220834 FIG01220835: hypothetical protein +FIG01220835 FIG01220836: hypothetical protein +FIG01220836 FIG01220838: hypothetical protein +FIG01220838 FIG01220842: hypothetical protein +FIG01220842 FIG01220844: hypothetical protein +FIG01220846 FIG01220847: hypothetical protein +FIG01220847 FIG00545237: hypothetical protein +FIG01220849 putative Bacteriophage protein gp46 +FIG01220851 FIG01220852: hypothetical protein +FIG01220852 FIG01220855: hypothetical protein +FIG01220856 FIG01220857: hypothetical protein +FIG01220857 FIG01220858: hypothetical protein +FIG01220858 FIG01220860: hypothetical protein +FIG01220860 FIG01220861: hypothetical protein +FIG01220861 FIG01220862: hypothetical protein +FIG01220862 FIG01220864: hypothetical protein +FIG01220864 FIG01220865: hypothetical protein +FIG01220865 FIG00643385: hypothetical protein +FIG01220866 FIG01220871: hypothetical protein +FIG01220871 FIG01220873: hypothetical protein +FIG01220873 FIG01220874: hypothetical protein +FIG01220874 FIG01220875: hypothetical protein +FIG01220875 FIG01220879: hypothetical protein +FIG01220879 FIG01220881: hypothetical protein +FIG01220881 FIG01220884: hypothetical protein +FIG01220886 FIG01220888: hypothetical protein +FIG01220888 FIG01220890: hypothetical protein +FIG01220893 Bacteriophage P7 related protein +FIG01220895 FIG01220899: hypothetical protein +FIG01220902 FIG01220903: hypothetical protein +FIG01220905 no significant database match found +FIG01220906 FIG01220908: hypothetical protein +FIG01220908 FIG01220909: hypothetical protein +FIG01220910 FIG01220912: hypothetical protein +FIG01220912 FIG01220913: hypothetical protein +FIG01220913 hypothetical protein +FIG01220915 FIG01220916: hypothetical protein +FIG01220916 MltA-interacting protein precursor +FIG01220917 FIG01220918: hypothetical protein +FIG01220918 FIG01220919: hypothetical protein +FIG01220919 COG2183: Transcriptional accessory protein +FIG01220921 FIG01220922: hypothetical protein +FIG01220922 FIG01220925: hypothetical protein +FIG01220925 FIG01220928: hypothetical protein +FIG01220928 FIG01220931: hypothetical protein +FIG01220931 FIG01220933: hypothetical protein +FIG01220933 FIG01220935: hypothetical protein +FIG01220935 FIG01220936: hypothetical protein +FIG01220936 FIG01220938: hypothetical protein +FIG01220939 FIG01220940: hypothetical protein +FIG01220940 FIG01220944: hypothetical protein +FIG01220946 FIG01220948: hypothetical protein +FIG01220948 hypothetical protein +FIG01220949 FIG01220950: hypothetical protein +FIG01220950 FIG01220953: hypothetical protein +FIG01220958 FIG01220959: hypothetical protein +FIG01220959 FIG01220960: hypothetical protein +FIG01220963 FIG01220969: hypothetical protein +FIG01220970 FIG01220972: hypothetical protein +FIG01220972 FIG01220973: hypothetical protein +FIG01220973 FIG01220974: hypothetical protein +FIG01220974 FIG01220975: hypothetical protein +FIG01220978 FIG01220979: hypothetical protein +FIG01220981 FIG01220982: hypothetical protein +FIG01220982 FIG01220984: hypothetical protein +FIG01220985 FIG01220986: hypothetical protein +FIG01220997 Putative integral membrane efflux protein +FIG01221002 FIG01221005: hypothetical protein +FIG01221005 FIG01221006: hypothetical protein +FIG01221017 FIG01221018: hypothetical protein +FIG01221018 FIG01221019: hypothetical protein +FIG01221019 probable exported protein YPO3518 +FIG01221020 FIG01221021: hypothetical protein +FIG01221021 FIG01221024: hypothetical protein +FIG01221024 FIG01221025: hypothetical protein +FIG01221027 FIG01221028: hypothetical protein +FIG01221028 FIG01221030: hypothetical protein +FIG01221031 FIG01221032: hypothetical protein +FIG01221032 FIG01221035: hypothetical protein +FIG01221035 FIG01221036: hypothetical protein +FIG01221046 FIG01221048: hypothetical protein +FIG01221048 FIG01221052: hypothetical protein +FIG01221052 FIG01221053: hypothetical protein +FIG01221055 FIG01221056: hypothetical protein +FIG01221056 FIG01221057: hypothetical protein +FIG01221057 FIG01221058: hypothetical protein +FIG01221073 FIG01221076: hypothetical protein +FIG01221076 FIG01221077: hypothetical protein +FIG01221077 FIG01221079: hypothetical protein +FIG01221079 hypothetical protein +FIG01221084 FIG01221086: hypothetical protein +FIG01221087 FIG01221088: hypothetical protein +FIG01221090 FIG01221092: hypothetical protein +FIG01221092 hypothetical protein +FIG01221094 Probable microcin H47 secretion ATP-binding protein mchF +FIG01221106 hypothetical protein +FIG01221108 FIG01221109: hypothetical protein +FIG01221110 FIG01221111: hypothetical protein +FIG01221111 Unknown pentose utilization regulator 2, DeoR family +FIG01221118 Putative DNA ligase +FIG01221122 FIG01221123: hypothetical protein +FIG01221131 FIG01221133: hypothetical protein +FIG01221134 FIG01221136: hypothetical protein +FIG01221136 FIG01221138: hypothetical protein +FIG01221143 FIG01221145: hypothetical protein +FIG01221146 FIG01221148: hypothetical protein +FIG01221148 FIG01221149: hypothetical protein +FIG01221149 FIG01221150: hypothetical protein +FIG01221162 FIG01221163: hypothetical protein +FIG01221163 FIG01221165: hypothetical protein +FIG01221165 FIG01221168: hypothetical protein +FIG01221168 FIG01221169: hypothetical protein +FIG01221169 hypothetical protein +FIG01221170 ABC-type amino acid transport/signal transduction systems, periplasmic component/domain +FIG01221171 FIG01221172: hypothetical protein +FIG01221179 FIG01221181: hypothetical protein +FIG01221186 FIG01221187: hypothetical protein +FIG01221187 minor tail fiber protein M +FIG01221188 FIG01221190: hypothetical protein +FIG01221190 FIG01221192: hypothetical protein +FIG01221192 FIG01221194: hypothetical protein +FIG01221198 FIG01221199: hypothetical protein +FIG01221199 FIG01221201: hypothetical protein +FIG01221201 FIG01221203: hypothetical protein +FIG01221203 FIG01221204: hypothetical protein +FIG01221204 FIG01221208: hypothetical protein +FIG01221208 FIG01221209: hypothetical protein +FIG01221209 FIG01221210: hypothetical protein +FIG01221210 FIG01221212: hypothetical protein +FIG01221218 FIG01221223: hypothetical protein +FIG01221225 FIG01221226: hypothetical protein +FIG01221226 FIG01221227: hypothetical protein +FIG01221227 FIG01221228: hypothetical protein +FIG01221228 FIG01221229: hypothetical protein +FIG01221229 CRISPR-associated helicase Cas3, Yersinia-type +FIG01221232 FIG01221235: hypothetical protein +FIG01221235 FIG01221237: hypothetical protein +FIG01221237 FIG01221238: hypothetical protein +FIG01221238 FIG01221240: hypothetical protein +FIG01221242 FIG01221243: hypothetical protein +FIG01221253 FIG01221256: hypothetical protein +FIG01221260 FIG01221261: hypothetical protein +FIG01221261 FIG01221262: hypothetical protein +FIG01221262 FIG01221263: hypothetical protein +FIG01221266 FIG01221267: hypothetical protein +FIG01221267 FIG01221269: hypothetical protein +FIG01221269 FIG01221271: hypothetical protein +FIG01221271 FIG01221275: hypothetical protein +FIG01221275 FIG01221278: hypothetical protein +FIG01221279 Regulatory protein CII bacteriophage 186 +FIG01221281 FIG01221289: hypothetical protein +FIG01221289 FIG01221290: hypothetical protein +FIG01221295 FIG01221296: hypothetical protein +FIG01221296 FIG01221298: hypothetical protein +FIG01221298 FIG01221299: hypothetical protein +FIG01221299 FIG01221301: hypothetical protein +FIG01221301 FIG01221302: hypothetical protein +FIG01221302 FIG01221303: hypothetical protein +FIG01221303 FIG01221304: hypothetical protein +FIG01221304 FIG01221306: hypothetical protein +FIG01221312 FIG01221314: hypothetical protein +FIG01221314 FIG01221319: hypothetical protein +FIG01221319 FIG01221322: hypothetical protein +FIG01221322 FIG01221323: hypothetical protein +FIG01221323 FIG01221324: hypothetical protein +FIG01221324 FIG01221327: hypothetical protein +FIG01221333 FIG01221335: hypothetical protein +FIG01221335 not considered as relevant in Y.pestis C0-92 annotation. +FIG01221339 FIG01221340: hypothetical protein +FIG01221340 FIG01221341: hypothetical protein +FIG01221343 FIG01221344: hypothetical protein +FIG01221344 FIG01221345: hypothetical protein +FIG01221346 FIG01221350: hypothetical protein +FIG01221351 FIG01221352: hypothetical protein +FIG01221352 FIG01221356: hypothetical protein +FIG01221356 FIG01221360: hypothetical protein +FIG01221363 FIG01221365: hypothetical protein +FIG01221368 FIG01221369: hypothetical protein +FIG01221369 FIG01221376: hypothetical protein +FIG01221376 FIG01221377: hypothetical protein +FIG01221377 FIG01221378: hypothetical protein +FIG01221379 FIG01221380: hypothetical protein +FIG01221382 FIG01221383: hypothetical protein +FIG01221383 FIG01221384: hypothetical protein +FIG01221384 FIG01221386: hypothetical protein +FIG01221386 FIG01221390: hypothetical protein +FIG01221394 FIG01221397: hypothetical protein +FIG01221403 FIG01221404: hypothetical protein +FIG01221405 FIG01221406: hypothetical protein +FIG01221408 FIG01221409: hypothetical protein +FIG01221409 FIG01221411: hypothetical protein +FIG01221412 FIG01221414: hypothetical protein +FIG01221414 FIG01221416: hypothetical protein +FIG01221428 FIG01221432: hypothetical protein +FIG01221434 Channel-forming transporter/cytolysins activator of TpsB family +FIG01221437 FIG01221438: hypothetical protein +FIG01221439 Putative prophage Hp1 family Holin precursor +FIG01221442 FIG01221445: hypothetical protein +FIG01221445 FIG01221446: hypothetical protein +FIG01221449 FIG01221454: hypothetical protein +FIG01221454 FIG01221461: hypothetical protein +FIG01221461 hypothetical protein +FIG01221466 Hypothetical response regulatory protein ypdB +FIG01221468 FIG01221469: hypothetical protein +FIG01221474 FIG01221475: hypothetical protein +FIG01221477 FIG01221482: hypothetical protein +FIG01221486 hypothetical protein +FIG01221490 FIG01221494: hypothetical protein +FIG01221495 FIG01221496: hypothetical protein +FIG01221496 FIG01221499: hypothetical protein +FIG01221503 FIG01221505: hypothetical protein +FIG01221510 hypothetical protein +FIG01221525 Prophage tail fiber protein +FIG01221531 FIG01221533: hypothetical protein +FIG01221537 FIG01221542: hypothetical protein +FIG01221542 FIG01221544: hypothetical protein +FIG01221544 FIG01221545: hypothetical protein +FIG01221545 FIG01221547: hypothetical protein +FIG01221549 FIG01221551: hypothetical protein +FIG01221553 FIG01221556: hypothetical protein +FIG01221558 FIG01221559: hypothetical protein +FIG01221563 FIG01221564: hypothetical protein +FIG01221564 FIG01221565: hypothetical protein +FIG01221565 FIG01221566: hypothetical protein +FIG01221566 Cytochrome B561 +FIG01221573 FIG01221574: hypothetical protein +FIG01221586 FIG01221595: hypothetical protein +FIG01221601 FIG01221603: hypothetical protein +FIG01221603 FIG01221605: hypothetical protein +FIG01221605 FIG01221612: hypothetical protein +FIG01221617 FIG01221618: hypothetical protein +FIG01221620 FIG01221635: hypothetical protein +FIG01221637 FIG01221638: hypothetical protein +FIG01221638 FIG01221642: hypothetical protein +FIG01221649 FIG01221650: hypothetical protein +FIG01221650 FIG01221654: hypothetical protein +FIG01221654 FIG01221655: hypothetical protein +FIG01221657 FIG01221660: hypothetical protein +FIG01221660 FIG01221663: hypothetical protein +FIG01221663 FIG01221666: hypothetical protein +FIG01221666 hypothetical protein +FIG01221677 FIG01221678: hypothetical protein +FIG01221685 FIG01221686: hypothetical protein +FIG01221686 FIG01221689: hypothetical protein +FIG01221689 FIG01221690: hypothetical protein +FIG01221690 FIG01221691: hypothetical protein +FIG01221695 FIG01221697: hypothetical protein +FIG01221697 FIG01221700: hypothetical protein +FIG01221703 FIG01221705: hypothetical protein +FIG01221713 FIG01221715: hypothetical protein +FIG01221715 hypothetical protein +FIG01221716 FIG01221719: hypothetical protein +FIG01221720 FIG01221722: hypothetical protein +FIG01221722 FIG01221723: hypothetical protein +FIG01221723 FIG01221724: hypothetical protein +FIG01221725 hypothetical protein +FIG01221727 FIG01221728: hypothetical protein +FIG01221728 FIG01221729: hypothetical protein +FIG01221729 FIG01221730: hypothetical protein +FIG01221730 FIG01221733: hypothetical protein +FIG01221744 FIG01221747: hypothetical protein +FIG01221747 FIG01221748: hypothetical protein +FIG01221748 FIG01221749: hypothetical protein +FIG01221750 FIG01221752: hypothetical protein +FIG01221752 FIG01221753: hypothetical protein +FIG01221754 FIG01221756: hypothetical protein +FIG01221756 FIG01221757: hypothetical protein +FIG01221758 FIG01221759: hypothetical protein +FIG01221759 FIG01221761: hypothetical protein +FIG01221761 FIG01221762: hypothetical protein +FIG01221762 FIG01221763: hypothetical protein +FIG01221766 FIG01221767: hypothetical protein +FIG01221775 FIG01221777: hypothetical protein +FIG01221777 FIG01221779: hypothetical protein +FIG01221779 Putative exported protein. precursor +FIG01221786 FIG01221789: hypothetical protein +FIG01221790 FIG01221792: hypothetical protein +FIG01221794 FIG01221797: hypothetical protein +FIG01221798 FIG01221800: hypothetical protein +FIG01221803 FIG01221804: hypothetical protein +FIG01221807 FIG01221809: hypothetical protein +FIG01221812 FIG01221814: hypothetical protein +FIG01221814 FIG01221816: hypothetical protein +FIG01221816 FIG01221817: hypothetical protein +FIG01221819 FIG01221823: hypothetical protein +FIG01221829 FIG01221832: hypothetical protein +FIG01221832 FIG01221834: hypothetical protein +FIG01221842 FIG01221846: hypothetical protein +FIG01221846 FIG01221849: hypothetical protein +FIG01221852 FIG01221853: hypothetical protein +FIG01221853 FIG01221854: hypothetical protein +FIG01221856 FIG01221857: hypothetical protein +FIG01221857 FIG01221858: hypothetical protein +FIG01221861 FIG01221864: hypothetical protein +FIG01221870 FIG01221871: hypothetical protein +FIG01221875 FIG01221876: hypothetical protein +FIG01221876 FIG01221877: hypothetical protein +FIG01221877 FIG01221880: hypothetical protein +FIG01221885 FIG01221888: hypothetical protein +FIG01221888 FIG01221895: hypothetical protein +FIG01221895 COG1475: Predicted transcriptional regulators +FIG01221898 FIG01221901: hypothetical protein +FIG01221901 FIG01221904: hypothetical protein +FIG01221905 FIG01221910: hypothetical protein +FIG01221919 FIG01221920: hypothetical protein +FIG01221926 FIG01221928: hypothetical protein +FIG01221928 Putative bacteriophage terminase large subunit +FIG01221930 FIG01221931: hypothetical protein +FIG01221931 FIG01221934: hypothetical protein +FIG01221938 FIG01221940: hypothetical protein +FIG01221943 FIG01221946: hypothetical protein +FIG01221951 FIG01221955: hypothetical protein +FIG01221955 FIG01221956: hypothetical protein +FIG01221956 FIG01221957: hypothetical protein +FIG01221960 FIG01221963: hypothetical protein +FIG01221968 FIG01221969: hypothetical protein +FIG01221973 FIG01221983: hypothetical protein +FIG01221984 FIG01221985: hypothetical protein +FIG01221997 Phage replication protein O +FIG01222005 FIG01222009: hypothetical protein +FIG01222012 FIG01222020: hypothetical protein +FIG01222020 FIG01222021: hypothetical protein +FIG01222021 FIG01222022: hypothetical protein +FIG01222022 FIG01222023: hypothetical protein +FIG01222023 FIG01222024: hypothetical protein +FIG01222027 FIG01222028: hypothetical protein +FIG01222044 hypothetical protein +FIG01222045 FIG01222046: hypothetical protein +FIG01222046 Putative colicin immunity protein +FIG01222047 FIG01222048: hypothetical protein +FIG01222049 FIG01222050: hypothetical protein +FIG01222054 FIG01222055: hypothetical protein +FIG01222055 FIG01222059: hypothetical protein +FIG01222065 FIG01222072: hypothetical protein +FIG01222072 FIG01222082: hypothetical protein +FIG01222085 FIG01222087: hypothetical protein +FIG01222100 phage hypothetical protein +FIG01222108 Methyl parathion hydrolase +FIG01222111 FIG01222113: hypothetical protein +FIG01222116 hypothetical protein +FIG01222121 FIG01222123: hypothetical protein +FIG01222123 FIG01222125: hypothetical protein +FIG01222130 COG4834: Uncharacterized protein conserved in bacteria +FIG01222131 FIG01222135: hypothetical protein +FIG01222136 FIG01222139: hypothetical protein +FIG01222139 FIG01222141: hypothetical protein +FIG01222141 FIG01222144: hypothetical protein +FIG01222144 YafW protein (antitoxin to YkfI) +FIG01222153 FIG01222156: hypothetical protein +FIG01222156 FIG01222158: hypothetical protein +FIG01222159 FIG01222160: hypothetical protein +FIG01222160 FIG01222162: hypothetical protein +FIG01222162 hypothetical protein +FIG01222169 Ascorbate-specific PTS system, EIIC component / Ascorbate-specific PTS system, EIIB component (EC 2.7.1.69) +FIG01222174 FIG01222177: hypothetical protein +FIG01222189 FIG01222190: hypothetical protein +FIG01222194 Putative O-unit flippase +FIG01222197 FIG01222200: hypothetical protein +FIG01222210 FIG01222211: hypothetical protein +FIG01222215 FIG01222218: hypothetical protein +FIG01222218 FIG01222219: hypothetical protein +FIG01222219 FIG01222221: hypothetical protein +FIG01222221 FIG01222222: hypothetical protein +FIG01222224 FIG01222225: hypothetical protein +FIG01222226 FIG01222227: hypothetical protein +FIG01222230 hypothetical phage-related protein +FIG01222233 FIG01222236: hypothetical protein +FIG01222243 FIG01222245: hypothetical protein +FIG01222245 FIG01222255: hypothetical protein +FIG01222255 FIG01222256: hypothetical protein +FIG01222259 FIG01222261: hypothetical protein +FIG01222262 FIG01222264: hypothetical protein +FIG01222280 FIG01222281: hypothetical protein +FIG01222281 FIG01222285: hypothetical protein +FIG01222285 FIG01222286: hypothetical protein +FIG01222292 FIG01222295: hypothetical protein +FIG01222300 FIG01222301: hypothetical protein +FIG01222301 FIG01222303: hypothetical protein +FIG01222307 FIG01222309: hypothetical protein +FIG01222331 FIG01222333: hypothetical protein +FIG01222333 FIG01222334: hypothetical protein +FIG01222334 FIG01222339: hypothetical protein +FIG01222339 FIG01222342: hypothetical protein +FIG01222342 FIG01222344: hypothetical protein +FIG01222345 Inner membrane protein YiaH +FIG01222353 FIG01222355: hypothetical protein +FIG01222362 FIG01222364: hypothetical protein +FIG01222370 FIG01222373: hypothetical protein +FIG01222400 FIG01222402: hypothetical protein +FIG01222412 FIG01222416: hypothetical protein +FIG01222416 FIG01222420: hypothetical protein +FIG01222423 FIG01222425: hypothetical protein +FIG01222427 extracellular functions; secreted proteins +FIG01222439 FIG01222442: hypothetical protein +FIG01222452 FIG01222454: hypothetical protein +FIG01222458 FIG01222459: hypothetical protein +FIG01222463 FIG01222464: hypothetical protein +FIG01222485 FIG01222486: hypothetical protein +FIG01222487 FIG01222488: hypothetical protein +FIG01222493 FIG01222494: hypothetical protein +FIG01222496 FIG01222503: hypothetical protein +FIG01222503 FIG01222506: hypothetical protein +FIG01222506 FIG01222507: hypothetical protein +FIG01222507 Secretion system apparatus protein SsaM +FIG01222510 FIG01222513: hypothetical protein +FIG01222514 FIG01222516: hypothetical protein +FIG01222522 FIG01222523: hypothetical protein +FIG01222523 COG0054: Riboflavin synthase beta-chain +FIG01222524 FIG01222525: hypothetical protein +FIG01222534 FIG01222535: hypothetical protein +FIG01222540 Possible high molecular weight siderophore biosynthesis protein +FIG01222549 COG4975: Putative glucose uptake permease +FIG01222551 FIG01222552: hypothetical protein +FIG01222552 FIG01222554: hypothetical protein +FIG01222571 FIG01222572: hypothetical protein +FIG01222582 possible (AB008550) orf34 [bacteriophage phi CTX] +FIG01222590 FIG01222591: hypothetical protein +FIG01222595 FIG01222596: hypothetical protein +FIG01222597 hypothetical protein +FIG01222603 hypothetical protein +FIG01222606 FIG01222608: hypothetical protein +FIG01222610 FIG01222618: hypothetical protein +FIG01222621 FIG01222622: hypothetical protein +FIG01222625 FIG01222630: hypothetical protein +FIG01222630 FIG01222631: hypothetical protein +FIG01222632 COG0188: Type IIA topoisomerase (DNA gyrase/topo II, topoisomerase IV), A subunit +FIG01222649 FIG01222654: hypothetical protein +FIG01222654 FIG01222655: hypothetical protein +FIG01222655 chaperone protein ecpD precursor +FIG01222666 COG1974: SOS-response transcriptional repressors (RecA-mediated autopeptidases) +FIG01222667 FIG01222669: hypothetical protein +FIG01222672 FIG01222673: hypothetical protein +FIG01222673 FIG01222674: hypothetical protein +FIG01222674 FIG01222678: hypothetical protein +FIG01222678 COG0484: DnaJ-class molecular chaperone with C-terminal Zn finger domain +FIG01222682 transposon resolvase +FIG01222693 FIG01222695: hypothetical protein +FIG01222696 FIG01222698: hypothetical protein +FIG01222703 FIG01222709: hypothetical protein +FIG01222713 FIG01222714: hypothetical protein +FIG01222714 FIG01222715: hypothetical protein +FIG01222720 FIG01222723: hypothetical protein +FIG01222725 COG4679: Phage-related protein +FIG01222728 FIG01222730: hypothetical protein +FIG01222737 COG0226: ABC-type phosphate transport system, periplasmic component +FIG01222744 FIG01222745: hypothetical protein +FIG01222746 FIG01222749: hypothetical protein +FIG01222749 FIG01222750: hypothetical protein +FIG01222761 FIG01222769: hypothetical protein +FIG01222773 FIG01222776: hypothetical protein +FIG01222786 FIG01222787: hypothetical protein +FIG01222787 FIG01222791: hypothetical protein +FIG01222791 FIG01222793: hypothetical protein +FIG01222793 FIG01222794: hypothetical protein +FIG01222794 FIG01222795: hypothetical protein +FIG01222806 FIG01222807: hypothetical protein +FIG01222811 FIG01222815: hypothetical protein +FIG01222815 FIG01222816: hypothetical protein +FIG01222836 Similar to Orf81 bacteriophage 186 +FIG01222837 FIG01222838: hypothetical protein +FIG01222840 FIG01222841: hypothetical protein +FIG01222849 FIG01222850: hypothetical protein +FIG01222850 FIG01222851: hypothetical protein +FIG01222851 FIG01222853: hypothetical protein +FIG01222859 FIG01222860: hypothetical protein +FIG01222860 FIG01222862: hypothetical protein +FIG01222878 FIG01222884: hypothetical protein +FIG01222884 FIG01222886: hypothetical protein +FIG01222904 FIG01222905: hypothetical protein +FIG01222906 FIG01222908: hypothetical protein +FIG01222913 FIG01222914: hypothetical protein +FIG01222917 putative portal vertex protein +FIG01222930 FIG01222935: hypothetical protein +FIG01222939 FIG00640012: hypothetical protein +FIG01222945 FIG01222949: hypothetical protein +FIG01222953 FIG01222955: hypothetical protein +FIG01222955 FIG01222957: hypothetical protein +FIG01222957 FIG01222963: hypothetical protein +FIG01222963 FIG01222964: hypothetical protein +FIG01222964 FIG01222972: hypothetical protein +FIG01222972 FIG01222973: hypothetical protein +FIG01222990 FIG01222992: hypothetical protein +FIG01223025 FIG01223030: hypothetical protein +FIG01223030 FIG01223031: hypothetical protein +FIG01223032 Type III secretion protein SsaB +FIG01223047 FIG01223048: hypothetical protein +FIG01223058 FIG01223060: hypothetical protein +FIG01223060 FIG01223065: hypothetical protein +FIG01223084 FIG01223090: hypothetical protein +FIG01223096 FIG01223097: hypothetical protein +FIG01223097 FIG01223098: hypothetical protein +FIG01223099 FIG01223103: hypothetical protein +FIG01223105 FIG01223109: hypothetical protein +FIG01223109 FIG01223111: hypothetical protein +FIG01223116 putative LPS biosynthesis related glycosyltransferase +FIG01223126 FIG01223130: hypothetical protein +FIG01223139 Protein MbtH +FIG01223142 FIG01223143: hypothetical protein +FIG01223149 FIG01223150: hypothetical protein +FIG01223152 FIG01223153: hypothetical protein +FIG01223153 FIG01223156: hypothetical protein +FIG01223156 FIG01223157: hypothetical protein +FIG01223157 FIG01223159: hypothetical protein +FIG01223162 FIG01223166: hypothetical protein +FIG01223168 FIG01223176: hypothetical protein +FIG01223176 FIG01223190: hypothetical protein +FIG01223198 FIG01223199: hypothetical protein +FIG01223203 Putative cytoplasmic protein (STMD1.83 protein) +FIG01223210 FIG01223212: hypothetical protein +FIG01223212 FIG01223216: hypothetical protein +FIG01223218 FIG01223220: hypothetical protein +FIG01223220 leader; amino acid biosynthesis: Isoleucine, Valine +FIG01223227 FIG01223228: hypothetical protein +FIG01223253 putative (AJ250469) putative SinR-like protein [Clostri... +FIG01223258 FIG01223266: hypothetical protein +FIG01223279 FIG01223285: hypothetical protein +FIG01223285 FIG01223286: hypothetical protein +FIG01223287 FIG01223288: hypothetical protein +FIG01223299 FIG01223304: hypothetical protein +FIG01223320 FIG01223325: hypothetical protein +FIG01223325 FIG01223327: hypothetical protein +FIG01223332 COG0778: Nitroreductase +FIG01223338 FIG01223339: hypothetical protein +FIG01223347 FIG01223349: hypothetical protein +FIG01223360 FIG01223362: hypothetical protein +FIG01223363 FIG01223366: hypothetical protein +FIG01223368 FIG01223371: hypothetical protein +FIG01223371 FIG01223372: hypothetical protein +FIG01223373 FIG01223374: hypothetical protein +FIG01223374 FIG01223375: hypothetical protein +FIG01223385 FIG01223389: hypothetical protein +FIG01223406 FIG01223412: hypothetical protein +FIG01223443 FIG01223449: hypothetical protein +FIG01223451 Hypothetical UPF0194 membrane protein ybhG +FIG01223465 FIG01223466: hypothetical protein +FIG01223466 COG1846: Transcriptional regulators +FIG01223482 FIG01223486: hypothetical protein +FIG01223486 FIG01223487: hypothetical protein +FIG01223488 FIG01223489: hypothetical protein +FIG01223490 FIG01223492: hypothetical protein +FIG01223493 Pili assembly chaperone precursor +FIG01223499 Putative pertactin family virulence factor/autotransporter precursor +FIG01223510 FIG01223511: hypothetical protein +FIG01223511 FIG01223512: hypothetical protein +FIG01223531 FIG01223534: hypothetical protein +FIG01223543 FIG01223544: hypothetical protein +FIG01223548 FIG01223549: hypothetical protein +FIG01223563 FIG01223564: hypothetical protein +FIG01223564 FIG01223566: hypothetical protein +FIG01223577 FIG01223581: hypothetical protein +FIG01223588 FIG01223592: hypothetical protein +FIG01223592 FIG01223601: hypothetical protein +FIG01223616 Type III secretion injected virulence protein (YopH,tyrosine phosphatase of FAK and p130cas, prevents phagocytosis) +FIG01223635 FIG01223637: hypothetical protein +FIG01223644 FIG01223646: hypothetical protein +FIG01223667 FIG01223676: hypothetical protein +FIG01223692 FIG01223696: hypothetical protein +FIG01223696 putative plasmid-related transcriptional repressor protein +FIG01223723 FIG01223726: hypothetical protein +FIG01223726 FIG01223727: hypothetical protein +FIG01223750 FIG01223757: hypothetical protein +FIG01223771 hypothetical protein +FIG01223775 FIG01223776: hypothetical protein +FIG01223783 FIG01223786: hypothetical protein +FIG01223798 FIG01223800: hypothetical protein +FIG01223803 FIG01223807: hypothetical protein +FIG01223807 Furin precursor (EC 3.4.21.75) +FIG01223835 FIG01223837: hypothetical protein +FIG01223837 FIG01223838: hypothetical protein +FIG01223844 FIG01223846: hypothetical protein +FIG01223846 FIG01223853: hypothetical protein +FIG01223855 FIG01223857: hypothetical protein +FIG01223857 FIG01223861: hypothetical protein +FIG01223861 FIG01223862: hypothetical protein +FIG01223898 FIG01223901: hypothetical protein +FIG01223908 FIG01223910: hypothetical protein +FIG01223933 FIG01223934: hypothetical protein +FIG01223987 FIG01223988: hypothetical protein +FIG01224015 FIG01224016: hypothetical protein +FIG01224025 FIG01224026: hypothetical protein +FIG01224028 FIG01224031: hypothetical protein +FIG01224035 FIG01224036: hypothetical protein +FIG01224136 FIG01224140: hypothetical protein +FIG01224157 FIG01224161: hypothetical protein +FIG01224225 FIG01224229: hypothetical protein +FIG01224254 FIG01224255: hypothetical protein +FIG01224255 FIG01224258: hypothetical protein +FIG01224258 FIG01224259: hypothetical protein +FIG01224261 FIG01224266: hypothetical protein +FIG01224273 FIG01224274: hypothetical protein +FIG01224275 FIG01224276: hypothetical protein +FIG01224277 FIG01224280: hypothetical protein +FIG01224280 FIG01224281: hypothetical protein +FIG01224281 FIG01224282: hypothetical protein +FIG01224283 FIG01224284: hypothetical protein +FIG01224284 FIG01224285: hypothetical protein +FIG01224285 FIG01224286: hypothetical protein +FIG01224289 FIG01224290: hypothetical protein +FIG01224293 FIG01224296: hypothetical protein +FIG01224299 FIG01224300: hypothetical protein +FIG01224300 FIG01224301: hypothetical protein +FIG01224301 FIG01224302: hypothetical protein +FIG01224303 FIG01224304: hypothetical protein +FIG01224304 FIG01224306: hypothetical protein +FIG01224309 FIG01224310: hypothetical protein +FIG01224311 FIG01224312: hypothetical protein +FIG01224312 FIG01224314: hypothetical protein +FIG01224314 FIG01224316: hypothetical protein +FIG01224316 FIG01224318: hypothetical protein +FIG01224318 FIG01224319: hypothetical protein +FIG01224319 FIG01224320: hypothetical protein +FIG01224320 FIG01224322: hypothetical protein +FIG01224322 FIG01224324: hypothetical protein +FIG01224324 FIG01224326: hypothetical protein +FIG01224326 FIG01224327: hypothetical protein +FIG01224328 FIG01224329: hypothetical protein +FIG01224329 FIG01224330: hypothetical protein +FIG01224330 FIG01224331: hypothetical protein +FIG01224331 FIG01224332: hypothetical protein +FIG01224332 FIG01224333: hypothetical protein +FIG01224335 FIG01224336: hypothetical protein +FIG01224338 FIG01224339: hypothetical protein +FIG01224339 FIG01224343: hypothetical protein +FIG01224343 FIG01224344: hypothetical protein +FIG01224344 FIG01224347: hypothetical protein +FIG01224348 COG1872 +FIG01224352 FIG01224353: hypothetical protein +FIG01224354 FIG01224355: hypothetical protein +FIG01224356 FIG01224357: hypothetical protein +FIG01224359 FIG01224360: hypothetical protein +FIG01224360 FIG01224362: hypothetical protein +FIG01224363 FIG01224364: hypothetical protein +FIG01224365 FIG01224366: hypothetical protein +FIG01224366 FIG01224368: hypothetical protein +FIG01224372 FIG01224374: hypothetical protein +FIG01224378 FIG01224379: hypothetical protein +FIG01224379 FIG01224380: hypothetical protein +FIG01224380 FIG01224381: hypothetical protein +FIG01224381 FIG01224383: hypothetical protein +FIG01224383 FIG01224385: hypothetical protein +FIG01224388 FIG01224389: hypothetical protein +FIG01224389 FIG01224391: hypothetical protein +FIG01224391 FIG01224393: hypothetical protein +FIG01224394 constituent protein +FIG01224398 FIG01224400: hypothetical protein +FIG01224400 FIG01224401: hypothetical protein +FIG01224401 FIG01224402: hypothetical protein +FIG01224404 FIG01224405: hypothetical protein +FIG01224405 FIG01224409: hypothetical protein +FIG01224409 FIG01224410: hypothetical protein +FIG01224413 FIG01224415: hypothetical protein +FIG01224415 FIG01224417: hypothetical protein +FIG01224417 FIG01224418: hypothetical protein +FIG01224418 cell wall hydrolyses +FIG01224422 FIG01224424: hypothetical protein +FIG01224424 FIG01224426: hypothetical protein +FIG01224429 FIG01224432: hypothetical protein +FIG01224439 FIG01224440: hypothetical protein +FIG01224440 FIG01224441: hypothetical protein +FIG01224441 FIG01224442: hypothetical protein +FIG01224442 FIG01224443: hypothetical protein +FIG01224443 FIG01224446: hypothetical protein +FIG01224448 FIG01224451: hypothetical protein +FIG01224451 FIG01224456: hypothetical protein +FIG01224461 FIG01224462: hypothetical protein +FIG01224462 FIG01224463: hypothetical protein +FIG01224464 FIG01224466: hypothetical protein +FIG01224466 FIG01224467: hypothetical protein +FIG01224467 FIG01224469: hypothetical protein +FIG01224469 FIG01224471: hypothetical protein +FIG01224472 FIG01224473: hypothetical protein +FIG01224473 FIG01224474: hypothetical protein +FIG01224474 FIG01224475: hypothetical protein +FIG01224475 FIG01224476: hypothetical protein +FIG01224478 FIG01224479: hypothetical protein +FIG01224479 FIG01224480: hypothetical protein +FIG01224482 FIG01224483: hypothetical protein +FIG01224484 FIG01224485: hypothetical protein +FIG01224485 FIG01224486: hypothetical protein +FIG01224486 FIG01224488: hypothetical protein +FIG01224488 FIG01224489: hypothetical protein +FIG01224489 FIG01224490: hypothetical protein +FIG01224490 FIG01224491: hypothetical protein +FIG01224491 FIG01224492: hypothetical protein +FIG01224492 FIG01224493: hypothetical protein +FIG01224493 FIG01224494: hypothetical protein +FIG01224494 two-component signal transduction histidine kinase +FIG01224496 FIG01224497: hypothetical protein +FIG01224498 FIG01224499: hypothetical protein +FIG01224499 RTX toxin +FIG01224502 FIG01224504: hypothetical protein +FIG01224504 FIG01224506: hypothetical protein +FIG01224508 FIG01224509: hypothetical protein +FIG01224510 FIG01224511: hypothetical protein +FIG01224511 FIG01224512: hypothetical protein +FIG01224514 FIG01224515: hypothetical protein +FIG01224518 FIG01224519: hypothetical protein +FIG01224519 FIG01224520: hypothetical protein +FIG01224523 FIG01224524: hypothetical protein +FIG01224524 FIG01224525: hypothetical protein +FIG01224525 FIG01224528: hypothetical protein +FIG01224528 FIG01224531: hypothetical protein +FIG01224531 FIG01224533: hypothetical protein +FIG01224534 FIG01224535: hypothetical protein +FIG01224537 FIG01224539: hypothetical protein +FIG01224544 FIG01224545: hypothetical protein +FIG01224545 Histidinol-phosphatase [alternative form] (EC 3.1.3.15) +FIG01224547 FIG01224549: hypothetical protein +FIG01224550 FIG01224551: hypothetical protein +FIG01224553 FIG01224555: hypothetical protein +FIG01224555 FIG01224557: hypothetical protein +FIG01224562 collagenase +FIG01224565 FIG01224568: hypothetical protein +FIG01224569 FIG01224572: hypothetical protein +FIG01224573 FIG01224574: hypothetical protein +FIG01224574 FIG01224575: hypothetical protein +FIG01224577 Acid phosphatase precursor (EC 3.1.3.2) +FIG01224578 FIG01224580: hypothetical protein +FIG01224580 FIG01224581: hypothetical protein +FIG01224581 NAD(P)H-dependent 2-cyclohexen-1-one reductase +FIG01224582 FIG01224583: hypothetical protein +FIG01224584 FIG01224585: hypothetical protein +FIG01224586 FIG01224587: hypothetical protein +FIG01224587 FIG01224589: hypothetical protein +FIG01224589 Acetylornithine deacetylase (EC 3.4.17.-) +FIG01224591 FIG01224593: hypothetical protein +FIG01224593 FIG01224594: hypothetical protein +FIG01224594 FIG01224596: hypothetical protein +FIG01224596 FIG01224597: hypothetical protein +FIG01224597 FIG01224598: hypothetical protein +FIG01224598 isoleucine biosynthesis transcriptional activator +FIG01224602 FIG01224603: hypothetical protein +FIG01224603 FIG01224604: hypothetical protein +FIG01224604 FIG01224608: hypothetical protein +FIG01224608 FIG01224609: hypothetical protein +FIG01224609 FIG01224610: hypothetical protein +FIG01224612 FIG01224613: hypothetical protein +FIG01224616 pseudouridylate synthase( EC:4.2.1.70 ) +FIG01224617 FIG01224618: hypothetical protein +FIG01224629 FIG01224631: hypothetical protein +FIG01224631 FIG01224632: hypothetical protein +FIG01224632 FIG01224633: hypothetical protein +FIG01224633 FIG01224635: hypothetical protein +FIG01224635 FIG01224637: hypothetical protein +FIG01224637 FIG01224638: hypothetical protein +FIG01224638 FIG01224639: hypothetical protein +FIG01224639 FIG01224641: hypothetical protein +FIG01224641 FIG01224642: hypothetical protein +FIG01224642 FIG01224644: hypothetical protein +FIG01224644 FIG01224648: hypothetical protein +FIG01224649 FIG01224651: hypothetical protein +FIG01224651 FIG01224653: hypothetical protein +FIG01224653 FIG01224654: hypothetical protein +FIG01224654 FIG01224655: hypothetical protein +FIG01224656 FIG01224657: hypothetical protein +FIG01224658 FIG01224659: hypothetical protein +FIG01224659 FIG01224660: hypothetical protein +FIG01224660 FIG01224661: hypothetical protein +FIG01224661 FIG01224662: hypothetical protein +FIG01224664 FIG01224665: hypothetical protein +FIG01224665 FIG01224667: hypothetical protein +FIG01224669 FIG01224670: hypothetical protein +FIG01224670 FIG01224671: hypothetical protein +FIG01224671 FIG01224672: hypothetical protein +FIG01224673 FIG01224674: hypothetical protein +FIG01224674 FIG01224675: hypothetical protein +FIG01224675 FIG01224676: hypothetical protein +FIG01224676 FIG01224677: hypothetical protein +FIG01224677 ABC-2 precursor +FIG01224678 FIG01224679: hypothetical protein +FIG01224679 FIG01224680: hypothetical protein +FIG01224680 FIG01224681: hypothetical protein +FIG01224686 FIG01224687: hypothetical protein +FIG01224689 FIG01224690: hypothetical protein +FIG01224694 FIG01224695: hypothetical protein +FIG01224702 FIG01224706: hypothetical protein +FIG01224709 FIG01224710: hypothetical protein +FIG01224714 secretion activator protein +FIG01224717 FIG01224719: hypothetical protein +FIG01224719 FIG01224720: hypothetical protein +FIG01224720 FIG01224723: hypothetical protein +FIG01224723 FIG01224725: hypothetical protein +FIG01224726 FIG01224729: hypothetical protein +FIG01224729 FIG01224730: hypothetical protein +FIG01224730 FIG01224734: hypothetical protein +FIG01224735 FIG01224736: hypothetical protein +FIG01224736 FIG01224737: hypothetical protein +FIG01224747 FIG01224748: hypothetical protein +FIG01224748 FIG01224749: hypothetical protein +FIG01224752 FIG01224753: hypothetical protein +FIG01224753 FIG01224754: hypothetical protein +FIG01224754 FIG01224757: hypothetical protein +FIG01224757 FIG01224758: hypothetical protein +FIG01224758 FIG01224759: hypothetical protein +FIG01224762 FIG01224763: hypothetical protein +FIG01224765 FIG01224766: hypothetical protein +FIG01224767 toluene tolerance family protein +FIG01224770 FIG01224772: hypothetical protein +FIG01224773 FIG01224774: hypothetical protein +FIG01224774 FIG01224776: hypothetical protein +FIG01224776 arabinose efflux permease +FIG01224778 FIG01224780: hypothetical protein +FIG01224783 Succinate dehydrogenase (EC 1.3.99.1) +FIG01224784 FIG01224786: hypothetical protein +FIG01224787 FIG01224789: hypothetical protein +FIG01224791 FIG01224793: hypothetical protein +FIG01224793 Mg(2+) transport ATPase protein C +FIG01224797 ABC transporter dipeptide-binding protein +FIG01224801 Flagellar assembly protein FliH +FIG01224804 FIG01224806: hypothetical protein +FIG01224806 FIG01224807: hypothetical protein +FIG01224807 FIG01224810: hypothetical protein +FIG01224811 FIG01224812: hypothetical protein +FIG01224813 FIG01224814: hypothetical protein +FIG01224814 FIG01224815: hypothetical protein +FIG01224815 FIG01224816: hypothetical protein +FIG01224816 FIG01224817: hypothetical protein +FIG01224822 FIG01224824: hypothetical protein +FIG01224826 FIG01224828: hypothetical protein +FIG01224828 FIG01224830: hypothetical protein +FIG01224832 thiamine monophosphate synthase +FIG01224835 FIG01224837: hypothetical protein +FIG01224837 FIG01224838: hypothetical protein +FIG01224840 FIG01224841: hypothetical protein +FIG01224841 peptidyl-prolyl isomerase( EC:5.2.1.8 ) +FIG01224850 FIG01224852: hypothetical protein +FIG01224857 expression activator protein +FIG01224858 FIG01224859: hypothetical protein +FIG01224863 FIG01224867: hypothetical protein +FIG01224867 FIG01224871: hypothetical protein +FIG01224874 FIG01224875: hypothetical protein +FIG01224879 FIG01224880: hypothetical protein +FIG01224882 FIG01224883: hypothetical protein +FIG01224883 FIG01224884: hypothetical protein +FIG01224884 probable GTP binding protein +FIG01224885 FIG01224887: hypothetical protein +FIG01224888 FIG01224889: hypothetical protein +FIG01224889 FIG01224891: hypothetical protein +FIG01224891 FIG01224892: hypothetical protein +FIG01224892 FIG01224894: hypothetical protein +FIG01224894 FIG01224895: hypothetical protein +FIG01224895 FIG01224898: hypothetical protein +FIG01224898 FIG01224899: hypothetical protein +FIG01224902 PnuC protein +FIG01224903 FIG01224904: hypothetical protein +FIG01224909 FIG01224910: hypothetical protein +FIG01224910 FIG01224911: hypothetical protein +FIG01224911 succinate dehydrogenase anchor subunit +FIG01224912 FIG01224913: hypothetical protein +FIG01224913 Bll6625 protein +FIG01224916 FIG01224918: hypothetical protein +FIG01224920 FIG01224922: hypothetical protein +FIG01224922 FIG01224923: hypothetical protein +FIG01224924 FIG01224925: hypothetical protein +FIG01224925 ATPase involved in chromosome partitioning +FIG01224931 FIG01224933: hypothetical protein +FIG01224933 Sigma-54 dependent DNA-binding response regulator FleR +FIG01224934 FIG01224938: hypothetical protein +FIG01224938 FIG01224939: hypothetical protein +FIG01224939 FIG01224940: hypothetical protein +FIG01224942 FIG01224943: hypothetical protein +FIG01224946 FIG01224948: hypothetical protein +FIG01224950 glutamate uptake regulatory protein +FIG01224956 FIG01224957: hypothetical protein +FIG01224957 FIG01224958: hypothetical protein +FIG01224958 FIG01224961: hypothetical protein +FIG01224962 FIG01224963: hypothetical protein +FIG01224963 FIG01224964: hypothetical protein +FIG01224966 predicted metal-dependent protease +FIG01224968 FIG01224969: hypothetical protein +FIG01224970 FIG01224972: hypothetical protein +FIG01224972 FIG01224973: hypothetical protein +FIG01224976 FIG01224977: hypothetical protein +FIG01224977 outer membrane porin precursor +FIG01224983 FIG01224984: hypothetical protein +FIG01224984 FIG01224988: hypothetical protein +FIG01224992 FIG01224993: hypothetical protein +FIG01224993 Glucose--fructose oxidoreductase precursor (EC 1.1.99.28) +FIG01224998 FIG01224999: hypothetical protein +FIG01225006 ABC-type Fe3+ transport system ATPase component +FIG01225008 flagellar chemotaxis protein +FIG01225009 FIG01225010: hypothetical protein +FIG01225010 FIG01225019: hypothetical protein +FIG01225019 FIG01225020: hypothetical protein +FIG01225021 FIG01225022: hypothetical protein +FIG01225022 FIG01225026: hypothetical protein +FIG01225026 FIG01225027: hypothetical protein +FIG01225027 FIG01225028: hypothetical protein +FIG01225040 Serine 3-dehydrogenase (EC 1.1.1.276) +FIG01225042 FIG01225043: hypothetical protein +FIG01225043 FIG01225046: hypothetical protein +FIG01225047 colicin tolerance protein +FIG01225061 FIG01225062: hypothetical protein +FIG01225066 FIG01225067: hypothetical protein +FIG01225067 major head protein +FIG01225069 FIG01225072: hypothetical protein +FIG01225072 FIG01225073: hypothetical protein +FIG01225082 FIG01225085: hypothetical protein +FIG01225085 FIG01225086: hypothetical protein +FIG01225093 DNA and RNA helicase +FIG01225098 FIG01225103: hypothetical protein +FIG01225103 FIG01225104: hypothetical protein +FIG01225108 Amidohydrolase 3 +FIG01225109 oxalate:formate antiporter, putative +FIG01225110 FIG01225112: hypothetical protein +FIG01225112 FIG01225113: hypothetical protein +FIG01225113 FIG01225114: hypothetical protein +FIG01225115 FIG01225116: hypothetical protein +FIG01225118 FIG01225121: hypothetical protein +FIG01225121 FIG01225123: hypothetical protein +FIG01225123 FIG01225124: hypothetical protein +FIG01225124 FIG01225125: hypothetical protein +FIG01225125 FIG01108286: hypothetical protein +FIG01225126 FIG01225127: hypothetical protein +FIG01225130 FIG01225131: hypothetical protein +FIG01225131 FIG01225132: hypothetical protein +FIG01225134 FIG01225135: hypothetical protein +FIG01225135 FIG01225136: hypothetical protein +FIG01225136 FIG01225137: hypothetical protein +FIG01225137 FIG01234358: hypothetical protein +FIG01225138 FIG01225139: hypothetical protein +FIG01225139 FIG01225143: hypothetical protein +FIG01225143 FIG01225144: hypothetical protein +FIG01225145 FIG01225146: hypothetical protein +FIG01225146 FIG01225147: hypothetical protein +FIG01225148 FIG01225149: hypothetical protein +FIG01225149 sensory box/GGDEF family protein, putative +FIG01225153 FIG01225154: hypothetical protein +FIG01225155 FIG01225156: hypothetical protein +FIG01225156 FIG01225157: hypothetical protein +FIG01225157 FIG01225158: hypothetical protein +FIG01225158 FIG01225160: hypothetical protein +FIG01225160 FIG01225161: hypothetical protein +FIG01225161 FIG01225162: hypothetical protein +FIG01225162 FIG01225164: hypothetical protein +FIG01225165 phosphoglycerate mutase family, putative +FIG01225167 FIG01225168: hypothetical protein +FIG01225168 FIG01225169: hypothetical protein +FIG01225169 FIG01225170: hypothetical protein +FIG01225172 FIG01225173: hypothetical protein +FIG01225173 FIG01225174: hypothetical protein +FIG01225176 FIG01225177: hypothetical protein +FIG01225178 FIG01225180: hypothetical protein +FIG01225180 FIG01225181: hypothetical protein +FIG01225182 FIG01225183: hypothetical protein +FIG01225183 FIG01225184: hypothetical protein +FIG01225184 FIG01225185: hypothetical protein +FIG01225187 FIG01225188: hypothetical protein +FIG01225188 Esterase (EC 3.1.1.1) +FIG01225192 FIG01225193: hypothetical protein +FIG01225193 FIG01225195: hypothetical protein +FIG01225195 FIG01225196: hypothetical protein +FIG01225199 FIG01225200: hypothetical protein +FIG01225200 FIG01225201: hypothetical protein +FIG01225202 Blr0341 protein +FIG01225207 FIG01225208: hypothetical protein +FIG01225210 FIG01225212: hypothetical protein +FIG01225212 FIG01225213: hypothetical protein +FIG01225213 FIG01225215: hypothetical protein +FIG01225217 FIG01225218: hypothetical protein +FIG01225218 FIG01225220: hypothetical protein +FIG01225220 FIG01225222: hypothetical protein +FIG01225222 Ortholog yrbG, yetE, ykjA, ydfS, ydfR B.subtilis +FIG01225223 FIG01225225: hypothetical protein +FIG01225225 FIG01225226: hypothetical protein +FIG01225226 FIG01225227: hypothetical protein +FIG01225230 Fatty acid desaturase (EC 1.14.99.-) +FIG01225231 FIG01225232: hypothetical protein +FIG01225232 FIG01225233: hypothetical protein +FIG01225233 FIG014736: hypothetical protein +FIG01225235 FIG01225238: hypothetical protein +FIG01225242 FIG01225244: hypothetical protein +FIG01225247 FIG01225251: hypothetical protein +FIG01225253 FIG01225255: hypothetical protein +FIG01225255 FIG01225256: hypothetical protein +FIG01225256 conserved hypothetical protein; possible phage protein +FIG01225258 FIG01225261: hypothetical protein +FIG01225261 FIG01225262: hypothetical protein +FIG01225262 OrfL2 +FIG01225263 FIG01225264: hypothetical protein +FIG01225264 FIG01225266: hypothetical protein +FIG01225266 FIG01225267: hypothetical protein +FIG01225268 FIG01225269: hypothetical protein +FIG01225269 conserved membrane protein +FIG01225270 FIG01225272: hypothetical protein +FIG01225273 FIG01225278: hypothetical protein +FIG01225278 FIG01225280: hypothetical protein +FIG01225280 Conserved protein YqgV +FIG01225281 FIG01225282: hypothetical protein +FIG01225282 FIG01225283: hypothetical protein +FIG01225284 Signal transduction histidine kinase +FIG01225285 FIG01225287: hypothetical protein +FIG01225290 Exosporium protein Y @ Spore coat protein Y +FIG01225292 FIG01225293: hypothetical protein +FIG01225293 FIG01225294: hypothetical protein +FIG01225294 Carbohydrate Esterase Family 4 +FIG01225295 FIG01225296: hypothetical protein +FIG01225298 FIG01225299: hypothetical protein +FIG01225299 FIG01225304: hypothetical protein +FIG01225304 FIG01225306: hypothetical protein +FIG01225306 FIG01225307: hypothetical protein +FIG01225307 FIG01225308: hypothetical protein +FIG01225308 FIG01225309: hypothetical protein +FIG01225309 FIG01225310: hypothetical protein +FIG01225310 FIG01225312: hypothetical protein +FIG01225312 FIG01225314: hypothetical protein +FIG01225316 FIG01225317: hypothetical protein +FIG01225317 FIG01225318: hypothetical protein +FIG01225318 FIG01225319: hypothetical protein +FIG01225319 FIG01225320: hypothetical protein +FIG01225322 FIG01225323: hypothetical protein +FIG01225323 FIG01225326: hypothetical protein +FIG01225326 FIG01225327: hypothetical protein +FIG01225327 FIG01225328: hypothetical protein +FIG01225332 Collagen adhesion protein +FIG01225333 FIG01225334: hypothetical protein +FIG01225336 FIG01225337: hypothetical protein +FIG01225337 FIG01225338: hypothetical protein +FIG01225338 FIG01225339: hypothetical protein +FIG01225339 FIG01225340: hypothetical protein +FIG01225341 FIG01225342: hypothetical protein +FIG01225342 response regulator, putative +FIG01225343 FIG01225345: hypothetical protein +FIG01225345 FIG01225349: hypothetical protein +FIG01225349 FIG01225350: hypothetical protein +FIG01225350 FIG01225351: hypothetical protein +FIG01225351 FIG01225352: hypothetical protein +FIG01225352 FIG01225353: hypothetical protein +FIG01225358 FIG01225359: hypothetical protein +FIG01225359 FIG01225360: hypothetical protein +FIG01225361 FIG01225362: hypothetical protein +FIG01225362 conserved hypothetical protein, possible ankyrin repeat protein +FIG01225367 FIG01225368: hypothetical protein +FIG01225368 FIG01225369: hypothetical protein +FIG01225371 alpha-amylase (EC 3.2.1.1) +FIG01225373 FIG01225375: hypothetical protein +FIG01225375 FIG01225376: hypothetical protein +FIG01225376 FIG01225377: hypothetical protein +FIG01225378 FIG01225380: hypothetical protein +FIG01225382 HesB-like, HesB-like domain +FIG01225384 FIG01225386: hypothetical protein +FIG01225386 FIG01225387: hypothetical protein +FIG01225387 FIG01225388: hypothetical protein +FIG01225388 FIG01225389: hypothetical protein +FIG01225389 FIG01225390: hypothetical protein +FIG01225390 FIG01225391: hypothetical protein +FIG01225393 FIG01225394: hypothetical protein +FIG01225395 FIG01225396: hypothetical protein +FIG01225396 FIG01225398: hypothetical protein +FIG01225398 Stage V sporulation protein required for normal spore cortex and coat synthesis (SpoVM) +FIG01225401 FIG01225403: hypothetical protein +FIG01225404 FIG01225405: hypothetical protein +FIG01225405 Hypothetical protein SAV1846 +FIG01225408 FIG01225409: hypothetical protein +FIG01225409 FIG01225410: hypothetical protein +FIG01225410 FIG01225411: hypothetical protein +FIG01225411 FIG01225413: hypothetical protein +FIG01225413 FIG01225417: hypothetical protein +FIG01225417 FIG01225418: hypothetical protein +FIG01225418 FIG01225419: hypothetical protein +FIG01225419 FIG01225420: hypothetical protein +FIG01225420 FIG01225422: hypothetical protein +FIG01225422 DNA binding protein, DksA/TraR family +FIG01225423 FIG01225424: hypothetical protein +FIG01225424 FIG01225427: hypothetical protein +FIG01225427 Hemolysin BL binding component precursor +FIG01225429 FIG01225430: hypothetical protein +FIG01225430 FIG01225431: hypothetical protein +FIG01225433 FIG01225434: hypothetical protein +FIG01225434 FIG01225436: hypothetical protein +FIG01225438 FIG01225440: hypothetical protein +FIG01225440 FIG01225441: hypothetical protein +FIG01225441 FIG01225442: hypothetical protein +FIG01225442 FIG01225443: hypothetical protein +FIG01225443 FIG01225445: hypothetical protein +FIG01225445 pXO1-51 +FIG01225446 FIG01225447: hypothetical protein +FIG01225447 FIG01225448: hypothetical protein +FIG01225448 FIG01225449: hypothetical protein +FIG01225449 FIG01225451: hypothetical protein +FIG01225451 FIG01225453: hypothetical protein +FIG01225453 FIG01225454: hypothetical protein +FIG01225454 FIG01225455: hypothetical protein +FIG01225456 FIG01225458: hypothetical protein +FIG01225459 FIG01225460: hypothetical protein +FIG01225460 FIG01225461: hypothetical protein +FIG01225461 FIG01225463: hypothetical protein +FIG01225466 FIG01225467: hypothetical protein +FIG01225467 collagen adhesion protein +FIG01225468 FIG01225469: hypothetical protein +FIG01225469 FIG01225470: hypothetical protein +FIG01225470 FIG01225473: hypothetical protein +FIG01225473 FIG01225474: hypothetical protein +FIG01225474 Cell surface protein +FIG01225475 FIG01225476: hypothetical protein +FIG01225476 FIG01225478: hypothetical protein +FIG01225478 FIG01225480: hypothetical protein +FIG01225480 FIG01225481: hypothetical protein +FIG01225482 FIG01225483: hypothetical protein +FIG01225484 FIG01225487: hypothetical protein +FIG01225488 FIG01225489: hypothetical protein +FIG01225489 FIG01225490: hypothetical protein +FIG01225490 FIG01225491: hypothetical protein +FIG01225492 FIG01225493: hypothetical protein +FIG01225493 protein gp8 +FIG01225494 FIG01225495: hypothetical protein +FIG01225495 FIG01225496: hypothetical protein +FIG01225496 FIG01225497: hypothetical protein +FIG01225499 FIG01225500: hypothetical protein +FIG01225502 FIG01225504: hypothetical protein +FIG01225504 FIG01225505: hypothetical protein +FIG01225505 FIG01225506: hypothetical protein +FIG01225507 FIG01225508: hypothetical protein +FIG01225510 FIG01225511: hypothetical protein +FIG01225512 FIG01225513: hypothetical protein +FIG01225513 DNA topology modulation protein FlaR, putative +FIG01225514 FIG01225515: hypothetical protein +FIG01225515 FIG01225516: hypothetical protein +FIG01225517 FIG01225518: hypothetical protein +FIG01225518 FIG01225519: hypothetical protein +FIG01225519 FIG01225521: hypothetical protein +FIG01225521 FIG01225522: hypothetical protein +FIG01225523 FIG01225525: hypothetical protein +FIG01225528 sensor histidine kinase, putative +FIG01225529 FIG01225530: hypothetical protein +FIG01225530 FIG01225531: hypothetical protein +FIG01225531 FIG01225533: hypothetical protein +FIG01225533 FIG01225534: hypothetical protein +FIG01225534 FIG01225538: hypothetical protein +FIG01225539 FIG01225541: hypothetical protein +FIG01225542 FIG01225543: hypothetical protein +FIG01225543 Urease domain protein +FIG01225545 FIG01225546: hypothetical protein +FIG01225546 Reductase or disulfide isomerase in copper uptake, YcnL +FIG01225547 FIG01225549: hypothetical protein +FIG01225550 FIG01225551: hypothetical protein +FIG01225551 FIG01225552: hypothetical protein +FIG01225552 FIG01225554: hypothetical protein +FIG01225554 FIG01225555: hypothetical protein +FIG01225555 FIG01225556: hypothetical protein +FIG01225557 FIG01225558: hypothetical protein +FIG01225559 FIG01225561: hypothetical protein +FIG01225563 FIG01225564: hypothetical protein +FIG01225564 FIG01225565: hypothetical protein +FIG01225565 FIG01225567: hypothetical protein +FIG01225570 FIG01225572: hypothetical protein +FIG01225572 FIG01225573: hypothetical protein +FIG01225573 FIG01225574: hypothetical protein +FIG01225574 FIG01225576: hypothetical protein +FIG01225576 FIG01225577: hypothetical protein +FIG01225577 YqgZ +FIG01225578 FIG01225579: hypothetical protein +FIG01225579 FIG01225581: hypothetical protein +FIG01225581 FIG01225583: hypothetical protein +FIG01225583 FIG01225585: hypothetical protein +FIG01225585 FIG01225586: hypothetical protein +FIG01225586 FIG01225587: hypothetical protein +FIG01225587 FIG01225588: hypothetical protein +FIG01225589 FIG01225592: hypothetical protein +FIG01225594 FIG01225596: hypothetical protein +FIG01225597 FIG01225599: hypothetical protein +FIG01225599 FIG01225600: hypothetical protein +FIG01225603 FIG01225604: hypothetical protein +FIG01225604 FIG01225606: hypothetical protein +FIG01225606 Possible repressor of comG operon +FIG01225607 FIG01225608: hypothetical protein +FIG01225608 FIG01225609: hypothetical protein +FIG01225609 FIG01225611: hypothetical protein +FIG01225614 FIG01225616: hypothetical protein +FIG01225616 FIG01225617: hypothetical protein +FIG01225618 FIG01225619: hypothetical protein +FIG01225619 FIG01225621: hypothetical protein +FIG01225621 FIG01225622: hypothetical protein +FIG01225622 FIG01225623: hypothetical protein +FIG01225625 FIG01225626: hypothetical protein +FIG01225626 Oligoendopeptidase F (EC 3.4.24.-) +FIG01225632 Hydrolase, HAD superfamily +FIG01225633 FIG01225635: hypothetical protein +FIG01225635 FIG01225636: hypothetical protein +FIG01225638 FIG01225640: hypothetical protein +FIG01225642 FIG01225643: hypothetical protein +FIG01225643 / Glutamine transport system permease protein GlnP (TC 3.A.1.3.2) +FIG01225646 FIG01225647: hypothetical protein +FIG01225647 FIG01225648: hypothetical protein +FIG01225648 FIG01225649: hypothetical protein +FIG01225649 FIG01225650: hypothetical protein +FIG01225650 FIG01225651: hypothetical protein +FIG01225651 FIG01225652: hypothetical protein +FIG01225653 FIG01225654: hypothetical protein +FIG01225654 FIG01225655: hypothetical protein +FIG01225656 FIG01225657: hypothetical protein +FIG01225657 pXO1-55 +FIG01225659 FIG01225661: hypothetical protein +FIG01225661 FIG01225662: hypothetical protein +FIG01225664 FIG01225665: hypothetical protein +FIG01225665 Hypothetical exported protein +FIG01225666 FIG01225667: hypothetical protein +FIG01225667 FIG01225669: hypothetical protein +FIG01225669 multidrug resistance protein, putative +FIG01225671 peptide chain release factor 2 +FIG01225674 FIG01225675: hypothetical protein +FIG01225679 Carboxylesterase (EC 3.1.1.1) +FIG01225680 FIG01225681: hypothetical protein +FIG01225683 FIG01225684: hypothetical protein +FIG01225685 FIG01225686: hypothetical protein +FIG01225687 FIG01225689: hypothetical protein +FIG01225690 FIG01225691: hypothetical protein +FIG01225691 ABC transporter, permease +FIG01225696 FIG01225698: hypothetical protein +FIG01225699 FIG01225700: hypothetical protein +FIG01225700 FIG01225701: hypothetical protein +FIG01225704 FIG01225705: hypothetical protein +FIG01225705 FIG01225706: hypothetical protein +FIG01225706 FIG01225708: hypothetical protein +FIG01225708 FIG01225709: hypothetical protein +FIG01225709 FIG01225710: hypothetical protein +FIG01225712 FIG01225713: hypothetical protein +FIG01225713 TraG/TraD family protein +FIG01225714 FIG01225715: hypothetical protein +FIG01225715 FIG01225716: hypothetical protein +FIG01225716 FIG01225718: hypothetical protein +FIG01225719 zwittermicin A-resistance protein +FIG01225720 prophage LambdaBa02, repressor protein +FIG01225721 FIG01225722: hypothetical protein +FIG01225722 FIG01225725: hypothetical protein +FIG01225725 FIG01225727: hypothetical protein +FIG01225728 FIG01225729: hypothetical protein +FIG01225729 FIG01225730: hypothetical protein +FIG01225730 FIG01225731: hypothetical protein +FIG01225731 FIG01225733: hypothetical protein +FIG01225733 FIG01225734: hypothetical protein +FIG01225734 FIG01108150: hypothetical protein +FIG01225736 FIG01225737: hypothetical protein +FIG01225742 Non-heme chloroperoxidase (EC 1.11.1.10) +FIG01225743 ABC transporter, substrate-binding protein, putative +FIG01225747 FIG01225748: hypothetical protein +FIG01225751 FIG01225752: hypothetical protein +FIG01225752 FIG01225753: hypothetical protein +FIG01225753 FIG01225754: hypothetical protein +FIG01225754 FIG01225755: hypothetical protein +FIG01225756 FIG01225757: hypothetical protein +FIG01225757 FIG01225758: hypothetical protein +FIG01225758 FIG00774849: hypothetical protein +FIG01225759 BH0957 unknown +FIG01225760 FIG01225761: hypothetical protein +FIG01225761 FIG01225762: hypothetical protein +FIG01225763 FIG01234419: hypothetical protein +FIG01225766 FIG01225767: hypothetical protein +FIG01225767 FIG01225769: hypothetical protein +FIG01225770 FIG01225771: hypothetical protein +FIG01225771 FIG01225772: hypothetical protein +FIG01225772 FIG01225773: hypothetical protein +FIG01225773 FIG01225774: hypothetical protein +FIG01225776 FIG01225777: hypothetical protein +FIG01225777 FIG01225778: hypothetical protein +FIG01225784 MoxR-like ATPases +FIG01225785 FIG01225786: hypothetical protein +FIG01225789 FIG01225790: hypothetical protein +FIG01225790 FIG01225791: hypothetical protein +FIG01225791 FIG01225793: hypothetical protein +FIG01225793 FIG01225794: hypothetical protein +FIG01225794 transporter, putative +FIG01225796 FIG01225797: hypothetical protein +FIG01225798 FIG01225799: hypothetical protein +FIG01225799 FIG01225800: hypothetical protein +FIG01225800 nucleotidyltransferase domain protein +FIG01225802 FIG01225803: hypothetical protein +FIG01225803 FIG01225804: hypothetical protein +FIG01225804 major facilitator family transporter, putative +FIG01225805 FIG01225806: hypothetical protein +FIG01225806 FIG01225807: hypothetical protein +FIG01225807 FIG01225808: hypothetical protein +FIG01225808 FIG01225809: hypothetical protein +FIG01225810 FIG01225811: hypothetical protein +FIG01225811 FIG01225812: hypothetical protein +FIG01225813 alternate gene name: yoxJ +FIG01225815 thiJ/pfpI family protein +FIG01225816 FIG01225817: hypothetical protein +FIG01225817 FIG01225818: hypothetical protein +FIG01225818 FIG01225819: hypothetical protein +FIG01225820 FIG01225821: hypothetical protein +FIG01225821 FIG01225822: hypothetical protein +FIG01225824 FIG01225827: hypothetical protein +FIG01225827 FIG01225828: hypothetical protein +FIG01225828 FIG01225831: hypothetical protein +FIG01225831 FIG01225832: hypothetical protein +FIG01225832 FIG01225833: hypothetical protein +FIG01225833 FIG01225834: hypothetical protein +FIG01225837 FIG01225838: hypothetical protein +FIG01225838 FIG01225841: hypothetical protein +FIG01225841 P54 protein precursor +FIG01225842 FIG01225844: hypothetical protein +FIG01225844 FIG01225845: hypothetical protein +FIG01225846 FIG01225847: hypothetical protein +FIG01225847 FIG01225848: hypothetical protein +FIG01225849 FIG01225850: hypothetical protein +FIG01225850 FIG01225852: hypothetical protein +FIG01225852 FIG01225853: hypothetical protein +FIG01225853 FIG01225854: hypothetical protein +FIG01225854 FIG01225856: hypothetical protein +FIG01225856 Uncharacterized protein YpeP +FIG01225857 FIG01225858: hypothetical protein +FIG01225858 FIG01225860: hypothetical protein +FIG01225860 oxidoreductase, short chain dehydrogenase/reductase family protein +FIG01225861 prophage LambdaBa04, DNA binding protein +FIG01225862 FIG01225863: hypothetical protein +FIG01225865 FIG01225866: hypothetical protein +FIG01225867 FIG01225868: hypothetical protein +FIG01225868 FIG01225869: hypothetical protein +FIG01225869 FIG01225870: hypothetical protein +FIG01225870 FIG01225871: hypothetical protein +FIG01225871 FIG01225872: hypothetical protein +FIG01225873 FIG01225875: hypothetical protein +FIG01225875 FIG01225877: hypothetical protein +FIG01225879 FIG01225881: hypothetical protein +FIG01225883 FIG01225884: hypothetical protein +FIG01225884 FIG01225885: hypothetical protein +FIG01225885 YqbG +FIG01225888 FIG01108140: hypothetical protein +FIG01225892 FIG01225893: hypothetical protein +FIG01225895 FIG01225897: hypothetical protein +FIG01225897 FIG01225898: hypothetical protein +FIG01225898 FIG01225899: hypothetical protein +FIG01225903 FIG01225904: hypothetical protein +FIG01225904 FIG01225905: hypothetical protein +FIG01225905 FIG01225907: hypothetical protein +FIG01225911 FIG01225912: hypothetical protein +FIG01225913 FIG01225914: hypothetical protein +FIG01225914 FIG01225916: hypothetical protein +FIG01225918 FIG01225919: hypothetical protein +FIG01225919 FIG01225920: hypothetical protein +FIG01225920 FIG01225921: hypothetical protein +FIG01225921 FIG01225923: hypothetical protein +FIG01225923 FIG01225924: hypothetical protein +FIG01225924 FIG01225926: hypothetical protein +FIG01225926 FIG01225927: hypothetical protein +FIG01225930 FIG01225931: hypothetical protein +FIG01225931 FIG01225932: hypothetical protein +FIG01225932 FIG01225935: hypothetical protein +FIG01225935 FIG01225936: hypothetical protein +FIG01225936 FIG01225937: hypothetical protein +FIG01225937 FIG01225938: hypothetical protein +FIG01225938 FIG01225942: hypothetical protein +FIG01225942 FIG01225944: hypothetical protein +FIG01225944 FIG01225947: hypothetical protein +FIG01225947 FIG01225948: hypothetical protein +FIG01225948 FIG01225949: hypothetical protein +FIG01225949 hypothetical protein +FIG01225950 FIG01225951: hypothetical protein +FIG01225954 FIG01225956: hypothetical protein +FIG01225956 FIG01225957: hypothetical protein +FIG01225957 glyoxalase family protein, putative +FIG01225960 FIG01225962: hypothetical protein +FIG01225963 FIG01225964: hypothetical protein +FIG01225965 FIG01225966: hypothetical protein +FIG01225966 FIG01225967: hypothetical protein +FIG01225967 FIG01225968: hypothetical protein +FIG01225970 FIG01225971: hypothetical protein +FIG01225972 FIG01225974: hypothetical protein +FIG01225974 FIG01225975: hypothetical protein +FIG01225975 bacitracin ABC transporter, ATP-binding protein, putative +FIG01225977 FIG01225978: hypothetical protein +FIG01225980 FIG01225981: hypothetical protein +FIG01225982 FIG01225983: hypothetical protein +FIG01225983 Spore germination protein xc. bacillus +FIG01225984 FIG01225986: hypothetical protein +FIG01225986 FIG01225987: hypothetical protein +FIG01225990 FIG01225991: hypothetical protein +FIG01225991 FIG01225992: hypothetical protein +FIG01225992 FIG01225993: hypothetical protein +FIG01225993 FIG01225995: hypothetical protein +FIG01225996 FIG01225999: hypothetical protein +FIG01226002 Transcriptional regulator splA +FIG01226003 FIG01226004: hypothetical protein +FIG01226004 FIG01226006: hypothetical protein +FIG01226006 FIG01226007: hypothetical protein +FIG01226007 FIG01226009: hypothetical protein +FIG01226009 FIG01226010: hypothetical protein +FIG01226010 FIG01226011: hypothetical protein +FIG01226012 FIG01226013: hypothetical protein +FIG01226014 FIG01226017: hypothetical protein +FIG01226017 FIG01226018: hypothetical protein +FIG01226018 FIG01226019: hypothetical protein +FIG01226019 FIG01226020: hypothetical protein +FIG01226020 FIG01226022: hypothetical protein +FIG01226022 FIG01226023: hypothetical protein +FIG01226023 YkzH +FIG01226024 FIG01226025: hypothetical protein +FIG01226025 FIG01226027: hypothetical protein +FIG01226027 FIG01226030: hypothetical protein +FIG01226030 FIG01226032: hypothetical protein +FIG01226032 FIG01226033: hypothetical protein +FIG01226033 FIG01226037: hypothetical protein +FIG01226043 FIG01226045: hypothetical protein +FIG01226047 FIG01226048: hypothetical protein +FIG01226048 FIG01226050: hypothetical protein +FIG01226050 FIG01226051: hypothetical protein +FIG01226051 transcriptional activator tipA +FIG01226052 Spore germination protein, gerB family +FIG01226053 FIG01226054: hypothetical protein +FIG01226054 FIG01226055: hypothetical protein +FIG01226055 2MDa_1 protein +FIG01226060 FIG01226061: hypothetical protein +FIG01226061 FIG01226063: hypothetical protein +FIG01226063 Squalene--hopene cyclase (EC 5.4.99.17) +FIG01226064 Lyzozyme M1 (1,4-beta-N-acetylmuramidase) (EC 3.2.1.17) +FIG01226065 putative sugar uptake ABC transporter periplasmic solute-binding protein precursor +FIG01226066 aminopeptidase +FIG01226068 FIG01226071: hypothetical protein +FIG01226071 FIG01226072: hypothetical protein +FIG01226073 FIG01226074: hypothetical protein +FIG01226074 FIG01226075: hypothetical protein +FIG01226081 UPF0020, Putative RNA methylase family UPF0020 +FIG01226083 conserved domain protein +FIG01226084 FIG01226085: hypothetical protein +FIG01226085 FIG01226086: hypothetical protein +FIG01226086 FIG01226088: hypothetical protein +FIG01226088 FIG01226089: hypothetical protein +FIG01226089 FIG01226091: hypothetical protein +FIG01226091 FIG01226092: hypothetical protein +FIG01226093 FIG01226094: hypothetical protein +FIG01226094 FIG01226095: hypothetical protein +FIG01226096 FIG01226098: hypothetical protein +FIG01226098 FIG01226099: hypothetical protein +FIG01226099 FIG01226101: hypothetical protein +FIG01226102 FIG01226103: hypothetical protein +FIG01226104 FIG01226105: hypothetical protein +FIG01226107 FIG01226108: hypothetical protein +FIG01226108 FIG01226109: hypothetical protein +FIG01226109 FIG01226110: hypothetical protein +FIG01226112 FIG01226114: hypothetical protein +FIG01226114 FIG01226115: hypothetical protein +FIG01226116 FIG01226117: hypothetical protein +FIG01226119 FIG01226121: hypothetical protein +FIG01226121 FIG01226122: hypothetical protein +FIG01226123 FIG01226124: hypothetical protein +FIG01226124 Protein clustered with N-succinyl arginine/lysine racemase +FIG01226127 FIG01226128: hypothetical protein +FIG01226128 FIG01226129: hypothetical protein +FIG01226130 Protein erfK/srfK +FIG01226131 type II secretion system protein, putative +FIG01226132 FIG01226133: hypothetical protein +FIG01226134 FIG01226135: hypothetical protein +FIG01226140 FIG01226141: hypothetical protein +FIG01226142 hypothetical protein +FIG01226143 FIG01226144: hypothetical protein +FIG01226144 FIG01226145: hypothetical protein +FIG01226146 FIG01226147: hypothetical protein +FIG01226147 YdaL protein +FIG01226149 FIG01226150: hypothetical protein +FIG01226150 FIG01226153: hypothetical protein +FIG01226153 FIG01226154: hypothetical protein +FIG01226154 FIG01226155: hypothetical protein +FIG01226155 FIG01226156: hypothetical protein +FIG01226156 FIG01226157: hypothetical protein +FIG01226157 Transcription state regulatory protein abrB +FIG01226159 FIG01226161: hypothetical protein +FIG01226161 FIG01226163: hypothetical protein +FIG01226163 FIG01226164: hypothetical protein +FIG01226165 FIG01226166: hypothetical protein +FIG01226166 FIG01226167: hypothetical protein +FIG01226167 FIG01226168: hypothetical protein +FIG01226168 FIG01226169: hypothetical protein +FIG01226169 FIG01226171: hypothetical protein +FIG01226171 FIG01226172: hypothetical protein +FIG01226173 FIG01226174: hypothetical protein +FIG01226176 FIG01226177: hypothetical protein +FIG01226179 FIG01226180: hypothetical protein +FIG01226180 FIG01226181: hypothetical protein +FIG01226181 FIG01226182: hypothetical protein +FIG01226182 FIG01226183: hypothetical protein +FIG01226184 acetoin transport permease protein +FIG01226186 FIG01226187: hypothetical protein +FIG01226188 PBS lyase HEAT-like repeat +FIG01226189 FIG01226191: hypothetical protein +FIG01226191 NAD(P)H dehydrogenase, quinone family protein +FIG01226192 FIG01226194: hypothetical protein +FIG01226194 FIG01226195: hypothetical protein +FIG01226199 FIG01226200: hypothetical protein +FIG01226200 Peptidase, M42 family +FIG01226201 FIG01226202: hypothetical protein +FIG01226202 FIG01226204: hypothetical protein +FIG01226204 FIG01226207: hypothetical protein +FIG01226207 FIG01226208: hypothetical protein +FIG01226209 FIG01226210: hypothetical protein +FIG01226210 FIG01226212: hypothetical protein +FIG01226212 FIG01226214: hypothetical protein +FIG01226214 SpoIISB +FIG01226216 FIG01226217: hypothetical protein +FIG01226218 FIG01226220: hypothetical protein +FIG01226220 FIG01226221: hypothetical protein +FIG01226221 prophage LambdaBa01, minor structural protein +FIG01226225 Sporulation kinase (EC 2.7.3.-) +FIG01226229 FIG01226230: hypothetical protein +FIG01226230 FIG01226231: hypothetical protein +FIG01226231 FIG01226233: hypothetical protein +FIG01226233 pkinase, Protein kinase domain +FIG01226234 FIG01226235: hypothetical protein +FIG01226237 FIG01226239: hypothetical protein +FIG01226239 FIG01226240: hypothetical protein +FIG01226240 FIG01226242: hypothetical protein +FIG01226242 FIG01226243: hypothetical protein +FIG01226244 FIG01226245: hypothetical protein +FIG01226245 FIG01226246: hypothetical protein +FIG01226246 FIG01226247: hypothetical protein +FIG01226253 FIG01226254: hypothetical protein +FIG01226254 FIG01226255: hypothetical protein +FIG01226255 FIG01226257: hypothetical protein +FIG01226257 FIG01226258: hypothetical protein +FIG01226261 enterotoxin / cell-wall binding protein +FIG01226263 FIG01226264: hypothetical protein +FIG01226264 FIG01226265: hypothetical protein +FIG01226265 FIG01226271: hypothetical protein +FIG01226271 Multidrug ABC transporter, permease +FIG01226272 FIG01226273: hypothetical protein +FIG01226273 FIG01226274: hypothetical protein +FIG01226274 OMP, Outer membrane protein +FIG01226275 FIG01226276: hypothetical protein +FIG01226278 FIG01226279: hypothetical protein +FIG01226279 FIG01226280: hypothetical protein +FIG01226280 FIG01228675: hypothetical protein +FIG01226282 spore coat protein C, putative +FIG01226285 FIG01226286: hypothetical protein +FIG01226286 FIG01226288: hypothetical protein +FIG01226288 FIG01226290: hypothetical protein +FIG01226290 FIG01226291: hypothetical protein +FIG01226291 FIG01226293: hypothetical protein +FIG01226293 FIG01226296: hypothetical protein +FIG01226298 FIG01226299: hypothetical protein +FIG01226299 FIG01226300: hypothetical protein +FIG01226300 FIG01226301: hypothetical protein +FIG01226301 FIG001891: protein involved in chromosome partitioning +FIG01226303 FIG01226305: hypothetical protein +FIG01226305 FIG01226307: hypothetical protein +FIG01226307 FIG01226308: hypothetical protein +FIG01226308 FIG01226310: hypothetical protein +FIG01226310 FIG01226311: hypothetical protein +FIG01226313 FIG01226314: hypothetical protein +FIG01226314 FIG01226315: hypothetical protein +FIG01226315 FIG01226316: hypothetical protein +FIG01226316 FIG01226317: hypothetical protein +FIG01226317 amino acid ABC transproter, permease protein VC0009 [imported] +FIG01226319 FIG01226320: hypothetical protein +FIG01226320 transcriptional regulator, merR family +FIG01226321 FIG01226324: hypothetical protein +FIG01226325 FIG01226326: hypothetical protein +FIG01226328 FIG01226329: hypothetical protein +FIG01226329 uncharacterized protein, YJDF B. subtilis ortholog +FIG01226330 Competence transcription factor +FIG01226331 FIG01226332: hypothetical protein +FIG01226332 FIG01226333: hypothetical protein +FIG01226334 FIG01226336: hypothetical protein +FIG01226336 FIG01226337: hypothetical protein +FIG01226338 glycolate oxidase, subunit GlcD, putative +FIG01226339 FIG01226340: hypothetical protein +FIG01226341 FIG01226343: hypothetical protein +FIG01226343 Uncharacterized protein YpeP +FIG01226344 PXO1-87 +FIG01226345 FIG01226346: hypothetical protein +FIG01226347 Small, acid-soluble spore protein +FIG01226349 FIG01226350: hypothetical protein +FIG01226350 FIG011739: membrane protein, putative +FIG01226352 FIG01226353: hypothetical protein +FIG01226353 FIG01226358: hypothetical protein +FIG01226363 FIG01226364: hypothetical protein +FIG01226364 FIG01226365: hypothetical protein +FIG01226365 FIG01226366: hypothetical protein +FIG01226369 hypothetical protein +FIG01226373 FIG01226375: hypothetical protein +FIG01226375 FIG01226376: hypothetical protein +FIG01226376 FIG01226378: hypothetical protein +FIG01226378 FIG01226379: hypothetical protein +FIG01226379 FIG01226382: hypothetical protein +FIG01226383 FIG01226385: hypothetical protein +FIG01226385 FIG01226386: hypothetical protein +FIG01226390 FIG01226392: hypothetical protein +FIG01226393 aldehyde dehydrogenase family protein +FIG01226395 FIG01226397: hypothetical protein +FIG01226397 glycosyl transferase, putative +FIG01226399 FIG01226400: hypothetical protein +FIG01226400 FIG01226403: hypothetical protein +FIG01226406 YVAO protein +FIG01226411 FIG01226412: hypothetical protein +FIG01226412 Lin1275 protein +FIG01226414 FIG01226416: hypothetical protein +FIG01226416 FIG01226417: hypothetical protein +FIG01226420 FIG01226421: hypothetical protein +FIG01226422 FIG01226423: hypothetical protein +FIG01226423 FIG01226424: hypothetical protein +FIG01226424 FIG01226425: hypothetical protein +FIG01226425 FIG01226426: hypothetical protein +FIG01226426 FIG01226427: hypothetical protein +FIG01226427 FIG01226430: hypothetical protein +FIG01226430 FIG01226432: hypothetical protein +FIG01226432 FIG01226433: hypothetical protein +FIG01226433 FIG01226434: hypothetical protein +FIG01226436 lipoprotein, NLP/P60 family +FIG01226441 FIG01226442: hypothetical protein +FIG01226442 FIG01226443: hypothetical protein +FIG01226443 FIG01226445: hypothetical protein +FIG01226445 FIG01226446: hypothetical protein +FIG01226447 FIG01226448: hypothetical protein +FIG01226448 FIG01226449: hypothetical protein +FIG01226450 FIG01226451: hypothetical protein +FIG01226455 FIG01226457: hypothetical protein +FIG01226458 FIG01234995: hypothetical protein +FIG01226460 FIG01226462: hypothetical protein +FIG01226463 FIG01226464: hypothetical protein +FIG01226464 FIG01226466: hypothetical protein +FIG01226469 FIG01226470: hypothetical protein +FIG01226470 Response regulator aspartate phosphatase +FIG01226472 FIG01226473: hypothetical protein +FIG01226473 FIG01226474: hypothetical protein +FIG01226474 FIG01226475: hypothetical protein +FIG01226475 FIG01226476: hypothetical protein +FIG01226477 FIG01226478: hypothetical protein +FIG01226479 FIG01226481: hypothetical protein +FIG01226482 FIG00895122: hypothetical protein +FIG01226486 conserved domain protein +FIG01226487 Macrolide efflux protein (EC 2.7.7.2) +FIG01226488 FIG01226489: hypothetical protein +FIG01226490 FIG01226491: hypothetical protein +FIG01226491 FIG01226492: hypothetical protein +FIG01226493 FIG01226494: hypothetical protein +FIG01226494 FIG01226495: hypothetical protein +FIG01226495 FIG01226496: hypothetical protein +FIG01226496 FIG01226497: hypothetical protein +FIG01226497 FIG01226498: hypothetical protein +FIG01226500 FIG01226501: hypothetical protein +FIG01226502 FIG01226504: hypothetical protein +FIG01226505 FIG01226506: hypothetical protein +FIG01226506 FIG01226508: hypothetical protein +FIG01226508 FIG01226509: hypothetical protein +FIG01226509 FIG01226510: hypothetical protein +FIG01226510 FIG01226511: hypothetical protein +FIG01226511 FIG01108239: hypothetical protein +FIG01226512 FIG01226514: hypothetical protein +FIG01226516 beta-lactamase domain protein +FIG01226517 FIG01226518: hypothetical protein +FIG01226518 FIG01226521: hypothetical protein +FIG01226522 Phage-related protein +FIG01226524 FIG01226527: hypothetical protein +FIG01226527 conserved protein YeaA +FIG01226528 FIG01226529: hypothetical protein +FIG01226529 FIG01226531: hypothetical protein +FIG01226531 FIG01226532: hypothetical protein +FIG01226532 FIG01226534: hypothetical protein +FIG01226535 glycosyl transferase domain protein, putative +FIG01226539 FIG01226540: hypothetical protein +FIG01226542 Exosporium protein A +FIG01226543 FIG01226544: hypothetical protein +FIG01226545 FIG01226546: hypothetical protein +FIG01226546 FIG01226547: hypothetical protein +FIG01226547 FIG01226548: hypothetical protein +FIG01226551 BH2003 unknown +FIG01226553 FIG01226554: hypothetical protein +FIG01226554 FIG01226555: hypothetical protein +FIG01226555 IG hypothetical protein 16680 +FIG01226557 FIG01226559: hypothetical protein +FIG01226560 FIG01226562: hypothetical protein +FIG01226562 FIG01226563: hypothetical protein +FIG01226563 FIG01226564: hypothetical protein +FIG01226564 FIG01226565: hypothetical protein +FIG01226565 20 kDa polypeptide +FIG01226567 FIG01226568: hypothetical protein +FIG01226569 FIG01226571: hypothetical protein +FIG01226571 FIG01226574: hypothetical protein +FIG01226577 FIG01226578: hypothetical protein +FIG01226578 FIG01226579: hypothetical protein +FIG01226579 FIG01226580: hypothetical protein +FIG01226585 FIG01226590: hypothetical protein +FIG01226591 FIG01226592: hypothetical protein +FIG01226592 FIG01226594: hypothetical protein +FIG01226595 FIG01226596: hypothetical protein +FIG01226597 FIG01226598: hypothetical protein +FIG01226598 mobile intron protein +FIG01226599 Glutamine transport ATP-binding protein GlnQ (TC 3.A.1.3.2) +FIG01226602 FIG01226603: hypothetical protein +FIG01226603 FIG01226605: hypothetical protein +FIG01226606 FIG01226607: hypothetical protein +FIG01226607 CcdC protein +FIG01226609 FIG01226610: hypothetical protein +FIG01226610 FIG01226611: hypothetical protein +FIG01226612 FIG01226613: hypothetical protein +FIG01226615 negative regulation of the defective prophage PBSX genes +FIG01226616 Possible serine/threonine specific protein phosphatase (EC 3.1.3.16) +FIG01226617 FIG01226618: hypothetical protein +FIG01226618 FIG01226624: hypothetical protein +FIG01226625 FIG01226626: hypothetical protein +FIG01226628 FIG01226629: hypothetical protein +FIG01226630 FIG01226633: hypothetical protein +FIG01226634 FIG01226635: hypothetical protein +FIG01226635 YfmB +FIG01226636 FIG01226637: hypothetical protein +FIG01226637 GNAT family acetyltransferase YYaT +FIG01226638 FIG01226639: hypothetical protein +FIG01226641 FIG01226642: hypothetical protein +FIG01226642 YqeB +FIG01226645 FIG01226646: hypothetical protein +FIG01226646 FIG01226649: hypothetical protein +FIG01226649 FIG01226652: hypothetical protein +FIG01226652 FIG01226653: hypothetical protein +FIG01226653 Possible protein-tyrosine-phosphatase (EC 3.1.3.48) +FIG01226658 FIG01226660: hypothetical protein +FIG01226665 FIG01226666: hypothetical protein +FIG01226666 FIG01226668: hypothetical protein +FIG01226668 FIG01226669: hypothetical protein +FIG01226669 PAP2 family protein +FIG01226672 FIG01226673: hypothetical protein +FIG01226673 FIG013069: hypothetical protein co-occurring with TPR domain protein +FIG01226678 6-aminohexanoate-dimer hydrolase, putative +FIG01226680 FIG01226681: hypothetical protein +FIG01226681 FIG01226682: hypothetical protein +FIG01226682 FIG01226683: hypothetical protein +FIG01226684 FIG01226688: hypothetical protein +FIG01226689 FIG01226691: hypothetical protein +FIG01226691 FIG01226693: hypothetical protein +FIG01226693 FIG01226694: hypothetical protein +FIG01226698 FIG01226699: hypothetical protein +FIG01226699 FIG01226706: hypothetical protein +FIG01226706 FIG01226707: hypothetical protein +FIG01226707 FIG01226708: hypothetical protein +FIG01226708 FIG01226709: hypothetical protein +FIG01226710 FIG01226713: hypothetical protein +FIG01226713 small, acid-soluble spore protein +FIG01226714 FIG01226716: hypothetical protein +FIG01226718 FIG01226719: hypothetical protein +FIG01226719 FIG01226720: hypothetical protein +FIG01226720 FIG01226721: hypothetical protein +FIG01226721 FIG01226722: hypothetical protein +FIG01226722 FIG01226725: hypothetical protein +FIG01226730 FIG01226732: hypothetical protein +FIG01226732 FIG01226738: hypothetical protein +FIG01226738 FIG01226739: hypothetical protein +FIG01226739 FIG01226740: hypothetical protein +FIG01226740 FIG01226743: hypothetical protein +FIG01226743 FIG01226744: hypothetical protein +FIG01226744 FIG01226745: hypothetical protein +FIG01226745 FIG01226746: hypothetical protein +FIG01226746 FIG01226747: hypothetical protein +FIG01226747 FIG01226748: hypothetical protein +FIG01226749 unknown +FIG01226754 FIG01226756: hypothetical protein +FIG01226758 FIG01226760: hypothetical protein +FIG01226760 FIG01226762: hypothetical protein +FIG01226762 FIG01226763: hypothetical protein +FIG01226763 FIG01226765: hypothetical protein +FIG01226765 FIG01226767: hypothetical protein +FIG01226767 FIG01226768: hypothetical protein +FIG01226768 FIG01226771: hypothetical protein +FIG01226771 FIG01226773: hypothetical protein +FIG01226773 FIG01226774: hypothetical protein +FIG01226774 FIG01226775: hypothetical protein +FIG01226776 FIG01226778: hypothetical protein +FIG01226778 FIG01226779: hypothetical protein +FIG01226779 FIG01226780: hypothetical protein +FIG01226783 FIG01226784: hypothetical protein +FIG01226784 FIG01231642: hypothetical protein +FIG01226785 FIG01226786: hypothetical protein +FIG01226786 Catabolite gene activator +FIG01226787 FIG01226788: hypothetical protein +FIG01226788 FIG01226789: hypothetical protein +FIG01226790 FIG01226791: hypothetical protein +FIG01226792 FIG01226796: hypothetical protein +FIG01226796 hypothetical protein +FIG01226797 FIG01226798: hypothetical protein +FIG01226798 FIG01226799: hypothetical protein +FIG01226799 FIG01226800: hypothetical protein +FIG01226800 FIG01226802: hypothetical protein +FIG01226802 FIG01226803: hypothetical protein +FIG01226803 FIG01226807: hypothetical protein +FIG01226807 Intracellular serine protease +FIG01226808 FIG01226809: hypothetical protein +FIG01226809 FIG01226811: hypothetical protein +FIG01226811 FIG01226812: hypothetical protein +FIG01226812 FIG01226813: hypothetical protein +FIG01226817 FIG01226819: hypothetical protein +FIG01226819 YeaB (Cation efflux protein) +FIG01226820 FIG01226821: hypothetical protein +FIG01226821 FIG01226822: hypothetical protein +FIG01226823 FIG01226824: hypothetical protein +FIG01226824 FIG01226826: hypothetical protein +FIG01226826 FIG01226828: hypothetical protein +FIG01226828 FIG01226830: hypothetical protein +FIG01226830 FIG01226831: hypothetical protein +FIG01226831 Tetraprenyl-beta-curcumene synthase (EC 4.2.3.130) +FIG01226832 RibT protein +FIG01226834 FIG01226835: hypothetical protein +FIG01226835 FIG01226839: hypothetical protein +FIG01226839 FIG01226841: hypothetical protein +FIG01226841 FIG01226843: hypothetical protein +FIG01226843 FIG01226844: hypothetical protein +FIG01226847 Probable oxidoreductase, with Rieske iron-sulfur protein 2Fe-2S subunit +FIG01226849 FIG01226851: hypothetical protein +FIG01226851 FIG01226852: hypothetical protein +FIG01226852 FIG01226853: hypothetical protein +FIG01226853 FIG01226854: hypothetical protein +FIG01226854 FIG01226855: hypothetical protein +FIG01226855 FIG01226856: hypothetical protein +FIG01226857 FIG01226858: hypothetical protein +FIG01226858 FIG01226859: hypothetical protein +FIG01226859 FIG01226860: hypothetical protein +FIG01226860 FIG01226861: hypothetical protein +FIG01226861 FIG01226863: hypothetical protein +FIG01226864 FIG01226865: hypothetical protein +FIG01226866 FIG01226870: hypothetical protein +FIG01226870 FIG01226871: hypothetical protein +FIG01226872 carbonic anhydrase, prokaryotic type, putative +FIG01226874 FIG01226875: hypothetical protein +FIG01226876 FIG01226877: hypothetical protein +FIG01226878 FIG01226880: hypothetical protein +FIG01226880 FIG01226881: hypothetical protein +FIG01226881 FIG01226883: hypothetical protein +FIG01226883 FIG01226884: hypothetical protein +FIG01226884 FIG01226885: hypothetical protein +FIG01226885 FIG01226887: hypothetical protein +FIG01226887 FIG01226888: hypothetical protein +FIG01226888 FIG01226890: hypothetical protein +FIG01226890 FIG01226891: hypothetical protein +FIG01226891 FIG01226893: hypothetical protein +FIG01226893 FIG01226896: hypothetical protein +FIG01226896 FIG01226898: hypothetical protein +FIG01226898 FIG01226899: hypothetical protein +FIG01226900 FIG01226901: hypothetical protein +FIG01226901 FIG01226902: hypothetical protein +FIG01226902 FIG01226904: hypothetical protein +FIG01226904 hypothetical protein +FIG01226905 FIG01226907: hypothetical protein +FIG01226907 FIG01226908: hypothetical protein +FIG01226908 YvkN +FIG01226912 FIG01226914: hypothetical protein +FIG01226914 FIG01226916: hypothetical protein +FIG01226916 FIG01226918: hypothetical protein +FIG01226918 EMG2 protein +FIG01226920 FIG01226923: hypothetical protein +FIG01226924 potassium uptake protein, TrkH family +FIG01226925 FIG01226926: hypothetical protein +FIG01226926 O-methyltransferase domain protein +FIG01226927 FIG01226929: hypothetical protein +FIG01226929 pXO1 ORF16-like protein +FIG01226930 FIG01226931: hypothetical protein +FIG01226933 FIG01226934: hypothetical protein +FIG01226936 FIG01226937: hypothetical protein +FIG01226940 FIG01226941: hypothetical protein +FIG01226941 FIG01226944: hypothetical protein +FIG01226945 FIG01226946: hypothetical protein +FIG01226947 FIG01226948: hypothetical protein +FIG01226949 FIG01226952: hypothetical protein +FIG01226957 FIG01226958: hypothetical protein +FIG01226958 Two-component sensor kinase (EC 2.7.3.-) +FIG01226959 FIG01226960: hypothetical protein +FIG01226962 FIG01226963: hypothetical protein +FIG01226963 possible resolvase +FIG01226965 FIG01226966: hypothetical protein +FIG01226966 FIG01226967: hypothetical protein +FIG01226967 Cyclic AMP receptor protein regulatory protein CRP +FIG01226968 FIG01226969: hypothetical protein +FIG01226970 Hypothetical protein YfkI +FIG01226971 FIG01226973: hypothetical protein +FIG01226974 FIG01226975: hypothetical protein +FIG01226975 FIG01226976: hypothetical protein +FIG01226976 FIG01226979: hypothetical protein +FIG01226981 reticulocyte binding protein +FIG01226982 FIG01226983: hypothetical protein +FIG01226984 FIG01226988: hypothetical protein +FIG01226991 Putative uncharacterized protein GBAA1178 +FIG01226992 FIG01226993: hypothetical protein +FIG01226993 FIG01226995: hypothetical protein +FIG01226995 FIG01226997: hypothetical protein +FIG01226997 FIG01226998: hypothetical protein +FIG01226998 FIG01226999: hypothetical protein +FIG01226999 FIG01227000: hypothetical protein +FIG01227000 FIG01227002: hypothetical protein +FIG01227003 FIG01227004: hypothetical protein +FIG01227006 FIG01227007: hypothetical protein +FIG01227007 FIG01227008: hypothetical protein +FIG01227008 FIG01227009: hypothetical protein +FIG01227009 FIG01227012: hypothetical protein +FIG01227012 alpha-ketoglutarate permease, putative +FIG01227020 FIG01227021: hypothetical protein +FIG01227021 FIG01227022: hypothetical protein +FIG01227023 hypothetical protein +FIG01227028 FIG01227030: hypothetical protein +FIG01227030 FIG01227031: hypothetical protein +FIG01227033 FIG01227034: hypothetical protein +FIG01227034 FIG01227036: hypothetical protein +FIG01227036 FIG01227037: hypothetical protein +FIG01227037 FIG01227038: hypothetical protein +FIG01227038 FIG01227039: hypothetical protein +FIG01227040 Competence transcription factor, degenerate +FIG01227043 FIG01227044: hypothetical protein +FIG01227045 FIG01227048: hypothetical protein +FIG01227048 FIG01227049: hypothetical protein +FIG01227050 conserved hypothetical Bacillus plasmid protein +FIG01227053 FIG01227054: hypothetical protein +FIG01227054 FIG01227055: hypothetical protein +FIG01227055 FIG01227058: hypothetical protein +FIG01227059 surfactin production and competence +FIG01227062 FIG01227063: hypothetical protein +FIG01227063 FIG01227065: hypothetical protein +FIG01227066 Macrocin O-methyltransferase (EC 2.1.1.101) +FIG01227067 FIG01227069: hypothetical protein +FIG01227071 FIG01227072: hypothetical protein +FIG01227072 FIG01227073: hypothetical protein +FIG01227073 FIG01227077: hypothetical protein +FIG01227077 FIG01227078: hypothetical protein +FIG01227078 FIG01227079: hypothetical protein +FIG01227079 FIG01227081: hypothetical protein +FIG01227083 Aminoglycoside 6-adenylyltransferase (EC 2.7.7.-) +FIG01227084 FIG01227087: hypothetical protein +FIG01227087 FIG01227088: hypothetical protein +FIG01227088 FIG01227090: hypothetical protein +FIG01227090 UDP-N-acetyl-D-mannosamine 6-dehydrogenase +FIG01227092 FIG01227094: hypothetical protein +FIG01227094 Uncharacterized protein ywkF +FIG01227095 FIG01227096: hypothetical protein +FIG01227096 FIG01227097: hypothetical protein +FIG01227097 FIG01227098: hypothetical protein +FIG01227098 FIG01227099: hypothetical protein +FIG01227101 FIG01227102: hypothetical protein +FIG01227103 FIG01227105: hypothetical protein +FIG01227105 FIG01227106: hypothetical protein +FIG01227106 FIG01227107: hypothetical protein +FIG01227107 FIG01227108: hypothetical protein +FIG01227109 FIG01227111: hypothetical protein +FIG01227111 FIG01227112: hypothetical protein +FIG01227112 CAAX amino terminal protease family family +FIG01227113 FIG01227114: hypothetical protein +FIG01227114 FIG01227115: hypothetical protein +FIG01227115 FIG01227117: hypothetical protein +FIG01227117 Nitrilotriacetate monooxygenase component A( EC:1.14.13.- ) +FIG01227119 YjfB +FIG01227123 FIG01227124: hypothetical protein +FIG01227128 FIG01227129: hypothetical protein +FIG01227129 FIG01227132: hypothetical protein +FIG01227132 FIG01227133: hypothetical protein +FIG01227133 FIG01227134: hypothetical protein +FIG01227136 FIG01227137: hypothetical protein +FIG01227137 FIG01227138: hypothetical protein +FIG01227138 FIG01227139: hypothetical protein +FIG01227139 XkdN2 +FIG01227142 Site-specific recombinase XerD +FIG01227143 FkbH +FIG01227144 FIG01227147: hypothetical protein +FIG01227149 FIG01227150: hypothetical protein +FIG01227150 FIG01227151: hypothetical protein +FIG01227153 FIG01227154: hypothetical protein +FIG01227156 FIG01227158: hypothetical protein +FIG01227158 FIG01227160: hypothetical protein +FIG01227160 FIG01227161: hypothetical protein +FIG01227161 FIG01227163: hypothetical protein +FIG01227163 FIG01227164: hypothetical protein +FIG01227164 FIG01227167: hypothetical protein +FIG01227167 Lantibiotic ABC transporter +FIG01227172 FIG01227174: hypothetical protein +FIG01227175 CARBOXYMETHYLENEBUTENOLIDASE-RELATED PROTEIN +FIG01227176 FIG01227178: hypothetical protein +FIG01227178 FIG01227179: hypothetical protein +FIG01227179 Integral membrane protein domain protein +FIG01227181 FIG01227182: hypothetical protein +FIG01227182 FIG01227183: hypothetical protein +FIG01227183 FIG01227184: hypothetical protein +FIG01227184 FIG01227185: hypothetical protein +FIG01227186 FIG01227190: hypothetical protein +FIG01227191 FIG01227193: hypothetical protein +FIG01227193 comA operon protein, putative +FIG01227194 FIG01227195: hypothetical protein +FIG01227196 FIG01227197: hypothetical protein +FIG01227197 Transposon Tn7 transposition protein tnsC +FIG01227198 FIG01227199: hypothetical protein +FIG01227199 FIG01227200: hypothetical protein +FIG01227200 FIG01227201: hypothetical protein +FIG01227205 EAL-domain protein +FIG01227207 FIG01227208: hypothetical protein +FIG01227208 FIG01227210: hypothetical protein +FIG01227210 Ferrichrome transport system permease protein FhuG +FIG01227215 FIG01227216: hypothetical protein +FIG01227216 FIG01227217: hypothetical protein +FIG01227217 FIG01227218: hypothetical protein +FIG01227218 FIG01227220: hypothetical protein +FIG01227220 Streptolysin S export transmembrane permease (SagH) +FIG01227221 PlcB, ORFX, ORFP, ORFB, ORFA, ldh gene +FIG01227222 FIG01227223: hypothetical protein +FIG01227224 FIG01227225: hypothetical protein +FIG01227226 FIG01227227: hypothetical protein +FIG01227227 FIG01227228: hypothetical protein +FIG01227228 FIG01227229: hypothetical protein +FIG01227229 FIG01227230: hypothetical protein +FIG01227231 FIG01227234: hypothetical protein +FIG01227237 FIG01227238: hypothetical protein +FIG01227238 FIG01227239: hypothetical protein +FIG01227239 SspL +FIG01227242 FIG01227244: hypothetical protein +FIG01227244 FIG01227245: hypothetical protein +FIG01227247 permease, putative +FIG01227248 Glycosyltransferase involved in cell wall biogenesis +FIG01227249 FIG01227251: hypothetical protein +FIG01227262 FIG01227263: hypothetical protein +FIG01227266 FIG01227267: hypothetical protein +FIG01227267 FIG01227268: hypothetical protein +FIG01227269 FIG01227271: hypothetical protein +FIG01227271 Hypothetical protein, GBAA2540 homolog +FIG01227273 FIG01227274: hypothetical protein +FIG01227275 FIG01227276: hypothetical protein +FIG01227285 substrate-binding family protein, putative +FIG01227286 FIG01227287: hypothetical protein +FIG01227287 FIG01227288: hypothetical protein +FIG01227288 FIG01227290: hypothetical protein +FIG01227293 Ankyrin repeat domain protein +FIG01227294 FIG01227295: hypothetical protein +FIG01227295 FIG01227296: hypothetical protein +FIG01227296 FIG01227298: hypothetical protein +FIG01227298 FIG01227299: hypothetical protein +FIG01227299 FIG01227300: hypothetical protein +FIG01227300 FIG01227301: hypothetical protein +FIG01227302 FIG01227303: hypothetical protein +FIG01227304 FIG01227307: hypothetical protein +FIG01227308 FIG01227309: hypothetical protein +FIG01227312 FIG01227313: hypothetical protein +FIG01227313 Cation transporter, putative +FIG01227319 FIG01227321: hypothetical protein +FIG01227321 FIG01227323: hypothetical protein +FIG01227323 Acetamidase (EC 3.5.1.4) +FIG01227324 FIG01227325: hypothetical protein +FIG01227325 NAD(P)H dehydrogenase, quinone family +FIG01227328 FIG01227331: hypothetical protein +FIG01227331 FIG01227332: hypothetical protein +FIG01227332 FIG01227333: hypothetical protein +FIG01227333 FIG01227334: hypothetical protein +FIG01227335 FIG01227336: hypothetical protein +FIG01227336 FIG01227337: hypothetical protein +FIG01227337 Two-component sensor protein yhcY +FIG01227338 Blr5358 protein +FIG01227342 FIG01227344: hypothetical protein +FIG01227346 FIG01227351: hypothetical protein +FIG01227352 FIG01227353: hypothetical protein +FIG01227355 FIG01227357: hypothetical protein +FIG01227359 FIG01227362: hypothetical protein +FIG01227362 FIG00673730: hypothetical protein +FIG01227363 FIG01227365: hypothetical protein +FIG01227365 FIG01227367: hypothetical protein +FIG01227370 FIG01227371: hypothetical protein +FIG01227371 FIG01227372: hypothetical protein +FIG01227373 Uncharacterized protein ywdE precursor +FIG01227375 FIG01227376: hypothetical protein +FIG01227376 FIG01227377: hypothetical protein +FIG01227377 FIG01227378: hypothetical protein +FIG01227379 FIG01227381: hypothetical protein +FIG01227381 FIG01227382: hypothetical protein +FIG01227382 FIG01227383: hypothetical protein +FIG01227383 FIG01227384: hypothetical protein +FIG01227389 FIG01227390: hypothetical protein +FIG01227390 FIG01227391: hypothetical protein +FIG01227391 FIG01227392: hypothetical protein +FIG01227392 FIG01227393: hypothetical protein +FIG01227393 FIG01227394: hypothetical protein +FIG01227395 wall-associated protein +FIG01227397 FIG01227398: hypothetical protein +FIG01227398 Sensor histidine kinase (EC 2.7.3.-) +FIG01227400 FIG01227402: hypothetical protein +FIG01227402 FIG01227403: hypothetical protein +FIG01227404 FIG01227405: hypothetical protein +FIG01227405 FIG01227406: hypothetical protein +FIG01227406 FIG01227407: hypothetical protein +FIG01227407 FIG01227409: hypothetical protein +FIG01227409 FIG01227410: hypothetical protein +FIG01227413 FIG01227414: hypothetical protein +FIG01227414 FIG01227415: hypothetical protein +FIG01227418 FIG01227419: hypothetical protein +FIG01227419 FIG01227420: hypothetical protein +FIG01227420 FIG01227421: hypothetical protein +FIG01227426 FIG01227429: hypothetical protein +FIG01227430 pXO1-19 +FIG01227434 conserved hypothetical protein; possible endonuclease +FIG01227438 FIG01227444: hypothetical protein +FIG01227444 FIG01227448: hypothetical protein +FIG01227448 FIG01227452: hypothetical protein +FIG01227452 FIG01227453: hypothetical protein +FIG01227454 FIG01227456: hypothetical protein +FIG01227456 FIG01227457: hypothetical protein +FIG01227457 Uncharacterized protein yuzG +FIG01227458 FIG01227463: hypothetical protein +FIG01227463 FIG01227464: hypothetical protein +FIG01227464 FIG01227467: hypothetical protein +FIG01227467 FIG01227468: hypothetical protein +FIG01227468 FIG01227469: hypothetical protein +FIG01227469 FIG01227471: hypothetical protein +FIG01227471 FIG01227473: hypothetical protein +FIG01227473 FIG01227476: hypothetical protein +FIG01227477 FIG01227478: hypothetical protein +FIG01227478 FIG01227479: hypothetical protein +FIG01227479 FIG01227480: hypothetical protein +FIG01227480 Antigen +FIG01227481 FIG01227482: hypothetical protein +FIG01227482 hypothetical protein +FIG01227488 FIG01227489: hypothetical protein +FIG01227489 competence protein j +FIG01227491 FIG01227492: hypothetical protein +FIG01227493 FIG01227494: hypothetical protein +FIG01227495 FIG01227496: hypothetical protein +FIG01227496 FIG01227497: hypothetical protein +FIG01227498 FIG01227499: hypothetical protein +FIG01227499 FIG01227501: hypothetical protein +FIG01227501 FIG01227502: hypothetical protein +FIG01227502 FIG01227503: hypothetical protein +FIG01227503 FIG01227504: hypothetical protein +FIG01227504 FIG01227505: hypothetical protein +FIG01227506 ProA domain protein +FIG01227507 FIG01227508: hypothetical protein +FIG01227508 FIG01227510: hypothetical protein +FIG01227510 FIG01227512: hypothetical protein +FIG01227512 Non-hemolytic enterotoxin A +FIG01227514 Spore germination protein KC +FIG01227517 FIG01227518: hypothetical protein +FIG01227523 FIG01227524: hypothetical protein +FIG01227527 FIG01227528: hypothetical protein +FIG01227528 FIG01227529: hypothetical protein +FIG01227530 FIG01227532: hypothetical protein +FIG01227532 FIG01227533: hypothetical protein +FIG01227533 FIG01227534: hypothetical protein +FIG01227534 FIG01227536: hypothetical protein +FIG01227537 FIG01227539: hypothetical protein +FIG01227541 FIG01227544: hypothetical protein +FIG01227544 FIG01227547: hypothetical protein +FIG01227549 FIG01227551: hypothetical protein +FIG01227551 FIG01227557: hypothetical protein +FIG01227557 FIG01227558: hypothetical protein +FIG01227558 FIG01227559: hypothetical protein +FIG01227560 FIG01227561: hypothetical protein +FIG01227561 hook-associated protein 2 +FIG01227563 FIG01227564: hypothetical protein +FIG01227565 bypass-of-forespore protein C, putative +FIG01227566 FIG01227569: hypothetical protein +FIG01227569 FIG01227570: hypothetical protein +FIG01227570 FIG01227571: hypothetical protein +FIG01227571 FIG01227572: hypothetical protein +FIG01227572 FIG01227574: hypothetical protein +FIG01227575 FIG020130: hypothetical protein +FIG01227578 MinD family ATPase domain protein +FIG01227579 FIG01227580: hypothetical protein +FIG01227584 wall-associated protein, putative +FIG01227588 FIG01227589: hypothetical protein +FIG01227589 FIG00673500: hypothetical protein +FIG01227591 Trp repressor binding protein +FIG01227594 Thioesterase +FIG01227595 FIG01227596: hypothetical protein +FIG01227596 FIG01227597: hypothetical protein +FIG01227600 FIG01227602: hypothetical protein +FIG01227608 Thioredoxin related protein +FIG01227610 FIG01227611: hypothetical protein +FIG01227614 FIG01227616: hypothetical protein +FIG01227617 FIG01227619: hypothetical protein +FIG01227619 FIG01227620: hypothetical protein +FIG01227620 cysteine synthase, putative +FIG01227624 FIG01227625: hypothetical protein +FIG01227625 FIG01227626: hypothetical protein +FIG01227630 Lumazine binding domain protein +FIG01227631 FIG01227633: hypothetical protein +FIG01227635 FIG01227636: hypothetical protein +FIG01227636 FIG01227637: hypothetical protein +FIG01227639 FIG01227640: hypothetical protein +FIG01227640 FIG01227641: hypothetical protein +FIG01227641 FIG01227643: hypothetical protein +FIG01227643 FIG01227644: hypothetical protein +FIG01227644 FIG01227645: hypothetical protein +FIG01227645 FIG01227646: hypothetical protein +FIG01227646 FIG01227647: hypothetical protein +FIG01227647 FIG01227649: hypothetical protein +FIG01227651 FIG01227652: hypothetical protein +FIG01227652 FIG01227654: hypothetical protein +FIG01227654 FIG01227655: hypothetical protein +FIG01227655 FIG01227656: hypothetical protein +FIG01227656 CDS_ID OB0376 +FIG01227657 FIG01227658: hypothetical protein +FIG01227658 FIG01227660: hypothetical protein +FIG01227661 FIG01227662: hypothetical protein +FIG01227662 FIG01227663: hypothetical protein +FIG01227663 FIG01227664: hypothetical protein +FIG01227664 FIG01227666: hypothetical protein +FIG01227671 FIG01227672: hypothetical protein +FIG01227672 FIG01227673: hypothetical protein +FIG01227673 FIG01227675: hypothetical protein +FIG01227675 FIG01227677: hypothetical protein +FIG01227677 response regulator DrrA +FIG01227679 FIG01227680: hypothetical protein +FIG01227681 FIG01227682: hypothetical protein +FIG01227683 FIG01227685: hypothetical protein +FIG01227685 FIG01227686: hypothetical protein +FIG01227686 FIG01227687: hypothetical protein +FIG01227691 FIG01227692: hypothetical protein +FIG01227692 uncharacterized protein, homolog of YCGL B. subtilis +FIG01227693 FIG01227695: hypothetical protein +FIG01227695 FIG01227696: hypothetical protein +FIG01227696 FIG01227698: hypothetical protein +FIG01227698 FIG01227699: hypothetical protein +FIG01227700 FIG01227702: hypothetical protein +FIG01227705 FIG01227706: hypothetical protein +FIG01227706 FIG01227708: hypothetical protein +FIG01227709 FIG01227711: hypothetical protein +FIG01227712 FIG01227713: hypothetical protein +FIG01227713 FIG01227715: hypothetical protein +FIG01227715 FIG01227716: hypothetical protein +FIG01227716 FIG01227719: hypothetical protein +FIG01227721 FIG01227722: hypothetical protein +FIG01227725 FIG01227726: hypothetical protein +FIG01227726 FIG01227728: hypothetical protein +FIG01227729 Sporulation control protein Spo0M +FIG01227732 FIG01227733: hypothetical protein +FIG01227733 FIG01227734: hypothetical protein +FIG01227734 FIG01227735: hypothetical protein +FIG01227737 FIG01227739: hypothetical protein +FIG01227741 FIG01227743: hypothetical protein +FIG01227743 FIG01227744: hypothetical protein +FIG01227744 FIG01227746: hypothetical protein +FIG01227746 FIG01227748: hypothetical protein +FIG01227748 FIG01227751: hypothetical protein +FIG01227755 FIG01227756: hypothetical protein +FIG01227756 FIG01227757: hypothetical protein +FIG01227757 FIG01227758: hypothetical protein +FIG01227758 FIG01227759: hypothetical protein +FIG01227761 FIG01227763: hypothetical protein +FIG01227763 FIG01227764: hypothetical protein +FIG01227765 FIG01227768: hypothetical protein +FIG01227769 FIG01227770: hypothetical protein +FIG01227774 FIG01227775: hypothetical protein +FIG01227775 FIG01227776: hypothetical protein +FIG01227776 FIG01227777: hypothetical protein +FIG01227777 FIG01227778: hypothetical protein +FIG01227779 FIG01227780: hypothetical protein +FIG01227780 FIG01227781: hypothetical protein +FIG01227781 FIG01227782: hypothetical protein +FIG01227782 FIG01227784: hypothetical protein +FIG01227784 integral membrane protein +FIG01227787 FIG01227790: hypothetical protein +FIG01227790 FIG01227791: hypothetical protein +FIG01227793 FIG01227794: hypothetical protein +FIG01227794 FIG01227796: hypothetical protein +FIG01227796 FIG01227797: hypothetical protein +FIG01227799 FIG01227800: hypothetical protein +FIG01227801 FIG01227803: hypothetical protein +FIG01227805 FIG01227808: hypothetical protein +FIG01227808 FIG01227809: hypothetical protein +FIG01227809 FIG01227811: hypothetical protein +FIG01227813 FIG01227814: hypothetical protein +FIG01227814 FIG01227816: hypothetical protein +FIG01227816 FIG01287439: hypothetical protein +FIG01227819 FIG01227821: hypothetical protein +FIG01227824 FIG01227825: hypothetical protein +FIG01227825 FIG01227826: hypothetical protein +FIG01227831 YokU +FIG01227835 tellurium resistance protein, putative +FIG01227839 teichuronopeptide biosynthesis +FIG01227840 FIG01227842: hypothetical protein +FIG01227842 pXO1-50 +FIG01227843 FIG01227844: hypothetical protein +FIG01227844 collagen adhesion protein +FIG01227847 FIG01227848: hypothetical protein +FIG01227848 hypothetical protein +FIG01227852 FIG01227853: hypothetical protein +FIG01227854 bacillopeptidase F +FIG01227855 FIG01227857: hypothetical protein +FIG01227859 copy control protein, repB - Enterococcus faecalis plasmid PAD1 (L01794) +FIG01227860 FIG01227861: hypothetical protein +FIG01227861 FIG01227862: hypothetical protein +FIG01227862 FIG01227864: hypothetical protein +FIG01227864 FIG01227865: hypothetical protein +FIG01227865 pXO1-75 +FIG01227867 FIG01227868: hypothetical protein +FIG01227868 FIG01227869: hypothetical protein +FIG01227872 porphyromonas-type peptidyl-arginine deiminase +FIG01227874 FIG01227876: hypothetical protein +FIG01227876 FIG01227877: hypothetical protein +FIG01227877 FIG01227878: hypothetical protein +FIG01227878 FIG01227880: hypothetical protein +FIG01227881 FIG01227882: hypothetical protein +FIG01227882 hypothetical protein +FIG01227885 FIG01227886: hypothetical protein +FIG01227890 FIG01227891: hypothetical protein +FIG01227892 FIG01227895: hypothetical protein +FIG01227898 FIG01227899: hypothetical protein +FIG01227899 FIG01227900: hypothetical protein +FIG01227903 FIG01227906: hypothetical protein +FIG01227906 FIG01227908: hypothetical protein +FIG01227908 FIG01227909: hypothetical protein +FIG01227909 Chloramphenicol-sensitive protein RarD +FIG01227910 Putative Xaa-Pro dipeptidyl-peptidase (EC 3.4.14.11) (X-Pro dipeptidyl-peptidase) (X-prolyl-dipeptidyl aminopeptidase) (X-PDAP) +FIG01227911 FIG01227912: hypothetical protein +FIG01227913 VPS10, VPS10 domain +FIG01227915 FIG00672739: hypothetical protein +FIG01227916 FIG01227918: hypothetical protein +FIG01227918 hypothetical protein +FIG01227919 FIG01227920: hypothetical protein +FIG01227922 FIG01227923: hypothetical protein +FIG01227923 FIG01227925: hypothetical protein +FIG01227926 FIG01227927: hypothetical protein +FIG01227927 FIG01227929: hypothetical protein +FIG01227929 FIG01227932: hypothetical protein +FIG01227932 FIG01227933: hypothetical protein +FIG01227936 FIG01227937: hypothetical protein +FIG01227937 FIG01227938: hypothetical protein +FIG01227938 Bona fide RidA/YjgF/TdcF/RutC subgroup +FIG01227940 FIG01227941: hypothetical protein +FIG01227942 FIG01227944: hypothetical protein +FIG01227944 FIG01227946: hypothetical protein +FIG01227946 FIG01227949: hypothetical protein +FIG01227949 FIG01227950: hypothetical protein +FIG01227950 Polypeptide composition of the spore coat; required for the assembly of CotJC +FIG01227951 FIG01227952: hypothetical protein +FIG01227952 FIG01227953: hypothetical protein +FIG01227961 FIG01227962: hypothetical protein +FIG01227962 FIG01227963: hypothetical protein +FIG01227964 FIG01227965: hypothetical protein +FIG01227965 FIG01227966: hypothetical protein +FIG01227966 Phage-like element PBSX protein xkdH +FIG01227975 FIG01227976: hypothetical protein +FIG01227976 FIG01227979: hypothetical protein +FIG01227981 FIG01227982: hypothetical protein +FIG01227982 glycosyltransferase, putative +FIG01227984 FIG01227986: hypothetical protein +FIG01227986 two-component sensor histidine kinase (stage II sporulation protein J) +FIG01227987 FIG01227990: hypothetical protein +FIG01227990 FIG01227994: hypothetical protein +FIG01227994 FIG01227995: hypothetical protein +FIG01227995 FIG01227996: hypothetical protein +FIG01227996 FIG01227998: hypothetical protein +FIG01227998 FIG01227999: hypothetical protein +FIG01228003 FIG01228004: hypothetical protein +FIG01228004 5-methylcytosine-specific restriction enzyme A +FIG01228008 FIG01228009: hypothetical protein +FIG01228010 FIG01228011: hypothetical protein +FIG01228012 FIG01228013: hypothetical protein +FIG01228013 FIG01228015: hypothetical protein +FIG01228015 FIG01228016: hypothetical protein +FIG01228017 FIG01228018: hypothetical protein +FIG01228018 FIG01228020: hypothetical protein +FIG01228027 FIG01228028: hypothetical protein +FIG01228029 FIG01228030: hypothetical protein +FIG01228030 FIG01228034: hypothetical protein +FIG01228035 ABC transporter, ATP-binding protein, putative +FIG01228040 FIG01228041: hypothetical protein +FIG01228041 FIG01228047: hypothetical protein +FIG01228047 pXO1 ORF14-like protein +FIG01228049 FIG01228050: hypothetical protein +FIG01228052 FIG01228053: hypothetical protein +FIG01228053 FIG01228054: hypothetical protein +FIG01228054 alternate gene name: comB, yufA +FIG01228055 FIG01228056: hypothetical protein +FIG01228056 FIG01228057: hypothetical protein +FIG01228062 FIG01228063: hypothetical protein +FIG01228063 FIG01228064: hypothetical protein +FIG01228064 FIG01228065: hypothetical protein +FIG01228065 Hypothetical membrane spanning protein +FIG01228068 FIG01228069: hypothetical protein +FIG01228073 FIG01228074: hypothetical protein +FIG01228074 FIG01228076: hypothetical protein +FIG01228077 FIG01228079: hypothetical protein +FIG01228079 FIG01228082: hypothetical protein +FIG01228082 FIG01228083: hypothetical protein +FIG01228083 Uncharacterised protein family UPF0157 (COG2320) +FIG01228085 FIG01228086: hypothetical protein +FIG01228087 FIG01228088: hypothetical protein +FIG01228088 FIG01228089: hypothetical protein +FIG01228099 FIG01228100: hypothetical protein +FIG01228101 FIG01228102: hypothetical protein +FIG01228102 FIG01228104: hypothetical protein +FIG01228105 FIG01228107: hypothetical protein +FIG01228107 FIG01228109: hypothetical protein +FIG01228109 Copper resistance protein CopC +FIG01228111 FIG01228116: hypothetical protein +FIG01228116 FIG01228117: hypothetical protein +FIG01228119 FIG01228120: hypothetical protein +FIG01228124 YoaO +FIG01228126 FIG01228129: hypothetical protein +FIG01228129 FIG01228131: hypothetical protein +FIG01228137 FIG01228138: hypothetical protein +FIG01228138 FIG01228139: hypothetical protein +FIG01228143 Protein SkfG +FIG01228150 UDP-glucose/GDP-mannose dehydrogenase family +FIG01228151 FIG01228153: hypothetical protein +FIG01228153 FIG01228154: hypothetical protein +FIG01228161 Protein of unknown function DUF419 +FIG01228162 FIG01228163: hypothetical protein +FIG01228163 FIG01228164: hypothetical protein +FIG01228164 FIG01228165: hypothetical protein +FIG01228165 FIG01228166: hypothetical protein +FIG01228166 FIG01228167: hypothetical protein +FIG01228167 FIG01228169: hypothetical protein +FIG01228170 FIG01228171: hypothetical protein +FIG01228171 FIG01228173: hypothetical protein +FIG01228188 FIG01228189: hypothetical protein +FIG01228189 FIG01228190: hypothetical protein +FIG01228191 FIG01228193: hypothetical protein +FIG01228193 FIG01228194: hypothetical protein +FIG01228194 FIG01228197: hypothetical protein +FIG01228198 FIG01228202: hypothetical protein +FIG01228202 FIG01228203: hypothetical protein +FIG01228204 FIG01228205: hypothetical protein +FIG01228206 FIG01228207: hypothetical protein +FIG01228207 FIG01228211: hypothetical protein +FIG01228211 FIG01228212: hypothetical protein +FIG01228212 FIG01228215: hypothetical protein +FIG01228219 FIG01228220: hypothetical protein +FIG01228221 FIG01228222: hypothetical protein +FIG01228223 FIG01228225: hypothetical protein +FIG01228225 FIG01228226: hypothetical protein +FIG01228226 FIG01228228: hypothetical protein +FIG01228229 FIG01228233: hypothetical protein +FIG01228234 FIG01228236: hypothetical protein +FIG01228239 FIG01228240: hypothetical protein +FIG01228243 FIG01228245: hypothetical protein +FIG01228247 FIG01228248: hypothetical protein +FIG01228248 FIG01228250: hypothetical protein +FIG01228250 FIG01228252: hypothetical protein +FIG01228266 FIG01228267: hypothetical protein +FIG01228268 Transcriptional regulator YetL, MarR family +FIG01228279 FIG01228280: hypothetical protein +FIG01228280 FIG01228281: hypothetical protein +FIG01228284 FIG01228285: hypothetical protein +FIG01228285 FIG01228287: hypothetical protein +FIG01228287 FIG01228289: hypothetical protein +FIG01228289 FIG01228292: hypothetical protein +FIG01228292 FIG01228293: hypothetical protein +FIG01228293 FIG01228294: hypothetical protein +FIG01228294 Enterotoxin C +FIG01228295 FIG01228296: hypothetical protein +FIG01228296 immunity repressor protein (phage-related protein) +FIG01228297 YwhL +FIG01228299 FIG01228300: hypothetical protein +FIG01228301 FIG01228303: hypothetical protein +FIG01228304 FIG01228305: hypothetical protein +FIG01228305 FIG01228306: hypothetical protein +FIG01228306 activation of degradative enzymes (aprE, nprE, sacB) +FIG01228308 FIG01228311: hypothetical protein +FIG01228312 FIG01228314: hypothetical protein +FIG01228315 FIG01228316: hypothetical protein +FIG01228316 FIG01228318: hypothetical protein +FIG01228318 FIG01228320: hypothetical protein +FIG01228320 Predicted exonuclease +FIG01228322 FIG008208: hypothetical protein +FIG01228323 FIG01228324: hypothetical protein +FIG01228324 FIG01228325: hypothetical protein +FIG01228326 FIG01228327: hypothetical protein +FIG01228327 FIG01228330: hypothetical protein +FIG01228333 FIG01228335: hypothetical protein +FIG01228338 FIG01228339: hypothetical protein +FIG01228339 FIG01228340: hypothetical protein +FIG01228341 FIG01228342: hypothetical protein +FIG01228342 FIG01228344: hypothetical protein +FIG01228344 FIG01228345: hypothetical protein +FIG01228345 FIG01228347: hypothetical protein +FIG01228348 CBS domain containing protein +FIG01228349 FIG01228351: hypothetical protein +FIG01228351 FIG01228354: hypothetical protein +FIG01228355 FIG01228356: hypothetical protein +FIG01228356 N-acetylmuramoyl-L-alanine amidase, family 3 +FIG01228361 transcriptional regulator involved in mercury resistance operon +FIG01228362 FIG01228363: hypothetical protein +FIG01228363 subtilisin-like serine protease +FIG01228364 FIG01228366: hypothetical protein +FIG01228366 FIG01228367: hypothetical protein +FIG01228367 FIG01228369: hypothetical protein +FIG01228370 FIG01228372: hypothetical protein +FIG01228372 FIG01228374: hypothetical protein +FIG01228374 spore coat polysaccharide synthesis +FIG01228377 FIG01228378: hypothetical protein +FIG01228380 FIG01228381: hypothetical protein +FIG01228381 FIG01228382: hypothetical protein +FIG01228382 FIG01228383: hypothetical protein +FIG01228383 pXO1-28 +FIG01228385 FIG01228387: hypothetical protein +FIG01228387 Endoglucanase 4 precursor (EC 3.2.1.4) +FIG01228390 FIG01228391: hypothetical protein +FIG01228391 FIG01228392: hypothetical protein +FIG01228392 FIG002540: Haloacid dehalogenase-like hydrolase +FIG01228393 FIG01228394: hypothetical protein +FIG01228394 FIG01228395: hypothetical protein +FIG01228395 FIG01228396: hypothetical protein +FIG01228397 FIG01228399: hypothetical protein +FIG01228399 FIG01228400: hypothetical protein +FIG01228400 FIG01228401: hypothetical protein +FIG01228401 hypothetical phage related protein +FIG01228402 FIG01228403: hypothetical protein +FIG01228405 ABC transporter, permease associated with salivaricin lantibiotic +FIG01228406 FIG01228407: hypothetical protein +FIG01228407 FIG01228408: hypothetical protein +FIG01228408 YhjC +FIG01228410 FIG01228413: hypothetical protein +FIG01228414 FIG01228415: hypothetical protein +FIG01228417 FIG01228419: hypothetical protein +FIG01228419 FIG01228420: hypothetical protein +FIG01228421 FIG01228422: hypothetical protein +FIG01228423 FIG01228426: hypothetical protein +FIG01228428 FIG01228431: hypothetical protein +FIG01228431 FIG01228432: hypothetical protein +FIG01228432 FIG01228433: hypothetical protein +FIG01228436 FIG01228437: hypothetical protein +FIG01228437 FIG01228439: hypothetical protein +FIG01228450 FIG01228451: hypothetical protein +FIG01228452 FIG01228453: hypothetical protein +FIG01228453 FIG01228454: hypothetical protein +FIG01228454 FIG01228455: hypothetical protein +FIG01228464 FIG01228465: hypothetical protein +FIG01228465 FIG01228466: hypothetical protein +FIG01228467 FIG01228469: hypothetical protein +FIG01228469 FIG01228471: hypothetical protein +FIG01228477 pXO1-68 +FIG01228478 FIG01228481: hypothetical protein +FIG01228481 FIG01228482: hypothetical protein +FIG01228484 FIG01228493: hypothetical protein +FIG01228496 response regulator aspartate phosphatase +FIG01228497 FIG01228498: hypothetical protein +FIG01228498 FIG01228499: hypothetical protein +FIG01228499 FIG01228501: hypothetical protein +FIG01228501 FIG01228502: hypothetical protein +FIG01228504 FIG01228506: hypothetical protein +FIG01228507 FIG01228510: hypothetical protein +FIG01228513 FIG01228514: hypothetical protein +FIG01228517 unknown +FIG01228522 YozN +FIG01228525 FIG01228527: hypothetical protein +FIG01228527 FIG01228529: hypothetical protein +FIG01228531 FIG01228532: hypothetical protein +FIG01228532 FIG01228533: hypothetical protein +FIG01228533 FIG01228534: hypothetical protein +FIG01228534 Uncharacterized HTH-type transcriptional regulator ydhC +FIG01228535 FIG01228536: hypothetical protein +FIG01228538 FIG01228541: hypothetical protein +FIG01228542 FIG01228543: hypothetical protein +FIG01228545 FIG01228546: hypothetical protein +FIG01228546 TOMM biosynthesis methyltransferase +FIG01228548 FIG01228550: hypothetical protein +FIG01228550 possible Zn-dependent hydrolase, beta-lactamase superfamily +FIG01228554 FIG01228556: hypothetical protein +FIG01228556 FIG01228558: hypothetical protein +FIG01228558 peptidase, M23/M37 family protein +FIG01228559 FIG01228561: hypothetical protein +FIG01228563 FIG01228564: hypothetical protein +FIG01228566 FIG01228568: hypothetical protein +FIG01228568 FIG01228570: hypothetical protein +FIG01228570 FIG01228571: hypothetical protein +FIG01228571 FIG01228574: hypothetical protein +FIG01228575 FIG01228576: hypothetical protein +FIG01228576 FIG01228577: hypothetical protein +FIG01228577 FIG01228580: hypothetical protein +FIG01228580 FIG01228581: hypothetical protein +FIG01228581 bacteriocin ABC transporter, permease protein subunit, putative +FIG01228582 FIG01228583: hypothetical protein +FIG01228583 FIG01228584: hypothetical protein +FIG01228585 FIG01228587: hypothetical protein +FIG01228589 FIG01228590: hypothetical protein +FIG01228593 FIG01228594: hypothetical protein +FIG01228595 POLY(A) POLYMERASE / TRNA NUCLEOTIDYLTRANSFERASE( EC:2.7.7.19,EC:2.7.7.25 ) +FIG01228596 FIG01228597: hypothetical protein +FIG01228597 FIG01228598: hypothetical protein +FIG01228599 FIG01228601: hypothetical protein +FIG01228609 FIG01228610: hypothetical protein +FIG01228610 O-acetyl transferase (EC 2.3.1.-) +FIG01228611 FIG01228614: hypothetical protein +FIG01228614 FIG01228615: hypothetical protein +FIG01228615 FIG01228617: hypothetical protein +FIG01228617 FIG01228620: hypothetical protein +FIG01228620 MutT/Nudix family protein (EC 3.6.1.-) +FIG01228621 FIG01228622: hypothetical protein +FIG01228624 YmaC +FIG01228625 FIG01228626: hypothetical protein +FIG01228626 YxeG +FIG01228627 FIG01228629: hypothetical protein +FIG01228629 FIG01228630: hypothetical protein +FIG01228630 FIG01228631: hypothetical protein +FIG01228631 Lipase +FIG01228633 FIG01228634: hypothetical protein +FIG01228634 FIG01228636: hypothetical protein +FIG01228636 FIG01228638: hypothetical protein +FIG01228638 FIG01228641: hypothetical protein +FIG01228641 FIG01228642: hypothetical protein +FIG01228643 FIG01228644: hypothetical protein +FIG01228644 FIG01228645: hypothetical protein +FIG01228648 Glyoxalase domain protein +FIG01228649 FIG01228650: hypothetical protein +FIG01228650 hypothetical protein +FIG01228652 Putative drug efflux protein +FIG01228654 FIG01228655: hypothetical protein +FIG01228655 FIG01228660: hypothetical protein +FIG01228669 FIG01228671: hypothetical protein +FIG01228675 FIG01228677: hypothetical protein +FIG01228678 CbiN domain protein +FIG01228681 FIG01228682: hypothetical protein +FIG01228687 FIG01228690: hypothetical protein +FIG01228690 Wall-associated protein precursor +FIG01228696 FIG01228697: hypothetical protein +FIG01228697 FIG01228698: hypothetical protein +FIG01228698 FIG01228700: hypothetical protein +FIG01228700 FIG01228701: hypothetical protein +FIG01228701 FIG01228703: hypothetical protein +FIG01228703 FIG01228704: hypothetical protein +FIG01228706 FIG01228707: hypothetical protein +FIG01228707 YqjY +FIG01228711 FIG01228712: hypothetical protein +FIG01228712 hypothetical protein +FIG01228716 FIG01228717: hypothetical protein +FIG01228719 FIG01228721: hypothetical protein +FIG01228721 FIG01228723: hypothetical protein +FIG01228723 FIG01228724: hypothetical protein +FIG01228724 FIG01228725: hypothetical protein +FIG01228725 FIG01228726: hypothetical protein +FIG01228726 alternate gene name: jofB +FIG01228729 FIG01228731: hypothetical protein +FIG01228733 pXO1-82 +FIG01228739 FIG01228740: hypothetical protein +FIG01228741 FIG01228742: hypothetical protein +FIG01228742 Probable transcriptional regulator +FIG01228743 FIG01228744: hypothetical protein +FIG01228744 sporulation kinase +FIG01228752 FIG01228753: hypothetical protein +FIG01228754 FIG01228757: hypothetical protein +FIG01228761 FIG01228762: hypothetical protein +FIG01228762 FIG01228763: hypothetical protein +FIG01228769 ABC-2 type transport system permease protein YvfS +FIG01228771 FIG01228772: hypothetical protein +FIG01228775 FIG01228778: hypothetical protein +FIG01228779 alternate gene name: ykaC lethal when synthesized during vegetative growth in the absence of SpoIISB +FIG01228782 FIG01228784: hypothetical protein +FIG01228784 Uncharacterized protein yfhE +FIG01228786 Spore coat polysaccharide biosynthesis protein SpsF +FIG01228793 FIG01228794: hypothetical protein +FIG01228798 FIG01228800: hypothetical protein +FIG01228800 transcriptional activator of comK gene +FIG01228805 FIG01228806: hypothetical protein +FIG01228806 FIG01228807: hypothetical protein +FIG01228807 Phage DNA packaging protein +FIG01228808 FIG01228809: hypothetical protein +FIG01228816 FIG01228817: hypothetical protein +FIG01228822 FIG01228823: hypothetical protein +FIG01228823 FIG01228824: hypothetical protein +FIG01228824 FIG01228825: hypothetical protein +FIG01228825 FIG01228826: hypothetical protein +FIG01228826 FIG01228827: hypothetical protein +FIG01228831 YhdK +FIG01228833 FIG01228834: hypothetical protein +FIG01228834 FIG01228837: hypothetical protein +FIG01228839 FIG01228840: hypothetical protein +FIG01228840 archaeosine tRNA-ribosyltransferase (EC 2.4.2.-) type 2 short +FIG01228841 FIG01228842: hypothetical protein +FIG01228842 YwoH +FIG01228843 FIG01228845: hypothetical protein +FIG01228845 FIG01228846: hypothetical protein +FIG01228853 FIG01228854: hypothetical protein +FIG01228857 FIG01228860: hypothetical protein +FIG01228860 FIG01228864: hypothetical protein +FIG01228865 FIG01228866: hypothetical protein +FIG01228867 FIG01228869: hypothetical protein +FIG01228869 FIG01228870: hypothetical protein +FIG01228871 FIG01228872: hypothetical protein +FIG01228876 FIG01228877: hypothetical protein +FIG01228877 FIG01228878: hypothetical protein +FIG01228879 FIG01228880: hypothetical protein +FIG01228880 FIG01228881: hypothetical protein +FIG01228881 Capsular polysaccharide biosynthsis protein +FIG01228882 hypothetical protein +FIG01228883 FIG01228884: hypothetical protein +FIG01228886 FIG01228887: hypothetical protein +FIG01228900 FIG01228901: hypothetical protein +FIG01228903 conserved hypothetical protein protein +FIG01228905 FIG01228906: hypothetical protein +FIG01228906 FIG01228908: hypothetical protein +FIG01228908 FIG01228909: hypothetical protein +FIG01228909 amino acid permease +FIG01228914 YocB +FIG01228917 Two component system histidine kinase( EC:2.7.3.- ) +FIG01228918 ErfK/YbiS/YcfS/YnhG family protein +FIG01228919 FIG01228921: hypothetical protein +FIG01228921 FIG01228922: hypothetical protein +FIG01228923 FIG01228924: hypothetical protein +FIG01228926 Mannosyl transferase +FIG01228927 FIG01228929: hypothetical protein +FIG01228929 Transcriptional regulator domain protein +FIG01228931 FIG01228933: hypothetical protein +FIG01228933 FIG01228934: hypothetical protein +FIG01228935 FIG01228937: hypothetical protein +FIG01228938 FIG01228939: hypothetical protein +FIG01228939 FIG01228942: hypothetical protein +FIG01228942 FIG01228946: hypothetical protein +FIG01228946 possible ribosomal protein S1 fragment +FIG01228947 FIG01228950: hypothetical protein +FIG01228950 FIG01228951: hypothetical protein +FIG01228951 FIG01228952: hypothetical protein +FIG01228952 FIG01228953: hypothetical protein +FIG01228955 FIG01228956: hypothetical protein +FIG01228956 polysaccharide deacetylase +FIG01228960 Glyoxalase, Glyoxalase/Bleomycin resistance protein/Dioxygenase superfamily +FIG01228962 FIG01228965: hypothetical protein +FIG01228967 FIG01228969: hypothetical protein +FIG01228969 FIG01228971: hypothetical protein +FIG01228973 FIG01228974: hypothetical protein +FIG01228974 FIG01228976: hypothetical protein +FIG01228976 FIG01228977: hypothetical protein +FIG01228977 FIG01228981: hypothetical protein +FIG01228981 FIG01228982: hypothetical protein +FIG01228982 YngL +FIG01228985 S-layer protein +FIG01228987 protein of unknown function DUF201 +FIG01228988 Glycosyl transferase Family 1 +FIG01228990 FIG01228992: hypothetical protein +FIG01228992 FIG01228993: hypothetical protein +FIG01228993 FIG01228994: hypothetical protein +FIG01228994 FIG01228995: hypothetical protein +FIG01228996 FIG01228997: hypothetical protein +FIG01228998 FIG01228999: hypothetical protein +FIG01228999 FIG01229000: hypothetical protein +FIG01229000 FIG01229002: hypothetical protein +FIG01229003 FIG01229004: hypothetical protein +FIG01229004 LemA domain protein +FIG01229006 FIG01229009: hypothetical protein +FIG01229009 FIG01229010: hypothetical protein +FIG01229010 FIG01229011: hypothetical protein +FIG01229013 FIG01229014: hypothetical protein +FIG01229014 transition state transcriptional regulatory protein +FIG01229015 lacX protein, putative +FIG01229016 FIG01229017: hypothetical protein +FIG01229019 YrzK +FIG01229020 FIG01229021: hypothetical protein +FIG01229022 FIG01229023: hypothetical protein +FIG01229025 FIG01229026: hypothetical protein +FIG01229028 FIG01229029: hypothetical protein +FIG01229029 FIG01229031: hypothetical protein +FIG01229034 FIG01229035: hypothetical protein +FIG01229035 camphor resistance protein CrcB +FIG01229039 Hbl B protein +FIG01229042 FIG01229044: hypothetical protein +FIG01229045 FIG01229047: hypothetical protein +FIG01229053 FIG01229054: hypothetical protein +FIG01229055 FIG01229056: hypothetical protein +FIG01229056 FIG01229057: hypothetical protein +FIG01229057 FIG01229059: hypothetical protein +FIG01229059 putative chemotaxis sensory transducer +FIG01229062 FIG01229064: hypothetical protein +FIG01229064 FIG01229065: hypothetical protein +FIG01229067 FIG01229070: hypothetical protein +FIG01229070 FIG01229072: hypothetical protein +FIG01229072 FIG01229074: hypothetical protein +FIG01229074 FIG01229075: hypothetical protein +FIG01229075 FIG01229076: hypothetical protein +FIG01229079 FIG01229080: hypothetical protein +FIG01229080 FIG01229084: hypothetical protein +FIG01229089 FIG01229090: hypothetical protein +FIG01229090 FIG01229091: hypothetical protein +FIG01229091 FIG01229092: hypothetical protein +FIG01229092 FIG01229094: hypothetical protein +FIG01229095 FIG01229097: hypothetical protein +FIG01229101 gp14 -like protein +FIG01229105 FIG01229107: hypothetical protein +FIG01229109 FIG01229110: hypothetical protein +FIG01229110 FIG01229114: hypothetical protein +FIG01229124 FIG01229125: hypothetical protein +FIG01229125 FIG01229128: hypothetical protein +FIG01229129 FIG01229131: hypothetical protein +FIG01229133 FIG01229135: hypothetical protein +FIG01229135 FIG01229136: hypothetical protein +FIG01229138 FIG01229140: hypothetical protein +FIG01229142 FIG01229143: hypothetical protein +FIG01229145 FIG01229146: hypothetical protein +FIG01229147 FIG01229148: hypothetical protein +FIG01229154 FIG01229155: hypothetical protein +FIG01229156 FIG01229157: hypothetical protein +FIG01229157 FIG01229158: hypothetical protein +FIG01229158 FIG01229159: hypothetical protein +FIG01229159 FIG01229160: hypothetical protein +FIG01229164 FIG01229165: hypothetical protein +FIG01229165 methyl-accepting/DNA response regulator, putative +FIG01229167 FIG01229168: hypothetical protein +FIG01229168 FIG01229169: hypothetical protein +FIG01229169 FIG01229170: hypothetical protein +FIG01229171 FIG01229174: hypothetical protein +FIG01229174 FIG01229175: hypothetical protein +FIG01229175 possible carbamoyl-phosphate synthase large chain +FIG01229177 GGDEF family protein +FIG01229178 FIG01229179: hypothetical protein +FIG01229181 FIG01229182: hypothetical protein +FIG01229183 FIG01229184: hypothetical protein +FIG01229185 Prolyl oligopeptidase family (Peptidase_S9) (EC 3.4.21.26) +FIG01229186 FIG01229188: hypothetical protein +FIG01229188 FIG01229189: hypothetical protein +FIG01229189 FIG01229191: hypothetical protein +FIG01229191 FIG01229193: hypothetical protein +FIG01229202 FIG01229203: hypothetical protein +FIG01229211 FIG01229212: hypothetical protein +FIG01229212 negative regulation of sporulation, septation and degradative enzyme genes (aprE, nprE, phoA, sacB) +FIG01229216 COG0119: Isopropylmalate/homocitrate/citramalate synthases +FIG01229217 Helix-turn-helix, AraC type +FIG01229219 FIG01229225: hypothetical protein +FIG01229227 FIG01229229: hypothetical protein +FIG01229231 RNA polymerase sigma factor, ECF subfamily, putative +FIG01229237 FIG01229239: hypothetical protein +FIG01229239 Phage-like element PBSX protein xkdA +FIG01229242 FIG01229245: hypothetical protein +FIG01229245 FIG01229246: hypothetical protein +FIG01229246 FIG01229247: hypothetical protein +FIG01229247 FIG01229248: hypothetical protein +FIG01229248 hypothetical protein +FIG01229256 FIG01229257: hypothetical protein +FIG01229258 Non-ribosomal peptide synthase (EC 6.3.2.26) (EC 2.3.1.38) +FIG01229262 FIG01229264: hypothetical protein +FIG01229264 FIG01229265: hypothetical protein +FIG01229265 FIG01229266: hypothetical protein +FIG01229266 FIG01229267: hypothetical protein +FIG01229267 FIG01229270: hypothetical protein +FIG01229270 FIG01229271: hypothetical protein +FIG01229272 FIG01229273: hypothetical protein +FIG01229273 FIG01229274: hypothetical protein +FIG01229280 FIG01229284: hypothetical protein +FIG01229288 FIG01229291: hypothetical protein +FIG01229291 FIG01229292: hypothetical protein +FIG01229292 FIG01229293: hypothetical protein +FIG01229293 FIG01229295: hypothetical protein +FIG01229295 FIG01229297: hypothetical protein +FIG01229297 hypothetical protein +FIG01229298 Uncharacterized protein ygaN +FIG01229299 hypothetical protein +FIG01229303 FIG01229307: hypothetical protein +FIG01229319 FIG01229320: hypothetical protein +FIG01229320 FIG01229323: hypothetical protein +FIG01229323 FIG01229324: hypothetical protein +FIG01229330 FIG01229331: hypothetical protein +FIG01229331 FIG01229332: hypothetical protein +FIG01229332 FIG01229333: hypothetical protein +FIG01229337 FIG01229340: hypothetical protein +FIG01229340 FIG01229343: hypothetical protein +FIG01229343 FIG01229346: hypothetical protein +FIG01229346 FIG01229347: hypothetical protein +FIG01229352 FIG01229354: hypothetical protein +FIG01229354 FIG01229355: hypothetical protein +FIG01229355 FIG01229356: hypothetical protein +FIG01229356 FIG01229357: hypothetical protein +FIG01229359 FIG01229360: hypothetical protein +FIG01229362 FIG01229364: hypothetical protein +FIG01229364 FIG01229365: hypothetical protein +FIG01229366 Exoenzymes regulatory protein aepA +FIG01229367 nicotinate phosphoribosyltransferase( EC:2.4.2.11 ) +FIG01229369 FIG01229371: hypothetical protein +FIG01229375 FIG01229376: hypothetical protein +FIG01229376 FIG01229378: hypothetical protein +FIG01229378 pXO1-52 +FIG01229379 FIG01229380: hypothetical protein +FIG01229380 FIG01229381: hypothetical protein +FIG01229381 FIG01229382: hypothetical protein +FIG01229385 FIG01229387: hypothetical protein +FIG01229387 YptA +FIG01229390 FIG01229392: hypothetical protein +FIG01229392 FIG01229393: hypothetical protein +FIG01229395 FIG01229396: hypothetical protein +FIG01229398 FIG01229399: hypothetical protein +FIG01229399 FIG01229401: hypothetical protein +FIG01229404 Phosphohydrolase (MutT/nudix family protein) +FIG01229409 FIG01229410: hypothetical protein +FIG01229410 Antilisterial bacteriocin subtilosin biosynthesis protein albG +FIG01229412 FIG01229413: hypothetical protein +FIG01229414 Structural feature(s) predicted by Psort:Transmembrane: 2677659 - 2677643 +FIG01229417 FIG01229418: hypothetical protein +FIG01229418 FIG01229419: hypothetical protein +FIG01229420 FIG01229422: hypothetical protein +FIG01229423 FIG01229424: hypothetical protein +FIG01229424 pXO1-30 +FIG01229426 FIG01229427: hypothetical protein +FIG01229429 FIG01229430: hypothetical protein +FIG01229430 FIG01229431: hypothetical protein +FIG01229431 FIG01229432: hypothetical protein +FIG01229432 FIG01229433: hypothetical protein +FIG01229438 FIG01229439: hypothetical protein +FIG01229439 FIG01229443: hypothetical protein +FIG01229443 FIG01229452: hypothetical protein +FIG01229452 glycosyl transferase, group 2 family protein, putative +FIG01229454 FIG01229455: hypothetical protein +FIG01229455 FIG01229456: hypothetical protein +FIG01229456 FIG01229458: hypothetical protein +FIG01229458 IG hypothetical 17967 +FIG01229461 CsbD +FIG01229468 CpsH domain protein +FIG01229469 FIG01229470: hypothetical protein +FIG01229470 Endo/excinuclease amino terminal domain protein +FIG01229472 FIG01229473: hypothetical protein +FIG01229473 FIG01229475: hypothetical protein +FIG01229475 FIG01229476: hypothetical protein +FIG01229476 Uncharacterized protein yczF precursor +FIG01229481 FIG01229484: hypothetical protein +FIG01229485 Uncharacterized glycosyltransferase yqgM (EC 2.-.-.-) +FIG01229486 FIG01229487: hypothetical protein +FIG01229491 FIG01229492: hypothetical protein +FIG01229492 probable galactosyl transferase +FIG01229498 FIG01229499: hypothetical protein +FIG01229502 FIG01229503: hypothetical protein +FIG01229503 FIG01229506: hypothetical protein +FIG01229506 BclA protein +FIG01229507 FIG01229509: hypothetical protein +FIG01229509 FIG01229512: hypothetical protein +FIG01229512 FIG01229513: hypothetical protein +FIG01229514 Sensor protein resE( EC:2.7.3.- ) +FIG01229518 UDP-2-acetamido-2,6-dideoxy-hexulose 4-reductase +FIG01229524 spore maturation protein +FIG01229527 FIG01229529: hypothetical protein +FIG01229529 FIG01229531: hypothetical protein +FIG01229536 FIG01229538: hypothetical protein +FIG01229538 FIG01229539: hypothetical protein +FIG01229539 FIG01229541: hypothetical protein +FIG01229541 FIG01229542: hypothetical protein +FIG01229542 FIG01229543: hypothetical protein +FIG01229547 Sporulation kinase( EC:2.7.3.- ) +FIG01229548 Quercetin 2,3-dioxygenase (EC 1.13.11.24) +FIG01229554 FIG01229563: hypothetical protein +FIG01229564 FIG01229566: hypothetical protein +FIG01229572 FIG01229573: hypothetical protein +FIG01229583 conserved hypothetical protein, truncation +FIG01229585 Uncharacterized protein ybcH +FIG01229586 Transcriptional regulator, XRE family +FIG01229588 MutT/Nudix family protein( EC:3.6.1.13 ) +FIG01229592 FIG01229594: hypothetical protein +FIG01229596 FIG01229598: hypothetical protein +FIG01229598 FIG01229599: hypothetical protein +FIG01229602 FIG01229603: hypothetical protein +FIG01229603 FIG01229605: hypothetical protein +FIG01229606 FIG01229608: hypothetical protein +FIG01229608 FIG01229610: hypothetical protein +FIG01229610 Uncharacterized protein ycnL +FIG01229616 FIG01229617: hypothetical protein +FIG01229617 FIG01229618: hypothetical protein +FIG01229619 FIG01229620: hypothetical protein +FIG01229620 FIG01229621: hypothetical protein +FIG01229623 FIG01229624: hypothetical protein +FIG01229624 FIG01229625: hypothetical protein +FIG01229625 Two-component protein Kinase +FIG01229627 FIG01229628: hypothetical protein +FIG01229628 hypothetical protein +FIG01229633 FIG01229634: hypothetical protein +FIG01229634 FIG01229635: hypothetical protein +FIG01229639 FIG01229641: hypothetical protein +FIG01229646 FIG01229647: hypothetical protein +FIG01229647 FIG01229648: hypothetical protein +FIG01229648 Response regulator of salavaricin regulon +FIG01229649 putative transcriptional regulator YfiV +FIG01229663 FIG01229664: hypothetical protein +FIG01229664 FIG01229668: hypothetical protein +FIG01229668 FIG01229669: hypothetical protein +FIG01229669 FIG01229671: hypothetical protein +FIG01229671 FIG01229672: hypothetical protein +FIG01229672 FIG01229673: hypothetical protein +FIG01229676 FIG01229677: hypothetical protein +FIG01229680 FIG01229681: hypothetical protein +FIG01229681 FIG01229682: hypothetical protein +FIG01229682 FIG01229686: hypothetical protein +FIG01229690 Kip operon repressor, IclR family +FIG01229691 FIG01229692: hypothetical protein +FIG01229697 FIG01229698: hypothetical protein +FIG01229698 FIG01229700: hypothetical protein +FIG01229708 FIG01229709: hypothetical protein +FIG01229709 FIG01229711: hypothetical protein +FIG01229716 FIG01229717: hypothetical protein +FIG01229717 FIG01229719: hypothetical protein +FIG01229719 FIG01229721: hypothetical protein +FIG01229721 FIG01229722: hypothetical protein +FIG01229727 Alanine-anticapsin ligase BacD +FIG01229728 FIG01229729: hypothetical protein +FIG01229732 FIG01229733: hypothetical protein +FIG01229737 sir2, Catalytic domain of the SIR2 like Histonde deacetylases and ADP ribosyl transferase +FIG01229738 Putative phage-related DNA binding protein +FIG01229744 FIG01229745: hypothetical protein +FIG01229745 conserved hypothetical protein, possible glycosyl transferase +FIG01229747 FIG01229748: hypothetical protein +FIG01229748 FIG01229749: hypothetical protein +FIG01229749 Possible response regulator aspartate phosphatase +FIG01229761 FIG01229766: hypothetical protein +FIG01229767 FIG01229768: hypothetical protein +FIG01229768 FIG01229769: hypothetical protein +FIG01229769 FIG01252839: hypothetical protein +FIG01229771 FIG01229773: hypothetical protein +FIG01229776 FIG01229777: hypothetical protein +FIG01229778 FIG01229779: hypothetical protein +FIG01229783 FIG01229786: hypothetical protein +FIG01229787 FIG01229791: hypothetical protein +FIG01229793 FIG01229794: hypothetical protein +FIG01229794 portion of orf between proU operon and 181 operon +FIG01229796 Zwittermicin A resistance protein ZmaR +FIG01229803 FIG01229805: hypothetical protein +FIG01229806 FIG01229808: hypothetical protein +FIG01229808 FIG01229810: hypothetical protein +FIG01229811 Lanthionine biosynthesis protein LanM +FIG01229814 FIG01229815: hypothetical protein +FIG01229819 FIG01229823: hypothetical protein +FIG01229823 FIG01229827: hypothetical protein +FIG01229831 multidrug ABC transporter, ATP-binding protein +FIG01229838 Transcriptional regulator, ArsR family protein +FIG01229839 FIG01229841: hypothetical protein +FIG01229841 Acetyltransferase, GNAT family (EC 2.3.1.-) +FIG01229843 Phage integrase family protein +FIG01229847 FIG01229848: hypothetical protein +FIG01229848 FIG01229849: hypothetical protein +FIG01229849 FIG01229850: hypothetical protein +FIG01229857 FIG01229858: hypothetical protein +FIG01229858 FIG01229859: hypothetical protein +FIG01229859 glycosyl transferase, putative +FIG01229870 FIG01229871: hypothetical protein +FIG01229871 FIG01229872: hypothetical protein +FIG01229874 FIG01229877: hypothetical protein +FIG01229877 FIG01229878: hypothetical protein +FIG01229878 FIG01229881: hypothetical protein +FIG01229882 FIG01229883: hypothetical protein +FIG01229887 FIG01229888: hypothetical protein +FIG01229888 Ribosomal-protein-serine acetyltransferase +FIG01229893 FIG01229894: hypothetical protein +FIG01229900 FIG01229902: hypothetical protein +FIG01229903 FIG01229905: hypothetical protein +FIG01229907 Nin +FIG01229908 FIG01229909: hypothetical protein +FIG01229909 FIG01229910: hypothetical protein +FIG01229912 FIG01229916: hypothetical protein +FIG01229916 FIG01229919: hypothetical protein +FIG01229919 FIG01229921: hypothetical protein +FIG01229925 YwiB +FIG01229934 FIG01229935: hypothetical protein +FIG01229935 FIG01229938: hypothetical protein +FIG01229940 FIG01229942: hypothetical protein +FIG01229942 FIG01229943: hypothetical protein +FIG01229949 FIG01229950: hypothetical protein +FIG01229960 FIG01229961: hypothetical protein +FIG01229962 hypothetical protein +FIG01229967 FIG01229968: hypothetical protein +FIG01229968 FIG01229969: hypothetical protein +FIG01229969 FIG01229971: hypothetical protein +FIG01229971 probable transport ATP-binding protein +FIG01229974 hypothetical protein +FIG01229976 FIG01229982: hypothetical protein +FIG01229982 FIG01229987: hypothetical protein +FIG01229988 FIG01229989: hypothetical protein +FIG01229993 FIG01229995: hypothetical protein +FIG01230002 FIG01230003: hypothetical protein +FIG01230003 Macrolide glycosyltransferase (EC 2.4.1.-) +FIG01230004 FIG01230005: hypothetical protein +FIG01230005 FIG01230007: hypothetical protein +FIG01230011 FIG01230012: hypothetical protein +FIG01230015 FIG01230017: hypothetical protein +FIG01230017 FIG01230020: hypothetical protein +FIG01230020 FIG01230022: hypothetical protein +FIG01230023 FIG01230024: hypothetical protein +FIG01230024 FIG01230026: hypothetical protein +FIG01230033 FIG01230034: hypothetical protein +FIG01230034 Molybdenum cofactor biosynthesis protein D; Molybdopterin converting factor subunit 1 +FIG01230035 FIG01230036: hypothetical protein +FIG01230036 FIG01230039: hypothetical protein +FIG01230047 FIG01230049: hypothetical protein +FIG01230050 FIG01230052: hypothetical protein +FIG01230052 Helix-turn-helix domain protein +FIG01230054 FIG01230056: hypothetical protein +FIG01230059 FIG01230062: hypothetical protein +FIG01230064 FIG01230066: hypothetical protein +FIG01230067 FIG01230070: hypothetical protein +FIG01230070 DNA integration/recombination/inversion protein +FIG01230071 FIG01230073: hypothetical protein +FIG01230073 FIG01230074: hypothetical protein +FIG01230074 FIG01230077: hypothetical protein +FIG01230077 FIG01230078: hypothetical protein +FIG01230078 FIG01230080: hypothetical protein +FIG01230080 FIG01230082: hypothetical protein +FIG01230085 FIG01230092: hypothetical protein +FIG01230092 FIG01230095: hypothetical protein +FIG01230097 FIG01230098: hypothetical protein +FIG01230101 BH2053 unknown conserved protein in B. subtilis +FIG01230105 FIG01230106: hypothetical protein +FIG01230108 FIG01230109: hypothetical protein +FIG01230111 FIG01230112: hypothetical protein +FIG01230112 metalloendopeptidase-like membrane protein +FIG01230118 FIG01230120: hypothetical protein +FIG01230125 FIG01230126: hypothetical protein +FIG01230136 Possible uridine kinase (EC 2.7.1.48) +FIG01230137 FIG01230138: hypothetical protein +FIG01230138 competence protein FB +FIG01230140 FIG01230142: hypothetical protein +FIG01230154 FIG01230157: hypothetical protein +FIG01230157 FIG01230158: hypothetical protein +FIG01230163 FIG01230164: hypothetical protein +FIG01230164 FIG01230165: hypothetical protein +FIG01230165 FIG01230169: hypothetical protein +FIG01230169 FIG01230170: hypothetical protein +FIG01230171 Probable beta-glycosyltransferase +FIG01230172 conserved hypothetical protein YbdO +FIG01230175 FIG01230181: hypothetical protein +FIG01230181 FIG01230182: hypothetical protein +FIG01230186 FIG01238535: hypothetical protein +FIG01230187 FIG01230188: hypothetical protein +FIG01230188 FIG01230191: hypothetical protein +FIG01230192 FIG01230194: hypothetical protein +FIG01230194 FIG01230195: hypothetical protein +FIG01230195 FIG01230197: hypothetical protein +FIG01230199 Phage repressor protein +FIG01230206 FIG01230207: hypothetical protein +FIG01230207 FIG01230208: hypothetical protein +FIG01230209 FIG01230215: hypothetical protein +FIG01230216 FIG01230218: hypothetical protein +FIG01230218 FIG01230219: hypothetical protein +FIG01230225 Probable amino-acid ABC transporter permease protein yckA +FIG01230233 FIG01230236: hypothetical protein +FIG01230236 FIG01230237: hypothetical protein +FIG01230237 FIG01230238: hypothetical protein +FIG01230238 FIG01230239: hypothetical protein +FIG01230244 FIG01230249: hypothetical protein +FIG01230249 Uncharacterized HTH-type transcriptional regulator yyaN +FIG01230253 FIG01230254: hypothetical protein +FIG01230260 FIG01230264: hypothetical protein +FIG01230266 FIG01230267: hypothetical protein +FIG01230268 FIG01230269: hypothetical protein +FIG01230269 FIG01230270: hypothetical protein +FIG01230273 ATP-grasp enzyme-like +FIG01230274 FIG01230275: hypothetical protein +FIG01230281 FIG01230282: hypothetical protein +FIG01230283 FIG01230286: hypothetical protein +FIG01230288 FIG01230289: hypothetical protein +FIG01230289 FIG01230291: hypothetical protein +FIG01230291 FIG01230293: hypothetical protein +FIG01230293 FIG01230294: hypothetical protein +FIG01230295 Phosphoesterase, PA-phosphatase related +FIG01230305 FIG01230307: hypothetical protein +FIG01230308 FIG01230312: hypothetical protein +FIG01230312 YvrI +FIG01230314 FIG01230315: hypothetical protein +FIG01230315 Uncharacterized protein yqeB +FIG01230317 methyl-accepting chemotaxis protein +FIG01230318 FIG01230320: hypothetical protein +FIG01230321 FIG01230322: hypothetical protein +FIG01230322 FIG01230323: hypothetical protein +FIG01230323 FIG01230325: hypothetical protein +FIG01230326 cgeb protein +FIG01230327 FIG01230329: hypothetical protein +FIG01230331 YhbI +FIG01230333 FIG01230334: hypothetical protein +FIG01230334 FIG01230335: hypothetical protein +FIG01230335 FIG01230336: hypothetical protein +FIG01230337 putative transcriptional regulatory protein, LysR family +FIG01230339 phage terminase, small subunit +FIG01230340 FIG01230341: hypothetical protein +FIG01230341 FIG01230342: hypothetical protein +FIG01230342 FIG01230345: hypothetical protein +FIG01230346 FIG01230350: hypothetical protein +FIG01230351 FIG01230352: hypothetical protein +FIG01230353 FIG01230354: hypothetical protein +FIG01230356 FIG01230357: hypothetical protein +FIG01230359 FIG01230360: hypothetical protein +FIG01230360 Phage-related integrase/recombinase +FIG01230362 FIG01230364: hypothetical protein +FIG01230364 FIG01230365: hypothetical protein +FIG01230365 possible permease; possible MrsE protein +FIG01230373 FIG01230374: hypothetical protein +FIG01230374 Cytochrome P450 152A1 (EC 1.14.-.-) +FIG01230378 FIG01230381: hypothetical protein +FIG01230383 FIG01230387: hypothetical protein +FIG01230389 FIG01230391: hypothetical protein +FIG01230391 FIG01230393: hypothetical protein +FIG01230393 Cystine-binding periplasmic protein precursor +FIG01230394 FIG01230397: hypothetical protein +FIG01230399 FIG01230401: hypothetical protein +FIG01230401 FIG01230406: hypothetical protein +FIG01230406 FIG01230408: hypothetical protein +FIG01230413 FIG01230415: hypothetical protein +FIG01230415 Transposon Tn7 transposition protein tnsB +FIG01230417 Thioredoxin, phage-associated +FIG01230424 FIG01230428: hypothetical protein +FIG01230428 FIG01230430: hypothetical protein +FIG01230432 FIG01230435: hypothetical protein +FIG01230436 FIG01230437: hypothetical protein +FIG01230438 FIG01230440: hypothetical protein +FIG01230440 FIG01230442: hypothetical protein +FIG01230443 FIG01230444: hypothetical protein +FIG01230444 FIG01230446: hypothetical protein +FIG01230446 FIG01230448: hypothetical protein +FIG01230450 FIG01230453: hypothetical protein +FIG01230453 FIG01230458: hypothetical protein +FIG01230460 Palmitoyl-CoA hydrolase precursor (EC 3.1.2.2) +FIG01230468 FIG01230469: hypothetical protein +FIG01230469 membrane protein, putative, (pXO1-60) +FIG01230470 FIG01230472: hypothetical protein +FIG01230472 FIG01230473: hypothetical protein +FIG01230473 FIG01230474: hypothetical protein +FIG01230474 FIG01230476: hypothetical protein +FIG01230476 FIG01230478: hypothetical protein +FIG01230478 DNA-3-methyladenine glycosylase II +FIG01230480 FIG01230484: hypothetical protein +FIG01230485 FIG01230486: hypothetical protein +FIG01230486 FIG01230487: hypothetical protein +FIG01230487 FIG01230494: hypothetical protein +FIG01230494 FIG01230496: hypothetical protein +FIG01230496 FIG01230497: hypothetical protein +FIG01230501 Bacilysin exporter protein BacE +FIG01230502 FIG01230504: hypothetical protein +FIG01230511 FIG01230514: hypothetical protein +FIG01230516 FIG01230520: hypothetical protein +FIG01230521 FIG01230524: hypothetical protein +FIG01230524 FIG01230525: hypothetical protein +FIG01230526 FIG01230527: hypothetical protein +FIG01230533 FIG01230534: hypothetical protein +FIG01230535 FIG01230539: hypothetical protein +FIG01230543 FIG01230544: hypothetical protein +FIG01230550 FIG01230551: hypothetical protein +FIG01230551 FIG01230552: hypothetical protein +FIG01230552 FIG01230553: hypothetical protein +FIG01230560 FIG01230561: hypothetical protein +FIG01230561 FIG01230564: hypothetical protein +FIG01230564 FIG01230566: hypothetical protein +FIG01230566 FIG01230567: hypothetical protein +FIG01230567 FIG01230568: hypothetical protein +FIG01230570 YQZC protein +FIG01230573 FIG00627453: hypothetical protein +FIG01230576 FIG01230578: hypothetical protein +FIG01230578 FIG01230579: hypothetical protein +FIG01230579 FIG01230581: hypothetical protein +FIG01230583 trkA domain protein +FIG01230587 FIG01230588: hypothetical protein +FIG01230590 family of unknown function (DUF450) family +FIG01230592 hypothetical protein +FIG01230594 protein gp15 +FIG01230601 FIG01230604: hypothetical protein +FIG01230607 FIG01230608: hypothetical protein +FIG01230608 FIG01230610: hypothetical protein +FIG01230615 FIG01230616: hypothetical protein +FIG01230617 FIG01230618: hypothetical protein +FIG01230619 FIG01230621: hypothetical protein +FIG01230621 FIG01230624: hypothetical protein +FIG01230625 FIG01230626: hypothetical protein +FIG01230627 FIG01230629: hypothetical protein +FIG01230635 FIG01230636: hypothetical protein +FIG01230638 FIG01230639: hypothetical protein +FIG01230642 FIG01230645: hypothetical protein +FIG01230646 FIG01230647: hypothetical protein +FIG01230647 Phage-like element PBSX protein xkdJ +FIG01230649 FIG01230651: hypothetical protein +FIG01230655 FIG01230656: hypothetical protein +FIG01230656 FIG01230657: hypothetical protein +FIG01230657 Exci_endo_N, Endo/excinuclease amino terminal domain +FIG01230664 YydK +FIG01230670 FIG01230671: hypothetical protein +FIG01230671 FIG01230674: hypothetical protein +FIG01230677 FIG01230678: hypothetical protein +FIG01230683 FIG01230684: hypothetical protein +FIG01230684 main capsid protein Gp34-like protein +FIG01230688 FIG01230689: hypothetical protein +FIG01230689 FIG01230690: hypothetical protein +FIG01230690 FIG01230694: hypothetical protein +FIG01230694 FIG01230696: hypothetical protein +FIG01230696 FIG01230700: hypothetical protein +FIG01230701 FIG01230703: hypothetical protein +FIG01230704 FIG00525014: hypothetical protein +FIG01230706 FIG01230707: hypothetical protein +FIG01230711 FIG01230714: hypothetical protein +FIG01230714 FIG01230716: hypothetical protein +FIG01230716 FIG01230717: hypothetical protein +FIG01230719 FIG01230720: hypothetical protein +FIG01230720 FIG01230721: hypothetical protein +FIG01230721 N-Acyltransferase superfamily / Uncharacterised protein family UPF0157 (COG2320) +FIG01230722 intracellular proteinase inhibitor +FIG01230727 FIG01230730: hypothetical protein +FIG01230730 FIG01230732: hypothetical protein +FIG01230733 FIG01241351: hypothetical protein +FIG01230735 Uncharacterized protein yxiK +FIG01230738 FIG01230740: hypothetical protein +FIG01230740 FIG01230744: hypothetical protein +FIG01230744 FIG01230746: hypothetical protein +FIG01230746 FIG01230747: hypothetical protein +FIG01230756 FIG01230757: hypothetical protein +FIG01230758 GABA permease +FIG01230762 FIG01230763: hypothetical protein +FIG01230765 FIG01230766: hypothetical protein +FIG01230766 ribosomal RNA adenine dimethylase domain protein +FIG01230769 serine alkaline protease (subtilisin E)( EC:3.4.21.62 ) +FIG01230771 FIG01230777: hypothetical protein +FIG01230777 FIG01230780: hypothetical protein +FIG01230784 FIG01230787: hypothetical protein +FIG01230787 FIG01230788: hypothetical protein +FIG01230790 FIG01230792: hypothetical protein +FIG01230792 FIG01230793: hypothetical protein +FIG01230795 FIG01230797: hypothetical protein +FIG01230799 FIG01230800: hypothetical protein +FIG01230801 FIG01230803: hypothetical protein +FIG01230804 FIG01230805: hypothetical protein +FIG01230805 FIG01230807: hypothetical protein +FIG01230812 FIG01230813: hypothetical protein +FIG01230813 FIG01230814: hypothetical protein +FIG01230814 LLAKR2I restriction enzyme +FIG01230817 CgeE +FIG01230818 Phage-like element PBSX protein xkdU +FIG01230819 FIG01230821: hypothetical protein +FIG01230824 FIG01230825: hypothetical protein +FIG01230825 FIG01230826: hypothetical protein +FIG01230826 FIG01230827: hypothetical protein +FIG01230830 FIG01230831: hypothetical protein +FIG01230833 FIG01230834: hypothetical protein +FIG01230834 FIG01230836: hypothetical protein +FIG01230836 Uncharacterized protein ydcT +FIG01230837 FIG01230840: hypothetical protein +FIG01230840 Hypothetical cytosolic protein +FIG01230846 FIG01230847: hypothetical protein +FIG01230847 FIG01230850: hypothetical protein +FIG01230850 FIG01230851: hypothetical protein +FIG01230851 Uncharacterized protein yheF +FIG01230852 FIG01230854: hypothetical protein +FIG01230854 FIG01230857: hypothetical protein +FIG01230857 FIG01230859: hypothetical protein +FIG01230859 FIG01230860: hypothetical protein +FIG01230860 hypothetical protein +FIG01230862 FIG01230863: hypothetical protein +FIG01230866 FIG01230868: hypothetical protein +FIG01230869 FIG01230870: hypothetical protein +FIG01230871 FIG01230872: hypothetical protein +FIG01230872 acetyl esterase, putative +FIG01230877 FIG01230879: hypothetical protein +FIG01230882 Protein involved in beta-1,3-glucan synthesis +FIG01230883 FIG01230887: hypothetical protein +FIG01230894 FIG01230895: hypothetical protein +FIG01230895 FIG01230898: hypothetical protein +FIG01230899 FIG01230901: hypothetical protein +FIG01230903 FIG01230905: hypothetical protein +FIG01230907 FIG01230909: hypothetical protein +FIG01230909 Cell wall-associated glycosyl hydrolase +FIG01230912 FIG01230914: hypothetical protein +FIG01230916 FIG01230918: hypothetical protein +FIG01230918 FIG01230920: hypothetical protein +FIG01230920 Protein csk22 +FIG01230927 FIG01230928: hypothetical protein +FIG01230928 FIG01230929: hypothetical protein +FIG01230929 hypothetical lambda repressor-like, DNA-binding +FIG01230931 FIG01230933: hypothetical protein +FIG01230939 dedA family protein +FIG01230940 FIG01230941: hypothetical protein +FIG01230941 FIG01230943: hypothetical protein +FIG01230943 FIG01230945: hypothetical protein +FIG01230948 FIG01230952: hypothetical protein +FIG01230952 FIG01230956: hypothetical protein +FIG01230956 FIG01230958: hypothetical protein +FIG01230958 IG hypothetical 15966 +FIG01230964 FIG01230965: hypothetical protein +FIG01230968 FIG01230969: hypothetical protein +FIG01230969 FIG01230970: hypothetical protein +FIG01230970 FIG01230971: hypothetical protein +FIG01230971 FIG01230972: hypothetical protein +FIG01230973 Flagellar biosynthesis +FIG01230976 FIG01230977: hypothetical protein +FIG01230977 C-125 initiation factor IF-I, RNA polymerase alpha subunit and ribosomal proteins, partial and complete cds +FIG01230980 FIG01230981: hypothetical protein +FIG01230981 FIG01230983: hypothetical protein +FIG01230985 FIG01230986: hypothetical protein +FIG01230986 FIG01230991: hypothetical protein +FIG01230991 FIG01230992: hypothetical protein +FIG01230992 FIG01230996: hypothetical protein +FIG01230999 FIG01231000: hypothetical protein +FIG01231002 FIG01231004: hypothetical protein +FIG01231004 DNA-binding response regulator VicR +FIG01231006 pXO1-83 +FIG01231009 FIG01231010: hypothetical protein +FIG01231010 FIG01231015: hypothetical protein +FIG01231021 FIG01231022: hypothetical protein +FIG01231025 FIG01231026: hypothetical protein +FIG01231027 FIG01231028: hypothetical protein +FIG01231028 Bona fide RidA/YjgF/TdcF/RutC subgroup +FIG01231032 FIG01231033: hypothetical protein +FIG01231033 FIG01231037: hypothetical protein +FIG01231037 FIG01231039: hypothetical protein +FIG01231039 FIG01231040: hypothetical protein +FIG01231040 FIG01231042: hypothetical protein +FIG01231046 FIG01231047: hypothetical protein +FIG01231047 hypothetical protein +FIG01231064 FIG01231065: hypothetical protein +FIG01231067 integrase-recombinase +FIG01231068 hypothetical protein +FIG01231070 FIG01231071: hypothetical protein +FIG01231071 FIG01231072: hypothetical protein +FIG01231072 FIG01231073: hypothetical protein +FIG01231073 FIG01231074: hypothetical protein +FIG01231086 FIG01231088: hypothetical protein +FIG01231089 FIG01231090: hypothetical protein +FIG01231090 FIG01231091: hypothetical protein +FIG01231091 FIG01231097: hypothetical protein +FIG01231101 FIG01231104: hypothetical protein +FIG01231104 hypothetical protein +FIG01231106 protein of unknown function UPF0187 +FIG01231108 FIG01231110: hypothetical protein +FIG01231110 Uncharacterized protein yrkO +FIG01231117 FIG01231118: hypothetical protein +FIG01231120 FIG01231121: hypothetical protein +FIG01231121 FIG01231123: hypothetical protein +FIG01231124 FIG01231125: hypothetical protein +FIG01231125 FIG01231130: hypothetical protein +FIG01231130 FIG01231132: hypothetical protein +FIG01231132 Uncharacterized protein ywmA +FIG01231135 YycN +FIG01231137 FIG01231138: hypothetical protein +FIG01231139 FIG01231140: hypothetical protein +FIG01231143 Uncharacterized protein yppD +FIG01231145 FIG01231146: hypothetical protein +FIG01231146 FIG01231147: hypothetical protein +FIG01231154 FIG01231157: hypothetical protein +FIG01231160 FIG01231165: hypothetical protein +FIG01231167 hypothetical protein +FIG01231168 FIG01231171: hypothetical protein +FIG01231176 FIG01231177: hypothetical protein +FIG01231177 FIG01231179: hypothetical protein +FIG01231181 FIG01231184: hypothetical protein +FIG01231184 FIG01231185: hypothetical protein +FIG01231191 FIG01231193: hypothetical protein +FIG01231198 FIG01231203: hypothetical protein +FIG01231203 FIG01231205: hypothetical protein +FIG01231211 FIG01231212: hypothetical protein +FIG01231212 FIG01231214: hypothetical protein +FIG01231214 FIG01231216: hypothetical protein +FIG01231216 FIG01231217: hypothetical protein +FIG01231218 FIG01231219: hypothetical protein +FIG01231219 FIG01231220: hypothetical protein +FIG01231233 FIG01231237: hypothetical protein +FIG01231237 FIG01231240: hypothetical protein +FIG01231244 FIG01231247: hypothetical protein +FIG01231250 FIG01231251: hypothetical protein +FIG01231251 FIG01231253: hypothetical protein +FIG01231256 hypothetical protein +FIG01231263 Phy( EC:3.1.3.8 ) +FIG01231272 Spermine/spermidine acetyltransferase (EC 2.3.1.57) +FIG01231277 FIG01231279: hypothetical protein +FIG01231279 FIG01231281: hypothetical protein +FIG01231281 Putative Heme biosynthesis related protein +FIG01231284 FIG01231286: hypothetical protein +FIG01231286 FIG01231287: hypothetical protein +FIG01231287 Trp repressor binding protein, putative +FIG01231290 FIG01231295: hypothetical protein +FIG01231295 FIG01231296: hypothetical protein +FIG01231296 FIG01231297: hypothetical protein +FIG01231298 FIG01231299: hypothetical protein +FIG01231301 FIG01231302: hypothetical protein +FIG01231304 FIG01231305: hypothetical protein +FIG01231305 FIG01231309: hypothetical protein +FIG01231310 FIG01231311: hypothetical protein +FIG01231311 Patatin-like phospholipase family +FIG01231312 FIG01231313: hypothetical protein +FIG01231314 membrane bound lipoprotein +FIG01231318 N-Acetyl-D-glucosamine ABC transport system, permease protein +FIG01231320 FIG01231321: hypothetical protein +FIG01231322 FIG01231325: hypothetical protein +FIG01231326 FIG01231327: hypothetical protein +FIG01231340 FIG01231342: hypothetical protein +FIG01231346 Uncharacterized protein yocL +FIG01231350 Phage head maturation protease +FIG01231351 FIG01231354: hypothetical protein +FIG01231354 FIG01231355: hypothetical protein +FIG01231355 FIG01231356: hypothetical protein +FIG01231357 FIG01231358: hypothetical protein +FIG01231368 FIG01231370: hypothetical protein +FIG01231372 FIG01231374: hypothetical protein +FIG01231374 FIG01231375: hypothetical protein +FIG01231375 FIG01231377: hypothetical protein +FIG01231378 YwoA +FIG01231383 FIG01231385: hypothetical protein +FIG01231398 FIG01231399: hypothetical protein +FIG01231400 FIG01231401: hypothetical protein +FIG01231414 Uncharacterized protein yugM +FIG01231416 FIG01231417: hypothetical protein +FIG01231420 FIG01231425: hypothetical protein +FIG01231425 FIG01231430: hypothetical protein +FIG01231430 FIG01231432: hypothetical protein +FIG01231433 Bacillolysin (EC 3.4.24.28) +FIG01231434 FIG01231439: hypothetical protein +FIG01231443 FIG01231444: hypothetical protein +FIG01231445 FIG01231449: hypothetical protein +FIG01231457 FIG01231459: hypothetical protein +FIG01231460 FIG01231462: hypothetical protein +FIG01231464 FIG01231466: hypothetical protein +FIG01231466 FIG01231467: hypothetical protein +FIG01231469 FIG01231470: hypothetical protein +FIG01231474 FIG01231475: hypothetical protein +FIG01231475 FIG01231477: hypothetical protein +FIG01231478 FIG01231483: hypothetical protein +FIG01231506 global nitrogen regulation (positive regulation of nrgAB, nasB, gabP, ureABC; negative regulation of glnRA) +FIG01231509 FIG01231510: hypothetical protein +FIG01231510 FIG01231514: hypothetical protein +FIG01231514 FIG01231517: hypothetical protein +FIG01231517 regulatory protein GntR, HTH:Bacterial regulatory protein GntR, HTH +FIG01231518 FIG01231519: hypothetical protein +FIG01231519 FIG01231522: hypothetical protein +FIG01231526 FIG01231528: hypothetical protein +FIG01231528 FIG01231530: hypothetical protein +FIG01231536 small multidrug export related protein +FIG01231540 FIG01231542: hypothetical protein +FIG01231545 FIG01231549: hypothetical protein +FIG01231549 FIG01231551: hypothetical protein +FIG01231553 YjgB +FIG01231554 FIG01231556: hypothetical protein +FIG01231556 FIG01231557: hypothetical protein +FIG01231557 FIG01231560: hypothetical protein +FIG01231560 FIG01231561: hypothetical protein +FIG01231565 FIG01231566: hypothetical protein +FIG01231567 FIG01231569: hypothetical protein +FIG01231573 FIG01231574: hypothetical protein +FIG01231576 FIG01231577: hypothetical protein +FIG01231577 FIG01231578: hypothetical protein +FIG01231592 FIG01231596: hypothetical protein +FIG01231596 Macrolide-efflux protein +FIG01231601 FIG01231603: hypothetical protein +FIG01231603 hydrolase, alpha/beta fold family, putative +FIG01231606 FIG01231607: hypothetical protein +FIG01231614 FIG01231620: hypothetical protein +FIG01231620 FIG01231621: hypothetical protein +FIG01231625 FIG01231626: hypothetical protein +FIG01231629 FIG01231630: hypothetical protein +FIG01231630 fis-type helix-turn-helix domain protein +FIG01231634 FIG01231638: hypothetical protein +FIG01231642 FIG01231644: hypothetical protein +FIG01231645 FIG01231647: hypothetical protein +FIG01231651 ATP-dependent RNA helicase +FIG01231652 FIG01231653: hypothetical protein +FIG01231653 Predicted nucleoside phosphatase +FIG01231654 FIG01231655: hypothetical protein +FIG01231656 FIG01231657: hypothetical protein +FIG01231657 FIG01231658: hypothetical protein +FIG01231658 FIG01231663: hypothetical protein +FIG01231663 FIG01231665: hypothetical protein +FIG01231672 potassium channel protein, N-terminus +FIG01231677 FIG01231679: hypothetical protein +FIG01231680 spore cortex-lytic enzyme +FIG01231687 FIG01231689: hypothetical protein +FIG01231691 FIG01231694: hypothetical protein +FIG01231694 FIG01231696: hypothetical protein +FIG01231698 FIG01231699: hypothetical protein +FIG01231699 FIG01231700: hypothetical protein +FIG01231708 FIG01231709: hypothetical protein +FIG01231709 FIG01231712: hypothetical protein +FIG01231712 hypothetical protein +FIG01231716 FIG01231717: hypothetical protein +FIG01231725 FIG01231727: hypothetical protein +FIG01231731 FIG01231732: hypothetical protein +FIG01231735 FIG01231736: hypothetical protein +FIG01231740 FIG01231742: hypothetical protein +FIG01231750 FIG01231751: hypothetical protein +FIG01231751 FIG01231753: hypothetical protein +FIG01231754 FIG01231757: hypothetical protein +FIG01231757 FIG01231758: hypothetical protein +FIG01231758 FIG01231759: hypothetical protein +FIG01231759 FIG01231760: hypothetical protein +FIG01231760 FIG01231765: hypothetical protein +FIG01231767 FIG01231769: hypothetical protein +FIG01231769 FIG01231772: hypothetical protein +FIG01231772 FIG01231773: hypothetical protein +FIG01231773 FIG01231776: hypothetical protein +FIG01231778 FIG01231780: hypothetical protein +FIG01231782 FIG01231783: hypothetical protein +FIG01231785 FIG01231786: hypothetical protein +FIG01231788 FIG01231789: hypothetical protein +FIG01231790 FIG01231791: hypothetical protein +FIG01231796 FIG01231797: hypothetical protein +FIG01231798 FIG01231800: hypothetical protein +FIG01231804 FIG01231808: hypothetical protein +FIG01231808 zwittermicin A resistance protein +FIG01231814 proton/sodium-glutamate symport protein +FIG01231815 FIG01231817: hypothetical protein +FIG01231817 FIG01231818: hypothetical protein +FIG01231825 FIG01231826: hypothetical protein +FIG01231826 putative methyl-accepting chemotaxis protein YoaH +FIG01231828 FIG01231829: hypothetical protein +FIG01231837 FIG01231838: hypothetical protein +FIG01231839 FIG01231841: hypothetical protein +FIG01231842 FIG01231844: hypothetical protein +FIG01231850 FIG01231851: hypothetical protein +FIG01231851 FIG01231852: hypothetical protein +FIG01231852 FIG01231853: hypothetical protein +FIG01231857 FIG01231858: hypothetical protein +FIG01231862 FIG01231863: hypothetical protein +FIG01231868 FIG01231869: hypothetical protein +FIG01231870 FIG01231871: hypothetical protein +FIG01231871 regulator of the activity of phosphatase RapG +FIG01231876 FIG01231877: hypothetical protein +FIG01231877 Lanthionine biosynthesis cyclase LanC +FIG01231878 FIG01231880: hypothetical protein +FIG01231886 N-acetylmuramoyl-L-alanine amidase +FIG01231890 Similar to proteins GerPF and GerPA +FIG01231893 hypothetical protein +FIG01231898 FIG01231899: hypothetical protein +FIG01231899 FIG01231901: hypothetical protein +FIG01231901 FIG01231902: hypothetical protein +FIG01231912 FIG01231913: hypothetical protein +FIG01231913 FIG01231914: hypothetical protein +FIG01231916 ABC transporter permease, fragment +FIG01231919 FIG01231920: hypothetical protein +FIG01231921 FIG01231922: hypothetical protein +FIG01231929 FIG01231930: hypothetical protein +FIG01231932 FIG01231933: hypothetical protein +FIG01231933 FIG01231934: hypothetical protein +FIG01231934 FIG01231938: hypothetical protein +FIG01231938 FIG01231943: hypothetical protein +FIG01231943 FIG01231945: hypothetical protein +FIG01231948 hypothetical protein; possible transcriptional regulator +FIG01231954 FIG01231959: hypothetical protein +FIG01231959 FIG01231962: hypothetical protein +FIG01231963 Uncharacterized protein yflB +FIG01231965 FIG01231966: hypothetical protein +FIG01231966 XhlA +FIG01231969 FIG01231972: hypothetical protein +FIG01231972 YycE +FIG01231973 small acid-soluble spore protein +FIG01231975 FIG01231976: hypothetical protein +FIG01231980 FIG01231981: hypothetical protein +FIG01231981 forespore-specific protein, putative +FIG01231983 hypothetical protein +FIG01231985 FIG01231987: hypothetical protein +FIG01231987 FIG01231988: hypothetical protein +FIG01231990 oligopeptide ABC transporter, ATP-binding protein, putative +FIG01231995 FIG01231996: hypothetical protein +FIG01231997 Spore coat polysaccharide biosynthesis protein spsB +FIG01232001 FIG01232006: hypothetical protein +FIG01232006 FIG01232007: hypothetical protein +FIG01232007 FIG01232008: hypothetical protein +FIG01232009 FIG01232010: hypothetical protein +FIG01232020 FIG01232021: hypothetical protein +FIG01232023 FIG01232024: hypothetical protein +FIG01232024 FIG01232025: hypothetical protein +FIG01232025 FIG01232026: hypothetical protein +FIG01232027 FIG01232028: hypothetical protein +FIG01232028 FIG01232032: hypothetical protein +FIG01232032 FIG01232034: hypothetical protein +FIG01232043 lactamase B, metallo-beta-lactamase superfamily +FIG01232044 FIG01232046: hypothetical protein +FIG01232047 FIG01232048: hypothetical protein +FIG01232048 FIG01232049: hypothetical protein +FIG01232058 FIG01232059: hypothetical protein +FIG01232059 FIG01232061: hypothetical protein +FIG01232061 FIG01232064: hypothetical protein +FIG01232064 6'-aminoglycoside N-acetyltransferase/2''-aminoglycoside phosphotransferase, putative +FIG01232065 Conserved protein YhfK +FIG01232070 FIG01232073: hypothetical protein +FIG01232074 FIG01232075: hypothetical protein +FIG01232078 FIG01232081: hypothetical protein +FIG01232089 FIG01232090: hypothetical protein +FIG01232090 Uncharacterized protein yddM +FIG01232092 FIG01232093: hypothetical protein +FIG01232093 FIG01232094: hypothetical protein +FIG01232095 FIG01232097: hypothetical protein +FIG01232100 FIG01232104: hypothetical protein +FIG01232104 FIG01232108: hypothetical protein +FIG01232108 FIG01232109: hypothetical protein +FIG01232116 Transcriptional regulator, Cro/CI family +FIG01232117 phage-like fragment +FIG01232118 FIG01232119: hypothetical protein +FIG01232121 FIG01232123: hypothetical protein +FIG01232125 SpsD +FIG01232127 FIG01232130: hypothetical protein +FIG01232132 FIG01232134: hypothetical protein +FIG01232138 FIG01232141: hypothetical protein +FIG01232141 FIG01232143: hypothetical protein +FIG01232144 YbfJ +FIG01232150 FIG01232154: hypothetical protein +FIG01232163 N-acetylmuramoyl-L-alanine amidase AmiC precursor (EC 3.5.1.28) +FIG01232169 FIG01232170: hypothetical protein +FIG01232177 FIG01232178: hypothetical protein +FIG01232192 FIG01232193: hypothetical protein +FIG01232193 FIG01232195: hypothetical protein +FIG01232197 FIG01232200: hypothetical protein +FIG01232200 FIG01232202: hypothetical protein +FIG01232204 FIG01232205: hypothetical protein +FIG01232215 FIG01232216: hypothetical protein +FIG01232216 FIG01232221: hypothetical protein +FIG01232234 FIG01232235: hypothetical protein +FIG01232235 CDS_ID OB3415 +FIG01232240 FIG01232241: hypothetical protein +FIG01232241 FIG01232245: hypothetical protein +FIG01232258 FIG01232259: hypothetical protein +FIG01232260 FIG01232261: hypothetical protein +FIG01232262 Uncharacterized NAD(P)H oxidoreductase ydeQ (EC 1.6.99.-) +FIG01232265 Two component sensor histidine kinase (EC 2.7.3.-) +FIG01232267 Uncharacterized protein yddH precursor +FIG01232273 putative MFS family transport protein +FIG01232274 FIG01232275: hypothetical protein +FIG01232275 FIG01232276: hypothetical protein +FIG01232276 FIG01232279: hypothetical protein +FIG01232280 FIG01232282: hypothetical protein +FIG01232282 FIG01232284: hypothetical protein +FIG01232286 FIG01232289: hypothetical protein +FIG01232289 hypothetical protein +FIG01232303 FIG01232305: hypothetical protein +FIG01232317 FIG01232321: hypothetical protein +FIG01232321 FIG01232322: hypothetical protein +FIG01232323 hypothetical protein BA3286 +FIG01232324 FIG01232327: hypothetical protein +FIG01232328 FIG01232329: hypothetical protein +FIG01232329 FIG01232330: hypothetical protein +FIG01232330 FIG01232331: hypothetical protein +FIG01232334 FIG01232335: hypothetical protein +FIG01232335 FIG01232336: hypothetical protein +FIG01232337 PTS system, diacetylchitobiose-specific IIA component (EC 2.7.1.6 +FIG01232347 FIG01232348: hypothetical protein +FIG01232348 FIG01232349: hypothetical protein +FIG01232349 metallo-beta-lactamase superfamily domain protein +FIG01232353 Succinoglycan biosynthesis protein +FIG01232359 FIG01232365: hypothetical protein +FIG01232369 FIG01232370: hypothetical protein +FIG01232373 FIG01232374: hypothetical protein +FIG01232374 FIG01232375: hypothetical protein +FIG01232375 FIG01232377: hypothetical protein +FIG01232397 FIG01232398: hypothetical protein +FIG01232398 FIG01232402: hypothetical protein +FIG01232406 FIG01232407: hypothetical protein +FIG01232407 FIG01232408: hypothetical protein +FIG01232416 FIG01232418: hypothetical protein +FIG01232422 FIG01232423: hypothetical protein +FIG01232425 FIG01232426: hypothetical protein +FIG01232426 FIG01232429: hypothetical protein +FIG01232435 FIG01232438: hypothetical protein +FIG01232438 FIG01232439: hypothetical protein +FIG01232441 FIG01232443: hypothetical protein +FIG01232454 FIG01232457: hypothetical protein +FIG01232457 FIG01232458: hypothetical protein +FIG01232458 FIG01232463: hypothetical protein +FIG01232463 FIG01232465: hypothetical protein +FIG01232466 FIG01232467: hypothetical protein +FIG01232470 choloylglycine hydrolase +FIG01232477 FIG01232478: hypothetical protein +FIG01232478 FIG01232481: hypothetical protein +FIG01232482 FIG01232483: hypothetical protein +FIG01232483 FIG01232486: hypothetical protein +FIG01232486 FIG01232487: hypothetical protein +FIG01232487 FIG01232489: hypothetical protein +FIG01232489 FIG01232491: hypothetical protein +FIG01232491 FIG01232496: hypothetical protein +FIG01232496 FIG01232497: hypothetical protein +FIG01232498 catalyses ATP-dependent electrogenic Na+ extrusion without mechanistically coupled H+ or K+ uptake +FIG01232501 FIG01232502: hypothetical protein +FIG01232502 FIG01232504: hypothetical protein +FIG01232510 FIG01232512: hypothetical protein +FIG01232512 FIG01232515: hypothetical protein +FIG01232518 FIG01232521: hypothetical protein +FIG01232524 FIG01232526: hypothetical protein +FIG01232526 cysteine protease +FIG01232529 FIG01232534: hypothetical protein +FIG01232536 FIG01232537: hypothetical protein +FIG01232542 FIG01232543: hypothetical protein +FIG01232544 FIG01232550: hypothetical protein +FIG01232550 FIG01232551: hypothetical protein +FIG01232553 FIG01232555: hypothetical protein +FIG01232555 FIG01232557: hypothetical protein +FIG01232557 FIG01232560: hypothetical protein +FIG01232566 FIG01232569: hypothetical protein +FIG01232569 FIG01232570: hypothetical protein +FIG01232571 Probable 1,4-dihydroxy-2-naphthoate octaprenyltransferase (EC 2.5.1.-) (DHNA-octaprenyltransferase) +FIG01232574 FIG01232575: hypothetical protein +FIG01232575 FIG01232576: hypothetical protein +FIG01232583 FIG01232585: hypothetical protein +FIG01232589 FIG01232593: hypothetical protein +FIG01232593 ErfK/YbiS/YcfS/YnhG superfamily +FIG01232605 FIG01232609: hypothetical protein +FIG01232609 EpiH/GdmH-related protein +FIG01232616 FIG01232618: hypothetical protein +FIG01232623 YqgW +FIG01232629 FIG01232631: hypothetical protein +FIG01232631 FIG01232632: hypothetical protein +FIG01232632 Prophage protein +FIG01232639 FIG01232640: hypothetical protein +FIG01232642 FIG01232643: hypothetical protein +FIG01232645 FIG01232648: hypothetical protein +FIG01232648 FIG01232649: hypothetical protein +FIG01232649 FIG01232650: hypothetical protein +FIG01232651 FIG01232652: hypothetical protein +FIG01232652 FIG01232653: hypothetical protein +FIG01232655 YwaF +FIG01232658 FIG01232660: hypothetical protein +FIG01232663 FIG01232666: hypothetical protein +FIG01232666 FIG01232667: hypothetical protein +FIG01232667 FIG01232668: hypothetical protein +FIG01232677 FIG01232682: hypothetical protein +FIG01232682 BH1264 unknown conserved protein in B. subtilis +FIG01232692 FIG01232693: hypothetical protein +FIG01232698 FIG01232699: hypothetical protein +FIG01232702 Protein of unknown function DUF861 +FIG01232705 YhaZ +FIG01232709 FIG01232717: hypothetical protein +FIG01232720 FIG01232724: hypothetical protein +FIG01232725 FIG01232729: hypothetical protein +FIG01232730 FIG01232732: hypothetical protein +FIG01232733 FIG01232739: hypothetical protein +FIG01232743 FIG01232744: hypothetical protein +FIG01232744 FIG01232745: hypothetical protein +FIG01232753 probable monooxygenase( EC:1.14.13.59 ) +FIG01232762 FIG01232764: hypothetical protein +FIG01232766 FIG01232771: hypothetical protein +FIG01232772 Subtilisin precursor (EC 3.4.21.62) +FIG01232779 YwqH +FIG01232783 YbyB +FIG01232784 YhjD +FIG01232789 FIG01232791: hypothetical protein +FIG01232800 FIG01232802: hypothetical protein +FIG01232809 FIG01232811: hypothetical protein +FIG01232811 uvrD/Rep helicase family protein +FIG01232813 3'-phosphoadenosine 5'-phosphosulfate sulfotransferase (PAPS reductase)/FAD synthetase and related enzymes +FIG01232816 FIG01232817: hypothetical protein +FIG01232834 FIG01232835: hypothetical protein +FIG01232842 FIG01232843: hypothetical protein +FIG01232844 FIG01232845: hypothetical protein +FIG01232852 FIG01232854: hypothetical protein +FIG01232854 Lysine exporter protein +FIG01232857 FIG01232858: hypothetical protein +FIG01232858 FIG01232859: hypothetical protein +FIG01232863 YdjM +FIG01232868 FIG01232871: hypothetical protein +FIG01232872 FIG01232873: hypothetical protein +FIG01232875 Possible transcriptional regulator/TPR domain protein +FIG01232876 FIG01232877: hypothetical protein +FIG01232878 FIG01232884: hypothetical protein +FIG01232887 FIG01232889: hypothetical protein +FIG01232889 Ca(2+) Citrate symporter (TC 2.A.11.1.2) +FIG01232892 FIG01232893: hypothetical protein +FIG01232893 FIG01232894: hypothetical protein +FIG01232894 FIG01232895: hypothetical protein +FIG01232897 FIG01232899: hypothetical protein +FIG01232910 transmembrane lipoprotein +FIG01232916 FIG01232920: hypothetical protein +FIG01232920 FIG01232922: hypothetical protein +FIG01232924 FIG01232928: hypothetical protein +FIG01232928 FIG01232929: hypothetical protein +FIG01232932 FIG013457: hypothetical protein +FIG01232934 FIG01232935: hypothetical protein +FIG01232938 FIG01232939: hypothetical protein +FIG01232939 FIG01232940: hypothetical protein +FIG01232940 hypothetical protein +FIG01232944 FIG01232945: hypothetical protein +FIG01232945 FIG01232946: hypothetical protein +FIG01232946 FIG01232947: hypothetical protein +FIG01232951 FIG01232959: hypothetical protein +FIG01232963 Oxalate decarboxylase oxdD (EC 4.1.1.2) +FIG01232969 FIG01232970: hypothetical protein +FIG01232979 FIG01232980: hypothetical protein +FIG01232984 FIG01232985: hypothetical protein +FIG01232985 ComP +FIG01232990 FIG01232991: hypothetical protein +FIG01232996 possible pyruvate kinase +FIG01232998 FIG01232999: hypothetical protein +FIG01233000 FIG01233001: hypothetical protein +FIG01233001 FIG01233008: hypothetical protein +FIG01233008 "Biotin-protein ligase " +FIG01233009 YugO +FIG01233012 FIG01233013: hypothetical protein +FIG01233013 YczC +FIG01233017 FIG01233019: hypothetical protein +FIG01233028 FIG01233030: hypothetical protein +FIG01233032 FIG01233034: hypothetical protein +FIG01233034 FIG01233035: hypothetical protein +FIG01233038 FIG01233041: hypothetical protein +FIG01233047 FIG01233049: hypothetical protein +FIG01233050 FIG01233051: hypothetical protein +FIG01233051 FIG01233052: hypothetical protein +FIG01233052 FIG01233053: hypothetical protein +FIG01233059 FIG01233060: hypothetical protein +FIG01233063 FIG01233064: hypothetical protein +FIG01233067 FIG01233068: hypothetical protein +FIG01233070 FIG01233072: hypothetical protein +FIG01233076 FIG01233077: hypothetical protein +FIG01233077 FIG01233080: hypothetical protein +FIG01233080 hypothetical protein +FIG01233081 FIG01233084: hypothetical protein +FIG01233087 Uncharacterized protein yhaS +FIG01233090 FIG01233091: hypothetical protein +FIG01233095 FIG01233096: hypothetical protein +FIG01233097 FIG01233098: hypothetical protein +FIG01233099 FIG01233103: hypothetical protein +FIG01233106 oxidase-related protein +FIG01233109 YocK +FIG01233114 Tetratricopeptide repeat family protein +FIG01233117 antilisterial bacteriocin (subtilosin) production +FIG01233119 FIG01233121: hypothetical protein +FIG01233132 Uncharacterized protein ydbN +FIG01233136 FIG01233139: hypothetical protein +FIG01233146 FIG01233149: hypothetical protein +FIG01233149 FIG01233151: hypothetical protein +FIG01233151 FIG01233153: hypothetical protein +FIG01233153 FIG01233154: hypothetical protein +FIG01233155 FIG01233156: hypothetical protein +FIG01233156 FIG01233159: hypothetical protein +FIG01233159 ABC-type daunorubicin resistance ATP-binding protein +FIG01233166 FIG01233168: hypothetical protein +FIG01233168 FIG01233172: hypothetical protein +FIG01233173 putative sugar ABC transporter +FIG01233183 FIG01233187: hypothetical protein +FIG01233189 FIG01233195: hypothetical protein +FIG01233197 Uncharacterized protein Bsub YpbR +FIG01233205 FIG01233206: hypothetical protein +FIG01233207 YnzE +FIG01233211 FIG01233216: hypothetical protein +FIG01233216 FIG01233217: hypothetical protein +FIG01233219 FIG01233221: hypothetical protein +FIG01233223 FIG01233224: hypothetical protein +FIG01233225 FIG01233228: hypothetical protein +FIG01233228 FIG01233229: hypothetical protein +FIG01233229 FIG01233231: hypothetical protein +FIG01233238 FIG01233239: hypothetical protein +FIG01233245 FIG01233246: hypothetical protein +FIG01233250 FIG01233251: hypothetical protein +FIG01233252 FIG01233253: hypothetical protein +FIG01233262 FIG01233269: hypothetical protein +FIG01233270 FIG01233271: hypothetical protein +FIG01233278 FIG01233279: hypothetical protein +FIG01233283 FIG01233284: hypothetical protein +FIG01233289 FIG01233290: hypothetical protein +FIG01233291 FIG01233292: hypothetical protein +FIG01233292 FIG01233293: hypothetical protein +FIG01233295 Mg-chelatase subunit ChlD +FIG01233298 FIG01233300: hypothetical protein +FIG01233300 FIG01233301: hypothetical protein +FIG01233303 FIG00675519: hypothetical protein +FIG01233305 FIG01233306: hypothetical protein +FIG01233306 FIG01233307: hypothetical protein +FIG01233308 FIG01233312: hypothetical protein +FIG01233325 FIG01233329: hypothetical protein +FIG01233332 FIG01233333: hypothetical protein +FIG01233333 Lipoprotein lplA precursor +FIG01233340 FIG01233342: hypothetical protein +FIG01233342 FIG01233345: hypothetical protein +FIG01233345 FIG01233346: hypothetical protein +FIG01233349 FIG01233350: hypothetical protein +FIG01233350 FIG01233352: hypothetical protein +FIG01233354 N-acetylmuramoyl-L-alanine amidase, N-terminus +FIG01233360 FIG01233361: hypothetical protein +FIG01233362 aromatic hydrocarbon catabolism protein +FIG01233372 FIG01233373: hypothetical protein +FIG01233373 FIG01233376: hypothetical protein +FIG01233381 FIG01233382: hypothetical protein +FIG01233385 FIG01233386: hypothetical protein +FIG01233386 FIG01233387: hypothetical protein +FIG01233387 FIG01233389: hypothetical protein +FIG01233390 FIG01233392: hypothetical protein +FIG01233393 FIG01233394: hypothetical protein +FIG01233394 FIG01233396: hypothetical protein +FIG01233398 FIG01233399: hypothetical protein +FIG01233414 FIG01233416: hypothetical protein +FIG01233426 FIG01233435: hypothetical protein +FIG01233435 FIG01233436: hypothetical protein +FIG01233436 FIG01233437: hypothetical protein +FIG01233437 FIG01233439: hypothetical protein +FIG01233440 FIG01233443: hypothetical protein +FIG01233447 FIG01233448: hypothetical protein +FIG01233448 FIG01233450: hypothetical protein +FIG01233450 CDS_ID OB0985 +FIG01233454 FIG01233455: hypothetical protein +FIG01233455 FIG01233457: hypothetical protein +FIG01233462 Macrolide efflux protein +FIG01233465 FIG01233467: hypothetical protein +FIG01233474 FIG01233475: hypothetical protein +FIG01233476 FIG01233477: hypothetical protein +FIG01233478 FIG01233479: hypothetical protein +FIG01233483 FIG01233487: hypothetical protein +FIG01233488 FIG01233489: hypothetical protein +FIG01233489 FIG01233490: hypothetical protein +FIG01233496 FIG01233500: hypothetical protein +FIG01233508 FIG01233509: hypothetical protein +FIG01233511 FIG01233514: hypothetical protein +FIG01233517 FIG01233519: hypothetical protein +FIG01233523 FIG01233530: hypothetical protein +FIG01233536 FIG01233538: hypothetical protein +FIG01233538 FIG01233539: hypothetical protein +FIG01233539 surface layer protein +FIG01233541 FIG01233542: hypothetical protein +FIG01233542 FIG01233546: hypothetical protein +FIG01233552 GlcT +FIG01233563 FIG01233565: hypothetical protein +FIG01233572 FIG01233578: hypothetical protein +FIG01233584 FIG01233585: hypothetical protein +FIG01233587 FIG01233590: hypothetical protein +FIG01233597 FIG01233598: hypothetical protein +FIG01233606 FIG01233608: hypothetical protein +FIG01233612 Uncharacterized protein ywcI +FIG01233614 FIG01233616: hypothetical protein +FIG01233616 FIG01233617: hypothetical protein +FIG01233623 alternate gene name: ipa-62r +FIG01233625 FIG01233627: hypothetical protein +FIG01233627 FIG01233629: hypothetical protein +FIG01233629 Phr-like protein +FIG01233648 FIG01233649: hypothetical protein +FIG01233651 Terminase small subunit [Bacteriophage A118] +FIG01233657 FIG01233660: hypothetical protein +FIG01233660 FIG01233662: hypothetical protein +FIG01233662 FIG01233663: hypothetical protein +FIG01233671 FIG01233672: hypothetical protein +FIG01233673 FIG01233674: hypothetical protein +FIG01233674 FIG01233676: hypothetical protein +FIG01233676 Stress response protein nhaX +FIG01233678 FIG01233682: hypothetical protein +FIG01233684 FIG01233685: hypothetical protein +FIG01233687 FIG01233689: hypothetical protein +FIG01233692 Sigma-X negative effector +FIG01233702 FIG01233705: hypothetical protein +FIG01233706 NAD-dependent epimerase/dehydratase / Alpha/beta hydrolase +FIG01233707 FIG01233708: hypothetical protein +FIG01233713 FIG01233714: hypothetical protein +FIG01233733 Erythromycin esterase type I +FIG01233738 FIG01233739: hypothetical protein +FIG01233739 FIG01233744: hypothetical protein +FIG01233744 FIG01233745: hypothetical protein +FIG01233748 FIG01233749: hypothetical protein +FIG01233749 FIG01233757: hypothetical protein +FIG01233761 AB hydrolase superfamily protein YdjP +FIG01233762 FIG01233763: hypothetical protein +FIG01233765 FIG01233772: hypothetical protein +FIG01233775 Phage terminase, large subunit [SA bacteriophages 11, Mu50B] +FIG01233786 FIG01233787: hypothetical protein +FIG01233787 FIG01233788: hypothetical protein +FIG01233788 hypothetical protein +FIG01233791 FIG01233796: hypothetical protein +FIG01233796 FIG01233798: hypothetical protein +FIG01233799 FIG01233802: hypothetical protein +FIG01233803 FIG01233805: hypothetical protein +FIG01233805 FIG01233806: hypothetical protein +FIG01233808 FIG01233809: hypothetical protein +FIG01233813 FIG01233814: hypothetical protein +FIG01233818 Small acid-soluble spore protein +FIG01233821 FIG01233823: hypothetical protein +FIG01233824 FIG01233826: hypothetical protein +FIG01233828 FIG01233829: hypothetical protein +FIG01233829 FIG01233830: hypothetical protein +FIG01233834 FIG01233836: hypothetical protein +FIG01233836 FIG01233838: hypothetical protein +FIG01233838 FIG01233840: hypothetical protein +FIG01233840 FIG01233841: hypothetical protein +FIG01233841 FIG01233842: hypothetical protein +FIG01233848 FIG01233850: hypothetical protein +FIG01233855 Penicillin-binding protein +FIG01233860 FIG01233862: hypothetical protein +FIG01233862 BH1041 unknown conserved protein +FIG01233882 FIG01233886: hypothetical protein +FIG01233891 FIG01233892: hypothetical protein +FIG01233897 FIG01233899: hypothetical protein +FIG01233899 FIG01233900: hypothetical protein +FIG01233902 FIG01233903: hypothetical protein +FIG01233903 FIG01233907: hypothetical protein +FIG01233907 FIG01233908: hypothetical protein +FIG01233917 prolyl endopeptidase +FIG01233925 FIG01233927: hypothetical protein +FIG01233927 FIG01233928: hypothetical protein +FIG01233929 FIG01233930: hypothetical protein +FIG01233930 Phosphoglycerate mutase( EC:5.4.2.1 ) +FIG01233934 FIG01233936: hypothetical protein +FIG01233941 FIG01233944: hypothetical protein +FIG01233946 FIG01233948: hypothetical protein +FIG01233950 YKOJ +FIG01233959 FIG01233961: hypothetical protein +FIG01233961 FIG01233967: hypothetical protein +FIG01233967 FIG01233968: hypothetical protein +FIG01233978 FIG01233980: hypothetical protein +FIG01233982 FIG01233985: hypothetical protein +FIG01233985 FIG01233986: hypothetical protein +FIG01233986 FIG01233987: hypothetical protein +FIG01233987 FIG01233988: hypothetical protein +FIG01233991 FIG01233992: hypothetical protein +FIG01233992 FIG01233993: hypothetical protein +FIG01234000 FIG01234004: hypothetical protein +FIG01234004 putative prophage protein +FIG01234006 Uncharacterized protein ymzC precursor +FIG01234007 FIG01234008: hypothetical protein +FIG01234008 Internalin G +FIG01234009 FIG01234012: hypothetical protein +FIG01234016 FIG01234019: hypothetical protein +FIG01234019 FIG01234021: hypothetical protein +FIG01234023 FIG01234025: hypothetical protein +FIG01234025 FIG01234029: hypothetical protein +FIG01234029 Ribonuclease (EC 3.1.27.-) (RNase Bci) +FIG01234036 Quaternary ammonium compound-resistance protein SugE +FIG01234039 FIG01234042: hypothetical protein +FIG01234044 FIG01234045: hypothetical protein +FIG01234045 putative Macrolide 2'-phosphotransferase +FIG01234046 FIG01234047: hypothetical protein +FIG01234047 FIG01234049: hypothetical protein +FIG01234054 FIG01234056: hypothetical protein +FIG01234056 FIG01234062: hypothetical protein +FIG01234062 FIG01234063: hypothetical protein +FIG01234066 FIG01234068: hypothetical protein +FIG01234071 FIG01234072: hypothetical protein +FIG01234072 FIG01234075: hypothetical protein +FIG01234075 FIG01234076: hypothetical protein +FIG01234077 FIG01234082: hypothetical protein +FIG01234083 FIG01234085: hypothetical protein +FIG01234091 FIG01234092: hypothetical protein +FIG01234092 FIG01234093: hypothetical protein +FIG01234096 FIG01234097: hypothetical protein +FIG01234097 FIG01234098: hypothetical protein +FIG01234100 FIG01234101: hypothetical protein +FIG01234101 FIG01234102: hypothetical protein +FIG01234102 FIG01234104: hypothetical protein +FIG01234108 FIG01234110: hypothetical protein +FIG01234112 FIG01234118: hypothetical protein +FIG01234118 FIG01234124: hypothetical protein +FIG01234124 hypothetical protein +FIG01234126 FIG01234128: hypothetical protein +FIG01234135 FIG01234139: hypothetical protein +FIG01234145 FIG01234146: hypothetical protein +FIG01234146 FIG01234148: hypothetical protein +FIG01234152 FIG01234153: hypothetical protein +FIG01234153 FIG01234155: hypothetical protein +FIG01234163 FIG01234166: hypothetical protein +FIG01234166 alternate gene name: ipa-51d +FIG01234167 FIG01234168: hypothetical protein +FIG01234168 FIG01234169: hypothetical protein +FIG01234172 FIG01234173: hypothetical protein +FIG01234176 FIG01234177: hypothetical protein +FIG01234186 FIG01234188: hypothetical protein +FIG01234190 FIG01234194: hypothetical protein +FIG01234194 FIG01234195: hypothetical protein +FIG01234195 FIG01234196: hypothetical protein +FIG01234196 FIG01234198: hypothetical protein +FIG01234198 Uncharacterized HTH-type transcriptional regulator ydgJ +FIG01234199 FIG01234200: hypothetical protein +FIG01234209 FIG01234211: hypothetical protein +FIG01234211 FIG01234212: hypothetical protein +FIG01234212 FIG01234213: hypothetical protein +FIG01234217 FIG01234218: hypothetical protein +FIG01234218 FIG01234219: hypothetical protein +FIG01234237 FIG01234239: hypothetical protein +FIG01234240 FIG01234242: hypothetical protein +FIG01234248 FIG01234249: hypothetical protein +FIG01234255 FIG01234257: hypothetical protein +FIG01234260 FIG01234261: hypothetical protein +FIG01234263 FIG01234265: hypothetical protein +FIG01234265 FIG01234267: hypothetical protein +FIG01234268 ABC transporter, ATP-binding protein +FIG01234272 FIG01234273: hypothetical protein +FIG01234275 FIG01234276: hypothetical protein +FIG01234279 FIG01234280: hypothetical protein +FIG01234280 FIG01234283: hypothetical protein +FIG01234288 FIG01234291: hypothetical protein +FIG01234305 FIG01234307: hypothetical protein +FIG01234307 FIG01234309: hypothetical protein +FIG01234309 FIG01234310: hypothetical protein +FIG01234310 FIG01234312: hypothetical protein +FIG01234313 Uncharacterized protein yxzF +FIG01234320 hypothetical protein +FIG01234330 FIG01234332: hypothetical protein +FIG01234332 FIG01234333: hypothetical protein +FIG01234333 FIG01234341: hypothetical protein +FIG01234344 FIG01234345: hypothetical protein +FIG01234345 FIG01234348: hypothetical protein +FIG01234348 FIG01234351: hypothetical protein +FIG01234351 FIG01234353: hypothetical protein +FIG01234353 FIG01234354: hypothetical protein +FIG01234358 FIG01234361: hypothetical protein +FIG01234366 FIG01234368: hypothetical protein +FIG01234369 FIG01234370: hypothetical protein +FIG01234371 YrzF +FIG01234373 Exoglucanase II precursor (EC 3.2.1.91) +FIG01234378 FIG01234379: hypothetical protein +FIG01234379 FIG01234383: hypothetical protein +FIG01234389 FIG01234391: hypothetical protein +FIG01234391 FIG01234393: hypothetical protein +FIG01234395 YcsK +FIG01234406 FIG01234408: hypothetical protein +FIG01234414 FIG01234417: hypothetical protein +FIG01234419 FIG01234421: hypothetical protein +FIG01234421 FIG01234422: hypothetical protein +FIG01234427 Hydrolase, alpha/beta fold family +FIG01234431 FIG01234432: hypothetical protein +FIG01234433 FIG01234435: hypothetical protein +FIG01234435 FIG01234437: hypothetical protein +FIG01234437 YhjH +FIG01234439 RS21-C6-like protein (RS21-C6 protein) +FIG01234446 conserved repeat domain protein +FIG01234447 FIG01234449: hypothetical protein +FIG01234449 FIG01234450: hypothetical protein +FIG01234458 FIG01234461: hypothetical protein +FIG01234461 FIG01234467: hypothetical protein +FIG01234468 FIG01234469: hypothetical protein +FIG01234469 Phage-like element PBSX protein xepA (Protein xkdY) +FIG01234475 FIG01234477: hypothetical protein +FIG01234477 FIG01234478: hypothetical protein +FIG01234495 involved in maturation of the outermost layer of the spore +FIG01234497 FIG01234501: hypothetical protein +FIG01234501 FIG01234503: hypothetical protein +FIG01234508 DnaD domain protein +FIG01234515 FIG01234517: hypothetical protein +FIG01234519 FIG01234521: hypothetical protein +FIG01234525 FIG01234527: hypothetical protein +FIG01234537 hypothetical protein +FIG01234545 FIG01234547: hypothetical protein +FIG01234558 FIG01234562: hypothetical protein +FIG01234567 gas vesicle protein GvpT +FIG01234575 FIG01234577: hypothetical protein +FIG01234577 FIG01234578: hypothetical protein +FIG01234579 FIG01234583: hypothetical protein +FIG01234583 FIG01234585: hypothetical protein +FIG01234595 FIG01234597: hypothetical protein +FIG01234597 FIG01234598: hypothetical protein +FIG01234603 FIG01234604: hypothetical protein +FIG01234609 conserved hypothetical protein TIGR01655 subfamily +FIG01234611 FIG01234612: hypothetical protein +FIG01234612 FIG01234613: hypothetical protein +FIG01234613 FIG01234615: hypothetical protein +FIG01234618 FIG01234619: hypothetical protein +FIG01234619 enoyl-CoA hydratase, R-specific +FIG01234620 FIG01234621: hypothetical protein +FIG01234628 FIG01234630: hypothetical protein +FIG01234630 FIG01234634: hypothetical protein +FIG01234636 FIG01234637: hypothetical protein +FIG01234637 FIG01234639: hypothetical protein +FIG01234641 FIG01234642: hypothetical protein +FIG01234642 FIG01234643: hypothetical protein +FIG01234643 D-threo-aldose 1-dehydrogenase +FIG01234646 FIG01234648: hypothetical protein +FIG01234655 fimbria-associated protein +FIG01234656 FIG01234661: hypothetical protein +FIG01234672 FIG01234673: hypothetical protein +FIG01234674 FIG01234678: hypothetical protein +FIG01234682 FIG01234685: hypothetical protein +FIG01234688 FIG01234690: hypothetical protein +FIG01234690 FIG01234691: hypothetical protein +FIG01234691 FIG01234694: hypothetical protein +FIG01234698 FIG01234699: hypothetical protein +FIG01234699 FIG01234702: hypothetical protein +FIG01234702 extracellular esterase +FIG01234706 FIG01234707: hypothetical protein +FIG01234713 FIG01234714: hypothetical protein +FIG01234716 FIG01234720: hypothetical protein +FIG01234725 FIG01234726: hypothetical protein +FIG01234726 FIG01234727: hypothetical protein +FIG01234727 FIG01234729: hypothetical protein +FIG01234729 FIG01234730: hypothetical protein +FIG01234734 FIG01234735: hypothetical protein +FIG01234735 FIG01234737: hypothetical protein +FIG01234739 CDS_ID OB0286 +FIG01234743 FIG01234745: hypothetical protein +FIG01234746 FIG014384: hypothetical protein +FIG01234747 YwnJ +FIG01234752 FIG01234753: hypothetical protein +FIG01234753 FIG01234754: hypothetical protein +FIG01234759 FIG01234764: hypothetical protein +FIG01234765 FIG01234768: hypothetical protein +FIG01234770 YnfF +FIG01234777 YqaB +FIG01234780 Tellurium resistance protein TerA +FIG01234782 FIG01234784: hypothetical protein +FIG01234785 FIG01234790: hypothetical protein +FIG01234791 sensor histidine kinase, N-terminus +FIG01234800 FIG01234801: hypothetical protein +FIG01234805 FIG01234807: hypothetical protein +FIG01234809 FIG01234812: hypothetical protein +FIG01234812 structural component +FIG01234817 FIG01234821: hypothetical protein +FIG01234822 FIG01234823: hypothetical protein +FIG01234842 FIG01234843: hypothetical protein +FIG01234844 N-acetylglucosaminyltransferase, N-terminus (glycosyl transferase) +FIG01234852 FIG01234854: hypothetical protein +FIG01234861 FIG01234863: hypothetical protein +FIG01234863 FIG01234866: hypothetical protein +FIG01234870 FIG01234872: hypothetical protein +FIG01234872 FIG01234873: hypothetical protein +FIG01234876 FIG01234880: hypothetical protein +FIG01234882 FIG01234884: hypothetical protein +FIG01234886 FIG01234887: hypothetical protein +FIG01234887 FIG01234888: hypothetical protein +FIG01234888 D-glycero-D-manno-heptose 1,7-bisphosphate phosphatase (EC 3.1.1.-) +FIG01234890 FIG01234891: hypothetical protein +FIG01234891 FIG01234893: hypothetical protein +FIG01234898 FIG01234899: hypothetical protein +FIG01234899 XkdD +FIG01234909 FIG01234910: hypothetical protein +FIG01234910 FIG01234911: hypothetical protein +FIG01234911 FIG01234912: hypothetical protein +FIG01234912 FIG01234914: hypothetical protein +FIG01234919 FIG01234921: hypothetical protein +FIG01234925 phytoene dehydrogenase +FIG01234932 FIG01234934: hypothetical protein +FIG01234934 FIG01234937: hypothetical protein +FIG01234938 FIG01234939: hypothetical protein +FIG01234939 FIG01234941: hypothetical protein +FIG01234941 FIG01234942: hypothetical protein +FIG01234945 Uncharacterized protein ydhF precursor +FIG01234948 FIG01234950: hypothetical protein +FIG01234971 FIG01234973: hypothetical protein +FIG01234978 FIG01234982: hypothetical protein +FIG01234995 FIG01234996: hypothetical protein +FIG01234998 FIG01234999: hypothetical protein +FIG01235000 FIG01235002: hypothetical protein +FIG01235003 FIG01235009: hypothetical protein +FIG01235009 conserved membrane protein ML1361 +FIG01235014 FIG01235016: hypothetical protein +FIG01235020 FIG01235021: hypothetical protein +FIG01235021 FIG01235023: hypothetical protein +FIG01235023 FIG01235024: hypothetical protein +FIG01235024 FIG01235026: hypothetical protein +FIG01235026 FIG01235027: hypothetical protein +FIG01235034 FIG01235035: hypothetical protein +FIG01235050 Probable mutT/Nudix family protein +FIG01235059 FIG01235063: hypothetical protein +FIG01235064 FIG01235065: hypothetical protein +FIG01235065 FIG01235069: hypothetical protein +FIG01235069 FIG01235071: hypothetical protein +FIG01235071 Replication protein O +FIG01235073 FIG01108941: hypothetical protein +FIG01235074 haemolytic enterotoxin +FIG01235079 FIG01235081: hypothetical protein +FIG01235084 BH2128 unknown +FIG01235096 FIG01235098: hypothetical protein +FIG01235104 FIG01235107: hypothetical protein +FIG01235107 FIG01235110: hypothetical protein +FIG01235110 FIG01235112: hypothetical protein +FIG01235115 FIG01235116: hypothetical protein +FIG01235116 FIG01235117: hypothetical protein +FIG01235117 FIG01235118: hypothetical protein +FIG01235128 BH0884 unknown conserved protein +FIG01235132 FIG01235136: hypothetical protein +FIG01235145 FIG01235146: hypothetical protein +FIG01235149 FIG01235150: hypothetical protein +FIG01235159 FIG01235164: hypothetical protein +FIG01235165 hypothetical protein +FIG01235166 FIG01235171: hypothetical protein +FIG01235192 lipoprotein, NLP/P60 family +FIG01235194 FIG01235195: hypothetical protein +FIG01235203 Fis-type helix-turn-helix domain protein +FIG01235212 FIG01235216: hypothetical protein +FIG01235216 spermidine acetyltransferase, putative +FIG01235217 FIG01235218: hypothetical protein +FIG01235218 FIG01235220: hypothetical protein +FIG01235221 ydzJ +FIG01235227 FIG01235229: hypothetical protein +FIG01235229 FIG01235231: hypothetical protein +FIG01235231 FIG01235234: hypothetical protein +FIG01235235 Bacitracin transport permease protein BCRC +FIG01235241 FIG01235242: hypothetical protein +FIG01235247 FIG01235248: hypothetical protein +FIG01235248 FIG01235250: hypothetical protein +FIG01235252 FIG01235253: hypothetical protein +FIG01235255 FIG01235260: hypothetical protein +FIG01235267 FIG01235268: hypothetical protein +FIG01235268 FIG01235271: hypothetical protein +FIG01235271 FIG01235272: hypothetical protein +FIG01235272 Phage capsid and scaffold +FIG01235274 FIG01235277: hypothetical protein +FIG01235277 FIG01235278: hypothetical protein +FIG01235278 FIG01235281: hypothetical protein +FIG01235282 FIG01235290: hypothetical protein +FIG01235296 FIG01235304: hypothetical protein +FIG01235304 competence and sporulation factor +FIG01235306 FIG01235308: hypothetical protein +FIG01235308 YozQ +FIG01235311 FIG01235313: hypothetical protein +FIG01235314 FIG01235317: hypothetical protein +FIG01235320 FIG01235321: hypothetical protein +FIG01235324 FIG01235328: hypothetical protein +FIG01235333 FIG01235334: hypothetical protein +FIG01235335 FIG01235336: hypothetical protein +FIG01235336 FIG01235337: hypothetical protein +FIG01235339 FIG01235342: hypothetical protein +FIG01235342 FIG01235343: hypothetical protein +FIG01235345 FIG01235347: hypothetical protein +FIG01235348 FIG01235351: hypothetical protein +FIG01235362 FIG01235365: hypothetical protein +FIG01235365 FIG01235366: hypothetical protein +FIG01235369 FIG01235370: hypothetical protein +FIG01235371 possible transcriptional regulator +FIG01235372 FIG01235373: hypothetical protein +FIG01235382 FIG01235383: hypothetical protein +FIG01235385 Plasmid replication initiation protein +FIG01235386 FIG01235387: hypothetical protein +FIG01235387 Spo0E regulatory protein, specific dephosphorylation of Spo0A-P (stage 0 sporulation) +FIG01235390 Stage V sporulation protein K +FIG01235391 FIG01235393: hypothetical protein +FIG01235393 Transcriptional regulators, LysR family protein +FIG01235394 FIG01235398: hypothetical protein +FIG01235404 FIG01235405: hypothetical protein +FIG01235406 FIG01235407: hypothetical protein +FIG01235410 FIG01235411: hypothetical protein +FIG01235413 FIG01235415: hypothetical protein +FIG01235415 FIG01235416: hypothetical protein +FIG01235416 FIG01235417: hypothetical protein +FIG01235417 FIG01235421: hypothetical protein +FIG01235421 FIG01235424: hypothetical protein +FIG01235428 FIG01235429: hypothetical protein +FIG01235429 FIG01235430: hypothetical protein +FIG01235433 FIG01235437: hypothetical protein +FIG01235442 FIG01235443: hypothetical protein +FIG01235448 FIG01235450: hypothetical protein +FIG01235459 beta-lactamase II( EC:3.5.2.6 ) +FIG01235460 YbeF +FIG01235464 FIG01235465: hypothetical protein +FIG01235465 FIG01235466: hypothetical protein +FIG01235471 FIG01235474: hypothetical protein +FIG01235474 FIG01235475: hypothetical protein +FIG01235480 YrzI +FIG01235493 FIG01235494: hypothetical protein +FIG01235500 FIG01235503: hypothetical protein +FIG01235505 FIG01235508: hypothetical protein +FIG01235510 FIG01235512: hypothetical protein +FIG01235512 FIG01235513: hypothetical protein +FIG01235513 hypothetical Lysophospholipase +FIG01235523 FIG01235524: hypothetical protein +FIG01235524 HTH-type transcriptional regulator CueR +FIG01235526 FIG01235529: hypothetical protein +FIG01235529 FIG01235530: hypothetical protein +FIG01235533 FIG01235540: hypothetical protein +FIG01235544 FIG01235546: hypothetical protein +FIG01235548 FIG01235551: hypothetical protein +FIG01235551 FIG01235555: hypothetical protein +FIG01235563 FIG01235566: hypothetical protein +FIG01235567 FIG01235568: hypothetical protein +FIG01235568 Tn7-like transposition protein B +FIG01235573 FIG01235575: hypothetical protein +FIG01235580 FIG01235582: hypothetical protein +FIG01235583 Gp8 protein +FIG01235592 FIG01235593: hypothetical protein +FIG01235593 FIG01235602: hypothetical protein +FIG01235602 FIG01235603: hypothetical protein +FIG01235603 FIG01242263: hypothetical protein +FIG01235606 Putative efflux protein in 2-methylcitrate synthase cluster; Homoserine/threonine efflux protein +FIG01235608 FIG01235610: hypothetical protein +FIG01235613 FIG01235614: hypothetical protein +FIG01235615 FIG01235616: hypothetical protein +FIG01235616 FIG01235621: hypothetical protein +FIG01235621 FIG01235622: hypothetical protein +FIG01235633 multidrug resistance protein (efflux transporter) +FIG01235637 FIG01235638: hypothetical protein +FIG01235643 FIG01235644: hypothetical protein +FIG01235644 FIG01235645: hypothetical protein +FIG01235645 FIG01235646: hypothetical protein +FIG01235647 FIG01235648: hypothetical protein +FIG01235649 FIG01235650: hypothetical protein +FIG01235650 group-specific protein +FIG01235660 CotF +FIG01235662 FIG01235663: hypothetical protein +FIG01235666 FIG01235670: hypothetical protein +FIG01235673 FIG01235675: hypothetical protein +FIG01235675 FIG01235680: hypothetical protein +FIG01235680 FIG01235682: hypothetical protein +FIG01235685 FIG01235687: hypothetical protein +FIG01235687 FIG01235689: hypothetical protein +FIG01235702 FIG01235705: hypothetical protein +FIG01235707 FIG01235712: hypothetical protein +FIG01235712 FIG01235713: hypothetical protein +FIG01235716 hypothetical and glycosyltransferase fusion protein +FIG01235720 FIG01235726: hypothetical protein +FIG01235730 FIG01235731: hypothetical protein +FIG01235732 FIG01235733: hypothetical protein +FIG01235733 FIG01235736: hypothetical protein +FIG01235736 FIG01235738: hypothetical protein +FIG01235738 FIG01235739: hypothetical protein +FIG01235739 FIG01235741: hypothetical protein +FIG01235741 FIG01235742: hypothetical protein +FIG01235753 FIG01235755: hypothetical protein +FIG01235755 Glutamate decarboxylase( EC:4.1.1.15 ) +FIG01235758 FIG01235760: hypothetical protein +FIG01235760 FIG01235768: hypothetical protein +FIG01235768 FIG01235770: hypothetical protein +FIG01235773 FIG01235774: hypothetical protein +FIG01235774 FIG01235776: hypothetical protein +FIG01235784 FIG01235788: hypothetical protein +FIG01235794 FIG01235795: hypothetical protein +FIG01235800 FIG01235802: hypothetical protein +FIG01235802 FIG002984: FAD-dependent pyridine nucleotide-disulphide oxidoreductase +FIG01235803 lantibiotic biosynthesis DNA-binding response regulator, putative +FIG01235806 FIG01235807: hypothetical protein +FIG01235811 FIG01235812: hypothetical protein +FIG01235815 FIG01235818: hypothetical protein +FIG01235830 FIG01235834: hypothetical protein +FIG01235842 FIG01235843: hypothetical protein +FIG01235845 drug transport protein, putative +FIG01235850 FIG01235851: hypothetical protein +FIG01235851 FIG01235858: hypothetical protein +FIG01235860 FIG01235861: hypothetical protein +FIG01235868 FIG01235874: hypothetical protein +FIG01235880 FIG01235883: hypothetical protein +FIG01235883 proline transporter +FIG01235893 FIG01235895: hypothetical protein +FIG01235906 FIG01235907: hypothetical protein +FIG01235919 FIG01235920: hypothetical protein +FIG01235922 Possible spore germination protein +FIG01235930 FIG01235932: hypothetical protein +FIG01235933 FIG01235937: hypothetical protein +FIG01235937 FIG01235939: hypothetical protein +FIG01235947 FIG01235949: hypothetical protein +FIG01235949 FIG01235950: hypothetical protein +FIG01235953 FIG01235956: hypothetical protein +FIG01235965 possible phosphinothricin N-acetyltransferase +FIG01235970 FIG01235971: hypothetical protein +FIG01235971 Predicted glycosyl hydrolase +FIG01235979 FIG01235980: hypothetical protein +FIG01235999 FIG01236000: hypothetical protein +FIG01236002 Uncharacterized protein yrzI +FIG01236005 FIG01236007: hypothetical protein +FIG01236007 FIG01236009: hypothetical protein +FIG01236010 FIG01236011: hypothetical protein +FIG01236012 FIG01236013: hypothetical protein +FIG01236013 FIG01236016: hypothetical protein +FIG01236016 FIG01236018: hypothetical protein +FIG01236025 FIG01236026: hypothetical protein +FIG01236031 FIG01236037: hypothetical protein +FIG01236037 FIG01236038: hypothetical protein +FIG01236042 FIG01236044: hypothetical protein +FIG01236063 FIG01236068: hypothetical protein +FIG01236068 FIG01236070: hypothetical protein +FIG01236079 FIG01236085: hypothetical protein +FIG01236085 FIG01236086: hypothetical protein +FIG01236086 FIG01236089: hypothetical protein +FIG01236089 FIG01236092: hypothetical protein +FIG01236100 FIG01236101: hypothetical protein +FIG01236102 Delta5 acyl-lipid desaturase (EC 1.14.99.-) +FIG01236103 chemotaxis +FIG01236109 FIG01236112: hypothetical protein +FIG01236119 FIG01236120: hypothetical protein +FIG01236120 FIG01236122: hypothetical protein +FIG01236126 YxaI +FIG01236128 hypothetical protein +FIG01236130 FIG01236131: hypothetical protein +FIG01236144 FIG01236145: hypothetical protein +FIG01236145 FIG01236146: hypothetical protein +FIG01236146 FIG01236150: hypothetical protein +FIG01236150 FIG01236151: hypothetical protein +FIG01236154 Uncharacterized protein yjaV +FIG01236155 replication terminator protein +FIG01236167 FIG01236170: hypothetical protein +FIG01236175 FIG01236176: hypothetical protein +FIG01236176 FIG01236177: hypothetical protein +FIG01236178 RarD protein, DMT superfamily transporter +FIG01236180 FIG01236182: hypothetical protein +FIG01236182 Uncharacterized protein yrzH +FIG01236185 FIG01236191: hypothetical protein +FIG01236192 FIG01236195: hypothetical protein +FIG01236195 FIG01236196: hypothetical protein +FIG01236196 FIG01236198: hypothetical protein +FIG01236198 FIG01236199: hypothetical protein +FIG01236199 FIG01236200: hypothetical protein +FIG01236203 FIG01236204: hypothetical protein +FIG01236204 FIG01236207: hypothetical protein +FIG01236208 FIG01236209: hypothetical protein +FIG01236211 FIG01249100: hypothetical protein +FIG01236213 FIG01236216: hypothetical protein +FIG01236216 sensory box sigma-54 dependent DNA-binding response regulator, in GABA cluster +FIG01236220 FIG01236222: hypothetical protein +FIG01236222 Fatty-acid desaturase (EC 1.14.99.-) +FIG01236228 FIG01236229: hypothetical protein +FIG01236232 FIG01236233: hypothetical protein +FIG01236233 FIG01236234: hypothetical protein +FIG01236234 FIG01236236: hypothetical protein +FIG01236236 FIG01236237: hypothetical protein +FIG01236244 FIG01236247: hypothetical protein +FIG01236249 FIG01236252: hypothetical protein +FIG01236252 FIG01236253: hypothetical protein +FIG01236262 FIG01236263: hypothetical protein +FIG01236264 FIG01236267: hypothetical protein +FIG01236267 FIG01236270: hypothetical protein +FIG01236270 FIG01236272: hypothetical protein +FIG01236272 FIG01236273: hypothetical protein +FIG01236274 FIG01236275: hypothetical protein +FIG01236280 FIG01236285: hypothetical protein +FIG01236287 Sporulation kinase A (EC 2.7.13.3) +FIG01236289 FIG01236290: hypothetical protein +FIG01236290 FIG01236291: hypothetical protein +FIG01236298 Putative acyl-coa dehydrogenase +FIG01236302 FIG01236305: hypothetical protein +FIG01236305 FIG01236310: hypothetical protein +FIG01236310 FIG01236311: hypothetical protein +FIG01236311 FIG01236313: hypothetical protein +FIG01236327 YwjC +FIG01236329 FIG01236332: hypothetical protein +FIG01236332 FIG01236337: hypothetical protein +FIG01236340 N-acetylmuramoyl-L-alanine amidase domain protein +FIG01236347 FIG01236348: hypothetical protein +FIG01236348 FIG01236349: hypothetical protein +FIG01236349 FIG01236350: hypothetical protein +FIG01236350 FIG01236351: hypothetical protein +FIG01236367 FIG01236369: hypothetical protein +FIG01236369 FIG01236370: hypothetical protein +FIG01236370 FIG01246697: hypothetical protein +FIG01236374 FIG01236375: hypothetical protein +FIG01236375 FIG01236376: hypothetical protein +FIG01236381 FIG01236383: hypothetical protein +FIG01236394 Sensory transduction protein kinase +FIG01236397 FIG01236398: hypothetical protein +FIG01236398 FIG01236399: hypothetical protein +FIG01236400 Hypothetical membrane associated protein +FIG01236405 FIG01236406: hypothetical protein +FIG01236406 FIG01236408: hypothetical protein +FIG01236408 FIG01236409: hypothetical protein +FIG01236417 FIG01236418: hypothetical protein +FIG01236423 Uncharacterized protein yhcE +FIG01236426 FIG01236435: hypothetical protein +FIG01236435 similar to ORF13 of enterococcus faecalis TRANSPOSON TN916., putative +FIG01236453 FIG01236454: hypothetical protein +FIG01236455 FIG01236456: hypothetical protein +FIG01236456 Uncharacterized protein ywmE +FIG01236459 FIG01236463: hypothetical protein +FIG01236463 FIG01236464: hypothetical protein +FIG01236469 FIG01236470: hypothetical protein +FIG01236473 FIG01236475: hypothetical protein +FIG01236496 FIG01236499: hypothetical protein +FIG01236499 FIG01236504: hypothetical protein +FIG01236507 FIG01236512: hypothetical protein +FIG01236513 Phage-related protein +FIG01236522 FIG01236524: hypothetical protein +FIG01236524 FIG01236526: hypothetical protein +FIG01236536 FIG01236537: hypothetical protein +FIG01236537 FIG01236538: hypothetical protein +FIG01236538 YckD +FIG01236552 FIG01236556: hypothetical protein +FIG01236556 FIG01236558: hypothetical protein +FIG01236562 FIG01236565: hypothetical protein +FIG01236566 FIG01236568: hypothetical protein +FIG01236568 DNA polymerase( EC:2.7.7.7 ) +FIG01236574 FIG01236576: hypothetical protein +FIG01236576 FIG01236578: hypothetical protein +FIG01236596 FIG01236597: hypothetical protein +FIG01236602 FIG01236603: hypothetical protein +FIG01236609 Enterotoxin; possible non-hemolytic enterotoxin lytic component L1 +FIG01236615 FIG01236616: hypothetical protein +FIG01236620 Carbon starvation induced protein CsiD +FIG01236624 FIG01236625: hypothetical protein +FIG01236627 FIG01236628: hypothetical protein +FIG01236628 FIG01236629: hypothetical protein +FIG01236632 FIG01236633: hypothetical protein +FIG01236635 CDS_ID OB3077 +FIG01236647 FIG01236650: hypothetical protein +FIG01236651 FIG01236654: hypothetical protein +FIG01236658 FIG01236665: hypothetical protein +FIG01236665 FIG01236666: hypothetical protein +FIG01236672 FIG01236673: hypothetical protein +FIG01236676 FIG01236679: hypothetical protein +FIG01236680 FIG01236681: hypothetical protein +FIG01236681 FIG01236682: hypothetical protein +FIG01236682 hypothetical protein +FIG01236685 FIG01236686: hypothetical protein +FIG01236686 FIG01236687: hypothetical protein +FIG01236687 FIG01236688: hypothetical protein +FIG01236690 FIG01236693: hypothetical protein +FIG01236693 FIG01236695: hypothetical protein +FIG01236695 General substrate transporter:Protein of unknown function DUF1228:Major facilitator superfamily MFS_1 +FIG01236698 FIG01236700: hypothetical protein +FIG01236701 FIG01236703: hypothetical protein +FIG01236716 FIG01236717: hypothetical protein +FIG01236719 SspJ +FIG01236724 hypothetical protein +FIG01236725 FIG01236729: hypothetical protein +FIG01236746 FIG01236749: hypothetical protein +FIG01236749 FIG01236752: hypothetical protein +FIG01236767 FIG01236772: hypothetical protein +FIG01236774 MAEBL, putative +FIG01236783 FIG01236784: hypothetical protein +FIG01236785 FIG01236791: hypothetical protein +FIG01236795 Uncharacterized protein ykuH precursor +FIG01236805 high-affinity nickel-transporter +FIG01236810 FIG01236811: hypothetical protein +FIG01236812 enhancin family protein +FIG01236818 CueR +FIG01236821 probable transcriptional regulator YdhC +FIG01236822 FIG01236825: hypothetical protein +FIG01236828 FIG01236829: hypothetical protein +FIG01236837 FIG01236838: hypothetical protein +FIG01236838 pXO1-01 +FIG01236841 FIG01236847: hypothetical protein +FIG01236857 FIG01236862: hypothetical protein +FIG01236862 FIG01236863: hypothetical protein +FIG01236863 FIG01236864: hypothetical protein +FIG01236874 FIG01236875: hypothetical protein +FIG01236883 FIG01236884: hypothetical protein +FIG01236884 FIG01236885: hypothetical protein +FIG01236885 FIG01236888: hypothetical protein +FIG01236892 FIG01236894: hypothetical protein +FIG01236894 FIG01236897: hypothetical protein +FIG01236899 FIG01236902: hypothetical protein +FIG01236904 FIG01236906: hypothetical protein +FIG01236906 UDP-galactose-lipid carrier transferase (EC 2.-.-.-) +FIG01236911 FIG01236914: hypothetical protein +FIG01236914 FIG01236915: hypothetical protein +FIG01236918 FIG01236920: hypothetical protein +FIG01236920 FIG01236921: hypothetical protein +FIG01236921 FIG01236923: hypothetical protein +FIG01236923 FIG01236926: hypothetical protein +FIG01236926 FIG01236928: hypothetical protein +FIG01236930 FIG01236931: hypothetical protein +FIG01236934 Small acid-soluble spore protein, alpha/beta type +FIG01236936 FIG01236937: hypothetical protein +FIG01236943 FIG01236946: hypothetical protein +FIG01236947 FIG01236949: hypothetical protein +FIG01236951 FIG01236952: hypothetical protein +FIG01236952 FIG01236953: hypothetical protein +FIG01236957 FIG01236959: hypothetical protein +FIG01236963 FIG01236965: hypothetical protein +FIG01236979 diamine N-acetyltransferase (spermine/spermidine acetyltransferase)( EC:2.3.1.57 ) +FIG01236983 FIG01236985: hypothetical protein +FIG01236987 FIG01236989: hypothetical protein +FIG01236996 Possible acyl-[acyl-carrier protein] desaturase (EC 1.14.19.2) +FIG01237004 YwbO +FIG01237006 FIG01237011: hypothetical protein +FIG01237012 hypothetical protein +FIG01237014 FIG01237015: hypothetical protein +FIG01237015 FIG01237017: hypothetical protein +FIG01237017 FIG01237025: hypothetical protein +FIG01237026 FIG01237027: hypothetical protein +FIG01237027 FIG01237029: hypothetical protein +FIG01237033 FIG01237036: hypothetical protein +FIG01237036 hypothetical protein( EC:3.1.21.- ) +FIG01237054 Ferrichrome transport system permease protein fhuG +FIG01237061 FIG01237063: hypothetical protein +FIG01237065 FIG01237067: hypothetical protein +FIG01237069 FIG01237073: hypothetical protein +FIG01237073 FIG01237074: hypothetical protein +FIG01237074 FIG01237075: hypothetical protein +FIG01237075 FIG01237077: hypothetical protein +FIG01237077 FIG01237082: hypothetical protein +FIG01237082 FIG01237087: hypothetical protein +FIG01237087 putative glycosyl-transferase +FIG01237092 FIG01237095: hypothetical protein +FIG01237099 FIG01237100: hypothetical protein +FIG01237106 FIG01237107: hypothetical protein +FIG01237115 FIG01237116: hypothetical protein +FIG01237116 pre-ComX modifying enzyme +FIG01237117 FIG01237118: hypothetical protein +FIG01237119 FIG01237121: hypothetical protein +FIG01237123 FIG01237125: hypothetical protein +FIG01237130 FIG01237131: hypothetical protein +FIG01237131 FIG01237134: hypothetical protein +FIG01237134 FIG01237135: hypothetical protein +FIG01237147 FIG01237149: hypothetical protein +FIG01237149 FIG01237150: hypothetical protein +FIG01237158 FIG01237161: hypothetical protein +FIG01237161 FIG01237163: hypothetical protein +FIG01237163 FIG01237164: hypothetical protein +FIG01237177 FIG01237178: hypothetical protein +FIG01237178 FIG01237180: hypothetical protein +FIG01237181 FIG01237184: hypothetical protein +FIG01237188 sugar ABC transporter (sugar-binding protein) +FIG01237190 Bacteriocin-associated integral membrane protein +FIG01237201 FIG01237203: hypothetical protein +FIG01237203 FIG01237210: hypothetical protein +FIG01237210 FIG01237212: hypothetical protein +FIG01237226 btrG family protein +FIG01237233 FIG01237234: hypothetical protein +FIG01237237 FIG01237239: hypothetical protein +FIG01237260 FIG01237261: hypothetical protein +FIG01237261 FIG01237266: hypothetical protein +FIG01237266 YfmK +FIG01237268 FIG01237270: hypothetical protein +FIG01237270 FIG01237273: hypothetical protein +FIG01237274 FIG01237275: hypothetical protein +FIG01237275 FIG01237276: hypothetical protein +FIG01237282 FIG01237283: hypothetical protein +FIG01237283 FIG01237285: hypothetical protein +FIG01237285 FIG01237286: hypothetical protein +FIG01237288 FIG01237289: hypothetical protein +FIG01237294 pectate lyase( EC:4.2.2.2 ) +FIG01237305 NAD(P)H dehydrogenase( EC:3.1.4.14 ) +FIG01237311 Xanthine dehydrogenase (molybdopterin-guanine dinucleotide biosynthesis subunit)( EC:1.1.1.204 ) +FIG01237312 FIG01237313: hypothetical protein +FIG01237313 FIG01237315: hypothetical protein +FIG01237325 FIG01237326: hypothetical protein +FIG01237327 FIG01237328: hypothetical protein +FIG01237329 FIG01237330: hypothetical protein +FIG01237335 nuclease inhibitor +FIG01237342 FIG01237347: hypothetical protein +FIG01237348 FIG01237350: hypothetical protein +FIG01237354 FIG01237355: hypothetical protein +FIG01237356 FIG01237357: hypothetical protein +FIG01237361 FIG01237362: hypothetical protein +FIG01237362 FIG01237363: hypothetical protein +FIG01237363 OrfX +FIG01237366 hypothetical protein +FIG01237368 FIG01237370: hypothetical protein +FIG01237370 FIG01237371: hypothetical protein +FIG01237382 FIG01237384: hypothetical protein +FIG01237386 FIG01237389: hypothetical protein +FIG01237389 FIG01237391: hypothetical protein +FIG01237391 FIG01237393: hypothetical protein +FIG01237394 FIG01237395: hypothetical protein +FIG01237396 FIG01237402: hypothetical protein +FIG01237402 FIG01237403: hypothetical protein +FIG01237403 FIG01237406: hypothetical protein +FIG01237409 Uncharacterized transporter yybO +FIG01237412 FIG01237413: hypothetical protein +FIG01237413 FIG01237414: hypothetical protein +FIG01237424 FIG01237425: hypothetical protein +FIG01237425 FIG01237426: hypothetical protein +FIG01237429 adh_zinc, Zinc-binding dehydrogenases +FIG01237445 FIG01237446: hypothetical protein +FIG01237446 FIG01237449: hypothetical protein +FIG01237449 FIG01237450: hypothetical protein +FIG01237452 FIG01237453: hypothetical protein +FIG01237456 FIG01237457: hypothetical protein +FIG01237459 FIG01237460: hypothetical protein +FIG01237462 FIG01237468: hypothetical protein +FIG01237480 FIG01237481: hypothetical protein +FIG01237485 FIG01237488: hypothetical protein +FIG01237500 FIG01237501: hypothetical protein +FIG01237501 Tail length tape measure protein +FIG01237510 FIG01237512: hypothetical protein +FIG01237515 phage-related protein YmaC +FIG01237517 FIG01237518: hypothetical protein +FIG01237520 IDEAL domain-containing protein +FIG01237521 FIG01237522: hypothetical protein +FIG01237524 Acetolactate synthase, large subunit( EC:2.2.1.6 ) +FIG01237525 FIG01237526: hypothetical protein +FIG01237528 FIG01237529: hypothetical protein +FIG01237529 FIG01237530: hypothetical protein +FIG01237537 FIG01237538: hypothetical protein +FIG01237539 FIG01237540: hypothetical protein +FIG01237540 FIG01237543: hypothetical protein +FIG01237545 hypothetical protein +FIG01237553 FIG01237555: hypothetical protein +FIG01237555 FIG01237558: hypothetical protein +FIG01237558 FIG01237565: hypothetical protein +FIG01237571 possible recombination protein, phage associated +FIG01237576 FIG01237578: hypothetical protein +FIG01237578 FIG01237580: hypothetical protein +FIG01237580 FIG01237584: hypothetical protein +FIG01237589 FIG01237590: hypothetical protein +FIG01237590 FIG01237594: hypothetical protein +FIG01237601 FIG01237605: hypothetical protein +FIG01237610 FIG01237611: hypothetical protein +FIG01237620 FIG01237623: hypothetical protein +FIG01237623 FIG01237626: hypothetical protein +FIG01237626 FIG01237629: hypothetical protein +FIG01237630 FIG01237632: hypothetical protein +FIG01237632 YdjO +FIG01237633 FIG01237635: hypothetical protein +FIG01237647 FIG01237649: hypothetical protein +FIG01237649 FIG01237653: hypothetical protein +FIG01237661 5-methylcytosine-specific restriction enzyme A( EC:3.1.21.- ) +FIG01237668 N-acetylmuramoyl-L-alanine amidase CwlH implicated in mother cell lysis (EC 3.5.1.28) +FIG01237672 FIG01237676: hypothetical protein +FIG01237680 FIG01237683: hypothetical protein +FIG01237683 FIG01237685: hypothetical protein +FIG01237691 FIG01237694: hypothetical protein +FIG01237694 FIG01237695: hypothetical protein +FIG01237695 FIG01237696: hypothetical protein +FIG01237707 FIG01237710: hypothetical protein +FIG01237711 FIG01237713: hypothetical protein +FIG01237714 FIG01237717: hypothetical protein +FIG01237717 FIG01237718: hypothetical protein +FIG01237729 FIG01237730: hypothetical protein +FIG01237736 FIG01237743: hypothetical protein +FIG01237743 Sporulation control protein Spo0M +FIG01237746 FIG01237747: hypothetical protein +FIG01237761 FIG01237762: hypothetical protein +FIG01237767 FIG01237769: hypothetical protein +FIG01237772 pfs protein, putative +FIG01237778 FIG01237779: hypothetical protein +FIG01237779 FIG01237781: hypothetical protein +FIG01237781 Complete genome +FIG01237801 FIG01237802: hypothetical protein +FIG01237806 FIG01237807: hypothetical protein +FIG01237807 YKOI +FIG01237815 FIG01237816: hypothetical protein +FIG01237822 FIG01237824: hypothetical protein +FIG01237826 FIG01237829: hypothetical protein +FIG01237839 DNA primase +FIG01237844 FIG01237845: hypothetical protein +FIG01237855 FIG01237856: hypothetical protein +FIG01237861 putative RNA polymerase, sigma 28 subunit, FliA/WhiG family +FIG01237866 FIG01237872: hypothetical protein +FIG01237872 FIG01237880: hypothetical protein +FIG01237880 FIG01237881: hypothetical protein +FIG01237882 YxiC +FIG01237891 FIG01237894: hypothetical protein +FIG01237894 multidrug resistance protein; possible tetracycline resistance determinant +FIG01237901 FIG01237903: hypothetical protein +FIG01237903 FIG01237904: hypothetical protein +FIG01237904 FIG01237905: hypothetical protein +FIG01237906 FIG01237914: hypothetical protein +FIG01237915 acetylornithine aminotransferase( EC:2.6.1.11 ) +FIG01237919 FIG01237921: hypothetical protein +FIG01237921 FIG01237924: hypothetical protein +FIG01237929 Bacteriophage-related protein +FIG01237938 protease synthase and sporulation negative regulatory protein PAI 1 +FIG01237950 bifunctional DNA polymerase III subunit epsilon/ATP-dependent DNA helicase +FIG01237965 FIG01237966: hypothetical protein +FIG01237971 FIG01237972: hypothetical protein +FIG01237972 FIG01237974: hypothetical protein +FIG01237979 FIG01237983: hypothetical protein +FIG01237983 FIG01237984: hypothetical protein +FIG01238002 FIG01238004: hypothetical protein +FIG01238004 FIG01238006: hypothetical protein +FIG01238013 FIG01238015: hypothetical protein +FIG01238015 FIG01238016: hypothetical protein +FIG01238020 FIG01238021: hypothetical protein +FIG01238021 FIG01238025: hypothetical protein +FIG01238025 FIG01238026: hypothetical protein +FIG01238026 FIG01238032: hypothetical protein +FIG01238043 FIG01238044: hypothetical protein +FIG01238055 FIG01238056: hypothetical protein +FIG01238056 FIG01238057: hypothetical protein +FIG01238057 FIG01238059: hypothetical protein +FIG01238059 FIG01238064: hypothetical protein +FIG01238070 DNA double-strand break repair protein Mre11 +FIG01238077 ABC transporter ATP-binding protein, C-terminus +FIG01238083 FIG01238084: hypothetical protein +FIG01238108 FIG00895131: hypothetical protein +FIG01238116 FIG01238117: hypothetical protein +FIG01238118 FIG01238120: hypothetical protein +FIG01238125 SAM-dependent methyltransferase YafE (UbiE paralog) +FIG01238128 FIG01238129: hypothetical protein +FIG01238129 FIG01238132: hypothetical protein +FIG01238132 FIG01238135: hypothetical protein +FIG01238135 FIG01243770: hypothetical protein +FIG01238141 FIG01238145: hypothetical protein +FIG01238150 FIG01238151: hypothetical protein +FIG01238151 FIG01238152: hypothetical protein +FIG01238154 acid phosphatase/vanadium-dependent haloperoxidase related +FIG01238157 FIG01238160: hypothetical protein +FIG01238161 FIG01238166: hypothetical protein +FIG01238166 FIG01238169: hypothetical protein +FIG01238172 FIG01238175: hypothetical protein +FIG01238180 FIG01238182: hypothetical protein +FIG01238189 FIG01238195: hypothetical protein +FIG01238195 FIG01238196: hypothetical protein +FIG01238196 FIG01238197: hypothetical protein +FIG01238197 FIG01238198: hypothetical protein +FIG01238207 FIG01238210: hypothetical protein +FIG01238212 FIG01238213: hypothetical protein +FIG01238213 Soluble lytic murein transglycosylase / N-acetylmuramoyl-L-alanine amidase( EC:3.2.1.-,EC:3.5.1.28 ) +FIG01238218 FIG01238219: hypothetical protein +FIG01238219 FIG01238220: hypothetical protein +FIG01238223 FIG01238226: hypothetical protein +FIG01238228 FIG01238230: hypothetical protein +FIG01238230 FIG01238231: hypothetical protein +FIG01238232 FIG01238233: hypothetical protein +FIG01238233 FIG01238236: hypothetical protein +FIG01238237 FIG01238239: hypothetical protein +FIG01238249 FIG01238251: hypothetical protein +FIG01238254 FIG01238257: hypothetical protein +FIG01238259 hypothetical protein BB14905_22168 +FIG01238262 prophage LambdaBa02, DNA replication protein +FIG01238263 FIG01238270: hypothetical protein +FIG01238274 FIG01238275: hypothetical protein +FIG01238275 FIG01238276: hypothetical protein +FIG01238276 FIG01238277: hypothetical protein +FIG01238293 FIG01238295: hypothetical protein +FIG01238295 FIG01238299: hypothetical protein +FIG01238301 FIG01238305: hypothetical protein +FIG01238319 Protein of unknown function DUF606 +FIG01238321 FIG01238323: hypothetical protein +FIG01238325 FIG01238327: hypothetical protein +FIG01238328 FIG01238330: hypothetical protein +FIG01238335 FIG01238336: hypothetical protein +FIG01238336 FIG01238337: hypothetical protein +FIG01238337 FIG01238341: hypothetical protein +FIG01238341 FIG01238343: hypothetical protein +FIG01238343 FIG01238344: hypothetical protein +FIG01238349 FIG01238350: hypothetical protein +FIG01238380 Phosphoesterase +FIG01238383 FIG01238384: hypothetical protein +FIG01238389 FIG01238396: hypothetical protein +FIG01238400 FIG01238402: hypothetical protein +FIG01238405 FIG01238406: hypothetical protein +FIG01238411 FIG01238413: hypothetical protein +FIG01238424 FIG01238431: hypothetical protein +FIG01238432 FIG01238435: hypothetical protein +FIG01238435 glycosyl transferase, group 2 family protein/polysaccharide deacetylase family protein +FIG01238436 FIG01238437: hypothetical protein +FIG01238442 FIG01238450: hypothetical protein +FIG01238450 FIG01238451: hypothetical protein +FIG01238458 FIG01238459: hypothetical protein +FIG01238459 FIG01238460: hypothetical protein +FIG01238460 FIG01238462: hypothetical protein +FIG01238467 FIG01238468: hypothetical protein +FIG01238498 FIG01238504: hypothetical protein +FIG01238506 FIG01238508: hypothetical protein +FIG01238518 gene 31.2 +FIG01238520 FIG01238522: hypothetical protein +FIG01238524 FIG01238525: hypothetical protein +FIG01238525 FIG01238529: hypothetical protein +FIG01238529 FIG01238534: hypothetical protein +FIG01238538 FIG01238541: hypothetical protein +FIG01238549 FIG01238552: hypothetical protein +FIG01238552 Methyltransferase( EC:2.1.1.- ) +FIG01238557 Tetracycline resistance protein +FIG01238559 FIG01238560: hypothetical protein +FIG01238562 FIG01238565: hypothetical protein +FIG01238567 FIG01238569: hypothetical protein +FIG01238570 FIG01238574: hypothetical protein +FIG01238574 FIG01238575: hypothetical protein +FIG01238579 FIG01238580: hypothetical protein +FIG01238583 FIG01238585: hypothetical protein +FIG01238585 FIG01238586: hypothetical protein +FIG01238592 protein of unknown function +FIG01238593 FIG01238594: hypothetical protein +FIG01238594 Bipolar DNA helicase +FIG01238595 FIG01238598: hypothetical protein +FIG01238605 FIG01238609: hypothetical protein +FIG01238611 FIG01238614: hypothetical protein +FIG01238615 serine/threonine protein phosphatase family +FIG01238623 FIG01238624: hypothetical protein +FIG01238634 FIG01238638: hypothetical protein +FIG01238640 FIG01238641: hypothetical protein +FIG01238641 FIG01238645: hypothetical protein +FIG01238650 FIG01238653: hypothetical protein +FIG01238653 Uncharacterized protein yczH +FIG01238657 FIG01238666: hypothetical protein +FIG01238666 FIG01238667: hypothetical protein +FIG01238667 Conserved phage protein +FIG01238668 FIG01238671: hypothetical protein +FIG01238671 FIG01238673: hypothetical protein +FIG01238680 antigen 332, putative +FIG01238681 FIG01238686: hypothetical protein +FIG01238686 FIG01238687: hypothetical protein +FIG01238687 FIG01238688: hypothetical protein +FIG01238690 putative SPbeta phage repressor +FIG01238697 FIG01238700: hypothetical protein +FIG01238700 probable endoglucanase +FIG01238714 FIG01238715: hypothetical protein +FIG01238717 probable intracellular serine protease( EC:3.4.21.- ) +FIG01238718 FIG01238723: hypothetical protein +FIG01238730 S-layer protein / Peptidoglycan endo-beta-N-acetylglucosaminidase +FIG01238734 FIG01238735: hypothetical protein +FIG01238761 FIG01238763: hypothetical protein +FIG01238765 FIG01238770: hypothetical protein +FIG01238773 FIG01238776: hypothetical protein +FIG01238778 FIG01238780: hypothetical protein +FIG01238782 FIG01238789: hypothetical protein +FIG01238791 FIG01238794: hypothetical protein +FIG01238796 Tyrosinase/Peptidase +FIG01238800 FIG01238801: hypothetical protein +FIG01238802 FIG01238803: hypothetical protein +FIG01238813 FIG01238814: hypothetical protein +FIG01238819 FIG01238821: hypothetical protein +FIG01238833 FIG01238836: hypothetical protein +FIG01238836 FIG01238839: hypothetical protein +FIG01238843 FIG01238844: hypothetical protein +FIG01238855 FIG01238856: hypothetical protein +FIG01238856 FIG01238857: hypothetical protein +FIG01238868 FIG01238871: hypothetical protein +FIG01238892 FIG01238896: hypothetical protein +FIG01238896 FIG01238897: hypothetical protein +FIG01238897 FIG01238900: hypothetical protein +FIG01238900 FIG01238903: hypothetical protein +FIG01238903 YhjO +FIG01238904 FIG01238905: hypothetical protein +FIG01238905 FIG01238907: hypothetical protein +FIG01238911 FIG01238919: hypothetical protein +FIG01238931 hypothetical protein +FIG01238932 FIG01238935: hypothetical protein +FIG01238935 hypothetical protein +FIG01238940 FIG01238942: hypothetical protein +FIG01238951 FIG01238953: hypothetical protein +FIG01238953 YwsB +FIG01238955 FIG01238956: hypothetical protein +FIG01238956 Phage related protein, YorS B.subtilis homolog +FIG01238977 FIG01238978: hypothetical protein +FIG01238987 FIG01238988: hypothetical protein +FIG01238988 FIG01238990: hypothetical protein +FIG01238991 FIG01238992: hypothetical protein +FIG01238996 FIG01238997: hypothetical protein +FIG01239003 hypothetical protein +FIG01239033 FIG01239035: hypothetical protein +FIG01239035 FIG01239036: hypothetical protein +FIG01239036 FIG01239039: hypothetical protein +FIG01239039 FIG01239044: hypothetical protein +FIG01239046 FIG01239047: hypothetical protein +FIG01239053 FIG01239054: hypothetical protein +FIG01239057 FIG01239058: hypothetical protein +FIG01239058 Spore coat F-containing protein +FIG01239059 Uncharacterized protein yxzG +FIG01239065 FIG01239066: hypothetical protein +FIG01239066 probable component of a germinant receptor +FIG01239067 FIG01239068: hypothetical protein +FIG01239072 FIG01239074: hypothetical protein +FIG01239074 FIG01239075: hypothetical protein +FIG01239079 FIG01239080: hypothetical protein +FIG01239080 FIG01239086: hypothetical protein +FIG01239086 FIG01239087: hypothetical protein +FIG01239099 FIG01239100: hypothetical protein +FIG01239100 FIG01239101: hypothetical protein +FIG01239103 FIG01239104: hypothetical protein +FIG01239122 FIG01239123: hypothetical protein +FIG01239128 FIG01239131: hypothetical protein +FIG01239142 FIG01239145: hypothetical protein +FIG01239150 FIG01239151: hypothetical protein +FIG01239157 FIG01239159: hypothetical protein +FIG01239160 FIG01239162: hypothetical protein +FIG01239164 FIG01239165: hypothetical protein +FIG01239165 FIG01239167: hypothetical protein +FIG01239186 FIG01239190: hypothetical protein +FIG01239194 FIG01239197: hypothetical protein +FIG01239208 FIG01239212: hypothetical protein +FIG01239213 FIG01239214: hypothetical protein +FIG01239217 FIG01239219: hypothetical protein +FIG01239226 FIG01239229: hypothetical protein +FIG01239229 FIG01239230: hypothetical protein +FIG01239230 FIG01239236: hypothetical protein +FIG01239241 oxidoreductase of aldo/keto reductase family, subgroup 1 +FIG01239248 FIG01239255: hypothetical protein +FIG01239255 FIG01239258: hypothetical protein +FIG01239258 FIG01239260: hypothetical protein +FIG01239260 FIG01239261: hypothetical protein +FIG01239265 potassium uptake protein, TrkH family +FIG01239267 FIG01239271: hypothetical protein +FIG01239271 FIG01239274: hypothetical protein +FIG01239274 FIG01239276: hypothetical protein +FIG01239276 FIG01239277: hypothetical protein +FIG01239279 BH0392 unknown conserved protein in B. subtilis +FIG01239280 FIG01239281: hypothetical protein +FIG01239293 FIG01239297: hypothetical protein +FIG01239301 FIG01239307: hypothetical protein +FIG01239311 FIG01239312: hypothetical protein +FIG01239313 FIG01239314: hypothetical protein +FIG01239320 FIG01239321: hypothetical protein +FIG01239321 FIG01239327: hypothetical protein +FIG01239327 FIG01239328: hypothetical protein +FIG01239330 FIG01239331: hypothetical protein +FIG01239333 FIG01239335: hypothetical protein +FIG01239349 FIG01239351: hypothetical protein +FIG01239361 FIG01239363: hypothetical protein +FIG01239363 Uncharacterized protein yqcC +FIG01239384 FIG01239385: hypothetical protein +FIG01239388 YeeF +FIG01239389 FIG01239390: hypothetical protein +FIG01239392 FIG01239393: hypothetical protein +FIG01239393 FIG01239395: hypothetical protein +FIG01239414 FIG01239415: hypothetical protein +FIG01239415 FIG01239416: hypothetical protein +FIG01239425 FIG01239426: hypothetical protein +FIG01239436 FIG01239437: hypothetical protein +FIG01239437 FIG01239442: hypothetical protein +FIG01239442 FIG01239445: hypothetical protein +FIG01239445 prophage LambdaBa02, DNA-binding protein +FIG01239449 FIG01239450: hypothetical protein +FIG01239450 FIG01239452: hypothetical protein +FIG01239452 FIG01239453: hypothetical protein +FIG01239453 Alkaline serine proteinase +FIG01239463 FIG01239466: hypothetical protein +FIG01239467 FIG01239471: hypothetical protein +FIG01239471 FIG01239475: hypothetical protein +FIG01239483 FIG01239484: hypothetical protein +FIG01239487 FIG01239489: hypothetical protein +FIG01239497 FIG01239499: hypothetical protein +FIG01239502 FIG01239503: hypothetical protein +FIG01239506 Uncharacterized protein ypzE +FIG01239507 FIG01239508: hypothetical protein +FIG01239511 FIG01239515: hypothetical protein +FIG01239515 FIG01239519: hypothetical protein +FIG01239528 FIG01239529: hypothetical protein +FIG01239532 FIG01239533: hypothetical protein +FIG01239533 FIG01239536: hypothetical protein +FIG01239543 FIG01239544: hypothetical protein +FIG01239554 FIG01239555: hypothetical protein +FIG01239571 FIG01239574: hypothetical protein +FIG01239574 FIG01239575: hypothetical protein +FIG01239576 FIG01239577: hypothetical protein +FIG01239586 DinB +FIG01239589 FIG01239590: hypothetical protein +FIG01239590 FIG01239592: hypothetical protein +FIG01239597 FIG01239598: hypothetical protein +FIG01239606 FIG01239609: hypothetical protein +FIG01239646 Domain of unknown function DUF1537 +FIG01239647 FIG01239649: hypothetical protein +FIG01239649 FIG01239650: hypothetical protein +FIG01239650 FIG01239651: hypothetical protein +FIG01239654 FIG01239655: hypothetical protein +FIG01239655 FIG01239658: hypothetical protein +FIG01239658 FIG01239661: hypothetical protein +FIG01239669 FIG01239671: hypothetical protein +FIG01239671 FIG01239672: hypothetical protein +FIG01239682 Alkaline phosphatase D precursor (EC 3.1.3.1) +FIG01239685 FIG01239688: hypothetical protein +FIG01239717 FIG01239719: hypothetical protein +FIG01239720 FIG01239721: hypothetical protein +FIG01239721 FIG01239722: hypothetical protein +FIG01239722 FIG01239726: hypothetical protein +FIG01239726 TetR +FIG01239733 FIG01239735: hypothetical protein +FIG01239736 FIG01239737: hypothetical protein +FIG01239737 Hypothetical protein, CF-7 family. Related to CAC1969 +FIG01239749 FIG01239751: hypothetical protein +FIG01239751 FIG01239754: hypothetical protein +FIG01239754 FIG01239755: hypothetical protein +FIG01239763 transcriptional regulator, lacI family protein +FIG01239764 FIG01239766: hypothetical protein +FIG01239766 FIG01239770: hypothetical protein +FIG01239770 FIG01239772: hypothetical protein +FIG01239773 hypothetical phage related protein +FIG01239783 FIG01239786: hypothetical protein +FIG01239786 major facilitator family transporter; possible chloramphenicol resistance protein +FIG01239792 FIG01239794: hypothetical protein +FIG01239803 FIG01239805: hypothetical protein +FIG01239807 FIG01239808: hypothetical protein +FIG01239810 FIG01239812: hypothetical protein +FIG01239812 FIG01239820: hypothetical protein +FIG01239823 FIG01239824: hypothetical protein +FIG01239826 FIG01239827: hypothetical protein +FIG01239833 protein of unknown function DUF1360 +FIG01239848 FIG01239852: hypothetical protein +FIG01239854 FIG01239855: hypothetical protein +FIG01239855 FIG01239856: hypothetical protein +FIG01239856 FIG01239861: hypothetical protein +FIG01239864 FIG01239869: hypothetical protein +FIG01239870 FIG01239871: hypothetical protein +FIG01239871 FIG01239875: hypothetical protein +FIG01239880 FIG01239886: hypothetical protein +FIG01239895 FIG01239897: hypothetical protein +FIG01239897 FIG01239898: hypothetical protein +FIG01239903 FIG01239906: hypothetical protein +FIG01239906 FIG01239907: hypothetical protein +FIG01239929 FIG01239937: hypothetical protein +FIG01239937 FIG01239940: hypothetical protein +FIG01239940 monooxygenase; possible 2-polyprenyl-6-methoxyphenol hydroxylase +FIG01239941 BH1181 unknown conserved protein +FIG01239948 FIG01239949: hypothetical protein +FIG01239950 probable permease, putative +FIG01239951 FIG01239953: hypothetical protein +FIG01239959 YoxA +FIG01239966 FIG01239969: hypothetical protein +FIG01239970 polysaccharide deacetylase, putative +FIG01239972 BH0450 unknown conserved protein +FIG01239977 FIG01239979: hypothetical protein +FIG01239979 FIG01239983: hypothetical protein +FIG01239989 FIG01239990: hypothetical protein +FIG01239994 FIG01239998: hypothetical protein +FIG01240002 phage related protein +FIG01240016 FIG01240017: hypothetical protein +FIG01240027 FIG01240028: hypothetical protein +FIG01240028 FIG01240031: hypothetical protein +FIG01240032 FIG01240034: hypothetical protein +FIG01240038 FIG01240041: hypothetical protein +FIG01240042 FIG01240043: hypothetical protein +FIG01240050 wall associated protein, putative +FIG01240051 FIG01240053: hypothetical protein +FIG01240053 FIG01240055: hypothetical protein +FIG01240055 FIG01240056: hypothetical protein +FIG01240060 FIG01240061: hypothetical protein +FIG01240063 FIG01240064: hypothetical protein +FIG01240072 FIG01240076: hypothetical protein +FIG01240079 FIG01240081: hypothetical protein +FIG01240088 FIG01240089: hypothetical protein +FIG01240106 FIG01240107: hypothetical protein +FIG01240109 FIG01240110: hypothetical protein +FIG01240111 FIG01240115: hypothetical protein +FIG01240119 FIG01240120: hypothetical protein +FIG01240120 FIG01240121: hypothetical protein +FIG01240125 pentapeptide repeat containing protein +FIG01240135 FIG01240146: hypothetical protein +FIG01240155 Pli0009 protein +FIG01240158 FIG01240159: hypothetical protein +FIG01240162 PXO2-37 +FIG01240164 FIG01240166: hypothetical protein +FIG01240167 FIG01240170: hypothetical protein +FIG01240170 FIG01240173: hypothetical protein +FIG01240173 FIG01240174: hypothetical protein +FIG01240174 FIG01240177: hypothetical protein +FIG01240177 FIG01240178: hypothetical protein +FIG01240178 FIG01240180: hypothetical protein +FIG01240183 FIG01240184: hypothetical protein +FIG01240188 FIG01240189: hypothetical protein +FIG01240189 FIG01240190: hypothetical protein +FIG01240216 FIG01240217: hypothetical protein +FIG01240224 FIG01240225: hypothetical protein +FIG01240225 FIG01240226: hypothetical protein +FIG01240228 FIG01240232: hypothetical protein +FIG01240232 FIG01240233: hypothetical protein +FIG01240233 FIG01240234: hypothetical protein +FIG01240241 FIG01240244: hypothetical protein +FIG01240244 FIG01240245: hypothetical protein +FIG01240248 FIG01240250: hypothetical protein +FIG01240253 FIG01240257: hypothetical protein +FIG01240285 FIG01240287: hypothetical protein +FIG01240304 FIG01240307: hypothetical protein +FIG01240307 FIG01240309: hypothetical protein +FIG01240309 hypothetical protein +FIG01240311 gene 31.1 +FIG01240315 FIG01240321: hypothetical protein +FIG01240325 FIG01240327: hypothetical protein +FIG01240336 FIG01240338: hypothetical protein +FIG01240340 FIG01240342: hypothetical protein +FIG01240342 hypothetical protein +FIG01240353 Hydralysin +FIG01240357 FIG01240361: hypothetical protein +FIG01240363 4-oxalocrotonate tautomerase +FIG01240365 FIG01240366: hypothetical protein +FIG01240369 FIG00675170: hypothetical protein +FIG01240388 FIG01240390: hypothetical protein +FIG01240390 FIG01240392: hypothetical protein +FIG01240395 FIG01240397: hypothetical protein +FIG01240411 FIG01240413: hypothetical protein +FIG01240413 FIG01240416: hypothetical protein +FIG01240416 FIG01240418: hypothetical protein +FIG01240425 FIG01240428: hypothetical protein +FIG01240430 FIG01240431: hypothetical protein +FIG01240431 Bacterial ring hydroxylating dioxygenase alpha-subunit +FIG01240432 FIG01240433: hypothetical protein +FIG01240445 FIG01240446: hypothetical protein +FIG01240448 FIG01240450: hypothetical protein +FIG01240467 FIG01240469: hypothetical protein +FIG01240469 FIG01240470: hypothetical protein +FIG01240470 FIG01240471: hypothetical protein +FIG01240478 Alcohol dehydrogenase, zinc containing +FIG01240479 Uncharacterized protein yhdX +FIG01240483 FIG01240484: hypothetical protein +FIG01240484 FIG01240486: hypothetical protein +FIG01240503 FIG01240505: hypothetical protein +FIG01240505 FIG01240507: hypothetical protein +FIG01240521 FIG01240525: hypothetical protein +FIG01240525 FIG01240527: hypothetical protein +FIG01240529 FIG01240532: hypothetical protein +FIG01240532 FIG01240533: hypothetical protein +FIG01240533 FIG01240536: hypothetical protein +FIG01240537 FIG01240539: hypothetical protein +FIG01240546 putative peptide transport system integral membrane protein +FIG01240548 FIG01240553: hypothetical protein +FIG01240556 FIG01240557: hypothetical protein +FIG01240559 FIG01240562: hypothetical protein +FIG01240564 FIG01240565: hypothetical protein +FIG01240566 FIG01240567: hypothetical protein +FIG01240567 FIG01240568: hypothetical protein +FIG01240568 FIG01240569: hypothetical protein +FIG01240569 FIG01240570: hypothetical protein +FIG01240572 FIG01202080: hypothetical protein +FIG01240573 FIG01240579: hypothetical protein +FIG01240580 cation antiporter (Na+/Ca2+) +FIG01240583 FIG01240585: hypothetical protein +FIG01240594 FIG01240603: hypothetical protein +FIG01240603 sensor histidine kinase +FIG01240608 FIG01240609: hypothetical protein +FIG01240620 FIG01240626: hypothetical protein +FIG01240626 FIG01240627: hypothetical protein +FIG01240628 FIG01240631: hypothetical protein +FIG01240635 FIG01240643: hypothetical protein +FIG01240651 FIG01240652: hypothetical protein +FIG01240656 RepA protein +FIG01240660 FIG01240663: hypothetical protein +FIG01240667 FIG01240668: hypothetical protein +FIG01240683 FIG01240685: hypothetical protein +FIG01240691 FIG01240693: hypothetical protein +FIG01240696 Surfactin synthetase subunit 1 +FIG01240718 FIG01240719: hypothetical protein +FIG01240730 Sterol-regulatory element binding protein (SREBP) site 2 protease family protein +FIG01240736 Butirosin biosynthesis protein BtrG +FIG01240738 FIG01240739: hypothetical protein +FIG01240739 FIG01240740: hypothetical protein +FIG01240743 Uncharacterized oxidoreductase yqjQ (EC 1.-.-.-) +FIG01240755 FIG01240756: hypothetical protein +FIG01240756 acid-soluble spore protein H +FIG01240757 conserved protein YdaT +FIG01240767 FIG01240768: hypothetical protein +FIG01240778 FIG01240783: hypothetical protein +FIG01240783 FIG01240784: hypothetical protein +FIG01240784 FIG01240788: hypothetical protein +FIG01240796 FIG01240797: hypothetical protein +FIG01240797 Oxidoreductase, aldo/keto reductase family protein +FIG01240798 FIG01240799: hypothetical protein +FIG01240799 FIG01240801: hypothetical protein +FIG01240819 FIG01240821: hypothetical protein +FIG01240825 FIG01240826: hypothetical protein +FIG01240828 FIG01240829: hypothetical protein +FIG01240845 FIG01240846: hypothetical protein +FIG01240846 FIG01240847: hypothetical protein +FIG01240847 FIG01240849: hypothetical protein +FIG01240852 FIG01240853: hypothetical protein +FIG01240879 FIG01240881: hypothetical protein +FIG01240905 FIG01240909: hypothetical protein +FIG01240917 FIG01240918: hypothetical protein +FIG01240924 response regulator aspartate phosphatase E( EC:3.1.- ) +FIG01240930 FIG01240931: hypothetical protein +FIG01240948 FIG01240949: hypothetical protein +FIG01240952 FIG01240953: hypothetical protein +FIG01240953 FIG01240957: hypothetical protein +FIG01240957 nonribosomal peptide synthetase subunit +FIG01240959 FIG01240961: hypothetical protein +FIG01240968 FIG01240972: hypothetical protein +FIG01240973 FIG01240974: hypothetical protein +FIG01240974 FIG01240975: hypothetical protein +FIG01240978 FIG01240982: hypothetical protein +FIG01241004 gamma-carboxymuconolactone decarboxylase( EC:4.1.1.44 ) +FIG01241011 FIG01241012: hypothetical protein +FIG01241021 FIG01241023: hypothetical protein +FIG01241023 FIG01241024: hypothetical protein +FIG01241028 FIG01241032: hypothetical protein +FIG01241032 FIG01241033: hypothetical protein +FIG01241035 FIG01241039: hypothetical protein +FIG01241042 FIG01241046: hypothetical protein +FIG01241055 Toxic anion resistance protein TelA +FIG01241061 FIG01241062: hypothetical protein +FIG01241062 chemotaxis deficiency toward cysteine, proline, threonine, glycine, serine, lysine, valine and arginine +FIG01241064 FIG01241065: hypothetical protein +FIG01241071 FIG01241072: hypothetical protein +FIG01241082 FIG01241089: hypothetical protein +FIG01241089 FIG01241093: hypothetical protein +FIG01241094 FIG01241095: hypothetical protein +FIG01241095 LysE +FIG01241102 FIG01241106: hypothetical protein +FIG01241114 FIG01241115: hypothetical protein +FIG01241130 Macrolide glycosyltransferase( EC:2.4.1.- ) +FIG01241132 YqjF +FIG01241142 FIG01241143: hypothetical protein +FIG01241143 FIG01241146: hypothetical protein +FIG01241150 FIG01241160: hypothetical protein +FIG01241160 possible RNA polymerase sigma-B factor (Sigma-37) (General stress protein84) (GSP84) +FIG01241178 FIG01241180: hypothetical protein +FIG01241182 phage putative head morphogenesis protein, SPP1 gp7 family +FIG01241186 FIG01241191: hypothetical protein +FIG01241200 FIG01241204: hypothetical protein +FIG01241204 FIG01241208: hypothetical protein +FIG01241208 Glycosyl transferase, group 2 family protein (EC 2.4.-.-) +FIG01241209 YoeB +FIG01241219 right origin-binding protein +FIG01241220 FIG01241221: hypothetical protein +FIG01241221 FIG01241222: hypothetical protein +FIG01241224 FIG01241232: hypothetical protein +FIG01241233 FIG01241234: hypothetical protein +FIG01241238 FIG01241240: hypothetical protein +FIG01241241 XpaF1 protein +FIG01241247 FIG01241249: hypothetical protein +FIG01241253 FIG01241254: hypothetical protein +FIG01241257 FIG01241259: hypothetical protein +FIG01241262 FIG01241264: hypothetical protein +FIG01241264 FIG01241269: hypothetical protein +FIG01241271 FIG01241272: hypothetical protein +FIG01241272 FIG01241273: hypothetical protein +FIG01241273 FIG01241274: hypothetical protein +FIG01241291 FIG01241292: hypothetical protein +FIG01241300 FIG01241301: hypothetical protein +FIG01241311 FIG01241313: hypothetical protein +FIG01241313 FIG01241314: hypothetical protein +FIG01241315 FIG01241320: hypothetical protein +FIG01241321 FIG01241323: hypothetical protein +FIG01241328 5-methylcytosine-specific restriction related enzyme +FIG01241335 FIG01241341: hypothetical protein +FIG01241344 FIG01241347: hypothetical protein +FIG01241349 phosphoglycerate mutase family protein, C-terminal region( EC:5.4.2.1 ) +FIG01241350 FIG01241355: hypothetical protein +FIG01241359 FIG01241362: hypothetical protein +FIG01241362 FIG01241363: hypothetical protein +FIG01241364 FIG01241366: hypothetical protein +FIG01241366 FIG01241369: hypothetical protein +FIG01241369 FIG01241377: hypothetical protein +FIG01241398 3-oxoacyl-[acyl-carrier protein] reductase( EC:1.1.1.100 ) +FIG01241409 FIG01241410: hypothetical protein +FIG01241410 FIG01241420: hypothetical protein +FIG01241434 FIG01241436: hypothetical protein +FIG01241444 FIG01241446: hypothetical protein +FIG01241449 FIG01241450: hypothetical protein +FIG01241450 FIG01241459: hypothetical protein +FIG01241459 FIG01241461: hypothetical protein +FIG01241472 FIG01241474: hypothetical protein +FIG01241474 FIG01241477: hypothetical protein +FIG01241480 FIG01241486: hypothetical protein +FIG01241489 BH2866 unknown conserved protein in B. subtilis +FIG01241498 FIG01241501: hypothetical protein +FIG01241506 Stress-responsive transcriptional regulator PspC +FIG01241507 FIG01241508: hypothetical protein +FIG01241511 Alpha-arabinosides ABC transport system, permease protein AraQ +FIG01241528 FIG01241529: hypothetical protein +FIG01241531 FIG01241532: hypothetical protein +FIG01241532 FIG01241533: hypothetical protein +FIG01241548 FIG01241552: hypothetical protein +FIG01241552 FIG01241554: hypothetical protein +FIG01241554 glycosyltransferase (biosynthesis of lipopolisaccharide O antigen) +FIG01241555 FIG01241558: hypothetical protein +FIG01241560 YbfF +FIG01241562 FIG01241563: hypothetical protein +FIG01241574 FIG01241576: hypothetical protein +FIG01241577 FIG01241578: hypothetical protein +FIG01241582 putative aldo/keto reductase +FIG01241591 FIG01241594: hypothetical protein +FIG01241603 FIG01241606: hypothetical protein +FIG01241620 FIG01241622: hypothetical protein +FIG01241622 FIG01241627: hypothetical protein +FIG01241627 FIG01241628: hypothetical protein +FIG01241628 FIG01241633: hypothetical protein +FIG01241644 FIG01241645: hypothetical protein +FIG01241649 YhjA +FIG01241650 FIG01241651: hypothetical protein +FIG01241651 FIG01241653: hypothetical protein +FIG01241653 FIG01241656: hypothetical protein +FIG01241656 FIG01241658: hypothetical protein +FIG01241658 FIG01241659: hypothetical protein +FIG01241659 FIG01241660: hypothetical protein +FIG01241679 FIG01241681: hypothetical protein +FIG01241688 FIG01241689: hypothetical protein +FIG01241689 FIG01241690: hypothetical protein +FIG01241691 YrhK +FIG01241692 FIG01241694: hypothetical protein +FIG01241697 FIG01241699: hypothetical protein +FIG01241702 FIG01241705: hypothetical protein +FIG01241710 FIG01241711: hypothetical protein +FIG01241723 FIG01241724: hypothetical protein +FIG01241729 FIG01241730: hypothetical protein +FIG01241740 FIG01241746: hypothetical protein +FIG01241747 FIG01241754: hypothetical protein +FIG01241756 FIG01241761: hypothetical protein +FIG01241763 FIG01241764: hypothetical protein +FIG01241767 FIG01241771: hypothetical protein +FIG01241771 FIG01241772: hypothetical protein +FIG01241772 FIG01241773: hypothetical protein +FIG01241774 FIG01241775: hypothetical protein +FIG01241776 FIG01241779: hypothetical protein +FIG01241781 FIG01241785: hypothetical protein +FIG01241794 FIG01241795: hypothetical protein +FIG01241838 FIG01241840: hypothetical protein +FIG01241841 FIG01241842: hypothetical protein +FIG01241848 FIG01241851: hypothetical protein +FIG01241859 sporulation-specific SASP protein +FIG01241865 FIG01241869: hypothetical protein +FIG01241869 FIG01241870: hypothetical protein +FIG01241870 hypothetical protein +FIG01241900 FIG01241905: hypothetical protein +FIG01241915 FIG01241916: hypothetical protein +FIG01241916 FIG01241920: hypothetical protein +FIG01241920 FIG01241922: hypothetical protein +FIG01241925 FIG01241928: hypothetical protein +FIG01241934 FIG01241936: hypothetical protein +FIG01241947 FIG01241948: hypothetical protein +FIG01241962 FIG01241963: hypothetical protein +FIG01241973 thiol-disulfide oxidoreductase +FIG01241987 FIG01241988: hypothetical protein +FIG01242000 FIG01242001: hypothetical protein +FIG01242013 FIG01242016: hypothetical protein +FIG01242026 FIG01242027: hypothetical protein +FIG01242032 FIG01242034: hypothetical protein +FIG01242034 FIG01242037: hypothetical protein +FIG01242047 Pesticidal crystal protein cry8Ca (Insecticidal delta-endotoxin CryVIIIC(a)) (Crystaline entomocidal protoxin) (130 kDa crystal protein) +FIG01242052 Uncharacterized protein, containing predicted phosphatase domain +FIG01242053 FIG01242054: hypothetical protein +FIG01242059 FIG01242069: hypothetical protein +FIG01242072 FIG01242077: hypothetical protein +FIG01242077 FIG01242078: hypothetical protein +FIG01242078 Membrane translocator +FIG01242083 FIG01242084: hypothetical protein +FIG01242085 FIG01242086: hypothetical protein +FIG01242093 possible DNA-invertase, C-terminal region +FIG01242094 FIG01242095: hypothetical protein +FIG01242111 FIG01242112: hypothetical protein +FIG01242112 FIG01242113: hypothetical protein +FIG01242114 FIG01242118: hypothetical protein +FIG01242118 FIG01242120: hypothetical protein +FIG01242120 FIG01242121: hypothetical protein +FIG01242129 FIG01242131: hypothetical protein +FIG01242137 Uncharacterized membrane protein YdjJ +FIG01242150 FIG01242153: hypothetical protein +FIG01242154 conserved hypothetical protein, possible permease +FIG01242157 FIG01242161: hypothetical protein +FIG01242167 FIG01242169: hypothetical protein +FIG01242171 FIG01242172: hypothetical protein +FIG01242187 FIG01242188: hypothetical protein +FIG01242196 FIG01242197: hypothetical protein +FIG01242207 FIG01242208: hypothetical protein +FIG01242208 FIG01242209: hypothetical protein +FIG01242209 FIG01242211: hypothetical protein +FIG01242219 FIG01242227: hypothetical protein +FIG01242270 FIG01242279: hypothetical protein +FIG01242279 FIG01242287: hypothetical protein +FIG01242288 FIG01242289: hypothetical protein +FIG01242293 FIG01242295: hypothetical protein +FIG01242331 FIG01242333: hypothetical protein +FIG01242334 FIG01242335: hypothetical protein +FIG01242346 FIG01242348: hypothetical protein +FIG01242348 FIG01242349: hypothetical protein +FIG01242349 FIG01242353: hypothetical protein +FIG01242353 putative antibiotic hydrolase +FIG01242362 FIG01242363: hypothetical protein +FIG01242363 FIG01242365: hypothetical protein +FIG01242365 FIG01242368: hypothetical protein +FIG01242369 FIG01242370: hypothetical protein +FIG01242373 FIG01242375: hypothetical protein +FIG01242377 FIG01242378: hypothetical protein +FIG01242396 FIG01242401: hypothetical protein +FIG01242402 ABC transporter protein, putative +FIG01242404 FIG01242406: hypothetical protein +FIG01242416 FIG01242424: hypothetical protein +FIG01242424 FIG01242431: hypothetical protein +FIG01242452 FIG01242454: hypothetical protein +FIG01242454 FIG01242455: hypothetical protein +FIG01242455 FIG01242459: hypothetical protein +FIG01242460 FIG01242461: hypothetical protein +FIG01242461 FIG01242462: hypothetical protein +FIG01242462 FIG01242463: hypothetical protein +FIG01242476 FIG01242477: hypothetical protein +FIG01242477 FIG01242480: hypothetical protein +FIG01242481 FIG01242483: hypothetical protein +FIG01242488 FIG01242490: hypothetical protein +FIG01242493 Transcriptional regulator, Xre family +FIG01242501 FIG01242506: hypothetical protein +FIG01242537 FIG01242540: hypothetical protein +FIG01242544 FIG01242545: hypothetical protein +FIG01242552 FIG01242556: hypothetical protein +FIG01242559 FIG01242571: hypothetical protein +FIG01242571 FIG01242576: hypothetical protein +FIG01242577 FIG01242578: hypothetical protein +FIG01242585 FIG01242589: hypothetical protein +FIG01242592 hypothetical protein +FIG01242594 FIG01242595: hypothetical protein +FIG01242595 FIG01242600: hypothetical protein +FIG01242615 transcriptional regulator, C-terminus +FIG01242618 FIG01242623: hypothetical protein +FIG01242628 FIG01242629: hypothetical protein +FIG01242629 FIG01242631: hypothetical protein +FIG01242632 FIG01242635: hypothetical protein +FIG01242635 FIG01242636: hypothetical protein +FIG01242671 FIG01242673: hypothetical protein +FIG01242673 FIG01242674: hypothetical protein +FIG01242674 FIG01242675: hypothetical protein +FIG01242675 FIG01242676: hypothetical protein +FIG01242688 BH0680 unknown conserved protein in others +FIG01242689 FIG01242691: hypothetical protein +FIG01242692 FIG01242697: hypothetical protein +FIG01242697 FIG01242699: hypothetical protein +FIG01242704 FIG01242711: hypothetical protein +FIG01242711 geranylgeranyl hydrogenase BchP +FIG01242719 FIG01242720: hypothetical protein +FIG01242726 FIG01242728: hypothetical protein +FIG01242733 FIG01242735: hypothetical protein +FIG01242754 FIG01242755: hypothetical protein +FIG01242759 FIG01242761: hypothetical protein +FIG01242761 FIG01242762: hypothetical protein +FIG01242765 FIG01242766: hypothetical protein +FIG01242766 FIG01242767: hypothetical protein +FIG01242767 FIG01242769: hypothetical protein +FIG01242772 FIG01242777: hypothetical protein +FIG01242786 FIG01242787: hypothetical protein +FIG01242793 FIG01242796: hypothetical protein +FIG01242816 FIG01242824: hypothetical protein +FIG01242824 FIG01242825: hypothetical protein +FIG01242825 FIG01242826: hypothetical protein +FIG01242833 FIG01242834: hypothetical protein +FIG01242835 MutT/nudix family protein +FIG01242851 FIG01242852: hypothetical protein +FIG01242853 FIG01242854: hypothetical protein +FIG01242854 YybP +FIG01242857 FIG01242860: hypothetical protein +FIG01242868 FIG01242870: hypothetical protein +FIG01242870 FIG01242871: hypothetical protein +FIG01242871 FIG01242874: hypothetical protein +FIG01242891 probable transcriptional regulator YwqM +FIG01242896 FIG01242897: hypothetical protein +FIG01242900 FIG01242901: hypothetical protein +FIG01242901 FIG01242903: hypothetical protein +FIG01242914 FIG01242918: hypothetical protein +FIG01242918 FIG01242921: hypothetical protein +FIG01242921 FIG01242922: hypothetical protein +FIG01242937 FIG01242939: hypothetical protein +FIG01242957 FIG01242959: hypothetical protein +FIG01242959 FIG01242960: hypothetical protein +FIG01242960 Transcriptional repressor, BlaI/MecI family +FIG01242961 FIG01242968: hypothetical protein +FIG01242983 arsenical pump family protein +FIG01242984 Bacilysin biosynthesis protein BacA; Similarities with prephenate dehydratase +FIG01243023 FIG01243025: hypothetical protein +FIG01243045 FIG01243046: hypothetical protein +FIG01243058 FIG01243059: hypothetical protein +FIG01243059 FIG01243063: hypothetical protein +FIG01243067 FIG01243069: hypothetical protein +FIG01243074 FIG01243075: hypothetical protein +FIG01243077 FIG01243079: hypothetical protein +FIG01243087 FIG01243089: hypothetical protein +FIG01243092 FIG01243098: hypothetical protein +FIG01243109 FIG01243110: hypothetical protein +FIG01243110 FIG01243114: hypothetical protein +FIG01243135 FIG01243137: hypothetical protein +FIG01243138 FIG01243139: hypothetical protein +FIG01243142 FIG01243143: hypothetical protein +FIG01243156 FIG01243157: hypothetical protein +FIG01243173 FIG01243174: hypothetical protein +FIG01243185 FIG01243189: hypothetical protein +FIG01243190 FIG01243195: hypothetical protein +FIG01243195 FIG01243198: hypothetical protein +FIG01243202 FIG01243204: hypothetical protein +FIG01243204 FIG01243206: hypothetical protein +FIG01243218 FIG01243220: hypothetical protein +FIG01243220 FIG01243222: hypothetical protein +FIG01243223 FIG01243224: hypothetical protein +FIG01243233 FIG01243235: hypothetical protein +FIG01243242 possible dioxygenase +FIG01243260 major facilitator family transporter; possible multidrug efflux pump +FIG01243262 FIG01243263: hypothetical protein +FIG01243275 FIG01243277: hypothetical protein +FIG01243293 FIG01243294: hypothetical protein +FIG01243294 probable ornithine aminotransferase( EC:2.6.1.11 ) +FIG01243326 FIG01243327: hypothetical protein +FIG01243327 carboxylesterase NP +FIG01243343 FIG01243347: hypothetical protein +FIG01243356 hypothetical protein +FIG01243359 FIG01243363: hypothetical protein +FIG01243364 FIG01243365: hypothetical protein +FIG01243370 FIG01243373: hypothetical protein +FIG01243373 FIG01243374: hypothetical protein +FIG01243387 Bacillolysin +FIG01243393 FIG01243395: hypothetical protein +FIG01243399 FIG01243402: hypothetical protein +FIG01243408 FIG01243409: hypothetical protein +FIG01243411 FIG01243412: hypothetical protein +FIG01243413 FIG01243416: hypothetical protein +FIG01243422 FIG01243423: hypothetical protein +FIG01243426 FIG01243427: hypothetical protein +FIG01243427 serine O-acetyltransferase +FIG01243430 hypothetical protein +FIG01243433 YndL +FIG01243434 Uncharacterized protein ywoA +FIG01243435 FIG01243439: hypothetical protein +FIG01243450 FIG01243451: hypothetical protein +FIG01243453 FIG01243459: hypothetical protein +FIG01243459 FIG01243460: hypothetical protein +FIG01243462 FIG01243463: hypothetical protein +FIG01243476 YvpB-like protein +FIG01243485 Epidermin leader peptide processing serine protease EpiP (EC 3.4.21.-) +FIG01243489 FIG01243490: hypothetical protein +FIG01243490 FIG01243492: hypothetical protein +FIG01243498 FIG01243499: hypothetical protein +FIG01243510 FIG01243511: hypothetical protein +FIG01243521 FIG01243523: hypothetical protein +FIG01243523 FIG01243524: hypothetical protein +FIG01243524 FIG01243527: hypothetical protein +FIG01243532 FIG01243535: hypothetical protein +FIG01243566 FIG01243567: hypothetical protein +FIG01243575 FIG01243577: hypothetical protein +FIG01243581 FIG01243582: hypothetical protein +FIG01243599 FIG01243602: hypothetical protein +FIG01243603 Saccharopine dehydrogenase [NADP+, L-lysine forming] +FIG01243616 FIG01243622: hypothetical protein +FIG01243632 FIG01243638: hypothetical protein +FIG01243647 FIG01243648: hypothetical protein +FIG01243661 FIG01243662: hypothetical protein +FIG01243690 FIG01243691: hypothetical protein +FIG01243692 FIG01243693: hypothetical protein +FIG01243693 FIG01243696: hypothetical protein +FIG01243707 FIG01243708: hypothetical protein +FIG01243716 FIG01243719: hypothetical protein +FIG01243724 Uncharacterized protein yfkS +FIG01243732 FIG01243733: hypothetical protein +FIG01243735 Levanase (EC 3.2.1.65) +FIG01243740 FIG01243744: hypothetical protein +FIG01243746 FIG01243755: hypothetical protein +FIG01243755 FIG01243758: hypothetical protein +FIG01243761 FIG01243763: hypothetical protein +FIG01243765 FIG01243767: hypothetical protein +FIG01243771 Zwa5A +FIG01243779 FIG01243781: hypothetical protein +FIG01243781 FIG01243785: hypothetical protein +FIG01243785 FIG01243788: hypothetical protein +FIG01243801 FIG01243806: hypothetical protein +FIG01243806 hypothetical protein +FIG01243841 Azoreductase +FIG01243850 FIG01243852: hypothetical protein +FIG01243882 FIG01243883: hypothetical protein +FIG01243883 FIG01243886: hypothetical protein +FIG01243901 FIG01243903: hypothetical protein +FIG01243903 FIG01243904: hypothetical protein +FIG01243905 FIG01243906: hypothetical protein +FIG01243927 hypothetical protein +FIG01243936 FIG01243939: hypothetical protein +FIG01243939 FIG01243942: hypothetical protein +FIG01243945 FIG01243946: hypothetical protein +FIG01243948 FIG01243958: hypothetical protein +FIG01243969 FIG01243973: hypothetical protein +FIG01243975 FIG01243981: hypothetical protein +FIG01243981 FIG01243982: hypothetical protein +FIG01243985 FIG01243990: hypothetical protein +FIG01243997 FIG01243999: hypothetical protein +FIG01244005 FIG01244006: hypothetical protein +FIG01244006 FIG01244009: hypothetical protein +FIG01244009 FIG01244013: hypothetical protein +FIG01244013 FIG01244017: hypothetical protein +FIG01244017 FIG01244020: hypothetical protein +FIG01244021 FIG01244025: hypothetical protein +FIG01244034 FIG01244035: hypothetical protein +FIG01244037 FIG01244038: hypothetical protein +FIG01244047 gas vesicle protein GvpG +FIG01244054 FIG01244055: hypothetical protein +FIG01244059 FIG01244061: hypothetical protein +FIG01244065 FIG01244066: hypothetical protein +FIG01244068 FIG01244069: hypothetical protein +FIG01244070 FIG01244071: hypothetical protein +FIG01244080 TOMM biosynthesis cyclodehydratase (protein C) +FIG01244105 FIG01244106: hypothetical protein +FIG01244106 DNA-binding response regulator CiaR +FIG01244122 Gas vesicle structural protein B (GVP B) +FIG01244127 FIG01244129: hypothetical protein +FIG01244135 FIG01244137: hypothetical protein +FIG01244143 FIG01244145: hypothetical protein +FIG01244145 FIG01244146: hypothetical protein +FIG01244149 FIG01244157: hypothetical protein +FIG01244157 FIG01244161: hypothetical protein +FIG01244164 Tetrahydrodipicolinate N-succinyltransferase +FIG01244166 glycine dehydrogenase +FIG01244170 FIG01244176: hypothetical protein +FIG01244177 FIG01244178: hypothetical protein +FIG01244199 FIG01244200: hypothetical protein +FIG01244216 subtilisin Carlsberg( EC:3.4.21.62 ) +FIG01244229 FIG01244230: hypothetical protein +FIG01244230 FIG01244235: hypothetical protein +FIG01244255 FIG01244256: hypothetical protein +FIG01244271 FIG01244273: hypothetical protein +FIG01244292 lipase precursor +FIG01244293 FIG01244294: hypothetical protein +FIG01244298 FIG01244300: hypothetical protein +FIG01244300 FIG01244301: hypothetical protein +FIG01244329 FIG01244330: hypothetical protein +FIG01244331 conserved protein YwpF +FIG01244335 glycosyltransferase, GT2 family( EC:2.4.1.- ) +FIG01244337 FIG01244339: hypothetical protein +FIG01244361 FIG01244370: hypothetical protein +FIG01244371 FIG01244375: hypothetical protein +FIG01244394 FIG01244396: hypothetical protein +FIG01244402 FIG01244403: hypothetical protein +FIG01244409 FIG01244410: hypothetical protein +FIG01244410 FIG01244413: hypothetical protein +FIG01244416 FIG01244418: hypothetical protein +FIG01244421 FIG01244426: hypothetical protein +FIG01244426 FIG01244429: hypothetical protein +FIG01244430 FIG01244431: hypothetical protein +FIG01244431 FIG01244434: hypothetical protein +FIG01244434 Immune inhibitor A precursor +FIG01244439 FIG01244442: hypothetical protein +FIG01244444 FIG01244445: hypothetical protein +FIG01244445 COG1349: Transcriptional regulators of sugar metabolism +FIG01244450 FIG01244454: hypothetical protein +FIG01244455 FIG01244462: hypothetical protein +FIG01244465 FIG01244469: hypothetical protein +FIG01244472 FIG01244473: hypothetical protein +FIG01244478 invasion protein IagB domain protein +FIG01244481 FIG01244483: hypothetical protein +FIG01244483 FIG01244484: hypothetical protein +FIG01244486 FIG01244488: hypothetical protein +FIG01244488 FIG01244491: hypothetical protein +FIG01244492 FIG01244494: hypothetical protein +FIG01244505 FIG01244506: hypothetical protein +FIG01244506 FIG01244508: hypothetical protein +FIG01244508 FIG01244509: hypothetical protein +FIG01244515 FIG01244518: hypothetical protein +FIG01244541 FIG01244545: hypothetical protein +FIG01244553 Uncharacterized spore germination protein YndF +FIG01244564 magnesium citrate secondary transporter +FIG01244566 flagellar protein FlaG +FIG01244575 FIG01244577: hypothetical protein +FIG01244605 FIG01244606: hypothetical protein +FIG01244606 FIG01244607: hypothetical protein +FIG01244607 FIG01244608: hypothetical protein +FIG01244608 FIG01244609: hypothetical protein +FIG01244610 FIG01244620: hypothetical protein +FIG01244649 FIG01244655: hypothetical protein +FIG01244664 FIG01244666: hypothetical protein +FIG01244666 FIG01244667: hypothetical protein +FIG01244669 Uncharacterized HTH-type transcriptional regulator yurK +FIG01244673 MFS family major facilitator transporter, macrolide:cation symporter +FIG01244681 FIG01244684: hypothetical protein +FIG01244684 FIG01244689: hypothetical protein +FIG01244698 FIG01244699: hypothetical protein +FIG01244702 FIG01244703: hypothetical protein +FIG01244703 FIG01244704: hypothetical protein +FIG01244709 FIG01244713: hypothetical protein +FIG01244713 FIG01244717: hypothetical protein +FIG01244724 FIG01244729: hypothetical protein +FIG01244732 FIG01244734: hypothetical protein +FIG01244734 FIG01244736: hypothetical protein +FIG01244738 FIG01244739: hypothetical protein +FIG01244754 Probable amino-acid ABC transporter ATP-binding protein HI1078 +FIG01244756 FIG01244761: hypothetical protein +FIG01244771 FIG01244775: hypothetical protein +FIG01244775 FIG01244776: hypothetical protein +FIG01244781 FIG01244783: hypothetical protein +FIG01244788 FIG01244789: hypothetical protein +FIG01244795 FIG01244797: hypothetical protein +FIG01244812 putative glycosyl transferase Family 4 +FIG01244840 FIG01244847: hypothetical protein +FIG01244849 possible chromosomal replication initiator protein +FIG01244859 REP 14-3 protein +FIG01244865 hypothetical protein +FIG01244866 FIG01244867: hypothetical protein +FIG01244867 FIG01244874: hypothetical protein +FIG01244875 FIG01244880: hypothetical protein +FIG01244882 FIG01244883: hypothetical protein +FIG01244883 FIG01244890: hypothetical protein +FIG01244910 FIG01244913: hypothetical protein +FIG01244913 FIG01244918: hypothetical protein +FIG01244929 FIG01244930: hypothetical protein +FIG01244934 FIG01244938: hypothetical protein +FIG01244946 FIG01244951: hypothetical protein +FIG01244951 FIG01244955: hypothetical protein +FIG01244955 FIG01244957: hypothetical protein +FIG01244961 FIG01244962: hypothetical protein +FIG01244965 MFS family major facilitator transporter +FIG01244967 Possible DNA-binding protein +FIG01244968 FIG01244970: hypothetical protein +FIG01244981 FIG01244987: hypothetical protein +FIG01244997 FIG01244999: hypothetical protein +FIG01245035 D-Ribose 1,5-phosphomutase (EC 5.4.2.7) +FIG01245036 threonine dehydratase( EC:4.3.1.19 ) +FIG01245038 FIG01245040: hypothetical protein +FIG01245047 DNA, complete sequence +FIG01245050 FIG01245054: hypothetical protein +FIG01245062 YxkD +FIG01245069 FIG01245071: hypothetical protein +FIG01245079 FIG01245080: hypothetical protein +FIG01245080 FIG01245082: hypothetical protein +FIG01245088 FIG01245089: hypothetical protein +FIG01245089 YxbD +FIG01245092 FIG01245096: hypothetical protein +FIG01245107 protein of unknown function DUF227 +FIG01245110 FIG01245112: hypothetical protein +FIG01245115 FIG01245118: hypothetical protein +FIG01245127 FIG01245128: hypothetical protein +FIG01245135 FIG01245139: hypothetical protein +FIG01245156 FIG01245160: hypothetical protein +FIG01245164 FIG01245167: hypothetical protein +FIG01245168 FIG01245169: hypothetical protein +FIG01245174 ATP-binding membrane protein +FIG01245175 FIG01245178: hypothetical protein +FIG01245201 FIG01246635: hypothetical protein +FIG01245207 FIG01245211: hypothetical protein +FIG01245211 putative SAM dependent methyltransferase YrrH +FIG01245212 possible S-layer protein +FIG01245236 FIG01245239: hypothetical protein +FIG01245245 FIG01245249: hypothetical protein +FIG01245258 YqaQ +FIG01245277 FIG01245282: hypothetical protein +FIG01245294 FIG01245296: hypothetical protein +FIG01245298 Structural feature(s) predicted by Psort:Transmembrane: 15288 - 15272 +FIG01245300 FIG01245308: hypothetical protein +FIG01245319 TOMM export ABC transporter, permease protein +FIG01245325 FIG01245326: hypothetical protein +FIG01245326 FIG01245330: hypothetical protein +FIG01245333 COG3448: CBS-domain-containing membrane protein +FIG01245338 FIG01245340: hypothetical protein +FIG01245346 FIG01245349: hypothetical protein +FIG01245361 FIG01245364: hypothetical protein +FIG01245364 FIG01245368: hypothetical protein +FIG01245368 YoaF +FIG01245393 FIG01245394: hypothetical protein +FIG01245413 lipase/acylhydrolase, putative +FIG01245422 FIG01245426: hypothetical protein +FIG01245429 Uncharacterized protein yfjC +FIG01245431 FIG01245433: hypothetical protein +FIG01245433 FIG01245440: hypothetical protein +FIG01245440 FIG01245443: hypothetical protein +FIG01245448 FIG01245449: hypothetical protein +FIG01245450 FIG01245452: hypothetical protein +FIG01245461 3-beta hydroxysteroid dehydrogenase/isomerase:NmrA-like +FIG01245463 FIG01245464: hypothetical protein +FIG01245464 FIG01245465: hypothetical protein +FIG01245492 FIG01245493: hypothetical protein +FIG01245495 hypothetical protein( EC:3.1.- ) +FIG01245496 FIG01245498: hypothetical protein +FIG01245507 FIG01245510: hypothetical protein +FIG01245515 FIG01245516: hypothetical protein +FIG01245516 Purine efflux pump PbuE +FIG01245528 FIG01245529: hypothetical protein +FIG01245530 FIG01245532: hypothetical protein +FIG01245538 FIG01245541: hypothetical protein +FIG01245542 FIG01245545: hypothetical protein +FIG01245545 FIG01245548: hypothetical protein +FIG01245559 FIG01245560: hypothetical protein +FIG01245587 FIG01245593: hypothetical protein +FIG01245611 FIG01245613: hypothetical protein +FIG01245620 FIG01245621: hypothetical protein +FIG01245624 FIG01245625: hypothetical protein +FIG01245636 FIG01245639: hypothetical protein +FIG01245640 FIG01245642: hypothetical protein +FIG01245644 FIG01245646: hypothetical protein +FIG01245648 FIG01245650: hypothetical protein +FIG01245670 FIG01245673: hypothetical protein +FIG01245673 FIG01245674: hypothetical protein +FIG01245693 FIG01245696: hypothetical protein +FIG01245698 FIG01245700: hypothetical protein +FIG01245701 FIG01245704: hypothetical protein +FIG01245712 FIG01245714: hypothetical protein +FIG01245724 FIG01245725: hypothetical protein +FIG01245725 FIG01245728: hypothetical protein +FIG01245728 FIG01245733: hypothetical protein +FIG01245733 FIG01245734: hypothetical protein +FIG01245745 FIG01245749: hypothetical protein +FIG01245764 FIG01245765: hypothetical protein +FIG01245765 FIG01245766: hypothetical protein +FIG01245766 FIG01245767: hypothetical protein +FIG01245775 FIG01245776: hypothetical protein +FIG01245777 FIG01245778: hypothetical protein +FIG01245778 FIG01245780: hypothetical protein +FIG01245783 FIG01245785: hypothetical protein +FIG01245811 conserved membrane protein YetF +FIG01245812 FIG01245818: hypothetical protein +FIG01245821 FIG01245828: hypothetical protein +FIG01245845 FIG01245847: hypothetical protein +FIG01245853 FIG01245857: hypothetical protein +FIG01245863 FIG01245869: hypothetical protein +FIG01245869 FIG01245872: hypothetical protein +FIG01245878 FIG01245879: hypothetical protein +FIG01245881 FIG01245882: hypothetical protein +FIG01245893 FIG01245895: hypothetical protein +FIG01245899 FIG01245900: hypothetical protein +FIG01245907 FIG01245908: hypothetical protein +FIG01245916 FIG01245924: hypothetical protein +FIG01245930 FIG01245932: hypothetical protein +FIG01245937 type II restriction endonuclease +FIG01245947 FIG01245948: hypothetical protein +FIG01245959 FIG01245962: hypothetical protein +FIG01245963 hypothetical protein +FIG01245971 spore germination protein, GerC family +FIG01245991 FIG01245997: hypothetical protein +FIG01246008 FIG01246010: hypothetical protein +FIG01246011 FIG01246012: hypothetical protein +FIG01246020 FIG01246029: hypothetical protein +FIG01246044 FIG01246045: hypothetical protein +FIG01246045 FIG01246048: hypothetical protein +FIG01246051 FIG01246057: hypothetical protein +FIG01246073 FIG01246074: hypothetical protein +FIG01246102 FIG01246106: hypothetical protein +FIG01246116 FIG01246117: hypothetical protein +FIG01246120 FIG01246122: hypothetical protein +FIG01246139 FIG01246140: hypothetical protein +FIG01246176 FIG01246177: hypothetical protein +FIG01246197 FIG01246200: hypothetical protein +FIG01246203 Uncharacterized protein yrkC +FIG01246209 FIG01246210: hypothetical protein +FIG01246212 FIG01246213: hypothetical protein +FIG01246216 FIG01246219: hypothetical protein +FIG01246221 FIG01246228: hypothetical protein +FIG01246228 FIG01246229: hypothetical protein +FIG01246235 FIG01246236: hypothetical protein +FIG01246239 FIG01246242: hypothetical protein +FIG01246244 FIG01246249: hypothetical protein +FIG01246250 Type II restriction enzyme HpaII (EC 3.1.21.4) (Endonuclease HpaII) (R.HpaII) +FIG01246257 FIG01246258: hypothetical protein +FIG01246267 FIG01246274: hypothetical protein +FIG01246279 FIG01246289: hypothetical protein +FIG01246303 FIG01246308: hypothetical protein +FIG01246314 Proline iminopeptidase (EC 3.4.11.5) (PIP) (Prolyl aminopeptidase) (PAP) +FIG01246327 FIG01246328: hypothetical protein +FIG01246337 FIG01246338: hypothetical protein +FIG01246342 FIG01246344: hypothetical protein +FIG01246344 FIG01246348: hypothetical protein +FIG01246351 FIG01246352: hypothetical protein +FIG01246362 FIG01246363: hypothetical protein +FIG01246365 FIG01246367: hypothetical protein +FIG01246369 FIG01246370: hypothetical protein +FIG01246377 FIG01246378: hypothetical protein +FIG01246381 FIG01246382: hypothetical protein +FIG01246386 Glutathione synthase S6 modification +FIG01246390 FIG01246392: hypothetical protein +FIG01246396 FIG01246399: hypothetical protein +FIG01246399 alkaliphily related protein +FIG01246406 FIG01246408: hypothetical protein +FIG01246411 CGEA protein +FIG01246431 FIG01246432: hypothetical protein +FIG01246444 Hypothetical protein, CF-38 family +FIG01246445 FIG01246447: hypothetical protein +FIG01246461 FIG01246463: hypothetical protein +FIG01246466 PhrB +FIG01246508 FIG01246510: hypothetical protein +FIG01246510 FIG01246513: hypothetical protein +FIG01246513 Thermitase( EC:3.4.21.66 ) +FIG01246516 FIG01246517: hypothetical protein +FIG01246519 FIG01246520: hypothetical protein +FIG01246524 CDS_ID OB2637 +FIG01246562 FIG01246564: hypothetical protein +FIG01246567 FIG01246569: hypothetical protein +FIG01246569 FIG01246570: hypothetical protein +FIG01246581 FIG01246585: hypothetical protein +FIG01246586 FIG01246588: hypothetical protein +FIG01246594 FIG01246595: hypothetical protein +FIG01246603 FIG01246605: hypothetical protein +FIG01246622 FIG01246625: hypothetical protein +FIG01246635 FIG01246636: hypothetical protein +FIG01246646 FIG01246652: hypothetical protein +FIG01246656 HesA/MoeB/ThiF family protein, putative +FIG01246657 FIG01246661: hypothetical protein +FIG01246680 FIG01246687: hypothetical protein +FIG01246693 FIG01246694: hypothetical protein +FIG01246697 FIG01246700: hypothetical protein +FIG01246702 unknown conserved protein in others +FIG01246719 FIG01246720: hypothetical protein +FIG01246729 FIG01246730: hypothetical protein +FIG01246736 YhfR +FIG01246751 FIG01246752: hypothetical protein +FIG01246752 modification methylase, putative +FIG01246778 FIG01246780: hypothetical protein +FIG01246787 FIG01246792: hypothetical protein +FIG01246795 Uncharacterized protein yxaJ +FIG01246800 FIG01246801: hypothetical protein +FIG01246806 FIG01246807: hypothetical protein +FIG01246822 similar to hCG2041257 +FIG01246828 FIG01246835: hypothetical protein +FIG01246838 bacitracin transport permease protein bcrc +FIG01246840 FIG01246847: hypothetical protein +FIG01246847 FIG01246848: hypothetical protein +FIG01246854 FIG01246857: hypothetical protein +FIG01246857 FIG01246860: hypothetical protein +FIG01246878 diaminopimelate epimerase( EC:5.1.1.7 ) +FIG01246883 FIG01246885: hypothetical protein +FIG01246904 N-acetylmuramoyl-L-alanine amidase CwlH implicated in mother cell lysis (EC 3.5.1.28) +FIG01246931 BH2108 unknown conserved protein in B. subtilis +FIG01246934 FIG01246940: hypothetical protein +FIG01246949 Dihydro-4-hydroxyphenylpyruvate reductase (NADH) +FIG01246954 FIG01246956: hypothetical protein +FIG01246960 FIG01246961: hypothetical protein +FIG01246977 FIG01246978: hypothetical protein +FIG01246979 Uncharacterized protein yjgB precursor +FIG01246988 FIG01246990: hypothetical protein +FIG01246991 FIG01246992: hypothetical protein +FIG01246993 FIG01246994: hypothetical protein +FIG01246994 FIG01246996: hypothetical protein +FIG01247013 FIG01247014: hypothetical protein +FIG01247018 FIG01247019: hypothetical protein +FIG01247032 restriction enzyme LlaI protein +FIG01247034 FIG01247036: hypothetical protein +FIG01247037 YqaO +FIG01247042 minor structural protein +FIG01247064 UPF0311 protein BSU34410 +FIG01247065 FIG01247070: hypothetical protein +FIG01247073 FIG01247074: hypothetical protein +FIG01247087 possible choloylglycine hydrolase +FIG01247093 FIG01247096: hypothetical protein +FIG01247103 FIG01247107: hypothetical protein +FIG01247118 FIG01247119: hypothetical protein +FIG01247119 FIG01247120: hypothetical protein +FIG01247129 FIG01247131: hypothetical protein +FIG01247131 FIG01247134: hypothetical protein +FIG01247140 FIG01247141: hypothetical protein +FIG01247145 FIG01247146: hypothetical protein +FIG01247157 FIG01247162: hypothetical protein +FIG01247166 FIG01247167: hypothetical protein +FIG01247167 FIG01247172: hypothetical protein +FIG01247181 FIG01247182: hypothetical protein +FIG01247182 FIG01247185: hypothetical protein +FIG01247185 FIG01247189: hypothetical protein +FIG01247215 FIG01247216: hypothetical protein +FIG01247217 FIG01247224: hypothetical protein +FIG01247224 FIG01247226: hypothetical protein +FIG01247229 FIG01247231: hypothetical protein +FIG01247231 FIG01247232: hypothetical protein +FIG01247233 FIG01247234: hypothetical protein +FIG01247261 FIG01247264: hypothetical protein +FIG01247279 FIG01247281: hypothetical protein +FIG01247281 sporulation-control protein +FIG01247289 FIG01247290: hypothetical protein +FIG01247308 FIG01247310: hypothetical protein +FIG01247315 FIG01247318: hypothetical protein +FIG01247319 FIG01247320: hypothetical protein +FIG01247323 FIG01247324: hypothetical protein +FIG01247331 FIG01247332: hypothetical protein +FIG01247333 FIG01247335: hypothetical protein +FIG01247335 FIG01247337: hypothetical protein +FIG01247347 endonuclease/exonuclease/phosphatase family +FIG01247367 FIG01247368: hypothetical protein +FIG01247369 FIG01247370: hypothetical protein +FIG01247370 probable leucine-specific binding protein +FIG01247385 hypothetical protein +FIG01247391 FIG01247392: hypothetical protein +FIG01247395 FIG01247396: hypothetical protein +FIG01247403 conserved membrane protein YkvA +FIG01247411 FIG01247413: hypothetical protein +FIG01247413 FIG01247416: hypothetical protein +FIG01247417 FIG01247418: hypothetical protein +FIG01247419 FIG01247422: hypothetical protein +FIG01247434 FIG01247435: hypothetical protein +FIG01247440 FIG01247441: hypothetical protein +FIG01247444 FIG01247448: hypothetical protein +FIG01247448 FIG01247450: hypothetical protein +FIG01247451 FIG01247454: hypothetical protein +FIG01247475 FIG01247476: hypothetical protein +FIG01247476 FIG01247478: hypothetical protein +FIG01247478 FIG01247479: hypothetical protein +FIG01247493 FIG01247497: hypothetical protein +FIG01247500 FIG01247502: hypothetical protein +FIG01247516 FIG01247517: hypothetical protein +FIG01247541 N-hydroxyarylamine O-acetyltransferase (Arylamine N-acetyltransferase) (EC 2.3.1.118) +FIG01247549 conserved membrane protein YtaF +FIG01247551 conserved hypothetical protein; RBL05884 +FIG01247575 FIG01247576: hypothetical protein +FIG01247594 FIG01247597: hypothetical protein +FIG01247597 phytase( EC:3.1.3.8 ) +FIG01247603 YdbA +FIG01247605 hypothetical protein( EC:3.5.2.12 ) +FIG01247607 FIG01247610: hypothetical protein +FIG01247619 FIG01247624: hypothetical protein +FIG01247624 FIG01247626: hypothetical protein +FIG01247638 FIG01247641: hypothetical protein +FIG01247643 FIG01247645: hypothetical protein +FIG01247649 FIG01247650: hypothetical protein +FIG01247665 FIG01247667: hypothetical protein +FIG01247674 FIG01247676: hypothetical protein +FIG01247696 FIG01247699: hypothetical protein +FIG01247710 Bacitracin transport permease protein bcrc +FIG01247715 FIG01247716: hypothetical protein +FIG01247716 FIG01247717: hypothetical protein +FIG01247743 FIG01247750: hypothetical protein +FIG01247782 FIG01247786: hypothetical protein +FIG01247787 YqeD +FIG01247796 Phenazine biosynthesis protein PhzF like +FIG01247804 FIG01247805: hypothetical protein +FIG01247805 FIG01247808: hypothetical protein +FIG01247808 FIG01247809: hypothetical protein +FIG01247824 cell division inhibitor SULA +FIG01247825 FIG01247827: hypothetical protein +FIG01247843 FIG01247851: hypothetical protein +FIG01247864 FIG01247865: hypothetical protein +FIG01247869 FIG01247874: hypothetical protein +FIG01247877 FIG01247878: hypothetical protein +FIG01247903 FIG01247909: hypothetical protein +FIG01247917 FIG01247921: hypothetical protein +FIG01247922 transcriptional regulator (Lrp/AsnC family) +FIG01247952 FIG01247953: hypothetical protein +FIG01247970 FIG01247972: hypothetical protein +FIG01247972 FIG01247978: hypothetical protein +FIG01247984 FIG01247986: hypothetical protein +FIG01247989 FIG01247992: hypothetical protein +FIG01248055 FIG01248056: hypothetical protein +FIG01248068 FIG01248069: hypothetical protein +FIG01248072 FIG01248074: hypothetical protein +FIG01248105 FIG01248106: hypothetical protein +FIG01248110 FIG01248111: hypothetical protein +FIG01248133 FIG01248135: hypothetical protein +FIG01248140 methyltransferase Atu1041 +FIG01248154 FIG01248155: hypothetical protein +FIG01248166 transition state regulatory protein +FIG01248202 BH0407 unknown conserved protein in others +FIG01248225 FIG01248226: hypothetical protein +FIG01248246 FIG01248248: hypothetical protein +FIG01248266 FIG01248273: hypothetical protein +FIG01248277 FIG01248279: hypothetical protein +FIG01248280 FIG01248283: hypothetical protein +FIG01248288 YdjN +FIG01248296 FIG01248297: hypothetical protein +FIG01248318 FIG01248319: hypothetical protein +FIG01248320 FIG01248323: hypothetical protein +FIG01248335 Quaternary ammonium compound-resistance protein +FIG01248337 FIG01248338: hypothetical protein +FIG01248356 FIG01248359: hypothetical protein +FIG01248366 FIG01248368: hypothetical protein +FIG01248369 FIG01248370: hypothetical protein +FIG01248398 FIG01248401: hypothetical protein +FIG01248417 FIG01248419: hypothetical protein +FIG01248419 FIG01248424: hypothetical protein +FIG01248436 FIG01248440: hypothetical protein +FIG01248440 FIG01248441: hypothetical protein +FIG01248443 FIG01248444: hypothetical protein +FIG01248463 FIG01248464: hypothetical protein +FIG01248481 FIG01248486: hypothetical protein +FIG01248487 FIG01248491: hypothetical protein +FIG01248492 FIG01248496: hypothetical protein +FIG01248496 FIG01248506: hypothetical protein +FIG01248547 FIG01248548: hypothetical protein +FIG01248552 FIG01248555: hypothetical protein +FIG01248555 FIG01248557: hypothetical protein +FIG01248578 FIG01248579: hypothetical protein +FIG01248587 FIG01248589: hypothetical protein +FIG01248621 FIG01248625: hypothetical protein +FIG01248665 oligopeptide transport system permease protein oppB +FIG01248667 FIG01248677: hypothetical protein +FIG01248682 FIG01248684: hypothetical protein +FIG01248697 FIG01248698: hypothetical protein +FIG01248703 FIG01248705: hypothetical protein +FIG01248718 FIG01248726: hypothetical protein +FIG01248726 FIG01248727: hypothetical protein +FIG01248735 exonuclease family protein +FIG01248747 FIG01248748: hypothetical protein +FIG01248749 FIG01248755: hypothetical protein +FIG01248766 YvmB +FIG01248769 FIG01248773: hypothetical protein +FIG01248773 Lactoylglutathione lyase and related lyases +FIG01248778 holin protein +FIG01248793 FIG01248795: hypothetical protein +FIG01248818 Collagen alpha 1(I) chain precursor +FIG01248837 FIG01248839: hypothetical protein +FIG01248839 Tellurium resistance protein TerD +FIG01248869 FIG01248872: hypothetical protein +FIG01248915 FIG01248917: hypothetical protein +FIG01248921 CDS_ID OB3229 +FIG01248922 FIG01248923: hypothetical protein +FIG01248923 FIG01248926: hypothetical protein +FIG01248927 FIG01248928: hypothetical protein +FIG01248937 FIG01248939: hypothetical protein +FIG01248943 FIG01248944: hypothetical protein +FIG01248946 FIG01248952: hypothetical protein +FIG01248965 FIG01248966: hypothetical protein +FIG01248970 hypothetical protein +FIG01248986 FIG01248990: hypothetical protein +FIG01249001 FIG01249014: hypothetical protein +FIG01249014 intracellular serine protease +FIG01249018 5-methylcytosine-specific restriction enzyme MRR( EC:3.1.21.- ) +FIG01249027 FIG01249028: hypothetical protein +FIG01249034 FIG01249049: hypothetical protein +FIG01249051 FIG01249055: hypothetical protein +FIG01249058 FIG01249060: hypothetical protein +FIG01249080 FIG01249084: hypothetical protein +FIG01249100 FIG01249102: hypothetical protein +FIG01249102 FIG01249104: hypothetical protein +FIG01249106 FIG01249107: hypothetical protein +FIG01249129 FIG01249131: hypothetical protein +FIG01249131 possible uncharacterized protein FAD-dependent dehydrogenase +FIG01249141 FIG01249144: hypothetical protein +FIG01249147 FIG01249148: hypothetical protein +FIG01249151 FIG01249153: hypothetical protein +FIG01249153 FIG01249154: hypothetical protein +FIG01249164 FIG01249167: hypothetical protein +FIG01249167 FIG01249170: hypothetical protein +FIG01249170 putative oligopeptide ABC transporter +FIG01249197 FIG01249200: hypothetical protein +FIG01249209 FIG01249213: hypothetical protein +FIG01249215 FIG01249216: hypothetical protein +FIG01249216 FIG01249225: hypothetical protein +FIG01249232 FIG01249233: hypothetical protein +FIG01249241 FIG01249244: hypothetical protein +FIG01249262 peptidase C60 sortase A and B +FIG01249268 FIG01249273: hypothetical protein +FIG01249273 FIG01249274: hypothetical protein +FIG01249298 FIG01249300: hypothetical protein +FIG01249301 FIG01249303: hypothetical protein +FIG01249312 FIG01249314: hypothetical protein +FIG01249323 FIG01249326: hypothetical protein +FIG01249332 FIG01249334: hypothetical protein +FIG01249346 FIG01249348: hypothetical protein +FIG01249357 FIG01249358: hypothetical protein +FIG01249358 FIG017263: hypothetical protein +FIG01249382 FIG01249387: hypothetical protein +FIG01249395 FIG01249396: hypothetical protein +FIG01249397 FIG01249399: hypothetical protein +FIG01249399 FIG01249400: hypothetical protein +FIG01249438 FIG01249440: hypothetical protein +FIG01249440 FIG01249441: hypothetical protein +FIG01249454 FIG01249456: hypothetical protein +FIG01249459 FIG01249465: hypothetical protein +FIG01249466 FIG01249469: hypothetical protein +FIG01249481 FIG01249484: hypothetical protein +FIG01249493 FIG01249496: hypothetical protein +FIG01249518 FIG01249519: hypothetical protein +FIG01249519 FIG01249520: hypothetical protein +FIG01249523 FIG01249526: hypothetical protein +FIG01249555 FIG01249557: hypothetical protein +FIG01249577 FIG01249580: hypothetical protein +FIG01249590 FIG01249591: hypothetical protein +FIG01249592 ThiF family protein +FIG01249597 FIG01249599: hypothetical protein +FIG01249612 FIG01249616: hypothetical protein +FIG01249643 FIG01249647: hypothetical protein +FIG01249655 YflN +FIG01249667 Two-component response regulator ybdJ +FIG01249669 FIG01249672: hypothetical protein +FIG01249685 FIG01249687: hypothetical protein +FIG01249687 FIG01249690: hypothetical protein +FIG01249712 FIG01249714: hypothetical protein +FIG01249715 FIG01249724: hypothetical protein +FIG01249724 FIG01249725: hypothetical protein +FIG01249749 chloramphenicol phosphotransferase protein +FIG01249758 FIG01249759: hypothetical protein +FIG01249759 possible DNA-binding protein +FIG01249760 FIG01249763: hypothetical protein +FIG01249768 FIG01249777: hypothetical protein +FIG01249777 Uncharacterized protein yeaD +FIG01249783 FIG01249784: hypothetical protein +FIG01249784 YrzF +FIG01249809 FIG01249815: hypothetical protein +FIG01249817 Aminomethyltransferase( EC:2.1.2.10 ) +FIG01249832 FIG00745698: hypothetical protein +FIG01249849 FIG01249850: hypothetical protein +FIG01249856 chromate transporter +FIG01249869 FIG01249871: hypothetical protein +FIG01249873 FIG01249876: hypothetical protein +FIG01249914 FAD-dependent oxidase +FIG01249916 FIG01249919: hypothetical protein +FIG01249919 FIG01249923: hypothetical protein +FIG01249941 FIG01249946: hypothetical protein +FIG01249946 FIG01249949: hypothetical protein +FIG01249956 FIG01249960: hypothetical protein +FIG01249962 FIG01249971: hypothetical protein +FIG01249987 FIG01249989: hypothetical protein +FIG01249992 FIG01249996: hypothetical protein +FIG01249996 FIG01249998: hypothetical protein +FIG01250006 spore cortex-lytic enzyme-like protein +FIG01250019 trancscriptional regulator MtrR, putative +FIG01250020 hypothetical protein +FIG01250022 amino acid ABC transporter +FIG01250024 FIG01250027: hypothetical protein +FIG01250028 hypothetical protein +FIG01250042 FIG01250043: hypothetical protein +FIG01250043 FIG01250044: hypothetical protein +FIG01250054 FIG01250057: hypothetical protein +FIG01250057 FIG01250058: hypothetical protein +FIG01250068 FIG01250076: hypothetical protein +FIG01250088 hypothetical protein BA3289 +FIG01250089 FIG01250091: hypothetical protein +FIG01250099 FIG01250102: hypothetical protein +FIG01250128 FIG01250130: hypothetical protein +FIG01250136 FIG01250137: hypothetical protein +FIG01250144 FIG01250146: hypothetical protein +FIG01250156 FIG01250157: hypothetical protein +FIG01250165 FIG01250167: hypothetical protein +FIG01250167 FIG01250169: hypothetical protein +FIG01250174 FIG01250177: hypothetical protein +FIG01250189 hypothetical protein +FIG01250216 hypothetical protein, CF-38 family +FIG01250217 FIG01250221: hypothetical protein +FIG01250233 FIG01250235: hypothetical protein +FIG01250241 FIG01250243: hypothetical protein +FIG01250258 para-nitrobenzyl esterase +FIG01250279 possible oligopeptide transport system permease +FIG01250301 FIG01250302: hypothetical protein +FIG01250302 Transcriptional regulator, copG family +FIG01250310 FIG01250313: hypothetical protein +FIG01250321 FIG01250322: hypothetical protein +FIG01250322 FIG01250323: hypothetical protein +FIG01250331 FIG01250335: hypothetical protein +FIG01250390 Type II restriction endonuclease, MutH family +FIG01250462 FIG01250463: hypothetical protein +FIG01250503 FIG01250505: hypothetical protein +FIG01250507 FIG01250510: hypothetical protein +FIG01250511 FIG01250517: hypothetical protein +FIG01250529 Gas vesicle protein gvpS +FIG01250538 prophage ps3 protein 01 +FIG01250546 FIG01250548: hypothetical protein +FIG01250572 FIG01250573: hypothetical protein +FIG01250574 FIG01250575: hypothetical protein +FIG01250587 FIG01250590: hypothetical protein +FIG01250595 acyltransferase family protein +FIG01250603 FIG01250607: hypothetical protein +FIG01250616 FIG01250617: hypothetical protein +FIG01250617 FIG01250618: hypothetical protein +FIG01250641 DNA replication protein dnaC +FIG01250678 FIG01250679: hypothetical protein +FIG01250682 FIG01250685: hypothetical protein +FIG01250698 FIG01250699: hypothetical protein +FIG01250719 FIG01250721: hypothetical protein +FIG01250721 Na+ ABC transporter (membrane protein) +FIG01250768 FIG01250776: hypothetical protein +FIG01250777 FIG01250779: hypothetical protein +FIG01250829 FIG01250830: hypothetical protein +FIG01250833 YuiD +FIG01250850 possible prophage protein +FIG01250872 FIG01250874: hypothetical protein +FIG01250884 FIG01250892: hypothetical protein +FIG01250917 FIG01250918: hypothetical protein +FIG01250929 FIG01250930: hypothetical protein +FIG01250974 FIG01250978: hypothetical protein +FIG01250979 FIG01250983: hypothetical protein +FIG01250983 sensory box histidine kinase VicK, putative( EC:2.7.3.- ) +FIG01250996 FIG01250998: hypothetical protein +FIG01251016 FIG01251018: hypothetical protein +FIG01251027 FIG01251028: hypothetical protein +FIG01251051 FIG01251060: hypothetical protein +FIG01251066 FIG01251067: hypothetical protein +FIG01251079 FIG01251080: hypothetical protein +FIG01251085 FIG01251087: hypothetical protein +FIG01251094 InterPro IPR000073:IPR000379:IPR000734:IPR002410 COGs COG0596 +FIG01251115 FIG01251116: hypothetical protein +FIG01251119 FIG01251124: hypothetical protein +FIG01251129 FIG01251136: hypothetical protein +FIG01251138 FIG01251144: hypothetical protein +FIG01251162 FIG01251165: hypothetical protein +FIG01251179 FIG01251181: hypothetical protein +FIG01251187 FIG01251192: hypothetical protein +FIG01251206 FIG01251207: hypothetical protein +FIG01251256 FIG01251257: hypothetical protein +FIG01251257 FIG01251260: hypothetical protein +FIG01251260 FIG01251262: hypothetical protein +FIG01251264 FIG01251269: hypothetical protein +FIG01251278 FIG01251279: hypothetical protein +FIG01251279 FIG01251282: hypothetical protein +FIG01251292 hypothetical Cytosolic Protein +FIG01251327 L-arabinose transport system permease protein araP (EC 3.6.3.17) +FIG01251332 FIG01251336: hypothetical protein +FIG01251336 FIG01251340: hypothetical protein +FIG01251340 FIG01251341: hypothetical protein +FIG01251342 methyl-accepting chemotaxis protein +FIG01251352 FIG01251356: hypothetical protein +FIG01251384 FIG01251388: hypothetical protein +FIG01251389 SpaF +FIG01251401 FIG01251405: hypothetical protein +FIG01251410 FIG01251415: hypothetical protein +FIG01251438 FIG01251439: hypothetical protein +FIG01251449 hypothetical protein +FIG01251453 FIG01251454: hypothetical protein +FIG01251454 FIG01251456: hypothetical protein +FIG01251456 FIG01251458: hypothetical protein +FIG01251458 hypothetical protein +FIG01251462 FIG01232742: hypothetical protein +FIG01251465 ABC transporter, ATP-binding protein, MDR family protein +FIG01251469 FIG01251475: hypothetical protein +FIG01251498 FIG01251499: hypothetical protein +FIG01251500 FIG01251501: hypothetical protein +FIG01251506 FIG01251508: hypothetical protein +FIG01251524 FIG01251525: hypothetical protein +FIG01251525 Acyl-CoA dehydrogenase, type 2, C-terminal domain +FIG01251586 FIG01251589: hypothetical protein +FIG01251589 FIG01251594: hypothetical protein +FIG01251615 FIG01251616: hypothetical protein +FIG01251616 FIG01251625: hypothetical protein +FIG01251627 FIG01251628: hypothetical protein +FIG01251630 FIG01251631: hypothetical protein +FIG01251654 FIG01251655: hypothetical protein +FIG01251663 FIG01251665: hypothetical protein +FIG01251682 FIG01251683: hypothetical protein +FIG01251691 FIG01251693: hypothetical protein +FIG01251714 FIG01251715: hypothetical protein +FIG01251716 FIG01251717: hypothetical protein +FIG01251743 FIG01251744: hypothetical protein +FIG01251748 FIG01251749: hypothetical protein +FIG01251802 FIG01251805: hypothetical protein +FIG01251819 FIG01251828: hypothetical protein +FIG01251828 FIG01251836: hypothetical protein +FIG01251860 FIG01251861: hypothetical protein +FIG01251865 FIG01251866: hypothetical protein +FIG01251881 FIG01251887: hypothetical protein +FIG01251895 FIG01251897: hypothetical protein +FIG01251897 FIG01251898: hypothetical protein +FIG01251900 putative protein 14 +FIG01251908 FIG01251909: hypothetical protein +FIG01251922 FIG01251923: hypothetical protein +FIG01251923 FIG01251926: hypothetical protein +FIG01251926 FIG01251936: hypothetical protein +FIG01251950 GABA permease +FIG01251957 FIG01251962: hypothetical protein +FIG01251965 FIG01251973: hypothetical protein +FIG01251975 hypothetical protein +FIG01251982 FIG01251985: hypothetical protein +FIG01252001 FIG01252006: hypothetical protein +FIG01252024 FIG01252032: hypothetical protein +FIG01252039 FIG01252040: hypothetical protein +FIG01252040 FIG01252041: hypothetical protein +FIG01252041 anthrax toxin moiety, protective antigen, pagA formerly pag, plasmid pXO1, B. anthracis (M22589, P13423) +FIG01252047 FIG01252048: hypothetical protein +FIG01252069 FIG01252070: hypothetical protein +FIG01252070 FIG01252075: hypothetical protein +FIG01252075 FIG01252076: hypothetical protein +FIG01252099 FIG01252100: hypothetical protein +FIG01252120 FIG01252132: hypothetical protein +FIG01252135 FIG01252136: hypothetical protein +FIG01252138 FIG01252141: hypothetical protein +FIG01252145 FIG01252149: hypothetical protein +FIG01252157 FIG01252169: hypothetical protein +FIG01252177 FIG01252182: hypothetical protein +FIG01252190 FIG01252200: hypothetical protein +FIG01252228 Prophage LambdaBa04, site-specific recombinase, phage integrase family +FIG01252236 FIG01252251: hypothetical protein +FIG01252251 FIG01225357: hypothetical protein +FIG01252258 FIG01252264: hypothetical protein +FIG01252275 Barstar-like protein ribonuclease (barnase) inhibitor +FIG01252309 FIG01252312: hypothetical protein +FIG01252316 FIG01252319: hypothetical protein +FIG01252327 FIG01252328: hypothetical protein +FIG01252328 FIG01252330: hypothetical protein +FIG01252330 FIG01252335: hypothetical protein +FIG01252350 FIG01252351: hypothetical protein +FIG01252376 FIG01252378: hypothetical protein +FIG01252467 FIG01252472: hypothetical protein +FIG01252472 FIG01252473: hypothetical protein +FIG01252475 FIG01252477: hypothetical protein +FIG01252486 FIG01252487: hypothetical protein +FIG01252509 FIG01252519: hypothetical protein +FIG01252526 FIG01252529: hypothetical protein +FIG01252566 FIG01252567: hypothetical protein +FIG01252579 FIG01252582: hypothetical protein +FIG01252587 FIG01252593: hypothetical protein +FIG01252619 FIG01252620: hypothetical protein +FIG01252622 FIG01252623: hypothetical protein +FIG01252670 FIG01252672: hypothetical protein +FIG01252673 FIG01252674: hypothetical protein +FIG01252690 FIG01252691: hypothetical protein +FIG01252703 FIG01252708: hypothetical protein +FIG01252723 FIG01252724: hypothetical protein +FIG01252724 FIG01252725: hypothetical protein +FIG01252738 FIG01252740: hypothetical protein +FIG01252769 FIG01252772: hypothetical protein +FIG01252806 FIG01252810: hypothetical protein +FIG01252812 FIG01252815: hypothetical protein +FIG01252816 Glycosyltransferase, MGT family +FIG01252847 FIG01252856: hypothetical protein +FIG01252874 FIG01252880: hypothetical protein +FIG01253000 FIG01253003: hypothetical protein +FIG01253076 FIG01253079: hypothetical protein +FIG01253098 FIG01253100: hypothetical protein +FIG01253103 replication-associated protein +FIG01253104 FIG01253110: hypothetical protein +FIG01253173 FIG01253174: hypothetical protein +FIG01253250 conserved hypothetical protein, N-terminal region +FIG01253256 FIG01253257: hypothetical protein +FIG01253265 FIG01253266: hypothetical protein +FIG01253340 FIG01253341: hypothetical protein +FIG01253353 FIG01253354: hypothetical protein +FIG01253403 FIG01253404: hypothetical protein +FIG01253412 FIG01253414: hypothetical protein +FIG01253427 FIG01253432: hypothetical protein +FIG01253435 FIG01253439: hypothetical protein +FIG01253524 hypothetical protein +FIG01253529 amino acid ABC superfamily ATP binding cassette transporter, binding protein +FIG01253584 FIG01253588: hypothetical protein +FIG01253588 FIG01253591: hypothetical protein +FIG01253656 Sodium/glutamine symporter glnT +FIG01253661 FIG01253662: hypothetical protein +FIG01253694 beta-lactamase +FIG01253760 FIG01253766: hypothetical protein +FIG01253824 HIT (histidine triad) family protein +FIG01253900 FIG01253901: hypothetical protein +FIG01253906 FIG01253909: hypothetical protein +FIG01253946 putative integral membrane protein +FIG01253958 hypothetical protein +FIG01254018 FIG01254019: hypothetical protein +FIG01254060 FIG00710727: hypothetical protein +FIG01254102 Peptidase / Na+/H+ antiporter NhaA type +FIG01254105 FIG01254123: hypothetical protein +FIG01254192 FIG01254194: hypothetical protein +FIG01254247 DNA gyrase subunit B (EC 5.99.1.3) @ intein-containing +FIG01254293 FIG00639273: hypothetical protein +FIG01254366 FIG01254368: hypothetical protein +FIG01254664 FIG01254665: hypothetical protein +FIG01254798 Dihydroorotate dehydrogenase, catalytic subunit (EC 1.3.3.1) / Dihydroorotate dehydrogenase electron transfer subunit (EC 1.3.3.1) +FIG01254899 ElaA protein +FIG01254958 Galactosyl transferase CpsE (EC 2.7.8.-) +FIG01254985 Xanthine dehydrogenase iron-sulfur subunit (EC 1.17.1.4) / Xanthine dehydrogenase, FAD binding subunit (EC 1.17.1.4); Xanthine oxidase (EC 1.17.3.2) +FIG01254986 FIG01254993: hypothetical protein +FIG01255000 FIG01255012: hypothetical protein +FIG01255012 FIG01255013: hypothetical protein +FIG01255013 FIG01255015: hypothetical protein +FIG01255086 FIG01255087: hypothetical protein +FIG01255088 hypothetical protein +FIG01255127 Metal-dependent hydrolases of the beta-lactamase superfamily III +FIG01255167 FIG01255168: hypothetical protein +FIG01255181 Superfamily II DNA/RNA helicases, SNF2 family +FIG01255196 IncF plasmid conjugative transfer protein TrbA +FIG01255217 RTX protein +FIG01255445 FIG01255446: hypothetical protein +FIG01255481 FIG01255482: hypothetical protein +FIG01255525 diglucosyldiacylglycerol synthase (LTA membrane anchor synthesis) +FIG01255539 FIG01255540: hypothetical protein +FIG01255541 FIG01255542: hypothetical protein +FIG01255664 Dienelactone hydrolase and related enzymes +FIG01255694 FIG01255695: hypothetical protein +FIG01255819 Glutaredoxin +FIG01255829 FIG01255830: hypothetical protein +FIG01255830 FIG01255831: hypothetical protein +FIG01255832 hypothetical protein +FIG01255853 FIG01255854: hypothetical protein +FIG01255877 Peptide chain release factor 2 +FIG01255891 FIG01255897: hypothetical protein +FIG01255898 COG1598: Uncharacterized conserved protein +FIG01255966 Internalin-like protein (LPXTG motif) Lmo0333 homolog +FIG01255974 Hypothetical SAV0790 homolog in superantigen-encoding pathogenicity islands SaPI +FIG01256162 hypothetical protein BVU_3741 +FIG01256319 Bacteriophage-related DNA polymerase +FIG01256324 Inclusion membrane protein-33 +FIG01256403 Penicillin-binding protein 3 +FIG01256412 Pseudouridine synthase family protein +FIG01256546 Hypothetical sugar kinase in cluster with indigoidine synthase indA , PfkB family of kinases +FIG01256560 Siderophore achromobactin ABC transporter, permease protein +FIG01256574 dNTP triphosphohydrolase, putative +FIG01256588 FIG01256597: hypothetical protein +FIG01256747 FIG01256755: hypothetical protein +FIG01256759 RpoD-related RNA polymerase sigma factor +FIG01256766 FIG01256781: hypothetical protein +FIG01256817 "Ascorbate-specific PTS system, EIIA component " +FIG01256902 FIG01256903: hypothetical protein +FIG01256920 Acetoin dehydrogenase E1 component beta-subunit (EC 1.2.4.-) +FIG01256941 FIG01256944: hypothetical protein +FIG01256944 FIG01256947: hypothetical protein +FIG01256982 FIG01257004: hypothetical protein +FIG01257014 TadE family protein +FIG01257071 Inhibitor of vertebrate lysozyme precursor +FIG01257096 phosphoesterase, PA-phosphatase related +FIG01257217 FIG01257225: hypothetical protein +FIG01257232 C50 carotenoid epsilon cyclase +FIG01257277 Proline-rich 28 kDa antigen precursor +FIG01257323 FIG01257340: hypothetical protein +FIG01257392 FIG01257406: hypothetical protein +FIG01257418 Translation initiation factor 2 (IF-2; GTPase) +FIG01257503 Methylmalonate-semialdehyde dehydrogenase [inositol] (EC 1.2.1.27) +FIG01257580 Xanthine dehydrogenase, iron-sulfur cluster and FAD-binding subunit A (1.17.1.4) +FIG01257615 Bll5876 protein +FIG01257647 Degenerate integrase, superantigen-encoding pathogenicity islands SaPI +FIG01257759 FIG01257760: hypothetical protein +FIG01257766 FIG01257780: hypothetical protein +FIG01257822 PTS system, diacetylchitobiose-specific IIB component (EC 2.7.1.69) +FIG01257969 FIG01257981: hypothetical protein +FIG01258074 Glycyl-tRNA synthetase (EC 6.1.1.14), carboxy-terminal 114 amino acids +FIG01258120 Methyl-accepting chemotaxis-like protein +FIG01258261 FIG00858196: hypothetical protein +FIG01258275 FIG00820415: hypothetical protein +FIG01258358 FIG01258360: hypothetical protein +FIG01258372 Streptococcal mitogenic exotoxin Z (SmeZ) +FIG01258386 FIG01258391: hypothetical protein +FIG01258536 FIG01258542: hypothetical protein +FIG01258694 Alkyl hydroperoxide reductase subunit C-like protein +FIG01258713 Ynd +FIG01258727 Putative glycosyltransferase +FIG01258831 Antiadhesin Pls, binding to squamous nasal epithelial cells +FIG01258882 FIG01258883: hypothetical protein +FIG01258918 GTP pyrophosphokinase (EC 2.7.6.5), (p)ppGpp synthetase II / Guanosine-3',5'-bis(diphosphate) 3'-pyrophosphohydrolase (EC 3.1.7.2) +FIG01258930 Putative membrane protein MmpS3 +FIG01258946 Protein involved in catabolism of external DNA +FIG01259198 Colanic acid biosynthesis glycosyl transferase WcaA +FIG01259203 Trehalose operon transcriptional repressor +FIG01259276 FIG01259277: hypothetical protein +FIG01259332 FIG01259335: hypothetical protein +FIG01259454 Transketolase (EC 2.2.1.1) +FIG01259474 DNA-entry nuclease (Competence-specific nuclease) (EC 3.1.30.-) +FIG01259538 Fap amyloid fibril major component +FIG01259652 FIG00983573: hypothetical protein +FIG01259681 DNA internalization-related competence protein ComEC/Rec2 +FIG01259740 Gamma-aminobutyrate:alpha-ketoglutarate aminotransferase (EC 2.6.1.19) +FIG01259749 Glycine N-methyltransferase (EC 2.1.1.20) @ Sarcosine N-methyltransferase / Sarcosine N-methyltransferase @ Dimethylglycine N-methyltransferase +FIG01259839 putative exported protein +FIG01259863 Phosphomannomutase (EC 5.4.2.8) / Phosphoglucomutase (EC 5.4.2.2) +FIG01259873 Lipid A biosynthesis (KDO) 2-(lauroyl)-lipid IVA acyltransferase (EC 2.3.1.-) +FIG01259905 Phosphatase NagD predicted to act in N-acetylglucosamine utilization subsystem +FIG01259918 Anaerobic selenate reductase protein YnfG +FIG01259921 DotA protein +FIG01260269 FIG01260270: hypothetical protein +FIG01260270 FIG01260271: hypothetical protein +FIG01260271 FIG01260272: hypothetical protein +FIG01260356 FIG01260357: hypothetical protein +FIG01260358 Type IV pilus biogenesis protein PilOPx +FIG01260427 FIG01260428: hypothetical protein +FIG01260480 FIG01260484: hypothetical protein +FIG01260576 DNA primase (EC 2.7.7.-), phage related +FIG01260731 FIG01260766: hypothetical protein +FIG01260772 Branched-chain amino acid transport system permease protein LivM (TC 3.A.1.4.1) / Branched-chain amino acid transport ATP-binding protein LivG (TC 3.A.1.4.1) +FIG01260797 IncF plasmid conjugative transfer protein TrbH +FIG01260980 TonB-dependent receptor +FIG01261124 Cytochrome C4 +FIG01261296 2-dehydro-3-deoxyphosphogluconate aldolase (EC 4.1.2.14) +FIG01261297 Copper-transporting ATPase domain protein +FIG01261352 FIG01261355: hypothetical protein +FIG01261435 FIG01261436: hypothetical protein +FIG01261436 FIG01261438: hypothetical protein +FIG01261528 Na+/H+ antiporter NhaD type +FIG01261531 5-carboxymethyl-2-hydroxymuconate semialdehyde dehydrogenase (EC 1.2.1.60) +FIG01261574 Transport ATP-binding protein CydD +FIG01261581 Transmembrane component of energizing module of ECF transporters in Cyanobacteria +FIG01261615 FIG01261637: hypothetical protein +FIG01261992 Arginine ABC transporter, periplasmic arginine-binding protein ArtI +FIG01262021 Sortase +FIG01262030 FIG01262040: hypothetical protein +FIG01262045 3-hydroxyacyl-CoA dehydrogenase (EC 1.1.1.35) / Enoyl CoA hydratase (EC 4.2.1.17) +FIG01262086 D-alanine--D-alanine ligase B (EC 6.3.2.4) +FIG01262149 FIG01262165: hypothetical protein +FIG01262173 Transcriptional regulator HxlR, formaldehyde assimilation +FIG01262190 FIG01262196: hypothetical protein +FIG01262312 FIG01262313: hypothetical protein +FIG01262324 Mucin +FIG01262639 Phage baseplate wedge tail fiber connector (T4-like gp9) +FIG01262677 Alginate lyase precursor (EC 4.2.2.3) +FIG01262685 Fructose-bisphosphate aldolase class I (EC 4.1.2.13) +FIG01262693 Flp pilus assembly protein TadC +FIG01262759 FIG01262762: hypothetical protein +FIG01262838 Integral membrane protein EccD1, component of Type VII secretion system ESX-1 +FIG01262842 FIG01262856: hypothetical protein +FIG01263011 FIG01263022: hypothetical protein +FIG01263028 Phosphoenolpyruvate phosphomutase (EC 5.4.2.9) +FIG01263164 FIG01263165: hypothetical protein +FIG01263176 FIG01263178: hypothetical protein +FIG01263178 FIG01263209: hypothetical protein +FIG01263212 FIG01263214: hypothetical protein +FIG01263234 putative Cytochrome bd2, subunit II / Cyanide insensitive terminal oxidase, subunit II +FIG01263252 LysR family transcriptional regulator STM3121 +FIG01263286 calmodulin sensitive adenylate cyclase, edema factor, cya, plasmid pXO1, B. anthracis (M23179, M24074) +FIG01263329 RNA-binding region RNP-1 (RNA recognition motif) +FIG01263394 FIG01263398: hypothetical protein +FIG01263400 FIG002708: Protein SirB1 +FIG01263577 FIG01263580: hypothetical protein +FIG01263580 N-acetylgalactosamine-6-phosphate deacetylase (EC 3.5.1.25) +FIG01263585 FIG01263599: hypothetical protein +FIG01263602 FIG019045: long form Mg-chelase associated protein with vWA domain +FIG01263765 FIG01263769: hypothetical protein +FIG01263804 FIG01263806: hypothetical protein +FIG01263835 Soluble lytic murein transglycosylase (EC 3.2.1.-) +FIG01263943 FIG01263964: hypothetical protein +FIG01263977 FIG01263980: hypothetical protein +FIG01263980 FIG01264014: hypothetical protein +FIG01264017 6-phosphogluconolactonase (EC 3.1.1.31) +FIG01264018 6-phosphogluconolactonase (EC 3.1.1.31) +FIG01264085 Crotonobetainyl-CoA:carnitine CoA-transferase (EC 2.8.3.-) +FIG01264131 FIG01264132: hypothetical protein +FIG01264133 hpt domain protein/STAS domain protein +FIG01264146 FIG01264147: hypothetical protein +FIG01264156 FIG01264158: hypothetical protein +FIG01264168 mobilization protein BmgA +FIG01264227 Probable acyl-CoA dehydrogenase fadE35 (EC 1.3.99.-) +FIG01264230 FIG01264231: hypothetical protein +FIG01264288 FIG01264289: hypothetical protein +FIG01264307 FIG137478: Hypothetical protein YbgI +FIG01264371 Inner membrane protein YqjF +FIG01264372 putative septum site determining protein +FIG01264373 FIG01264378: hypothetical protein +FIG01264385 FIG01264387: hypothetical protein +FIG01264654 FIG01264655: hypothetical protein +FIG01264655 Bll2208 protein +FIG01264709 Flagellar hook-length control protein +FIG01264751 Octaprenyl diphosphate synthase (EC 2.5.1.90) / Dimethylallyltransferase (EC 2.5.1.1) / Geranyltranstransferase (EC 2.5.1.10) / Geranylgeranyl pyrophosphate synthetase (EC 2.5.1.29) +FIG01264759 FIG01264765: hypothetical protein +FIG01264801 Membrane anchored protein +FIG01264810 FIG01264811: hypothetical protein +FIG01264960 Conjugative signal peptidase TrhF +FIG01265038 DEDDh 3'-5' exonuclease domain of the epsilon subunit of DNA polymerase III +FIG01265079 Chitinase (EC 3.2.1.14) +FIG01265183 Stage III sporulation protein AG +FIG01265301 Methionyl-tRNA synthetase (EC 6.1.1.10) +FIG01265369 Hypothetical SAR0371 homolog in superantigen-encoding pathogenicity islands SaPI +FIG01265370 drug resistance transporter, EmrB/QacA family +FIG01265678 Tryptophan synthase alpha chain (EC 4.2.1.20) +FIG01265780 FIG01265782: hypothetical protein +FIG01265782 small secreted hydrophilic protein +FIG01265940 FIG01265941: hypothetical protein +FIG01265980 HesA/MoeB/ThiF family protein related to EC-YgdL +FIG01266069 FIG01266078: hypothetical protein +FIG01266087 FIG01266089: hypothetical protein +FIG01266102 FIG01266107: hypothetical protein +FIG01266118 Putative subunit of NAD(P)H:quinone oxidoreductase +FIG01266131 FIG01266132: hypothetical protein +FIG01266134 FIG01266141: hypothetical protein +FIG01266186 FIG01266190: hypothetical protein +FIG01266212 FIG01266219: hypothetical protein +FIG01266244 Ribosomal protein S12p Asp88 (E. coli) methylthiotransferase +FIG01266294 Dehydrogenase in mycofactocin cluster +FIG01266397 Hybrid sensory histidine kinase in two-component regulatory system with EvgA +FIG01266434 Putative DNA helicase, superantigen-encoding pathogenicity islands SaPI +FIG01266490 Predicted L-serine dehydratase (EC 4.3.1.17) TdcG +FIG01266631 Vitellogenin II precursor +FIG01266634 ATP-dependent DNA helicase UvrD/PcrA/Rep family, Francisella type +FIG01266661 Putative reductase (alkanesulfonate metabolism) +FIG01266712 FIG01266718: hypothetical protein +FIG01266876 Acetyl-CoA:acetoacetyl-CoA transferase, alpha subunit (EC 2.8.3.8) +FIG01266881 FIG01266882: hypothetical protein +FIG01266882 FIG01266891: hypothetical protein +FIG01266945 Phage tail spike protein +FIG01267088 Immune inhibitor A metalloprotease +FIG01267098 Ribose ABC transport system, permease protein RbsC (TC 3.A.1.2.1) +FIG01267140 Enterotoxin, B subunit +FIG01267170 FIG01267171: hypothetical protein +FIG01267207 FIG01267210: hypothetical protein +FIG01267248 FIG01267251: hypothetical protein +FIG01267278 hypothetical protein +FIG01267488 bacteriophage f237 ORF5 +FIG01267511 FIG01267551: hypothetical protein +FIG01267659 Molybdopterin biosynthesis Mog protein, molybdochelatase +FIG01267691 Monoamine oxidase (1.4.3.4) +FIG01267732 STRUCTURAL ELEMENTS; Cell Exterior; surface polysaccharides/antigens +FIG01267885 FIG01267895: hypothetical protein +FIG01267922 FIG01267923: hypothetical protein +FIG01267923 FIG01267924: hypothetical protein +FIG01267968 FIG01267978: hypothetical protein +FIG01268101 FIG01268102: hypothetical protein +FIG01268109 Bacteriocin immunity protein BlpL +FIG01268134 COG1887: Putative glycosyl/glycerophosphate transferases involved in teichoic acid biosynthesis TagF/TagB/EpsJ/RodC +FIG01268141 FIG01268142: hypothetical protein +FIG01268230 Long-chain-fatty-acid--CoA ligase (EC 6.2.1.3) / long-chain acyl-CoA synthetase +FIG01268363 Deblocking aminopeptidase (EC 3.4.11.-) +FIG01268396 Antibiotic biosynthesis monooxygenase +FIG01268512 FIG01268515: hypothetical protein +FIG01268577 FIG01268581: hypothetical protein +FIG01268617 COG1956, GAF domain-containing protein +FIG01268810 FIG01268811: hypothetical protein +FIG01268822 FIG01268823: hypothetical protein +FIG01268864 COG0613, Predicted metal-dependent phosphoesterases (PHP family) +FIG01268888 lprE +FIG01268991 Succinate dehydrogenase hydrophobic membrane anchor protein +FIG01268994 IncI1 plasmid conjugative transfer NusG-type transcription antiterminator TraB +FIG01269013 Cobalamin biosynthesis protein CobG +FIG01269114 Uncharacterized SAV1743 homolog +FIG01269129 Siroheme synthase / Precorrin-2 oxidase (EC 1.3.1.76) / Sirohydrochlorin ferrochelatase (EC 4.99.1.4) / Glutamate-1-semialdehyde aminotransferase (EC 5.4.3.8) +FIG01269130 Collagen-like triple helix repeat protein +FIG01269179 FIG01269180: hypothetical protein +FIG01269180 bifunctional aspartokinase I/homeserine dehydrogenase I( EC:1.1.1.13 ) +FIG01269316 Betaine aldehyde dehydrogenase (EC 1.2.1.8) +FIG01269423 macromolecule metabolism; macromolecule degradation; degradation of polysaccharides +FIG01269473 FIG01269475: hypothetical protein +FIG01269488 COG1399 protein, clustered with ribosomal protein L32p +FIG01269523 FIG01269524: hypothetical protein +FIG01269527 FIG01269530: hypothetical protein +FIG01269537 FIG01269538: hypothetical protein +FIG01269538 FIG01269539: hypothetical protein +FIG01269547 IcmG protein +FIG01269590 FIG016519: Putative DNA-binding protein +FIG01269679 Biotin sulfoxide reductase +FIG01269733 NanA gene +FIG01269746 possible Zinc finger, C3HC4 type (RING finger) +FIG01269762 hypothetical protein +FIG01269835 N-acetyl-L,L-diaminopimelate aminotransferase (EC 2.6.1.-) +FIG01269908 tolB protein precursor, periplasmic protein involved in the tonb-independent uptake of group A colicins +FIG01269942 FIG01269950: hypothetical protein +FIG01269950 FIG01269951: hypothetical protein +FIG01269952 FIG01269953: hypothetical protein +FIG01269953 Small membrane protein +FIG01269967 FIG01269976: hypothetical protein +FIG01270006 FIG01270007: hypothetical protein +FIG01270007 FIG01270011: hypothetical protein +FIG01270039 Acetoin dehydrogenase E1 component beta-subunit (EC 1.2.4.-) +FIG01270047 N,N'-diacetylchitobiose-specific regulator ChbR, AraC family +FIG01270171 Arsenical-resistance protein ACR3 / Arsenate reductase (EC 1.20.4.1) +FIG01270172 Arsenate reductase (EC 1.20.4.1) / Arsenical resistance operon repressor +FIG01270242 FIG01270244: hypothetical protein +FIG01270279 FIG01270281: hypothetical protein +FIG01270314 FIG01270316: hypothetical protein +FIG01270316 FIG01270322: hypothetical protein +FIG01270353 Putative esterase, FIGfam005057 +FIG01270367 keratin associated protein 17-1 +FIG01270409 FIG001341: Probable Fe(2+)-trafficking protein YggX +FIG01270482 Predicted transcriptional regulator with C-terminal CBS domain +FIG01270502 protein of unknown function DUF1328 +FIG01270509 Phage protein +FIG01270577 PROBABLE MEMBRANE GLYCINE AND PROLINE RICH PROTEIN +FIG01270593 FIG01270594: hypothetical protein +FIG01270597 FIG01270614: hypothetical protein +FIG01270614 FIG01270615: hypothetical protein +FIG01270640 FIG01270642: hypothetical protein +FIG01270642 FIG01270644: hypothetical protein +FIG01270649 FIG01270651: hypothetical protein +FIG01270651 FIG01270652: hypothetical protein +FIG01270652 FIG01270656: hypothetical protein +FIG01270838 iron aquisition yersiniabactin synthesis enzyme (Irp2) +FIG01270839 hypothetical protein +FIG01270864 MotA/TolQ/ExbB proton channel family protein, probably associated with flagella +FIG01270907 FIG01270911: hypothetical protein +FIG01270911 FIG01270915: hypothetical protein +FIG01270941 FIG01270943: hypothetical protein +FIG01270975 ortholog of Bordetella pertussis (BX470248) BP1831 +FIG01270997 FIG01271000: hypothetical protein +FIG01271223 FIG01271224: hypothetical protein +FIG01271239 FIG01271252: hypothetical protein +FIG01271266 FIG01271267: hypothetical protein +FIG01271298 Histone-like protein +FIG01271376 Surface presentation of antigens protein SpaS +FIG01271377 Beta-propeller domains of methanol dehydrogenase type +FIG01271475 FIG01271476: hypothetical protein +FIG01271562 FIG01271588: hypothetical protein +FIG01271658 Phage baseplate (uncharacterized for now) +FIG01271659 FIG01271660: hypothetical protein +FIG01271660 FIG01271664: hypothetical protein +FIG01271759 FIG01149397: hypothetical protein +FIG01271767 SpdD protein +FIG01271881 FIG01271883: hypothetical protein +FIG01271967 FIG01271984: hypothetical protein +FIG01271998 Possible hypoxanthine oxidase XdhD (EC 1.-.-.-) +FIG01272034 GCN5-related N-acetyltransferase +FIG01272119 FIG01272120: hypothetical protein +FIG01272181 FIG01272183: hypothetical protein +FIG01272184 Glucarate dehydratase related protein YgcY +FIG01272192 Sulfate transport system permease protein CysW +FIG01272202 Dipeptide transport ATP-binding protein DppF (TC 3.A.1.5.2); puatative hemin transporter subunit +FIG01272270 6-phosphofructokinase (EC 2.7.1.11); Inosine-guanosine kinase (EC 2.7.1.73); Adenosine kinase (EC 2.7.1.20); Cytidine kinase +FIG01272278 FIG01272282: hypothetical protein +FIG01272345 Putative membrane protein YfcA +FIG01272472 Inclusion membrane protein-7 +FIG01272482 FIG01272488: hypothetical protein +FIG01272488 FIG01272494: hypothetical protein +FIG01272494 Alkanesulfonates transport system permease protein +FIG01272500 FIG01272501: hypothetical protein +FIG01272563 Biphenyl dioxygenase beta subunit (EC 1.14.12.18) +FIG01272594 Transcription initiation factor TFIIIB, Brf1 subunit/Transcription initiation factor TFIIB +FIG01272597 FIG01272598: hypothetical protein +FIG01272598 FIG01272599: hypothetical protein +FIG01272859 ; Probable coniferyl aldehyde dehydrogenase (EC 1.2.1.68) +FIG01272889 CRISPR-associated protein, CT1974 +FIG01272891 FIG01272892: hypothetical protein +FIG01272940 FIG01272942: hypothetical protein +FIG01272992 FIG01272995: hypothetical protein +FIG01272995 2,3-dihydroxybiphenyl 1,2-dioxygenase (EC 1.13.11.39) +FIG01273048 Ferredoxin-like protein FixX +FIG01273086 DNA topoisomerase III (EC 5.99.1.2) / ATP-dependent DNA helicase RecQ +FIG01273109 Phage endopeptidase (EC 3.4.-.-) Rz +FIG01273117 FIG01273118: hypothetical protein +FIG01273147 Asparagine synthetase [glutamine-hydrolyzing] (EC 6.3.5.4) AsnH +FIG01273199 MSHA biogenesis protein MshI +FIG01273211 Glucose ABC transporter, permease component +FIG01273238 Uncharacterized protein MJ0729 +FIG01273248 FIG01273249: hypothetical protein +FIG01273262 Peptidyl-prolyl cis-trans isomerase PpiD (EC 5.2.1.8) +FIG01273301 FIG01273326: hypothetical protein +FIG01273336 Multiple antibiotic resistance protein MarC +FIG01273413 FIG035246: DoxX family protein +FIG01273482 FIG01273505: hypothetical protein +FIG01273528 FIG01273529: hypothetical protein +FIG01273529 FIG01273533: hypothetical protein +FIG01273533 ABC amino acid transporter, extracellular solute binding component +FIG01273570 TTE0859 replicon stabilization toxin +FIG01273675 possible tetrapyrrole methyltransferase domain / Nucleoside triphosphate pyrophosphohydrolase MazG (EC 3.6.1.8) +FIG01273734 FIG01273736: hypothetical protein +FIG01273772 FIG01273817: hypothetical protein +FIG01273870 FIG01273874: hypothetical protein +FIG01273904 Non-ribosomal peptide synthetase modules, pyoverdine +FIG01273975 FIG01273977: hypothetical protein +FIG01274014 FIG01274015: hypothetical protein +FIG01274178 Prop transport protein +FIG01274184 Methylmalonyl-CoA mutase, small subunit (EC 5.4.99.2) +FIG01274195 SAM dependent methyltransferase +FIG01274218 DNA modification methyltransferase (EC 2.1.1.-) +FIG01274225 FIG01274249: hypothetical protein +FIG01274272 hypothetical protein, possible TrbK +FIG01274276 PE-PGRS FAMILY PROTEIN +FIG01274278 RelE antibacterial toxin protein +FIG01274351 Dipeptide transport ATP-binding protein DppD (TC 3.A.1.5.2) +FIG01274567 Trilactone hydrolase IroD +FIG01274668 L-asparaginase I, cytoplasmic (EC 3.5.1.1) +FIG01274900 Possible purine NTPase +FIG01274936 secretory protein kinase @ intein-containing +FIG01274978 FIG01274979: hypothetical protein +FIG01275077 FIG01275087: hypothetical protein +FIG01275136 FIG01275137: hypothetical protein +FIG01275203 phosphoribosyltransferase +FIG01275248 Putative ABC transporter of substrate X, ATP- binding subunit; interrupted +FIG01275415 archaeal ATPase, fused to C-terminal DUF234 domain +FIG01275533 190 kD antigen precursor +FIG01275596 Beta-galactosidase (EC 3.2.1.23), LacA family +FIG01275784 identified by similarity to GB:AAK22812.1; match to protein family HMM PF06676 +FIG01275817 FIG01275823: hypothetical protein +FIG01275861 MSHA pilin protein MshB +FIG01275912 Type-IV sectretion leader peptidase/N-methyltransferase +FIG01275927 FIG01275930: hypothetical protein +FIG01275930 BH2577 unknown conserved protein in B. subtilis +FIG01276032 Quinol oxidase (SoxABC), cytochrome aa3 subunit (SoxB) +FIG01276057 FIG01276059: hypothetical protein +FIG01276099 Flagellar biosynthesis protein FliO +FIG01276112 Xylose ABC transporter, permease component +FIG01276129 Catalyzes the cleavage of p-aminobenzoyl-glutamate to p-aminobenzoate and glutamate, subunit A +FIG01276198 FIG01276199: hypothetical protein +FIG01276217 CRISPR-associated protein, Cse1 family +FIG01276220 Lysyl endopeptidase (EC 3.4.21.50) +FIG01276259 FIG01276260: hypothetical protein +FIG01276260 FIG01276261: hypothetical protein +FIG01276261 FIG01276262: hypothetical protein +FIG01276262 FIG01276263: hypothetical protein +FIG01276341 FIG01276356: hypothetical protein +FIG01276359 FIG01276362: hypothetical protein +FIG01276429 Formate dehydrogenase N gamma subunit (EC 1.2.1.2) +FIG01276430 Probable transmembrane protein +FIG01276436 hypothetical protein in Cytochrome oxidase biogenesis cluster +FIG01276459 Extracellular Matrix protein PelG +FIG01276473 FOG: GGDEF domain +FIG01276477 Extracellular Matrix protein PelD +FIG01276480 Extracellular Matrix protein PelE +FIG01276558 FIG01276569: hypothetical protein +FIG01276569 HYPOTHETICAL/UNKNOWN PROTEIN +FIG01276740 FIG01276757: hypothetical protein +FIG01276757 FIG01276758: hypothetical protein +FIG01276953 FIG01276954: hypothetical protein +FIG01276954 Type IV pilus biogenesis protein PilMx +FIG01277113 FIG01277115: hypothetical protein +FIG01277169 FIG01277171: hypothetical protein +FIG01277241 FIG01277244: hypothetical protein +FIG01277293 T4-like phage baseplate hub + tail lysozyme +FIG01277296 Phage baseplate hub +FIG01277306 FIG01277307: hypothetical protein +FIG01277329 FIG01277330: hypothetical protein +FIG01277399 PROBABLE TRANSCRIPTION REGULATOR PROTEIN +FIG01277400 hydrolytic protein +FIG01277473 PE-PGRS virulence associated protein +FIG01277515 FIG01277535: hypothetical protein +FIG01277551 Inorganic pyrophospatase PpaX +FIG01277629 FIG01277638: hypothetical protein +FIG01277638 ADP-ribose pyrophosphatase (EC 3.6.1.13) homolog +FIG01277640 Uncharacterized protein YohN precursor +FIG01277656 FIG01277657: hypothetical protein +FIG01277734 Putative PROLIN-rich signal peptide protein +FIG01277865 FIG01277875: hypothetical protein +FIG01277875 FIG01277876: hypothetical protein +FIG01277909 Predicted molybdopterin biosynthesis related methylmutase domain / Molybdopterin biosynthesis protein MoeA +FIG01277940 Copper resistance protein C precursor +FIG01277980 FIG01277981: hypothetical protein +FIG01278028 FIG01278029: hypothetical protein +FIG01278029 FIG01278034: hypothetical protein +FIG01278058 FIG01278065: hypothetical protein +FIG01278070 Predicted oxidoreductase, Fe-S subunit +FIG01278139 Ferrous iron transport protein A, putative +FIG01278148 FIG01278177: hypothetical protein +FIG01278268 Teichoic acid biosynthesis protein +FIG01278337 Cytochrome c family protein +FIG01278354 FIG01278370: hypothetical protein +FIG01278539 cyclolysin secretion protein +FIG01278543 FIG01278568: hypothetical protein +FIG01278587 FIG009688: Thioredoxin +FIG01278743 FIG01278745: hypothetical protein +FIG01278848 FIG01278852: hypothetical protein +FIG01278856 Uncharacterized protein YgeP +FIG01278891 Probable polyketide synthase, similar to many. e.g. gp|M63676|SERERYAA_1 S.erythraea first ORF of eryA gene, involved in complex polyketide formation in erythromycin biosynthesis. +FIG01278941 Translation initiation factor 2 fragment +FIG01279035 L-arabinose-binding periplasmic protein precursor AraF (TC 3.A.1.2.2) +FIG01279135 Folylpolyglutamate synthase (EC 6.3.2.17) +FIG01279153 FIG01279159: hypothetical protein +FIG01279159 Nicotinate-nucleotide adenylyltransferase (EC 2.7.7.18) +FIG01279179 Rod shape-determining protein MreC +FIG01279186 FIG01279193: hypothetical protein +FIG01279193 FIG000557: hypothetical protein +FIG01279237 Manganese superoxide dismutase +FIG01279359 Protein of unknown function DUF182 +FIG01279374 3-ketoacyl-CoA thiolase (EC 2.3.1.16) +FIG01279384 Ribosomal small subunit pseudouridine synthase A (EC 4.2.1.70);RsuA-16S rRNA pseudouridylate 516 synthase +FIG01279435 tRNA 5-methylaminomethyl-2-thiouridine synthase TusB +FIG01279446 Hydrogenase-4 maturation protease +FIG01279457 FIG01279458: hypothetical protein +FIG01279458 XRE-like DNA-binding protein +FIG01279471 DNA-binding response regulator PhoP +FIG01279473 putative ABC transporter, oligopeptides +FIG01279495 transcriptional regulator, GntR family +FIG01279501 DNA replication inhibitor protein +FIG01279517 D-glycero-D-manno-heptose 1-phosphate guanosyltransferase +FIG01279548 Cytochrome c-type biogenesis protein CcdA (DsbD analog) / Ccs1/ResB-related putative cytochrome C-type biogenesis protein +FIG01279717 cytochrome c551 +FIG01279727 FIG01279730: hypothetical protein +FIG01279739 Internalin-like protein (LPXTG motif) Lin0290 homolog +FIG01279765 Histone deacetylase 6 +FIG01279781 Glyoxylase family protein +FIG01279791 Aminotransferase, class III +FIG01279810 Late competence protein ComGE, FIG075573 +FIG01279824 FIG01279834: hypothetical protein +FIG01279839 formate/nitrite transporter +FIG01279844 Two component, Sigma-54 Specific, central transcriptional regulator of acidic amino acid uptake +FIG01279859 Substrate-specific component SCO2325 of predicted cobalamin ECF transporter +FIG01279872 FIG01279884: hypothetical protein +FIG01279926 outer membrane copper receptor OprC +FIG01279934 Unspecified monosaccharide ABC transport system, permease component Ib (FIG143636) +FIG01279965 cytochrome c-type biogenesis protein CcmF +FIG01279982 General secretion pathway protein A / General secretion pathway protein B +FIG01280006 Cyclopropane-fatty-acyl-phospholipid synthase PcaA (EC 2.1.1.79) +FIG01280018 putative P-type ATPase transporter for copper +FIG01280029 YisI +FIG01280036 TonB system receptor, putative [KO:K02014] +FIG01280045 TmhB-like bacteriocin enhancer peptide +FIG01280057 Putative morphological differentiation-related protein +FIG01280065 FIG01280076: hypothetical protein +FIG01280122 Capsular polysaccharide synthesis enzyme Cap5F +FIG01280137 Similar to coproporphyrinogen III oxidase, oxygen-independent (EC 1.3.99.22) +FIG01280183 Putative two-component response regulatory protein +FIG01280224 Na(+)/H(+) antiporter subunit F (Multiple resistance and pH homeostasis protein F) (Mrp complex subunit F) +FIG01280248 FIG01280259: hypothetical protein +FIG01280259 Duplicated ATPase component SCO2324 of energizing module of predicted cobalamin ECF transporter +FIG01280337 Phosphotransferase system fructose-specific component IIB +FIG01280345 LSU m3Psi1915 methyltransferase RlmH +FIG01280354 Hydroxyaromatic non-oxidative decarboxylase protein B (EC 4.1.1.-) / Hydroxyaromatic non-oxidative decarboxylase protein C (EC 4.1.1.-) +FIG01280365 PTS system, galactosamine-specific IIA component (EC 2.7.1.69) +FIG01280380 YciO family +FIG01280410 ferrichrome transport ATP-binding protein fhuC +FIG01280473 FIG01280474: hypothetical protein +FIG01280474 FIG01280477: hypothetical protein +FIG01280486 "Cysteine synthase " +FIG01280521 Outer membrane protein X precursor +FIG01280538 UDP-N-acetylmuramoylalanyl-D-glutamate--L-ornithine ligase @ UDP-N-acetylmuramoylalanyl-D-glutamate--L-lysine ligase (EC 6.3.2.7) +FIG01280579 Zn-dependent hydrolase +FIG01280583 transcriptional regulator; glutamine synthetase repressor +FIG01280600 cytochrome c3 +FIG01280635 Probable ATP-binding ABC transporter protein +FIG01280654 CoA-disulfide reductase (EC 1.8.1.14) / Disulfide bond regulator +FIG01280689 Response regulator, ompR family [USSDB2A] +FIG01280757 FIG01280790: hypothetical protein +FIG01280831 FIG01280833: hypothetical protein +FIG01280833 putative Rhodanese-related sulfurtransferase +FIG01280842 putative cell division protein (FtsB-like) +FIG01280852 FIG01280857: hypothetical protein +FIG01280922 probable dihydrokaempferol 4-reductase +FIG01280947 3-oxoacid CoA-transferase, B subunit( EC:2.8.3.5 ) +FIG01280951 transcriptional regulator-like protein +FIG01280956 biotin/lipoyl attachment domain-containing protein +FIG01280957 malate synthase A +FIG01280960 carbon monoxide dehydrogenase subunit G +FIG01280964 6-phosphogluconate dehydrogenase NAD-binding +FIG01280965 gid protein +FIG01280967 FIG01280972: hypothetical protein +FIG01280972 DsbA oxidoreductase +FIG01280973 UDP-GLUCOSE 4-EPIMERASE (EC 5.1.3.2) +FIG01280976 Uracil-DNA glycosylase superfamily +FIG01280989 Inorganic diphosphatase( EC:3.6.1.1 ) +FIG01280993 Long-chain-fatty-acid CoA ligase +FIG01281005 cobalamin (vitamin B12) biosynthesis CbiM protein +FIG01281009 FIG01281010: hypothetical protein +FIG01281021 Carbon monoxide oxidation accessory protein CoxE +FIG01281027 Two-component system response regulator CreC +FIG01281028 Hsp33 protein +FIG01281067 Flp/Fap pilin component +FIG01281109 ABC transporter, substrate-binding protein, aliphatic sulfonates family +FIG01281111 homocysteine S-methyltransferase +FIG01281113 DNA polymerase I 5'-3' exonuclease domain +FIG01281120 nickel-dependent hydrogenase large subunit +FIG01281132 nucleoside recognition domain protein +FIG01281139 MCP methyltransferase, CheR-type( EC:2.1.1.80 ) +FIG01281142 ABC branched chain amino acid transporter, periplasmic ligand binding protein +FIG01281153 cytochrome bd ubiquinol oxidase subunit II +FIG01281156 Thimet oligopeptidase (EC 3.4.24.15) +FIG01281167 soluble lytic murein transglycosylase, putative +FIG01281168 Response regulator receiver domain protein (CheY-like) +FIG01281172 amino acid/peptide transporter +FIG01281175 NosL protein +FIG01281179 hydrogenase expression/synthesis HypA +FIG01281185 phage SPO1 DNA polymerase-related protein +FIG01281221 FIG01281222: hypothetical protein +FIG01281222 2-amino-4-hydroxy-6-hydroxymethyldihydropteridine pyrophosphokinase (EC 2.7.6.3) +FIG01281230 FIG01281232: hypothetical protein +FIG01281232 FIG01281237: hypothetical protein +FIG01281237 glycerate dehydrogenase +FIG01281243 TonB-dependent outer membrane receptor +FIG01281247 outer membrane protein SusE +FIG01281253 Arylsulfatase +FIG01281272 FIG146085: 3-to-5 oligoribonuclease A, Bacillus type +FIG01281286 Flavodoxin reductases (ferredoxin-NADPH reductases) family 1 +FIG01281301 putative peptide ABC transporter permease protein +FIG01281302 FtsX-like protein involved in cell division +FIG01281305 probable membrane channel protein +FIG01281307 probable cation efflux protein +FIG01281311 Long-chain-fatty-acid--CoA ligase (EC 6.2.1.3) +FIG01281314 FIG01281319: hypothetical protein +FIG01281321 Phosphate ABC transporter, periplasmic phosphate-binding protein PstS (TC 3.A.1.7.1) +FIG01281330 dehydrogenase or reductase protein( EC:1.1.1.274 ) +FIG01281332 FIG01281335: hypothetical protein +FIG01281353 FIG01281357: hypothetical protein +FIG01281357 dipeptide transport ATP-binding protein +FIG01281364 FIG01281365: hypothetical protein +FIG01281365 possible pyrophosphate-releasing NTPase in MutT family +FIG01281377 Phosphoglycerate dehydrogenase +FIG01281384 FIG01281385: hypothetical protein +FIG01281385 COG0395: ABC-type sugar transport system, permease component +FIG01281390 FIG01281398: hypothetical protein +FIG01281447 Uncharacterized protein Bsu YraM +FIG01281456 4HBT, 4-hydroxybenzoyl-CoA thioesterase +FIG01281461 putative hydroxymethylglutaryl-CoA lyase +FIG01281510 uridylate kinase( EC:2.7.4.22 ) +FIG01281517 DNA polymerase related protein +FIG01281526 enoyl-CoA hydratase( EC:4.2.1.17 ) +FIG01281539 Arsenate reductase (EC 1.20.4.1); ArsR family transcriptional regulator +FIG01281573 putative sulfonate transport system substrate-binding protein +FIG01281599 lactonase +FIG01281618 fumarylacetoacetate (FAA) hydrolase +FIG01281661 conserved protein of unknown function; putative outer membrane protein +FIG01281666 lipoprotein releasing system, transmembrane protein, LolC/E family +FIG01281670 gluconolactonase protein family +FIG01281786 FIG01281806: hypothetical protein +FIG01281806 Non-ribosomal peptide synthetase modules, pyoverdine?? @ Siderophore biosynthesis non-ribosomal peptide synthetase modules +FIG01281829 membrane fusion protein, RND efflux pump +FIG01281839 precorrin methylase protein +FIG01281864 FIG01281866: hypothetical protein +FIG01281867 putative oxygenase +FIG01281868 Putative monooxygenase, FAD-binding +FIG01281869 Pentachlorophenol 4-monooxygenase (EC 1.14.13.50) +FIG01281959 D-3-phosphoglycerate dehydrogenase [EC:1.1.1.95] +FIG01282019 Rhodanese-related sulfurtransferase( EC:2.8.1.1 ) +FIG01282054 Flagellar hook-length control protein FliK +FIG01282132 ABC transporter, periplasmic ligand binding protein +FIG01282152 FIG01282161: hypothetical protein +FIG01282202 FIG01282206: hypothetical protein +FIG01282223 GCN5-related N-acetyltransferase (EC 2.3.1.57) +FIG01282243 ABC-type arginine transport system, permease component +FIG01282247 ABC branched chain amino acid family transporter, periplasmic ligand binding protein +FIG01282290 FIG01282305: hypothetical protein +FIG01282336 D-alanine--D-alanine ligase (EC 6.3.2.4) / UDP-N-acetylmuramate--alanine ligase (EC 6.3.2.8) +FIG01282379 3-oxoacyl-(acyl-carrier-protein) reductase, putative +FIG01282386 photosystem P840 reaction center cytochrome c-551 +FIG01282398 protein of unknown function DUF214 +FIG01282447 Beta-phosphoglucomutase hydrolase +FIG01282474 aconitate hydratase 1( EC:4.2.1.3 ) +FIG01282484 acriflavin resistance protein +FIG01282500 ferric siderophore receptor, putative, TonB receptor family +FIG01282519 FIG01282537: hypothetical protein +FIG01282537 FIG01282548: hypothetical protein +FIG01282554 FIG01282559: hypothetical protein +FIG01282570 putative cell division protein FtsL +FIG01282587 Electron transfer flavoprotein beta-subunit +FIG01282594 Cell division protein FtsI [Peptidoglycan synthetase] (EC 2.4.1.129) +FIG01282595 hydrogenase maturation protease +FIG01282611 D-hydantoinase( EC:3.5.2.2 ) +FIG01282619 FIG00674010: hypothetical protein +FIG01282620 FIG01282626: hypothetical protein +FIG01282626 FIG01282627: hypothetical protein +FIG01282627 phage major capsid protein, HK97 family +FIG01282638 FIG134140: hypothetical protein +FIG01282668 probable P-loop kinase or ATPase distantly related to phosphoenolpyruvate carboxykinase +FIG01282701 Flagellar hook-length control protein fliK +FIG01282713 FIG01282719: hypothetical protein +FIG01282736 FIG01282744: hypothetical protein +FIG01282744 Pyruvate carboxylase, C-terminal domain/subunit (EC 2.1.3.1) +FIG01282748 Na(+) H(+) antiporter subunit F +FIG01282750 FIG01282753: hypothetical protein +FIG01282753 Oxaloacetate decarboxylase, divalent-cation-dependent (EC 4.1.1.3) +FIG01282754 nitrogen regulatory protein PII +FIG01282756 SigD +FIG01282761 selenocysteine lyase +FIG01282766 Trehalose-6-phosphate synthase (EC 2.4.1.15) +FIG01282771 FIG01282775: hypothetical protein +FIG01282781 FIG01282784: hypothetical protein +FIG01282784 thiamin biosynthesis ThiS +FIG01282796 FIG01282797: hypothetical protein +FIG01282799 FIG01282800: hypothetical protein +FIG01282817 transglycosylase, Slt family +FIG01282883 DNA repair protein, HhH-GPD family +FIG01282935 Pyrrolysyl-tRNA synthetase (EC 6.1.1.26) +FIG01282967 formate dehydrogenase, beta subunit, putative +FIG01282981 flagellar basal-body rod protein, putative +FIG01282984 FIG01282996: hypothetical protein +FIG01282996 FIG01283008: hypothetical protein +FIG01283023 Branched-chain amino acid aminotransferase (EC 2.6.1.42) +FIG01283035 octaprenyl-diphosphate synthase +FIG01283040 COG1413: FOG: HEAT repeat +FIG01283044 Tetraheme cytochrome c isozyme 2 +FIG01283051 FIG01283052: hypothetical protein +FIG01283052 Biotin-protein ligase (EC 6.3.4.15) +FIG01283057 phosphoenolpyruvate synthase, putative +FIG01283082 Probable glycerol-1-phosphate dehydrogenase +FIG01283083 NADH-ubiquinone/plastoquinone oxidoreductase family protein +FIG01283085 Deoxyuridine 5'-triphosphate nucleotidohydrolase +FIG01283213 Head completion/stabilization protein +FIG01283217 putative DNA N-6-adenine methyltransferase +FIG01283219 Capsid scaffolding protein +FIG01283220 Small terminase subunit +FIG01283224 FIG01283235: hypothetical protein +FIG01283235 Aldehyde-alcohol dehydrogenase +FIG01283243 Protein NinB +FIG01283301 putative molybdopterin converting factor +FIG01283310 FIG01283325: hypothetical protein +FIG01283362 Arginine/ornithine antiporter +FIG01283374 FIG01283404: hypothetical protein +FIG01283405 Sugar-binding transcriptional regulator LacI family +FIG01283412 Aliphatic sulfonates transport system permease protein +FIG01283417 Two component, sigma54 specific, transcriptional regulator, Fis family +FIG01283424 sensor histidine kinase +FIG01283427 long-chain-fatty-acid--CoA ligase, putative +FIG01283430 Ferredoxin +FIG01283439 Signal transduction protein containing GAF and PtsI domains +FIG01283460 Cobalt-precorrin-3b C17-methyltransferase / Cobyric acid synthase (EC 6.3.5.10) +FIG01283470 Fe(III) reductase, alpha subunit +FIG01283472 Periplasmic deca-heme c-type cytochrome +FIG01283507 FIG01283510: hypothetical protein +FIG01283514 FIG01283525: hypothetical protein +FIG01283532 F0F1 ATP synthase subunit I( EC:3.6.3.14 ) +FIG01283533 Heme/hemopexin utilization protein C precursor +FIG01283539 Hemin-binding lipoprotein HbpA +FIG01283554 Glyceraldehyde-3-phosphate ketol-isomerase (EC 5.3.1.1) @ Triosephosphate isomerase (EC 5.3.1.1) +FIG01283556 lipooligosaccharide 5G8 epitope biosynthesis-associated protein (lex2B) +FIG01283557 putative NA+/H+ ANTIPORTER +FIG01283579 signal-transducing protein, histidine kinase +FIG01283608 Tfp pilus assembly protein PilF +FIG01283631 putative glycine cleavage system H protein +FIG01283636 Cell division membrane protein +FIG01283637 FIG013736: cell division protein (putative) +FIG01283640 FIG01283651: hypothetical protein +FIG01283651 two-component system histidine kinase +FIG01283678 cysteine aminopeptidase +FIG01283682 contains 1,4-dihydroxy-2-naphthoate octaprenyltransferase domain +FIG01283699 rod-shape determining protein +FIG01283700 glutamine synthetase, type I( EC:6.3.1.2 ) +FIG01283712 putative ribosomal protein S1 +FIG01283727 galactitol PTS, EIIB( EC:2.7.1.69 ) +FIG01283734 contains glycosyl hydrolases family 31 domain +FIG01283741 Peptidase U35, phage prohead HK97 +FIG01283763 Phosphonate ABC transporter phosphate-binding periplasmic component (TC 3.A.1.9.1) homolog +FIG01283764 Phage DNA binding protein +FIG01283766 FIG01283769: hypothetical protein +FIG01283769 sorbitol-6-phosphate 2-dehydrogenase +FIG01283811 FIG01283813: hypothetical protein +FIG01283820 Xanthine/uracil permease +FIG01283826 HelB protein +FIG01283827 Lipid A lauroyl acyltransferase (EC 2.3.1.-) +FIG01283831 FIG01283879: hypothetical protein +FIG01283879 OsmC-like protein +FIG01283886 Internalin H (LPXTG motif) +FIG01283947 FIG01283953: hypothetical protein +FIG01283967 ferredoxin 1-related protein +FIG01283973 Integral membrane protein EccD4, component of Type VII secretion system ESX-4 +FIG01284055 Phthiocerol/phthiodiolone dimycocerosyl transferase PapA5 (EC 2.3.1.-) +FIG01284061 Alkyl hydroperoxide reductase subunit C-like protein +FIG01284066 Bona fide RidA/YjgF/TdcF/RutC subgroup +FIG01284078 FIG01284085: hypothetical protein +FIG01284120 FIG01284148: hypothetical protein +FIG01284162 "3-oxoacyl-[acyl-carrier-protein] synthase, KASIII (EC 2.3.1.41)" +FIG01284177 Putative cystathionine gamma-lyase (EC 4.4.1.1) (Gamma-cystathionase) +FIG01284192 EstC +FIG01284195 DNA gyrase subunit A (EC 5.99.1.3) @ intein-containing +FIG01284233 Transport protein SgaT +FIG01284234 Probable ABC transporter permease protein MG188 homolog +FIG01284243 PTS system enzyme IIB component (EC 2.7.1.69) +FIG01284256 Aspartyl-tRNA(Asn) amidotransferase subunit C (EC 6.3.5.6) @ Glutamyl-tRNA(Gln) amidotransferase subunit C (EC 6.3.5.7) +FIG01284257 Riboflavin biosynthesis protein (EC 2.7.1.26) +FIG01284259 predicted metal-dependent hydrolase +FIG01284268 FIG01284285: hypothetical protein +FIG01284285 FIG01284295: hypothetical protein +FIG01284456 Putative protease La homolog (EC 3.4.21.-) +FIG01284537 possible photosystem I reaction centre subunit XII (PsaM) +FIG01284555 serum resistance locus BrkB-like protein +FIG01284556 possible Photosystem II reaction center Z protein (PsbZ) +FIG01284564 Phycoerythrin beta chain; Phycoerythrin class III beta chain +FIG01284566 phycobilisome protein +FIG01284571 cell division protein FtsH2 +FIG01284590 Phycoerythrin alpha chain; Phycoerythrin class III alpha chain +FIG01284603 FIG01284606: hypothetical protein +FIG01284606 FIG01284611: hypothetical protein +FIG01284611 Cell division protein FtsH (EC 3.4.24.-) +FIG01284631 beta-galactosidase fused to beta-N-acetylhexosaminidase +FIG01284694 Monoamine oxidase +FIG01284759 Cyclic nucleotide-binding protein +FIG01284766 still frameshift probable component of chemotactic signal transduction system +FIG01284774 Chemotaxis response regulator protein-glutamate methylesterase group 3 operon (EC 3.1.1.61) +FIG01284833 Vfr transcriptional regulator / Cyclic AMP receptor protein +FIG01284836 Histidine transport ATP-binding protein HisP (TC 3.A.1.3.1) +FIG01284856 Nucleotidyl transferase possibly involved in threonylcarbamoyladenosine formation +FIG01284880 lipopolysaccharide core biosynthesis protein, putative +FIG01284900 RND transporter, membrane fusion protein +FIG01284907 COG2010: Cytochrome c, mono- and diheme variants +FIG01284934 Probable glutamine synthetase +FIG01284972 Toluate 1,2-dioxygenase alpha subunit +FIG01284982 Oxidoreductase, zinc-binding +FIG01285018 FIG01285020: hypothetical protein +FIG01285036 3-hydroxyisobutyrate dehydrogenase family protein +FIG01285070 HTH-type transcriptional regulator trpI +FIG01285094 Lysine decarboxylase (EC 4.1.1.18) +FIG01285124 Glycine betaine/carnitine/choline ABC transporter, ATP-binding protein +FIG01285191 FIG01285202: hypothetical protein +FIG01285202 FIG01285227: hypothetical protein +FIG01285229 FIG01285262: hypothetical protein +FIG01285272 PROBABLE FLAGELLA SYNTHESIS PROTEIN FLGN +FIG01285273 Guanyl-specific ribonuclease Sa +FIG01285290 FIG01285306: hypothetical protein +FIG01285329 FIG01285335: hypothetical protein +FIG01285337 flagellar hook-basal body complex protein FliE +FIG01285433 probable UDP-glucose 4-epimerase +FIG01285456 Probable SigD protein +FIG01285471 InterPro IPR006442 +FIG01285478 FIG01285498: hypothetical protein +FIG01285508 VirR +FIG01285540 Alcohol dehydrogenase +FIG01285542 Lipoprotein-releasing system ATP-binding protein lolD 1 (EC 3.6.3.-) +FIG01285562 D-isomer specific 2-hydroxyacid dehydrogenase, NAD-binding +FIG01285563 D-3-phosphoglycerate dehydrogenase (EC 1.1.1.95) +FIG01285596 intracellular polyhydroxyalkanoate depolymerase +FIG01285607 FIG01285608: hypothetical protein +FIG01285608 Peptidylprolyl isomerase( EC:5.2.1.8 ) +FIG01285614 Mlr2698 protein +FIG01285624 FIG01285637: hypothetical protein +FIG01285637 FIG01285663: hypothetical protein +FIG01285663 Bll7107 protein +FIG01285665 FlhB-related protein +FIG01285679 Alcohol dehydrogenase [acceptor] precursor (EC 1.1.99.8) +FIG01285681 FIG01285689: hypothetical protein +FIG01285689 Multiple resistance and pH regulation protein F precursor +FIG01285697 COG1530: Ribonucleases G and E +FIG01285714 hypothetical 3-hydroxyacyl-CoA dehydrogenase (FadB) +FIG01285716 POSSIBLE 1-ACYL-SN-GLYCEROL-3-PHOSPHATE ACYLTRANSFERASE (plsC) +FIG01285769 FIG01285771: hypothetical protein +FIG01285771 aminotransferase family protein +FIG01285796 esterase, putative +FIG01285815 Glutathione S-transferase, putative (EC 2.5.1.18) +FIG01285817 Amidase, hydantoinase/carbamoylase family +FIG01285824 Transglycosylase SLT domain protein +FIG01285938 Fimbrial subunit +FIG01285990 Cold shock-like protein +FIG01285993 LysR-family transcriptional regulator STM3020 +FIG01286001 Polysaccharide biosynthesis/export protein +FIG01286029 Ada regulatory protein, putative +FIG01286042 Peptide methionine sulfoxide reductase msrA (EC 1.8.4.11) (Protein-methionine-S-oxide reductase) (Peptide-methionine (S)-S-oxide reductase) (Peptide Met(O) reductase) +FIG01286051 Esterase/lipase (EC 3.1.-.-) +FIG01286059 FIG01286067: hypothetical protein +FIG01286067 Nucleotide-binding protein implicated in inhibition of septum formation +FIG01286077 PROBABLE SIGMA-54 INTERACTING RESPONSE REGULATOR TRANSCRIPTION REGULATOR PROTEIN +FIG01286082 FIG01286086: hypothetical protein +FIG01286088 FIG01286109: hypothetical protein +FIG01286109 outer membrane efflux family protein, putative +FIG01286110 Periplasmic septal ring factor with murein hydrolase activity EnvC/YibP +FIG01286118 Sodium/calcium exchanger +FIG01286125 Flagellar protein lafL +FIG01286128 TonB-dependent heme receptor +FIG01286136 Transcriptional regulator response CpxR two-component regulatory DNA-Binding +FIG01286137 Transcriptional regulator CpxR +FIG01286141 Sigma-54 dependent transcriptional regulator/sensory box protein +FIG01286155 Response regulator, LuxR family +FIG01286168 ATP-dependent protease La (LON) domain protein, putative +FIG01286188 FIG01286189: hypothetical protein +FIG01286189 RND multidrug efflux membrane fusion protein MexE +FIG01286205 Chemotaxis protein CheV +FIG01286226 TonB-dependent receptor, homolog 2 +FIG01286301 dehydrogenase, (succinatesemialdehyde dehydrogenase, aldehyde dehydrogenase, aldehyde dehydrogenase) +FIG01286318 Hypothetical protein, PVL orf52 homolog [SA bacteriophages 11, Mu50B] +FIG01286330 Adhesin of unknown specificity SdrC +FIG01286333 Hypothetical protein, PVL orf51 homolog [SA bacteriophages 11, Mu50B] +FIG01286340 Phage head protein [SA bacteriophages 11, Mu50B] / Phage major capsid protein +FIG01286348 major cold shock protein +FIG01286366 Broad-specificity glycerol dehydrogenase (EC 1.1.99.22), subunit SldB / Broad-specificity glycerol dehydrogenase (EC 1.1.99.22), subunit SldA +FIG01286408 putative collagen binding protein +FIG01286440 LacI family regulatory protein +FIG01286450 Foldase protein prsA 1 precursor (EC 5.2.1.8) +FIG01286478 CBS domain protein +FIG01286483 Collagen-like surface protein (Fragment) +FIG01286484 Sugar-binding transcriptional regulator, LacI family protein +FIG01286487 Drs12.02 gene +FIG01286518 Prophage pi2 protein 39 +FIG01286522 FIG01286523: hypothetical protein +FIG01286523 electron transfer oxidoreductase +FIG01286524 FIG01286525: hypothetical protein +FIG01286525 ABC sugar transporter, ATP-binding subunit +FIG01286540 NADH dehydrogenase subunit NuoJ2 +FIG01286573 FIG01286584: hypothetical protein +FIG01286589 NADH dehydrogenase subunit NuoM2 +FIG01286595 putative FAD-dependent oxidoreductase +FIG01286602 ABC transport system ATP-binding protein +FIG01286609 isobutyryl-CoA mutase A +FIG01286614 putative branched-chain amino acid ABC transport permease. +FIG01286682 Nitrate transport ATP-binding subunits C and D( EC:3.6.3.25 ) +FIG01286693 possible pseudouridine synthase +FIG01286702 N-acetylglucosamine kinase euakryotic type (EC 2.7.1.59) +FIG01286705 CDP-diacylglycerol-glycerol-3-phosphate 3-phosphatidyltransferase +FIG01286710 FIG01286716: hypothetical protein +FIG01286720 Phycocyanin beta chain; R-phycocyanin II beta chain +FIG01286724 FIG01286751: hypothetical protein +FIG01286757 FIG01286762: hypothetical protein +FIG01286796 M-related protein +FIG01286854 menaquinone-specific isochorismate synthase( EC:5.4.4.2 ) +FIG01286856 Aspartate aminotransferase( EC:2.6.1.1 ) +FIG01286888 ATP-binding protein (contains P-loop) +FIG01286892 COG4935: Regulatory P domain of the subtilisin-like proprotein convertases and other proteases +FIG01286924 FIG01286925: hypothetical protein +FIG01286925 ABC-type oligopeptide transport system, periplasmic component +FIG01286930 Flp pilus assembly protein, secretin CpaC +FIG01286955 Flp pilus assembly protein TadA +FIG01287032 pectinesterase +FIG01287035 cysteine synthase +FIG01287049 lipopolysaccharide core biosynthesis protein +FIG01287088 iron transporter +FIG01287102 FIG01287104: hypothetical protein +FIG01287109 FIG01287147: hypothetical protein +FIG01287199 FIG01287212: hypothetical protein +FIG01287225 Glycerol metabolism operon regulatory protein +FIG01287230 Oligosaccharide translocase (flippase) +FIG01287274 Uncharacterized ABC transporter ATP-binding protein ytrE +FIG01287310 Peptidoglycan N-acetylglucosamine deacetylase +FIG01287320 iron compound ABC transporter, ATP-binding protein +FIG01287332 internalin, putative +FIG01287339 sensor histidine kinase, C-terminal +FIG01287378 YfkI +FIG01287395 FIG01287407: hypothetical protein +FIG01287407 Proline,Na+ Cotransport +FIG01287456 Glucose epimerase +FIG01287466 Late competence protein ComC, processing protease / Leader peptidase (Prepilin peptidase) (EC 3.4.23.43) / N-methyltransferase (EC 2.1.1.-) +FIG01287470 glyoxalase family protein, putative +FIG01287474 FIG01287478: hypothetical protein +FIG01287478 dipeptide ABC transporter (permease) +FIG01287499 YdbP +FIG01287512 Protein-tyrosine kinase( EC:2.7.1.112 ) +FIG01287563 FIG01287568: hypothetical protein +FIG01287568 YwkB +FIG01287572 ABC transporter, ATP-binding protein; possible subtilin transporter +FIG01287595 LSU ribosomal protein L23p (L23Ae) / hypothetical protein +FIG01287600 Similar to ribosomal large subunit pseudouridine synthase F, group RluF1 +FIG01287669 DNA-3-methyladenine glycosylase II +FIG01287691 ATP:corrinoid adenosyltransferase +FIG01287703 flagellar protein FlaG protein +FIG01287725 MaoC domain protein +FIG01287744 Phage major spike protein +FIG01287762 FIG01287763: hypothetical protein +FIG01287773 FIG01287774: hypothetical protein +FIG01287774 Phage head completion protein +FIG01287779 FIG01287783: hypothetical protein +FIG01287789 Toluate 1,2-dioxygenase beta subunit +FIG01287810 FIG01287811: hypothetical protein +FIG01287811 Phage minor capsid protein - DNA pilot protein +FIG01287818 FIG01287819: hypothetical protein +FIG01287822 Phage prohead assembly (scaffolding) protein +FIG01287834 Putative N-carbamyl-L-cysteine amidohydrolase +FIG01287843 FIG01287849: hypothetical protein +FIG01287851 Putative pimeloyl-CoA dehydrogenase (Small subunit), PimD-like (EC 1.3.99.-) +FIG01287870 FIG01287873: hypothetical protein +FIG01287876 FIG01287877: hypothetical protein +FIG01287890 PTS system, lichenan-, cellobiose-specific IIB component (EC 2.7.1.69); PTS system, cellobiose-specific IIB component (EC 2.7.1.69) +FIG01287915 FIG01287916: hypothetical protein +FIG01287918 Daxx-like protein +FIG01287998 FIG01288000: hypothetical protein +FIG01288021 Phage internal scaffolding protein +FIG01288039 ATP-binding component of ABC transporter +FIG01288047 FIG01288054: hypothetical protein +FIG01288077 FIG01288080: hypothetical protein +FIG01288105 FIG01288107: hypothetical protein +FIG01288118 oligopeptide ABC transporter, oligopeptide-binding protein +FIG01288154 Alpha-glucosidase (EC 3.2.1.20) +FIG01288203 Duplicated ATPase component Cce_1530 of energizing module of predicted ECF transporter +FIG01288227 FIG01288235: hypothetical protein +FIG01288235 ATP-dependent RNA helicase RhlB +FIG01288237 FIG01288243: hypothetical protein +FIG01288267 FIG01288275: hypothetical protein +FIG01288305 FIG01288306: hypothetical protein +FIG01288306 FIG01288314: hypothetical protein +FIG01288329 FIG01288330: hypothetical protein +FIG01288340 FIG01288341: hypothetical protein +FIG01288350 probable capsid scaffolding protein +FIG01288360 FIG01288368: hypothetical protein +FIG01288373 FIG01288378: hypothetical protein +FIG01288380 Kynureninase (EC 3.7.1.3) homolog; Cysteine desulfurase (EC 2.8.1.7) +FIG01288547 23S rRNA (Uracil-5-) -methyltransferase rumB (EC 2.1.1.-) +FIG01288581 Two component system response regulator CiaR +FIG01288587 Nitrogen regulatory protein P-II, glnK +FIG01288606 Transcriptional activator HlyU +FIG01288623 ABC transporter, permease protein +FIG01288636 Formylmethanofuran dehydrogenase (molybdenum) subunit B (EC 1.2.99.5) @ selenocysteine-containing +FIG01288640 Acyl-CoA dehydrogenase family protein +FIG01288644 TsaC protein (YrdC-Sua5 domains) required for threonylcarbamoyladenosine t(6)A37 modification in tRNA +FIG01288647 sugar-binding transcriptional regulator, LacI family +FIG01288650 Alpha-1,4-digalacturonate ABC transporter, substrate-binding protein +FIG01288661 Glycolate permease +FIG01288685 FIG01288702: hypothetical protein +FIG01288706 Aspartate aminotransferase (EC 2.6.1.1) @ Biosynthetic Aromatic amino acid aminotransferase alpha (EC 2.6.1.57) +FIG01288720 D-alanyl-D-alanine carboxypeptidase (EC 3.4.16.4) +FIG01288732 FIG033266: Phage DNA binding protein +FIG01288745 Na+/H+ antiporter NhaP +FIG01288752 putative protein-export membrane protein +FIG01288765 ORF X +FIG01288789 Type III secretion injected virulence protein (YopH,tyrosine phosphatase of FAK and p130cas, prevents phagocytosis) +FIG01288795 Chaperonin, 10 kDa +FIG01288803 Coupling protein VirD4, ATPase required for T-DNA transfer +FIG01288810 Cyanophycin synthetase-like +FIG01288823 FIG003089: Probable transmembrane protein +FIG01288824 Lipoprotein of type IV secretion complex that spans outer membrane and periplasm, VirB7 +FIG01288836 ABC-type antimicrobial peptide transport system, ATPase component +FIG01288841 membrane protein, putative +FIG01288844 C5a peptidase precursor (EC 3.4.21.-) +FIG01288851 putative pectin degradation protein +FIG01288861 Lipoprotein of type IV secretion complex that spans outer membrane and periplasm (VirB7) +FIG01288872 VirB4 protein +FIG01288911 Cinnamyl alcohol dehydrogenase/reductase (EC 1.1.1.195) @ Alcohol dehydrogenase (EC 1.1.1.1) +FIG01288915 N-Ribosylnicotinamide phosphorylase (EC 2.4.2.1) +FIG01288919 Alcohol dehydrogenase (EC 1.1.1.1) clustered to malQ +FIG01288927 L,L-diaminopimelate aminotransferase (EC 2.6.1.83) +FIG01288932 Mannose-1-phosphate guanylyltransferase (GDP) (EC 2.7.7.22); Mannose-6-phosphate isomerase (EC 5.3.1.8) +FIG01288940 ErpA, essential respiratory protein A / probable iron binding protein from the HesB_IscA_SufA family +FIG01288955 Enoyl-CoA hydratase/isomerase family +FIG01288967 HTH-type transcriptional regulator zntR +FIG01288971 high-affinity branched-chain amino acid ABC ransporter, permease protein +FIG01289000 23S rRNA methyltransferase and Florfenicol/chloramphenicol resistance protein / Radical SAM family enzyme, UPF0063 family +FIG01289004 PQQ (Pyrrolo quinoline) WD40-like repeat, enzyme repeat domain protein +FIG01289005 23S rRNA (Uracil-5-) -methyltransferase RumA (EC 2.1.1.-) +FIG01289014 Sugar ABC transporter, sugar-binding protein +FIG01289018 transporter, EamA family +FIG01289021 Phosphopantetheinyl transferase component of siderophore synthetase (EC 2.7.8.-) +FIG01289032 putative molybdopterin biosynthesis protein +FIG01289037 DNA polymerase III, chi subunit +FIG01289047 oligopeptide transport system permease protein appB +FIG01289050 60 kDa chaperonin +FIG01289053 Lipoprotein of type IV secretion complex that spans outer membrane and periplasm, VirB7 +FIG01289056 chaperonin Cpn10 +FIG01289071 Spore cortex-lytic enzyme +FIG01289074 Ribosomal RNA large subunit methyltransferase N +FIG01289090 predicted Fe-S-cluster redox enzyme +FIG01289095 Flagellar basal-body rod modification protein flgD +FIG01289098 prophage Lp3 protein 18 +FIG01289107 FIG011178: rRNA methylase +FIG01289120 ElaA +FIG01289125 Transcriptional regulator, GntR family / Aspartate aminotransferase (EC 2.6.1.1) +FIG01289130 Acyl-CoA dehydrogenase FadE20 +FIG01289183 FIG01289191: hypothetical protein +FIG01289195 maltose O-acetyltransferase( EC:2.3.1.79 ) +FIG01289196 FIG01289198: hypothetical protein +FIG01289207 FIG01289214: hypothetical protein +FIG01289214 FIG01289227: hypothetical protein +FIG01289227 polysaccharide deacetylase, putative +FIG01289249 RNA polymerase, sigma-24 subunit, ECF subfamily +FIG01289300 ortholog to Borrelia burgdorferi BB0103 +FIG01289301 superoxide dismutase +FIG01289302 Protein-N(5)-glutamine methyltransferase PrmC, methylates polypeptide chain release factors RF1 and RF2 +FIG01289303 ortholog to Borrelia burgdorferi BB0545 +FIG01289306 ferric uptake regulation protein +FIG01289310 signal peptidase I (lepB-2) +FIG01289311 uridylate kinase +FIG01289325 putative ATP-binding component of a transport system +FIG01289331 Phosphate regulon sensor protein PhoR (EC 2.7.3.-) +FIG01289370 putative aliphatic sulfonates ABC transporter,substrate-binding lipoprotein +FIG01289381 SN-glycerol-3-phosphate transport ATP-binding protein ugpC (TC 3.A.1.1.3) +FIG01289407 prohead protease +FIG01289408 FIG01289410: hypothetical protein +FIG01289411 Lactose and galactose permease, GPH translocator family +FIG01289412 FIG01289414: hypothetical protein +FIG01289424 FIG01289430: hypothetical protein +FIG01289451 FIG01289452: hypothetical protein +FIG01289454 FIG01289464: hypothetical protein +FIG01289478 FIG01289484: hypothetical protein +FIG01289496 putative sugar-phosphate nucleotidyl transferase +FIG01289503 Bsu YqfO NIF3/CutA domain +FIG01289518 FIG01289528: hypothetical protein +FIG01289528 oligopeptide ABC transporter, permease protein +FIG01289538 Portal protein, phage associated +FIG01289549 FIG01289553: hypothetical protein +FIG01289554 Probable DNA polymerase III, delta prime subunit (EC 2.7.7.7) +FIG01289564 Acetyl xylan esterase XylU (EC 3.1.1.41) +FIG01289571 proton/glutamate symporter +FIG01289577 ABC transporter vitamin B12 uptake permease +FIG01289587 FIG01289588: hypothetical protein +FIG01289589 bacterial extracellular solute-binding protein, family 5 +FIG01289595 Inosine-uridine preferring nucleoside hydrolase +FIG01289618 CDP-diacylglycerol--glycerol-3-phosphate 3-phosphatidyltransferase (EC 2.7.8.5) / C-terminal domain of CinA type S; Protein Implicated in DNA repair function with RecA and MutS +FIG01289645 probable tRNA/rRNA methyltransferase +FIG01289654 FIG01289657: hypothetical protein +FIG01289673 narrowly conserved hypothetical protein possibly in the MutT/Nudix family +FIG01289678 DNA polymerase III subunit delta' +FIG01289681 Thiamine pyrophosphate-requiring enzymes [acetolactate synthase, pyruvate dehydrogenase (cytochrome), glyoxylate carboligase, phosphonopyruvate decarboxylase] +FIG01289682 Taurine transport system permease protein tauC +FIG01289685 PROBABLE CARDIOLIPIN SYNTHETASE TRANSMEMBRANE PROTEIN (EC 2.7.8.-) +FIG01289690 FIG01289694: hypothetical protein +FIG01289694 FIG01289695: hypothetical protein +FIG01289712 Butyryl-CoA dehydrogenase (EC 1.3.99.2) +FIG01289726 ampG protein, putative +FIG01289732 FIG01289736: hypothetical protein +FIG01289747 transcriptional regulator, arsR family +FIG01289783 FIG01289784: hypothetical protein +FIG01289810 FIG01289812: hypothetical protein +FIG01289905 PTS system, arbutin-, cellobiose-, and salicin-specific IIBC component (EC 2.7.1.69) +FIG01289913 FIG01289920: hypothetical protein +FIG01290002 polyketide synthase of type I +FIG01290007 Aspartokinase (EC 2.7.2.4) / Homoserine dehydrogenase (EC 1.1.1.3) +FIG01290011 FIG01290012: hypothetical protein +FIG01290033 serine/threonine protein kinases +FIG01290114 recombinase recT protein +FIG01290137 FIG01290145: hypothetical protein +FIG01290147 FIG01290151: hypothetical protein +FIG01290242 Phage capsid and scaffold +FIG01290285 FIG01290288: hypothetical protein +FIG01290411 FIG01290412: hypothetical protein +FIG01290464 Flagellar motor switch protein FliM +FIG01290482 FIG01290487: hypothetical protein +FIG01290487 dNTP triphosphohydrolase, broad substrate specificity, subgroup 2 +FIG01290501 Biotin synthesis protein BioG +FIG01290615 FIG01290618: hypothetical protein +FIG01290653 Phosphate regulon transcriptional regulatory protein PhoB (SphR) +FIG01290804 Minor fimbrial subunit StfE +FIG01290835 FIG01290840: hypothetical protein +FIG01290926 Prolyl-tRNA synthetase (EC 6.1.1.15), bacterial type +FIG01290960 hypothetical protein +FIG01291083 Protoporphyrinogen oxidase( EC:1.3.3.4 ) +FIG01291158 Methyl-accepting chemotaxis protein IV (dipeptide chemoreceptor protein) +FIG01291169 FIG01291173: hypothetical protein +FIG01291237 FIG01291246: hypothetical protein +FIG01291286 tRNA (adenine37-N(6))-methyltransferase TrmN6 (EC 2.1.1.223) +FIG01291334 Xanthine permease +FIG01291377 FIG01291385: hypothetical protein +FIG01291433 Bifunctional autolysin Atl / N-acetylmuramoyl-L-alanine amidase (EC 3.5.1.28) / Endo-beta-N-acetylglucosaminidase (EC 3.2.1.96) +FIG01291434 Phosphoesterase domain of DHH family / Phosphoglycolate phosphatase (EC 3.1.3.18) +FIG01291522 FIG01291525: hypothetical protein +FIG01291525 Fibronectin-binding protein +FIG01291539 D-galactarate dehydratase/Altronate hydrolase-like protein +FIG01291590 FIG01291597: hypothetical protein +FIG01291632 FIG01291636: hypothetical protein +FIG01291715 Phosphomannomutase (EC 5.4.2.8) / Phosphoglucomutase (EC 5.4.2.2) +FIG01291773 Mandelate racemase (EC 5.1.2.2) +FIG01291795 Modification methylase Sau3AI (EC 2.1.1.37) +FIG01291995 bsr protein +FIG01292191 FIG01292205: hypothetical protein +FIG01292214 Peptidyl-prolyl cis-trans isomerase ppiA precursor (EC 5.2.1.8) +FIG01292262 Putative terminase, superantigen-encoding pathogenicity islands SaPI +FIG01292343 FIG01292348: hypothetical protein +FIG01292367 FIG01292368: hypothetical protein +FIG01292371 [NiFe] hydrogenase metallocenter assembly protein HypF +FIG01292432 FIG01292433: hypothetical protein +FIG01292461 FIG01292463: hypothetical protein +FIG01292486 Threonine dehydrogenase and related Zn-dependent dehydrogenases +FIG01292499 hypothetical protein +FIG01292579 Oxaloacetate decarboxylase alpha chain (EC 4.1.1.3); Methylmalonyl-CoA decarboxylase alpha chain (EC 4.1.1.41) +FIG01292717 FIG01292722: hypothetical protein +FIG01292733 FIG01292735: hypothetical protein +FIG01292786 Aldehyde dehydrogenase (EC 1.2.1.3) +FIG01292933 FIG01292951: hypothetical protein +FIG01293075 Glutamine synthetase (EC 6.3.1.2) +FIG01293200 Formate dehydrogenase N alpha subunit (EC 1.2.1.2) @ selenocysteine-containing +FIG01293286 Tyrosine-protein phosphatase CpsB (EC 3.1.3.48) +FIG01293334 ABC transporter, carbohydrate uptake transporter-2 (CUT2) family, permease protein +FIG01293494 FIG01293498: hypothetical protein +FIG01293603 IncI1 plasmid conjugative transfer putative membrane protein PilT +FIG01293608 FIG01293609: hypothetical protein +FIG01293649 Uncharacterized protein YeaG +FIG01293726 Ferredoxin reductase / At1g63940 homolog +FIG01293852 FIG01293855: hypothetical protein +FIG01293855 FIG01293872: hypothetical protein +FIG01294188 possible Sensor with Chase2 domain +FIG01294236 Energy conserving hydrogenase Eha associated protein (protein S); Formylmethanofuran--tetrahydromethanopterin N-formyltransferase (EC 2.3.1.101) +FIG01294362 FIG01294367: hypothetical protein +FIG01294635 Biosynthetic Aromatic amino acid aminotransferase alpha (EC 2.6.1.57) @ Aspartate aminotransferase (EC 2.6.1.1) +FIG01294687 FIG01294690: hypothetical protein +FIG01294895 FIG01294898: hypothetical protein +FIG01294926 hypothetical protein +FIG01294968 FIG01294969: hypothetical protein +FIG01294994 FIG01295006: hypothetical protein +FIG01295084 Fumarylacetoacetate (FAA) hydrolase (EC 3.7.1.5) +FIG01295483 Gll1470 protein +FIG01295491 putative fatty acid:CoA ligase +FIG01295611 RTX toxins determinant A and related Ca2+-binding proteins / Cytolysin-adenylate cyclase (EC 4.6.1.1) +FIG01295752 L-rhamnonate transporter (predicted by genome context) +FIG01295845 Protein of unknown function YceH +FIG01295925 Glycosyltransferase MshA involved in mycothiol biosynthesis (EC 2.4.1.-) +FIG01296107 Putative peptidoglycan bound protein (LPXTG motif) Lmo0159 homolog +FIG01296202 Methylglyoxal reductase, acetol producing (EC 1.1.1.-) / 2,5-diketo-D-gluconate reductase A (EC 1.1.1.274) +FIG01296222 Eukaryotic translation initiation factor 4A +FIG01296235 Protein YjgF, putative endoribonuclease L-PSP +FIG01296283 proteasome regulatory subunit Rpn11 +FIG01296411 Sigma-fimbriae uncharacterized paralogous subunit +FIG01296457 proteasome regulatory subunit Rpn6 +FIG01296610 DNA replication terminus site-binding protein +FIG01296651 GDP-mannose pyrophosphatase YffH +FIG01296669 Diaminobutyrate-pyruvate aminotransferase (EC 2.6.1.46) +FIG01296685 ATPase component STY3232 of energizing module of queuosine-regulated ECF transporter +FIG01296719 DNA-binding protein HU / low-complexity, AKP-rich domain +FIG01296751 MFS family multidrug transport protein, bicyclomycin resistance protein +FIG01296775 DNA-directed RNA polymerase III largest subunit (EC 2.7.7.6) +FIG01296785 RTX toxin transporter, ATP-binding protein / cyclolysin secretion ATP-binding protein +FIG01296897 Nitric oxide -responding transcriptional regulator NnrR (Crp/Fnr family) +FIG01297086 Bona fide RidA/YjgF/TdcF/RutC subgroup +FIG01297124 Putative two-component sensor histidine kinase +FIG01297251 Putative sodium:solute symporter, similarity with yeast urea transporter DUR3 +FIG01297276 DNA-binding response regulator, LuxR family, near polyamine transporter +FIG01297317 isobutyryl-CoA dehydrogenase +FIG01297342 Putative permease PerM (= YfgO) +FIG01297346 type 1 fimbrae adaptor subunit FimG +FIG01297388 CRISPR-associated protein, Csa4 family +FIG01297553 Phage recombination-related endonuclease Gp46 +FIG01297554 Ferredoxin 3 fused to uncharacterized domain +FIG01297617 Eukaryotic translation initiation factor 3 110 kDa subunit +FIG01297652 Phage lysin, glycosyl hydrolase +FIG01297668 Steryl-sulfatase precursor (EC 3.1.6.2) +FIG01297753 Response regulator of the competence regulon ComE +FIG01297847 YjbE secreted protein +FIG01297962 Predicted glycosylase TM1225 +FIG01298069 Lysine ketoglutarate reductase (EC 1.5.1.8) (LOR) (LKR) / Saccharopine dehydrogenase (EC 1.5.1.9) +FIG01298098 Conserved protein YghT, with nucleoside triphosphate hydrolase domain +FIG01298121 FIG005429: hypothetical protein +FIG01298122 Translation initiation factor SUI1 +FIG01298141 3'-phosphatase, 5'-polynucleotide kinase, phage-associated +FIG01298169 Threonine catabolic operon transcriptional activator TdcR +FIG01298199 Transmembrane component STY3231 of energizing module of queuosine-regulated ECF transporter +FIG01298235 Periplasmic binding protein-related protein +FIG01298237 Meiosis-specific DNA cleavage protein SPO11 +FIG01298255 Phage recombination-related endonuclease Gp47 +FIG01298280 GTPase Nug1p, which associates with pre-60S ribosomal subunits in the nucleolus and is required for their export from the nucleus +FIG01298521 Lipoteichoic acid synthase LtaS Type IIb +FIG01298571 Predicted regulator of cellobiose and glucan utilization, LacI family +FIG01298657 LSU ribosomal protein L11p (L12e), mitochondrial +FIG01298677 YqxM protein, required for localization of TasA to extracellular matrix +FIG01298687 Single stranded DNA-binding protein, phage-associated +FIG01298698 Predicted carboxypeptidase +FIG01298743 DNA-directed RNA polymerase II second largest subunit (EC 2.7.7.6) +FIG01298864 Eukaryotic peptide chain release factor GTP-binding subunit +FIG01298953 ubiquitin-like protein fubi / SSU ribosomal protein S30e +FIG01298970 proteasome regulatory subunit Rpt3 +FIG01298991 RNA helicase, putative +FIG01299018 Chorismate mutase III (EC 5.4.99.5) +FIG01299026 FIG023675: hypothetical protein +FIG01299034 SSU ribosomal protein S12e +FIG01299099 Tyrosyl-tRNA synthetase (EC 6.1.1.1), mitochondrial +FIG01299133 Coagulation factor XIa, protease S01.213 +FIG01299163 Gas vesicle protein GvpC +FIG01299257 Methionyl-tRNA synthetase (EC 6.1.1.10), mitochondrial +FIG01299298 Putative iron-containing NADPH-dependent propanol dehydrogenase +FIG01299343 SSU ribosomal protein S15p (S13e), mitochondrial +FIG01299372 Nitric oxide synthase, inducible (EC 1.14.13.39) +FIG01299458 SSU ribosomal protein S7e +FIG01299560 LSU ribosomal protein L27e +FIG01299606 UDP-glucuronate decarboxylase (EC 4.1.1.35) +FIG01299705 Malonyl CoA-acyl carrier protein transacylase (EC 2.3.1.39); Enoyl-[acyl-carrier-protein] reductase [FMN] (EC 1.3.1.9) +FIG01299719 Nicotinamide-nucleotide adenylyltransferase, NadM family (EC 2.7.7.1) +FIG01299763 proteasome subunit beta2 (EC 3.4.25.1) +FIG01299822 Gas vesicle protein GvpO +FIG01299855 Gamma-glutamyl cyclotransferase (EC 2.3.2.4) +FIG01299858 Energy-conserving hydrogenase (ferredoxin), subunit A +FIG01299871 L-lysine aminomutase regulator +FIG01299885 DNA-directed RNA polymerase subunit Rpo13 (EC 2.7.7.6) +FIG01299891 threonine dehydrogenase +FIG01299904 Gas vesicle protein GvpF +FIG01299961 Pyochelin synthetase PchF, non-ribosomal peptide synthetase module +FIG01300053 Predicted regulator of fructose utilization, DeoR family +FIG01300072 DNA-directed RNA polymerase III second largest subunit (EC 2.7.7.6) +FIG01300083 DNA-directed RNA polymerase II largest subunit (EC 2.7.7.6) +FIG01300125 proteasome regulatory subunit Rpt6 +FIG01300233 Glutamyl-tRNA(Gln) amidotransferase subunit F (EC 6.3.5.7) +FIG01300296 Pyridoxal-5'-phosphate phosphatase (EC 3.1.3.74), eukaryotic type +FIG01300322 L-lactaldehyde dehydrogenase (NAD) @ Propionaldehyde dehydrogenase (NAD) @ Glyceraldehyde dehydrogenase (NAD) @ Crotonaldehyde dehydrogenase (NAD) +FIG01300344 Glutathione S-transferase, delta (EC 2.5.1.18) +FIG01300349 Xanthosine permease, C-terminus +FIG01300368 Eukaryotic translation initiation factor 5 +FIG01300389 proteasome regulatory subunit Rpn10 +FIG01300394 Putative alpha-glucosidase (EC 3.2.1.-) +FIG01300395 Phage outer membrane lytic protein Rz +FIG01300409 Ribonuclease J1 (endonuclease and 5' exonuclease) +FIG01300423 DNA topoisomerase II (EC 5.99.1.3) +FIG01300478 Internalin D (LPXTG motif) +FIG01300482 proteasome regulatory subunit Rpn5 +FIG01300489 Aldehyde dehydrogenase B (EC 1.2.1.22) +FIG01300492 proteasome regulatory subunit p28 +FIG01300606 Predicted inosose dehydrogenase +FIG01300611 Eukaryotic translation initiation factor 3 93 kDa subunit +FIG01300623 LSU ribosomal protein L41e +FIG01300659 Gas vesicle protein GvpH, heat shock protein Hsp20 +FIG01300697 Ferritin-like di-iron-carboxylate protein / Encapsulating protein for a DyP-type peroxidase or ferritin-like protein oligomers +FIG01300700 Sucrose-6-phosphate hydrolase (EC 3.2.1.26) +FIG01300705 Predicted cellobiose ABC transport system, permease protein 2 +FIG01300707 Phytochelatin synthase (EC 2.3.2.15), eukaryotic type +FIG01300749 Eukaryotic translation initiation factor 4B +FIG01300759 Phage endoribonulcease translational repressor of early genes, regA +FIG01300760 Predicted alpha-mannoside ABC transporter, permease protein 1 +FIG01300801 Gas vesicle protein GvpL +FIG01300848 U6 snRNA-associated Sm-like protein LSm6 +FIG01300984 Fatty-acid amide hydrolase (EC 3.1.-.-) +FIG01301144 Predicted galactoside ABC transporter, permease protein 2 +FIG01301148 Alpha-N-arabinofuranosidase II (EC 3.2.1.55) +FIG01301159 CO dehydrogenase/acetyl-CoA synthase corrinoid activation protein +FIG01301172 Extracellular endo-1,4-beta-glucanase (EC 3.2.1.4) +FIG01301186 Cytochrome C550 (Soluble cytochrome C) +FIG01301211 ubiquitin / SSU ribosomal protein S27Ae +FIG01301221 Possible potassium-efflux system protein +FIG01301236 IncF plasmid conjugative transfer protein TrbD +FIG01301273 Phenylalanyl-tRNA synthetase alpha chain (EC 6.1.1.20), mitochondrial +FIG01301320 Type III secretion protein HrpE +FIG01301337 SSU ribosomal protein S22mt, mitochondrial +FIG01301341 Alternative L-rhamnose isomerase (EC 5.3.1.14) +FIG01301353 HrpF protein +FIG01301365 Unknown carbohydrate transporter from TRAP family, large transmembrane component UctQ +FIG01301377 Glutamyl-tRNA(Gln) amidotransferase subunit B (EC 6.3.5.7) +FIG01301385 Putative beta-glucuronidase +FIG01301408 Membrane-type matrix metallopeptidase-1 +FIG01301410 Protein C, protease S01.218 +FIG01301446 FIG033545: PE-PGRS family protein +FIG01301464 Beta-amylase (EC 3.2.1.2) +FIG01301466 CBS domain protein +FIG01301470 Thymidine kinase +FIG01301473 Phytol kinase +FIG01301476 Glutathione S-transferase, mu (EC 2.5.1.18) +FIG01301534 Maltose/maltodextrin ABC transporter 2, permease protein MalF2 +FIG01301546 Fimbriae usher protein StcC +FIG01301555 Alcohol sulfotransferase (EC 2.8.2.2) +FIG01301580 Coagulation factor XIIa, protease S01.211 +FIG01301584 Predicted 2-keto-3-deoxygluconate-responsive regulator of glucuronate utilization, IclR family +FIG01301602 Methyl-accepting chemotaxis protein co-located with beta-glucan transporter system +FIG01301626 QscR quorum-sensing control repressor +FIG01301658 NAD-dependent deacetylase +FIG01301666 Eukaryotic translation initiation factor 3 135 kDa subunit +FIG01301698 Unknown carbohydrate transporter from TRAP family, substrate-binding component UctP +FIG01301708 Ubiquinone biosynthesis protein COQ4, mitochondrial precursor +FIG01301782 Gas vesicle protein GvpD +FIG01301794 Predicted regulator of ribose utilization, LacI family +FIG01301829 Putative peptidoglycan bound protein (LPXTG motif) Lmo2178 homolog +FIG01301837 V-type ATP synthase subunit F (EC 3.6.3.14) +FIG01301866 Gas vesicle protein GvpM +FIG01301908 DNA primase (EC 2.7.7.-) / DNA helicase (EC 3.6.1.-), phage-associated +FIG01301935 Inosine-guanosine kinase (EC 2.7.1.73); Cytidine kinase +FIG01301940 Gas vesicle protein GvpI +FIG01301976 ATP-energized glutathione S-conjugate pump, putative +FIG01301977 Energy conserving hydrogenase Eha associated protein (protein R) +FIG01301982 DNA-directed RNA polymerases I and III 16 kDa polypeptide (EC 2.7.7.6) +FIG01302010 Cytochrome c oxidase polypeptide VIIc, mitochondrial precursor (EC 1.9.3.1) +FIG01302030 Stage II sporulation protein P +FIG01302038 NAD-specific glutamate dehydrogenase (EC 1.4.1.2), eukaryotic type +FIG01302041 Serpin A5, protease inhibitor I04.004 +FIG01302064 Protein serine/threonine phosphatase PrpC, regulation of stationary phase +FIG01302103 Phosphoglycerate dehydrogenase TM0327, putative +FIG01302144 Histidine kinase in an arabinose sensing sensor +FIG01302158 Gas vesicle protein GvpE +FIG01302169 Hydrolase (HAD superfamily), YqeK +FIG01302231 LSU ribosomal protein L6e +FIG01302295 Glycoside hydrolase family 2, sugar binding +FIG01302382 Novel D-mannonate-D-gluconate epimerase +FIG01302422 Predicted chitobiose ABC transport system II, sugar-binding protein +FIG01302441 Pyoverdine sidechain non-ribosomal peptide synthetase PvdJ +FIG01302453 Outer membrane lipoprotein carrier protein LolA +FIG01302569 Na(+)-translocating NADH-quinone reductase subunit D (EC 1.6.5.-) +FIG01302599 Predicted keto-inosose hydrolase +FIG01302623 Gas vesicle protein GvpJ +FIG01302630 Alpha-1,4-amylase / Alpha-1,6-pullulanase +FIG01302674 Novel 5-ketogluconate epimerase +FIG01302688 ATP-dependent DNA helicase, RecQ family +FIG01302696 Translation elongation factor 3 +FIG01302697 Alpha-1,4-digalacturonate ABC transporter, permease protein 1 +FIG01302724 Glutamate transport substrate-binding protein +FIG01302739 Phage spanin Rz +FIG01302773 Alpha-L-fucosidase (EC 3.2.1.51) +FIG01302881 CRISPR-associated RAMP, Csx10 family +FIG01302903 Short-chain alcohol dehydrogenase associated with acetoin utilization / Acetoin catabolism protein X +FIG01302980 Estrogen sulfotransferase (EC 2.8.2.4) +FIG01303047 Conjugative transfer protein TrbN +FIG01303062 Putative peptidoglycan bound protein (LPXTG motif) Lmo1799 homolog +FIG01303079 Extracellular alpha-amylase precursor +FIG01303121 Energy conserving hydrogenase Eha associated protein, ribokinase homolog (protein T) +FIG01303151 Light-harvesting LHII, alpha subunit B / Histone protein +FIG01303154 Ubiquinone/menaquinone biosynthesis methyltransferase UbiE (EC 2.1.1.-) +FIG01303173 Predicted regulator of rhamnose oligosacchoride utilization, DeoR family +FIG01303211 FIG033155: Hypothetical protein +FIG01303216 Putative coproporphyrinogen III oxidase of BS HemN-type, oxygen-independent (EC 1.3.99.22), in heat shock gene cluster +FIG01303280 1-hydroxy-2-naphthoic acid ring cleavage dioxygenase +FIG01303404 N-terminal domain of CinA protein, COG1058 / C-terminal domain of CinA type S +FIG01303428 Outer membrane hemoglobin-haptoglobin utilization protein HpuB +FIG01303507 D-serine/D-alanine/glycine transporter / truncated +FIG01303527 Trk system potassium uptake protein TrkA +FIG01303663 Fimbrial protein YadC +FIG01303703 Coagulation factor IXa, protease S01.214 +FIG01303721 Siderophore synthetase superfamily, group A @ Siderophore synthetase large component, acetyltransferase +FIG01303728 Tetracycline resistance protein TetM +FIG01303733 3-oxoacyl-[acyl-carrier protein] reductase paralog (EC 1.1.1.100) in cluster with unspecified monosaccharide transporter +FIG01303734 Cysteine desulfurase (EC 2.8.1.7), NifS subfamily +FIG01303735 NifS-like cysteine desulfurase DndA +FIG01303737 3-ketoacyl-CoA thiolase (EC 2.3.1.16); Acetyl-CoA acetyltransferase (EC 2.3.1.9) +FIG01303740 Signal peptidase SipW (EC 3.4.21.89), required for TasA secretion +FIG01303741 (2E,6E)-farnesyl diphosphate synthase (EC 2.5.1.10) +FIG01303742 Octaprenyl diphosphate synthase (EC 2.5.1.90) +FIG01303744 Dimethylallyltransferase (EC 2.5.1.1) / (2E,6E)-farnesyl diphosphate synthase (EC 2.5.1.10) / Geranylgeranyl pyrophosphate synthetase (EC 2.5.1.29) +FIG01303745 Cell division protein FtsW / Stage V sporulation protein E +FIG01303746 Stage V sporulation protein E +FIG01303751 Prolyl-tRNA synthetase (EC 6.1.1.15), bacterial type +FIG01303754 Methenyltetrahydrofolate cyclohydrolase (EC 3.5.4.9) / Methylenetetrahydrofolate dehydrogenase (NADP+) (EC 1.5.1.5) +FIG01303756 GTP-binding protein Obg +FIG01303757 Putative deoxyribonuclease similar to YcfH, type 2 +FIG01303758 ATP synthase B' chain (EC 3.6.3.14) +FIG01303761 FMN adenylyltransferase (EC 2.7.7.2) / Riboflavin kinase (EC 2.7.1.26) +FIG01303764 tRNA (Guanine37-N1) -methyltransferase (EC 2.1.1.31) / Histone acetyltransferase HPA2 and related acetyltransferases +FIG01303767 RecA protein @ group I intron-containing gene +FIG01303770 UDP-N-acetylmuramoylalanyl-D-glutamate--L,L-2,6-diaminopimelate ligase +FIG01303771 UDP-N-acetylmuramoylalanyl-D-glutamate--2,6-diaminopimelate ligase (EC 6.3.2.13) / UDP-N-acetylmuramoylalanyl-D-glutamyl-2,6-diaminopimelate--D-alanyl-D-alanine ligase (EC 6.3.2.10) +FIG01303772 UDP-N-acetylmuramoylalanyl-D-glutamate--L-diaminobutyrate ligase +FIG01303775 GTP-binding protein related to HflX +FIG01303777 Alternative dihydrofolate reductase 2 / Dihydropteroate synthase (EC 2.5.1.15) +FIG01303778 FIG000325: clustered with transcription termination protein NusA +FIG01303779 Argininosuccinate lyase (EC 4.3.2.1) / Amino-acid acetyltransferase (EC 2.3.1.1) +FIG01303780 D-alanine--D-alanine ligase A (EC 6.3.2.4) +FIG01303783 Glutamate 5-kinase (EC 2.7.2.11) / RNA-binding C-terminal domain PUA +FIG01303785 Aspartyl-tRNA(Asn) amidotransferase subunit A (EC 6.3.5.6); Glutamyl-tRNA(Gln) amidotransferase subunit A (EC 6.3.5.7) +FIG01303788 3,4-dihydroxy-2-butanone 4-phosphate synthase (EC 4.1.99.12) +FIG01303790 5-amino-6-(5-phosphoribosylamino)uracil reductase (EC 1.1.1.193) / Diaminohydroxyphosphoribosylaminopyrimidine deaminase (EC 3.5.4.26) +FIG01303792 Aspartyl-tRNA(Asn) amidotransferase subunit B (EC 6.3.5.6); Glutamyl-tRNA(Gln) amidotransferase subunit B (EC 6.3.5.7) +FIG01303800 Aspartyl-tRNA(Asn) amidotransferase subunit C (EC 6.3.5.6); Glutamyl-tRNA(Gln) amidotransferase subunit C (EC 6.3.5.7) +FIG01303802 Acetyl-coenzyme A carboxyl transferase alpha chain (EC 6.4.1.2) / Acetyl-coenzyme A carboxyl transferase beta chain (EC 6.4.1.2) +FIG01303804 (R)-2-hydroxyacid dehydrogenase, similar to L-sulfolactate dehydrogenase (EC 1.1.1.272) +FIG01303805 Maltodextrin phosphorylase (EC 2.4.1.1) +FIG01303806 Iron binding protein IscA for iron-sulfur cluster assembly +FIG01303807 Iron binding protein SufA for iron-sulfur cluster assembly +FIG01303808 Zinc transporter ZitB +FIG01303812 Cytosolic Fe-S cluster assembling factor NBP35 / Chromosome (plasmid) partitioning protein ParA +FIG01303815 Acyl dehydratase +FIG01303817 Phosphate butyryltransferase (EC 2.3.1.19) / Phosphate acetyltransferase (EC 2.3.1.8) +FIG01303818 MaoC-like dehydratase +FIG01303819 MaoC domain protein dehydratase +FIG01303820 Octanoate-[acyl-carrier-protein]-protein-N-octanoyltransferase / Dihydroneopterin triphosphate pyrophosphohydrolase type 2 (nudB) +FIG01303822 Hypothetical protein VC0266 (sugar utilization related?) +FIG01303823 Ferredoxin-dependent glutamate synthase (EC 1.4.7.1) +FIG01303824 4'-phosphopantetheinyl transferase of FASI (EC 2.7.8.7) +FIG01303825 Ribonuclease HI (EC 3.1.26.4) / hypothetical protein ssl1918 +FIG01303827 L-serine dehydratase 1 (EC 4.3.1.17) +FIG01303828 L-serine dehydratase, beta subunit (EC 4.3.1.17) / L-serine dehydratase, alpha subunit (EC 4.3.1.17) +FIG01303829 NADH dehydrogenase subunit 4L +FIG01303830 Hydroxyaromatic non-oxidative decarboxylase protein B (EC 4.1.1.-) +FIG01303831 DNA topoisomerase III, TraE-type (EC 5.99.1.2) +FIG01303832 Xanthosine/inosine triphosphate pyrophosphatase; HAM1-like protein +FIG01303835 2-dehydro-3-deoxyphosphogluconate aldolase (EC 4.1.2.14) / 4-Hydroxy-2-oxoglutarate aldolase (EC 4.1.3.16) +FIG01303838 Enoyl-CoA hydratase [isoleucine degradation] (EC 4.2.1.17) / 3-hydroxyacyl-CoA dehydrogenase (EC 1.1.1.35) / 3-hydroxybutyryl-CoA epimerase (EC 5.1.2.3) +FIG01303839 Enoyl-CoA hydratase (EC 4.2.1.17) / 3-hydroxyacyl-CoA dehydrogenase (EC 1.1.1.35) / 3-hydroxybutyryl-CoA epimerase (EC 5.1.2.3) +FIG01303840 Glutamate N-acetyltransferase (EC 2.3.1.35) / Amino-acid acetyltransferase (EC 2.3.1.1) +FIG01303841 Nitric oxide reductase activation protein NorE +FIG01303843 tRNA (adenine37-N(6))-methyltransferase TrmN6 (EC 2.1.1.223) / COG2827: putative endonuclease containing a URI domain +FIG01303845 5-methyltetrahydrofolate:corrinoid iron-sulfur protein methyltransferase +FIG01303848 Ubiquinone biosynthesis monooxygenase UbiF/COQ7 (EC 1.14.13.-); 2-octaprenyl-3-methyl-6-methoxy-1,4-benzoquinol hydroxylase (EC 1.14.13.-) +FIG01303849 Glutamyl-tRNA synthetase (EC 6.1.1.17); Glutamyl-tRNA(Gln) synthetase (EC 6.1.1.24) +FIG01303850 [Fe] hydrogenase, HymA subunit, putative +FIG01303853 FIG000735: Adenosine (5')-pentaphospho-(5'')-adenosine pyrophosphohydrolase (EC 3.6.1.-) +FIG01303856 K(+)-uptake protein KtrB, integral membrane subunit; Potassium uptake protein TrkH +FIG01303866 DNA repair exonuclease family protein YhaO +FIG01303868 Pyruvate-utilizing enzyme, similar to phosphoenolpyruvate synthase +FIG01303869 Rod shape-determining membrane protein MrdB (RodA) / Cell division protein FtsW +FIG01303872 Peptidoglycan-associated lipoprotein precursor +FIG01303876 Phosphoribosylformylglycinamidine synthase, synthetase subunit (EC 6.3.5.3) +FIG01303877 Phosphoadenylyl-sulfate reductase [thioredoxin] (EC 1.8.4.8) / Adenylyl-sulfate reductase [thioredoxin] (EC 1.8.4.10) +FIG01303879 K(+)-uptake protein KtrA, peripherally bound subunit; Trk system potassium uptake protein TrkA +FIG01303880 Dihydrolipoamide dehydrogenase of pyruvate dehydrogenase complex (EC 1.8.1.4) +FIG01303881 Dihydrolipoamide dehydrogenase of branched-chain alpha-keto acid dehydrogenase (EC 1.8.1.4) +FIG01303882 Dihydrolipoamide dehydrogenase of pyruvate dehydrogenase complex (EC 1.8.1.4) @ Dihydrolipoamide dehydrogenase (EC 1.8.1.4) +FIG01303883 Copper sensory histidine kinase CusS +FIG01303885 Sensory histidine kinase BaeS +FIG01303887 FIG000859: hypothetical protein YebC +FIG01303889 Phosphoribosyl-AMP cyclohydrolase (EC 3.5.4.19) +FIG01303892 FIG000875: Thioredoxin domain-containing protein EC-YbbN +FIG01303894 Mutator mutT protein (7,8-dihydro-8-oxoguanine-triphosphatase) (EC 3.6.1.-) / Thiamin-phosphate pyrophosphorylase-like protein +FIG01303895 GDP-mannose mannosyl hydrolase (EC 3.6.1.-) +FIG01303896 Uncharacterized protein YqeC +FIG01303898 Uridine kinase family protein YggC homolog +FIG01303900 Xanthine dehydrogenase iron-sulfur subunit (EC 1.17.1.4) / Xanthine dehydrogenase, molybdenum binding subunit (EC 1.17.1.4) +FIG01303902 RNA polymerase sigma-70 factor +FIG01303905 Malate:quinone oxidoreductase (EC 1.1.99.16) +FIG01303908 RNA-2',3'-PO4:RNA-5'-OH ligase +FIG01303909 RNA-2',3'-PO4:RNA-5'-OH ligase @ intein-containing +FIG01303912 Apolipoprotein N-acyltransferase (EC 2.3.1.-) +FIG01303913 Glycine oxidase ThiO (EC 1.4.3.19) @ Opine oxidase subunit B +FIG01303914 Glycine oxidase ThiO (EC 1.4.3.19) / Opine oxidase subunit B +FIG01303917 Similar to ribosomal large subunit pseudouridine synthase A +FIG01303918 Similar to ribosomal large subunit pseudouridine synthase D, type RluD4 +FIG01303919 Similar to ribosomal large subunit pseudouridine synthase D, type RluD5 +FIG01303920 NADPH-dependent 7-cyano-7-deazaguanine reductase (EC 1.7.1.-) +FIG01303921 Probable two-component sensor, near polyamine transporter +FIG01303922 Monoglyceride lipase (EC 3.1.1.23) +FIG01303924 Mlr7403 protein @ FIG001046: putative membrane protein +FIG01303928 Sulfite reduction-associated complex DsrMKJOP protein DsrM (= HmeC) +FIG01303929 Multidrug resistance protein A +FIG01303933 Colicin V production protein +FIG01303934 L-Cystine ABC transporter, periplasmic cystine-binding protein +FIG01303938 FIG137478: Hypothetical protein +FIG01303940 UPF0135 protein Bsu YqfO +FIG01303941 UPF0135 protein Bsu YqfO @ Bsu YqfO NIF3/CutA domain +FIG01303942 Predicted secretion system W protein GspG-like 2 +FIG01303944 Lysine/cadaverine antiporter membrane protein CadB +FIG01303945 Arginine/agmatine antiporter +FIG01303946 Acetylornithine aminotransferase (EC 2.6.1.11) / N-succinyl-L,L-diaminopimelate aminotransferase (EC 2.6.1.17) +FIG01303947 pyoverdine-specific efflux macA-like protein +FIG01303948 FIG008443: hypothetical protein +FIG01303950 [NiFe] hydrogenase nickel incorporation protein HybF +FIG01303951 sigma-70, region 4 +FIG01303953 General secretion pathway protein F / Type II secretory pathway, component PulF / Type IV fimbrial assembly protein PilC +FIG01303954 Phage portal +FIG01303955 Vanillate O-demethylase oxidoreductase (EC 1.14.13.-) +FIG01303956 Putative dioxygenase, beta subunit (EC 1.-.-.-); Choline monooxygenase, beta subunit (EC 1.14.15.7) +FIG01303961 Membrane protease family protein Swol_1659 +FIG01303963 Ribonuclease J2 (endoribonuclease in RNA processing) +FIG01303964 Zn-dependent hydrolase, RNA-metabolising +FIG01303969 Ornithine aminotransferase (EC 2.6.1.13); Succinylornithine transaminase (EC 2.6.1.81); Acetylornithine aminotransferase (EC 2.6.1.11); N-succinyl-L,L-diaminopimelate aminotransferase (EC 2.6.1.17) +FIG01303971 GCN5-related N-acetyltransferase; Histone acetyltransferase HPA2 and related acetyltransferases +FIG01303974 Selenide,water dikinase (EC 2.7.9.3); selenocysteine-containing +FIG01303978 N-acetylmuramoyl-L-alanine amidase (EC 3.5.1.28) AmpD +FIG01303979 Phage lysin, N-acetylmuramoyl-L-alanine amidase (EC 3.5.1.28) +FIG01303981 Na(+) H(+) antiporter subunit C (TC 2.A.63.1.3) +FIG01303982 pH adaptation potassium efflux system c +FIG01303984 Formate dehydrogenase N beta subunit (EC 1.2.1.2) +FIG01303986 Na(+) H(+) antiporter subunit D (TC 2.A.63.1.3) +FIG01303987 pH adaption potassium efflux system protein PhaD +FIG01303988 pH adaptation potassium efflux system d +FIG01303990 Na(+) H(+) antiporter subunit E (TC 2.A.63.1.3) +FIG01303991 pH adaption potassium efflux system protein PhaE +FIG01303992 pH adaptation potassium efflux system e +FIG01303993 ATPase required for both assembly of type IV secretion complex and secretion of T-DNA complex, VirB4 +FIG01303994 Inner membrane protein forms channel for type IV secretion of T-DNA complex, VirB3 / ATPase required for both assembly of type IV secretion complex and secretion of T-DNA complex, VirB4 +FIG01303996 Na(+) H(+) antiporter subunit F (TC 2.A.63.1.3) +FIG01303997 pH adaption potassium efflux system protein PhaF +FIG01303998 pH adaptation potassium efflux system f +FIG01303999 Predicted flavin reductase RutF in novel pyrimidine catabolism pathway +FIG01304001 dATP pyrophosphohydrolase NudB (EC 3.6.1.-) +FIG01304002 Isoaspartyl aminopeptidase @ Asp-X dipeptidase +FIG01304003 Isoaspartyl aminopeptidase (EC 3.4.19.5) @ Asp-X dipeptidase +FIG01304004 Aldehyde dehydrogenase (EC 1.2.1.3); Probable coniferyl aldehyde dehydrogenase (EC 1.2.1.68) +FIG01304006 Uncharacterized monothiol glutaredoxin ycf64-like +FIG01304007 Probable monothiol glutaredoxin GrlA +FIG01304010 Serine-pyruvate aminotransferase/archaeal aspartate aminotransferase +FIG01304011 XdhC protein (assists in molybdopterin insertion into xanthine dehydrogenase) +FIG01304012 Xanthine and CO dehydrogenases maturation factor, XdhC/CoxF family / Selenium-dependent molybdenum hydroxylase system protein YqeB +FIG01304013 Aconitate hydratase 2 (EC 4.2.1.3) @ 2-methylisocitrate dehydratase (EC 4.2.1.99) +FIG01304015 Histidinol-phosphate aminotransferase (EC 2.6.1.9) @ Biosynthetic Aromatic amino acid aminotransferase beta (EC 2.6.1.57) +FIG01304016 Aspartate aminotransferase (EC 2.6.1.1) @ Histidinol-phosphate aminotransferase (EC 2.6.1.9) +FIG01304019 DltD protein +FIG01304021 Carnitine 3-dehydrogenase (EC 1.1.1.108) / Carnitine 3-dehydratase @ 3-hydroxyacyl-CoA dehydrogenase (EC 1.1.1.35) / Enoyl-CoA hydratase (EC 4.2.1.17) +FIG01304022 Inner membrane protein of type IV secretion of T-DNA complex, TonB-like, VirB10 +FIG01304024 Ribitol 2-dehydrogenase (EC 1.1.1.56) +FIG01304026 Cobalamin biosynthesis protein BluB @ Predicted cobalamine reductase BluB +FIG01304034 Oxaloacetate decarboxylase beta chain (EC 4.1.1.3) @ Methylmalonyl-CoA decarboxylase, beta chain (EC 4.1.1.41) +FIG01304035 Methylmalonyl-CoA decarboxylase, beta chain (EC 4.1.1.41); Oxaloacetate decarboxylase beta chain (EC 4.1.1.3) +FIG01304036 Methylmalonyl-CoA decarboxylase, beta chain (EC 4.1.1.41) +FIG01304037 Oxaloacetate decarboxylase beta chain (EC 4.1.1.3); Methylmalonyl-CoA decarboxylase, beta chain (EC 4.1.1.41) +FIG01304039 Putative esterase +FIG01304041 Inner membrane protein forms channel for type IV secretion of T-DNA complex, VirB8 +FIG01304042 S1 RNA binding domain +FIG01304043 Competence/damage-inducible protein CinA +FIG01304044 Molybdopterin binding motif, CinA N-terminal domain / C-terminal domain of CinA type S +FIG01304045 C-terminal domain of CinA type S; Protein Implicated in DNA repair function with RecA and MutS +FIG01304048 Molybdopterin binding motif, CinA N-terminal domain / C-terminal domain of CinA type E +FIG01304052 Carbon starvation protein A paralog +FIG01304053 PTS system, mannitol-specific cryptic IIA component (EC 2.7.1.69) +FIG01304054 Acetoacetyl-CoA reductase (EC 1.1.1.36) +FIG01304055 3-hydroxybutyrate dehydrogenase (EC 1.1.1.30) +FIG01304056 Predicted sugar dehydrogenase TM0325 +FIG01304058 Putative aldolase YdjI +FIG01304059 Phage major tail sheath protein +FIG01304060 Protein RcsF +FIG01304063 Putative 6-phospho-beta-glucosidase CelZ +FIG01304066 Na(+) H(+) antiporter subunit A +FIG01304067 Na(+) H(+) antiporter subunit A (TC 2.A.63.1.3) +FIG01304068 Na(+) H(+) antiporter subunit A / Na(+) H(+) antiporter subunit B +FIG01304069 pH adaptation potassium efflux system a +FIG01304070 Na(+) H(+) antiporter subunit A (TC 2.A.63.1.2) +FIG01304071 Na(+) H(+) antiporter subunit B +FIG01304073 Cold shock protein CspD +FIG01304076 FIG001943: hypothetical protein YajQ +FIG01304077 PTS system, mannose-specific IIB component (EC 2.7.1.69) @ PTS system, fructose-specific IIB component (EC 2.7.1.69) +FIG01304080 Pyruvate decarboxylase (EC 4.1.1.1); Indole-3-pyruvate decarboxylase (EC 4.1.1.74) +FIG01304082 Inner membrane protein of type IV secretion of T-DNA complex, VirB3 +FIG01304085 Alpha-glucuronidase (EC 3.2.1.139) +FIG01304087 CRISPR-associated helicase Cas3, protein +FIG01304089 Cell division inhibitor Slr1223 (YfcH in EC), contains epimerase/dehydratase and DUF1731 domains +FIG01304092 UPF0229 protein YeaH +FIG01304093 Low temperature requirement B protein +FIG01304096 Acetyl-coenzyme A carboxyl transferase alpha chain (EC 6.4.1.2) / Acetyl-coenzyme A carboxyl transferase beta chain (EC 6.4.1.2); Propionyl-CoA carboxylase beta chain (EC 6.4.1.3); Methylmalonyl-CoA decarboxylase, alpha chain (EC 4.1.1.41) +FIG01304097 Acetyl-coenzyme A carboxyl transferase alpha chain (EC 6.4.1.2) / Acetyl-coenzyme A carboxyl transferase beta chain (EC 6.4.1.2); Methylmalonyl-CoA decarboxylase, alpha chain (EC 4.1.1.41) +FIG01304098 Glutaconyl-CoA decarboxylase alpha chain (EC 4.1.1.70) +FIG01304099 Bona fide RidA/YjgF/TdcF/RutC subgroup +FIG01304101 Cytoplasmic hypothetical protein DUF199, a subgroup +FIG01304103 ATP/GTP-binding site motif A (P-loop) :BolA-like protein +FIG01304104 PTS system, galactosamine-specific IIB component (EC 2.7.1.69) +FIG01304106 Protein SlyX +FIG01304109 Formate dehydrogenase O alpha subunit (EC 1.2.1.2); selenocysteine-containing +FIG01304110 Formate dehydrogenase N alpha subunit (EC 1.2.1.2); selenocysteine-containing +FIG01304111 FIG002207: Probable transmembrane protein +FIG01304112 PTS system, glucose-specific IIC component (EC 2.7.1.69) / PTS system, glucose-specific IIB component (EC 2.7.1.69) / PTS system, glucose-specific IIA component (EC 2.7.1.69) +FIG01304115 PTS system, L-fucose-specific IIA component (EC 2.7.1.69) +FIG01304116 PTS system, mannose-specific IIA component @ PTS system, fructose-specific IIA component +FIG01304120 3-oxoacyl-[ACP] synthase (EC 2.3.1.41) FabV like +FIG01304123 PTS system, galactosamine-specific IID component +FIG01304124 D-hydantoinase (EC 3.5.2.2) +FIG01304126 Acyl carrier protein / HmrB protein involved in methicillin resistance +FIG01304127 Acyl carrier protein (ACP2) +FIG01304132 Siroheme synthase / Precorrin-2 oxidase (EC 1.3.1.76) / Sirohydrochlorin ferrochelatase (EC 4.99.1.4) +FIG01304133 N-acetylneuraminate mutarotase +FIG01304134 Transcriptional regulator, LysR family +FIG01304135 8-oxo-dGTPase Bsu YtkD / 8-oxo-GTPase Bsu YtkD +FIG01304136 Biotin sulfoxide reductase (EC 1.-.-.-) / Free methionine-(S)-sulfoxide reductase +FIG01304139 Succinate dehydrogenase cytochrome b558 subunit +FIG01304141 Chaperone protein TorD +FIG01304142 MSHA pilin protein MshB +FIG01304144 Capsular polysaccharide synthesis enzyme Cap8C; Manganese-dependent protein-tyrosine phosphatase (EC 3.1.3.48) +FIG01304146 CRISPR-associated protein, Cse4 family +FIG01304147 FIG002473: Protein YcaR in KDO2-Lipid A biosynthesis cluster +FIG01304148 Membrane bound c-di-GMP receptor LapD +FIG01304149 Glutathione S-transferase domain protein +FIG01304153 unknown protein encoded within prophage CP-933V +FIG01304155 Putative uncharacterized protein YmcB +FIG01304156 Arginine/ornithine ABC transporter, ATP-binding protein AotP +FIG01304157 CRISPR-associated protein, Csd2 family +FIG01304158 CRISPR-associated protein, Csh2 family +FIG01304161 Probable VANILLIN dehydrogenase oxidoreductase protein (EC 1.-.-.-) +FIG01304165 Putative glutathione transporter, permease component +FIG01304167 Mannoside ABC transport system, permease protein 1 +FIG01304168 GAF domain protein; CDS_ID OB2202 +FIG01304174 tRNA pseudouridine synthase A (EC 4.2.1.70) / Ribosomal large subunit pseudouridine synthase B (EC 4.2.1.70) +FIG01304175 Molybdenum transport ATP-binding protein ModC (TC 3.A.1.8.1) / Molybdenum transport system permease protein ModB (TC 3.A.1.8.1) +FIG01304177 PTS IIA-like nitrogen-regulatory protein PtsN +FIG01304179 Isoaspartyl dipeptidase (EC 3.4.19.5); Asp-X dipeptidase +FIG01304181 Phosphoheptose isomerase 2 (EC 5.3.1.-) +FIG01304182 Intramembrane protease RasP/YluC, implicated in cell division based on FtsL cleavage +FIG01304183 FIG002813: LPPG:FO 2-phospho-L-lactate transferase like, CofD-like +FIG01304186 Universal stress protein UspA +FIG01304195 ABC transporter involved in cytochrome c biogenesis, ATPase component CcmA +FIG01304199 Aerobactin siderophore receptor IutA @ TonB-dependent siderophore receptor +FIG01304201 Benzoate 1,2-dioxygenase, ferredoxin reductase component +FIG01304203 benzoate dioxygenase, ferredoxin reductase component; Anthranilate dioxygenase reductase +FIG01304205 Hypothetical adenine-specific methylase yfcB +FIG01304207 Arginine decarboxylase (EC 4.1.1.19); Ornithine decarboxylase (EC 4.1.1.17); Lysine decarboxylase (EC 4.1.1.18) +FIG01304208 Lysine decarboxylase 2, constitutive (EC 4.1.1.18) +FIG01304210 Protein of unknown function YceH / Virulence factor MviM +FIG01304212 Stage V sporulation protein involved in spore cortex synthesis (SpoVR) +FIG01304213 Proton/glutamate symport protein @ Sodium/glutamate symport protein +FIG01304214 Iron starvation-induced chlorophyll a(b) binding protein IsiA, photosystem II CP43 protein (PsbC) homolog +FIG01304218 hydrogenase, group 4, HycG subunit, putative +FIG01304220 Transcriptional regulator, MerR family, associated with photolyase +FIG01304221 Cd(II)/Pb(II)-responsive transcriptional regulator +FIG01304224 Large exoproteins involved in heme utilization or adhesion +FIG01304225 Phage tail fibers +FIG01304229 MSM (multiple sugar metabolism) operon regulatory protein +FIG01304230 Sigma-54 dependent transcriptional regulator +FIG01304234 Cytochrome c-type heme lyase subunit nrfE, nitrite reductase complex assembly / Cytochrome c-type heme lyase subunit nrfF, nitrite reductase complex assembly +FIG01304235 Lipopolysaccharide cholinephosphotransferase LicD2 (EC 2.7.8.-) +FIG01304237 NADH dehydrogenase I subunit 4, Involved in photosystem-1 cyclic electron flow +FIG01304240 LysR-family transcriptional regulator PtxE, associated with phosphonate utilization +FIG01304241 ABC-type polar amino acid transport system, ATPase component +FIG01304242 type I secretion system ATPase, LssB family (LapB) +FIG01304243 Poly(3-hydroxyalkanoate) depolymerase +FIG01304247 Molybdenum cofactor biosynthesis protein MoaD; Molybdopterin converting factor subunit 1 +FIG01304248 Type III secretion outermembrane contact sensing protein( yopN,Yop4b,LcrE) +FIG01304250 FIG003879: Predicted amidohydrolase / Aliphatic amidase AmiE (EC 3.5.1.4) +FIG01304251 Omega amidase (Nit2 homolog) +FIG01304252 Putrescine transport system permease protein PotI (TC 3.A.1.11.2) +FIG01304253 [NiFe] hydrogenase metallocenter assembly protein HybG +FIG01304256 Proline-specific permease proY +FIG01304258 Na(+) H(+) antiporter subunit B (TC 2.A.63.1.2) +FIG01304262 Universal stress protein F +FIG01304263 Cold shock protein CspE +FIG01304266 Inner membrane protein YhaI +FIG01304267 TonB-dependent receptor; Enterobactin receptor IrgA +FIG01304268 Putative outer membrane TonB-dependent receptor associated with haemagglutinin family outer membrane protein +FIG01304270 L,D-transpeptidase ErfK +FIG01304274 Competence protein F, phosphoribosyltransferase +FIG01304275 Ferrichrome transport ATP-binding protein FhuC (TC 3.A.1.14.3) +FIG01304276 Cystathionine beta-lyase (EC 4.4.1.8) +FIG01304277 Rhodanese-related sulfurtransferase +FIG01304278 Di/tripeptide permease YjdL +FIG01304279 Di/tripeptide permease DtpT +FIG01304280 Di/tripeptide permease YbgH +FIG01304281 Oligogalacturonate-specific porin protein KdgM +FIG01304282 23S rRNA (Uracil-5-) -methyltransferase RumA (EC 2.1.1.-) +FIG01304287 Hypothetical, similarity to phosphoglycerate mutase +FIG01304292 Intracellular alpha-amylase (EC 3.2.1.1) +FIG01304293 ammonium/methylammonium permease +FIG01304294 Anaerobic C4-dicarboxylate transporter DcuC +FIG01304295 Ferredoxin-like protein YdiT +FIG01304301 Uricase (urate oxidase) (EC 1.7.3.3) / 2-oxo-4-hydroxy-4-carboxy--5-ureidoimidazoline (OHCU) decarboxylase +FIG01304304 Sulfate permease, Trk-type +FIG01304310 Glycine betaine ABC transport system, permease protein OpuAB / Glycine betaine ABC transport system, glycine betaine-binding protein OpuAC +FIG01304314 CRISPR-associated protein, Csd1 family +FIG01304317 CRISPR-associated protein, CT1972 family +FIG01304322 Hypothetical sugar ABC transporter TM0460, substrate-binding protein +FIG01304323 FIG006220: Hypothetical MbtH-like protein +FIG01304324 Cold shock protein CspI +FIG01304325 Cold shock protein CspF +FIG01304327 Dissimilatory sulfite reductase, alpha subunit +FIG01304329 Chromosome (plasmid) partitioning protein ParA +FIG01304330 Chromosome partitioning protein ParA +FIG01304331 Sporulation initiation inhibitor protein Soj +FIG01304333 Chromosome partitioning protein ParA / Chromosome (plasmid) partitioning protein ParA +FIG01304335 TRAP-type transport system, small permease component, predicted N-acetylneuraminate transporter / TRAP-type transport system, large permease component, predicted N-acetylneuraminate transporter +FIG01304336 Predicted D-glucuronide-specific TRAP transporter, large transmembrane component +FIG01304337 D-allose-6-phosphate isomerase (EC 5.3.1.-) +FIG01304339 Enoyl-CoA hydratase (EC 4.2.1.17) / 3-hydroxyacyl-CoA dehydrogenase (EC 1.1.1.35) +FIG01304341 SpoVS-related protein, type 4 +FIG01304343 Dissimilatory sulfite reductase, beta subunit +FIG01304344 NAD-dependent malic enzyme (EC 1.1.1.38) +FIG01304345 Formate dehydrogenase H (EC 1.2.1.2) +FIG01304348 Putative hydroxycinnamate transporter +FIG01304349 Predicted alpha-mannoside ABC transporter, substrate binding protein +FIG01304353 Maltose/maltodextrin transport ATP-binding protein MalK (EC 3.6.3.19); Multiple sugar ABC transporter, ATP-binding protein +FIG01304355 Hypothetical radical SAM family enzyme in heat shock gene cluster, similarity with CPO of BS HemN-type +FIG01304356 2-nitropropane dioxygenase (EC 1.13.11.32) +FIG01304357 2-keto-4-pentenoate hydratase (EC 4.2.1.80) +FIG01304360 Na(+) H(+) antiporter subunit G (TC 2.A.63.1.3) +FIG01304361 pH adaption potassium efflux system protein PhaG +FIG01304362 Na(+) H(+) antiporter subunit G (TC 2.A.63.1.2) +FIG01304368 Fe-bacillibactin uptake system FeuB +FIG01304370 Catechol-2,3-dioxygenase (EC 1.13.11.2) +FIG01304376 Sodium/glutamate symport protein +FIG01304378 Glutamate-aspartate carrier protein +FIG01304382 Na+/H+ antiporter NhaB +FIG01304383 Malate Na(+) symporter +FIG01304384 Lipoteichoic acid primase LtaP +FIG01304385 Ribose ABC transporter, periplasmic ribose-binding protein RbsB (TC 3.A.1.2.1) +FIG01304386 FIG137887: membrane protein related to purine degradation +FIG01304388 Phosphonate ABC transporter permease protein phnE2 (TC 3.A.1.9.1) +FIG01304391 Predicted nucleoside ABC transporter, permease 2 component +FIG01304392 Transcriptional regulator, ArsR family +FIG01304394 5-carboxymethyl-2-oxo-hex-3- ene-1,7-dioate decarboxylase (EC 4.1.1.68) +FIG01304395 NADH dehydrogenase (EC 1.6.99.3) in cluster with putative pheromone precursor +FIG01304396 YkfI toxin protein +FIG01304397 YpjF toxin protein +FIG01304398 CRISPR-associated protein, Cas5e family +FIG01304399 Efflux pump Lde +FIG01304401 Putative symporter YjcG; putative hemin permease +FIG01304402 Isochorismatase (EC 3.3.2.1) [enterobactin] siderophore / Apo-aryl carrier domain of EntB @ Isochorismatase (EC 3.3.2.1) of siderophore biosynthesis +FIG01304405 Branched-chain acyl-CoA dehydrogenase (EC 1.3.99.12) +FIG01304407 Isovaleryl-CoA dehydrogenase (EC 1.3.8.4); Butyryl-CoA dehydrogenase (EC 1.3.99.2) +FIG01304408 Probable acyl-CoA dehydrogenase (EC 1.3.99.3) +FIG01304409 ; Acetaldehyde dehydrogenase (EC 1.2.1.3) +FIG01304412 type 1 fimbriae protein FimI, unknown function +FIG01304417 transcriptional regulator, PemK family +FIG01304418 probable iron binding protein for iron-sulfur cluster assembly +FIG01304425 probable exported protein YPO3233 +FIG01304427 Putative membrane protein found fused to lysyl-tRNA synthetase like protein / Lysyl-tRNA synthetase (class II) related protein found fused to membrane protein +FIG01304429 Response regulator LiaR +FIG01304430 putative ATP-dependent DNA helicase YjcD +FIG01304431 FrmR: Negative transcriptional regulator of formaldehyde detoxification operon +FIG01304435 T1SS associated transglutaminase-like cysteine proteinase LapP +FIG01304438 CO dehydrogenase iron-sulfur protein CooF (EC 1.2.99.2) +FIG01304439 PTS system, chitobiose-specific IIA component (EC 2.7.1.69) +FIG01304440 PTS system, beta-glucoside-specific IIA component; PTS system, cellobiose-specific IIA component (EC 2.7.1.69) +FIG01304442 Glutamate carboxypeptidase (EC 3.4.17.11) +FIG01304443 prolyl oligopeptidase family protein +FIG01304444 Phage capsid and scaffold +FIG01304446 Phage collar +FIG01304449 PTS system, mannose-specific IIC component @ PTS system, fructose-specific IIC component +FIG01304452 Serine protease (EC 3.4.21.-) +FIG01304453 UPF0028 protein YchK +FIG01304454 Transcriptional regulator, RpiR family; Sialic acid utilization regulator, RpiR family +FIG01304455 Fin: required for the switch from sigmaF to sigmaG during sporulation +FIG01304457 Predicted D-glucuronide-specific TRAP transporter, small transmembrane component +FIG01304458 TsaE protein, required for threonylcarbamoyladenosine t(6)A37 formation in tRNA / COG3178: Predicted phosphotransferase related to Ser/Thr protein kinases +FIG01304460 Unspecified monosaccharide ABC transport system, permease component Ia (FIG025991) / Unspecified monosaccharide ABC transport system, permease component Ib (FIG143636) +FIG01304461 Putative sugar ABC transport system, permease protein YtfT +FIG01304462 Xylose ABC transporter, permease protein XylH +FIG01304463 Sua5 YciO YrdC YwlC family protein +FIG01304464 COG0009 YrdC subfamily, required for N6-threonylcarbamoyl adenosine t(6)A37 modification in tRNA +FIG01304467 Dihydrolipoamide dehydrogenase of 2-oxoglutarate dehydrogenase (EC 1.8.1.4) / Dihydrolipoamide dehydrogenase of pyruvate dehydrogenase complex (EC 1.8.1.4) +FIG01304470 Predicted transcriptional regulator of leucine degradation pathway, MerR family +FIG01304472 Stage II sporulation protein D +FIG01304474 Enoyl-CoA hydratase [branched-chain amino acid degradation] (EC 4.2.1.17) +FIG01304475 3-methylthioacryloyl-CoA hydratase 2 (DmdD2) +FIG01304476 Long-chain-fatty-acid--CoA ligase associated with anthrachelin biosynthesis +FIG01304482 FIG014801: Cation ABC transporter, periplasmic cation-binding protein +FIG01304484 Outer membrane TonB-dependent transducer VreA of trans-envelope signaling system +FIG01304485 Mannoside ABC transport system, ATP-binding protein 2 +FIG01304487 StbD replicon stabilization protein (antitoxin to StbE) +FIG01304488 RelB/StbD replicon stabilization protein (antitoxin to RelE/StbE) +FIG01304489 RelB protein (antitoxin to RelE) +FIG01304490 SMT0609 replicon stabilization protein (antitoxin to SMT0608) +FIG01304495 Substrate-specific component PdxT of predicted pyridoxine ECF transporter +FIG01304496 Surface presentation of antigens protein SpaN +FIG01304497 Methionine aminotransferase, PLP-dependent / Glutamine-dependent 2-keto-4-methylthiobutyrate transaminase +FIG01304499 L-lactate permease; Glycolate permease +FIG01304502 Hypoxanthine/guanine permease PbuG +FIG01304503 Beta-lactamase, class C +FIG01304505 Arginine decarboxylase (EC 4.1.1.19); Lysine decarboxylase (EC 4.1.1.18); Ornithine decarboxylase (EC 4.1.1.17) +FIG01304507 Carboxynorspermidine dehydrogenase +FIG01304508 Biotin carboxyl carrier protein of acetyl-CoA carboxylase; Biotin carboxyl carrier protein +FIG01304509 Biotin carboxyl carrier protein of methylmalonyl-CoA decarboxylase; Biotin carboxyl carrier protein +FIG01304512 SH3 domain-containing protein +FIG01304516 PhnB protein +FIG01304517 COG0523: Putative GTPases (G3E family) +FIG01304522 Transcriptional regulator, Cro/CI family +FIG01304524 Phage lysin +FIG01304527 Phage protein +FIG01304528 Hydrogen cyanide synthase HcnC +FIG01304529 ABC-type probable sulfate transporter, ATPase component +FIG01304530 Phage terminase, large subunit +FIG01304534 FIG173184: hypothetical protein +FIG01304535 Molybdenum cofactor biosynthesis protein MoaE; Molybdopterin converting factor subunit 2 +FIG01304537 Chaperone protein YscY (Yop proteins translocation protein Y) +FIG01304538 Unspecified monosaccharide ABC transport system, ATP-binding protein +FIG01304539 CRISPR-associated protein, Cas5d family +FIG01304543 Programmed cell death antitoxin PemI +FIG01304545 Organic solvent tolerance protein precursor +FIG01304547 N-carbamoyl-L-amino acid hydrolase (EC 3.5.1.87); Beta-ureidopropionase (EC 3.5.1.6) +FIG01304549 Phosphate-specific outer membrane porin OprP; Pyrophosphate-specific outer membrane porin OprO +FIG01304550 Maltose oligosaccharide ABC transporter, permease protein MalF1 +FIG01304552 Transcriptional activator PhbR +FIG01304553 Two-component system histidine kinase RacS +FIG01304555 T1SS peptidoglycan-associated lipoprotein LapL +FIG01304556 Outer membrane stress sensor protease DegQ, serine protease +FIG01304557 Inosine-5'-monophosphate dehydrogenase, catalytic domain (EC 1.1.1.205) +FIG01304559 IMP dehydrogenase related 2 (EC 1.7.1.7) +FIG01304560 Type III secretion host injection and negative regulator protein (YopD); Surface presentation of antigens protein SpaN (Invasion protein InvJ) +FIG01304561 Cell division protein FtsQ homolog +FIG01304562 Capsular polysaccharide synthesis enzyme Cap5O +FIG01304565 tRNA (Guanine37-N1) -methyltransferase (EC 2.1.1.31) / 2-C-methyl-D-erythritol 2,4-cyclodiphosphate synthase (EC 4.6.1.12) +FIG01304566 Chromosome partitioning protein parB / Chromosome (plasmid) partitioning protein ParB +FIG01304568 Chromosome (plasmid) partitioning protein ParB-2 +FIG01304575 Putative dNTP triphosphohydrolase, associated with nucleotidase YfbR +FIG01304576 Deoxyguanosinetriphosphate triphosphohydrolase (EC 3.1.5.1), subgroup 1 +FIG01304577 dNTP triphosphohydrolase, broad substrate specificity, subgroup 3 +FIG01304578 type I secretion system, outer membrane component (LapE) +FIG01304579 CRISPR-associated negative autoregulator, Cst2 family +FIG01304581 Surface presentation of antigens protein SpaP +FIG01304582 Thiamine kinase (EC 2.7.1.89) +FIG01304586 Hypothetical adenine-specific methylase yfcB +FIG01304587 NAD(P)H oxidoreductase YRKL (EC 1.6.99.-); Putative NADPH-quinone reductase (modulator of drug activity B); Flavodoxin 2 +FIG01304588 Mannoside ABC transport system, sugar-binding protein +FIG01304590 Uracil-xanthine permease +FIG01304592 Xanthine/uracil transporter +FIG01304594 Xanthine-uracil permease / 2-oxo-4-hydroxy-4-carboxy--5-ureidoimidazoline (OHCU) decarboxylase +FIG01304597 2-polyprenylphenol hydroxylase and related flavodoxin oxidoreductases / CDP-6-deoxy-delta-3,4-glucoseen reductase-like +FIG01304598 Pyruvate dehydrogenase E1 component beta subunit (EC 1.2.4.1); Branched-chain alpha-keto acid dehydrogenase, E1 component, beta subunit (EC 1.2.4.4) +FIG01304599 Type III secretion cytoplasmic ATP synthase (EC 3.6.3.14, YscN,SpaL,MxiB,HrcN,EscN) +FIG01304600 Type III secretion system protein BsaR; Surface presentation of antigens protein SpaK (Invasion protein InvB) +FIG01304601 Exonuclease SbcC +FIG01304604 Periplasmic aromatic aldehyde oxidoreductase, FAD binding subunit YagS @ 4-hydroxybenzoyl-CoA reductase, beta subunit (EC 1.3.99.20) +FIG01304606 Hydrogen cyanide synthase HcnB +FIG01304610 Hydrogen cyanide synthase HcnA +FIG01304613 Phage lysin (EC 3.2.1.17) +FIG01304614 Extracellular and/or outer membrane deoxyribonuclease NucH/SO1066 +FIG01304615 Aerobic C4-dicarboxylate transporter for fumarate, L-malate, D-malate, succunate, aspartate +FIG01304617 Allantoate amidohydrolase (EC 3.5.3.9) +FIG01304619 PTS system, chitobiose-specific IIC component (EC 2.7.1.69) +FIG01304621 Phage protein +FIG01304622 Per-activated serine protease autotransporter enterotoxin EspC / autotransporter domain, T5aSS type secretion +FIG01304623 Capsular polysaccharide synthesis enzyme Cap5E +FIG01304624 Hydroxypyruvate reductase (EC 1.1.1.81) +FIG01304633 Phage protein +FIG01304636 NADH-dependent butanol dehydrogenase A (EC 1.1.1.-) +FIG01304639 Phage protein +FIG01304642 Asparagine synthetase [glutamine-hydrolyzing] (EC 6.3.5.4) YisO +FIG01304643 Tyrosine-protein kinase EpsD (EC 2.7.10.2) / Capsular polysaccharide synthesis enzyme Cap5B +FIG01304644 Putative tail fiber assembly protein p37 +FIG01304646 Phage protein +FIG01304649 Phage minor head protein +FIG01304654 COG1355, Predicted dioxygenase / COG2078: Uncharacterized ACR +FIG01304659 Respiratory arsenate reductase, Mo binding subunit (ArrA) +FIG01304660 Type III secretion inner membrane protein SctL +FIG01304662 GMP synthase [glutamine-hydrolyzing], amidotransferase subunit (EC 6.3.5.2) / GMP synthase [glutamine-hydrolyzing], ATP pyrophosphatase subunit (EC 6.3.5.2) +FIG01304663 GMP synthase [glutamine-hydrolyzing], ATP pyrophosphatase subunit (EC 6.3.5.2) / GMP synthase [glutamine-hydrolyzing], amidotransferase subunit (EC 6.3.5.2) +FIG01304666 HrpD5 protein +FIG01304667 GTP-binding protein RBG1 +FIG01304668 Similar to tRNA pseudouridine synthase C, group TruC1 +FIG01304670 TorE protein +FIG01304671 Type III secretion chaperone SycN +FIG01304673 3,5-diaminohexanoate dehydrogenase (EC 1.4.1.11) +FIG01304674 Sn-glycerol-3-phosphate dehydrogenase (Aerobic) (Aerobic glycerol-3-phosphate dehydrogenase)(EC 1.1.99.5) +FIG01304675 Type III secretion protein SctX +FIG01304679 Predicted galactoside ABC transporter, ATP-binding protein 1 +FIG01304680 Aquaporin (Major Intrinsic Protein Family) +FIG01304682 Aquaporin / Glycerol uptake facilitator protein +FIG01304687 GTP pyrophosphokinase (EC 2.7.6.5) / Guanosine-3',5'-bis(diphosphate) 3'-pyrophosphohydrolase (EC 3.1.7.2) +FIG01304692 Minor pilin of type IV secretion complex (VirB5) +FIG01304694 Putative parvulin type peptidyl-prolyl isomerase, similarity with PrsA foldase +FIG01304698 Molybdate-binding domain of ModE +FIG01304699 Zn-dependent hydrolase YycJ/WalJ, required for cell wall metabolism and coordination of cell division with DNA replication +FIG01304701 Group 2 RNA polymerase sigma factor; RNA polymerase sigma factor RpoD +FIG01304703 FIG003492: Threonine dehydrogenase and related Zn-dependent dehydrogenases +FIG01304705 Pyruvate dehydrogenase E1 component alpha subunit (EC 1.2.4.1); Branched-chain alpha-keto acid dehydrogenase, E1 component, alpha subunit (EC 1.2.4.4) +FIG01304708 Phosphoglycerate kinase (EC 2.7.2.3) / Triosephosphate isomerase (EC 5.3.1.1) +FIG01304711 Branched-chain alpha-keto acid dehydrogenase, E1 component, alpha subunit (EC 1.2.4.4) / Branched-chain alpha-keto acid dehydrogenase, E1 component, beta subunit (EC 1.2.4.4) +FIG01304712 High-affinity leucine-specific transport system, periplasmic binding protein LivK (TC 3.A.1.4.1) +FIG01304713 NADPH-dependent butanol dehydrogenase (EC 1.1.1.-) +FIG01304715 ATPase required for both assembly of type IV secretion complex and secretion of T-DNA complex, VirB11 +FIG01304716 Na/Pi cotransporter II-related protein +FIG01304720 Phage protein +FIG01304721 Uncharacterized protein COG3236 / GTP cyclohydrolase II (EC 3.5.4.25) +FIG01304727 Alpha-1,3-N-acetylgalactosamine transferase PglA (EC 2.4.1.-) +FIG01304729 Alkanesulfonates ABC transporter ATP-binding protein +FIG01304734 MreB-like protein (Mbl protein) +FIG01304735 Extracellular Matrix protein PslB +FIG01304741 Spectinomycin 9-O-adenylyltransferase +FIG01304745 Anthranilate dioxygenase small subunit +FIG01304747 Phage excisionase +FIG01304748 3-aminobutyryl-CoA ammonia-lyase (EC 4.3.1.14) +FIG01304749 Fe-bacillibactin uptake system FeuD +FIG01304751 Glycolate oxidase (EC 1.1.3.15) +FIG01304752 Phosphate butyryltransferase (EC 2.3.1.19) +FIG01304757 PhoH-like protein +FIG01304758 Unknown pentose kinase TM0952 +FIG01304759 5-Enolpyruvylshikimate-3-phosphate synthase (EC 2.5.1.19) / Cytidylate kinase (EC 2.7.4.25) +FIG01304762 Glutaredoxin 1 +FIG01304766 Arrested fork binding / Primosomal protein N' +FIG01304768 Hydroxyneurosporene synthase +FIG01304770 Urea ABC transporter, substrate binding protein UrtA +FIG01304772 Glucuronide transporter UidB +FIG01304773 Glucuronide permease +FIG01304774 Small acid-soluble spore protein, alpha/beta family, SASP_1 +FIG01304778 similar to protocatechuate 4,5-dioxygenase beta chain +FIG01304780 Biosynthetic Aromatic amino acid aminotransferase alpha (EC 2.6.1.57) @ Aromatic-amino-acid aminotransferase (EC 2.6.1.57) +FIG01304781 Biosynthetic Aromatic amino acid aminotransferase alpha (EC 2.6.1.57) @ Aromatic-amino-acid aminotransferase (EC 2.6.1.57) @ Aspartate aminotransferase (EC 2.6.1.1) +FIG01304782 Aspartate aminotransferase (EC 2.6.1.1) @ Aromatic-amino-acid aminotransferase (EC 2.6.1.57) +FIG01304783 Biosynthetic Aromatic amino acid aminotransferase alpha (EC 2.6.1.57) +FIG01304785 Peptidase M23B precursor +FIG01304786 Periplasmic septal ring factor with murein hydrolase activity EnvC/YibP +FIG01304789 Pyrene 4,5-dioxygenase alpha subunit @ Phenanthrene 4,5-dioxygenase alpha subunit +FIG01304790 LysR family transcriptional regulator PA5437 +FIG01304791 anti-sigma F factor antagonist (spoIIAA-2) +FIG01304792 Phosphomethylpyrimidine kinase (EC 2.7.4.7) / Thiamin-phosphate pyrophosphorylase (EC 2.5.1.3) +FIG01304793 Heat shock protein FtsJ/RrmJ @ Ribosomal RNA large subunit methyltransferase E (EC 2.1.1.-) +FIG01304794 Cell division protein FtsJ +FIG01304798 DMSP demethylase transcriptional regulator +FIG01304802 Thermosome subunit +FIG01304805 Carboxynorspermidine decarboxylase +FIG01304807 Probable acyl-CoA dehydrogenase FadE29 (EC 1.3.99.-) +FIG01304809 TonB-dependent receptor; Outer membrane receptor for ferric enterobactin and colicins B, D +FIG01304810 CRISPR-associated protein, SAG0894 family +FIG01304812 Acetyl-CoA C-acyltransferase (EC 2.3.1.16) @ Acetyl-CoA acetyltransferase (EC 2.3.1.9) +FIG01304813 Uncharacterized dehydrogenase [pyrroloquinoline-quinone] +FIG01304815 Aldehyde dehydrogenase (EC 1.2.1.3); Aldehyde dehydrogenase A (EC 1.2.1.22) +FIG01304818 GTP-binding protein Era +FIG01304819 Glycosyl transferase, group 2 family protein; dTDP-rhamnosyl transferase RfbF (EC 2.-.-.-) +FIG01304820 Vancomycin Teicoplanin A-type resistance protein VanA / D-alanine--D-serine ligase +FIG01304821 Vancomycin Teicoplanin A-type resistance protein VanA / D-alanine--D-alanine ligase A (EC 6.3.2.4) +FIG01304822 IncF plasmid conjugative transfer protein TrbC +FIG01304826 NADPH-dependent glyceraldehyde-3-phosphate dehydrogenase (EC 1.2.1.13) / NAD-dependent glyceraldehyde-3-phosphate dehydrogenase (EC 1.2.1.12) +FIG01304829 Anthranilate synthase, amidotransferase component (EC 4.1.3.27) +FIG01304830 tRNA 2-thiouridine synthesizing protein E (EC 2.8.1.-) @ Dissimilatory sulfite reductase, gamma subunit (EC 1.8.99.3) +FIG01304831 DsrC family protein +FIG01304833 Phosphonate dehydrogenase (EC 1.20.1.1) (NAD-dependent phosphite dehydrogenase) +FIG01304834 Fumarate hydratase class I, anaerobic (EC 4.2.1.2) +FIG01304835 Fumarate hydratase class I (EC 4.2.1.2) +FIG01304837 Predicted dye-decolorizing peroxidase (DyP), YfeX-like subgroup +FIG01304839 Swarming motility protein SwrC +FIG01304842 Putative 2-hydroxyacid dehydrogenase YcdW (EC 1.-.-.-) +FIG01304846 N-succinyl arginine/lysine racemase +FIG01304849 Biotin synthesis protein bioH +FIG01304850 4-carboxymuconolactone decarboxylase (EC 4.1.1.44) +FIG01304852 Carbon monoxide dehydrogenase form I, large chain (EC 1.2.99.2) +FIG01304853 Carbon monoxide dehydrogenase large chain (EC 1.2.99.2) parolog without usual motifs +FIG01304854 Putative pheromone precursor lipoprotein, related to Cad +FIG01304855 Similar to ribosomal large subunit pseudouridine synthase D, group RluD10 +FIG01304859 Ribulose bisphosphate carboxylase (EC 4.1.1.39) +FIG01304860 [Ni/Fe] hydrogenase, group 1, small subunit +FIG01304862 PTS system, glucose-specific IIA component / Phosphocarrier protein of PTS system / Phosphoenolpyruvate-protein phosphotransferase of PTS system (EC 2.7.3.9) +FIG01304863 Glyoxylate reductase (EC 1.1.1.79) / Hydroxypyruvate reductase (EC 1.1.1.81) / 2-ketoaldonate reductase, broad specificity (EC 1.1.1.215) (EC 1.1.1.-) +FIG01304865 4-alpha-glucanotransferase MgtA (EC 2.4.1.25) +FIG01304867 YgjD/Kae1/Qri7 family, required for N6- threonylcarbamoyl adenosine t(6)A37 modification in tRNA +FIG01304870 Glyoxalase in BtlB locus +FIG01304872 Isochorismate synthase (EC 5.4.4.2) @ Menaquinone-specific isochorismate synthase (EC 5.4.4.2) +FIG01304875 Lysine 2,3-aminomutase related protein +FIG01304878 Respiratory arsentate reductase, FeS subunit (ArrB) +FIG01304879 Glycine reductase component B gamma subunit (EC 1.21.4.2); selenocysteine-containing +FIG01304881 COG0398: uncharacterized membrane protein +FIG01304883 Dihydrolipoamide acyltransferase component of branched-chain alpha-keto acid dehydrogenase complex (EC 2.3.1.168) +FIG01304884 Light-harvesting LHII, beta subunit E +FIG01304885 5-amino-6-(5-phosphoribosylamino)uracil reductase (EC 1.1.1.193) / 2,5-diamino-6-ribitylamino-pyrimidinone 5-phosphate deaminase, fungal (EC 3.5.4.-) +FIG01304886 Electron transfer flavoprotein, beta subunit +FIG01304889 Predicted beta-glucoside specific TonB-dependent outer membrane receptor +FIG01304892 Betaine aldehyde dehydrogenase (EC 1.2.1.8) +FIG01304894 Long-chain-fatty-acid--CoA ligase (EC 6.2.1.3) / Acetoacetyl-CoA synthetase [leucine] (EC 6.2.1.16) +FIG01304898 Xylulose-5-phosphate phosphoketolase (EC 4.1.2.9) / Fructose-6-phosphate phosphoketolase (EC 4.1.2.22) +FIG01304900 Type III secretion inner membrane protein (YscS,homologous to flagellar export components); Surface presentation of antigens protein SpaQ +FIG01304902 N-3-oxooctanoyl-L-homoserine lactone synthase; N-3-oxohexanoyl-L-homoserine lactone synthase +FIG01304907 6-carboxytetrahydropterin synthase (EC 4.1.2.50) @ Queuosine biosynthesis QueD, PTPS-I / Folate biosynthesis protein PTPS-III, catalyzes a reaction that bypasses dihydroneopterin aldolase (FolB) +FIG01304908 6-carboxytetrahydropterin synthase (EC 4.1.2.50) @ Queuosine biosynthesis QueD, PTPS-I / Folate biosynthesis, PTPS-III +FIG01304909 16S rRNA m(5)C 967 methyltransferase (EC 2.1.1.-) +FIG01304911 Predicted glycolate dehydrogenase, 2-subunit type (EC 1.1.99.14), iron-sulfur subunit GlcD +FIG01304912 3-ketoacyl-CoA thiolase [isoleucine degradation] (EC 2.3.1.16) +FIG01304915 ATP-binding protein phnN; Guanylate kinase (EC 2.7.4.8) +FIG01304917 Propionyl-CoA carboxylase carboxyl transferase subunit (EC 6.4.1.3) +FIG01304918 Propionyl-CoA carboxylase beta chain (EC 6.4.1.3) +FIG01304920 Orn/DAP/Arg family decarboxylase +FIG01304923 Flagellar biosynthesis protein FliP +FIG01304927 NADH-ubiquinone oxidoreductase chain C (EC 1.6.5.3) / NADH-ubiquinone oxidoreductase chain D (EC 1.6.5.3) +FIG01304928 Ring hydroxylating dioxygenase, alpha subunit (EC 1.14.12.13) +FIG01304929 Anthranilate dioxygenase large subunit +FIG01304930 CRISPR-associated protein, Cas5h family +FIG01304931 L-malyl-CoA/beta-methylmalyl-CoA lyase (EC 4.1.3.-) +FIG01304932 FIG017670: hypothetical protein +FIG01304933 Phosphate butyryltransferase (EC 2.3.1.19) / Phosphate acetyltransferase (EC 2.3.1.8) +FIG01304937 Polysulfide reductase, subunit C, putative +FIG01304943 NADP-reducing hydrogenase, subunit C +FIG01304944 CRISPR-associated protein, MJ0381 family +FIG01304947 N-3-oxohexanoyl-L-homoserine lactone quorum-sensing transcriptional activator +FIG01304948 UDP-2,3-diacylglucosamine pyrophosphatase +FIG01304952 Hydrogenase-4 component A +FIG01304953 D-proline reductase, 26 kDa subunit; selenocysteine-containing +FIG01304954 similar to D-proline reductase, 26 kDa subunit @ selenocysteine-containing +FIG01304956 Type III secretion inner membrane channel protein (LcrD,HrcV,EscV,SsaV); Invasion protein InvA +FIG01304957 Type III secretion inner membrane protein (YscU,SpaS,EscU,HrcU,SsaU, homologous to flagellar export components); Surface presentation of antigens protein SpaS +FIG01304959 Type III secretion outermembrane contact sensing protein (YopN,Yop4b,LcrE); Invasion protein InvE +FIG01304960 Type III secretion inner membrane protein (YscQ,homologous to flagellar export components); Surface presentation of antigens protein SpaO +FIG01304961 Type III secretion outermembrane pore forming protein (YscC,MxiD,HrcC, InvG); Protein InvG precursor +FIG01304962 Type III secretion chaperone protein for YopD (SycD); Chaperone protein SicA (Salmonella invasin chaperone) +FIG01304964 Cell division protein FtsI [Peptidoglycan synthetase] (EC 2.4.1.129) @ Penicillin-binding protein 2 (PBP-2) +FIG01304965 Benzoate 1,2-dioxygenase, ferredoxin reductase component / 1,2-dihydroxycyclohexa-3,5-diene-1-carboxylate dehydrogenase (EC 1.3.1.25) +FIG01304968 Probable acyl-CoA dehydrogenase FadE28 (EC 1.3.99.-) +FIG01304969 TonB-dependent heme and hemoglobin receptor HutA ; TonB-dependent hemin , ferrichrome receptor +FIG01304970 Protein-N(5)-glutamine methyltransferase PrmB, methylates LSU ribosomal protein L3p +FIG01304972 glycogen debranching enzyme-related protein +FIG01304975 Chorismate mutase I (EC 5.4.99.5) / Aromatic aminotransferase +FIG01304978 LL-diaminopimelate aminotransferase, predicted alternative +FIG01304980 Putative cytochrome P450 125 (EC 1.14.-.-) +FIG01304981 FIG147869: Carbon-nitrogen hydrolase / Aliphatic amidase AmiE (EC 3.5.1.4) +FIG01304982 Isochorismate synthase (EC 5.4.4.2) +FIG01304984 Phage peptidoglycan hydrolase +FIG01304992 CRISPR-associated protein, Cas6 +FIG01304993 FIG069887: hypothetical protein / Protein-N(5)-glutamine methyltransferase PrmC, methylates polypeptide chain release factors RF1 and RF2 +FIG01304997 type I secretion system, membrane fusion protein, HlyD family (LapC) +FIG01304998 RND efflux system, membrane fusion protein CmeA +FIG01305001 Cysteine desulfurase (EC 2.8.1.7), SufS subfamily; Selenocysteine lyase( EC:4.4.1.16 ) subunit +FIG01305003 FIG000506: Predicted P-loop-containing kinase +FIG01305004 FIG000506: Hypothetical ATP-binding protein +FIG01305005 Siderophore staphylobactin biosynthesis protein SbnB, cyclodeaminase +FIG01305006 Glutaredoxin 3 +FIG01305013 Type IV fimbrial assembly, ATPase PilB / Twitching motility protein PilT +FIG01305019 Fimbrial periplasmic chaperone SfmC +FIG01305020 UPF0135 protein Bsu YqfO @ Bsu YqfO NIF3/CutA domain +FIG01305021 LysR-family transcriptional regulator STM1677 +FIG01305022 Acetyl-CoA acetyltransferase (EC 2.3.1.9); Beta-ketoadipyl CoA thiolase (EC 2.3.1.-) +FIG01305024 Phage endolysin +FIG01305026 Pyrophosphatase PpaX (EC 3.6.1.1) +FIG01305033 Para-aminobenzoate synthase, aminase component (EC 2.6.1.85) / Para-aminobenzoate synthase, amidotransferase component (EC 2.6.1.85) +FIG01305035 Xylose ABC transporter, substrate-binding component +FIG01305039 Phosphocholine cytidylyltransferase (EC 2.7.7.15) / Aspartate aminotransferase (EC 2.6.1.1) +FIG01305042 Phage terminase, small subunit +FIG01305046 HrpB1 protein +FIG01305053 FIG01305054: hypothetical protein +FIG01305056 Ferredoxin +FIG01305063 putative minor capsid protein - phage associated +FIG01305064 Putative oxidoreductase component of anaerobic dehydrogenases; Chaperone protein TorD +FIG01305066 CBS domain protein +FIG01305071 Minor capsid protein [Bacteriophage A118] / Phage minor capsid protein +FIG01305073 Minor capsid protein [Bacteriophage A118] +FIG01305074 Extradiol ring-cleavage dioxygenase, class III subunit B-like domain / COG2078: Uncharacterized ACR +FIG01305076 Minor capsid protein +FIG01305080 Putative transcriptional regulator YgbI, DeoR family +FIG01305081 Probable Fe-S oxidoreductase family 2 +FIG01305083 Phage DNA binding protein Roi +FIG01305087 FrmR: Negative transcriptional regulator of formaldehyde detoxification operon +FIG01305088 Para-aminobenzoate synthase, amidotransferase component (EC 2.6.1.85) @ Anthranilate synthase, amidotransferase component (EC 4.1.3.27) +FIG01305094 Lactoylglutathione lyase +FIG01305099 Outer membrane protein SusE +FIG01305100 Phage lysozyme +FIG01305106 Hypothetical protein GlcG in glycolate utilization operon +FIG01305109 Electron transport protein HydN +FIG01305110 Uronate dehydrogenase (EC 1.1.1.203) +FIG01305111 C-terminal domain of CinA, fragment of +FIG01305117 Secreted von Willebrand factor-binding protein VWbp; truncated +FIG01305119 Adhesin of unknown specificity SdrD +FIG01305128 Gluconate kinase, PFKB family +FIG01305135 FIG01305136: hypothetical protein +FIG01305144 Possible membrane protein +FIG01305149 D-alanine-D-alanine ligase and related ATP-grasp enzymes-like +FIG01305155 Glycogen [starch] synthase, eukaryotic (EC 2.4.1.11) / Glycogen phosphorylase (EC 2.4.1.1) +FIG01305156 Integron integrase IntI2 +FIG01305158 Muconate cycloisomerase (EC 5.5.1.1) +FIG01305166 Urea ABC transporter, ATPase protein UrtE / Amidase clustered with urea ABC transporter and nitrile hydratase functions +FIG01305173 Methylmalonyl-CoA mutase (EC 5.4.99.2) +FIG01305174 Putative ABC transporter of substrate X, ATP-binding subunit +FIG01305175 ATP synthase F0 sector subunit b (EC 3.6.3.14) / ATP synthase delta chain (EC 3.6.3.14) +FIG01305190 Type IV prepilin peptidase, putative / Late competence protein ComC, processing protease +FIG01305191 Capsular polysaccharide synthesis enzyme Cap8F +FIG01305194 Phage DNA N-6-adenine methyltransferase +FIG01305196 Membrane protein associated with methylmalonyl-CoA decarboxylase; truncated +FIG01305199 Capsular polysaccharide synthesis enzyme Cap8A; truncated +FIG01305200 Capsular polysaccharide synthesis enzyme Cap5A / Tyrosine-protein kinase transmembrane modulator EpsC +FIG01305202 Beta hemolysin operon CylE protein +FIG01305211 Tyrosine-protein phosphatase YopH (EC 3.1.3.48) / Type III secretion injected virulence protein (YopH,tyrosine phosphatase of FAK and p130cas, prevents phagocytosis) +FIG01305220 Acetyl-CoA:acetoacetyl-CoA transferase, alpha subunit (EC 2.8.3.8) / Acetyl-CoA:acetoacetyl-CoA transferase, beta subunit (EC 2.8.3.8) @ Acyl-CoA:acetate CoA transferase +FIG01305229 Allantoicase (EC 3.5.3.4) / 2-oxo-4-hydroxy-4-carboxy--5-ureidoimidazoline (OHCU) decarboxylase +FIG01305234 replication protein P +FIG01305236 DNA ligase, phage-associated +FIG01305237 Phage DNA polymerase clamp loader subunit Gp62 +FIG01305238 DNA polymerase (EC 2.7.7.7), phage-associated +FIG01305239 T7-like phage primase/helicase protein +FIG01305242 hydrolase, haloacid dehalogenase-like family protein BCZK2594 +FIG01305243 Heat shock protein HtrA +FIG01305244 Predicted secretion system W protein GspF-like +FIG01305247 T7-like phage DNA Polymerase (EC 2.7.7.7) +FIG01305248 Phage DNA replication protein +FIG01305254 Phage DNA helicase loader +FIG01305255 DNA transposition protein +FIG01305259 Small protein often clustered with efflux pumps +FIG01305260 Phage ssDNA binding protein +FIG01305261 D-nopaline/octopine oxidase subunit A @ Opine oxidase subunit A +FIG01305267 4-pyridoxolactonase (EC 3.1.1.27) +FIG01305273 DNA topoisomerase, phage-associated +FIG01305283 Putative polyamine transporter; Oligopeptide transport system permease protein OppB (TC 3.A.1.5.1) +FIG01305291 Lumazine protein, riboflavin synthase homolog +FIG01305300 RtcB-like protein +FIG01305305 [NiFe] hydrogenase nickel incorporation HybF-like protein +FIG01305308 polysulfide reductase, subunit B +FIG01305311 C-terminal domain of CinA paralog, YdeJ +FIG01305312 Na(+) H(+) antiporter subunit A / Na(+) H(+) antiporter subunit B +FIG01305315 Anti-sigma B factor RsbT +FIG01305318 Toluate 1,2-dioxygenase electron transfer component +FIG01305319 Putative N-methyltransferase Bcep18194_A3584 +FIG01305320 Prophage long tail fiber protein +FIG01305338 Putative dNTP triphosphohydrolase, Firmicutes subgroup +FIG01305348 GTP pyrophosphokinase (EC 2.7.6.5), (p)ppGpp synthetase I / Guanosine-3',5'-bis(diphosphate) 3'-pyrophosphohydrolase (EC 3.1.7.2) +FIG01305353 Cytidylate kinase (EC 2.7.4.25) / GTP-binding protein EngA +FIG01305357 Heme-degrading monooxygenase IsdI (EC 1.14.99.3) +FIG01305359 Electron transfer flavoprotein, alpha subunit FixB +FIG01305377 Single stranded DNA binding protein, phage-associated +FIG01305387 Dihydrolipoamide dehydrogenase (EC 1.8.1.4) / Dihydrolipoamide dehydrogenase of pyruvate dehydrogenase complex (EC 1.8.1.4) +FIG01305401 Phage protein +FIG01305404 probable methyltransferase, HemK family +FIG01305407 Putative large exoprotein involved in heme utilization or adhesion of ShlA/HecA/FhaA family +FIG01305409 Glycerol dehydratase large subunit (EC 4.2.1.30) +FIG01305413 Chromosome partitioning protein ParA +FIG01305418 Phage DNA-packaging protein +FIG01305427 Outer membrane stress sensor protease DegQ, serine protease / HtrA protease/chaperone protein / Serine protease (Protease DO) (EC 3.4.21.-) +FIG01305431 UDP-N-acetylmuramoylalanyl-D-glutamyl-2,6-diaminopimelate--D-alanyl-D-alanine ligase (EC 6.3.2.10) / Alanine racemase (EC 5.1.1.1) +FIG01305434 Alanine racemase (EC 5.1.1.1) / TsaE protein, required for threonylcarbamoyladenosine t(6)A37 formation in tRNA +FIG01305444 Electron transfer flavoprotein, beta subunit FixA +FIG01305447 Multidrug efflux membrane fusion protein MexE +FIG01305451 DNA helicase (EC 3.6.1.-), phage-associated +FIG01305455 Anti-sigma B factor RsbT / Phosphoserine phosphatase RsbX (EC 3.1.3.3) +FIG01305456 RNA chaperone Hfq homologue +FIG01305469 Phosphoserine phosphatase RsbX (EC 3.1.3.3) +FIG01305472 Inclusion membrane protein-5 +FIG01305473 Scc1 protein (Type III secretion chaperone) +FIG01305488 Putative permease, ortholog yfkN B.subtilis +FIG01305499 Uncharacterized hydrolase MJ0555 +FIG01305503 low-affinity L-arabinose transport system proton symport protein +FIG01305504 Uncharacterized protein YbeL / FIG002095: hypothetical protein +FIG01305507 Pyruvate:Oxaloacetate transcarboxylase domain protein +FIG01305509 Putative N-methyltransferase Bcep18194_A3584 +FIG01305511 Uncharacterized protein SCO4203 +FIG01305516 RNA methyltransferase, TrmH family +FIG01305522 Glycine betaine ABC transport system, substrate binding protein OpuAC +FIG01305528 bifunctional outer membrane translocase / extracellular lipase, PlpD +FIG01305535 short-chain dehydrogenase/reductase SDR +FIG01305539 Indoleamine 2,3-dioxygenase (EC 1.13.11.52) +FIG01305545 putative thiamine biosynthesis lipoprotein +FIG01305553 Putative antirepressor protein of cryptic prophage CP-933M +FIG01305558 Tyrosine recombinase xerD +FIG01305559 Glutamate-aspartate carrier protein +FIG01305580 Beta-lactamase regulatory sensor-transducer BlaR1 +FIG01305581 Extracellular fibrinogen-binding protein Efb +FIG01305583 FIG030803: Hypothetical protein +FIG01305585 D-specific D-2-hydroxyacid dehydrogenase ddh homolog (EC 1.1.1.28) +FIG01305586 Histidyl-tRNA synthetase, archaeal-type paralog (EC 6.1.1.21) +FIG01305592 Acetylornithine aminotransferase 1 (EC 2.6.1.11) +FIG01305594 Transcriptional regulator SpxA2 +FIG01305595 Enterotoxin, A subunit (NAD(+)--diphthamide ADP- ribosyltransferase) (EC 2.4.2.36) +FIG01305596 Tetracycline resistance protein TetO +FIG01305603 Type III secretion and flagellar regulator RtsA +FIG01305605 WhiB-family transcriptional regulator; role in cell cycle control +FIG01305606 N-acetylgalactosamine-6-sulfatase (EC 3.1.6.4) +FIG01305609 Non-specific DNA-binding protein Dps / Iron-binding ferritin-like antioxidant protein / Ferroxidase +FIG01305618 Virulence protein MsgA +FIG01305621 Enoyl-CoA hydratase (EC 4.2.1.17), anthrose biosynthesis +FIG01305626 D-arabinose 5-phosphate isomerase (EC 5.3.1.13) +FIG01305627 Siderophore staphylobactin biosynthesis protein SbnH +FIG01305645 Phosphotransferase system HPr enzyme in cluster with fructose-bisphosphate aldolase +FIG01305663 hypothetical protein +FIG01305683 Pertussis toxin subunit 1 precursor (NAD-dependent ADP-ribosyltransferase) (EC 2.4.2.-) +FIG01305700 FIG035400: Hypothetical protein +FIG01305705 Distant similarity with viral glycoprotein gp160 of HIV type 1 +FIG01305709 Glucitol/sorbitol-specific transport protein GutA +FIG01305719 Siderophore [Alcaligin] translocase AlcS +FIG01305720 internalin, putative +FIG01305741 putative glycosyltransferase - possibly involved in cell wall localization and side chain formation of rhamnose-glucose polysaccharide +FIG01305762 L-xylulose 5-phosphate 3-epimerase (EC 5.1.3.-) +FIG01305766 capsular polysaccharide biosynthesis protein, putative +FIG01305788 Toxin co-regulated pilus biosynthesis protein H, transcriptional activator of ToxT promoter +FIG01305789 Vi polysaccharide biosynthesis protein tviC; UDP-glucose 4-epimerase (EC 5.1.3.2) +FIG01305790 Enoyl-[acyl-carrier-protein] reductase [FMN] (EC 1.3.1.9); Glutamate-1-semialdehyde aminotransferase (EC 5.4.3.8) +FIG01305804 Phage baseplate +FIG01305829 N-Acetyl-D-glucosamine permease 2, possible +FIG01305858 FIGfam010146: Two component system histidine kinase +FIG01305877 Putative transcriptional regulator of sorbose uptake and utilization genes +FIG01305891 Apolipoprotein N-acyltransferase / Copper homeostasis protein CutE +FIG01305910 L-proline glycine betaine binding ABC transporter protein ProX (TC 3.A.1.12.1) +FIG01305912 Nitrilase 2 (EC 3.5.5.1) +FIG01305919 TRAP-type C4-dicarboxylate transport system, large permease component / Taurine transporter, large permease component +FIG01305927 Xylitol ABC transporter, periplasmic substrate-binding protein +FIG01305931 tungsten-containing formate dehydrogenase alpha subunit +FIG01305935 Heterodisulfide reductase, subunit A +FIG01305945 Cyclopropane-fatty-acyl-phospholipid synthase (EC 2.1.1.79), plant type +FIG01305946 Putative cytochrome c-type biogenesis protein related to CcmF +FIG01305970 Hydroxymethylpyrimidine ABC transporter, ATPase component +FIG01305973 Outer surface protein of unknown function, cellobiose operon +FIG01305984 regulator protein,SalR +FIG01305986 Prophage Clp protease-like protein +FIG01305989 GMP reductase +FIG01306012 Heme ABC type transporter HtsABC, heme-binding protein +FIG01306014 Flagellar basal-body rod modification protein FlgD +FIG01306044 Rhodanese-related sulfurtransferase; Rhodanese-like domain protein +FIG01306046 TPR repeat containing exported protein +FIG01306048 Probable drug resistance transport protein +FIG01306100 Sensor protein of zinc sigma-54-dependent two-component system +FIG01306117 Serine--glyoxylate aminotransferase (EC 2.6.1.45) / Serine--pyruvate aminotransferase (EC 2.6.1.51) +FIG01306122 Dihydrolipoamide acetyltransferase component of pyruvate dehydrogenase complex (EC 2.3.1.12) @ Lipoamide acyltransferase component of branched-chain alpha-keto acid dehydrogenase complex (EC 2.3.1.-) +FIG01306136 FIG121501: Prophage tail protein +FIG01306167 Hypothetical transcriptional regulator YqhC +FIG01306174 L-serine dehydratase 1 (EC 4.3.1.17) +FIG01306190 Predicted N-acetylgalactosamine kinase, COG2971 (EC 2.7.1.157) +FIG01306282 Similar to ribosomal large subunit pseudouridine synthase D, group RluD12 +FIG01306294 FIG003089: Probable transmembrane protein +FIG01306296 LysR-family transcriptional regulator APECO1_2639 +FIG01306298 putative integral membrane protein / Protein-N(5)-glutamine methyltransferase PrmC, methylates polypeptide chain release factors RF1 and RF2 +FIG01306307 Aspartate/tyrosine/aromatic aminotransferase / Glutamine-dependent 2-keto-4-methylthiobutyrate transaminase +FIG01306310 Nitrilase 1 (EC 3.5.5.1) +FIG01306316 Predicted D-glucuronide-specific TRAP transporter, substrate-binding component +FIG01306324 Proline reductase proprotein, two subunits +FIG01306331 Major tail protein +FIG01306332 unknown function +FIG01306349 Predicted riboflavin ABC transporter, transmembrane component +FIG01306367 Polysialic acid transport protein KpsD precursor +FIG01306378 ABC transporter periplasmic substrate-binding component +FIG01306386 CBS domain protein +FIG01306405 Capsular polysaccharide synthesis enzyme Cap8B +FIG01306410 Putative cysteine desulfurase, associated with tRNA 4-thiouridine synthase +FIG01306411 Anaerobic nitric oxide reductase transcription regulator NorR +FIG01306414 Permease of the drug/metabolite transporter (DMT) superfamily / AdoMet-AdoHcy transporter +FIG01306418 Adenylate cyclase +FIG01306419 Phosphoserine phosphatase, putative (EC 3.1.3.3) +FIG01306420 Anti anti-sigma regulatory factor SypA; Anti-sigma F factor antagonist (spoIIAA-2); Anti-sigma B factor antagonist RsbV +FIG01306422 Probable valine-pyruvate aminotransferase (EC 2.6.1.66) +FIG01306441 FIG030769: Probable conserved MCE associated membrane protein +FIG01306442 FIG033430: Probable conserved MCE associated membrane protein +FIG01306444 FIG025093: Probable membrane protein +FIG01306446 Lanthionine precursor peptide LanA +FIG01306450 Putative Zn-dependent oxidoreductase BA2113 +FIG01306452 TOMM biosynthesis precursor peptide (protein A) +FIG01306453 Peptide deformylase related protein +FIG01306456 TOMM precursor peptide, NHLP family +FIG01306459 domain of unknown function / TOMM export ABC transporter, ATP-binding protein +FIG01306462 SSU ribosomal protein S14p (S29e) @ SSU ribosomal protein S14p (S29e), zinc-dependent +FIG01306466 molybdopterin biosynthesis protein moeB related protein +FIG01306469 hypothetical protein +FIG01306472 NifU-like protein +FIG01306479 23S rRNA (guanosine-2'-O-) -methyltransferase rlmB (EC 2.1.1.-) +FIG01306489 Sigma-54 dependent transcriptional regulator; Response regulator receiver domain / Serine-protein kinase RsbW (EC 2.7.11.1) +FIG01306496 ThiI domain protein +FIG01306501 Aconitate hydratase small subunit (EC 4.2.1.3) +FIG01306502 Aconitate hydratase large subunit (EC 4.2.1.3) +FIG01306503 Shikimate kinase II (EC 2.7.1.71) +FIG01306504 Phage lysin, phospho-MurNAc-pentapeptide translocase inhibitor +FIG01306506 FmtA protein involved in methicillin resistance +FIG01306509 Phage single stranded DNA synthesis +FIG01306511 Mycobacteriophage lysis protein, LysB +FIG01306512 ATP-dependent protease La (EC 3.4.21.53) LonB Type I +FIG01306513 FIG018298: PE family protein +FIG01306514 cis-4,5-dihydroxypyrene dehydrogenase @ cis-3,4-dihydroxyphenanthrene-4-carboxylate dehydrogenase (decarboxylating) @ Pyrene cis-1,2-dihydrodiol dehydrogenase +FIG01306516 Expressed protein possibly involved in photorespiration +FIG01306518 Replication factor C small subunit / Phage DNA polymerase clamp loader subunit +FIG01306520 Proline 2-methylase for pyrrolysine biosynthesis +FIG01306524 Anthranilate synthase, amidotransferase component (EC 4.1.3.27) [PQS biosynthesis] +FIG01306528 Predicted aconitase subunit 1 +FIG01306531 Sliding clamp DNA polymerase accessory protein, phage associated +FIG01306534 T4-like phage RNA polymerase sigma factor for late transcription +FIG01306536 Phage portal vertex of the head +FIG01306537 Geranylfarnesyl diphosphate synthetase (EC EC 2.5.1.81) +FIG01306543 Arogenate dehydratase (EC 4.2.1.91) +FIG01306551 Proline reductase for pyrrolysine biosynthesis +FIG01306554 Phage neck +FIG01306568 Mobile element protein +FIG01306569 "Octaprenyl diphosphate synthase / Dimethylallyltransferase / (2E,6E)-farnesyl diphosphate synthase / Geranylgeranyl diphosphate synthase " +FIG01306570 Decaprenyl diphosphate synthase (EC 2.5.1.91) +FIG01306573 Undecaprenyl diphosphate synthase (EC 2.5.1.31) +FIG01306574 (2E,6Z)-farnesyl diphosphate synthase (EC 2.5.1.68) +FIG01306575 GTPase CgtA +FIG01306576 Demethyl 4-deoxygadusol synthase MysA +FIG01306577 Riboflavin synthase alpha chain (EC 2.5.1.9) +FIG01306588 UDP-2,3-diacetamido-2,3-dideoxy-D-glucuronic acid 2-epimerase +FIG01306589 4-hydroxybenzoate polyprenyltransferase (EC 2.5.1.39) +FIG01306590 Menaquinone via futalosine polyprenyltransferase (MenA homolog) +FIG01306592 Polyprenyltransferase, MA0790 type +FIG01306593 Polyprenyltransferase, MA4420 type +FIG01306597 UbiD family decarboxylase associated with menaquinone via futalosine +FIG01306599 UbiD family decarboxylase, MJ1133 type +FIG01306602 UbiX family decarboxylase associated with menaquinone via futalosine +FIG01306605 L-aspartate oxidase (EC 1.4.3.16) / Quinolinate phosphoribosyltransferase [decarboxylating] (EC 2.4.2.19) +FIG01306609 Cystathionine gamma-synthase (EC 2.5.1.48) @ O-acetylhomoserine sulfhydrylase (EC 2.5.1.49) +FIG01306610 Uncharacterized hydroxylase PA0655 +FIG01306611 Putative monooxygenase VisC; 2-octaprenyl-3-methyl-6-methoxy-1,4-benzoquinol hydroxylase (EC 1.14.13.-) +FIG01306622 O-succinylbenzoate synthase (EC 4.2.1.113) +FIG01306626 Molybdopterin biosynthesis protein MoeB +FIG01306628 Hydrogenase maturation factor HoxT/HybE / Hydrogenase maturation factor HoxR +FIG01306630 [FeFe]-hydrogenase maturation protein HydG +FIG01306631 LL-diaminopimelate aminotransferase (EC 2.6.1.83), predicted alternative +FIG01306632 Para-aminobenzoate synthase, aminase component (EC 6.3.5.8) / Aminodeoxychorismate lyase (EC 4.1.3.38) +FIG01306634 Aerobic carbon monoxide dehydrogenase molybdenum cofactor insertion protein CoxF +FIG01306635 Cyclopropane-fatty-acyl-phospholipid synthase +FIG01306636 Hypothetical protein COG3496 +FIG01306638 Carbon monoxide oxidation accessory protein CoxG +FIG01306640 Sorbitol-6-phosphate 2-dehydrogenase (EC 1.1.1.140) +FIG01306641 UDP-2-acetamido-3-amino-2,3-dideoxy-D-glucuronic acid acetyltransferase +FIG01306643 TonB-dependent hemin , ferrichrome receptor @ Iron siderophore receptor protein +FIG01306645 Bacterial regulatory protein LysR, HTH motif protein +FIG01306653 Uracil permease / Xanthine permease +FIG01306656 SpoU rRNA Methylase family +FIG01306657 Type III Pyridoxal 5-phosphate (PLP)-Dependent Enzyme +FIG01306659 23S rRNA (Uracil-5-) -methyltransferase RumA (EC 2.1.1.-) +FIG01306660 Glutathione S-transferase family protein Sll1545 +FIG01306664 Putative urate catabolism protein +FIG01306665 Transcriptional regulator, GntR family domain +FIG01306666 GntR family transcriptional regulator YdcR @ Transcriptional regulator, GntR family domain +FIG01306670 GntR family transcriptional regulator YjiR @ Transcriptional regulator, GntR family domain +FIG01306671 GntR family transcriptional regulator XCC3386 @ Transcriptional regulator, GntR family domain +FIG01306673 GntR family transcriptional regulator sll5086 @ Transcriptional regulator, GntR family domain +FIG01306674 GntR family transcriptional regulator Fjoh_4822 @ Transcriptional regulator, GntR family domain +FIG01306678 GntR family transcriptional regulator VV2092 @ Transcriptional regulator, GntR family domain +FIG01306681 2-heptaprenyl-1,4-naphthoquinone methyltransferase (EC 2.1.1.163) +FIG01306686 Methyltransferase TM1293 +FIG01306688 Methyltransferase VNG0294G +FIG01306690 SAM-dependent methyltransferase DSY4148 (UbiE paralog) +FIG01306695 [FeFe]-hydrogenase maturation protein HydF +FIG01306697 Sugar transport system ATP-binding protein +FIG01306700 GntR family transcriptional regulator PA4165 @ Transcriptional regulator, GntR family domain +FIG01306703 DNA integrity scanning protein DisA +FIG01306706 Menaquinone via 6-amino-6-deoxyfutalosine step 1 +FIG01306712 Carbon monoxide oxidation accessory protein CoxD +FIG01306713 3-demethylubiquinol 3-O-methyltransferase (EC 2.1.1.64) +FIG01306723 Arsenate reductase (EC 1.20.99.1) +FIG01306727 UPF0149 exported protein YgfB +FIG01306728 Dimethylallyltransferase (EC 2.5.1.1) / (2E,6E)-farnesyl diphosphate synthase (EC 2.5.1.10) / Farnesyltranstransferase (EC 2.5.1.29) +FIG01306730 Geranylgeranyl diphosphate reductase (EC 1.3.1.83); Digeranylgeranylglycerophospholipid reductase +FIG01306733 Rubrerythrin +FIG01306734 NAD-reducing [Fe]-hydrogenase, cytoplasmic, alpha subunit (EC 1.12.1.4) +FIG01306737 Branched-chain amino acid aminotransferase (EC 2.6.1.42) +FIG01306738 Geranylgeranyl diphosphate synthase (EC 2.5.1.29) +FIG01306739 gamma-tocopherol methyltransferase (EC 2.1.1.95) @ delta-tocopherol methyltransferase (EC 2.1.1.95) +FIG01306740 Sigma-70 factor FpvI (ECF subfamily), controling pyoverdin biosynthesis @ FIG006045: Sigma factor, ECF subfamily +FIG01306741 Multidrug Resistance Protein 1 +FIG01306743 2-methyl-6-phytyl-1,4-benzoquinone cyclase @ 2,3-dimethyl-6-phytyl-1,4-benzoquinone cyclase @ Tocopherol cyclase +FIG01306745 Dimethylallyltransferase (EC 2.5.1.1) @ (2E,6E)-farnesyl diphosphate synthase (EC 2.5.1.10) @ Geranylgeranyl pyrophosphate synthetase (EC 2.5.1.29) +FIG01306747 Putative Ton-B dependent hemine receptor @ Iron siderophore receptor protein +FIG01306755 Carbon monoxide oxidation accessory protein CoxE +FIG01306756 ATP-binding protein PhnN; Guanylate kinase (EC 2.7.4.8) +FIG01306758 NADP-reducing [Fe]-hydrogenase, cytoplasmic, beta subunit (EC 1.12.1.4) +FIG01306760 Iron compound ABC transporter, periplasmic iron compound-binding protein +FIG01306761 FIG00344505: hypothetical protein +FIG01306763 NAD-reducing [Fe]-hydrogenase, cytoplasmic, gamma subunit (EC 1.12.1.4) +FIG01306765 NADP-reducing [Fe]-hydrogenase, cytoplasmic, delta subunit (EC 1.12.1.4) +FIG01306767 Carbon monoxide oxidation accessory protein CoxC +FIG01306768 Menaquinone via 6-amino-6-deoxyfutalosine step 2 +FIG01306770 N-acetyl-L,L-diaminopimelate aminotransferase homolog +FIG01306772 Nitrilase superfamily protein +FIG01306778 Dimethylallyltransferase (EC 2.5.1.1); (2E,6E)-farnesyl diphosphate synthase (EC 2.5.1.10); Geranylgeranyl diphosphate synthase (EC 2.5.1.29) +FIG01306779 Octaprenyl diphosphate synthase (EC 2.5.1.90); Dimethylallyltransferase (EC 2.5.1.1); (2E,6E)-farnesyl diphosphate synthase (EC 2.5.1.10); Geranylgeranyl diphosphate synthase (EC 2.5.1.29) +FIG01306780 Para-aminobenzoate synthase, aminase component (EC 6.3.5.8) +FIG01306785 NLP/P60 family lipoprotein +FIG01306794 FIG00762853: hypothetical protein +FIG01306801 Antisigma transmembrane sensor FpvR @ Iron siderophore sensor protein +FIG01306810 Glutamine amidotransferase chain of NAD synthetase +FIG01306816 Octaprenyl diphosphate synthase (EC 2.5.1.90) / Dimethylallyltransferase (EC 2.5.1.1) / Geranyltranstransferase (EC 2.5.1.10) / Geranylgeranyl diphosphate synthase (EC 2.5.1.29) +FIG01306819 Anaerobic dehydrogenases, typically selenocysteine-containing +FIG01306820 Anaerobic dimethyl sulfoxide reductase chain A (EC 1.8.99.-) @ Trimethylamine-N-oxide reductase (EC 1.6.6.9) +FIG01306829 (2E,6E)-farnesyl diphosphate synthase (EC 2.5.1.10) +FIG01306830 Dimethylallyltransferase (EC 2.5.1.1) @ (2E,6E)-farnesyl diphosphate synthase (EC 2.5.1.10) +FIG01306832 Dimethylallyltransferase (EC 2.5.1.1) / (2E,6E)-farnesyl diphosphate synthase (EC 2.5.1.10) / Geranylgeranyl diphosphate synthase (EC 2.5.1.29) +FIG01306837 Xanthine dehydrogenase accessory protein XdhC +FIG01306843 Putative hemin-binding lipoprotein +FIG01306854 Anaerobic dimethyl sulfoxide reductase chaperone DmsD +FIG01306855 Protein gp4 +FIG01306858 Alanine racemase (EC 5.1.1.1) +FIG01306864 2-Methylcitrate dehydratase AcnD +FIG01306875 Il-IS_2, transposase +FIG01306878 Phage lysis protein S +FIG01306879 type 1 fimbriae regulatory protein FimE +FIG01306880 FIG00828840: hypothetical protein +FIG01306881 Transposase YhgA +FIG01306882 Nitrate/nitrite transporter +FIG01306883 Phage integrase, Phage P4-associated +FIG01306884 Sensor histidine kinase in Mg(2+) transport ATPase cluster +FIG01306885 Uncharacterized HTH-type transcriptional regulator MJ0774 +FIG01306886 Monomeric sarcosine oxidase (EC:1.5.3.1), curated +FIG01306887 Tungsten-containing ferredoxin oxidoreductase WOR6 +FIG01306888 Archaeal flavoprotein COG1036 +FIG01306889 Hydrogenase maturation factor HoxR +FIG01306890 Dinucleotide-utilizing enzymes involved in molybdopterin and thiamine biosynthesis family 2 +FIG01306891 Respiratory nitrate reductase NarX +FIG01306892 Uncharacterized protein MJ0760 +FIG01306894 H(2)-dependent N5,N10-methylenetetrahydromethanopterin dehydrogenase +FIG01306896 Hydrogenase maturation factor HoxQ +FIG01306897 Uncharacterized protein MJ0790 +FIG01306898 Uncharacterized protein MJ0793 +FIG01306899 Uncharacterized AsnC family transcriptional regulator MJ0769 +FIG01306905 Uncharacterized protein MJ0693 +FIG01306907 O-methyltransferase MysB +FIG01306911 Diflavin flavoprotein SYNW2367 +FIG01306912 Uncharacterized protein MJ0780 +FIG01306913 Uncharacterized protein MJ0772 +FIG01306914 Uncharacterized protein Rv2003c/MT2059 +FIG01306917 Uncharacterized protein MJ0787 +FIG01306919 Predicted sodium/serine symporter MysT +FIG01306921 F420H2 oxidase (FprA) +FIG01306922 Uncharacterized protein MJ0818 +FIG01306927 Sarcosine oxidase alpha subunit (EC 1.5.3.1) @ Opine oxidase subunit A +FIG01306928 Uncharacterized protein MJ0738 +FIG01306929 ISPsy4, transposition helper protein +FIG01306931 Ribosomal protein L24, conjectural +FIG01306932 Tungsten-containing ferredoxin oxidoreductase WOR4 +FIG01306937 Mg(2+) transport ATPase, P-type (EC 3.6.3.2) +FIG01306948 Anaerobic dimethyl sulfoxide reductase chain B (EC 1.8.99.-) @ Respiratory trimethylamine-N-oxide reductase, iron-sulfur subunit +FIG01306950 Uncharacterized polyferredoxin MJ0750 +FIG01306954 Uncharacterized protein MJ0761 +FIG01306964 Serine hydroxymethyltransferase (EC 2.1.2.1) @ L-threonine aldolase (EC 4.1.2.5) @ L-allo-threonine aldolase (EC 4.1.2.49) +FIG01306972 SSU ribosomal protein S18p @ SSU ribosomal protein S18p, zinc-dependent +FIG01306976 LSU ribosomal protein L20p / similar to N-terminal region of rho transcription termination factor +FIG01306982 LSU ribosomal protein L21p / domain of unknown function +FIG01306991 Probable 5'-3' exonuclease Bsu YpcP +FIG01306994 ATP-dependent DNA helicase RecS (RecQ family) +FIG01306996 Glycerate-2-kinase (EC 2.7.1.165) +FIG01306997 5-nucleotidase SurE (EC 3.1.3.5) @ Exopolyphosphatase (EC 3.6.1.11) +FIG01307003 Metal-dependent hydrolase YbeY, involved in rRNA and/or ribosome maturation and assembly / Pyridoxine 5'-phosphate synthase (EC 2.6.99.2) +FIG01307004 Pyridoxal phosphate biosynthetic protein pdxJ +FIG01307008 ATP phosphoribosyltransferase regulatory subunit (EC 2.4.2.17) / ATP phosphoribosyltransferase (EC 2.4.2.17) +FIG01307013 """ABC-type multidrug transport system, ATPase component""" +FIG01307022 Alanyl-tRNA synthetase domain protein +FIG01307023 FUPA27 P-type ATPase +FIG01307025 FKBP-type peptidyl-prolyl cis-trans isomerase FklB (EC 5.2.1.8) +FIG01307026 FIG056164: rhomboid family serine protease +FIG01307028 Cytochrome c oxidase caa3-type, assembly factor CtaG-related protein +FIG01307030 """ABC-type multidrug transport system, permease component""" +FIG01307034 Acetyltransferase, CysE/LacA/LpxA/NodL family +FIG01307036 Cof protein, HD superfamily hydrolase +FIG01307038 HMP-PP hydrolase (pyridoxal phosphatase) Cof, detected in genetic screen for thiamin metabolic genes (PMID:15292217) +FIG01307039 hypothetical protein +FIG01307042 hypothetical protein +FIG01307046 FIG002813: hypothetical protein +FIG01307048 ATP-dependent RNA helicase YejH +FIG01307049 FIG003190: hypothetical protein co-occurring with TPR domain protein +FIG01307050 Formate hydrogenlyase subunit 11 +FIG01307052 Geranylgeranyl hydrogenase BchP; Geranylgeranyl diphosphate reductase (EC 1.3.1.83) +FIG01307056 LarE: implicated in lactate racemization +FIG01307058 Transcriptional regulator, GntR family +FIG01307059 hypothetical protein +FIG01307060 2'-5' RNA ligase (EC 6.5.1.-) +FIG01307063 Ferric enterobactin transport system permease protein FepG (TC 3.A.1.14.2) @ ABC-type Fe3+-siderophore transport system, permease 2 +FIG01307065 phosphoglycerate mutase/fructose-2,6-bisphosphatase +FIG01307068 Fructose-bisphosphate aldolase, archaeal class I (EC 4.1.2.13) @ Methylglyoxal--fructose-6-phosphate transaldolase @ Methylglyoxal--fructose-1,6-bisphosphate transaldolase +FIG01307069 GntR family transcriptional regulator Daci_0595 @ Transcriptional regulator, GntR family domain +FIG01307071 GntR family transcriptional regulator MSMEG1569 @ Transcriptional regulator, GntR family domain +FIG01307074 Phosphoesterase family protein +FIG01307077 D-galactarate permease +FIG01307079 "transcriptional regulator, Crp/Fnr family" +FIG01307080 Mg(2+) transport ATPase protein C / Putative membrane transporter ATPase,YhiD +FIG01307084 2-keto-3-deoxy-D-arabinonate dehydratase +FIG01307086 [FeFe]-hydrogenase maturation GTPase HydF +FIG01307087 Na+/H+ antiporter NapA +FIG01307088 Cyclic amid hydrolase in mycofactocin cluster +FIG01307091 3'-5' exonuclease domain similar to epsilon subunit of DNA polymerase III, PA3232-type +FIG01307093 FIG009026: Hypothetical transmembrane protein +FIG01307095 FIG009300: TPR-repeat-containing protein +FIG01307096 Probable RNA 2'-phosphotransferase (EC 2.7.1.-) +FIG01307100 Similar to 5-oxoprolinase (EC 3.5.2.9) and Methylhydantoinases A, B (EC 3.5.2.14), contradiction in experimental data (see Annotation) +FIG01307102 L-alanyl-gamma-D-glutamyl-L-diamino acid endopeptidase +FIG01307103 L-fucose mutarotase, type 2 +FIG01307104 """YrdC/Sua5 family protein, required for threonylcarbamoyladenosine (t(6)A) formation in tRNA""" +FIG01307111 Metal-dependent amidase/aminoacylase/carboxypeptidase +FIG01307115 """Serine phosphatase RsbU, regulator of sigma subunit""" +FIG01307118 """Uracil-DNA glycosylase, family 5""" +FIG01307123 Yersiniabactin synthetase, thiazolinyl reductase component Irp3 +FIG01307132 """Oligopeptide ABC transporter, periplasmic oligopeptide-binding protein OppA (TC 3.A.1.5.1)""" +FIG01307133 Cu+ P-type ATPase +FIG01307138 DNA polymerase IV-like protein ImuB +FIG01307139 Heavy-Metal transporting ATPase +FIG01307147 "Geranylgeranyl diphosphate reductase " +FIG01307149 GlpF1: implicated in lactate racemization +FIG01307151 Heavy-Metal transporting ATPase +FIG01307155 2-amino-2-deoxy-isochorismate hydrolase PhzD (EC 3.-.-.-) +FIG01307157 mandelate racemase family protein Pfl_3283 +FIG01307162 FUPA26 P-type ATPase +FIG01307164 Ferrichrome-iron receptor @ Iron siderophore receptor protein +FIG01307165 LarC1: implicated in lactate racemization / LarC2: implicated in lactate racemization +FIG01307171 Mycofactocin system heme/flavin dehydrogenase +FIG01307172 Diflavin flavoprotein Sll0219 +FIG01307175 Isochorismatase (EC 3.3.2.1) [brucebactin] siderophore @ Isochorismatase (EC 3.3.2.1) of siderophore biosynthesis +FIG01307176 Isochorismatase (EC 3.3.2.1) [enterobactin] siderophore / Apo-aryl carrier domain of EntB @ Isochorismatase (EC 3.3.2.1) of siderophore biosynthesis +FIG01307177 Isochorismate synthase (EC 5.4.4.2) [brucebactin] siderophore @ Isochorismate synthase (EC 5.4.4.2) of siderophore biosynthesis +FIG01307178 Isochorismate synthase (EC 5.4.4.2) [enterobactin] siderophore @ Isochorismate synthase (EC 5.4.4.2) of siderophore biosynthesis +FIG01307184 Carbon-monoxide dehydrogenase form II, large subunit (EC 1.2.99.2) +FIG01307185 Hydrogen-sensing hydrogenase small subunit (HoxB/HupU) +FIG01307187 Conjugative transposon primase TraP @ DNA primase (EC 2.7.7.-) +FIG01307192 Guanosine-5'-triphosphate,3'-diphosphate pyrophosphatase (EC 3.6.1.40) @ Exopolyphosphatase (EC 3.6.1.11) +FIG01307193 L-fuco-beta-pyranose dehydrogenase (EC 1.1.1.122) +FIG01307195 FIG00821975: hypothetical protein +FIG01307203 LarB: implicated in lactate racemization +FIG01307204 2,3-dihydroxybenzoate-AMP ligase (EC 2.7.7.58) [bacillibactin] siderophore @ 2,3-dihydroxybenzoate-AMP ligase (EC 2.7.7.58) +FIG01307205 """Hypothetical ATP-binding protein UPF0042, contains P-loop""" +FIG01307208 Inorganic pyrophospatase PpaX (EC 3.1.3.18) +FIG01307214 FIG00514497: hypothetical protein +FIG01307225 Uncharacterized protein YeeW +FIG01307226 Cu+ P-type ATPase fragment +FIG01307227 Heavy-Metal transporting ATPase fragment +FIG01307234 Transcriptional regulator +FIG01307235 Predicted D-mannonate epimerase +FIG01307239 hypothetical protein +FIG01307242 Membrane protein, Rhomboid family +FIG01307245 Possible RNA methyltransferase aq_898 +FIG01307249 Integral membrane protein +FIG01307252 Periplasmic sugar-binding component of uncharacterized ABC-type transport system +FIG01307256 2,3-dihydroxybenzoate-AMP ligase (EC 2.7.7.58) of siderophore biosynthesis / Isochorismate synthase (EC 5.4.4.2) of siderophore biosynthesis +FIG01307262 Bacteriophage-encoded homolog of DNA replication protein DnaC +FIG01307265 Oligopeptide transport system permease protein OppD (TC 3.A.1.5.1) +FIG01307266 DNA topoisomerase III (EC 5.99.1.2) / ATP-dependent DNA helicase RecQ +FIG01307267 Peptidyl-prolyl cis-trans isomerase PpiD (EC 5.2.1.8) +FIG01307280 Oligopeptide transport system permease protein OppD (TC 3.A.1.5.1) +FIG01307286 6,7-dimethyl-8-ribityllumazine synthase (EC 2.5.1.9) +FIG01307295 ABC transport system, periplasmic substrate-binding protein Z5689 +FIG01307302 Putative metal chaperone, involved in Zn homeostasis, GTPase of COG0523 family +FIG01307313 Phage integrase / RstB phage-related integrase +FIG01307316 Integron integrase IntI1 +FIG01307318 Phage integrase +FIG01307329 Trehalose-6-phosphate phosphatase (EC 3.1.3.12) +FIG01307330 FIG017822: Ferredoxin +FIG01307332 Putative alkylsulfatase (EC 1.14.11.17) +FIG01307336 General stress protein 13 +FIG01307337 FIG00349941: hypothetical protein +FIG01307338 FIG00622811: hypothetical protein +FIG01307343 FIG00769719: hypothetical protein +FIG01307345 FIG00633155: hypothetical protein +FIG01307348 ABC transporter protein +FIG01307358 putative serine/threonine protein kinase +FIG01307365 FIG011754: hypothetical protein +FIG01307369 1,4-alpha-glucan branching enzyme (EC 2.4.1.18) +FIG01307370 FIG00622905: hypothetical protein +FIG01307377 FIG00640718: hypothetical protein +FIG01307385 FIG00899225: hypothetical protein +FIG01307387 MFS general substrate transporter +FIG01307390 COG0471: Di- and tricarboxylate transporters +FIG01307391 alpha/beta hydrolase fold family protein +FIG01307392 FIG00350255: hypothetical protein +FIG01307393 5-bromo-4-chloroindolyl phosphate hydrolysis protein +FIG01307395 FIG00403730: hypothetical protein +FIG01307410 Propionyl-CoA:succinyl-CoA transferase +FIG01307414 quaternary ammonium compound-resistance protein, C-terminal +FIG01307416 Probable lipopolysaccharide modification acyltransferase +FIG01307421 Putative amino acid permease +FIG01307428 COG1088: dTDP-D-glucose 4,6-dehydratase +FIG01307433 Putative carbohydrate-binding protein +FIG01307447 plasmid-related protein +FIG01307460 FIG00688531: hypothetical protein +FIG01307462 Hypothetical protein SAV1789 +FIG01307468 neutral protease +FIG01307475 FIG00766944: hypothetical protein +FIG01307476 Two-component sensor CbrA: intrcellular carbon:nitrogen balance +FIG01307479 possible tyrosine-protein phosphatase +FIG01307483 FIG085450: fimbrial protein +FIG01307493 Cytochrome b (EC 1.10.2.2) +FIG01307499 3-OXOACYL-(ACYL-CARRIER PROTEIN) REDUCTASE (EC 1.1.1.100) +FIG01307503 tetratricopeptide repeat protein +FIG01307504 DUF1696 domain-containing protein +FIG01307512 Phosphotransferase system mannitol/fructose-specific IIA domain +FIG01307518 Similar orfs in genome (SYNW2413,SYNW0367,SYNW0892) +FIG01307520 FIG00350205: hypothetical protein +FIG01307527 Tetrathionate reductase subunit B (1.8.99.-) +FIG01307528 ortholog of Bordetella pertussis (BX470248) BP3300 +FIG01307531 Protein tyrosine phosphatase +FIG01307542 Multidrug efflux system subunit MdtC +FIG01307547 Probable integral membrane protein Cj1165c +FIG01307552 Transposase IS200-like protein +FIG01307555 Probable cation-transporting ATPase F (EC 3.6.3.-) +FIG01307563 Phosphorylase kinase alpha subunit +FIG01307565 Replication protein +FIG01307566 Cytochrome P450 +FIG01307571 oxidoreductase +FIG01307572 Heat shock protein 22.5 (Hsp22.5) +FIG01307575 hypothetical glycine rich protein +FIG01307576 FIG00403166: hypothetical protein +FIG01307586 STY3078 protein +FIG01307591 FIG00763585: hypothetical protein +FIG01307593 Methyl-accepting chemotaxis protein, homolog 7 +FIG01307594 putative cold shock protein +FIG01307599 Multi-sensor Hybrid Histidine Kinase +FIG01307600 FIG00350303: hypothetical protein +FIG01307604 hypothetical protein within prophage +FIG01307606 DNA-binding response regulator, LuxR family +FIG01307607 putative BigA-like protein +FIG01307617 PPO candidate 1 +FIG01307623 Putative phosphotransferase enzyme II, B component +FIG01307626 Transcriptional regulator, CrP/Fnr family +FIG01307629 Probable aminoglycoside efflux pump +FIG01307630 Putative integrase for prophage CP-933R +FIG01307635 STAS domain protein +FIG01307644 Phosphoethanolamine N-methyltransferase +FIG01307659 ElaD protein +FIG01307663 FIG00672526: hypothetical protein +FIG01307671 Putative dehydrogenase protein +FIG01307675 Predicted hydrolase or acyltransferase +FIG01307678 membrane protein, MmpL family +FIG01307679 Regulatory protein cro +FIG01307688 Daunorubicin resistance ATP-binding protein drrA +FIG01307690 FIG00623851: hypothetical protein +FIG01307699 FOG: FHA domain +FIG01307717 TraF-related protein +FIG01307722 putative taurine transport ATP-binding protein tauB +FIG01307726 Phage lysin; N-acetylmuramoyl-L-alanine amidase, family 3 (EC:3.5.1.28) +FIG01307734 Chemotactic transducer-related protein +FIG01307735 hypothetical protein +FIG01307738 FIG00350497: hypothetical protein +FIG01307745 STMD1.44 protein +FIG01307746 HTH-type transcriptional regulator gadW +FIG01307748 Hypothetical protein SAV2260 +FIG01307752 FIG01045569: hypothetical protein +FIG01307753 Hypothetical hydrolase +FIG01307755 FIG00513685: hypothetical protein +FIG01307762 Minor tail protein Z +FIG01307768 N-acetyltransferase (GNAT) family, Syn7942_0773 homolog, Ycf52 protein +FIG01307772 FIG00416648: hypothetical protein +FIG01307775 putative lipoprotein-34 precursor (NlpB) +FIG01307786 FIG00388395: hypothetical protein +FIG01307794 Histidine kinase sensor protein (EC 2.7.1.-) +FIG01307797 Prespore specific transcriptional activator RsfA +FIG01307799 sodium export ATP-binding protein natA +FIG01307806 outer membrane lipoprotein carrier protein LolA +FIG01307807 hypothetical protein +FIG01307809 hypothetical protein +FIG01307810 Uncharacterized protein TP_0708 +FIG01307814 FIG00769124: hypothetical protein +FIG01307815 FIG00349939: hypothetical protein +FIG01307816 hypothetical protein similar to TpgX +FIG01307822 Prophage helix-turn-helix protein +FIG01307832 Bacterial regulatory proteins, AsnC family +FIG01307837 MutT/Nudix family protein +FIG01307846 biofilm formation protein YmcA +FIG01307847 Permeases of the drug/metabolite transporter (DMT) superfamily +FIG01307848 Cytotoxic necrotizing factor +FIG01307850 NAD(FAD)-utilizing enzyme possibly involved in translation +FIG01307853 BH3430 unknown conserved protein +FIG01307855 FIG00763123: hypothetical protein +FIG01307861 Acyltransferase 3 +FIG01307865 Candidate zinc-binding lipoprotein ZinT +FIG01307868 Intercellular spread protein +FIG01307869 Histone deacetylase family protein +FIG01307879 hypothetical protein NMA0239 +FIG01307883 protein of unknown function DUF1052 +FIG01307888 Perfringolysin O regulator protein PfoR +FIG01307892 probable periplasmic protein NMA1083 +FIG01307894 hydrolase, NUDIX family +FIG01307902 FIG01225759: possible membrane protein +FIG01307906 Uncharacterized conserved protein, contains double-stranded beta-helix domain +FIG01307911 site-specific recombinase, phage integrase family +FIG01307928 COG4478, integral membrane protein +FIG01307932 DNA topoisomerase (ATP-hydrolyzing), subunit B +FIG01307937 FIG00628771: hypothetical protein +FIG01307940 FIG00623287: hypothetical protein +FIG01307955 Acyl carrier protein, paralog +FIG01307961 FIG00822969: hypothetical protein +FIG01307966 Putative cytoplasmic protein +FIG01307970 FIG00450219: hypothetical protein +FIG01307972 PROBABLE LIPOPROTEIN LPPU +FIG01307976 Glutamate ABC transporter, periplasmic glutamine-binding protein +FIG01307979 RhlA, 3-(3-hydroxyalkanoyloxy)alkanoic acids (HAAs) synthase +FIG01307993 transcriptional regulator, DeoR family +FIG01307995 hypothetical protein +FIG01307998 Putative F1C and S fimbrial switch Regulatory protein +FIG01308000 probable membrane protein b2001 +FIG01308002 FIG01219932: hypothetical protein +FIG01308003 Putative dihydroneopterin aldolase protein (EC 4.1.2.25) +FIG01308011 NT (nucleotidyltransferase) domain and HEPN (higher eukarytoes and prokaryotes nucleotide-binding) domain +FIG01308021 Multidrug resistance protein Mmr +FIG01308039 transcriptional regulator, AfsR/DnrI/RedD family +FIG01308043 Possible exported heavy-metal binding protein +FIG01308046 DNA polymerase X +FIG01308051 Type IV pilus biogenesis protein PilO +FIG01308053 Putative OmpA-family membrane protein +FIG01308059 FIG00351922: hypothetical protein +FIG01308062 L-seryl-tRNA(Sec) selenium transferase, probably playing another role +FIG01308063 Phosphorylated carbohydrates phosphatase TM1254 (EC 3.1.3.-) +FIG01308079 UPF0118 membrane protein ytvI +FIG01308082 Putative coiled-coil protein +FIG01308083 hypothetical protein +FIG01308087 FIG00847614: hypothetical protein +FIG01308090 YibE/F-like protein +FIG01308092 putative cytoplasmic protein +FIG01308098 Sensor protein vanSB (EC 2.7.3.-) +FIG01308116 hypothetical protein +FIG01308127 Cytochrome c5 +FIG01308128 LafD +FIG01308133 FIG00424978: hypothetical protein +FIG01308136 putative inner membrane protein +FIG01308142 protease-related protein +FIG01308147 BsaU protein +FIG01308153 PHOSPHINOTHRICIN N-ACETYLTRANSFERASE (EC 2.3.1.-) +FIG01308155 plasmid maintenance system antidote protein, XRE family +FIG01308163 6-hexanolactone hydrolase +FIG01308165 FIG00350892: hypothetical protein +FIG01308166 Prophage LambdaBa04, transactivating regulatory domain protein +FIG01308175 L-lysine permease +FIG01308177 putative Zn-dependent protease +FIG01308181 Allergen V5/Tpx-1 related +FIG01308183 Lactoylglutathione lyase (fragment) +FIG01308185 RidA/YER057c/UK114 superfamily, group 2, YoaB-like protein +FIG01308188 transcriptional regulator, GstR +FIG01308189 FIG00350708: hypothetical protein +FIG01308192 FIG00763684: hypothetical protein +FIG01308194 MutT/nudix family protein; 7,8-dihydro-8-oxoguanine-triphosphatase +FIG01308195 L-Aspartate dehydrogenase (EC 1.4.1.21) homolog +FIG01308197 FIG00765174: hypothetical protein +FIG01308201 Transcriptional regulator of N-acetylglucosamine utilization, LacI family +FIG01308206 Superfamily I DNA and RNA helicase and helicase subunits-like protein +FIG01308215 Transcriptional regulator yidN, Cro/CI family +FIG01308224 FIG00350425: hypothetical protein +FIG01308233 B. burgdorferi predicted coding region BBA50 +FIG01308234 Putative hydroxymethyltransferase +FIG01308239 Protein bptA precursor (Borrelial persistence in ticks protein A) +FIG01308241 DUF1805 domain-containing protein +FIG01308252 Cassette chromosome recombinase B +FIG01308258 Sialic acid transporter (permease) NanT +FIG01308259 Phage integrase family +FIG01308266 Beta-lactamase-related protein +FIG01308270 Excinuclease ABC subunit A domain protein +FIG01308271 Glutamyl-tRNA(Gln) amidotransferase subunit A-like protein +FIG01308280 FIG00648575: hypothetical protein +FIG01308292 putative phosphoglycerate mutase family protein +FIG01308293 resolvase, putative +FIG01308294 phosphohistidine phosphatase SixA, putative +FIG01308296 FIG00404512: hypothetical protein +FIG01308316 Virulence factor mviM +FIG01308320 Ubiquitin-protein ligase +FIG01308322 Oleate hydratase (EC 4.2.1.53) +FIG01308327 DNA polymerase beta domain protein region +FIG01308330 Putative ABC RTX toxin transporter, fused ATP binding/permease domains +FIG01308331 FIG00348511: hypothetical protein +FIG01308332 glucose uptake protein +FIG01308337 phage tail X +FIG01308343 Lipase-related protein +FIG01308345 Putative carboxy-terminal processing protease (EC 3.4.21.102) +FIG01308359 Phenazine biosynthesis protein PhzF +FIG01308361 ATP-dependent efflux pump essential for phthiocerol dimycocerosates translocation, integral membrane protein DrrB-like +FIG01308362 POSSIBLE CELL FILAMENTATION PROTEIN FIC +FIG01308380 COG0744: Membrane carboxypeptidase (penicillin-binding protein) +FIG01308386 PioO protein +FIG01308397 FIG00350026: hypothetical protein +FIG01308404 FIG00350652: hypothetical protein +FIG01308407 Immune inhibitor A, metalloprotease (EC 3.4.24.-) +FIG01308413 FIG00763266: hypothetical protein +FIG01308416 FIG00411777: hypothetical protein +FIG01308420 Arabidopsis thaliana genomic DNA, chromosome 5, P1 clone:MYN8 +FIG01308421 Serine/threonine-protein kinase PknE (EC 2.7.11.1) +FIG01308426 BH2601 unknown conserved protein in B. subtilis +FIG01308427 2OG-Fe(II) oxygenase family enzyme +FIG01308432 ISGsu7, transposase OrfA +FIG01308437 Probable methyltransferase (EC 2.1.1.-) +FIG01308441 cag island protein, CYTOTOXICITY ASSOCIATED IMMUNODOMINANT ANTIGEN +FIG01308442 Spore germination protein. gerKA +FIG01308443 ABC transporter, ATP binding protein +FIG01308444 Secreted enzyme, contains two amidohydrolase related domains +FIG01308448 putative transcriptional regulator (TetR family) +FIG01308464 Tyrosine/serine protein phosphatase +FIG01308467 TcaA protein +FIG01308470 FIG00641791: hypothetical protein +FIG01308472 membrane spanning protein +FIG01308481 Two-component system sensor histidine kinase +FIG01308486 Putative alanine/glycine transport protein +FIG01308494 N-hydroxyarylamine O-acetyltransferase (EC 2.3.1.118) +FIG01308496 Paralysed flagella protein PflA +FIG01308501 Quinolone resistance protein norA +FIG01308503 CT560 hypothetical protein +FIG01308515 integrase/recombinase, putative +FIG01308517 Glycosyl transferase, family 8 +FIG01308519 Rv3128c-like protein +FIG01308522 Probable aminoglycoside 3'-phosphotransferase (EC 2.7.1.95) (Kanamycin kinase) +FIG01308524 mutT/nudix family protein +FIG01308528 FIG00760960: hypothetical protein +FIG01308542 Sodium-dependent transporter +FIG01308549 putative aminopeptidase +FIG01308552 FIG00766438: hypothetical protein +FIG01308553 doubtful CDS found within S. typhi pathogenicity island +FIG01308554 Hyaluronoglucosaminidase (EC 3.2.1.35) +FIG01308559 Cytochrome c peroxidase +FIG01308570 Transcriptional regulator/sugar kinase +FIG01308590 Transcriptional regulator, HxlR family +FIG01308593 POSSIBLE METHYLTRANSFERASE (METHYLASE) +FIG01308610 gp3 +FIG01308612 Glycosyl transferase, group 1 family (EC 2.4.1.-) +FIG01308626 Uncharacterized protein YqeH +FIG01308637 Glucosamine 6-phosphate synthetase, contains amidotransferase and phosphosugar isomerase domains +FIG01308650 Secretory antigen SsaA-like protein transposon-related +FIG01308654 FIG00350684: hypothetical protein +FIG01308655 FIG00960438: hypothetical protein +FIG01308664 FIG00946177: hypothetical protein +FIG01308672 Hypothetical protein SAV1799 +FIG01308676 ABC-type anion transport system, duplicated permease component +FIG01308681 EhpF +FIG01308682 hypothetical Cytosolic Protein +FIG01308687 ORF100 +FIG01308690 Acid shock protein precursor +FIG01308703 Glutamine-binding periplasmic protein +FIG01308736 probable membrane protein STY1534 +FIG01308739 two component transcriptional regulator, LuxR family +FIG01308740 hypothetical protein +FIG01308744 possible efflux permease +FIG01308768 FIG00670987: hypothetical protein +FIG01308772 FIG00405844: hypothetical protein +FIG01308776 putative sulfatase +FIG01308779 DNA-binding protein inhibitor Id-2-related protein +FIG01308782 Resolvase/integrase Bin +FIG01308784 hypothetical protein +FIG01308786 N-acyl-L-homoserine lactone synthetase RhlL +FIG01308794 Cyclic beta-1,2-glucan modification transmembrane protein +FIG01308805 Hypothetical transcriptional regulator yidL +FIG01308806 TrkA family protein +FIG01308812 prophage LambdaBa04, DNA binding protein, putative +FIG01308821 FIG00351097: hypothetical protein +FIG01308828 FIG00755425: hypothetical protein +FIG01308831 Probable oxidoreductase ordL (EC 1.-.-.-) +FIG01308832 nitroreductase family protein family +FIG01308876 Uncharacterized protein MJ0840 +FIG01308878 FIG00389948: hypothetical protein +FIG01308891 PROBABLE IS1560 TRANSPOSASE +FIG01308892 Rrf2-linked NADH-flavin reductase +FIG01308903 amino acid permease family protein +FIG01308904 putative sodium/calcium exchanger +FIG01308906 FIG00352749: hypothetical protein +FIG01308911 transpeptidase-related protein +FIG01308914 FIG01308914: hypothetical protein YwzC +FIG01308930 FIG00350029: hypothetical protein +FIG01308932 putative 2-hydroxyhepta-2,4-diene-1,7-dioate isomerase +FIG01308941 7-alpha-hydroxysteroid dehydrogenase (EC 1.1.1.159) +FIG01308948 probable membrane protein yetF +FIG01308962 Type IV pilus (Tfp) assembly protein PilF +FIG01308963 Outer membrane hemoglobin utilization protein HmbR +FIG01308973 Mn2+ and Fe2+ transporters of the NRAMP family +FIG01308979 B. burgdorferi predicted coding region BBA54 +FIG01308980 Possible transcriptionl regulator +FIG01308986 FIG00764300: hypothetical protein +FIG01308994 NgrB +FIG01308999 2-hydroxymuconic semialdehyde hydrolase +FIG01309009 LysR family transcriptional regulator Bucepa02002399 +FIG01309028 FIG00405701: hypothetical protein +FIG01309029 FIG00762739: hypothetical protein +FIG01309048 ATP-grasp( EC:6.2.1.5 ) +FIG01309064 FIG012187: hypothetical protein +FIG01309065 Aminoglycoside N3'-acetyltransferase (EC 2.3.1.81) +FIG01309068 GtrA family protein +FIG01309073 Putative efflux protein +FIG01309081 FIG00764796: hypothetical protein +FIG01309085 Acyl carrier protein, putative +FIG01309087 Putative lacI-family transcriptional regulator +FIG01309095 FIG00639516: hypothetical protein +FIG01309103 replication control protein PrgN +FIG01309107 Protein containing glutaredoxin domain and PD1-like DNA-binding domain +FIG01309109 stage 0 sporulation regulatory protein +FIG01309112 FIG004405: Putative cytoplasmic protein +FIG01309113 Probably membrane associated protein containing PAS/PAC domain +FIG01309117 TrkA domain protein +FIG01309121 ribonuclease inhibitor barstar +FIG01309127 CsiR, transcriptional repressor of CsiD +FIG01309130 FIG00622872: hypothetical protein +FIG01309138 ABC transporter ATP-binding/membrane spanning protein - multidrug resistance +FIG01309147 FIG00351517: hypothetical protein +FIG01309160 AbrB family transciptional regulator +FIG01309169 FIG00658473: hypothetical protein +FIG01309172 Methicillin resistance protein +FIG01309186 FIG00896779: hypothetical protein +FIG01309191 FIG00384963: hypothetical protein +FIG01309193 Methyltransferase +FIG01309194 putative phage transposase +FIG01309197 Spore germination protein A2 +FIG01309202 acid phosphatase, class B +FIG01309213 Chromosome-anchoring protein racA +FIG01309222 FIG00744494: hypothetical protein +FIG01309225 FIG00628511: hypothetical protein +FIG01309227 FIG00385065: hypothetical protein +FIG01309229 Uncharacterized protein MJ0737 +FIG01309239 lignin peroxidase LipJ +FIG01309253 Acid shock protein 2 precursor +FIG01309258 Gll2959 protein +FIG01309263 HokE protein +FIG01309267 Staphylokinase +FIG01309269 FIG00351445: hypothetical protein +FIG01309278 Sigma 54 modulation protein YhbH +FIG01309279 Phage Integrase +FIG01309283 Helix-turn-helix motif +FIG01309285 putative phosphoribulokinase/uridine kinase protein +FIG01309286 hypothetical protein +FIG01309296 FIG00824130: hypothetical protein +FIG01309315 LysR-family transcriptional regulator VC1561 +FIG01309321 B. burgdorferi predicted coding region BB0661 +FIG01309329 FIG00409921: hypothetical protein +FIG01309349 sugar transporter membrane protein +FIG01309350 FIG00744600: hypothetical protein +FIG01309353 MazG related NTP pyrophosphohydrolase +FIG01309356 MCP-domain signal transduction protein +FIG01309361 DNA-damage-inducible protein D +FIG01309362 FIG00406100: hypothetical protein +FIG01309371 FIG126011: Hypothetical protein +FIG01309382 Possible caffeoyl-CoA O-methyltransferase (EC 2.1.1.104) +FIG01309383 cysteine-rich protein +FIG01309397 pyridine nucleotide-disulphide oxidoreductase family protein +FIG01309404 endonuclease +FIG01309410 hypothetical protein BH3432 +FIG01309426 FIG01115693: hypothetical protein +FIG01309427 response regulator receiver (CheY-like) modulated metal dependent phosphohydrolase +FIG01309438 toxin-like outer membrane protein +FIG01309441 FIG00808804: hypothetical protein +FIG01309443 Pneumococcal vaccine antigen A homolog +FIG01309444 Putative adhesin +FIG01309445 Helix-turn-helix protein, copG family +FIG01309448 DNA polymerase III, epsilon subunit:DNA polymerase 3, epsilon subunit (EC 2.7.7.7) +FIG01309462 Sulfate transporter +FIG01309473 Membrane protein MmpS4 +FIG01309481 PROBABLE TWO COMPONENT SENSOR KINASE (FIRST PART) +FIG01309487 Truncated cell surface protein map-w +FIG01309490 putative oxidoreductase, Fe-S subunit +FIG01309495 biofilm regulator BssR +FIG01309499 Uncharacterized ferredoxin-like protein YdhX +FIG01309504 Zinc transporter, ZIP family +FIG01309505 YURZ protein +FIG01309521 HIT family hydrolase +FIG01309532 IS1595 transposase +FIG01309540 FIG00350294: hypothetical protein +FIG01309543 probable NADH-dependent flavin oxidoreductase YqjM +FIG01309544 FIG00402688: hypothetical protein +FIG01309546 FIG00896938: hypothetical protein +FIG01309548 PE_PGRS +FIG01309551 FIG00351690: hypothetical protein +FIG01309556 FIG00768194: hypothetical protein +FIG01309558 glycosyl hydrolase, family 38 +FIG01309565 FIG00351126: hypothetical protein +FIG01309571 FIG00516742: hypothetical protein +FIG01309573 Protein cysQ homolog +FIG01309574 Transcriptional regulator, AlpA like +FIG01309575 FIG01044168: hypothetical protein +FIG01309582 Lacticin-481/lactococcin-DR transport/processing ATP-binding protein lcnDR3 (EC 3.4.22.-) +FIG01309585 Polyketide synthase associated protein PapA1 +FIG01309591 Hc2 nucleoprotein +FIG01309593 Putative phosphotransferase enzyme +FIG01309596 Transcriptional regulatory protein afsQ1 +FIG01309599 DNA polymerase III, gamma subunit-related protein +FIG01309604 ALPHA (1,3)-FUCOSYLTRANSFERASE +FIG01309609 Tetratricopeptide domain protein precursor +FIG01309612 FIG00402858: hypothetical protein +FIG01309622 Flagellar motor protein MotB +FIG01309630 Probable signal peptide protein +FIG01309631 FIG00424688: hypothetical protein +FIG01309632 Formate-nitrate transporter +FIG01309635 FIG00630302: hypothetical protein +FIG01309645 Putative secreted serine protease (EC 3.4.21.-) +FIG01309658 hydrolase, CocE/NonD family +FIG01309659 Putative HTH-type transcriptional regulator ykgD +FIG01309664 transcriptional regulator, AfsR/DnrI/RedD family +FIG01309672 Spherulin-4 precursor +FIG01309682 Sugar kinase and transcription regulator (EC 2.7.1.-) +FIG01309692 Uncharacterized protein yfhR +FIG01309696 FIG01049723: hypothetical protein +FIG01309703 sodium solute symporter +FIG01309707 Putative efflux protein in 2-methylcitrate synthase cluster; homoserine/threonine efflux protein, putative +FIG01309711 transcriptional regulator (MerR family) +FIG01309712 FtsK/SpoIIIE family protein, putative EssC component of Type VII secretion system +FIG01309721 nucleic acid binding, OB-fold, tRNA/helicase-type +FIG01309725 Putative glycoprotein/receptor +FIG01309726 Peptide ABC transporter, ATP-binding protein +FIG01309728 Diacyglycerol O-acyltransferase (EC 2.3.1.20) +FIG01309737 Putative LysR-family transcriptional regulator YidZ +FIG01309738 Transport protein SgaT, putative +FIG01309750 HD-GYP domain +FIG01309763 Putative transport +FIG01309768 FIG00350253: hypothetical protein +FIG01309769 Non-hemolytic enterotoxin lytic component L1 +FIG01309771 ABC transporter ATP binding protein - unknown substrate +FIG01309774 FIG00823229: hypothetical protein +FIG01309777 FIG00350986: hypothetical protein +FIG01309785 Cytochrome P450 143 Rv1785c +FIG01309798 FIG00768879: hypothetical protein +FIG01309803 metallo-beta-lactamase superfamily hydrolase +FIG01309804 Vi polysaccharide export protein vexE +FIG01309805 FIG00413602: hypothetical protein +FIG01309806 phosphotransferase enzyme family protein, putative +FIG01309814 ATP-dependent Clp protease, ATP-binding subunit ClpE +FIG01309815 Bll1872 protein +FIG01309831 No significant database matches +FIG01309835 RpfN protein +FIG01309842 Zn-dependent hydrolases of the metallo-beta-lactamase superfamily +FIG01309854 spore coat protein (outer) +FIG01309864 Gll0911 protein +FIG01309865 FIG031860: hypothetical protein, Rv2337c +FIG01309873 190 KD ANTIGEN PRECURSOR (sca2) +FIG01309879 Uncharacterized protein, similar to the N-terminal domain of Lon protease +FIG01309882 Protein of pXO2-46 +FIG01309885 Transcriptional regulator +FIG01309886 regulatory protein RecX +FIG01309889 FIG00768702: hypothetical protein +FIG01309891 Tfp pilus assembly protein PilW +FIG01309894 FIG00768297: hypothetical protein +FIG01309902 Transposase YfcI +FIG01309907 Autolysin (EC 3.5.1.28) +FIG01309910 FIG00763122: hypothetical protein +FIG01309915 ortholog to Borrelia burgdorferi BB0063 +FIG01309921 N5-(1-carboxyethyl)-L-ornithine synthase +FIG01309927 Hydroxypyruvate isomerase +FIG01309931 FIG00424949: hypothetical protein +FIG01309936 putative guanyltransferase +FIG01309948 FIG00350799: hypothetical protein +FIG01309964 Glucose/sorbosone dehydrogenases +FIG01309966 FIG00823574: hypothetical protein +FIG01309969 NADPH-dependent glutamate synthase beta chain and related oxidoreductases +FIG01309971 FIG00589520: hypothetical protein +FIG01309973 FIG00451108: hypothetical protein +FIG01309974 Putative uncharacterized protein spr0086 +FIG01309985 type 2 phosphatidic acid phosphatase family protein +FIG01309989 copper-bind, Copper binding proteins, plastocyanin/azurin family +FIG01309998 Lipoprotein LprF +FIG01310005 ABC transporter, periplasmic substrate-binding protein, putative +FIG01310014 WhiB family transcriptional regulator +FIG01310023 FIG00348220: hypothetical protein +FIG01310026 NhaP-type Na+/H+ or K+/H+ antiporter +FIG01310030 acetyltransferase, CYSE/LACA/LPXA/NODL family +FIG01310039 PE-PGRS family protein +FIG01310047 DNA primase traC (EC 2.7.7.-) +FIG01310049 RNA signal recognition particle 4.5S RNA +FIG01310051 YjfP protein +FIG01310052 FIG00603844: hypothetical protein +FIG01310060 FIG01221417: hypothetical protein +FIG01310061 Disulfide bond formation protein (EC 1.8.4.-), BdbC-like +FIG01310064 extracellular protease +FIG01310066 Hypothetical membrane protein +FIG01310071 Succinyl-CoA:coenzyme A transferase (EC 2.8.3.-) +FIG01310073 orf, hypothetical protein +FIG01310074 Flagellar biosynthesis related protein +FIG01310076 putative secreted protein +FIG01310077 Degradation enzyme regulation protein degQ +FIG01310079 FIG00757138: hypothetical protein +FIG01310080 FIG01115384: hypothetical protein +FIG01310081 Probable sulfate permease +FIG01310086 putative cytochrome b561 +FIG01310099 malic acid transport protein +FIG01310100 probable transporter +FIG01310105 coat protein B of bacteriophage Pf1) +FIG01310114 Amidase family protein Rv3175 +FIG01310129 Chaperone protein afaB precursor +FIG01310130 putative P4-family integrase +FIG01310131 FIG00848843: hypothetical protein +FIG01310138 FIG01209174: hypothetical protein +FIG01310139 FIG00629338: hypothetical protein +FIG01310153 Uncharacterized protein MJ1337 +FIG01310160 Fibronectin-binding protein, putative +FIG01310166 FIG00978734: hypothetical protein +FIG01310167 Type III secretion inner membrane protein (YscT,HrcT,SpaR,EscT,EpaR1,homologous to flagellar export components) +FIG01310168 Secreted protein EspB +FIG01310175 Nucleoside-binding protein +FIG01310181 PROBABLE CELLULASE CELA2B (ENDO-1,4-BETA-GLUCANASE) (ENDOGLUCANASE) (CARBOXYMETHYL CELLULASE) (EC 3.2.1.4) +FIG01310187 Transmembrane transport protein MmpL7 +FIG01310189 FIG00351960: hypothetical protein +FIG01310191 Endonuclease +FIG01310207 FIG00637923: hypothetical protein +FIG01310209 Os03g0684500 +FIG01310214 FIG00407240: hypothetical protein +FIG01310217 Prophage helix-turn-helix protein +FIG01310226 Bll0064 protein +FIG01310236 Sensory box histidine kinase/response regulator +FIG01310259 FIG01198714: hypothetical protein +FIG01310262 Transporter, monovalent cation:proton antiporter-2 (CPA2) family +FIG01310267 blr7843; hypothetical protein +FIG01310271 FIG00821340: hypothetical protein +FIG01310274 probable protein phosphatase +FIG01310285 COG family: methyl-accepting chemotaxis protein +FIG01310289 FIG00404202: hypothetical protein +FIG01310290 Putative lipoprotein LppY +FIG01310292 Sodium/pantothenate symporter +FIG01310297 LysM-repeat proteins and domains +FIG01310298 Daunorubicin resistance transmembrane protein +FIG01310300 Extracellular protein +FIG01310302 putative plasmid-related protein +FIG01310306 Hypothetical protein SAV2286 +FIG01310317 steroid isomerase, putative +FIG01310319 Exoenzymes regulatory protein AepA in lipid-linked oligosaccharide synthesis cluster +FIG01310322 EXTRACYTOPLASMIC FUNCTION ALTERNATIVE SIGMA FACTOR +FIG01310323 PTS system, beta-glucoside-specific, IIC component +FIG01310324 Carboxylesterase +FIG01310326 1,4-beta-cellobiosidase +FIG01310328 B. burgdorferi predicted coding region BBA33 +FIG01310330 FIG00351251: hypothetical protein +FIG01310335 Toxic anion resistance protein +FIG01310339 Transcription antiterminator +FIG01310354 DNA packaging +FIG01310357 FIG00632849: hypothetical protein +FIG01310359 Hypothetical protein SAV2327 +FIG01310367 DNA-binding response regulator TrcR +FIG01310368 FIG00896814: hypothetical protein +FIG01310371 FIG00628206: hypothetical protein +FIG01310378 alcohol dehydrogenase, iron-containing +FIG01310379 FIG00407436: hypothetical protein +FIG01310381 Proteinase inhibitor I11, ecotin precursor +FIG01310384 FIG00407441: hypothetical protein +FIG01310397 Outer membrane protein RomA +FIG01310398 Long polar fimbria protein A precursor +FIG01310413 Y4mH +FIG01310418 Putative cytoplasmic protein +FIG01310424 RNAI modulator protein Rom +FIG01310444 Superfamily II DNA and RNA helicases +FIG01310447 putative phosphoribosyl-AMP cyclohydrolase +FIG01310448 FIG00745210: hypothetical protein +FIG01310454 Peptidase S9, prolyl oligopeptidase active site domain protein +FIG01310459 Probable site-specific recombinase +FIG01310461 ortholog to Borrelia burgdorferi BB0555 +FIG01310462 FIG00762889: hypothetical protein +FIG01310466 Molybdenum cofactor biosynthesis enzyme and related Fe-S oxidoreductases +FIG01310468 Ketosteroid isomerase-related protein +FIG01310470 FIG00644409: hypothetical protein +FIG01310477 Glycosyl transferase, group 2 family protein (EC 2.4.1.-) +FIG01310479 conserved hypothetical protein 22 +FIG01310480 FIG00624487: hypothetical protein +FIG01310481 protein of unknown function UPF0005 +FIG01310487 L-tyrosine decarboxylase (EC 4.1.1.25) +FIG01310488 Putative uncharacterized protein spr0080 +FIG01310500 Putative sugar kinase +FIG01310511 C4-dicarboxylate transport protein homolog b2343 +FIG01310516 putative cellulose-binding protein +FIG01310523 probable uroporphyrin-III c-methyltransferase (EC 2.1.1.107) +FIG01310524 putative phage-related lipoprotein +FIG01310531 FMN-dependent NADH-azoreductase (EC 1.6.5.2) +FIG01310534 YqkD +FIG01310538 Ribosomal protein S3AE +FIG01310541 Putative lipid carrier protein +FIG01310551 Perosamine synthetase Per +FIG01310562 FIG00350874: hypothetical protein +FIG01310568 Xylose repressor protein +FIG01310570 Lytic regulatory protein +FIG01310576 Antibiotic resistance protein +FIG01310587 FIG038648: MoaD and/or ThiS families +FIG01310589 Hypothetical protein SAV2325 +FIG01310594 Alpha/beta hydrolase fold-1 precursor +FIG01310595 STMF1.14 protein +FIG01310597 putative peptide transport ATP-binding protein +FIG01310603 A298L +FIG01310609 FIG047598: Phage protein +FIG01310616 Z1226 protein +FIG01310622 FIG00351421: hypothetical protein +FIG01310632 FIG01201155: hypothetical protein +FIG01310633 FIG01114575: hypothetical protein +FIG01310637 EPSX protein +FIG01310638 FIG024317: hypothetical protein +FIG01310645 periplasmic protein +FIG01310648 Oxidoreductase (putative) +FIG01310650 B. burgdorferi predicted coding region BB0549 +FIG01310652 Predicted nucleoside-diphosphate sugar epimerase +FIG01310667 MFS transporter +FIG01310670 secretion chaparone +FIG01310673 transporter, LysE family +FIG01310674 Insertion element iso-IS1n protein insB +FIG01310681 FIG00450720: hypothetical protein +FIG01310687 putative orphan protein +FIG01310691 FIG00824062: hypothetical protein +FIG01310694 Esterase/lipase/thioesterase( EC:3.1.1.1 ) +FIG01310699 Drug resistance transporter, EmrB/QacA subfamily +FIG01310711 Ribose/Galactose ABC transporter, ATP-binding component +FIG01310721 transcriptional regulator, LuxR family +FIG01310722 regulatory protein, LuxR +FIG01310727 Diguanylate cyclase (EC 2.7.7.65). putative +FIG01310732 Hypothetical protein MW1689 +FIG01310733 FIG00352013: hypothetical protein +FIG01310735 CMP-N-acetylneuraminic acid synthetase( EC:2.7.7.43 ) +FIG01310737 Uncharacterized protein YpbS +FIG01310746 sensor histidine kinase SrrB, putative +FIG01310753 Sulfatase family protein +FIG01310754 PIN domain protein +FIG01310756 FIG00642170: hypothetical protein +FIG01310764 Acyl-CoA dehydrogenase-like protein +FIG01310767 SAM-dependent methyltransferase BA1462 (UbiE paralog) +FIG01310771 putative sodium-coupled permease +FIG01310780 Uncharacterized low-complexity protein +FIG01310787 SCP-2 sterol transfer family protein +FIG01310793 SOS-response transcriptional repressors (RecA-mediated autopeptidases) +FIG01310799 Putative homoserine kinase type II (protein kinase fold) +FIG01310803 DsORF-h1 +FIG01310807 Putative undecaprenyl-phosphate N-acetylgalactosaminyl 1-phosphate transferase; teichuronic acid biosynthesis glycosyltransferase TuaA +FIG01310810 MerF +FIG01310820 FIG00426652: hypothetical protein +FIG01310822 Short chain dehydrogenase +FIG01310823 FIG00350023: hypothetical protein +FIG01310830 FIG00824223: hypothetical protein +FIG01310832 acetyltransferase (GNAT) family protein +FIG01310837 DNA alkylation repair enzyme, truncation +FIG01310850 anaerobic C4-dicarboxylate transporter +FIG01310854 Transcriptional regulatory protein CpxR +FIG01310855 Phenolpthiocerol synthesis type-I polyketide synthase PpsD +FIG01310857 Transcription regulator AraC/XylS family +FIG01310860 organization of cell wall +FIG01310862 FIG00350394: hypothetical protein +FIG01310864 RND efflux system membrane fusion protein +FIG01310865 Hypothetical protein SAV2183 +FIG01310866 Acyl-CoA-binding protein +FIG01310869 FIG00774754: hypothetical protein +FIG01310871 FIG00639549: hypothetical protein +FIG01310883 FIG00766662: hypothetical protein +FIG01310890 Cysteine dioxygenase +FIG01310894 FIG075815: hypothetical protein +FIG01310900 Positive transcriptional regulator, MutR family +FIG01310903 FIG00384867: hypothetical protein +FIG01310910 FIG00849712: hypothetical protein +FIG01310916 DUF1232 domain-containing protein +FIG01310921 FIG01045986: hypothetical protein +FIG01310924 FIG00406657: hypothetical protein +FIG01310925 COG0631: Serine/threonine protein phosphatase +FIG01310937 InterPro IPR000847 +FIG01310938 17 kD surface antigen precursor +FIG01310943 Arginine ABC transporter, arginine-binding protein +FIG01310944 Superfamily I DNA and RNA helicases and helicase subunits +FIG01310948 FIG00406501: hypothetical protein +FIG01310950 Bll8032 protein +FIG01310956 Glutamine amidotransferase, class I +FIG01310960 resolvase +FIG01310962 AzlC family protein +FIG01310964 cAMP-dependent protein kinase regulatory chain +FIG01310971 protein of unknown function DUF179 +FIG01310975 FIG00407069: hypothetical protein +FIG01310988 Steroid delta-isomerase (EC 5.3.3.1) +FIG01310990 Transcriptional regulator, TetR family +FIG01310994 Slr0517 protein +FIG01310998 Ribosomal-protein-alanine acetyltransferase (EC 2.3.1.128) +FIG01310999 phage-like element PBSX protein XkdA +FIG01311000 FIG00638837: hypothetical protein +FIG01311002 FIG027054: hypothetical protein +FIG01311003 Glutamate decarboxylase +FIG01311008 FIG00826712: hypothetical protein +FIG01311017 glutamine amidotransferase-like +FIG01311023 Multidrug resistance protein EbrB +FIG01311029 ATPase for chromosome partitioning +FIG01311034 FIG00821351: hypothetical protein +FIG01311041 Antibiotic transport protein +FIG01311050 Uncharacterized protein conserved in bacteria +FIG01311053 hypothetical protein +FIG01311056 hypothetical protein +FIG01311068 hypothetical Membrane Spanning Protein +FIG01311070 conserved hypothetical protein +FIG01311074 aminotransferase, class III +FIG01311083 COGs COG3683 +FIG01311085 FIG01092559: hypothetical protein +FIG01311087 FIG00767103: hypothetical protein +FIG01311090 Alcohol dehydrogenase, class IV +FIG01311097 Uncharacterized protein YohL +FIG01311100 Purine nucleoside permease +FIG01311101 Disease resistance domain-containing protein +FIG01311103 L-O-lysylphosphatidylglycerol synthase (EC 2.3.2.3) +FIG01311108 Phospholipase, patatin family protein +FIG01311120 FIG00351202: hypothetical protein +FIG01311138 Protein parA +FIG01311154 FIG01221448: hypothetical protein +FIG01311156 putative siderophore-interacting protein +FIG01311165 Putative alpha helix chain +FIG01311170 Acyl-CoA synthetases (AMP-forming)/AMP-acid ligases +FIG01311171 FIG00848867: hypothetical protein +FIG01311174 DipZ protein +FIG01311175 Hypothetical protein SAV1852 +FIG01311188 outer membrane protein P1 (ompP1) +FIG01311190 FIG00631913: hypothetical protein +FIG01311204 Cysteine and methionine metabolism regulator CmbR, LysR family +FIG01311210 Putative invasion protein +FIG01311212 PE family protein Rv3893c, component of Type VII secretion system ESX-2 +FIG01311223 Putative ROK-family transcriptional regulator +FIG01311229 YcgL protein +FIG01311235 FIG01228959: hypothetical protein +FIG01311241 FIG00767841: hypothetical protein +FIG01311251 pXO1-117 +FIG01311257 FIG00425118: hypothetical protein +FIG01311258 HtrA suppressor protein +FIG01311261 Group B streptococcal surface immunogenic protein +FIG01311273 FIG00352211: hypothetical protein +FIG01311279 Phage regulatory protein +FIG01311285 N-methyl-transferase-related protein +FIG01311289 Hyphotheical protein +FIG01311298 Phospholipase D endonuclease superfamily +FIG01311306 DamX-related protein +FIG01311307 FIG00820639: hypothetical protein +FIG01311311 Probable methyltransferase +FIG01311313 Dihydrolipoamide acetyltransferase +FIG01311315 Likely not a Glycine cleavage system H protein +FIG01311317 UsfY +FIG01311322 FIG032699: hypothetical protein +FIG01311324 Ans operon transcriptional repressor +FIG01311325 Glutamate synthase [NADPH] small chain (EC 1.4.1.13) +FIG01311330 ADP-heptose:LPS heptosyltransferase +FIG01311332 Hypothetical protein, CF-5 family +FIG01311343 Hydroxymethylglutaryl-CoA synthase N-domain homolog (EC 2.3.3.10) +FIG01311350 FIG01225496: hypothetical protein +FIG01311353 carbon dioxide concentrating mechanism protein CcmL, putative +FIG01311358 Transcriptional regulators +FIG01311360 ABC transporter permease +FIG01311361 FIG00405292: hypothetical protein +FIG01311367 DNA topoisomerase III, Bacillus plasimid type (EC 5.99.1.2) +FIG01311376 FIG00742151: hypothetical protein +FIG01311385 alternate gene name: yoxF +FIG01311387 inner membrane protein forms channel for type IV secretion of T-DNA complex (VirB10) +FIG01311399 Membrane-associated phospholipid phosphatase +FIG01311410 cell filamentation protein Fic-related protein +FIG01311414 putative short chain dehydrogenase +FIG01311419 hypothetical protein +FIG01311421 bacterial seryl-tRNA synthetase related +FIG01311430 FIG01124167: hypothetical protein +FIG01311439 Cell shape-determining protein +FIG01311445 probable membrane lipoprotein NMA1581 +FIG01311447 cell surface protein precursor +FIG01311465 Probable ALANIN-rich signal peptide protein +FIG01311476 Putative (3R)-hydroxymyristoyl-[acyl-carrier-protein] dehydrase +FIG01311481 Molybdopterin biosynthesis protein MoeY +FIG01311487 FIG00350430: hypothetical protein +FIG01311488 FIG00641709: hypothetical protein +FIG01311490 FIG00762850: hypothetical protein +FIG01311491 hypothetical protein YmgB +FIG01311500 Period clock protein +FIG01311501 UV-endonuclease UvdE family +FIG01311503 Putative DedA family, membrane protein +FIG01311509 HAD hydrolase, IIB family +FIG01311512 FIG057355: hypothetical protein +FIG01311514 DUF1706 domain-containing protein +FIG01311519 FIG01207016: hypothetical protein +FIG01311522 Oligopeptide ABC transporter, oligopeptide binding protein +FIG01311524 Lipase-like protein +FIG01311525 short chain dehydrogenase +FIG01311529 DNA binding domain, excisionase family +FIG01311530 Sugar phosphate transporter +FIG01311538 D-aminopeptidase (EC 3.4.11.19) +FIG01311545 Glycine/D-amino acid oxidases family +FIG01311554 Uncharacterized protein yisN, only in Bacillus +FIG01311566 FIG00350452: hypothetical protein +FIG01311570 probable exported protein YPO2884 +FIG01311579 FIG00352399: hypothetical protein +FIG01311586 Dihydroorotase (EC 3.5.2.3) +FIG01311587 cytochrome c554 +FIG01311589 Phenylalanyl-tRNA synthetase alpha subunit +FIG01311595 probable membrane protein STY4873 +FIG01311596 Similar to F420-dependent glucose-6-phosphate dehydrogenase, BCG_0166c family +FIG01311601 Putative GTP-binding protein +FIG01311602 Phage DNA invertase +FIG01311605 Esterase/lipase family protein +FIG01311606 FIG00403378: hypothetical protein +FIG01311612 FIG01239122: hypothetical protein +FIG01311615 Cation/multidrug efflux pump +FIG01311644 Putative 5'(3')-deoxyribonucleotidase (EC 3.1.3.-) +FIG01311647 FIG00405874: hypothetical protein +FIG01311653 UspA-related nucleotide-binding protein +FIG01311655 spermidine N1-acetyltransferase +FIG01311661 Secretion system effector SsaE +FIG01311666 membrane protein, putaive +FIG01311669 FIG00404382: hypothetical protein +FIG01311670 Hypothetical protein, CF-36 family +FIG01311683 putative amino acid permease +FIG01311687 FIG00824110: hypothetical protein +FIG01311691 Hypothetical protein SA2091 +FIG01311699 IS600 orfB +FIG01311711 DNA-binding protein H-NS +FIG01311716 FIG00563303: hypothetical protein +FIG01311720 Predicted transcriptional regulator LiuX of leucine degradation pathway, AcrR family +FIG01311722 Putative toxin subunit +FIG01311729 Phage shock protein A +FIG01311745 296aa long conserved hypothetical protein +FIG01311754 XoxI +FIG01311758 FIG01197944: hypothetical protein +FIG01311760 FIG00822946: hypothetical protein +FIG01311764 Violacein biosynthesis protein VioB +FIG01311767 FIG00639676: hypothetical protein +FIG01311780 Haloalkane dehalogenase 2 (EC 3.8.1.5) +FIG01311784 DNA topoisomerase I, eukaryotic-type (EC 5.99.1.2) +FIG01311794 FIG00847810: hypothetical protein +FIG01311810 FIG00569035: hypothetical protein +FIG01311816 Putative cell wall hydrolase +FIG01311819 FIG011566: hypothetical protein +FIG01311821 Possible transcriptional regulatory protein +FIG01311833 Nucleotide sugar synthetase-like protein +FIG01311835 extracellular solute-binding protein, putative +FIG01311843 Predicted nucleoside-diphosphate-sugar epimerases +FIG01311855 FIG00768605: hypothetical protein +FIG01311856 FIG00763502: hypothetical protein +FIG01311859 Possible Pirin family proteins +FIG01311861 Bacillolysin precursor (EC 3.4.24.28) +FIG01311862 similar to plasmid replication protein +FIG01311863 FIG00763856: hypothetical protein +FIG01311865 FIG00350252: hypothetical protein +FIG01311868 Exopolysaccharide production protein +FIG01311871 Putative catalase (EC 1.11.1.6) +FIG01311876 FIG00515055: hypothetical protein +FIG01311881 Heptose kinase WapQ, eukaryotic type +FIG01311883 FIG00451141: hypothetical protein +FIG01311886 Regulatory protein recX +FIG01311907 B. burgdorferi predicted coding region BB0003 +FIG01311910 FIG00409141: hypothetical protein +FIG01311916 Pirin-like protein Rv0181c/MT0192 +FIG01311928 proteinase inhibitor, putative +FIG01311934 Zn-dependent protease with chaperone function PA4632 +FIG01311936 Mycofactocin system transcriptional regulator +FIG01311946 Possible acetyltransferase +FIG01311947 3-demethylubiquinone-9 3-methyltransferase +FIG01311948 FIG00351947: hypothetical protein +FIG01311952 FIG00823221: hypothetical protein +FIG01311955 FIG00638667: hypothetical protein +FIG01311959 FIG00747110: hypothetical protein +FIG01311961 dioxygenase( EC:1.13.11.32 ) +FIG01311962 Methyl-accepting chemotaxis protein II (mcp-II) (aspartate chemoreceptor protein) +FIG01311964 hypothetical protein Rv1115 +FIG01311966 FIG00768193: hypothetical protein +FIG01311968 Bile acid sodium symporter +FIG01311972 Probable lysozyme (EC 3.2.1.17) +FIG01311978 S-adenosylmethionine-dependent methyltransferase +FIG01311980 McrBC 5-methylcytosine restriction system component +FIG01311984 pp-binding family protein +FIG01311985 3-Oxoadipate enol-lactonase, alpha/beta hydrolase fold family [EC:3.1.1.24] +FIG01311993 2-oxoglutarate/malate translocator-like protein +FIG01312005 Glycosyl transferase family protein +FIG01312007 Formyltransferase WbkC +FIG01312010 nuclear scaffold-like protein p76-like +FIG01312018 Non-heme haloperoxidase Hpx +FIG01312029 FIG00762730: hypothetical protein +FIG01312031 hypothetical protein BA3287 +FIG01312040 Bacterioferritin (BFR) (EC 1.16.3.1) +FIG01312044 FIG00766595: hypothetical protein +FIG01312049 putative colicin +FIG01312050 Uncharacterized protein related to plant photosystem II stability/assembly factor +FIG01312056 DNA translocase FtsK +FIG01312063 FIG01101187: hypothetical protein +FIG01312067 Conjugal transfer protein TraA +FIG01312068 cdd2 +FIG01312075 D-alanyl-D-alanine dipeptidase (EC 3.4.13.22) +FIG01312078 nitroreductase family protein +FIG01312079 Phage Kil +FIG01312082 FIG00534652: hypothetical protein +FIG01312083 Esterase/lipase (EC 3.1.1.-) +FIG01312095 FIG00826393: hypothetical protein +FIG01312101 FAD-binding monooxygenase, PheA/TfdB family +FIG01312102 Chitinase B +FIG01312103 FIG01196643: hypothetical protein +FIG01312104 Contains cell adhesion domain +FIG01312105 amino acid ABC transporter periplasmic amino acid-binding protein +FIG01312109 Hypothetical protein +FIG01312114 Nuclease subunit of the excinuclease complex +FIG01312115 hydrolase, putative +FIG01312116 Uncharacterized protein MJ0816 +FIG01312124 Probable integral membrane protein Cj1452 +FIG01312128 syc1922_c +FIG01312131 Ethidium bromide-methyl viologen resistance protein EmrE +FIG01312135 Isoniazid inductible protein IniA +FIG01312136 FIG00654050: hypothetical protein +FIG01312145 putative RecF protein +FIG01312146 FIG00520248: hypothetical protein +FIG01312154 Helicase loader DnaB +FIG01312173 Low molecular weight antigen MTB12 +FIG01312180 Abi family protein +FIG01312181 FIG00387840: hypothetical protein +FIG01312182 FIG00622794: hypothetical protein +FIG01312183 ECF-family RNA polymerase sigma factor +FIG01312189 S1 RNA binding domain +FIG01312191 hypothetical protein +FIG01312196 cytochrome C-type biogenesis protein (ccdA), conjectural +FIG01312198 probable lipoprotein YPO2292 +FIG01312200 HTH-type transcriptional regulator ydeO +FIG01312204 ESAT-6-like protein EsxQ +FIG01312208 Serine protease (EC 3.4.21.-) +FIG01312212 Putative adhesion and penetration protein +FIG01312219 CDP-4-dehydro-6-deoxy-D-glucose 3-dehydratase (EC 4.2.1.-) +FIG01312233 LppN +FIG01312241 Transcriptional regulator, PBSX family +FIG01312250 AglU +FIG01312260 Sodium/alanine symporter family protein +FIG01312267 Acetyltransferase (EC 2.3.1.-) GNAT family +FIG01312274 Dinucleotide-utilizing enzymes involved in molybdopterin and thiamine biosynthesis family 2 +FIG01312277 Transcriptional regulator, AraC family / Glycoside hydrolase +FIG01312278 Uncharacterized protein ydcO +FIG01312279 transcriptional regulator gntR family +FIG01312286 FIG01203924: hypothetical protein +FIG01312288 hypothetical protein +FIG01312294 FIG00872179: hypothetical protein +FIG01312296 Na+/H+ ion antiporter family protein +FIG01312297 Transposase of IS657 +FIG01312300 FIG00350149: hypothetical protein +FIG01312301 entericidin A anti-toxin precursor +FIG01312302 Probable type II DNA modification enzyme +FIG01312303 phage related integrase +FIG01312310 FIG00353716: hypothetical protein +FIG01312321 Prophage Lp2 protein 6 +FIG01312322 Putative amino acid ABC tansporter permease protein +FIG01312326 17 kDa major membrane protein precursor +FIG01312329 oxidoreductase, short-chain dehydrogenase/reductase family +FIG01312331 hypothetical protein Rv2558 +FIG01312341 BH1265 unknown +FIG01312343 FIG00699088: hypothetical protein +FIG01312354 4Fe-4S ferredoxin, iron-sulfur binding +FIG01312357 hypothetical +FIG01312359 Monooxygenase, FAD-binding (EC 1.14.13.20) +FIG01312360 Blue-light photoreceptor +FIG01312368 TVG0046979 protein +FIG01312369 POSSIBLE CONSERVED TRANSMEMBRANE PROTEIN +FIG01312390 TraI protein (DNA helicase I) (EC 3.6.1.-) +FIG01312395 Phytochrome-like protein; two-component sensor histidine kinase +FIG01312397 trifolitoxin immunity domain protein +FIG01312402 Two-component system sensor protein / Periplasmic iron-binding protein +FIG01312410 Phenylalanyl-tRNA synthetase beta subunit +FIG01312412 Hypothetical protein SAV2263 +FIG01312413 Uncharacterized lipoprotein yaeF precursor +FIG01312414 Peptidase E (EC 3.4.11.2) +FIG01312420 Transcriptional regulator +FIG01312422 FIG01047778: hypothetical protein +FIG01312423 two-component sensor (kinase)( EC:2.7.3.- ) +FIG01312438 HAD superfamily hydrolase/phosphatase +FIG01312443 Putative helix-turn-helix motif protein +FIG01312448 2-hydroxychromene-2-carboxylate isomerase +FIG01312450 Alkaline serine protease +FIG01312454 DnaK-related protein +FIG01312461 4-hydroxyphenylacetate decarboxylase, small subunit (EC 4.1.1.83) +FIG01312462 FIG00848278: hypothetical protein +FIG01312472 hypothetical protein +FIG01312473 Carbohydrate kinase, FGGY family +FIG01312475 Homolog of E. coli HemX protein +FIG01312479 Probable prepilin peptidase transmembrane protein +FIG01312482 FIG00344702: hypothetical protein +FIG01312484 Peptidase, M28 family +FIG01312485 Bdm protein +FIG01312487 Ammonia permease +FIG01312490 FIG00403349: hypothetical protein +FIG01312491 Probable bacteriophage integrase +FIG01312494 FIG00352261: hypothetical protein +FIG01312496 FIG00768600: hypothetical protein +FIG01312498 Ubiquinone/menaquinone biosynthesis methyltransferase UBIE (EC 2.1.1.-) +FIG01312501 Transcription regulator, RpiR family +FIG01312517 outer surface protein C (ospC) +FIG01312520 Phosphoprotein phosphatase +FIG01312523 putative tail length tape measure protein precursor +FIG01312529 FIG00424567: hypothetical protein +FIG01312531 FIG01166632: hypothetical protein +FIG01312532 DNA mismatch repair enzyme +FIG01312536 Sodium/dicarboxylate symporter +FIG01312540 Sensor-receptor histidine kinase NisK +FIG01312548 Membrane protein related to metalloendopeptidases +FIG01312553 Hypothetical protein yrhB +FIG01312561 Hypothetical protein perhaps functionally coupled to transcription elongation factor GreA +FIG01312568 Regulator of competence-specific genes +FIG01312573 Sigma-M negative effector +FIG01312584 Putative MFS Superfamily multidrug efflux transporter +FIG01312585 FIG00638217: hypothetical protein +FIG01312603 putative minor fimbrial subunit precursor +FIG01312614 Tryptophan repressor binding protein +FIG01312617 PUTATIVE REMNANT OF A TRANSPOSASE +FIG01312621 Galactoside O-acetyltransferase +FIG01312625 ExtraCellular Mutant; Ecm15p +FIG01312639 Exfoliative toxin A +FIG01312644 hypothetical protein-signal peptide and transmembrane prediction +FIG01312645 FAD-binding oxidoreductase +FIG01312647 L-gulono-1,4-lactone oxidase (EC 1.1.3.8) +FIG01312652 FIG01240895: hypothetical protein +FIG01312657 FIG00351649: hypothetical protein +FIG01312667 Transcriptional regulator lysR family +FIG01312669 hypothetical protein +FIG01312674 Uncharacterized membrane protein Bsu2508 (YqfU) +FIG01312676 hypothetical protein +FIG01312677 FIG01227023: hypothetical protein +FIG01312683 FIG00948224: hypothetical protein +FIG01312688 UPF0304 protein yfbU +FIG01312689 Alpha-methylacyl-CoA racemase (EC 5.1.99.4) +FIG01312692 putative disulfide bond isomerase +FIG01312699 Thymidylate kinase +FIG01312701 putative chromate reductase +FIG01312702 APH, Aminoglycoside phosphotransferase +FIG01312705 Hemolysin activation/secretion protein-like +FIG01312710 FIG00350434: hypothetical protein +FIG01312716 Helix destabilizing protein of bacteriophage Pf1 +FIG01312718 FIG00353193: hypothetical protein +FIG01312725 ABC transporter, periplasmic iron-transport lipoprotein +FIG01312727 hypothetical protein +FIG01312729 FIG00782218: hypothetical protein +FIG01312731 Possible enzyme +FIG01312742 FIG00425398: hypothetical protein +FIG01312757 2-amino-3-carboxymuconate 6-semialdehyde decarboxylase +FIG01312801 glucose uptake protein +FIG01312802 FIG00406074: hypothetical protein +FIG01312814 Lhr-like helicases +FIG01312824 Possible Cytochrome c oxidase subunit Va +FIG01312828 peptidase M3 family protein +FIG01312830 Phage lysin, glycosyl hydrolase, family 25 +FIG01312847 putative N-acetyl-muramidase +FIG01312850 Oligopeptide transporter, OPT family +FIG01312852 protein family PM-16 +FIG01312858 FIG00613761: hypothetical protein +FIG01312861 4,5-dihydroxyphthalate decarboxylase (EC 4.1.1.55) +FIG01312867 FIG00644298: hypothetical protein +FIG01312875 putative fimbrial protein +FIG01312883 putative integrase within CP-933O; partial +FIG01312887 Possible 4Fe-4S iron sulfur cluster binding pr +FIG01312896 putative TonB domain protein +FIG01312902 FIG01119252: hypothetical protein +FIG01312903 nickel-cobalt-cadmium resistance protein (nccB) +FIG01312908 Peptidase S8 and S53 subtilisin, kexin, sedolisin +FIG01312918 lipoprotein LA7 +FIG01312919 POSSIBLE OXIDOREDUCTASE (EC 1.-.-.-) +FIG01312927 Orf21; putative lipoprotein +FIG01312939 antigen +FIG01312944 FIG01047471: hypothetical protein +FIG01312948 Signal transduction response regulator / Tetratricopeptide repeat-containing protein +FIG01312966 FIG01220556: hypothetical protein +FIG01312972 N-acetylmuramoyl-L-alanine amidase AmiB precursor (EC 3.5.1.28) +FIG01312984 Formamidase amiF (EC 3.5.1.49) +FIG01312985 GnsA protein +FIG01313008 Possible outer membrane adhesin +FIG01313014 Colicin nuclease family protein +FIG01313020 O-Methyltransferase involved in polyketide biosynthesis +FIG01313022 Probable extracellular solute-binding protein +FIG01313023 Collagenase +FIG01313031 FIG00744091: hypothetical protein +FIG01313033 FIG00521203: hypothetical protein +FIG01313034 Glucosyl-3-phosphoglycerate synthase (EC 2.4.1.266) +FIG01313036 Conserved hypothetical phage protein +FIG01313060 Trx +FIG01313070 Probable RNA polymerase sigma factor HI1459 +FIG01313088 Protein At2g37660, chloroplast precursor +FIG01313097 ISXo3 transposase orfB +FIG01313099 hypothetical protein +FIG01313105 CAIB/BAIF family protein +FIG01313112 Predicted manganese transporter, 11 TMS +FIG01313118 Germination (Cortex hydrolysis) and sporulation protein GerM +FIG01313120 DNA-binding protein, CopG family +FIG01313123 hypothetical protein +FIG01313128 hypothetical protein +FIG01313145 Acetyltransferase +FIG01313150 PE family protein +FIG01313156 (S)-2-hydroxy-acid oxidase chain D +FIG01313159 Putative transmembrane protein HieC +FIG01313164 BRAMP +FIG01313166 Predicted hydrolase +FIG01313184 ABC-type transport system, ATPase component +FIG01313191 Helicase, SNF2/RAD54 family +FIG01313194 Succinate dehydrogenase/fumarate reductase, flavoprotein subunit +FIG01313200 leucine-rich repeat protein, function unknown +FIG01313207 Pli0006 protein +FIG01313218 hypothetical protein +FIG01313226 Mlr1851 protein +FIG01313228 Putative inner membrane protein +FIG01313239 NLP/P60:Mannosyl-glycoprotein endo-beta-N-acetylglucosamidase +FIG01313248 GGDEF domain protein +FIG01313254 Putative chaperone (IpgB2) +FIG01313263 Medium-chain-fatty-acid--CoA ligase (EC 6.2.1.-) +FIG01313270 FIG00352997: hypothetical protein +FIG01313273 B. burgdorferi predicted coding region BBB09 +FIG01313291 Spermidine synthase-like protein +FIG01313294 Lysyl aminopeptidase (EC 3.4.11.15) +FIG01313299 FIG00639674: hypothetical protein +FIG01313300 Transcriptional regulator, TrmB family +FIG01313305 NrdB +FIG01313317 membrane protein-like +FIG01313321 Bifunctional protein: zinc-containing alcohol dehydrogenase; quinone oxidoreductase ( NADPH:quinone reductase) (EC 1.1.1.-); Similar to arginate lyase +FIG01313323 FIG00823745: hypothetical protein +FIG01313324 FIG00521538: hypothetical protein +FIG01313331 Amino acid transport ATP-binding protein +FIG01313342 FIG00629985: hypothetical protein +FIG01313347 Zn peptidase with DNA binding +FIG01313353 Membrane associated histidine kinase-like ATPase +FIG01313365 FIG00624829: hypothetical protein +FIG01313386 FIG00764276: hypothetical protein +FIG01313391 B. burgdorferi predicted coding region BBG15 +FIG01313392 putative ferrous iron transport protein A +FIG01313396 Putative phage-related protein precursor +FIG01313400 glycosyl transferase, family 28 +FIG01313410 O-antigen polymerase +FIG01313412 Cytosine/adenosine deaminases +FIG01313416 FIG00643789: hypothetical protein +FIG01313417 hypothetical protein +FIG01313418 FIG01017299: hypothetical protein +FIG01313429 DNA helicase II (EC 3.6.1.-) +FIG01313442 Uncharacterized signaling protein CC_0091 +FIG01313455 Huntingtin interacting protein E-like protein +FIG01313464 putative translation initiation factor IF-2 +FIG01313471 Diguanylate cyclase/phosphodiesterase domain 1 (GGDEF) +FIG01313475 Predicted thioesterase +FIG01313488 FIG00847161: hypothetical protein +FIG01313494 Microcystin synthetase associated thioesterase +FIG01313511 putative lipoprotein thioredoxin +FIG01313519 FIG00465755: hypothetical protein +FIG01313520 doc protein +FIG01313529 27 kDa antigen Cfp30B +FIG01313533 UDP-sulfoquinovose synthase (EC 3.13.1.1) +FIG01313535 FIG00710614: hypothetical protein +FIG01313540 ABC-type multidrug transport system, ATPase and permease component +FIG01313546 GMP synthase - Glutamine amidotransferase domain +FIG01313560 A2-5a orf4 +FIG01313563 FIG00764182: hypothetical protein +FIG01313570 FIG00405000: hypothetical protein +FIG01313572 Membrane protein with C2C2 zinc finger +FIG01313581 FIG00823117: hypothetical protein +FIG01313583 UPF0033 protein VNG5061C/VNG5236C/VNG6059C/VNG6467C +FIG01313586 ABC-type amino acid transport/signal transduction system +FIG01313591 hypothetical protein +FIG01313592 Probable integrase/recombinase protein +FIG01313607 BapB protein +FIG01313608 FIG01045788: hypothetical protein +FIG01313616 Putative arylsulfatase regulator +FIG01313626 RhsD protein precursor +FIG01313628 Potential queD like +FIG01313630 FIG00402966: hypothetical protein +FIG01313639 FIG00847619: hypothetical protein +FIG01313642 iron compound ABC transporter, permease protein +FIG01313645 NADH dehydrogenase subunit II-related protein +FIG01313653 FIG00639248: hypothetical protein +FIG01313654 probable amino-acid binding protein for ABC transporter system +FIG01313656 putative response regulator involved in antitermination +FIG01313662 FIG00349945: hypothetical protein +FIG01313670 unknown protein encoded within prophage CP-933R +FIG01313682 Uncharacterized protein ybeF +FIG01313684 BchE/P-methylase family protein +FIG01313687 FIG00763926: hypothetical protein +FIG01313697 Predicted ring-cleavage extradiol dioxygenase +FIG01313701 Predicted phosphohydrolase +FIG01313708 Putative binding-protein-dependent transport system +FIG01313714 FIG00953497: hypothetical protein +FIG01313724 PROBABLE CONSERVED TRANSMEMBRANE PROTEIN +FIG01313737 FIG00821422: hypothetical protein +FIG01313748 Polyketide synthase modules and related proteins +FIG01313749 Prolidase (EC 3.4.13.9) +FIG01313751 Arabinose efflux permease +FIG01313756 FIG00768102: hypothetical protein +FIG01313763 Putative sugar translocase in surface polysaccharides biosynthesis +FIG01313765 Putative amidase MSMEG_2521 +FIG01313768 YfhS protein +FIG01313771 Putative single stranded DNA-binding protein of prophage +FIG01313774 Hypothetical protein, CF-26 family +FIG01313780 FIG00350173: hypothetical protein +FIG01313785 FIG01205125: hypothetical protein +FIG01313786 putative transcriptional regulator, MerR family +FIG01313793 Phage-related protein, tail component +FIG01313800 nickel ABC transporter, permease protein +FIG01313801 DNA-directed DNA polymerase I +FIG01313805 YjiD protein +FIG01313811 Phage outer membrane lipoprotein Rz1 +FIG01313812 single-strand DNA-binding protein +FIG01313813 UDP-glucose/GDP-mannose dehydrogenase family protein +FIG01313815 Uncharacterized protein YmdE +FIG01313819 major facilitator family transporter +FIG01313821 FIG060670: Protein of unknown function DUF924 +FIG01313830 Glycosyl transferase, family 9 +FIG01313833 Oligopeptide transporter +FIG01313842 N-acetyl-L,L-diaminopimelate deacetylase homolog (EC 3.5.1.18) +FIG01313846 12-TMS multidrug efflux protein homolog +FIG01313860 hypothetical protein +FIG01313862 Probable peptidase SodX for nickel-dependent superoxide dismutase +FIG01313873 FIG00385363: hypothetical protein +FIG01313874 Bucepa02001210 protein family (probably prophage associated) +FIG01313877 FIG00768139: hypothetical protein +FIG01313879 quinone oxidoreductase +FIG01313880 Galactose mutarotase and related enzymes +FIG01313885 Protein chain release factor B +FIG01313886 ABC transporter ATP-binding protein +FIG01313888 glycogen synthesis protein GlgS +FIG01313900 Beta-galactosidase/beta-glucuronidase +FIG01313903 intimin/invasin family protein +FIG01313905 Cell wall hydrolase cwlJ +FIG01313910 Autolysin precursor +FIG01313913 Competence protein ComEA +FIG01313925 Predicted hydrolases or acyltransferases (alpha/beta hydrolase superfamily) +FIG01313934 FIG00769079: hypothetical protein +FIG01313955 FIG00356038: hypothetical protein +FIG01313962 FIG00828390: hypothetical protein +FIG01313967 similar to ABC-type sugar transport system periplasmic component +FIG01313977 Iron-uptake factor PiuC +FIG01313989 putative choline binding protein +FIG01313991 ROK family Glucokinase with ambiguous substrate specificity +FIG01314003 glucose-6-phosphate dehydrogenase domain protein +FIG01314009 Nuclease precursor (EC 3.1.30.2) +FIG01314014 marR-family transcriptional regulator +FIG01314033 FIG00402719: hypothetical protein +FIG01314034 FIG00350285: hypothetical protein +FIG01314037 FIG00388648: hypothetical protein +FIG01314038 tsr or; CheD +FIG01314039 Energy conserving hydrogenase Eha associated polyferredoxin +FIG01314042 FIG00425689: hypothetical protein +FIG01314052 FIG00468458: hypothetical protein +FIG01314061 probable membrane protein YPO3302 +FIG01314074 FIG00872757: hypothetical protein +FIG01314078 Toxin secretion ABC transporter HlyB/MsbA family ATP-binding protein +FIG01314079 Transposase +FIG01314096 Possible glycosyl hydrolase (EC 3.-.-.-) +FIG01314104 contains chromosome segregation ATPase domain +FIG01314107 Nucleoprotein/polynucleotide-associated enzyme +FIG01314108 Putative hydrolase from alpha/beta family +FIG01314113 Protein of unknown function DUF583 +FIG01314116 Kumamolysin +FIG01314117 FIG01147549: hypothetical protein +FIG01314125 Insecticial toxin +FIG01314128 FIG00674437: hypothetical protein +FIG01314131 Cytochrome P450 136 +FIG01314132 bacteriocin immunity protein +FIG01314140 FIG00765726: hypothetical protein +FIG01314142 rickettsial 17 kDa surface antigen precursor +FIG01314148 Transcriptional regulator, MarR family / Aspartate N-acetyltransferase (EC 2.3.1.17) +FIG01314149 FIG01116266: hypothetical protein +FIG01314160 Secretion system regulator of DegU/UvrY/BvgA type +FIG01314168 Tiorf87 protein +FIG01314173 Histidyl-tRNA synthetase related protein in Streptococcus pneumoniae +FIG01314174 FIG00424248: hypothetical protein +FIG01314175 ATP (GTP) -binding protein +FIG01314180 Putative methyl-accepting chemotaxis protein +FIG01314194 FIG00639629: hypothetical protein +FIG01314195 FIG00406265: hypothetical protein +FIG01314197 Protease Do (EC 3.4.21.-) +FIG01314205 FIG00413399: hypothetical protein +FIG01314214 Glycopeptide antibiotics resistance protein +FIG01314217 FIG00766655: hypothetical protein +FIG01314220 PlcR-regulated protein PRP2 +FIG01314222 HTH-type transcriptional regulator gadX +FIG01314225 Hypothetical protein, CF-6 family +FIG01314239 FIG01135104: hypothetical protein +FIG01314257 FIG00768482: hypothetical protein +FIG01314258 5-amino-6-(5-phosphoribosylamino)uracil reductase +FIG01314261 Transposase, mutator family +FIG01314268 surface protein +FIG01314273 FIG00253438: hypothetical protein +FIG01314274 Phage transposase +FIG01314276 FIG00643723: hypothetical protein +FIG01314279 Pkn9 associate protein 1 +FIG01314289 YolD +FIG01314299 FIG00350263: hypothetical protein +FIG01314300 transposase IS3/family protein +FIG01314302 Polyketide synthase, type I +FIG01314307 LysM domain protein +FIG01314316 Similar to ompF +FIG01314317 y4eB gene in pNGR234a homolog +FIG01314318 Similar to cell surface protein Map-w +FIG01314325 PmgL +FIG01314326 Shikimate transporter +FIG01314328 FIG027960: hypothetical protein +FIG01314334 Transmembrane transport protein MmpL13 +FIG01314340 FIG00351546: hypothetical protein +FIG01314343 3-oxoacyl-[acyl-carrier protein] reductase paralog (EC 1.1.1.100) +FIG01314356 lipase/acylhydrolase family protein +FIG01314365 FIG00350655: hypothetical protein +FIG01314374 FIG00820561: hypothetical protein +FIG01314375 Azoreductase +FIG01314376 FIG00768704: hypothetical protein +FIG01314377 FIG01114101: hypothetical protein +FIG01314381 FIG032330: hypothetical protein +FIG01314384 Ribosomal-protein-alanine acetyltransferase( EC:2.3.1.128 ) +FIG01314389 FIG00767485: hypothetical protein +FIG01314393 Hypothetical protein DUF2999 +FIG01314394 hypothetical protein +FIG01314414 FIG00663401: hypothetical protein +FIG01314420 B. burgdorferi predicted coding region BBB24 +FIG01314425 FIG00762876: hypothetical protein +FIG01314428 possible DnaJ +FIG01314429 hydrolase-related protein +FIG01314430 Hemerythrin-like, metal-binding protein +FIG01314437 FIG00939120: hypothetical protein +FIG01314442 Secretion system chaparone SscA +FIG01314444 Cytidine/deoxycytidylate deaminase family protein +FIG01314445 phosphinothricin acetyltransferase, putative +FIG01314451 FIG00640703: hypothetical protein +FIG01314461 Immunodominant staphylococcal antigen A precursor +FIG01314482 Amino-acid ABC transporter integral membrane protein +FIG01314484 Response regulator aspartate phosphatase inhibitor +FIG01314487 Phasmid Socket Absent +FIG01314494 FIG00406380: hypothetical protein +FIG01314502 Bll4328 protein +FIG01314516 Sensory transduction protein regX3 +FIG01314524 Glutamine synthetase (EC 6.3.1.2), putative +FIG01314527 FIG029313: hypothetical protein Rv2000/MT2056 +FIG01314534 Peptidase +FIG01314556 Thiosulfate sulfurtransferase, rhodanese (EC 2.8.1.1) +FIG01314561 truncated transcriptional regulator +FIG01314568 FIG00615170: hypothetical protein +FIG01314573 Inclusion membrane protein-21 +FIG01314578 Probable ABC transporter permease protein y4oR +FIG01314581 Intracellular proteinase inhibitor domain protein +FIG01314586 Hypothetical protein SAV2074 +FIG01314590 Transcriptional regulator SczA, TetR family +FIG01314598 FIG00426715: hypothetical protein +FIG01314616 Hemolysin secretion protein precursor +FIG01314635 FIG00642820: hypothetical protein +FIG01314638 bacteriolytic lipoprotein entericidin B +FIG01314648 FIG00348620: hypothetical protein +FIG01314649 FIG00352918: hypothetical protein +FIG01314656 NADH:ubiquinone oxidoreductase subunit 2 (chain N) +FIG01314665 Putative helix-turn-helix containsing protein +FIG01314669 Mob421 protein +FIG01314684 Putative regulatory membrane protein +FIG01314690 Signaling protein with a acyltransferase and GGDEF domains +FIG01314693 Aldo/keto reductase (EC 1.1.1.91) +FIG01314737 FIG00767880: hypothetical protein +FIG01314743 Penicillin acylase (Penicillin amidase) (EC 3.5.1.11) +FIG01314744 FIG01251273: hypothetical protein +FIG01314748 FIG00766988: hypothetical protein +FIG01314749 FIG00960592: hypothetical protein +FIG01314753 FIG033348: hypothetical protein +FIG01314755 COG0065: 3-isopropylmalate dehydratase large subunit +FIG01314775 CheD, stimulates methylation of MCP protein +FIG01314778 FIG01251890: hypothetical protein +FIG01314782 Cyclopropane-fatty-acyl-phospholipid synthase 2, CmaA2 (EC 2.1.1.79) +FIG01314783 putative polyketide synthase +FIG01314786 DNA polymerase III polC-type (EC 2.7.7.7) +FIG01314810 FIG00350686: hypothetical protein +FIG01314811 UPF0189 protein Mb1934c +FIG01314812 FIG01017954: hypothetical protein +FIG01314815 ABC transporter, multidrug efflux family +FIG01314820 FIG00361373: hypothetical protein +FIG01314823 FIG00850578: hypothetical protein +FIG01314837 secreted protein with 1 GW repeat +FIG01314840 general stress protein +FIG01314856 Probable M18-family aminopeptidase 1 (EC 3.4.11.-) +FIG01314859 Dipeptidase (EC 3.4.-.-) +FIG01314860 Cytochrome c4 family protein +FIG01314867 putative Mg(2+) transporter +FIG01314868 FIG00350954: hypothetical protein +FIG01314871 Mlr6684 protein +FIG01314876 FIG062653: putative inner membrane protein +FIG01314884 putative; ORF located using Glimmer/Genemark +FIG01314885 probable membrane protein NMA1128 +FIG01314886 COGs COG2954 +FIG01314898 FIG00820463: hypothetical protein +FIG01314900 Phage protein +FIG01314906 hypothetical protein NMA1072 +FIG01314907 tannase precursor +FIG01314912 FIG01048512: hypothetical protein +FIG01314916 FIG00425043: hypothetical protein +FIG01314920 FIG00353372: hypothetical protein +FIG01314927 probable transcriptional regulator, marR family +FIG01314928 FIG00407422: hypothetical protein +FIG01314929 Esterase A +FIG01314931 gluconolactonase, putative +FIG01314938 Putative transport protein/putative regulator +FIG01314941 general secretion pathway protein-related protein +FIG01314949 FIG00769828: hypothetical protein +FIG01314950 Mll3431 protein +FIG01314955 Hypothetical protein SAV2319 +FIG01314958 Hypothetical fimbrial chaperone yqiH +FIG01314962 Choline binding protein G +FIG01314969 FIG01225891: hypothetical protein +FIG01314977 Poly(3-hydroxybutyrate) depolymerase +FIG01314981 FIG012070: hypothetical protein +FIG01314985 FIG00498400: hypothetical protein +FIG01314987 FIG00764081: hypothetical protein +FIG01314989 Internalin E (LPXTG motif) +FIG01314994 hypothetical protein +FIG01315018 Serine/threonine-protein kinase PknF (EC 2.7.11.1) +FIG01315021 putative membrane permeability altering protein +FIG01315026 Opine dehydrogenase (EC 1.5.1.28) +FIG01315034 FIG00407312: hypothetical protein +FIG01315035 Putative surface protein +FIG01315053 FIG01231154: hypothetical protein +FIG01315076 protein of unknown function DUF488 +FIG01315082 Phage protein +FIG01315083 Leukocidin LukF-PV +FIG01315086 omt (omt) +FIG01315087 Uncharacterized protein yxnB +FIG01315091 Uncharacterized protein yqhG precursor +FIG01315106 Modification methylase NlaIII (EC 2.1.1.72) +FIG01315108 contains phage integrase domain +FIG01315109 ATP:guanido phosphotransferase +FIG01315110 Pentapeptide repeat family protein +FIG01315111 PROBABLE REMNANT OF A TRANSPOSASE +FIG01315112 FIG00350003: hypothetical protein +FIG01315125 IRON-REGULATED OUTER MEMBRANE PROTEIN FRPB +FIG01315135 PROBABLE INTEGRAL MEMBRANE PROTEIN +FIG01315136 FIG00350240: hypothetical protein +FIG01315156 Ser/Thr protein phosphatase family protein +FIG01315169 Sensor histidine kinase/response regulator +FIG01315177 COG3740: Phage head maturation protease +FIG01315179 FIG00629254: hypothetical protein +FIG01315186 Putative intestinal colonization factor encoded by prophage CP-933O +FIG01315187 FIG01117876: hypothetical protein +FIG01315202 Serine acetyltransferase-like protein +FIG01315211 Response regulator receiver, CheY3 +FIG01315223 P60 extracellular protein, invasion associated protein Iap +FIG01315227 Cof-like hydrolase, HAD-superfamily, subfamily IIB +FIG01315230 ISSwp3, transposase OrfB +FIG01315231 ABC transporter, ATP binding component +FIG01315237 FIG020308: hypothetical protein +FIG01315246 Amino acid ABC transporter, periplasmic amino acid-binding protein +FIG01315256 Bll3052 protein +FIG01315263 Acetyltransferase (GNAT) family +FIG01315276 antigen, S1 +FIG01315280 FIG01128995: hypothetical protein +FIG01315281 Hypothetical oxidoreductase YqhD (EC 1.1.-.-) +FIG01315285 FIG01212334: hypothetical protein +FIG01315286 Type II secretion envelope pseudopilin protein (PulG,guides folded protein to PulD in outer membrane) +FIG01315289 Protein SlyX +FIG01315295 FIG00850084: hypothetical protein +FIG01315297 FIG00689465: hypothetical protein +FIG01315301 Ribonucleotide ABC transporter ATP-binding protein +FIG01315303 FIG00385573: hypothetical protein +FIG01315307 ABC transporter, ATP-binding/permease protein +FIG01315317 FIG00945106: hypothetical protein +FIG01315318 Thioesterase in siderophore biosynthesis gene cluster +FIG01315346 Nodulation protein nolO (EC 2.1.3.-) +FIG01315353 FIG01227885: hypothetical protein +FIG01315362 FIG00749339: hypothetical protein +FIG01315364 acetyltransferase, GNAT family +FIG01315376 FIG01061955: hypothetical protein +FIG01315383 hypothetical protein +FIG01315384 putative conserved inner membrane protein +FIG01315386 putative membrane integrated oxidoreductase +FIG01315387 FIG00711896: hypothetical protein +FIG01315397 FIG00424063: hypothetical protein +FIG01315398 FIG00350517: hypothetical protein +FIG01315400 anaerobic dicarboxylate transport +FIG01315410 FIG00628455: hypothetical protein +FIG01315413 FIG01240560: hypothetical protein +FIG01315414 DNA repair and recombination protein, putative helicase +FIG01315420 Putative replicase +FIG01315422 PLP-dependent aminotransferase +FIG01315423 FIG00769410: hypothetical protein +FIG01315430 DNA alkylation repair enzyme +FIG01315434 Tyrosinase (EC 1.14.18.1) +FIG01315438 Metal-dependent hydrolase +FIG01315441 possible rhodanese-related sulfurtransferase +FIG01315444 competence-specific nuclease +FIG01315452 heme biosynthesis protein +FIG01315456 Fatty acid alpha hydroxylase +FIG01315457 putative ribosomal-protein-serine N-acetyltransferase +FIG01315458 FIG00762902: hypothetical protein +FIG01315459 astB/chuR-related protein-putative enzyme of the MoaA / nifB / pqqE family +FIG01315461 Leader peptidase HopD +FIG01315465 FIG00351891: hypothetical protein +FIG01315476 Predicted histidine uptake transporter +FIG01315478 Hypothetical protein SAV2259 +FIG01315481 ABC transporter, substrate-binding protein +FIG01315490 FIG00387962: hypothetical protein +FIG01315492 Lipid A core-O-antigen ligase +FIG01315493 Predicted enzyme of the cupin superfamily +FIG01315496 FIG00411950: hypothetical protein +FIG01315500 outer membrane lipoprotein receptor +FIG01315502 LacI family transcriptional repressor +FIG01315505 FIG00343947: hypothetical protein +FIG01315511 Serine/threonine protein kinase (EC 2.7.1.37) +FIG01315518 Putative superfamily I DNA helicases +FIG01315522 Toxin 1, PIN domain +FIG01315524 FIG012002: lipoprotein, putative +FIG01315528 Malate/L-lactate dehydrogenases +FIG01315534 Predicted flavoprotein +FIG01315535 Chaperone protein hchA +FIG01315541 FIG00638583: hypothetical protein +FIG01315545 FIG00763449: hypothetical protein +FIG01315549 Hydroxyindole O-methyltransferase (EC 2.1.1.4) +FIG01315555 putative zinc protease +FIG01315565 hypothetical protein BAS3041 +FIG01315572 putative secreted xylosidase +FIG01315575 DNA helicase +FIG01315577 FIG01231422: hypothetical protein +FIG01315583 RecX-like protein +FIG01315585 Protein-L-isoD(D-D) O-methyltransferase +FIG01315587 Predicted hydrolase of the alpha/beta superfamily +FIG01315588 FIG236089: hypothetical protein +FIG01315604 ethanolamine utilization protein EutN +FIG01315608 Probable homoserine/homoserine lactone efflux protein +FIG01315609 FIG00764172: hypothetical protein +FIG01315618 FIG01038009: hypothetical protein +FIG01315628 transporter, major facilitator family protein +FIG01315650 MTCI65.01 protein +FIG01315665 G-nucleotide exchange factor SopE +FIG01315666 Inner membrane protein yjdF +FIG01315674 Putative uncharacterized protein YrbL +FIG01315676 pheromone shutdown protein +FIG01315683 thioredoxin, putative +FIG01315691 possible bacteriophage Mu GP27-like protein +FIG01315696 Hemagglutinin, Hemagglutinin +FIG01315697 FIG00402728: hypothetical protein +FIG01315706 putative phosphoesterase CT488 +FIG01315716 WbpG +FIG01315717 FIG00349211: hypothetical protein +FIG01315733 CAG pathogenicity island protein 23 (Protein picB) +FIG01315737 FIG00468703: hypothetical protein +FIG01315741 Amidase family protein +FIG01315750 FIG160596: Signaling protein with membrane-bound sensor domain and GGDEF domain +FIG01315760 FIG00460211: hypothetical protein +FIG01315779 POSSIBLE INTEGRAL MEMBRANE PROTEIN +FIG01315780 Response regulator containing a CheY-like receiver domain and an HD-GYP domain +FIG01315803 Sugar kinases, ribokinase family +FIG01315814 Tributyrin esterase +FIG01315817 Doubtful CDS. No database matches +FIG01315818 hypothetical protein +FIG01315827 probable integral membrane protein NMA1777 +FIG01315845 Isopentenyl transferase +FIG01315847 Phospholipase C +FIG01315855 BH3197 unknown conserved protein +FIG01315857 Fimbrial adapter papK precursor +FIG01315865 Putative SAM-dependent methyltransferases +FIG01315866 Endonuclease V (EC 3.1.25.1) +FIG01315870 FIG00350901: hypothetical protein +FIG01315872 regulatory protein MarR +FIG01315873 Tetracenomycin polyketide synthesis O-methyltransferase tcmP( EC:2.1.1.- ) +FIG01315874 Branched-chain amino acid ABC transporter, periplasmic amino acid-binding protein, putative +FIG01315876 FIG00688740: hypothetical protein +FIG01315884 Transporter, LysE family +FIG01315896 Uncharacterized lipoprotein yaeF precursor +FIG01315905 Thermonuclease +FIG01315909 FIG00822600: hypothetical protein +FIG01315911 Putative cytoplasmic protein +FIG01315913 death-on-curing family protein +FIG01315915 FIG01074951: hypothetical protein +FIG01315918 FIG01239712: hypothetical protein +FIG01315921 Spore photoproduct lyase (EC 4.1.99.-) +FIG01315932 hypothetical protein +FIG01315933 putative phytase +FIG01315943 SCP-like extracellular protein +FIG01315946 Inosine-5'-monophosphate dehydrogenase (EC 1.1.1.205) +FIG01315953 FIG00904084: hypothetical protein +FIG01315957 Ferric vibriobactin receptor ViuA +FIG01315958 Putative gp46 [Bacteriophage N15] pir||T13133 protein gp46- +FIG01315961 FIG01047449: hypothetical protein +FIG01315962 putative ABC transporter transmembrane subunit +FIG01315968 FIG00403019: hypothetical protein +FIG01315972 thymidylate synthase +FIG01315974 FIG00355570: hypothetical protein +FIG01315986 FIG00822523: hypothetical protein +FIG01315990 transcriptional regulator/TPR domain protein +FIG01315993 FIG01126365: hypothetical protein +FIG01315994 sodium/solute symporter family protein +FIG01316001 Putative NAGC-like transcriptional regulator +FIG01316002 FIG00623536: hypothetical protein +FIG01316004 Possible Ribosomal protein L11 +FIG01316007 PUTATIVE LIPOPROTEIN LPQV +FIG01316017 putative recet +FIG01316027 FIG00468741: hypothetical protein +FIG01316037 hypothetical protein +FIG01316038 transposase +FIG01316040 Phosphotransferase system IIC components, glucose/maltose/N-acetylglucosamine-specific +FIG01316045 FIG00408467: hypothetical protein +FIG01316046 Streptogramin lyase +FIG01316065 Lipoprotein LpqA +FIG01316071 FIG01116450: hypothetical protein +FIG01316084 TrkA C-terminal domain protein +FIG01316096 Hypothetical protein SAV2097 +FIG01316100 lincomycin resistance protein LmrB +FIG01316101 lyase, putative +FIG01316103 RND efflux system, outer membrane lipoprotein, NodT precursor +FIG01316106 putative multidrug efflux ABC transporter +FIG01316113 ABC-type sugar transport system, periplasmic component +FIG01316116 Carboxypeptidase C (cathepsin A) +FIG01316117 FIG00623840: hypothetical protein +FIG01316118 COG1949: Oligoribonuclease (3'->5' exoribonuclease) +FIG01316121 FIG00404257: hypothetical protein +FIG01316122 NLP/P60 family protein +FIG01316133 Methyl-accepting chemotaxis transducer +FIG01316135 FIG01046034: hypothetical protein +FIG01316147 Periplasmic fimbrial chaperone protein +FIG01316157 Purine-binding chemotaxis protein +FIG01316163 B. burgdorferi predicted coding region BB0426 +FIG01316171 Transcriptional regulator, RofA-like Protein (RALP) +FIG01316175 FIG00402755: hypothetical protein +FIG01316176 FIG00639928: hypothetical protein +FIG01316187 Protein inaA +FIG01316195 Two-component response regulator vanR +FIG01316199 Nitroreductase family protein +FIG01316211 FIG00755909: hypothetical protein +FIG01316219 Iron Transporting ABC transporter, ATP binding component +FIG01316237 FIG00517231: hypothetical protein +FIG01316240 putative macrolide efflux pump +FIG01316242 Secretion system effector SseB +FIG01316247 IG hypothetical 18022 +FIG01316255 Predicted membrane protein/domain +FIG01316265 LuxR family transcriptional regulator +FIG01316270 L-alanoyl-D-glutamate peptidase +FIG01316282 Secreted protein EspE, component of Type VII secretion system ESX-1 +FIG01316283 aminotransferase, class I/II +FIG01316285 D-amino acid oxidase family protein +FIG01316293 FIG00653760: hypothetical protein +FIG01316294 Amino acid transporters +FIG01316295 FIG01120446: hypothetical protein +FIG01316302 FIG00348677: hypothetical protein +FIG01316307 LAGLIDADG DNA endonuclease +FIG01316311 POSSIBLE MYCOLIC ACID SYNTHASE UMAA1 +FIG01316313 Hit Family Protein +FIG01316316 Galactose oxidase precursor (EC 1.1.3.9) +FIG01316317 Putative glycoporin +FIG01316320 FIG01046300: hypothetical protein +FIG01316323 FIG00350857: hypothetical protein +FIG01316325 SpoIISA like protein +FIG01316330 FIG00468008: hypothetical protein +FIG01316332 FIG00350704: hypothetical protein +FIG01316333 FIG00624270: hypothetical protein +FIG01316343 PE family protein +FIG01316357 Uroporphyrin-III C/tetrapyrrole (Corrin/Porphyrin) methyltransferase +FIG01316358 putative ABC transporter integral membrane protein +FIG01316365 transposase of IS654-like element +FIG01316369 19 kDa lipoprotein antigen precursor +FIG01316387 FIG00384938: hypothetical protein +FIG01316388 FIG00822073: hypothetical protein +FIG01316389 COG3332 +FIG01316398 Sfa protein +FIG01316400 transporter, MFS superfamily +FIG01316403 phosphinothricin N-acetyltransferase +FIG01316405 FIG00764060: hypothetical protein +FIG01316421 Amidase, 6-aminohexanoate-cyclic-dimer hydrolase (EC 3.5.1.4) +FIG01316424 Cation-transporting ATPase +FIG01316428 cellular communication/signal transduction +FIG01316433 Electron transfer subunit protein +FIG01316440 Peptide chain release factor RF-3 +FIG01316446 FIG00361316: hypothetical protein +FIG01316456 FIG01160564: hypothetical protein +FIG01316464 FIG00424980: hypothetical protein +FIG01316476 probable exported protein YPO1624 +FIG01316480 PROBABLE CONSERVED TRANSMEMBRANE PROTEIN +FIG01316488 Carbon storage regulator (could also regulate swarming and quorum sensing) +FIG01316497 FIG01231848: hypothetical protein +FIG01316507 Possible outer membrane protein +FIG01316511 PTS system, nitrogen regulatory component IIA, putative +FIG01316523 HNH endonuclease +FIG01316525 PUTATIVE GLUCOSE-FRUCTOSE OXIDOREDUCTASE OXIDOREDUCTASE PROTEIN( EC:1.1.99.28 ) +FIG01316539 Ferric anguibactin-binding protein +FIG01316545 Ketosteroid isomerase homolog +FIG01316546 FIG051971: hypothetical protein +FIG01316547 FIG00564112: hypothetical protein +FIG01316549 FIG00768575: hypothetical protein +FIG01316552 Integral membrane domain protein +FIG01316558 FIG00767468: hypothetical protein +FIG01316559 Membrane-bound protoheme IX biogenesis protein, HemY +FIG01316564 Type I restriction-modification system specificity subunit +FIG01316568 Formamidase (EC 3.5.1.49) +FIG01316570 FIG00991410: hypothetical protein +FIG01316578 ATP-binding region, ATPase-like:Histidine kinase A, N-terminal +FIG01316595 probable membrane protein YPO1468 +FIG01316596 DUF378 domain-containing protein +FIG01316599 FIG00764499: hypothetical protein +FIG01316600 DNA modification methylase (Adenine-specific methyltransferase) (EC 2.1.1.72) +FIG01316602 putative phage transcriptional regulator +FIG01316605 Involved in lipopolysaccharide biosynthesis +FIG01316610 alternate gene name: ytbB +FIG01316615 MULTIPLE SUGAR-BINDING PERIPLASMIC RECEPTOR CHVE PRECURSOR +FIG01316616 Campylobacter invasion antigen B (CiaB) +FIG01316627 FIG00351404: hypothetical protein +FIG01316638 TnpA +FIG01316639 Competence-associated EpuA protein +FIG01316640 FIG01062552: hypothetical protein +FIG01316641 FIG00426061: hypothetical protein +FIG01316643 Type IV secretory pathway, VirJ component +FIG01316651 Acetyltransferase (GNAT) family protein +FIG01316661 FIG00411445: hypothetical protein +FIG01316673 FIG00072885: hypothetical protein +FIG01316674 Periplasmic sugar-binding lipoprotein UspC +FIG01316677 Putative ABC amino acid transporter permease +FIG01316680 sulfatase domain protein +FIG01316693 DNA-directed RNA polymerase ECF-type sigma factor +FIG01316697 AmiS_UreI, AmiS/UreI family transporter +FIG01316701 FIG00405746: hypothetical protein +FIG01316706 putative periplasmic protein +FIG01316707 protein of unknown function DUF559 +FIG01316712 Adenosine deaminase (EC 3.5.4.4), alternative form +FIG01316725 sodium/alanine symporter family protein +FIG01316749 Putative excisionase +FIG01316768 FIG00424915: hypothetical protein +FIG01316769 PE-PGRS FAMILY PROTEIN +FIG01316772 FIG00408893: hypothetical protein +FIG01316773 FIG00351072: hypothetical protein +FIG01316778 Thioredoxin +FIG01316782 Invasion protein +FIG01316790 Capsular polysaccharide transcription antitermination protein, UpxY family +FIG01316794 Secreted protein EspD +FIG01316807 ABC-type multidrug/protein/lipid transport system, membrane ATPase component +FIG01316810 Putative fimbrial componenet +FIG01316813 Possible peroxidase bpoB (Non-haem peroxidase) (EC 1.11.1.-) +FIG01316821 Antigen polymerase O6 +FIG01316824 COG family: cell wall-associated hydrolases (invasion-associated proteins); PFAM_ID: NLPC_P60 +FIG01316826 Patatin family protein (EC 3.1.1.4) +FIG01316829 putative sodium/glutamate symporter +FIG01316837 multi-component regulatory system-5 +FIG01316843 fosmidomycin resistance protein +FIG01316846 Phage transcriptional activator +FIG01316855 2-dehydro-3-deoxy-phosphogluconate aldolase +FIG01316861 Putative O-methyltransferase +FIG01316862 phospholipid/glycerol acyltransferase +FIG01316880 Phage family integrase +FIG01316881 Lanosterol 14-alpha demethylase @ Cytochrome P450 51 (EC 1.14.13.70) +FIG01316886 putative transmembran protein +FIG01316911 gene 11-1 protein precursor +FIG01316919 Histidine triad (HIT) nucleotide-binding protein, cyanobacterial subgroup +FIG01316922 methylase +FIG01316931 minor extracellular protease VpR +FIG01316936 microcin immunity protein MccF +FIG01316937 NAD-dependent oxidoreductase +FIG01316940 conserved hypothetical protein TIGR00661 +FIG01316942 RIO1 protein +FIG01316943 corresponds to STY2919 from Accession AL513382: Salmonella typhi CT18 +FIG01316944 ExoD protein +FIG01316948 FIG00442552: hypothetical protein +FIG01316958 ABC transporter, solute-binding protein +FIG01316975 Collagen triple helix repeat protein +FIG01316992 FIG00510550: hypothetical protein +FIG01317004 HAD-superfamily subfamily IIA hydrolase, hypothetical 2 +FIG01317036 Spore coat protein +FIG01317044 possible outer surface protein +FIG01317046 FIG00353955: hypothetical protein +FIG01317054 FIG00820882: hypothetical protein +FIG01317057 Leucine-rich repeat protein +FIG01317059 FIG00352275: hypothetical protein +FIG01317061 FIG00514404: hypothetical protein +FIG01317064 Outer membrane protein 26 +FIG01317070 FIG00350224: hypothetical protein +FIG01317076 putative transferase/hydrolase +FIG01317077 FIG00351753: hypothetical protein +FIG01317082 YSIRK Gram-positive signal peptide +FIG01317083 adenylate/guanylate cyclase +FIG01317093 Peptidase S24 S26A and S26B +FIG01317118 FIG01116726: hypothetical protein +FIG01317121 FIG00405371: hypothetical protein +FIG01317132 Putative transposase +FIG01317133 23Sr RNA gene +FIG01317146 Transcriptional activator protein LuxR +FIG01317147 Cation transport ATPase +FIG01317149 BNR/Asp-box repeat protein +FIG01317153 DNA transformation competancy +FIG01317162 B. burgdorferi predicted coding region BB0475 +FIG01317163 Endo-1,4-beta-xylanase Z precursor +FIG01317167 hydrolase, alpha/beta fold family +FIG01317170 Putative salt-induced outer membrane protein +FIG01317174 FIG00405367: hypothetical protein +FIG01317176 Truncated replication protein for pUB110 plasmid +FIG01317181 FIG00642900: hypothetical protein +FIG01317186 FIG01114631: hypothetical protein +FIG01317187 SUGAR TRANSPORT SYSTEM PERMEASE PROTEIN +FIG01317194 FIG00814918: hypothetical protein +FIG01317198 GTPase (EC 3.6.1.-) +FIG01317206 alcohol dehydrogenase subunit III +FIG01317209 Possible DnaJ domain +FIG01317210 aspartyl protease-like protein +FIG01317215 FIG00937838: hypothetical protein +FIG01317216 FIG00384980: hypothetical protein +FIG01317218 FIG00672880: hypothetical protein +FIG01317233 Predicted transporter component +FIG01317237 PUTATIVE LIPASE TRANSMEMBRANE PROTEIN +FIG01317247 putative, Na(+) H(+) antiporter subunit B +FIG01317251 putative transporter +FIG01317261 Transposase +FIG01317263 NifU-related domain containing protein +FIG01317269 Metabolite transport protein +FIG01317284 Predicted kinase +FIG01317285 Capsular synthesis regulator component B +FIG01317294 Transcriptional regulator, MecI family +FIG01317295 FIG00384928: hypothetical protein +FIG01317299 FIG00733398: hypothetical protein +FIG01317302 Leucyl-tRNA synthetase-like protein in Burkholderia mallei group +FIG01317307 spore germination protein GerPF-like protein +FIG01317308 conserved hypothetical transport protein +FIG01317315 Copper-transporting ATPase +FIG01317327 FIG01046130: hypothetical protein +FIG01317335 FIG00977867: hypothetical protein +FIG01317353 FIG00624043: hypothetical protein +FIG01317362 FIG01061167: hypothetical protein +FIG01317370 hypothetical repressor protein +FIG01317372 Hypothetical MW0753 homolog in superantigen-encoding pathogenicity islands SaPI +FIG01317376 Antitoxin of toxin-antitoxin stability system +FIG01317386 conserved hypothetical protein; putative exported protein +FIG01317400 Lhr +FIG01317403 Hypothetical ABC transporter ATP-binding protein yddA +FIG01317415 Haloacid dehalogenase/epoxide hydrolase family +FIG01317417 peptidase, U32 family small subunit [C1] +FIG01317421 Secretion system chaparone SscB +FIG01317425 probable membrane protein STY0526 +FIG01317427 Heat shock protein C +FIG01317445 FIG00673103: hypothetical protein +FIG01317478 phage transcriptional repressor +FIG01317479 conserved domain protein +FIG01317482 FIG00351094: hypothetical protein +FIG01317484 Pyridine nucleotide-disulphide oxidoreductase family protein associated with PFOR +FIG01317486 phosphoglycerate mutase family protein +FIG01317487 Putative dimeric protein +FIG01317488 Lactonase Drp35 (EC 3.1.1.-) +FIG01317493 Probable phiRV1 phage protein +FIG01317501 FIG005119: putative inner membrane protein +FIG01317512 Conserved secreted protein +FIG01317516 Autoinducer synthase BpsI +FIG01317525 FIG00764743: hypothetical protein +FIG01317528 predicted dienelactone hydrolase +FIG01317529 Putative phosphosugar isomerase +FIG01317537 Alpha-glucosidase( EC:3.2.1.20 ) +FIG01317538 Oligoendopeptidase F (EC 3.4.24.-) +FIG01317541 IS861, transposase OrfB +FIG01317545 FIG00406732: hypothetical protein +FIG01317550 Hypothetical protein SAV2132 +FIG01317565 FIG00624375: hypothetical protein +FIG01317573 Mobile element protein +FIG01317574 Tuberculin related peptide +FIG01317579 Hypothetical protein SAV2314 +FIG01317592 Amino-acid carrier protein AlsT +FIG01317594 colicin immunity protein +FIG01317611 FIG01021904: hypothetical protein +FIG01317613 Mll1902 protein +FIG01317614 DUF1440 domain-containing membrane protein +FIG01317617 Two-component response regulator vanRB +FIG01317621 Auxin efflux carrier family protein +FIG01317636 PTS system, IIA component +FIG01317637 POSSIBLE RHAMNOSYL TRANSFERASE WBBL2 +FIG01317643 FIG01063709: hypothetical protein +FIG01317644 putative glycerophosphoryl diester phosphodiesterase +FIG01317646 nuclease (SNase domain protein) +FIG01317651 Probable bifunctional P-450/NADPH-P450 reductase CypD +FIG01317658 FIG00622884: hypothetical protein +FIG01317665 hypothetical protein +FIG01317667 ABC transporter membrane-spanning permease - amino acid transport +FIG01317673 Protease +FIG01317680 A component of zinc uptake system +FIG01317682 Transcriptional Regulator, AraC family +FIG01317683 Serine/Threonine protein kinase and Signal Transduction Histidine Kinase (STHK) with GAF and PAS/PAC sensor (EC 2.7.1.117) +FIG01317690 Phosphotransferase system, mannose/fructose-specific component IIA +FIG01317698 FIG00832379: hypothetical protein +FIG01317699 Phospholipase C +FIG01317702 C-5 sterol desaturase (EC 1.3.-.-) +FIG01317703 ABC-type multidrug transport system, ATPase component +FIG01317711 exclusion of bacteriophage Ap1 +FIG01317712 FIG00426429: hypothetical protein +FIG01317716 FIG00823081: hypothetical protein +FIG01317726 FIG00841515: hypothetical protein +FIG01317734 B. burgdorferi predicted coding region BB0404 +FIG01317741 Thioredoxin-like protein TxlA +FIG01317742 Cyclopentanol dehydrogenase (EC 1.1.1.163) +FIG01317744 Putative xylanase +FIG01317747 FIG00344294: hypothetical protein +FIG01317748 Probable HTH-type transcriptional regulator endR +FIG01317753 Gas vesicle structural protein (GVP) +FIG01317758 Glycosyl transferase, family 2, (EC 2.4.1.-) +FIG01317761 putative derepression protein +FIG01317768 Possible dnaJ-like protein +FIG01317775 FIG00404887: hypothetical protein +FIG01317780 cag pathogenicity island protein Z +FIG01317785 FIG00353866: hypothetical protein +FIG01317788 NADH peroxidase Npx (EC 1.11.1.1) +FIG01317789 capsule biosynthesis protein capA +FIG01317825 TRAG family protein +FIG01317833 FIG00402715: hypothetical protein +FIG01317835 FIG00412037: hypothetical protein +FIG01317838 FIG00753333: hypothetical protein +FIG01317839 phosphoglycolate phosphatase +FIG01317845 COGs COG3216 +FIG01317857 FIG00823856: hypothetical protein +FIG01317864 protein of unknown function UPF0157 +FIG01317865 Glycosyl transferase, family 3 +FIG01317867 Pathogenicity island encoded protein: SPI3 +FIG01317879 Putative ATL autolysin transcription regulator +FIG01317882 hyothetical protein +FIG01317892 putative phage repressor +FIG01317898 GlcNAc phosphomutase (EC 5.4.2.3) +FIG01317901 Laminin-binding surface protein +FIG01317902 FIG00905767: hypothetical protein +FIG01317904 Phosphohistidine phosphatase SixA (EC 3.1.3.-) +FIG01317910 FIG00350595: hypothetical protein +FIG01317916 Outer membrane protein OmpU +FIG01317922 Re face-specific citrate synthase (EC 2.3.3.3) +FIG01317924 Pathogenicity determinant protein D +FIG01317931 fimbrial chaperone protein +FIG01317933 Peptidase M64 +FIG01317936 Branched-chain amino acid transport protein azlD +FIG01317937 site-specific recombinase, resolvase family, putative +FIG01317940 FIG00848148: hypothetical protein +FIG01317953 FIG00518980: hypothetical protein +FIG01317958 Exotoxin 10 +FIG01317961 syc1962_c +FIG01317963 Tryptophan halogenase +FIG01317966 COG1649 predicted glycoside hydrolase +FIG01317994 FIG00733574: hypothetical protein +FIG01317995 peptidyl-prolyl cis-trans isomerase, FKBP-type +FIG01318003 Isoflavone_redu, Isoflavone reductase +FIG01318005 PHA synthase subunit +FIG01318011 FIG00640449: hypothetical protein +FIG01318018 Lipoprotein-related protein +FIG01318030 periplasmic serine protease DO +FIG01318042 Putative uncharacterized protein BCG_3881 +FIG01318047 3-oxosteroid 1-dehydrogenase (EC 1.3.99.4) +FIG01318050 FIG00411811: hypothetical protein +FIG01318053 FIG00743012: hypothetical protein +FIG01318054 Putative sugar transport protein +FIG01318059 FIG00570570: hypothetical protein +FIG01318085 Putative phosphosugar-binding protein +FIG01318087 FIG00412221: hypothetical protein +FIG01318093 SepQ +FIG01318104 transposase +FIG01318109 Arginine:pyruvate transaminase +FIG01318112 FIG00350862: hypothetical protein +FIG01318115 CELL SURFACE PROTEIN +FIG01318133 Na+/Ca+ exchange protein, putative +FIG01318136 PROBABLE CONSERVED LIPOPROTEIN LPPF +FIG01318144 Rieske (2Fe-2S) domain-containing protein +FIG01318146 hydrolase (secreted protein) +FIG01318150 FIG00350323: hypothetical protein +FIG01318151 Putative fimbrial structural subunit +FIG01318161 Xylitol dehydrogenase +FIG01318172 FIG00468763: hypothetical protein +FIG01318174 DksA-type zinc finger protein +FIG01318181 C4-dicarboxylate anaerobic carrier, putative +FIG01318191 Asp-tRNAAsn/Glu-tRNAGln amidotransferase B subunit (PET112 homolog) +FIG01318196 regulatory protein +FIG01318209 Purple acid phosphatase/fibronectin domain protein +FIG01318225 glycosyl transferase, group 2 family protein domain protein +FIG01318236 Hypothetical protein SAV2141 +FIG01318246 Transposase, mutator type +FIG01318254 Possible L-Asparaginase II +FIG01318255 vanZ family protein +FIG01318256 FIG00409287: hypothetical protein +FIG01318260 FIG00648172: hypothetical protein +FIG01318263 putative alpha-N-acetylgalactosaminidase +FIG01318272 FIG00385155: hypothetical protein +FIG01318273 FIG00350410: hypothetical protein +FIG01318274 Thioredoxin +FIG01318276 ketopantoate reductase PanE/ApbA +FIG01318281 Transmembrane transport protein MmpL family +FIG01318284 FIG00822794: hypothetical protein +FIG01318293 FIG00629364: hypothetical protein +FIG01318296 Tellurite resistance protein TerB +FIG01318320 FOG: CheY-like receiver +FIG01318321 OstA family organic solvent tolerance protein +FIG01318324 Putative chemotaxis protein CheY +FIG01318326 Periplasmic protein TonB, links inner and outer membranes +FIG01318332 hypothetical protein +FIG01318337 FIG00534614: hypothetical protein +FIG01318359 Hypothetical protein, PV83 orf12 homolog [SA bacteriophages 11, Mu50B] +FIG01318361 FIG00733647: hypothetical protein +FIG01318367 POSSIBLE PARA-NITROBENZYL ESTERASE (FRAGMENT) +FIG01318376 FIG01206059: hypothetical protein +FIG01318380 FIG00638580: hypothetical protein +FIG01318383 FIG00750858: hypothetical protein +FIG01318388 FIG00352351: hypothetical protein +FIG01318398 Membrane protein involved in the export of O-antigen, teichoic acid lipoteichoic acids +FIG01318400 MscS family mechanosensitive ion channel +FIG01318402 Hypothetical protein SAV2184 +FIG01318408 FIG00642671: hypothetical protein +FIG01318409 pXO1-133 +FIG01318417 GDP-mannose 4,6 dehydratase (EC 4.2.1.47) +FIG01318428 RNA binding protein +FIG01318442 RevS +FIG01318444 VrlI homologue +FIG01318452 Putative merR family bacterial regulatory protein +FIG01318458 FIG00946381: hypothetical protein +FIG01318463 Chain A, Crystal Structure Of Yfir, A Putative Transcriptional Regulator From Bacillus Subtilis +FIG01318484 FIG00644977: hypothetical protein +FIG01318494 Putative transcriptional regulator +FIG01318499 Putative acetoin utilization protein AcuB +FIG01318500 alcohol dehydrogenase, zinc-containing +FIG01318504 Enterochelin esterase +FIG01318506 DUF1871 domain-containing protein +FIG01318507 insertion element protein +FIG01318510 FIG043818: putative DNA binding protein +FIG01318516 Putative protein-S-isoprenylcysteine methyltransferase +FIG01318521 Putative transporter, DME family +FIG01318524 Gns protein +FIG01318528 alpha-rhamnosidase +FIG01318534 rhamnogalacturonase B +FIG01318535 FIG00349011: hypothetical protein +FIG01318542 FIG00351164: hypothetical protein +FIG01318545 FIG00350158: hypothetical protein +FIG01318551 Probable ABC transport protein, ATP-binding protein +FIG01318554 FIG00351054: hypothetical protein +FIG01318561 putative ATP binding site +FIG01318569 ABC-type iron (III) transport system, ATPase component +FIG01318574 DNA polymerase, DinB family +FIG01318575 Phage integrase (Site-specific recombinase) +FIG01318585 FIG00781656: hypothetical protein +FIG01318595 probable sugar transferase YPO0186 +FIG01318619 Uncharacterized protein MJ0496 +FIG01318622 nucleoside transport protein +FIG01318631 FIG00946467: hypothetical protein +FIG01318641 F200 +FIG01318647 hypothetical protein +FIG01318650 Pseudouridylate synthases, 23S RNA-specific +FIG01318653 Acetylpolyamine aminohydrolase +FIG01318655 FIG00850446: hypothetical protein +FIG01318656 Holliday junction resolvasome, helicase subunit +FIG01318680 FIG00633314: hypothetical protein +FIG01318683 Possible benzoquinone methyltransferase +FIG01318696 HesA/MoeB/ThiF family protein +FIG01318700 Poor database matches. Doubtful CDS +FIG01318703 Peptidase, M13 family +FIG01318705 FIG00624334: hypothetical protein +FIG01318712 [Acyl-carrier-protein] acetyl transferase of FASI (EC 2.3.1.38) / Enoyl-[acyl-carrier-protein] reductase of FASI (EC 1.3.1.9) / 3-hydroxypalmitoyl-[acyl-carrier-protein] dehydratase of FASI (EC 4.2.1.61) / [Acyl-carrier-protein] malonyl transferase of FASI (EC 2.3.1.39) / [Acyl-carrier-protein] palmitoyl transferase of FASI (EC 2.3.1.-) / Acyl carrier protein of FASI / 3-oxoacyl-[acyl-carrier-protein] reductase of FASI (EC 1.1.1.100) / 3-oxoacyl-[acyl-carrier-protein] synthase of FASI (EC 2.3.1.41) +FIG01318714 FIG00817341: hypothetical protein +FIG01318718 Possible integral membrane protein +FIG01318719 Two-component response regulator +FIG01318726 FIG00407938: hypothetical protein +FIG01318733 Putative fimbrial-like protein +FIG01318737 Sulfotransferase +FIG01318743 Hypothetical protein SAV2044 +FIG01318744 Succinate-semialdehyde dehydrogenase [NAD(P)+] (EC 1.2.1.16) +FIG01318756 Structural protein, phage associated +FIG01318762 Menaquinone biosynthesis related protein MenX +FIG01318765 Uncharacterized protein yjfZ +FIG01318770 FIG00355215: hypothetical protein +FIG01318775 3-ketoacyl-CoA thiolase (EC 2.3.1.16) @ Acetyl-CoA acetyltransferase (EC 2.3.1.9) +FIG01318777 FIG00425848: hypothetical protein +FIG01318780 FIG01070512: hypothetical protein +FIG01318784 transcriptional regulator, CarD family +FIG01318785 cell division control protein 27, putative +FIG01318789 hypothetical protein +FIG01318791 Oxidoreductase (flavoprotein) +FIG01318800 Protein YaiC +FIG01318808 Heat shock protein +FIG01318809 possible diacylglycerol kinase +FIG01318826 Ribose transport system permease protein rbsC +FIG01318831 Cytotoxic translational repressor of toxin-antitoxin stability system +FIG01318848 Putative metal-dependent hydrolase BCE33L2441 (EC 3.-.-.-) +FIG01318850 L-carnitine dehydratase/bile acid-inducible protein F +FIG01318859 Putative uncharacterized protein spr0085 +FIG01318864 DinB family protein +FIG01318870 DnaJ homolog subfamily B member 6 +FIG01318878 Major facilitator superfamily (MFS) transport protein +FIG01318879 COG0546: Predicted phosphatases +FIG01318880 intracellular proteinase inhibitor BsuPI +FIG01318888 immunoreactive 14 kDa protein BA14k +FIG01318892 putative sensor-like histidine kinase +FIG01318894 Uncharacterized protein gp7 (Protein E6) +FIG01318916 FIG00353355: hypothetical protein +FIG01318923 Serine/threonine specific protein phosphatase 2 (EC 3.1.3.16) +FIG01318934 FIG00351548: hypothetical protein +FIG01318946 carboxymuconolactone decarboxylase +FIG01318950 FIG00846768: hypothetical protein +FIG01318953 ABC-type sugar transport system, ATPase component +FIG01318956 FIG01234543: hypothetical protein +FIG01318961 Putative acyl carrier protein +FIG01318963 Glycosyl transferase, group 2 family protein, a member of the cellulose synthase superfamily +FIG01318964 Putative fructose-1,6-bisphosphatase or related enzymes of inositol monophosphatase family +FIG01318967 glutamyl endopeptidase precursor +FIG01318971 Nonheme iron-containing ferritin +FIG01318973 Rare lipoprotein A +FIG01318976 peptide/opine/nickel uptake ABC transporter (PepT) family, ATP-binding protein +FIG01318978 ATPases involved in chromosome partitioning +FIG01318981 Alpha-hemolysin precursor +FIG01318986 FIG00404507: hypothetical protein +FIG01318998 FIG00390128: hypothetical protein +FIG01319003 FIG00824120: hypothetical protein +FIG01319018 Putative uncharacterized protein BCG_1966 +FIG01319020 FIG00624008: hypothetical protein +FIG01319024 3-carboxymuconate cyclase +FIG01319025 Glucarate transporter +FIG01319027 Probable serine/threonine-protein kinase pknB (EC 2.7.11.1) +FIG01319028 Putative transport sensor protein +FIG01319031 FIG012639: hypothetical Membrane Spanning Protein +FIG01319033 enhanced entry protein EnhC +FIG01319035 putative IS1 encoded protein +FIG01319041 Secretion system effector SseD +FIG01319052 Zinc finger domain-containing protein +FIG01319055 Ribonucleotide reductase, alpha subunit +FIG01319061 putative tetratricopeptide repeat family protein +FIG01319064 protein TolB +FIG01319067 Sodium/di- and tricarboxylate cotransporter +FIG01319069 FIG00723626: hypothetical protein +FIG01319075 Oleate hydratase (EC 4.2.1.53) +FIG01319077 Acid phosphatase precursor +FIG01319084 FIG00380724: hypothetical protein +FIG01319095 FIG00350345: hypothetical protein +FIG01319097 cag pathogenicity island protein (cag1) +FIG01319101 DNA topoisomerase (ATP-hydrolyzing), subunit B +FIG01319106 FIG00641620: hypothetical protein +FIG01319114 FIG00688502: hypothetical protein +FIG01319118 Chloramphenicol resistance protein +FIG01319119 DGPFAETKE domain-containing protein +FIG01319126 Hipothetical membrane protein +FIG01319128 putative iron-regulated membrane protein +FIG01319132 FIG01121868: secreted protein +FIG01319150 putative amino acid transport protein +FIG01319154 Unknown function. +FIG01319161 Ycf84 protein +FIG01319185 putative large integral membrane protein +FIG01319186 FIG00424766: hypothetical protein +FIG01319204 glutaredoxin family protein +FIG01319211 conserved hypothetical protein, putative protein kinase +FIG01319212 FKBP-type peptidyl-prolyl cis-trans isomerase / Macrophage infectivity potentiator +FIG01319222 FIG00355788: hypothetical protein +FIG01319223 NADH dehydrogenase subunit 4, Involved in CO2 fixation +FIG01319231 Probable ATP-dependent helicase lhr (EC 3.6.1.-) +FIG01319234 FIG00350389: hypothetical protein +FIG01319239 Alr5253 protein +FIG01319241 FIG00414938: hypothetical protein +FIG01319244 FIG00767678: hypothetical protein +FIG01319250 Quinohemoprotein amine dehydrogenase gamma subunit (EC 1.4.99.-) +FIG01319252 FIG00411920: hypothetical protein +FIG01319261 rhodanese-related sulfurtransferase +FIG01319267 Uncharactecterized conserved membrane protein, possible ABC-type MDR permease +FIG01319271 FIG00526516: hypothetical protein +FIG01319272 putative 5'(3')-deoxyribonucleotidase +FIG01319276 Metallo-beta-lactamase superfamily protein +FIG01319281 Acyl-ACP thioesterase +FIG01319291 ABC transporter, substrate binding protein [oligopeptide] [KO:K02035] +FIG01319297 FIG00765496: hypothetical protein +FIG01319299 IS3 orf2 +FIG01319300 FIG00765044: hypothetical protein +FIG01319302 Corrinoid methyltransferase protein +FIG01319303 subtilase family peptidase +FIG01319309 probable oxidoreductase/Short-chain dehydrogenase +FIG01319326 Hypothetical protein yqgB +FIG01319327 FIG00849028: hypothetical protein +FIG01319346 PUTATIVE TRANSMEMBRANE PROTEIN +FIG01319353 chitinase +FIG01319357 CONSERVED 13E12 REPEAT FAMILY PROTEIN +FIG01319359 DnaK suppressor protein +FIG01319360 Heat shock protein htpG +FIG01319362 Secretory antigen SsaA homolog +FIG01319365 FIG00350411: hypothetical protein +FIG01319367 putative carboxylesterase/lipase +FIG01319368 FIG016527: hypothetical protein +FIG01319369 HD phosphohydrolase-like protein +FIG01319387 FIG00350145: hypothetical protein +FIG01319390 FIG00385216: hypothetical protein +FIG01319395 FIG00350483: hypothetical protein +FIG01319398 MATE efflux family protein DinF +FIG01319407 COG1502: Phosphatidylserine/phosphatidylglycerophosphate/cardiolipi n synthases and related enzymes +FIG01319420 Putative DNA-binding protein +FIG01319421 FIG00639450: hypothetical protein +FIG01319451 Putative glycerophosphate (or ribitol phosphate) transferase relatede to lipopolysaccharide core biosynthesis +FIG01319465 FIG00412153: hypothetical protein +FIG01319468 putative TonB-dependent receptor +FIG01319482 Phage protein +FIG01319489 Similar to cobalamin biosynthesis protein CbiB +FIG01319491 FIG01202022: hypothetical protein +FIG01319494 FIG00385226: hypothetical protein +FIG01319496 FIG00733764: hypothetical protein +FIG01319497 Lactone-specific esterase +FIG01319504 FIG00350055: hypothetical protein +FIG01319517 Thermolysin precursor (EC 3.4.24.27) +FIG01319520 FIG00559050: hypothetical protein +FIG01319522 hypothetical protein with possible nucleotidyltransferase domain +FIG01319523 FIG00354137: hypothetical protein +FIG01319525 putative STAS domain protein +FIG01319532 Outer membrane liproprotein mapA precursor +FIG01319536 FIG01046667: hypothetical protein +FIG01319539 ankyrin-related protein +FIG01319544 ergothioneine biosynthesis PLP enzyme EgtE +FIG01319546 putative bi-functional transferase/deacetylase +FIG01319550 transcriptional regulator, ArsR family +FIG01319551 FIG00639755: hypothetical protein +FIG01319553 Glutamine ABC transporter, periplasmic glutamine-binding protein (TC 3.A.1.3.2) / Glutamine transport system permease protein GlnP (TC 3.A.1.3.2) +FIG01319555 Orf5 +FIG01319566 Multi antimicrobial extrusion (MATE) family transporter +FIG01319569 FIG00411228: hypothetical protein +FIG01319570 hypothetical protein Rv2237 +FIG01319579 hypothetical CDS +FIG01319585 Invasion gene E protein (Pathogenicity island encoded protein: homologous to ipgE of Shigella) +FIG01319606 FIG00766895: hypothetical protein +FIG01319624 Isochorismatase hydrolase family protein +FIG01319636 FIG00849505: hypothetical protein +FIG01319640 sugar and carbohydrate transporters +FIG01319654 (U95165) OrfY +FIG01319660 FIG01165888: hypothetical protein +FIG01319667 protein of unknown function DUF1223 +FIG01319671 Mobilization protein B +FIG01319672 probable copper-binding protein +FIG01319682 Probable sugar-transport integral membrane protein ABC transporter +FIG01319685 Gfa-like protein +FIG01319700 universal stress protein family +FIG01319704 FIG00820737: hypothetical protein +FIG01319712 FIG00850882: hypothetical protein +FIG01319728 Fimbrial protein pilin +FIG01319740 Hypothetical protein SAV1798 +FIG01319741 Metallo-beta-lactamase family protein +FIG01319747 RarD protein +FIG01319751 FIG00364066: hypothetical protein +FIG01319759 FIG00945201: hypothetical protein +FIG01319768 Oligogalacturonide transporter +FIG01319776 FIG00672439: hypothetical protein +FIG01319777 FIG00351225: hypothetical protein +FIG01319779 Uncharacterized protein MJ0835.2 +FIG01319793 FIG00404554: hypothetical protein +FIG01319802 YbjC protein, clustered with oxygen-insensitive NADPH nitroreductase +FIG01319811 Hypothetical protein SAV1800 +FIG01319812 Bll5266 protein +FIG01319822 FIG00350089: hypothetical protein +FIG01319827 FIG00361972: hypothetical protein +FIG01319828 antigen, S2 +FIG01319837 Tyrosine phosphatase II superfamily protein +FIG01319838 4-amino-4-deoxy-L-arabinose transferase and related glycosyltransferases of PMT family +FIG01319845 FIG00946288: hypothetical protein +FIG01319856 ABC transporter MppL +FIG01319858 aldo/keto reductase family oxidoreductase +FIG01319866 FIG00347667: hypothetical protein +FIG01319875 Probable lipoprotein Cj1090c +FIG01319887 sensory box, GGDEF family protein +FIG01319889 Possible helicase +FIG01319890 FIG00361258: hypothetical protein +FIG01319891 Chaperone protein fimC precursor +FIG01319895 YdeB +FIG01319896 Low molecular weight heat shock protein +FIG01319900 FIG00346669: hypothetical protein +FIG01319903 CdsF +FIG01319907 4-oxalocrotonate tautomerase (EC 5.3.2.-); Xylose transport system permease protein xylH +FIG01319911 Phage-like element PBSX protein xkdG +FIG01319925 Pirin +FIG01319928 possible membrane fusion protein +FIG01319933 FIG01152353: hypothetical protein +FIG01319937 alternate gene name: ipa-20r +FIG01319939 probable DNA repair exonuclease +FIG01319940 serine/threonine kinase with two-component sensor domain +FIG01319941 Creatinine amidohydrolase +FIG01319948 Replication protein P +FIG01319958 LktB +FIG01319961 FtsK/SpoIIIE family protein Rv1784, component of ESX-1 secretion system +FIG01319965 AIDA autotransporter-like protein +FIG01319969 Kef-type K+ transport systems, membrane components +FIG01319972 FIG00384891: hypothetical protein +FIG01319979 RepB +FIG01319990 lysophospholipase-like family protein +FIG01319999 FIG00351573: hypothetical protein +FIG01320012 FIG00352133: hypothetical protein +FIG01320015 FIG00385422: hypothetical protein +FIG01320024 Putative holin protein +FIG01320038 B. burgdorferi predicted coding region BB0307 +FIG01320039 Hypothetical protein SAV1854 +FIG01320045 Iron-containing alcohol dehydrogenase +FIG01320056 Lysine exporter protein (LYSE/YGGA) precursor +FIG01320062 Asl7591 protein +FIG01320066 Thiol:disulfide interchange protein tlpA +FIG01320067 Phage-associated DNA primase (EC 2.7.7.-) +FIG01320070 SWI/SNF family helicase_1 +FIG01320078 FIG00350304: hypothetical protein +FIG01320081 hypothetical protein +FIG01320090 xenobiotic reductase A +FIG01320091 Streptogrisin-C precursor (EC 3.4.21.-) (Serine protease C) (SGPC) +FIG01320094 Putative uncharacterized protein YraL +FIG01320115 SWF/SNF family helicase +FIG01320119 M42 glutamyl aminopeptidase, cellulase +FIG01320122 DNA binding protein, putative +FIG01320124 Lipoprotein LpqJ +FIG01320131 Cro +FIG01320134 Two-component sensor kinase yycG (EC 2.7.3.-) +FIG01320143 possible ABC Mn(2+)/Zn(2+) transporter, permease component +FIG01320151 FIG00641790: hypothetical protein +FIG01320152 NAD dependent epimerase/dehydratase +FIG01320157 alternate gene name: yznA +FIG01320167 hypothetical protein +FIG01320168 possible alkaline shock protein +FIG01320182 Truncated-SA protein +FIG01320204 Transcriptional regulator, RpiR family +FIG01320210 Possible protease IV SppA (endopeptidase IV) (signal peptide peptidase) +FIG01320211 Periplasmic dsDNA and ssDNA-binding protein contributing to transformation +FIG01320216 Hemagglutinin +FIG01320222 Xaa-His dipeptidase (EC 3.4.13.3) +FIG01320228 phage/colicin/tellurite resistance cluster terY protein +FIG01320234 protein of unknown function DUF992 +FIG01320239 Drug resistance transporter +FIG01320242 FIG017897: Phage protein +FIG01320244 Dicarboxylate carrier protein +FIG01320246 IS1 transposase +FIG01320250 Proline-rich region +FIG01320255 ABC transporter, periplasmic sugar binding protein precursor +FIG01320268 spore peptidoglycan hydrolase (N-acetylglucosaminidase) (EC 3.2.1.-) +FIG01320282 Adenine-specific methyltransferase activity (EC 2.1.1.72) +FIG01320283 FIG00406678: hypothetical protein +FIG01320288 VapB23 protein (antitoxin to VapC23) +FIG01320296 Lipase (EC 3.1.1.3) +FIG01320318 Alpha-1,6-mannanase +FIG01320323 Enhanced entry protein EnhC +FIG01320325 Signaling protein with a periplasmic binding domain and GGDEF domain +FIG01320334 Predicted regulator for deoxynucleoside utilization, GntR family +FIG01320342 Secretion activator protein +FIG01320350 Putative uncharacterized protein FIG019238 +FIG01320357 2-keto-3-deoxy-6-phosphogluconate aldolase +FIG01320360 FIG01048137: hypothetical protein +FIG01320366 copper-ion-binding protein +FIG01320367 ATP-dependent exoDNAse (exonuclease V) beta subunit (contains helicase and exonuclease domains) +FIG01320374 trse-like protein +FIG01320378 FIG00408380: hypothetical protein +FIG01320379 glycogen branching enzyme +FIG01320386 Isopenicillin N synthase +FIG01320400 Cytochrome c peroxidase +FIG01320402 14 kDa antigen (16 kDa antigen) (HSP 16.3) +FIG01320407 Putative isomerase +FIG01320408 COG2271: Sugar phosphate permease +FIG01320415 Ribosyl nicotinamide transporter, PnuC-like +FIG01320432 staphylococcal accessory regulator A homologue +FIG01320433 FIG00349933: hypothetical protein +FIG01320438 TspO/MBR family protein +FIG01320440 Galactose-binding protein regulator +FIG01320443 Multidrug resistance efflux pump +FIG01320445 FIG00388332: hypothetical protein +FIG01320448 Bacterial/Archaeal transporter family protein +FIG01320452 Bicyclomycin resistance protein TcaB +FIG01320453 Conjugative transfer protein 123 +FIG01320457 FIG00632263: hypothetical protein +FIG01320461 FIG00764529: hypothetical protein +FIG01320463 PROBABLE RESUSCITATION-PROMOTING FACTOR RPFD +FIG01320465 cag pathogenicity island protein (cag9) +FIG01320466 Uncharacterized protein MJ0835 +FIG01320467 sodium/calcium exchanger protein +FIG01320468 Hypothetical protein SAV2178 +FIG01320469 Chemotaxis signal transduction protein +FIG01320476 Bll1294 protein +FIG01320481 Lipoprotein LprB +FIG01320482 ABC transporter ATP-bindng protein - possibly multidrug efflux, truncation +FIG01320495 putative HsdR +FIG01320501 IS21 family transposition helper protein +FIG01320511 Nucleoside diphosphate kinase regulator +FIG01320514 Putative haem-binding lipoprotein +FIG01320521 COGs COG0840 +FIG01320544 type I secretion system ATPase +FIG01320547 FIG00527511: hypothetical protein +FIG01320570 thiol-disulfide isomerase and thioredoxins +FIG01320576 FIG00350720: hypothetical protein +FIG01320578 Lipooligosaccharide cholinephosphotransferase( EC:2.7.8.- ) +FIG01320581 Type II restriction enzyme DpnI (dpnC) +FIG01320584 DNA polymerase, beta-like +FIG01320585 hypothetical nucleotidyltransferase +FIG01320598 phage protein lin1266 +FIG01320599 FIG00849084: hypothetical protein +FIG01320600 amino acid adenylation domain-containing protein( EC:5.1.1.11,EC:6.2.1.26 ) +FIG01320604 Metallo cofactor biosynthesis protein, conjectural +FIG01320608 enterotoxin family protein +FIG01320611 B. burgdorferi predicted coding region BB0138 +FIG01320632 FIG00385431: hypothetical protein +FIG01320634 PROBABLE REMNANT OF A TRANSPOSASE GENE PROTEIN +FIG01320635 FIG00355813: hypothetical protein +FIG01320637 hypothetical protein +FIG01320643 FIG00675199: hypothetical protein +FIG01320645 InterPro IPR003688 COGs COG3505 +FIG01320650 Thiopurine S-methyltransferase (EC 2.1.1.67) +FIG01320652 FIG00672241: hypothetical protein +FIG01320660 sodium-dependent transporter (huNaDC-1), putative +FIG01320661 Putative integral memnbrane protein +FIG01320662 TcpC +FIG01320663 FIG00403860: hypothetical protein +FIG01320665 Multisubunit Na+/H+ antiporter, MnhF subunit +FIG01320667 FIG00743472: hypothetical protein +FIG01320673 Listeria antigen LmaA +FIG01320678 Cell surface lipoprotein MPT83 precursor +FIG01320682 oxidoreductase, Gfo/Idh/MocA family +FIG01320703 FIG00765127: hypothetical protein +FIG01320708 FIG005030: hypothetical protein +FIG01320712 FIG00353265: hypothetical protein +FIG01320713 hypothetical protein +FIG01320721 similar to NrfA-putative nitrite reduction protein +FIG01320732 Oxidoreductase, short-chain dehydrogenase/reductase family +FIG01320737 Putative molecular chaperone, DnaJ family +FIG01320742 Repressor of toxins Rot +FIG01320748 FIG00408681: hypothetical protein +FIG01320752 prolipoprotein diacylglyceryl transferase family protein +FIG01320754 FIG00764667: hypothetical protein +FIG01320760 Xaa-Pro dipeptidase +FIG01320763 putative domain GGDEF protein +FIG01320767 FIG00766864: hypothetical protein +FIG01320775 (U62541) immunoreactive 14 kDa protein BA14k +FIG01320781 PROBABLE PROLINE AND GLYCINE RICH TRANSMEMBRANE PROTEIN +FIG01320782 FIG00638839: hypothetical protein +FIG01320784 FIG00765941: hypothetical protein +FIG01320789 Cytochrome P450 +FIG01320798 Hypothetical protein SAV2140 +FIG01320802 FIG013450: hypothetical protein +FIG01320811 FIG00343845: hypothetical protein +FIG01320812 Protein of unknown function DUF123 +FIG01320820 Microsomal dipeptidase precursor (EC 3.4.13.19) +FIG01320841 Putative uncharacterized protein YndJ +FIG01320848 2-oxoglutarate dehydrogenase complex, dehydrogenase component +FIG01320872 VapD-related protein +FIG01320877 Neuraminidase (sialidase) +FIG01320878 hypothetical protein +FIG01320880 Phosphoribosylcarboxyaminoimidazole (NCAIR) mutase +FIG01320885 Peptidoglycan hydrolase, Autolysin2 (EC 3.5.1.28) +FIG01320889 FIG00765159: hypothetical protein +FIG01320895 Histidyl-tRNA synthetase-related domain +FIG01320901 endo-1,4-beta-xylanase Z precursor +FIG01320912 Lipoprotein, similar to ferrichrome ABC transporter +FIG01320918 probable membrane protein NMA1176 +FIG01320919 PROBABLE CONSERVED LIPOPROTEIN LPQO +FIG01320931 Serine/threonine protein kinases +FIG01320947 BH2600 unknown conserved protein in B. subtilis +FIG01320950 Two-component response regulator yesN +FIG01320952 Glycerate kinase (EC 2.7.1.31) +FIG01320960 FIG00352393: hypothetical protein +FIG01320967 hypothetical protein +FIG01320969 Putative NADH-dependent flavin oxidoreductase +FIG01320973 type II secretion pathway related protein +FIG01320975 FIG00351133: hypothetical protein +FIG01320980 hypothetical secreted protein +FIG01320985 SN-glycerol-3-phosphate transport ATP-binding protein UgpC (TC 3.A.1.1.3) +FIG01320992 Hemolysin II regulator HlyIIR, TetR family +FIG01320997 Uncharacterized protein ygiV +FIG01321002 Intracellular PHB depolymerase +FIG01321024 Staphopain B precursor (EC 3.4.22.-) +FIG01321025 spermine/spermidine acetyltransferase blt +FIG01321026 FIG00389748: hypothetical protein +FIG01321035 ABC-type branched-chain amino acid transport system, periplasmic component +FIG01321040 Glycosyl transferase domain protein +FIG01321043 UPF0316 protein DP2912 +FIG01321045 Hypothetical protein, similar to glucose epimerase +FIG01321048 FIG00350035: hypothetical protein +FIG01321055 conserved hypothetical protein, putative membrane protein +FIG01321056 possible carbamoyl-phosphate synthase L chain +FIG01321058 NOL1/NOP2/sun family protein +FIG01321059 putative vacuolating cytotoxin (VacA) paralog +FIG01321071 FIG00644525: hypothetical protein +FIG01321075 FIG00571005: hypothetical protein +FIG01321093 Ferrous iron transporter protein B +FIG01321095 tRNA pseudouridine synthase B( EC:5.4.99.- ) +FIG01321097 BpoA +FIG01321100 probable transposase protein +FIG01321103 membrane protein yaiZ +FIG01321108 putative peptidoglycan linked protein (LPXTG motif) +FIG01321111 (Y14336) putative extracellular protein containing predicted 35aa signal peptide +FIG01321120 FIG00350110: hypothetical protein +FIG01321121 Probable tonB-dependent receptor yncD precursor +FIG01321122 FIG00526693: hypothetical protein +FIG01321123 FIG00403577: hypothetical protein +FIG01321124 Glycosyltransferase involved in cell wall biogenesis +FIG01321136 protein of unknown function DUF1289 +FIG01321139 Replicative helicase RepA +FIG01321145 CpeT homolog +FIG01321151 FIG00765589: hypothetical protein +FIG01321154 Type III secretion system SepZ protein +FIG01321157 FIG00643244: hypothetical protein +FIG01321158 RNA pseudouridine synthase family protein +FIG01321161 FIG00350921: hypothetical protein +FIG01321169 FIG00350072: hypothetical protein +FIG01321177 FIG01234096: hypothetical protein +FIG01321180 Hypothetical protein SAV1782 +FIG01321183 putative bacitracin synthetase 1; BacA +FIG01321184 FIG01044301: hypothetical protein +FIG01321189 putative lipase/esterase +FIG01321193 FIG00402702: hypothetical protein +FIG01321207 putative integral membrane protein (possible nuclease activity) +FIG01321230 FIG00766395: hypothetical protein +FIG01321241 PE_PGRS family protein +FIG01321255 FIG00458378: hypothetical protein +FIG01321257 putative two-component system sensor kinase( EC:2.7.3.- ) +FIG01321262 Hypothetical protein ywlB +FIG01321267 CBS-domain containing protein +FIG01321273 FIG00405147: hypothetical protein +FIG01321284 Iduronate-2-sulfatase (EC 3.1.6.13) +FIG01321288 Xylan oligosaccharide ABC transporter, permease component 1 +FIG01321293 putative ABC-2 type transporter +FIG01321305 FIG00687538: hypothetical protein +FIG01321310 VacJ like lipoprotein +FIG01321315 Ankyrin-repeat protein A +FIG01321317 FIG00768265: hypothetical protein +FIG01321320 NagD, Predicted sugar phosphatases of the HAD superfamily +FIG01321321 FIG00388852: hypothetical protein +FIG01321325 competence-induced protein Ccs4 +FIG01321338 FIG00352175: hypothetical protein +FIG01321347 B. burgdorferi predicted coding region BBB02 +FIG01321350 B. burgdorferi predicted coding region BB0654 +FIG01321356 FIG00351092: hypothetical protein +FIG01321357 PROBABLE CONSERVED LIPOPROTEIN LPQN +FIG01321373 FIG00769293: hypothetical protein +FIG01321383 putative DNA mismatch repair protein +FIG01321385 FIG00640688: hypothetical protein +FIG01321389 FIG01116279: hypothetical protein +FIG01321397 tryptophan halogenase, putative +FIG01321400 NA+/H+ antiporter (napA), putative +FIG01321403 Sensor protein (EC 2.7.13.3) +FIG01321404 Probable glutamate/gamma-aminobutyrate antiporter +FIG01321422 Transcriptional regulatory protein degU +FIG01321426 putative thioesterase +FIG01321436 conserved hypothetical protein; putative enzyme +FIG01321439 Pentapeptide repeat domain protein +FIG01321447 hypothetical protein Rv2227 +FIG01321460 ORF_f143 +FIG01321463 Putative peptidoglycan binding domain 1 +FIG01321467 FIG01231169: hypothetical protein +FIG01321471 3-Ketoacyl-ACP reductase +FIG01321478 CRISPR-associated protein Csc2 +FIG01321492 FIG00822959: hypothetical protein +FIG01321495 putative peroxidase +FIG01321503 Probable aspartoacylase (EC 3.5.1.15) +FIG01321525 Two-component response regulator-like protein +FIG01321527 phosphorylase family protein +FIG01321529 FIG00768479: hypothetical protein +FIG01321533 FIG00623069: hypothetical protein +FIG01321546 Ribosomal RNA small subunit methyltransferase C (EC 2.1.1.52) (rRNA (guanine-N(2)-)-methyltransferase) (16S rRNA m2G1207 methyltransferase) +FIG01321553 FIG070430: hypothetical protein +FIG01321557 FMN oxidoreductase CC3083 +FIG01321571 aa_permeases +FIG01321572 FOG: EAL domain protein +FIG01321577 Protein of unknown function DUF512 +FIG01321585 PE family protein +FIG01321592 Hypothetical protein SAV2317 +FIG01321594 aspartate racemase family protein +FIG01321595 PapI protein +FIG01321600 exclusion of bacteriophage Ap1 +FIG01321623 Cf-2.3 +FIG01321628 probable integral membrane protein NMA0300 +FIG01321629 putative outer membrane adhesin like proteiin +FIG01321633 Putative OMPA family outer membrane porin precursor +FIG01321636 RNA polymerase sigma factor SigS +FIG01321637 Metal transporter, ZIP family +FIG01321650 FIG00767965: hypothetical protein +FIG01321652 sensor histidine kinase/response regulator +FIG01321653 FIG01206134: hypothetical protein +FIG01321654 FIG00742845: hypothetical protein +FIG01321656 FIG01118502: hypothetical protein +FIG01321659 phage protein +FIG01321681 Transglutaminase-like enzymes, putative cysteine proteases +FIG01321682 hypothetical protein +FIG01321695 Superfamily I DNA/RNA helicase protein +FIG01321712 Tail fiber protein +FIG01321721 ORF049 +FIG01321732 GDP-L-fucose synthetase (EC 1.1.1.271) +FIG01321736 Uncharacterized membrane protein Bsu0528 (YdeO) +FIG01321743 AAA family ATPase +FIG01321746 transmembrane efflux protein +FIG01321747 Hypothetical CDS +FIG01321755 FIG00350642: hypothetical protein +FIG01321766 ATP-dependent DNA helicase rep (EC 3.6.1.-) +FIG01321768 Bsl0170 protein +FIG01321770 M23/M37 peptidase domain protein +FIG01321772 contains MutT-like domain +FIG01321778 ankyrin repeat domain protein +FIG01321780 FIG00408492: hypothetical protein +FIG01321789 putative lipopolysaccharide biosynthesis protein +FIG01321791 Excisionase +FIG01321799 RepFIB replication protein A +FIG01321807 Phage repressor +FIG01321810 Putative anti-sigma factor +FIG01321811 FIG01115259: hypothetical protein +FIG01321817 Quaternary ammonium compound-resistance protein SugE +FIG01321818 FIG00712950: hypothetical protein +FIG01321824 FIG00825588: hypothetical protein +FIG01321828 Replication initiation protein, topisomerase +FIG01321845 formate/nitrite transporter family protein +FIG01321856 transcription regulator, MerR family +FIG01321859 Oxidoreductase +FIG01321863 Two-component system regulator llrE +FIG01321864 FIG00406338: hypothetical protein +FIG01321872 Core component Dace_2067 of predicted ECF transporter +FIG01321880 HicA-related protein +FIG01321888 oxetanocin A resistance protein +FIG01321889 cag pathogenicity island protein (cag17) +FIG01321891 FIG00622941: hypothetical protein +FIG01321896 O-antigen acetylase WbiA +FIG01321900 TrsD +FIG01321912 FIG00350007: hypothetical protein +FIG01321921 FIG00920574: hypothetical protein +FIG01321924 FIG00414154: hypothetical protein +FIG01321927 Z-ring-associated protein +FIG01321928 LysR family transcriptional regulator YnfL +FIG01321934 FLJ00180 protein +FIG01321938 Carboxymuconolactone decarboxylase family protein +FIG01321942 FIG00411552: hypothetical protein +FIG01321948 FIG00426631: hypothetical protein +FIG01321954 Probable HesA/MoeB/ThiF family protein +FIG01321955 Probable aquaporin TIP4-3 (Tonoplast intrinsic protein 4-3) (OsTIP4;3) +FIG01321964 FIG00766097: hypothetical protein +FIG01321966 similar to glycosyltransferase involved capsular polysaccharide biosynthesis +FIG01321970 Orf10 +FIG01321973 Puromycin-sensitive aminopeptidase (EC 3.4.11.-) +FIG01321974 methylmalonyl CoA epimerase( EC:5.1.99.1 ) +FIG01321980 glycosyltransferase family 2 +FIG01321983 FIG00687683: hypothetical protein +FIG01321992 Two-component sensor histidine kinase, controling glutamine utilization +FIG01321995 FIG00424011: hypothetical protein +FIG01321997 Mannan endo-1,4-beta-mannosidase precursor (EC 3.2.1.78) +FIG01322001 FIG00519919: hypothetical protein +FIG01322002 ABC transporter, ATP-binding protein +FIG01322008 Possible secreted protein +FIG01322016 transposase, IS605 family +FIG01322021 FIG00405109: hypothetical protein +FIG01322026 S-layer protein / Peptidoglycan endo-beta-N-acetylglucosaminidase +FIG01322029 Nucleoside-triphosphate transporter, NTT2 +FIG01322038 Iron-dependent transcription repressor +FIG01322051 FIG00848655: hypothetical protein +FIG01322057 FIG00388769: hypothetical protein +FIG01322067 Cation-transporting ATPase, E1-E2 family +FIG01322074 Protein MbtH +FIG01322084 Ribosomal protein L5 domain protein +FIG01322090 prophage LambdaBa02, transcriptional regulator, AbrB family +FIG01322095 FIG00403299: hypothetical protein +FIG01322103 putative CaCA family, sodium/calcium exchanger +FIG01322106 Undecaprenyl pyrophosphate synthase +FIG01322108 putative DNA-binding protein (histone) +FIG01322110 Hemolysin III +FIG01322114 hypothetical protein +FIG01322119 FIG00624496: hypothetical protein +FIG01322120 CRISPR-associated protein, Csy2 family +FIG01322129 FIG042201: hypothetical protein +FIG01322141 FIG01017183: hypothetical protein +FIG01322143 Response regulator receiver domain protein (CheY) (EC 3.1.1.61) +FIG01322144 FIG00821765: hypothetical protein +FIG01322147 FIG01221295: hypothetical protein +FIG01322149 putative sigma-54-dependent transcriptional regulator (partial) +FIG01322168 lipoprotein LppV +FIG01322169 general secretion pathway protein H +FIG01322184 putative integrase +FIG01322185 FIG00822163: hypothetical protein +FIG01322192 hypothetical protein +FIG01322198 2-methyl-6-phytyl-1,4-benzoquinone methyltransferase / 2-methyl-6-solanyl-1,4-benzoquinone methyltransferase +FIG01322202 MISCELLANEOUS; Unknown +FIG01322214 FIG01029991: hypothetical protein +FIG01322215 FIG00385133: hypothetical protein +FIG01322217 putative hydrogenase +FIG01322223 Uncharacterized ABC transporter ATP-binding protein ywjA +FIG01322226 peptidyl-prolyl cis-trans isomerase, FKBP-type( EC:5.2.1.8 ) +FIG01322228 probable exported protein STY2149 +FIG01322233 CdsI +FIG01322235 Hypothetical protein SAV1896 +FIG01322249 FIG00424523: hypothetical protein +FIG01322255 Fatty acid degradation regulator YsiA, TetR family +FIG01322256 FIG00351613: hypothetical protein +FIG01322260 Probable zinc protease pqqL (EC 3.4.99.-) +FIG01322270 TerW +FIG01322273 Transcriptional regulator OrfX +FIG01322276 PepA +FIG01322282 FIG00957790: hypothetical protein +FIG01322286 FOG: TPR repeat protein, SEL1 subfamily +FIG01322300 FIG00350128: hypothetical protein +FIG01322303 FIG00860246: hypothetical protein +FIG01322314 Multidrug resistance ABC transporter ATP-binding and permease protein +FIG01322318 similar to 2-polyprenyl-3-methyl-5-hydroxy-6-metoxy-1 4-benzoquinol methylase +FIG01322319 ORF_ID:alr7561 unknown protein +FIG01322333 UPF0104 membrane protein MJ1078 +FIG01322334 3-alpha-hydroxysteroid dehydrogenase +FIG01322339 FIG00350312: hypothetical protein +FIG01322341 ABC transporter ecsA-like protein +FIG01322343 FIG00765580: hypothetical protein +FIG01322351 Alpha-1,2-N-acetylglucosamine transferase +FIG01322360 Sensory box protein/GGDEF/EAL domains +FIG01322362 Probable FecR, iron siderophore sensor protein +FIG01322374 Aldo/keto reductase +FIG01322378 Permease of the major facilitator superfamily +FIG01322383 FIG00515518: hypothetical protein +FIG01322394 Extracellular protease precursor (EC 3.4.21.-) +FIG01322397 FIG00461447: hypothetical protein +FIG01322400 Outer membrane protein E +FIG01322408 Apyrase (EC 3.6.1.5) +FIG01322411 FIG00424420: hypothetical protein +FIG01322413 hypothetical protein +FIG01322433 A3(2) GLYCOGEN METABOLISM CLUSTERI +FIG01322454 Na+-dependent transporters of the SNF family +FIG01322455 FIG00350330: hypothetical protein +FIG01322457 ComE-like protein, Metallo beta-lactamase superfamily hydrolase, secreted +FIG01322458 FIG00629312: hypothetical protein +FIG01322462 ThiJ/PfpI domain protein +FIG01322483 PTS system +FIG01322488 FIG00351057: hypothetical protein +FIG01322490 Avirulence AvrD-like protein +FIG01322501 Putative sgc region protein sgcX +FIG01322506 putative low temperature requirement A protein +FIG01322511 serine protease, DegP-HtrA family +FIG01322513 Zinc-regulated outer membrane receptor +FIG01322519 Hypothetical Membrane Spanning Protein +FIG01322527 PREDICTED: KIAA1205 [Source:RefSeq_peptide;Acc:XP_046305] +FIG01322532 adh_short, short chain dehydrogenase +FIG01322547 Alternative splicing could exist. 2 probable transmembrane helices predicted by TMHMM2.0 at aa 297-319 and 339-361 +FIG01322549 FIG00404313: hypothetical protein +FIG01322560 Nucleoside:H+ symporter:Major facilitator superfamily +FIG01322565 Streptomycin biosynthesis StrF domain protein +FIG01322566 Ferredoxin subunits of nitrite reductase and ring-hydroxylating dioxygenases +FIG01322568 FIG00641050: hypothetical protein +FIG01322573 subtilase family protein( EC:3.4.21.- ) +FIG01322575 ABC-transporter ATP-binding protein +FIG01322578 Molybdopterin converting factor, small subunit +FIG01322579 8-oxoguanine-DNA-glycosylase +FIG01322584 Large repetitive protein +FIG01322587 Isoniazid inductible protein IniB +FIG01322597 FIG00016288: hypothetical protein +FIG01322601 FIG00468387: hypothetical protein +FIG01322604 Sigma-F transcribed protein csfB +FIG01322616 FIG01234688: hypothetical protein +FIG01322617 FIG00633620: hypothetical protein +FIG01322620 disulfide interchange protein +FIG01322623 FIG01202222: hypothetical protein +FIG01322633 Heat shock protein HslJ +FIG01322634 macrophage activating lipoprotein-404 precursor +FIG01322647 UPF0089 protein Rv3130c/MT3216 +FIG01322652 FIG00361548: hypothetical protein +FIG01322657 Possible transmembrane protein +FIG01322660 LemA PROTEIN +FIG01322664 Probable secreted serine protease +FIG01322672 Exotoxin 13 +FIG01322679 ATP-NAD kinase (EC 2.7.1.23) +FIG01322684 Carbohydrate kinase, FGGY +FIG01322687 3/4-TMS conserved FUPA26-associated hypothetical protein +FIG01322692 NAD(P)H dehydrogenase, quinone family +FIG01322695 FIG013210: hypothetical protein +FIG01322699 FIG00528850: hypothetical protein +FIG01322700 Xylose operon regulatory protein +FIG01322702 similar to alkaline phosphatase phoA( EC:3.1.3.1 ) +FIG01322708 Peptidoglycan binding domain containing protein +FIG01322726 VapC2 antibacterial toxin protein +FIG01322739 Capsular polysaccharide synthesis enzyme Cap8D +FIG01322740 Uncharacterized protein MJ0187 +FIG01322742 Peptidoglycan hydrolase +FIG01322745 Amino acid ABC transporter, permease protein +FIG01322759 DUF458 domain-containing protein +FIG01322760 PEP/pyruvate binding domain protein +FIG01322761 FIG00347744: hypothetical protein +FIG01322767 Putative frv operon regulatory protein +FIG01322768 Homolog of Salmonella FimH protein +FIG01322770 FIG00954310: hypothetical protein +FIG01322782 ISLmo1, transposase OrfA +FIG01322783 Protein crcB homolog +FIG01322792 Enterobactin synthetase component F (EC 2.7.7.-) +FIG01322796 Outer membrane esterase +FIG01322803 GtrA family protein; MesH protein +FIG01322804 short-chain type dehydrogenase +FIG01322810 unsaturated glucuronyl hydrolase +FIG01322815 SinI homolog +FIG01322821 FIG00350985: hypothetical protein +FIG01322825 FIG00351046: hypothetical protein +FIG01322832 FIG00639640: hypothetical protein +FIG01322854 Phosphotransferase system IIA component +FIG01322856 IS1381, transposase OrfA +FIG01322865 Diadenosine tetraphosphatase and related serine/threonine protein phosphatases +FIG01322868 lipase +FIG01322870 Saccharopine dehydrogenase and related proteins +FIG01322874 secreted effector protein +FIG01322879 Manganese ABC transporter, ATP-binding protein SitB +FIG01322881 Alkaline protease secretion protein AprE +FIG01322883 rhamnogalacturonan acetylesterase +FIG01322885 FIG00640646: hypothetical protein +FIG01322903 NAD-dependent 4-hydroxybutyrate dehydrogenase (EC 1.1.1.61) +FIG01322910 putative arylsulfatase +FIG01322913 deoxyribodipyrimidine photolyase-related protein +FIG01322921 PTS system IIA 2 domain protein +FIG01322926 FIG00402950: hypothetical protein +FIG01322929 ABC transporter, ATP-binding protein +FIG01322935 FIG01228440: hypothetical protein +FIG01322937 MitM-related protein +FIG01322953 FIG01252029: hypothetical protein +FIG01322954 hypothetical protein +FIG01322959 FIG028593: membrane protein +FIG01322965 hypothetical protein +FIG01322985 FIG00821656: hypothetical protein +FIG01322987 FIG00408297: hypothetical protein +FIG01322989 Polysaccharide biosynthesis protein CsaA +FIG01323006 FIG00385563: hypothetical protein +FIG01323008 serine/threonine kinase, putative +FIG01323010 Serine/threonine protein phosphatase (EC 3.1.3.16) +FIG01323018 FIG01118032: hypothetical protein +FIG01323023 FIG00402748: hypothetical protein +FIG01323034 Transcriptional regulator, Cro/CI family +FIG01323038 Cold-active serine alkaline protease +FIG01323047 Quinolone resistance protein +FIG01323048 Raffinose operon transcriptional regulatory protein RafR +FIG01323051 Group-specific protein +FIG01323053 Uncharacterized conserved protein, YitT family +FIG01323066 Bactoprenol glucosyl transferase (EC 2.4.1.-) +FIG01323069 Probable transport protein +FIG01323075 Serine protease, subtilase family +FIG01323083 FIG01116603: hypothetical protein +FIG01323086 possible Na+/H+ antiporter, CPA1 family +FIG01323093 FIG00776115: hypothetical protein +FIG01323098 hypothetical protein Psyc020833 +FIG01323105 probable secreted protein homolog of yjcM/yhbB B. subtilis +FIG01323106 Hypothetical protein Cj0135 +FIG01323108 FIG00403651: hypothetical protein +FIG01323113 Amino acid ABC transporter, periplasmic amino acid-binding portion +FIG01323119 Putative mannitol dehydrogenase +FIG01323120 Uncharacterized acetyltransferase YafP (EC 2.3.1.-) +FIG01323136 FIG00351769: hypothetical protein +FIG01323138 colonization factor +FIG01323144 4-hydroxy-tetrahydrodipicolinate synthase (EC 4.3.3.7) +FIG01323145 FAD-dependent oxidoreductase family +FIG01323154 Periplasmic binding protein-like II superfamily +FIG01323161 failed axon connections protein +FIG01323165 FIG00353782: hypothetical protein +FIG01323166 FIG00516040: hypothetical protein +FIG01323168 Uncharacterized PLP-dependent aminotransferase YfdZ +FIG01323171 FIG00644614: hypothetical protein +FIG01323173 B. burgdorferi predicted coding region BB0576 +FIG01323180 zinc/manganese ABC transporter permease protein +FIG01323187 Polyketide synthase associated protein papA2 +FIG01323188 FIG00767473: hypothetical protein +FIG01323193 Selenoprotein W-related protein +FIG01323197 FIG00820637:: Acyl dehydratase +FIG01323204 beta-lactamase-like protein +FIG01323211 FIG00752093: hypothetical protein +FIG01323213 FIG00350893: hypothetical protein +FIG01323219 Putative general secretion pathway protein L (GspL family) +FIG01323224 Predicted endonuclease containing a URI domain +FIG01323226 Transcriptional regulator, AsnC family +FIG01323228 CopG domain-containing protein +FIG01323232 hypothetical cytochrome oxidase associated membrane protein +FIG01323239 putative Na+/H+ antiporter +FIG01323244 Transcription initiation factor IIH cyclin-dependent kinase 7 +FIG01323246 Major antigenic peptide PEB3 +FIG01323247 CT845 hypothetical protein +FIG01323262 ATPase with chaperone activity, ATP-binding domain, diverged +FIG01323284 replicative DNA helicase +FIG01323292 FIG00385075: hypothetical protein +FIG01323295 Streptococcal NAD glycohydrolase inhibitor +FIG01323298 endo-type 6-aminohexanoate oligomer hydrolase +FIG01323321 RidA/YER057c/UK114 superfamily, group 7, YjgH-like protein +FIG01323325 FIG00643509: hypothetical protein +FIG01323327 Phosphoglycerate dehydrogenase and related dehydrogenases +FIG01323334 Hypothetical protein MW2050 +FIG01323336 Probable catechol-o-methyltransferase (EC 2.1.1.6) +FIG01323342 FIG00671984: hypothetical protein +FIG01323344 HAD-superfamily hydrolase, subfamily IIB +FIG01323346 putative beta-xylosidase +FIG01323385 FIG00351731: hypothetical protein +FIG01323390 putative exonuclease Recj +FIG01323396 subtilosin A +FIG01323402 Phosphoserine phosphatase +FIG01323403 HD domain protein +FIG01323406 Amino acid ABC transporter permease component +FIG01323407 FIG00624518: hypothetical protein +FIG01323428 Phage transcriptional terminator +FIG01323430 Lipoprotein LppQ +FIG01323434 FIG00408780: hypothetical protein +FIG01323436 MutT/nudix family protein +FIG01323448 sensory box sensor histidine kinase/response regulator( EC:2.7.3.- ) +FIG01323450 FIG01191399: hypothetical protein +FIG01323461 protein from bacterioferritin family +FIG01323485 F0F1 ATP synthase subunit alpha +FIG01323490 Cold shock protein-related protein +FIG01323491 glycosyltransferase +FIG01323492 FIG01047234: hypothetical protein +FIG01323503 FIG00643641: hypothetical protein +FIG01323510 FIG00762909: hypothetical protein +FIG01323514 FIG00403794: hypothetical protein +FIG01323524 HTH-type transcriptional regulator LrpA +FIG01323528 FIG00424698: hypothetical protein +FIG01323541 FIG00403793: hypothetical protein +FIG01323548 FIG00353298: hypothetical protein +FIG01323555 Iron-regulated protein frpC +FIG01323562 Glu/Leu/Phe/Val dehydrogenase family protein +FIG01323569 YdgC +FIG01323576 3-alpha-(or 20-beta)-hydroxysteroid dehydrogenase (EC 1.1.1.53) +FIG01323597 haloacid dehalogenase/epoxide hydrolase family protein +FIG01323605 Oxalate decarboxylase (EC 4.1.1.2) +FIG01323610 Exopolysaccharide biosynthesis protein +FIG01323616 HNH nuclease +FIG01323624 carbonic anhydrase +FIG01323625 FIG00418594: hypothetical protein +FIG01323641 putative sugar transporter sugar binding protein +FIG01323649 VapB4 protein (antitoxin to VapC4) +FIG01323655 Possible methyltransferase (EC 2.1.1.-) +FIG01323658 FIG00267293: hypothetical protein +FIG01323667 COG1272: Predicted membrane protein hemolysin III homolog +FIG01323671 mina protein +FIG01323680 Ferrous iron transport protein +FIG01323681 probable exported protein YPO2521 +FIG01323686 FIG00402815: hypothetical protein +FIG01323704 FIG01381021: Hydrolase, alpha/beta fold family protein +FIG01323705 Metal-dependent phosphohydrolase, HD subdomain +FIG01323737 Probable conserved transmembrane ATP-binding protein ABC transporter +FIG01323743 4-methyl-5(B-hydroxyethyl)-thiazole monophosphate biosynthesis enzyme +FIG01323754 response regulatory protein +FIG01323756 USG protein +FIG01323757 Bacteriocin-like prepeptide or inducing peptide for bacteriocin synthesis +FIG01323771 Protein EccB3, component of Type VII secretion system ESX-3 +FIG01323776 CheY-like domain containing protein +FIG01323779 FIG00765409: hypothetical protein +FIG01323786 LysR-type transcriptional regulator NahR +FIG01323799 FIG00768927: hypothetical protein +FIG01323800 FIG00385406: hypothetical protein +FIG01323805 Transcriptional repressor EthR, TetR family +FIG01323808 COG5566: Uncharacterized conserved protein +FIG01323811 glycoside hydrolase, family 48 +FIG01323850 Major facilitator:Oxalate:Formate Antiporter +FIG01323852 putative factor +FIG01323857 Uncharacterized ABC-type transport system, permease component +FIG01323859 hypothetical protein +FIG01323860 Usg protein +FIG01323867 FIG00348762: hypothetical protein +FIG01323880 FIG00350682: hypothetical protein +FIG01323892 FIG00768518: hypothetical protein +FIG01323897 Putative diguanylate cyclase/phosphodiesterase +FIG01323898 FIG00425136: hypothetical protein +FIG01323908 ComA-related protein +FIG01323909 FIG00351466: hypothetical protein +FIG01323915 FIG00380362: hypothetical protein +FIG01323940 Dehydrogenase +FIG01323945 Capsule biosynthesis protein CapA +FIG01323950 SN-glycerol-3-phosphate transport ATP-binding protein UgpC (TC 3.A.1.1.3) +FIG01323951 LPXTG-site transpeptidase family protein +FIG01323952 Putative phage-encoded peptidoglycan binding protein +FIG01323956 Putative resistance protein +FIG01323965 Probable lipoprotein Cj0818-related protein +FIG01323972 FIG034929: Fimbriae usher protein SafC +FIG01323974 FIG00767895: hypothetical protein +FIG01323980 C-di-GMP phosphodiesterase MbaA, repressor of biofilm formation +FIG01323985 FIG00820419: hypothetical protein +FIG01323994 hypothetical protein +FIG01324000 type I restriction enzyme r protein +FIG01324006 Methyltransferase TM1293 +FIG01324015 Oxidoreductase (flavoprotein) +FIG01324019 Bacillus cereus group-specific protein, uncharacterized +FIG01324030 FIG00407700: hypothetical protein +FIG01324034 Protein-tyrosine-phosphatase (EC 3.1.3.48) +FIG01324048 Probable short-chain dehydrogenase +FIG01324052 Imidazolonepropionase and related amidohydrolases +FIG01324066 Predicted dehydrogenases and related proteins +FIG01324072 FIG00406453: hypothetical protein +FIG01324096 Tetracycline resistence protein, metal-tetracycline/H+ antiporter +FIG01324097 Aliphatic amidase AmiE (EC 3.5.1.4) +FIG01324104 FIG00385157: hypothetical protein +FIG01324107 Strictosidine synthase precursor (EC 4.3.3.2) +FIG01324117 parathion hydrolase +FIG01324120 putative ATP binding protein +FIG01324128 PspC domain protein, truncated +FIG01324130 RmbA +FIG01324132 FIG00424337: hypothetical protein +FIG01324147 Signal peptide peptidase SppA, 36K type +FIG01324159 Outer membrane protein OmpK +FIG01324170 hypothetical protein +FIG01324171 elements of external origin; plasmid-related functions non-bacterial functions +FIG01324172 FIG00351305: hypothetical protein +FIG01324173 Filamentous hemagglutinin +FIG01324184 short-chain type dehydrogenase-reductase +FIG01324185 FIG01069670: hypothetical protein +FIG01324187 Perosamine synthetase WbkB +FIG01324199 transposase (5' fragment) +FIG01324214 Blr0328 protein +FIG01324218 Ctn002 +FIG01324219 outer membrane protein F +FIG01324220 Tll1441 protein +FIG01324225 Putative enzyme +FIG01324229 Putative uncharacterized protein YaiO +FIG01324241 Gamma-D-glutamyl-L-diamino acid endopeptidase 1 (EC 3.4.19.11) +FIG01324252 methyl-accepting chemotaxis protein (mcp-2) +FIG01324261 Sugar transferase involved in lipopolysaccharide synthesis +FIG01324265 Type V secretory pathway, adhesin AidA +FIG01324272 ortholog to Borrelia burgdorferi BB0739 +FIG01324274 hypothetical protein with similarity to family of proteins in M. tuberculosis +FIG01324279 NADPH:quinone reductase or related Zn-dependent oxidoreductase +FIG01324280 FIG00350167: hypothetical protein +FIG01324282 Probable conserved lipoprotein lppK +FIG01324298 FIG00350197: hypothetical protein +FIG01324300 ABC transporter ATP-binding protein with unknown substrate +FIG01324304 FIG00765078: hypothetical protein +FIG01324320 Outer membrane protein OmpV +FIG01324329 staphopain peptidase C47 +FIG01324333 chromosome partition protein, putative +FIG01324336 FIG00403185: hypothetical protein +FIG01324345 hypothetical protein, CF-8 family +FIG01324346 Integral membrane protein EccD3, component of Type VII secretion system ESX-3 +FIG01324360 Similar to nitrogenase cofactor scaffold and assembly proteins +FIG01324361 FIG00628854: hypothetical protein +FIG01324362 COG5039: Exopolysaccharide biosynthesis protein +FIG01324371 Formate transporter +FIG01324374 FIG00767930: hypothetical protein +FIG01324376 FIG00390399: hypothetical protein +FIG01324386 FIG00351493: hypothetical protein +FIG01324393 Similar to methyltransferase domain of sarcosine-dimethylglycine methyltransferase +FIG01324396 Phenazine biosynthesis protein, PhzF family +FIG01324400 Transposase ERIG_04326 +FIG01324402 CAIB/BAIF family protein +FIG01324408 PHP family metal-dependent phosphoesterase +FIG01324412 FIG01119245: hypothetical protein +FIG01324417 Cytochrome c553i +FIG01324424 SSS sodium solute transporter superfamily +FIG01324437 Putative oxidoreductase, Fe-S subunit +FIG01324438 MutT-like protein +FIG01324442 FIG00406335: hypothetical protein +FIG01324448 hypothetical protein NMA1195 +FIG01324457 Hypothetical exported proline-rich protein +FIG01324461 IS2 ORF2 +FIG01324467 Phosphoribosyltransferase +FIG01324468 FIG00822495: hypothetical protein +FIG01324476 phage infection protein +FIG01324484 FIG00354033: hypothetical protein +FIG01324487 Putative uncharacterized protein ygiA +FIG01324495 FIG00414029: hypothetical protein +FIG01324498 FIG01201121: hypothetical protein +FIG01324503 Glutaryl-7-ACA acylase +FIG01324504 acid-shock protein, putative +FIG01324510 general stress protein 26 +FIG01324514 tubulin/FtsZ family, GTPase domain protein +FIG01324519 Membrane-bound C-5 sterol desaturase Erg3 +FIG01324525 ParE1 antibacterial toxin protein +FIG01324535 Bacterial extracellular solute-binding protein +FIG01324540 ABC-type protease/lipase transport system, ATPase and permease component +FIG01324569 POSSIBLE TWO COMPONENT SENSOR KINASE +FIG01324578 putative S-layer protein/N-acetylmuramoyl-L-alanine amidase +FIG01324580 FIG00350964: hypothetical protein +FIG01324582 PBS lyase HEAT-like repeat domain protein +FIG01324586 FIG00766786: hypothetical protein +FIG01324603 Inosine monophosphate dehydrogenase-related protein +FIG01324611 FIG00898796: hypothetical protein +FIG01324645 FIG00821929: hypothetical protein +FIG01324662 FIG00402761: hypothetical protein +FIG01324685 FIG00351496: hypothetical protein +FIG01324686 Probable transmembrane protein Cj0352 +FIG01324687 Pirin, N-terminal:Pirin, C-terminal +FIG01324689 conserved hypothetical phage-like protein +FIG01324692 vrrB protein +FIG01324705 alpha-glucosidase +FIG01324706 Hypothetical fimbrial chaperone yqiH +FIG01324710 Protein-disulfide isomerase, related to DsbA +FIG01324713 SERINE PROTEASE (EC 3.4.21.-) +FIG01324714 FKBP-type peptidyl-prolyl cis-trans isomerase MJ0825 (EC 5.2.1.8) +FIG01324716 Mur ligase middle region +FIG01324717 glycosyl transferase, group 2 family protein( EC:2.4.1.- ) +FIG01324724 FIG00385094: hypothetical protein +FIG01324735 hypothetical protein +FIG01324740 amino acid permease family protein, putative +FIG01324741 tetratricopeptide TPR_2 +FIG01324752 FIG00385288: hypothetical protein +FIG01324754 carotenoid oxygenase +FIG01324758 Hsp12 variant C +FIG01324777 putative phenylacetic acid degradation protein +FIG01324782 methyltransferase, FkbM family domain protein +FIG01324785 FIG00402879: hypothetical protein +FIG01324789 Sodium/glutamate symporter +FIG01324793 C4-dicarboxylate transporter +FIG01324800 Transmembrane transport protein MmpL4 +FIG01324801 FIG00766856: hypothetical protein +FIG01324802 Amidase/cyclase family protein +FIG01324804 HEPN domain protein +FIG01324806 36 +FIG01324815 FIG00638173: hypothetical protein +FIG01324817 Phosphinothricin N-acetyltransferase +FIG01324826 FIG00351533: hypothetical protein +FIG01324827 hydrolase, NUDIX family protein +FIG01324850 putative sugar transporter sugar-binding protein +FIG01324853 FIG00351590: hypothetical protein +FIG01324862 FIG00431543: hypothetical protein +FIG01324896 Alpha-1,6-galactosidase, putative +FIG01324903 FIG00409942: hypothetical protein +FIG01324908 2-hydroxy-6-oxohepta-2,4-dienoate hydrolase +FIG01324952 Probable membrane protein YetF +FIG01324964 probable UDP-glucose-4-epimerase +FIG01324990 exonuclease, putative +FIG01324993 FIG00385430: hypothetical protein +FIG01324996 hypothetical protein +FIG01325004 FIG00424035: hypothetical protein +FIG01325010 contains DUF20 region +FIG01325015 FIG00350907: hypothetical protein +FIG01325017 Probable phospholipase protein +FIG01325030 Putative inner membrane or exported +FIG01325037 FIG01165910: hypothetical protein +FIG01325044 hypothetical protein +FIG01325059 FIG01238310: hypothetical protein +FIG01325061 Putative threonine efflux protein +FIG01325064 flagellar protein, putative {Borrelia burgdorferi +FIG01325067 protein of unknown function DUF309 +FIG01325069 FIG00404266: hypothetical protein +FIG01325074 FIG00733816: hypothetical protein +FIG01325079 FIG00488724: hypothetical protein +FIG01325085 FIG00623821: hypothetical protein +FIG01325094 putative serine protease precursor +FIG01325148 small peptidoglycan-associated lipoprotein +FIG01325157 FIG00352559: hypothetical protein +FIG01325162 FIG00469138: hypothetical protein +FIG01325163 Carboxylate/Amino Acid/Amine Transporter, membrane protein +FIG01325171 glutamate transporter, putative +FIG01325182 FIG00403148: hypothetical protein +FIG01325183 NADH oxidase H2O-forming (EC 1.6.-.-) +FIG01325187 putative integral membrane protein dedA-like protein +FIG01325209 phosphopyruvate hydratase +FIG01325210 FIG00450210: hypothetical protein +FIG01325211 PUTATIVE OXIDOREDUCTASE +FIG01325213 FIG00954117: hypothetical protein +FIG01325218 FIG00821012: hypothetical protein +FIG01325221 Putative redoxin +FIG01325226 bacitracin ABC transporter, ATP-binding protein +FIG01325237 Possible lipoprotein thiredoxin +FIG01325243 transposase family protein +FIG01325248 Membrane metalloprotease +FIG01325252 FIG00350070: hypothetical protein +FIG01325255 FIG038012: hypothetical protein +FIG01325258 FIG00408511: hypothetical protein +FIG01325262 FIG00350213: hypothetical protein +FIG01325264 FIG00414498: hypothetical protein +FIG01325267 prophage Lp3 protein 1, integrase +FIG01325269 Transposase and inactivated derivatives-like protein +FIG01325273 Plasmid recombination enzyme +FIG01325294 Heat shock protein, molecular chaperone +FIG01325298 B. burgdorferi predicted coding region BBA37 +FIG01325319 hypothetical protein +FIG01325331 CoA transferase, CAIB/BAIF family +FIG01325335 Probable glucosyl transferase +FIG01325340 hypothetical protein +FIG01325343 NAD-dependent aldehyde dehydrogenases +FIG01325356 FIG00350243: hypothetical protein +FIG01325360 IS861, transposase (orf1), IS3 family, truncated +FIG01325404 transport; Transport of small molecules: Cations +FIG01325408 FIG019540: hypothetical protein +FIG01325416 putative neutral invertase-like protein +FIG01325432 transcriptional regulator, Bla/Mec family +FIG01325434 Histone deacetylase/AcuC/AphA family protein +FIG01325441 Hydrolase, HAD subfamily IIIA +FIG01325449 transposase, putative +FIG01325461 HtxF protein +FIG01325486 conserved hypothetical protein TIGR01671 +FIG01325494 FIG00816841: hypothetical protein +FIG01325497 Phosphinothricin N-acetyltransferase (EC 2.3.1.-) +FIG01325498 Possible ABC-transport protein, periplasmic-binding component +FIG01325512 RidA/YER057c/UK114 superfamily, group 2, YoaB-like protein +FIG01325523 Chromate transporter +FIG01325527 Bll2821 protein +FIG01325531 ABC-type dipeptide/oligopeptide/nickel transport system, ATP-binding protein +FIG01325537 FIG00350599: hypothetical protein +FIG01325541 photosystem I reaction center protein PsaK +FIG01325544 Clostripain-related protein +FIG01325547 FIG00640482: hypothetical protein +FIG01325551 ThiS family protein +FIG01325552 Phenylacetic acid degradation operon negative regulatory protein paaX +FIG01325555 Acetyl-CoA hydrolase (EC 3.1.2.1) +FIG01325559 Hypothetical protein, SLT orf99 homolog [SA bacteriophages 11, Mu50B] +FIG01325561 COG0148: Enolase +FIG01325574 DUF819 domain-containing protein +FIG01325585 FIG00362383: hypothetical protein +FIG01325586 voltage-gated chloride channel +FIG01325587 / Glutamine transport system permease protein glnP (TC 3.A.1.3.2) +FIG01325607 Putative phage-related protein +FIG01325609 transporter, monovalent cation:proton antiporter-2 (CPA2) family protein +FIG01325612 FIG00831546: hypothetical protein +FIG01325623 Putative ATP/GTP binding protein +FIG01325636 transcriptional activator-regulatory protein +FIG01325639 FIG00994467: hypothetical protein +FIG01325642 Reductase/isomerase/elongation factor common domain +FIG01325675 Hypothetical sugar permease +FIG01325676 putative transmembrane lipoprotein LplC +FIG01325678 AraC-type DNA-binding domain-containing protein +FIG01325680 UDP-glucoronosyl and UDP-glucosyltransferases family protein +FIG01325685 FIG00945211: hypothetical protein +FIG01325698 S-layer protein, putative +FIG01325709 Sensory box/GGDEF family protein +FIG01325739 possible chlorohydrolase-like protein +FIG01325744 methyltransferase type 11 +FIG01325751 Putative outer membrane or secreted lipoprotein +FIG01325754 FIG00752365: hypothetical protein +FIG01325773 drug resistance transporter, Bcr/CflA family +FIG01325778 Dipeptidyl anminopeptidase +FIG01325785 FIG00789234: hypothetical protein +FIG01325787 FIG00639874: hypothetical protein +FIG01325792 Chaperone protein lpfB precursor +FIG01325796 FIG00639825: hypothetical protein +FIG01325801 flagellin modification protein FlmC +FIG01325805 Degenerate transposase +FIG01325818 FIG00765583: hypothetical protein +FIG01325819 FIG00764266: hypothetical protein +FIG01325830 Predicted metal-dependent hydrolase +FIG01325834 transcriptional regulator, GntR-family +FIG01325835 Putative O-antigen synthesis protein, WbyH +FIG01325837 FIG00824824: hypothetical protein +FIG01325842 IS1380-Spn1, transposase +FIG01325847 DUF1176 domain-containing protein +FIG01325860 putative phage gene +FIG01325863 identified by similarity to GB:AAM72242.1 +FIG01325864 FIG00415025: hypothetical protein +FIG01325882 FIG00622888: hypothetical protein +FIG01325884 acetamidase/formamidase family protein +FIG01325893 FIG00352418: hypothetical protein +FIG01325896 GGDEF DOMAIN PROTEIN +FIG01325900 Amino acid ABC-type transporter, ATPase component +FIG01325907 IS1381, transposase OrfB +FIG01325909 FIG00828949: hypothetical protein +FIG01325914 gsc +FIG01325921 Putative amidotransferase +FIG01325934 esterase/lipase/thioesterase family +FIG01325951 FIG00643765: hypothetical protein +FIG01325958 FIG00350091: hypothetical protein +FIG01325965 ortholog to Borrelia burgdorferi BB0071 +FIG01325968 FIG00354483: hypothetical protein +FIG01325983 28.1 kDa virulence protein +FIG01325985 Rlx-like protein +FIG01325990 FIG00895146: hypothetical protein +FIG01325996 FIG01202447: hypothetical protein +FIG01326008 FIG00763116: hypothetical protein +FIG01326011 FIG00407755: hypothetical protein +FIG01326012 FIG00349934: hypothetical protein +FIG01326013 putative transcriptional regulator +FIG01326015 Restriction endonuclease +FIG01326022 ORF25 +FIG01326023 probable acetyltransferase NMA0494 +FIG01326026 FIG00745135: hypothetical protein +FIG01326031 basic membrane protein D (bmpD) +FIG01326045 protease synthase and sporulation negative regulatory protein PAI 2 +FIG01326048 Taurine dioxygenase +FIG01326049 probable NMA1686 +FIG01326052 Lysophospholipase L1 and related esterase +FIG01326053 Putative inner membrane protein +FIG01326054 RhlB, TDP-rhamnosyltransferase 1 (EC 2.4.1.-) +FIG01326060 FIG01113058: hypothetical protein +FIG01326074 possible ABC-type sugar transport system, periplasmic component +FIG01326076 putative ABC transporter permease +FIG01326083 R.meliloti pRmeGR4a plasmid DNA +FIG01326085 Bile acid transporter family protein +FIG01326088 putative cationic amino acid transporter protein +FIG01326095 Phage integrase +FIG01326112 FIG01017312: hypothetical protein +FIG01326114 FIG00385629: hypothetical protein +FIG01326115 pseudomonapepsin precursor +FIG01326128 FIG00402727: hypothetical protein +FIG01326130 Hypothetical membrane protein Rv2120c +FIG01326131 TsaB protein, required for threonylcarbamoyladenosine (t(6)A) formation in tRNA / Beta-phosphoglucomutase (EC 5.4.2.6) +FIG01326133 Amino acid ABC transporter, amino acid-binding/permease protein +FIG01326135 N(4)-(Beta-N-acetylglucosaminyl)-L-asparaginase precursor (EC 3.5.1.26) (Glycosylasparaginase) (Aspartylglucosaminidase) (N4-(N-acetyl-beta-glucosaminyl)-L-asparagine amidase) (AGA) [Contains: Glycosylasparaginase alpha chain; Glycosylasparaginase beta chain] +FIG01326139 FIG00755240: hypothetical protein +FIG01326156 Oxidoreductase, FAD/FMN-binding +FIG01326168 FIG00410459: hypothetical protein +FIG01326171 SCO1/SenC family protein +FIG01326177 FIG00406137: hypothetical protein +FIG01326182 UPF0346 protein BCE33L2081 +FIG01326184 spoIID-like domain containing protein, peptidoglycan-binding domain +FIG01326190 Predicted Rossmann fold nucleotide-binding protein, possible lysine decarboxylase +FIG01326193 peptidylarginine deiminase family protein +FIG01326202 FIG01165795: hypothetical protein +FIG01326217 FIG01123659: hypothetical protein +FIG01326221 Transcriptional regulator, GntR family +FIG01326235 Probable cation-transporting P-type ATPase C (EC 3.6.3.-) (Metal-transporting ATPase Mta72); FUPA32 P-type ATPase +FIG01326253 Subtilisin (EC 3.4.21.62) +FIG01326260 Putative Type III secretion apparatus protein +FIG01326262 FIG00351471: hypothetical protein +FIG01326265 FIG00424434: hypothetical protein +FIG01326274 possible sodium/sulphate transporter +FIG01326279 FIG00350534: hypothetical protein +FIG01326284 FIG00529394: hypothetical protein +FIG01326290 Putative peptide ABC-transport system permease protein +FIG01326291 PhnO-related protein +FIG01326295 hypothetical protein +FIG01326297 UPF0150 family protein +FIG01326298 Lipase LipD +FIG01326303 Bacitracin transport ATP-binding protein bcrA +FIG01326304 transcriptional repressor/ROK family +FIG01326317 54K polar flagellar sheath protein A +FIG01326324 FIG00411007: hypothetical protein +FIG01326336 Phosphoglycerate mutase family (Rhiz) +FIG01326339 Cyanate permease +FIG01326345 ferrodoxin-like protein +FIG01326347 pXO2-11 +FIG01326348 FIG00350632: hypothetical protein +FIG01326354 UvrC-like protein +FIG01326358 conserved hypothetical protein fragment 2 +FIG01326382 MoaE protein +FIG01326390 Phage host specificity protein +FIG01326392 PROBABLE TRANSPOSASE +FIG01326407 Cob(I)alamin adenosyltransferase +FIG01326417 POSSIBLE phiRv2 PROPHAGE PROTEIN +FIG01326419 FIG00403582: hypothetical protein +FIG01326420 cag island protein +FIG01326423 FIG020717: Phage-associated protein +FIG01326426 Acid phosphatase +FIG01326429 Sugar-binding transcriptional regulator, LacI family +FIG01326448 Iron-sulphur-binding reductase +FIG01326450 FIG01326450: Putative hydroxylase +FIG01326455 FIG00866334: hypothetical protein +FIG01326463 LipO +FIG01326466 PROTEIN YBIS PRECURSOR +FIG01326468 Acetyl esterase +FIG01326476 Exo-beta-1 3-glucanase-like +FIG01326478 Phospholipid N-methyltransferase +FIG01326488 FIG00385706: hypothetical protein +FIG01326491 alkyl sulfatase (EC 3.1.6.-) +FIG01326492 Iron-containing alcohol dehydrogenase (EC 1.1.1.1) +FIG01326493 ABC transporter ATP-binding protein - Na+ export +FIG01326506 FIG00418307: hypothetical protein +FIG01326512 STAPHYLOLYTIC protease PREPROENZYME LASA +FIG01326517 Predicted Fe-S protein +FIG01326523 ortholog to Borrelia burgdorferi BB0666 +FIG01326524 hypothetical protein +FIG01326525 FIG00847570: hypothetical protein +FIG01326526 trypsin, putative +FIG01326536 Ssr2554 protein +FIG01326548 FIG00416553: hypothetical protein +FIG01326550 3',5'-cyclic nucleotide phosphodiesterase (EC 3.1.4.17) +FIG01326559 putative alpha-dextrin endo-1, 6-alpha-glucosidase +FIG01326564 FIG030357: hypothetical protein +FIG01326578 Phage infection protein +FIG01326580 pXO1-12 +FIG01326586 473aa long hypothetical protein +FIG01326588 probable lipoprotein YPO0352 +FIG01326599 putative DNA-binding protein +FIG01326607 FIG00527026: hypothetical protein +FIG01326609 oligoendopeptidase F +FIG01326611 SH3 domain protein +FIG01326613 FIG00423842: hypothetical protein +FIG01326622 FIG00766231: hypothetical protein +FIG01326624 Type I restriction-modification system specificity subunit +FIG01326634 FIG00629940: hypothetical protein +FIG01326637 putative type II restriction enzyme HphI +FIG01326638 FIG00403759: hypothetical protein +FIG01326643 FIG00824157: hypothetical protein +FIG01326646 outer membrane component of multidrug efflux system +FIG01326652 possible DNA polymerase (viral) N-terminal dom +FIG01326664 FIG00389028: hypothetical protein +FIG01326669 Uncharacterized protein family (UPF0236) +FIG01326680 Oxidoreductase, short-chain dehydrogenase/reductase in mymA operon +FIG01326691 FIG01048984: hypothetical protein +FIG01326696 very long chain acyl-CoA dehydrogenase-related protein +FIG01326705 Type III effector HopPmaJ +FIG01326715 nonessential protein; lysogenic conversion; exonuclease; blocks growth of phage lambda +FIG01326725 Putative chemotaxis protein, resembles cheA +FIG01326729 iron-dependent repressor, putative +FIG01326745 FIG00352474: hypothetical protein +FIG01326748 General stress protein, Gls24 family +FIG01326760 phage integrase family protein +FIG01326768 Acetyltransferases +FIG01326769 Sulfate transporter/antisigma-factor antagonist STAS:Sulphate transporter +FIG01326784 Conserved hypothetical protein 2001 +FIG01326796 VrrA protein +FIG01326799 DNA helicase, phage associated; Type III restriction enzme +FIG01326800 Hypothetical protein with diguanylate-cyclase (GGDEF) domain +FIG01326802 Putative O-antigen biosynthesis protein precursor +FIG01326804 probable DNA methylase +FIG01326805 PE_PGRS family protein +FIG01326819 FIG01116480: hypothetical protein +FIG01326826 Bll0480 protein +FIG01326829 ortholog to Borrelia burgdorferi BB0689 +FIG01326832 FIG00642282: hypothetical protein +FIG01326837 Exotoxin 6 +FIG01326841 plastoquinol terminal oxidase +FIG01326844 Acyl-CoA synthetase +FIG01326860 ankyrin repeat-containing protein 12_01 +FIG01326868 transcriptional regulator AnsR +FIG01326882 Putaive two-component response regulator +FIG01326884 HIPA PROTEIN +FIG01326890 RlgA +FIG01326892 FIG00767515: hypothetical protein +FIG01326897 o68; similar to gi|2182435 +FIG01326914 C4-dicarboxylate transporter/malic acid transport protein +FIG01326920 FIG00410951: hypothetical protein +FIG01326921 Transposase STM0479 +FIG01326922 FIG00350000: hypothetical protein +FIG01326926 Hypothetical lipoprotein yghG precursor +FIG01326932 FIG00389917: hypothetical protein +FIG01326934 probable sugar transport membrane protein +FIG01326937 FIG00350191: hypothetical protein +FIG01326941 RECOMBINASE +FIG01326944 Putative chaperonin +FIG01326948 FIG00405395: hypothetical protein +FIG01326949 FIG00423816: hypothetical protein +FIG01326960 UPF0319 protein VV0984 precursor +FIG01326961 Oligoketide cyclase/lipid transport protein homolog +FIG01326974 FIG00629616: hypothetical protein +FIG01326985 Uncharacterised protein family UPF0157 (COG2320) +FIG01326990 TnpB +FIG01326993 Nucleoside permease NupG +FIG01326998 TPR repeat +FIG01327001 putative cyclase SCIF3.09c +FIG01327008 Bactriocin immunity protein BlpY +FIG01327014 SM-20-related protein +FIG01327018 Probable outer membrane receptor protein +FIG01327025 FIG016877: hypothetical protein +FIG01327034 FIG00414564: hypothetical protein +FIG01327038 COG family: dihydrodipicolinate reductase +FIG01327039 treponemal membrane protein B precursor-like protein +FIG01327045 Putative fucose synthetase (EC 1.1.1.271) +FIG01327054 Nudix hydrolase family protein +FIG01327057 FIG01203668: hypothetical protein +FIG01327059 poly-gamma-glutamate synthesis protein (capsule biosynthesis protein) +FIG01327062 Major porin and structural outer membrane porin OprF +FIG01327064 phenylacetate-CoA oxygenase, PaaI subunit +FIG01327066 Beta-hemolysin +FIG01327069 FIG00404338: hypothetical protein +FIG01327072 Sterol desaturase +FIG01327079 putative carboxypeptidase +FIG01327097 HEAT SHOCK PROTEIN (hsp22) +FIG01327099 BlpS protein +FIG01327101 OspD1 +FIG01327135 Endoglucanase C (EC 3.2.1.4) +FIG01327136 lprJ +FIG01327138 Protease IV (EC 3.4.21.-) +FIG01327143 putative ABC RTX toxin transporter, fused ATP binding/permease domains +FIG01327150 FIG00762612: hypothetical protein +FIG01327157 FIG00411431: hypothetical protein +FIG01327170 Shiga toxin A-chain precursor (EC 3.2.2.22) +FIG01327172 FIG00636849: hypothetical protein +FIG01327187 Amino-acid acetyltransferase (EC 2.3.1.1) +FIG01327198 Thiaminase 1 (EC 2.5.1.2), putative +FIG01327206 FIG021166: Prophage P4 integrase +FIG01327228 putative positive regulator of late gene transcription +FIG01327229 NHL repeat +FIG01327230 protein of unknown function DUF1130 +FIG01327231 Leucine responsive regulatory protein +FIG01327232 possible transmembrane protein +FIG01327236 Homoserine dehydrogenase +FIG01327243 Response regulator containing a CheY-like receiver domain and an HTH DNA-binding domain +FIG01327244 Hypothetical protein SAV1779 +FIG01327254 Membrane protein DUF2324 in 2-Ketogluconate Utilization cluster +FIG01327265 FIG00405723: hypothetical protein +FIG01327266 Type II secretory pathway, component ExeA +FIG01327271 Acetyltransferases (the isoleucine patch superfamily) +FIG01327276 Arabinogalactan endo-1,4-beta-galactosidase +FIG01327295 2,4'-dihydroxyacetophenone dioxygenase (EC 1.13.11.41) +FIG01327301 response regulator containing a CheY-like receiver domain and a HTH DNA-binding domain +FIG01327302 CobN-like chelatase BtuS for metalloporphyrine salvage +FIG01327318 Two-component response regulator, controling glutamine utilization +FIG01327324 MarC family integral membrane protein +FIG01327326 Putative ATPase involved in DNA repair +FIG01327343 Glucose-1-phosphatase (EC 3.1.3.10) +FIG01327355 FIG00763346: hypothetical protein +FIG01327357 Thioesterase type II +FIG01327358 putative envelope protein +FIG01327368 peptidase, M50 family protein( EC:3.4.24.- ) +FIG01327375 FIG00350743: hypothetical protein +FIG01327379 Hypothetical protein SAV2131 +FIG01327380 FIG01236627: hypothetical protein +FIG01327381 Histone H1 +FIG01327386 ABC-2 type transporter superfamily protein +FIG01327392 FIG00425692: hypothetical protein +FIG01327395 MTH1175-like domain family protein +FIG01327396 Glycolipoprotein LprG, antigen P27 modulating immune response against mycobacteria in favour of bacterial persistence +FIG01327397 FIG00349065: hypothetical protein +FIG01327400 FIG00414240: hypothetical protein +FIG01327406 Putative prolyl oligopeptidase family protein +FIG01327422 FIG01048072: hypothetical protein +FIG01327425 oxidoreductase, aldo/keto reductase family +FIG01327427 ADP-heptose--LPS heptosyltransferase II (EC 2.-.-.-) +FIG01327429 methlytransferase, UbiE/COQ5 family +FIG01327433 ATP-dependent protease ATP-binding subunit clpL +FIG01327441 Nicotinamide mononucleotide adenylyltransferase +FIG01327449 Putative glutamate dehydrogenase +FIG01327451 3-dehydroquinate dehydratase +FIG01327458 FIG00416771: hypothetical protein +FIG01327459 DUF1526 domain-containing protein +FIG01327465 transposase IS4 family protein +FIG01327466 PROBABLE EXPORTED PROTEIN +FIG01327470 COGs COG3558 +FIG01327473 Permease YjgP/YjgQ family protein (EC 3.6.3.-) +FIG01327486 FIG00384919: hypothetical protein +FIG01327493 FIG00829478: hypothetical protein +FIG01327516 ISCco1, transposase orfB +FIG01327524 Putative ammonia monooxygenase +FIG01327541 conserved hypothetical protein TIGR00147 +FIG01327554 putative inner membrane component of binding-protein-dependent transport system +FIG01327557 ydaQ protein +FIG01327568 FIG01046561: hypothetical protein +FIG01327572 putative methyl-accepting chemotaxis I +FIG01327573 diguanylate cyclase/phosphodiesterase (GGDEF & EAL domains) with PAS/PAC sensor(s) +FIG01327596 2-hydroxychromene-2-carboxylate isomerase family protein +FIG01327605 Nodulation protein nolNO (EC 2.1.3.-) +FIG01327611 dehydrogenase, FMN-dependent family +FIG01327617 two-component system regulator +FIG01327624 Transcriptional regulator of glmS gene, DeoR family +FIG01327629 FIG00848010: hypothetical protein +FIG01327631 FIG00411761: hypothetical protein +FIG01327634 bogus protein +FIG01327635 membrane protein containing RDD domain +FIG01327646 AidA +FIG01327649 Putative cellsurface protein +FIG01327653 oxidoreductase ylbE +FIG01327662 Pentapeptide repeat +FIG01327665 FIG00385126: hypothetical protein +FIG01327666 Potential queD like 2 +FIG01327677 FIG01121128: hypothetical protein +FIG01327679 Protein of unknown function DUF1341 +FIG01327685 FIG00848516: hypothetical protein +FIG01327688 probable cation-transporting ATPase +FIG01327692 FIG00765092: hypothetical protein +FIG01327693 Sugar ABC transporter, permease protein +FIG01327698 Phosphodiesterase MJ0936 (EC 3.1.4.-) +FIG01327701 Prevent-host-death protein +FIG01327715 Capsular polysaccharide synthesis enzyme CpsG, Lipid A core - O-antigen ligase +FIG01327720 cell processes; transport of small molecules; carbohydrates, organic acids, alcohols +FIG01327764 putative stress-induced protein OsmC +FIG01327769 putative AbaA-like protein +FIG01327770 possible sugar transferase +FIG01327774 peptidyl-tRNA hydrolase +FIG01327775 FIG00897374: hypothetical protein +FIG01327779 predicted OMP [leader (16) peptide] +FIG01327783 Lactoylglutathione lyase/catechol 2,3-dioxygenase related enzyme +FIG01327797 Leukocidin LukS-PV +FIG01327809 SrpA-related protein +FIG01327813 Protein of unknown function DUF202 +FIG01327821 Ring-cleaving dioxygenase +FIG01327823 Phage-like element PBSX protein xkdE +FIG01327833 Transcriptional regulator of alpha-acetolactate operon alsR +FIG01327834 FIG00350793: hypothetical protein +FIG01327842 FIG00410552: hypothetical protein +FIG01327854 Pirin-related protein +FIG01327866 FIG00822644: hypothetical protein +FIG01327869 FIG00388275: hypothetical protein +FIG01327878 FIG00689796: hypothetical protein +FIG01327881 FIG00351405: hypothetical protein +FIG01327890 Hypothetical protein SAV1803 +FIG01327891 Glutamate decarboxylase, eukaryotic type (EC 4.1.1.15) +FIG01327895 Possible oxidoreductase subunit +FIG01327901 FIG01211993: hypothetical protein +FIG01327914 RNA-binding protein +FIG01327918 putative thioesterase +FIG01327930 FIG00766561: hypothetical protein +FIG01327935 Methionine biosynthesis and transport regulator MtaR, LysR family +FIG01327938 alginate biosynthesis transcriptional regulatory protein AlgB +FIG01327939 Putative methyltransferase YodH +FIG01327940 bacteriophage f237 ORF10 +FIG01327943 FIG01226582: hypothetical protein +FIG01327949 Branched-chain amino acid permease +FIG01327950 Methylase involved in ubiquinone/menaquinone biosynthesis +FIG01327957 FIG00350602: hypothetical protein +FIG01327961 RRNA methylase, putative +FIG01327965 Putative methyltransferase (EC 2.1.1.72) +FIG01327970 RhlC, TDP-rhamnosyltransferase 2 (EC 2.4.1.-) +FIG01327971 Acetyltransferase (GNAT) family, Syn7942_2240 homolog +FIG01327977 FIG01109439: hypothetical protein +FIG01327981 possible DNA methylase +FIG01327993 S-layer protein, (pXO1-90) +FIG01327998 Lipase 1 (EC 3.1.1.3) +FIG01328011 Lipoprotein LppW +FIG01328012 FIG00832913: hypothetical protein +FIG01328017 Putative Holliday junction resolvase YqgF +FIG01328024 Gamma-D-glutamyl-L-diamino acid endopeptidase I (EC 3.4.19.11) +FIG01328036 FIG00525336: hypothetical protein +FIG01328054 Protein yeeZ precursor +FIG01328058 FIG00821638: hypothetical protein +FIG01328060 Putative membrane protein MmpL12 +FIG01328061 Response regulators consisting of a CheY-like receiver domain and a winged-helix DNA-binding domain +FIG01328066 Putative O-antigen ligase WaaL +FIG01328069 FIG00350631: hypothetical protein +FIG01328070 PfkB domain protein +FIG01328081 Putative ferredoxin +FIG01328092 PhbF +FIG01328109 Gb|AAF35419.1 +FIG01328115 putative hemolysin activating-like protein +FIG01328117 possible Gram-negative pili assembly chaperone +FIG01328123 Uncharacterized protein yhaV +FIG01328124 FIG00921641: hypothetical protein +FIG01328127 FIG00411274: hypothetical protein +FIG01328141 FIG00354458: hypothetical protein +FIG01328146 transposase, is605 family, orfb +FIG01328149 FIG00351868: hypothetical protein +FIG01328155 Hypothetical protein SAV2296 +FIG01328162 E16-related protein +FIG01328167 MmcQ +FIG01328201 Phosphocarrier protein, nitrogen regulation associated +FIG01328209 pXO1-76 +FIG01328215 Spore germination protein XB +FIG01328216 oligo alginate lyase +FIG01328225 TSPc, tail specific protease +FIG01328230 Hypothetical protein SAV1772 +FIG01328240 FIG00451252: hypothetical protein +FIG01328241 FIG00350103: hypothetical protein +FIG01328243 FIG01306796: hypothetical protein +FIG01328244 Uncharacterized protein ypmT +FIG01328245 Lipoprotein LppE +FIG01328248 putative two-component system response regulator (partial) +FIG01328250 Sakacin A production response regulator +FIG01328251 hypothetical protein +FIG01328257 Cytochrome P450-related protein +FIG01328260 Sugar efflux permease, MFS-like +FIG01328261 FIG00628893: hypothetical protein +FIG01328267 truncated hypothetical protein +FIG01328271 DNA-binding protein rdgB +FIG01328273 Acid phosphatase (EC 3.1.3.2) +FIG01328290 FIG00641929: hypothetical protein +FIG01328291 contains transcriptional regulator helix-turn-helix domain, lysR family +FIG01328301 similar to nucleoside-diphosphate-sugar epimerase +FIG01328309 putative cytochrome P450 hydroxylase +FIG01328311 FIG00351289: hypothetical protein +FIG01328318 Response regulator CsrR +FIG01328320 Probable ABC transporter ATP binding protein +FIG01328326 FIG00388007: hypothetical protein +FIG01328336 Virulence protein msgA +FIG01328351 Cellulose synthase (UDP-forming) (EC 2.4.1.12) +FIG01328352 Cytochrome b561 homolog 1 +FIG01328355 FIG00351112: hypothetical protein +FIG01328362 Pressure-regulated ORF-like protein +FIG01328384 FIG00623936: hypothetical protein +FIG01328398 virulence factor Mce family protein +FIG01328421 FIG00349989: hypothetical protein +FIG01328426 cyclic nucleotide-binding protein +FIG01328429 Protein kinase domain containing protein +FIG01328430 FIG00388658: hypothetical protein +FIG01328434 FIG00559216: hypothetical protein +FIG01328438 Predicted protein-tyrosine phosphatase +FIG01328440 Acyl-ACP thioesterase +FIG01328445 Amino acid transporter-like protein +FIG01328471 Mll2537 protein +FIG01328482 FIG00351865: hypothetical protein +FIG01328484 FIG00639116: hypothetical protein +FIG01328486 PROBABLE RESUSCITATION-PROMOTING FACTOR RPFE +FIG01328490 FIG00825505: hypothetical protein +FIG01328493 FIG00350689: hypothetical protein +FIG01328505 sensory box histidine kinase +FIG01328508 prophage LambdaBa04, tape measure protein +FIG01328519 hypothetical protein +FIG01328543 DegV family protein +FIG01328552 FIG00350853: hypothetical protein +FIG01328566 putative large secreted protein +FIG01328569 Putative transmembrane symporter +FIG01328574 FIG00350805: hypothetical protein +FIG01328577 prophage Lp1 protein 54 +FIG01328594 COG4804: Uncharacterized conserved protein +FIG01328603 ABC transporter iron(III)/siderophore permease protein +FIG01328611 hypothetical protein +FIG01328627 Acetyl esterase (EC 3.1.1.-) +FIG01328628 Sugar phosphate isomerase/epimerase +FIG01328633 Conserved protein, with a weak D-galactarate dehydratase/altronate hydrolase domain +FIG01328638 hydrolase, alpha/beta hydrolase fold family +FIG01328640 syc1926_d +FIG01328644 putative NAD dependent epimerase/dehydratase family protein +FIG01328650 POSSIBLE CONSERVED MEMBRANE OR SECRETED PROTEIN +FIG01328665 FIG00898345: hypothetical protein +FIG01328666 Phage antirepressor protein +FIG01328675 DNA repair helicase rad25 +FIG01328684 FIG00849841: hypothetical protein +FIG01328687 Invasion protein iagA +FIG01328688 Metal-dependent hydrolase/cyclase +FIG01328702 FIG00352037: hypothetical protein +FIG01328708 FIG01165872: hypothetical protein +FIG01328718 17 kDa surface antigen precursor +FIG01328724 Putative accessory processing protein +FIG01328728 FIG011400: transcriptional activator of Lmo0327 homolog +FIG01328731 FIG00385009: hypothetical protein +FIG01328734 Phytochrome-like protein; Cph2 +FIG01328735 aldolase +FIG01328741 Putative major fimbrial subunit precursor +FIG01328743 Gene 18 protein +FIG01328752 FIG00765476: hypothetical protein +FIG01328760 Acid phosphatase (EC 3.1.3.2) +FIG01328766 Type III secretion system EscD protein +FIG01328773 FIG00354329: hypothetical protein +FIG01328779 Phage-like element PBSX protein xtrA +FIG01328784 YxaJ +FIG01328786 FIG00410327: hypothetical protein +FIG01328790 Hypothetical protein SAV1853 +FIG01328795 hypothetical protein +FIG01328800 D-octopine dehydrogenase +FIG01328807 Predicted phosphohydrolases +FIG01328823 FIG01240556: hypothetical protein +FIG01328825 Accessory gene regulator protein B (EC 3.4.-.-) +FIG01328838 Pirin family protein +FIG01328843 cell surface glycoprotein (s-layer protein) related protein-like +FIG01328844 HNH endonuclease:HNH nuclease +FIG01328848 Probable ABC transporter ATP-binding protein y4oS +FIG01328850 FIG00351138: hypothetical protein +FIG01328859 FIG00403961: hypothetical protein +FIG01328861 MoeB/thiF family protein +FIG01328866 Adenylate kinase, archaeal type (EC 2.7.4.3) +FIG01328893 putative iron-sulfur cluster assembly scaffold protein from Chlamydia +FIG01328895 Universal stress protein +FIG01328910 Two-component sensor histidine kinase, Nisin biosynthesis sensor NisK (EC 2.7.3.-) +FIG01328912 dehydrogenase clustered with L-fuconate utilization genes +FIG01328922 Amino acid (Glutamine) ABC transporter, periplasmic amino acid binding protein +FIG01328928 Cyclic nucleotide-binding domain +FIG01328942 Biopolymer transport protein +FIG01328952 DltE +FIG01328954 FIG00425218: hypothetical protein +FIG01328967 Hypothetical DUF1027 domain protein +FIG01328986 L-sorbosone dehydrogenase (EC 1.1.1.-) +FIG01328992 Low temperature requirement protein A +FIG01328999 ATP-citrate (pro-S-)-lyase, subunit 1 (EC 2.3.3.8) +FIG01329000 actin binding protein +FIG01329016 Putative ribosomal-protein-serine acetyltransferase +FIG01329031 Sensor protein +FIG01329032 Putative uncharacterized protein yybC +FIG01329052 FIG00414654: hypothetical protein +FIG01329057 FLAGELLAR PROTEIN G FLAG +FIG01329071 FIG00674320: hypothetical protein +FIG01329084 FIG01114684: hypothetical protein +FIG01329085 Putative transcription regulator +FIG01329086 putative ATPase, AAA+ family protein +FIG01329090 HIT family protein +FIG01329113 probable membrane protein YPO1564 +FIG01329124 contains alpha/beta hydrolase fold domain +FIG01329129 FIG00824705: hypothetical protein +FIG01329130 conserved hypothetical protein, putative transport protein +FIG01329131 Aminoacid specific permease +FIG01329139 Integrase +FIG01329143 putative resistance protein +FIG01329147 IncP-type DNA transfer maturation peptidase TraF +FIG01329153 Hemolysin-type calcium-binding protein +FIG01329154 FIG00402836: hypothetical protein +FIG01329159 Putative lipopolysaccharide biosynthesis protein +FIG01329162 FIG00822970: hypothetical protein +FIG01329163 FIG01217340: hypothetical protein +FIG01329165 spermine/spermidine acetyltransferase +FIG01329167 FIG00354920: hypothetical protein +FIG01329175 Bona fide RidA/YjgF/TdcF/RutC subgroup +FIG01329183 FIG00765373: hypothetical protein +FIG01329187 FIG00385054: hypothetical protein +FIG01329194 Reductase +FIG01329216 alkaline shock protein 23 +FIG01329218 ORF_ID:asl7678 unknown protein +FIG01329219 Shiga toxin I subunit B precursor +FIG01329228 B. burgdorferi predicted coding region BBA56 +FIG01329235 Methyltransferase (EC 2.1.1.-) +FIG01329244 FIG00426296: hypothetical protein +FIG01329245 FIG00350375: hypothetical protein +FIG01329256 FIG00846945: hypothetical protein +FIG01329274 Short-chain alcohol dehydrogenase family +FIG01329288 Poly-gamma-glutamate biosynthesis protein +FIG01329298 FIG00768216: hypothetical protein +FIG01329314 formyl transferase family protein +FIG01329321 VapB10 protein (antitoxin to VapC10) +FIG01329322 ADP-ribosylglycohydrolase family protein +FIG01329327 Molybdate transport repressor domain protein ModE +FIG01329336 FIG01045439: hypothetical protein +FIG01329342 Predicted transcriptional regulator for fatty acid degradation FadQ, TetR family +FIG01329344 Acyl-ACP thioesterase +FIG01329352 Pigment production hydroxylase (EC 1.-.-.-) +FIG01329356 FIG01235782: hypothetical protein +FIG01329360 Possible lipoprotein +FIG01329365 ADP-ribose 1"-phosphate phophatase related protein +FIG01329369 Siderophore synthetase superfamily, group B +FIG01329380 Putative transcriptional antiterminator, BglG family / PTS system, mannitol/fructose-specific IIA component (EC 2.7.1.69) +FIG01329381 EspA protein +FIG01329382 FIG00350228: hypothetical protein +FIG01329391 FIG00350134: hypothetical protein +FIG01329396 Response regulator of the LytR/AlgR family +FIG01329398 Zn-dependent protease +FIG01329413 FIG00408327: hypothetical protein +FIG01329420 HTH-type transcriptional regulator LrpC +FIG01329429 hypothetical protein +FIG01329440 putative hemagglutinin/hemolysin-related protein +FIG01329443 probable lipoprotein NMA0883 +FIG01329452 prophage LambdaBa04, DnaD replication protein, putative +FIG01329461 Putative inner membrane protein YqgA +FIG01329465 FIG00769141: hypothetical protein +FIG01329468 syc1400_d +FIG01329470 ATP-binding sugar transporter-like protein +FIG01329472 Methylcobalamin:coenzyme M methyltransferase MA3613 +FIG01329476 Sugar efflux transpoter +FIG01329481 FIG00623003: hypothetical protein +FIG01329490 FIG00387837: hypothetical protein +FIG01329494 RpfF protein +FIG01329504 Lmo1913 protein +FIG01329525 Pilin transcriptional activator +FIG01329538 acetobutylicum phosphotransbutyrylase +FIG01329544 Abi-alpha protein +FIG01329550 FIG006557: hypothetical protein +FIG01329559 FIG00769998: hypothetical protein +FIG01329565 Fucolectin-related protein +FIG01329580 probable DeoR-type transcriptional regulator +FIG01329585 Hypothetical transcriptional regulator yfjR +FIG01329590 Excinuclease ABC subunit C domain protein +FIG01329591 Adenylyl cyclase class-3/4/guanylyl cyclase / Disease resistance domain-containing protein / Tetratricopeptide repeat-containing protein / Transcriptional regulator, LuxR family +FIG01329593 Probable secreted protein containing HslJ-like protein +FIG01329618 FIG00643874: hypothetical protein +FIG01329628 FIG00515137: hypothetical protein +FIG01329641 FIG00769327: hypothetical protein +FIG01329645 helicase, UvrD/Rep family +FIG01329647 FIG00822530: hypothetical protein +FIG01329658 Pathogenicity-related protein +FIG01329683 FIG00402711: hypothetical protein +FIG01329706 FIG00351343: hypothetical protein +FIG01329708 Conserved protein containing a Zn-ribbon motif +FIG01329739 Regulatory protein Cro of bacteriophage BP-933W +FIG01329744 FIG00351713: hypothetical protein +FIG01329746 FIG01329746: membrane protein +FIG01329748 Multidrug resistance protein Atm1 +FIG01329760 Taurine ATP-binding component of a transport system +FIG01329761 Mycothiol conjugate amidase Mca (Mycothiol S-conjugate amidase) +FIG01329787 Methyl viologen resistance protein smvA +FIG01329803 FIG00765429: hypothetical protein +FIG01329807 Enhancing factor +FIG01329827 PROBABLE TRANSMEMBRANE PROTEIN +FIG01329837 phage protein-related protein +FIG01329840 POSSIBLE CONSERVED PROLINE RICH MEMBRANE PROTEIN +FIG01329842 hypothetical protein +FIG01329844 Aromatic-ring-hydroxylating dioxygenase, beta subunit (EC 1.14.12.3) +FIG01329857 probable solute binding protein of ABC transporter system +FIG01329860 major facilitator family protein +FIG01329862 Prolyl oligopeptidase family protein +FIG01329865 Benzodiazepine receptor TspO +FIG01329867 Carboxylesterase type B (EC 3.1.1.-) +FIG01329869 ABC transporter of unknown compound (not Fe3+), ATP-binding protein +FIG01329870 FIG00765107: hypothetical protein +FIG01329886 FIG00426491: hypothetical protein +FIG01329887 heparinase II/III-like protein +FIG01329890 FIG00849324: hypothetical protein +FIG01329893 FIG00640010: hypothetical protein +FIG01329896 Dicarboxylate MFS transporter +FIG01329915 ERCC4-type nuclease +FIG01329916 transmembrane transport protein possibly for shikimate +FIG01329917 FIG01247261: hypothetical protein +FIG01329924 FIG00847354: hypothetical protein +FIG01329928 VapB7 protein (antitoxin to VapC7) +FIG01329941 FIG00403233: hypothetical protein +FIG01329964 poly (glycerol-phosphate) alpha-glucosyltransferase +FIG01329983 Multidrug ABC exporter (DrugE2) family, ATP binding/membrane-spanning protein +FIG01329993 POSSIBLE RESOLVASE +FIG01329996 COG3173: Predicted aminoglycoside phosphotransferase +FIG01330012 FIG00769211: hypothetical protein +FIG01330013 Serine protease inhibitor (serpin family) +FIG01330020 Cosmid L247 +FIG01330022 Hypothetical transcriptional regulator yihL +FIG01330026 Secretory lipase precursor +FIG01330030 putative NADH:flavin oxidoreductase +FIG01330031 B. burgdorferi predicted coding region BBA48 +FIG01330032 FIG00387795: hypothetical protein +FIG01330045 Lyzozyme M1 (1,4-beta-N-acetylmuramidase) (EC 3.2.1.17) +FIG01330054 QbdB +FIG01330055 FIG00351246: hypothetical protein +FIG01330060 AmpG protein +FIG01330061 Transcriptional regulator TetR family +FIG01330063 N-acetylglucosaminyltransferase (EC 2.4.1.-) +FIG01330076 NAD binding site +FIG01330078 hypothetical protein, possible protease homolog +FIG01330087 Phosphoglycerol transferase and related proteins +FIG01330089 ORF_ID:tll1300 hypothetical protein +FIG01330090 Predicted phosphoribosyltransferases +FIG01330091 FIG00385359: hypothetical protein +FIG01330095 Alkaline ceramidase domain protein +FIG01330097 FIG01237617: hypothetical protein +FIG01330126 peptidase-like +FIG01330138 Putative phosphoesterase, GBAA2539 homolog +FIG01330141 FIG017032: hypothetical protein +FIG01330148 ISSth1, transposase (orf1), IS3 family +FIG01330172 Outer membrane protein FopA +FIG01330175 FIG00956601: hypothetical protein +FIG01330177 Putative nucleoside triphosphatase +FIG01330183 Cra +FIG01330196 Putative inner membrane lipoprotein +FIG01330208 Hemerythrin +FIG01330214 Uncharacterized siderophore biosynthesis protein near heme transporter HtsABC @ Siderophore synthetase superfamily, group B +FIG01330215 FIG01120270: hypothetical protein +FIG01330219 Patatin +FIG01330224 putative RapH phosphatase inhibitor +FIG01330225 FIG00849917: hypothetical protein +FIG01330228 SmrB +FIG01330230 2-alkenal reductase( EC:1.3.1.74 ) +FIG01330232 putative lipase +FIG01330236 LysR family transcriptional regulator +FIG01330242 FIG00762715: hypothetical protein +FIG01330276 cro-like repressor (phage associated) +FIG01330284 FIG00312315: hypothetical protein +FIG01330292 Putative Zn-dependent protease aq_972 +FIG01330293 CMAS family +FIG01330295 FIG00632033: hypothetical protein +FIG01330309 fatty acid hydroxylase-like protein +FIG01330315 Site-specific recombinase, phage integrase family +FIG01330316 MxaD protein +FIG01330320 Possible arsenate reductase (Glutaredoxin) (EC 1.20.4.1) +FIG01330324 FIG00762918: hypothetical protein +FIG01330341 secreted protein containing DUF1552 +FIG01330360 Oxidoreductase, 2OG-Fe(II) oxygenase family +FIG01330364 FIG00847402: hypothetical protein +FIG01330366 Periplasmic sugar-binding protein of sugar ABC transporter +FIG01330368 Extensin protein-like +FIG01330386 Phosphotransferase system cellobiose-specific component IIB +FIG01330391 FIG00762495: hypothetical protein +FIG01330392 Putative glutamine transport system permease +FIG01330396 Bona fide RidA/YjgF/TdcF/RutC subgroup +FIG01330400 heat shock protein, Hsp20 family +FIG01330402 probable metal-dependent peptidase +FIG01330403 DcaP +FIG01330404 FIG01204084: hypothetical protein +FIG01330417 N5,N10-methylenetetrahydromethanopterin reductase-related protein, BCG_2972c group +FIG01330419 FIG00351462: hypothetical protein +FIG01330433 Pleiotropic regulator of exopolysaccharide synthesis, competence and biofilm formation Ftr, XRE family +FIG01330438 FIG00350438: hypothetical protein +FIG01330445 Hypothetical protein yrhA +FIG01330474 ABC-type phosphate transport system, periplasmic component +FIG01330487 N-acetylglucosaminidase (EC 3.2.1.96) Auto +FIG01330488 CRP-like regulatory protein +FIG01330496 ABC polar amino acid transporter, inner membrane subunit +FIG01330500 Tir chaperone +FIG01330511 lprJ +FIG01330524 FIG01222362: hypothetical protein +FIG01330525 putative Na+/H+ exchange protein +FIG01330526 Putative ATP-dependent Lon protease +FIG01330529 FIG00454527: hypothetical protein +FIG01330530 FIG00519619: hypothetical protein +FIG01330533 FIG00384864: hypothetical protein +FIG01330539 Replication-associated protein +FIG01330544 Protease inhibitor SIL-V1/SIL-V4 +FIG01330551 Glycosyl transferase family protein, putative +FIG01330561 putative calcium/proton antiporter +FIG01330565 FIG00766109: hypothetical protein +FIG01330586 DNA replication protein DnaD +FIG01330597 Cell division protein ZipN/Ftn2/Arc6, specific for cyanobacteria and chloroplast +FIG01330603 Mlr5040 protein +FIG01330609 Insertion element IS1415 transposase (istA) and helper protein (istB) genes +FIG01330615 FIG00406739: hypothetical protein +FIG01330623 cation ABC transporter, periplasmic binding protein +FIG01330633 Sodium/hydrogen exchanger +FIG01330636 Tfp pilus assembly protein PilE +FIG01330637 FHA-domain containing protein +FIG01330641 Putative cytoplasmic protein +FIG01330649 Periplasmic fimbrial chaperone +FIG01330651 DNA topoisomerase III (EC 5.99.1.2), C-terminal domain +FIG01330652 Uncharacterized protein MJ1495 +FIG01330666 T. pallidum predicted coding region TP0592 +FIG01330672 electron transport protein, putative +FIG01330679 putative bacteroiocin operon protein +FIG01330691 FIG00350481: hypothetical protein +FIG01330703 Cps2H +FIG01330705 ABC transporter permease protein with unknown substrate +FIG01330712 Chitosanase +FIG01330726 cytochrome c, NapC/NirT family +FIG01330756 Uncharacterized conserved membrane protein, LemA family +FIG01330763 Acylamino-acid-releasing enzyme +FIG01330782 pyridoxal phosphate-dependent deaminase, putative +FIG01330785 Holin associated membrane protein 2 +FIG01330790 DNA alkylation repair enzyme +FIG01330793 Hypothetical protein SAV2252 +FIG01330796 DGPFAETKE domain protein +FIG01330802 FIG01029409: hypothetical protein +FIG01330815 uncharacterized ACR involved in oxidation of intracellular sulfur +FIG01330819 Peroxiredoxin family protein/glutaredoxin +FIG01330823 FIG017917: hypothetical protein +FIG01330826 UPF0098 protein ybcL precursor +FIG01330834 probable plasmid transfer protein +FIG01330844 sensory box sigma-54 dependent DNA-binding response regulator +FIG01330845 periplasmic binding protein +FIG01330865 Bacterial transcription activator, effector binding protein +FIG01330868 FIG00423915: hypothetical protein +FIG01330869 ketol-acid reductoisomerase( EC:1.1.1.86 ) +FIG01330873 TRANSCRIPTIONAL REGULATORY PROTEIN, LYSR FAMILY +FIG01330875 transglutaminase-like predicted protease +FIG01330882 Generic methyl-transferase +FIG01330900 FIG00451463: hypothetical protein +FIG01330925 Response regulator protein Z5684 +FIG01330930 FIG00733808: hypothetical protein +FIG01330932 FIG00410014: hypothetical protein +FIG01330937 FIG00403782: hypothetical protein +FIG01330940 Outer membrane receptor for lactoferrin or transferrin, TonB-dependent protein A +FIG01330943 Fragment flavodoxin oxidoreductase +FIG01330944 Two component transcriptional regulatory protein DevR +FIG01330945 Protein usg +FIG01330956 Negative regulator of genetic competence, sporulation and motility +FIG01330962 low similarity to 51 kDa seed maturation protein [Glycine max] GI:414977; contains Pfam profile PF02987: Late embryogenesis abundant protein; go_process: embryonic development (sensu Magnoliophyta) [goid 0009793] / late embryogenesis abundant domain-containing protein / LEA domain-containing protein +FIG01330976 FIG00766548: hypothetical protein +FIG01330978 FIG00829914: hypothetical protein +FIG01330982 FIG00769518: hypothetical protein +FIG01330984 transporter, monovalent cation:proton antiporter-2 family protein +FIG01330986 DUF309 domain-containing protein +FIG01330995 Class B acid phosphatase precursor (EC 3.1.3.2) +FIG01331003 Membrane-bound protease, CAAX family +FIG01331007 NhaP-type Na+/H+ and K+/H+ antiporters +FIG01331029 Uncharacterized protein MJ0811 +FIG01331036 hypothetical protein +FIG01331038 aminotransferase, DegT/DnrJ/EryC1/StrS family +FIG01331039 FIG223542: hypothetical protein +FIG01331046 Major Facilitator Superfamily transporter +FIG01331048 DNA polymerase III +FIG01331051 lactoylglutathione lyase, putative +FIG01331054 General stress protein 26 +FIG01331055 FIG01007305: hypothetical protein +FIG01331064 NADPH:quinone reductase and related Zn-dependent oxidoreductases +FIG01331066 hemolysin accessory protein +FIG01331082 FIG00766065: hypothetical protein +FIG01331085 FIG00877431: hypothetical protein +FIG01331086 probable leucine-responsive regulator +FIG01331105 FIG00820584: hypothetical protein +FIG01331108 Nitrogenase (vanadium-iron) cluster gene Avin0834 +FIG01331126 Metal dependent phosphohydrolase +FIG01331132 FIG00379838: hypothetical protein +FIG01331145 probable exported protein YPO0702 +FIG01331148 FIG00532638: hypothetical protein +FIG01331153 phosphoesterase PA-phosphatase related +FIG01331176 FIG00768148: hypothetical protein +FIG01331188 FIG00351299: hypothetical protein +FIG01331204 ribose/galactose ABC transporter, ATP-binding protein +FIG01331205 putative integral membrane ATPase +FIG01331222 ABC-type Fe3+-hydroxamate transport system, periplasmic component +FIG01331223 Phage minor structural protein +FIG01331240 FIG00351331: hypothetical protein +FIG01331255 putative galactosyl transferase PssJ +FIG01331260 FIG00347496: hypothetical protein +FIG01331271 Peptidase M19, renal dipeptidase +FIG01331274 hypothetical protein +FIG01331281 F1C minor fimbrial subunit protein G presursor +FIG01331299 dinitrogenase iron-molybdenum cofactor biosynthesis +FIG01331305 Monogalactosyldiacylglycerol synthase +FIG01331307 FIG01127042: hypothetical protein +FIG01331310 probable beta-lactamase +FIG01331314 FIG00388074: hypothetical protein +FIG01331319 Putative hydrolase +FIG01331324 CDS_ID OB2928 +FIG01331334 FIG00351999: hypothetical protein +FIG01331337 FIG00822902: hypothetical protein +FIG01331340 Sugar-binding transcriptional regulator, LacI family, putative +FIG01331347 FIG00450967: hypothetical protein +FIG01331348 Peptidase, M20A family +FIG01331358 hypothetical protein NMA1067 +FIG01331370 ferrous iron transport protein A, putative +FIG01331372 CBSS-293826.4.peg.2064: hypothetical protein +FIG01331379 secreted protein involved in flagellar motility +FIG01331389 putative transposase +FIG01331397 LysR family transcriptional regulator YahB +FIG01331400 Sll0839 protein +FIG01331407 FIG00756745: hypothetical protein +FIG01331432 FIG00774580: hypothetical protein +FIG01331434 sigma factor regulatory protein, FecR/PupR family +FIG01331445 Uncharacterized lipoprotein yceB precursor +FIG01331463 Putative copper chaperone +FIG01331473 TraA +FIG01331478 Putative phosphotransferase +FIG01331482 Atr protein +FIG01331484 Putative transcriptional regulatory protein +FIG01331488 FIG00764717: hypothetical protein +FIG01331490 FIG01238137: hypothetical protein +FIG01331492 FIG00407892: hypothetical protein +FIG01331494 FIG01166310: hypothetical protein +FIG01331507 probable NreB protein +FIG01331508 putative AMINO ACID ABC TRANSPORTER, BINDING PROTEIN PRECURSOR +FIG01331515 FIG01206517: hypothetical protein +FIG01331516 hypothetical protein +FIG01331532 FIG00709965: hypothetical protein +FIG01331536 Bll5163 protein +FIG01331540 NrfJ-related protein +FIG01331541 FIG00424637: hypothetical protein +FIG01331542 FIG00629220: hypothetical protein +FIG01331548 HP848-like protein +FIG01331549 Probable secreted glycosyl hydrolase +FIG01331558 FIG106692: Outer membrane lipoprotein +FIG01331568 Possible beta-xylosidase diverged, family 5/39 of glycosyl hydrolases and alpha-amylase C (Greek key) C-terminal domain +FIG01331571 probable bacteriocin/lantibiotic ABC transporter, ATP-binding protein +FIG01331573 Putative ligase protein (EC 6.-.-.-) +FIG01331590 FIG00388678: hypothetical protein +FIG01331595 adenine specific DNA methyltransferase (VSPIM) +FIG01331607 Peptidase S9, prolyl oligopeptidase active site region:Peptidase S9, prolyl oligopeptidase active site region precursor +FIG01331618 FIG00763501: hypothetical protein +FIG01331640 FIG00623349: hypothetical protein +FIG01331649 FIG00350261: hypothetical protein +FIG01331650 FIG00351108: hypothetical protein +FIG01331661 cement precursor protein 3B variant 2 +FIG01331664 FIG00402962: hypothetical protein +FIG01331668 Effector protein A, substrate of the Dot/Icm secretion system +FIG01331690 Spectinomycin phosphotransferase +FIG01331695 Similar to tetracycline resistance protein +FIG01331697 FIG00769609: hypothetical protein +FIG01331701 ABC transport protein, sugar-binding component yneA +FIG01331712 Possible flagellar biogenesis protein. precursor +FIG01331721 Protein YciF +FIG01331723 FIG00351134: hypothetical protein +FIG01331731 FIG00767795: hypothetical protein +FIG01331738 Putative phage protein +FIG01331741 FIG00348705: hypothetical protein +FIG01331748 sigmaB-controlled gene product +FIG01331760 Acyltransferase, ws/dgat/mgat subfamily protein +FIG01331770 FIG00404083: hypothetical protein +FIG01331777 Abc2 +FIG01331778 Putative major fimbrial subunit +FIG01331788 FIG00379820: hypothetical protein +FIG01331790 transcriptional regulator, rgg family +FIG01331801 Probable arabinosyltransferase A (EC 2.4.2.-) +FIG01331802 Putative dihydropyrimidine dehydrogenase [NADP+], similar to dihydroorotate dehydrogenase +FIG01331805 possible secreted protease +FIG01331811 FIG00765069: hypothetical protein +FIG01331815 Membrane associated protein +FIG01331822 Unclassified ABC-type transport system permease +FIG01331832 cytochrome c family protein +FIG01331848 Amino acid permease family protein +FIG01331849 Tryptophan-rich sensory protein +FIG01331854 FIG030001: hypothetical protein +FIG01331859 Short-chain dehydrogenase/reductase SDR +FIG01331863 FIG00363159: hypothetical protein +FIG01331866 Bll8034 protein +FIG01331867 Iron-sulfur cluster-binding protein, Rieske family +FIG01331873 Transposase and inactivated derivatives +FIG01331875 Alkylhydroperoxidase precursor +FIG01331897 NADH:ubiquinone oxidoreductase subunit 2 +FIG01331912 Adenylate cyclase (EC 4.6.1.1) +FIG01331924 FIG00510838: hypothetical protein +FIG01331930 Putative 8-amino-7-oxononanoate synthase +FIG01331958 4Fe-4S ferredoxin, iron-sulfur binding protein +FIG01331959 hypothetical protein +FIG01331960 MinD superfamily P-loop ATPase containing an inserted ferredoxin domain +FIG01331964 FIG00412134: hypothetical protein +FIG01331981 FIG00767634: hypothetical protein +FIG01331984 FIG00887139: hypothetical protein +FIG01331986 Two-component response regulator yhcZ +FIG01331990 FIG00350222: hypothetical protein +FIG01331995 Leukocidin/Hemolysin toxin family protein +FIG01331996 Probable histidine acid phosphatase (EC 3.1.3.2) +FIG01332003 Phage tail fiber +FIG01332017 Possible biopolymer transport protein, ExbB family +FIG01332031 FIG00822561: hypothetical protein +FIG01332040 Possible HipA protein +FIG01332051 FIG00623222: hypothetical protein +FIG01332056 BigB +FIG01332067 Thioesterase family protein domain protein +FIG01332068 Zn-ribbon-containing, possibly nucleic-acid-binding protein +FIG01332075 putative regulatory protein +FIG01332089 FIG00873981: hypothetical protein +FIG01332100 FIG00847870: hypothetical protein +FIG01332103 Glucose-6-phosphate 1-dehydrogenase (EC 1.1.1.49) +FIG01332107 Putative periplasmic binding protein +FIG01332116 Metallophosphoesterase precursor +FIG01332118 FIG00350869: hypothetical protein +FIG01332120 Acyl-CoA dehydrogenase (EC 1.3.8.1), Mycobacterial subgroup FadE36 +FIG01332121 Protein ecsC +FIG01332129 glyoxalase/bleomycin resistance +FIG01332145 FIG00426290: hypothetical protein +FIG01332163 Probable deoxyribodipyrimidine photolyase (EC 4.1.99.3) +FIG01332164 FIG00351557: hypothetical protein +FIG01332166 Probable binding-protein-dependent transport system protein +FIG01332167 FIG00424334: hypothetical protein +FIG01332169 Two-component sensor histidine kinase +FIG01332171 asparagine-rich antigen +FIG01332181 orf30 +FIG01332184 TerC family protein +FIG01332188 aminoglycoside phophotransferase family protein +FIG01332204 Transcription regulatory protein opdE +FIG01332209 Replication initiation protein +FIG01332227 FIG00767955: hypothetical protein +FIG01332229 Methyl-accepting chemotaxis signal transduction protein +FIG01332231 FIG01126469: hypothetical protein +FIG01332232 3-oxoacyl-(acyl-carrier-protein) reductase (fabG) +FIG01332244 Putative metabolite transport protein +FIG01332245 zinc finger, CDGSH-type domain protein +FIG01332251 Fucose 4-O-acetylase +FIG01332264 transposase alr7163 +FIG01332271 antigen S2-related protein +FIG01332276 membrane bound endonuclease (nuc) +FIG01332283 Tryptophan synthase beta chain +FIG01332287 FIG00768350: hypothetical protein +FIG01332291 POSSIBLE ESTERASE LIPOPROTEIN LPQC +FIG01332307 Phage conserved hypothetical protein, phiE125 gp8 +FIG01332312 POSSIBLE LIPOPROTEIN PEPTIDASE LPQM +FIG01332314 LysR-family transcriptional regulator VC0068 +FIG01332317 Hypothetical protein within Pathogenicity island SaPIn2 +FIG01332318 FIG00766208: hypothetical protein +FIG01332319 FIG00407300: hypothetical protein +FIG01332321 Transcriptional regulatory protein ComA (Bsu) +FIG01332325 hypothetical gene +FIG01332357 Two component transcriptional regulator +FIG01332365 peptidase, M48 family +FIG01332366 FIG00632000: hypothetical protein +FIG01332367 putative ATP synthase I +FIG01332370 FIG00687780: hypothetical protein +FIG01332380 FIG00833008: hypothetical protein +FIG01332382 DUF1893 domain-containing protein +FIG01332383 Diacetyl/L-xylulose reductase (EC 1.1.1.10) +FIG01332384 Possible periplasmic thioredoxin +FIG01332391 FIG00388035: hypothetical protein +FIG01332392 CotS-related protein +FIG01332393 conserved hypothetical protein [Pyrococcus horikoshii]; COG2102: Predicted ATPases of PP-loop superfamily; IPR002761: Domain of unknown function DUF71 +FIG01332399 protein of unknown function DUF521 +FIG01332400 possible exported protein +FIG01332401 FIG00526164: hypothetical protein +FIG01332402 FIG01118215: hypothetical protein +FIG01332409 Cpx6C +FIG01332415 N-ethylammeline chlorohydrolase +FIG01332424 flavodoxin-like fold domain protein +FIG01332425 protein of unknown function DUF901 +FIG01332428 MscS family mechanosensitive ion channel +FIG01332432 tonB-dependent receptor protein +FIG01332433 N-acetylmuramoyl-L-alanine amidase +FIG01332437 cytochrome c552 +FIG01332439 FIG00385558: hypothetical protein +FIG01332442 Probable VANILLIN dehydrogenase oxidoreductase protein (EC 1.-.-.-) +FIG01332460 Uncharacterized protein Rv0502/MT0523 +FIG01332473 amino acid carrier domain protein +FIG01332482 Probable transcription antiterminator, BglG family +FIG01332484 Acyl-CoA dehydrogenase (EC 1.3.8.1), Mycobacterial subgroup FadE7 +FIG01332488 iron compound ABC transporter, iron compound-binding protein +FIG01332507 FIG00412238: hypothetical protein +FIG01332509 Bacterial SH3 domain protein [Signal transduction mechanisms] +FIG01332517 DNA/RNA non-specific endonuclease +FIG01332520 FIG00351105: hypothetical protein +FIG01332559 FIG00820034: hypothetical protein +FIG01332561 COG0582: Integrase +FIG01332563 PRD/PTS system IIA 2 domain protein +FIG01332579 prevent-host-death family protein +FIG01332584 Dihydrolipoamide acyltransferases +FIG01332586 Putative PRS2 protein +FIG01332589 unknown phage protein +FIG01332609 Xanthine Phosphoribosyl Transferase; Xpt1p +FIG01332636 FIG00523307: hypothetical protein +FIG01332646 TonB dependent/Ligand-Gated channel +FIG01332653 (MTCY180.06), len: 334. fadB5, Possible oxidoreductase, similar to hydroxyacyl-CoA dehydrogenase, quinone oxidoreductases (EC 1.6.5.5) and polyketide synthases.Contains quinone oxidoreductase / zeta-crystallin signature(PS01162). FASTA results: Q53927 HYDROXYACYL-COA DEHYDROGENASE. (329 aa) opt: 621; E(): 2e-30; 39.5\% identity in349 aa overlap. Similar to many hypothetical M. tuberculosisproteins including: MTCY24G1.09, MTCY13D12.11, MTCY19H9.01, MTCY24G1.03, MTCY03A2.17c, etc. TBparse score is 0.921 +FIG01332658 putative fatty acid alpha hydroxylase +FIG01332661 Transcriptional regulatory protein pcoR +FIG01332666 probable LysR-family transcriptional regulator +FIG01332671 FIG00850081: hypothetical protein +FIG01332688 FIG00426070: hypothetical protein +FIG01332690 ABC-type polar amino acid transport system protein, ATP-binding protein +FIG01332693 FIG00765777: hypothetical protein +FIG01332696 Integrase-recombinase protein XERCD family +FIG01332706 Hypothetical protein SAV2264 +FIG01332722 DNA polymerase, bacteriophage-type (EC 2.7.7.7) +FIG01332727 Thioredoxin family protein +FIG01332728 Bll6261 protein +FIG01332732 FIG01230405: hypothetical protein +FIG01332740 NADPH dehydrogenase (EC 1.6.99.1) +FIG01332742 FIG00658471: hypothetical protein +FIG01332743 Lactose permease +FIG01332744 FIG00349963: hypothetical protein +FIG01332746 FIG00643271: hypothetical protein +FIG01332748 MarR-family transcriptional regulator +FIG01332750 FIG00527409: hypothetical protein +FIG01332751 FIG00417361: hypothetical protein +FIG01332753 D-aminoacylase (EC 3.5.1.81) +FIG01332755 Predicted tyrosine transporter, NhaC family +FIG01332778 Phage EaG protein +FIG01332785 ORFID:MW0043 +FIG01332802 FIG00352195: hypothetical protein +FIG01332814 Mlr9741 protein +FIG01332816 Sporulation kinase +FIG01332817 MaoC family protein +FIG01332818 FIG00632398: hypothetical protein +FIG01332834 FIG00765485: hypothetical protein +FIG01332844 FIG00469188: hypothetical protein +FIG01332861 Protein psiE homolog +FIG01332877 Tartrate-resistant acid phosphatase type 5 precursor (EC 3.1.3.2) +FIG01332894 Centrosomal protein Cep290 +FIG01332895 Thiol-disulfide isomerase and thioredoxin +FIG01332901 INTEGRAL MEMBRANE PROTEIN +FIG01332905 Xanthine/uracil permease family protein +FIG01332908 FIG00733971: hypothetical protein +FIG01332916 FIG00412737: hypothetical protein +FIG01332930 FIG00769029: hypothetical protein +FIG01332946 Acetyl xylan esterase 1; Cephalosporin-C deacetylase (EC 3.1.1.41) +FIG01332960 FIG01238652: hypothetical protein +FIG01332961 FIG022125: Phage-associated protein +FIG01332969 lysophospholipase L2, putative +FIG01332975 Putative hydrogenase protein +FIG01332989 FIG00520135: hypothetical protein +FIG01333002 Putative zinc metalloprotease +FIG01333010 O-Methyltransferase involved in polyketide biosynthesis +FIG01333022 FIG00711849: hypothetical protein +FIG01333030 cephalosporin C deacetylase +FIG01333039 Hypothetical protein SAV2142 +FIG01333042 FIG00532875: hypothetical protein +FIG01333044 FIG00873463: hypothetical protein +FIG01333052 Predicted periplasmic or secreted lipoprotein +FIG01333053 hypothetical membrane spanning protein +FIG01333055 Uncharacterized iron-regulated protein +FIG01333066 Competence protein ComGC +FIG01333072 TerC-like integral membrane protein +FIG01333077 spore coat protein, putative +FIG01333082 putative phage lysozyme +FIG01333084 virulence protein +FIG01333087 putative adhesin/invasin +FIG01333088 Hypothetical protein SAV2173 +FIG01333094 gamma-aminobutyrate (GABA) permease +FIG01333098 NtrC family Transcriptional regulator, ATPase domain +FIG01333100 FIG00643946: hypothetical protein +FIG01333114 FIG00638375: hypothetical protein +FIG01333126 FIG00904093: hypothetical protein +FIG01333132 FIG00763006: hypothetical protein +FIG01333133 Na+/H+ antiporter NhaP +FIG01333146 type IIS restriction enzyme R protein (MBOIIR) +FIG01333160 probable ribosylglycoyhdrolase +FIG01333162 membrane-associated lipoprotein (lpp20) +FIG01333174 FIG00442659: hypothetical protein +FIG01333177 Exotoxin 8 +FIG01333184 FIG00526708: hypothetical protein +FIG01333192 FIG00404371: hypothetical protein +FIG01333193 Maltose maltodextrin transport ATP-binding protein malK +FIG01333195 similar to nucleoside-diphosphate-sugar epimerases +FIG01333199 Spore coat protein W +FIG01333217 probable heat shock protein (hsp90 family) +FIG01333220 cytochrome P450 Rv0136 +FIG01333225 Acyl-CoA dehydrogenase (EC 1.3.99.-) +FIG01333235 ortholog of Bordetella pertussis (BX470248) BP2250 +FIG01333240 FIG00641324: hypothetical protein +FIG01333251 FIG00765151: hypothetical protein +FIG01333255 HTH DNA-binding protein +FIG01333256 FIG01116558: hypothetical protein +FIG01333269 Synthetic lethal KAR3-like protein +FIG01333292 ATP-binding region, ATPase domain protein domain protein +FIG01333296 Signal recognition particle protein SRP19 +FIG01333299 probable mechanosensitive ion channel +FIG01333302 FIG00424772: hypothetical protein +FIG01333307 glycosyl transferase, family 39 +FIG01333310 putative tellurium resistance protein +FIG01333313 hypothetical protein +FIG01333321 PROBABLE CONSERVED TRANSMEMBRANE ALANINE RICH PROTEIN +FIG01333326 transcriptional regulator, putative +FIG01333331 Carbohydrate-binding domain containing protein +FIG01333335 FIG00403423: hypothetical protein +FIG01333345 Molybdopterin binding domain +FIG01333346 Uncharacterized protein HI1720 +FIG01333352 Ethyl tert-butyl ether degradation EthD +FIG01333358 FIG01116033: hypothetical protein +FIG01333378 Na+/H+-dicarboxylate symporters +FIG01333386 membrane protein related to metalloendopeptidase +FIG01333392 Cationic amino acid transporter - APC Superfamily +FIG01333396 chaperone protein HchA +FIG01333399 Major capsid protein precursor +FIG01333404 FIG01048908: hypothetical protein +FIG01333409 FIG00624236: hypothetical protein +FIG01333417 Probable acetyltransferase +FIG01333431 hypothetical protein +FIG01333432 PROBABLE CONSERVED POLYKETIDE SYNTHASE ASSOCIATED PROTEIN PAPA4 +FIG01333435 2-pyrone-4,6-dicarboxylic acid hydrolase, putative +FIG01333437 permease protein of polyamine ABC transporter +FIG01333455 CorD2 protein (Fragment) +FIG01333468 dermonecrotic toxin +FIG01333496 ROK family protein, in a cluster with chitinase +FIG01333498 L-carnitine dehydratase/bile acid-inducible protein F +FIG01333504 Tll1574 protein +FIG01333510 Putative type-I secretion protein +FIG01333515 FIG00351973: hypothetical protein +FIG01333520 COG2932: Predicted transcriptional regulator +FIG01333523 Probable two-component sensor +FIG01333524 COG3464: Transposase and inactivated derivatives +FIG01333528 B. burgdorferi predicted coding region BB0305 +FIG01333533 ComEC like protein FIG012334 +FIG01333534 FIG015032: hypothetical protein +FIG01333537 FIG00765073: hypothetical protein +FIG01333538 ATP-grasp enzyme-like protein +FIG01333542 extensin-like protein +FIG01333551 Mlr2757 protein +FIG01333569 FIG00897215: hypothetical protein +FIG01333574 FIG00814282: hypothetical protein +FIG01333589 FIG00353810: hypothetical protein +FIG01333592 FIG00409864: hypothetical protein +FIG01333593 FIG00350342: hypothetical protein +FIG01333620 Acyltransferase family +FIG01333628 probable putative transmembrane protein +FIG01333634 FIG00352022: hypothetical protein +FIG01333645 putative cytochrome P450 hydroxylase +FIG01333648 FIG00848687: hypothetical protein +FIG01333665 ABC transporter substrate binding protein +FIG01333679 FIG00733751: hypothetical protein +FIG01333684 KED +FIG01333692 Mll2847 protein +FIG01333696 FIG01044654: hypothetical protein +FIG01333697 Transposase IS200-like +FIG01333705 Transcriptional regulator RhlR +FIG01333708 cell wall surface anchor family protein +FIG01333717 ESAT-6-like protein EsxH, 10 kDa antigen CFP7 +FIG01333721 FIG00850254: hypothetical protein +FIG01333742 Transcriptional regulator, AsnC family +FIG01333747 ABC-type Co2+ transport system, permease component +FIG01333752 two-component hybrid sensor and regulator( EC:2.7.3.- ) +FIG01333765 Possible lipoprotein LprC +FIG01333776 iron(III) ABC transporter, periplasmic iron-binding protein (ceuE) +FIG01333800 YhhN family membrane protein +FIG01333802 RepA domain protein +FIG01333811 Hypothetical protein SAV2303 +FIG01333817 Relaxase/mobilization nuclease domain containing protein +FIG01333820 conserved membrane protein, predicted permease +FIG01333828 N-acyl-D-glutamate deacylase +FIG01333839 Possible bicarbonate transporter, ICT family +FIG01333857 DNA/RNA helicase of DEAD/DEAH box family +FIG01333859 non-heme chloroperoxidase( EC:1.11.1.10 ) +FIG01333869 pXO2-27 +FIG01333872 Major antigenic peptide PEB2 +FIG01333885 FIG00644292: hypothetical protein +FIG01333888 DNA polymerase III subunit epsilon +FIG01333890 Plasmid stabilization system antitoxin protein +FIG01333894 Type IV pili associated protein +FIG01333901 SaPI1 Orf21 +FIG01333904 Prophage CP4-57 integrase +FIG01333907 Probable lysozyme from lambdoid prophage DLP12 (EC 3.2.1.17) +FIG01333908 FIG00641224: hypothetical protein +FIG01333909 FIG01180527: hypothetical protein +FIG01333912 UPF0148 protein SSO0781 +FIG01333913 FIG00354681: hypothetical protein +FIG01333920 syc0088_d +FIG01333925 FIG00403134: hypothetical protein +FIG01333932 FIG00351379: hypothetical protein +FIG01333938 putative lipopolysaccharide core biosynthesis glycosyl transferase protein +FIG01333942 FIG00847250: hypothetical protein +FIG01333943 FIG00405699: hypothetical protein +FIG01333948 nonribosomal peptide synthetase DhbF +FIG01333966 sensor histidine kinase +FIG01333977 FIG01239020: hypothetical protein +FIG01333979 FIG00350094: hypothetical protein +FIG01333994 FIG01205565: hypothetical protein +FIG01333999 probable membrane protein YPO4049 +FIG01334006 SEQ ID NO 15Q W +FIG01334026 Probable DNA recombinase +FIG01334027 D-aminopeptidase (EC 3.4.11.-) +FIG01334029 FIG00352485: hypothetical protein +FIG01334031 hypothetical protein +FIG01334041 HicB +FIG01334056 Putative iron-siderophore uptake system exported solute-binding component +FIG01334058 FIG00351489: hypothetical protein +FIG01334068 Outer membrane lipoprotein Blc +FIG01334069 Transposase +FIG01334071 glucokinase( EC:2.7.1.2 ) +FIG01334072 Predicted archaeal kinase (sugar kinase superfamily) +FIG01334083 phage-like protein +FIG01334089 FIG00767288: hypothetical protein +FIG01334091 FIG00965015: hypothetical protein +FIG01334129 DNA replication protein DnaD +FIG01334132 FIG01334132: Putative conserved alanine, valine and leucine rich integral membrane protein +FIG01334133 P. aerophilum family 453 +FIG01334150 IS630 ORF +FIG01334153 Large tegument protein +FIG01334178 N-acetylgalactosamine-6-sulfatase +FIG01334196 PTS system glucose-specific IIA component +FIG01334202 FIG01202676: hypothetical protein +FIG01334205 Probable sulfate exporter tauZ +FIG01334231 Doubtful CDS +FIG01334234 FIG00350933: hypothetical protein +FIG01334264 oxidoreductase, short chaindehydrogenase +FIG01334274 FIG00945103: hypothetical protein +FIG01334277 Adenylyl cyclase class-3/4/guanylyl cyclase / Transcriptional regulator, LuxR family +FIG01334279 ORF102 +FIG01334283 FIG00350505: hypothetical protein +FIG01334292 FIG00734341: hypothetical protein +FIG01334294 DNA-binding protein, phage associated +FIG01334311 tetracycline repressor protein (TetR family) +FIG01334312 putative SimX4 homolog +FIG01334314 Transcriptional repressor +FIG01334316 oxidoreductase, YhhX family +FIG01334322 FIG00622837: hypothetical protein +FIG01334324 FIG00820378: hypothetical protein +FIG01334335 Hypothetical protein SAV2322 +FIG01334346 putative fimbrial protein precursor +FIG01334358 IAA acetyltransferase (EC 2.3.1.-) +FIG01334360 FIG00698356: hypothetical protein +FIG01334370 YqzG +FIG01334375 FIG00413187: hypothetical protein +FIG01334378 FIG00769027: hypothetical protein +FIG01334386 FIG01239153: hypothetical protein +FIG01334391 Putative PQQ enzyme repeat +FIG01334394 FIG00412478: hypothetical protein +FIG01334395 FIG00820455: hypothetical protein +FIG01334418 Aldose 1-epimerase +FIG01334420 putative transfer protein +FIG01334422 pXO1-09 +FIG01334425 LysR-family transcriptional regulator VCA0830 +FIG01334427 FIG00406901: hypothetical protein +FIG01334428 PapG protein +FIG01334436 Lipopolysaccharide biosynthesis protein WzxC +FIG01334437 FIG00710256: hypothetical protein +FIG01334465 putative antirepressor - phage associated +FIG01334468 Cellulase M and related proteins +FIG01334482 glutathione S-transferase, fosfomycin resistance protein, putative +FIG01334501 FIG018632: Phage-associated protein +FIG01334506 Sigma-24 (FecI) +FIG01334507 FIG00350821: hypothetical protein +FIG01334508 Membrane protein related to Kef-type K+ transport system NAD-binding component +FIG01334512 transcriptional regulator, AbrB family +FIG01334515 Phage DNA transfer protein +FIG01334519 FIG00410900: hypothetical protein +FIG01334523 FIG00945166: hypothetical protein +FIG01334524 FIG00351259: hypothetical protein +FIG01334530 Uncharacterized protein yozF precursor +FIG01334542 PilV-like protein +FIG01334560 Protein hdeB precursor +FIG01334566 Lysine decarboxylase +FIG01334567 FIG00351128: hypothetical protein +FIG01334568 predicted transcriptional regulators +FIG01334570 probable serine protease +FIG01334572 NAD transporter of enosymbionts, possible +FIG01334576 LpqG Protein +FIG01334585 Putative glutamine transport ATP-binding protein +FIG01334593 FIG304026: hypothetical protein +FIG01334601 FIG00403728: hypothetical protein +FIG01334616 viral A-type inclusion protein, putative +FIG01334623 FIG00641630: hypothetical protein +FIG01334628 Putative Histidine protein kinase sensor +FIG01334632 Amidohydrolase family protein +FIG01334641 ABC transporter ATP-binding subunit +FIG01334642 CDP-abequose synthase (Fragment) +FIG01334643 Putative membrane receptor protein +FIG01334652 iron ABC transporter iron-binding protein, putative +FIG01334654 Protease VII (Omptin) precursor (EC 3.4.23.49) +FIG01334663 Pyridine nucleotide-disulphide oxidoreductase family protein +FIG01334679 Cassette chromosome recombinase A +FIG01334691 FIG00623903: hypothetical protein +FIG01334694 probable transmembrane protein +FIG01334706 FIG00824206: hypothetical protein +FIG01334707 FIG00351400: hypothetical protein +FIG01334711 FIG00406179: hypothetical protein +FIG01334718 FIG00640030: hypothetical protein +FIG01334727 disulphide isomerase +FIG01334750 Putative chaperone +FIG01334790 Amino-acid permease rocE +FIG01334793 FIG00523829: hypothetical protein +FIG01334808 cytochrome, putative +FIG01334819 FIG00351750: hypothetical protein +FIG01334831 hypothetical, predicted membrane protein (TMS5) +FIG01334849 FIG00407981: hypothetical protein +FIG01334851 Potassium channel TrkA, possible KefG analog required for KefB activity +FIG01334857 BRCA1 +FIG01334858 Predicted protein +FIG01334869 Bacitracin transport permease protein BCRB +FIG01334877 hopene-associated glycosyltransferase HpnB +FIG01334891 Iron (III) ABC transporter, ATP-binding protein +FIG01334895 FIG00641023: hypothetical protein +FIG01334906 FIG00344284: hypothetical protein +FIG01334914 Fibroin heavy chain precursor +FIG01334925 RecA-family ATPase +FIG01334926 POSSIBLE CONSERVED EXPORTED OR MEMBRANE PROTEIN +FIG01334937 Putative two-component regulator +FIG01334977 Bsl1589 protein +FIG01334983 probable multidrug efflux pump +FIG01334986 Putative transmembrane transport protein +FIG01335004 hypothetical bacteriophage protein +FIG01335005 FIG00823395: hypothetical protein +FIG01335011 probable carboxylesterase +FIG01335023 Potential AcrAB operon repressor +FIG01335028 RNA binding S1 domain protein +FIG01335037 Polysaccharide deacetylase, possible chitooligosaccharide deacetylase (EC 3.5.1.41) +FIG01335040 FIG00807791: hypothetical protein +FIG01335046 pyruvate kinase( EC:2.7.1.40 ) +FIG01335050 serine/threonine protein kinase with WD40 repeats +FIG01335051 FIG00767186: hypothetical protein +FIG01335058 putative amino acid ABC transporter +FIG01335062 FIG00524509: hypothetical protein +FIG01335064 FIG00643760: hypothetical protein +FIG01335071 Regulatory protein, LysR:LysR, substrate-binding precursor +FIG01335075 Putative amino-acid dehydratase (EC 4.2.-.-) +FIG01335094 FIG00698772: hypothetical protein +FIG01335103 aldose reductase, putative +FIG01335111 Osmotically inducible protein OsmC +FIG01335114 Nucleotide-diphosphate-sugar epimerase, membrane associated +FIG01335127 Nitrate/nitrite sensor protein (EC 2.7.3.-) +FIG01335155 Unknown, probable two-component sensor kinase +FIG01335158 Modification methylase HphIA (EC 2.1.1.37) +FIG01335161 membrane lipoprotein lipid attachment site +FIG01335174 heavy metal dependent transcription regulator (partial) +FIG01335182 Putative uncharacterized protein STY1876 (Putative uncharacterized protein) +FIG01335183 hypothetical protein +FIG01335186 Mlr1181 protein +FIG01335187 Polysaccharide export outer membrane protein +FIG01335207 Putative cold-shock protein +FIG01335208 FIG00841351: hypothetical protein +FIG01335209 putative Tricorn-like protease +FIG01335219 FIG00769126: hypothetical protein +FIG01335222 pXO1-140 +FIG01335230 putative phage-associated protein +FIG01335233 acyl carrier protein, putative +FIG01335236 xylose operon regulatory protein +FIG01335241 FIG01232828: hypothetical protein +FIG01335248 Aggregation promoting factor +FIG01335285 pH 6 antigen adhesin +FIG01335288 FIG00351932: hypothetical protein +FIG01335299 FIG00763560: hypothetical protein +FIG01335315 FIG00388774: hypothetical protein +FIG01335321 Phosphoribosylglycinamide synthetase, ATP-grasp (A) domain protein +FIG01335342 Pyridoxal-dependent decarboxylase family protein +FIG01335348 FIG00350137: hypothetical protein +FIG01335353 Transcriptional regulatory protein glnR +FIG01335385 FIG00354314: hypothetical protein +FIG01335403 Bacterocin transport accessory protein +FIG01335413 FIG00349962: hypothetical protein +FIG01335421 cGMP-gated cation channel alpha 1 +FIG01335423 UV DNA damage endonuclease (EC 3.-.-.-) +FIG01335433 FIG00351334: hypothetical protein +FIG01335435 Nonspecific acid phosphatase precursor (EC 3.1.3.2) (NSAP) +FIG01335442 FIG00521280: hypothetical protein +FIG01335482 IcmM protein +FIG01335486 AtsE protein +FIG01335491 adenine specific DNA methyltransferase (HINFIM) +FIG01335495 Bsl1363 protein +FIG01335514 AagD +FIG01335536 FIG00623242: hypothetical protein +FIG01335541 Sensory box/GGDEF domain protein +FIG01335546 FIG01119332: hypothetical protein +FIG01335551 hypothetical protein +FIG01335555 copE1 +FIG01335556 hypothetical protein +FIG01335561 FIG00639463: hypothetical protein +FIG01335572 syc2416_d +FIG01335575 FIG043360: Hypothetical protein +FIG01335578 aminotransferase, classes I and II +FIG01335589 FIG00527089: hypothetical protein +FIG01335599 FIG00763458: hypothetical protein +FIG01335609 SdbA +FIG01335643 FIG00763612: hypothetical protein +FIG01335660 FIG00351470: hypothetical protein +FIG01335661 DIM6/NTAB family protein +FIG01335676 FIG00405189: hypothetical protein +FIG01335677 putative transport protein (permease) +FIG01335682 serine/threonine phosphatase, putative +FIG01335692 Hns-dependent expression protein A (HdeA)(acid-resistance protein) +FIG01335699 FIG01235032: hypothetical protein +FIG01335716 Fe2+-dicitrate sensor, membrane component +FIG01335721 outer membrane protein (omp30) +FIG01335726 FIG00350667: hypothetical protein +FIG01335731 Methionyl-tRNA synthetase +FIG01335738 putative tellurique resistant protein (KlaB/TelA) +FIG01335744 Aspartate racemase +FIG01335747 nodulin 21-related protein +FIG01335759 Secretion system effector SseE +FIG01335776 N-ethylammeline chlorohydrolase +FIG01335789 Ca ion P-type ATPase +FIG01335790 FIG00568510: hypothetical protein +FIG01335791 Phosphoglycerol transferase +FIG01335798 serine esterase, cutinase family +FIG01335801 CBS/parB domain-containing protein +FIG01335806 FIG00425638: hypothetical protein +FIG01335827 Uncharacterized protein MJ1141 +FIG01335830 sensory transduction histidine kinase, putative +FIG01335844 Secretion protein HlyD family protein precursor +FIG01335859 ortholog of Bordetella pertussis (BX470248) BP2467 +FIG01335862 FIG00350673: hypothetical protein +FIG01335870 Squalene synthase (EC 2.5.1.21) +FIG01335879 FIG01114110: hypothetical protein +FIG01335882 FIG00639191: hypothetical protein +FIG01335886 FIG00640928: hypothetical protein +FIG01335895 hypothetical protein Rv3821 +FIG01335900 FIG00523178: hypothetical protein +FIG01335918 SyrM transcriptional regulator +FIG01335931 Probable glycosyltransferase (EC 2.4.1.-) +FIG01335934 Acetoacetate decarboxylase (EC 4.1.1.4) +FIG01335942 FIG00639603: hypothetical protein +FIG01335943 FIG00520096: hypothetical protein +FIG01335952 FIG048477: Hypothetical protein +FIG01335959 Phosphinothricin acetyltransferase +FIG01335967 pXO1-135 +FIG01335969 1-acylglycerol-3-phosphate O-acyltransferase precursor (EC 2.3.1.51) +FIG01335995 Phosphonoacetaldehyde phosphonohydrolase-related protein +FIG01336027 Carboxylesterase, type B +FIG01336037 Hypothetical protein SAV1752 +FIG01336040 FIG00350175: hypothetical protein +FIG01336047 Zn(II) or Co(II)-specific transcriptional repressor protein +FIG01336050 FIG00443813: hypothetical protein +FIG01336063 FIG00406549: hypothetical protein +FIG01336071 FIG00421893: hypothetical protein +FIG01336072 hypothetical protein +FIG01336076 Outer membrane hemin receptor +FIG01336078 FIG00751562: hypothetical protein +FIG01336083 AknN +FIG01336089 Endo-1,4-beta-xylanase D +FIG01336098 DNA ligase (ATP) (EC 6.5.1.1) +FIG01336101 FIG00350085: hypothetical protein +FIG01336114 gliding motility protein +FIG01336128 FIG00412396: hypothetical protein +FIG01336143 Uncharacterized protein MJ0068 +FIG01336147 FIG01127277: hypothetical protein +FIG01336156 FIG00404457: hypothetical protein +FIG01336163 FIG00402964: hypothetical protein +FIG01336165 Thermonuclease family protein( EC:3.1.31.1 ) +FIG01336169 RofA-like transcriptional regulator +FIG01336178 FIG01016542: hypothetical protein +FIG01336181 FIG00452071: hypothetical protein +FIG01336224 Putative lipoprotein in cluster with COG2110 +FIG01336228 Immunodominant antigen A +FIG01336230 O-methyltransferase-related protein +FIG01336232 plasmid replication protein, (pXO2-38) +FIG01336234 putative head-tail preconnector protein +FIG01336235 TPR-repeat-containing protein +FIG01336238 M. jannaschii predicted coding region MJ1339 +FIG01336243 FIG00624752: hypothetical protein +FIG01336249 Predicted Zn-dependent peptidases +FIG01336254 Integrase IntN1 +FIG01336259 putative cro repressor +FIG01336262 FIG00350665: hypothetical protein +FIG01336265 FIG00350669: hypothetical protein +FIG01336280 FIG00425521: hypothetical protein +FIG01336292 Sigma-70 region 4 +FIG01336309 Alpha-clostripain precursor (EC 3.4.22.8) +FIG01336314 FIG00406595: hypothetical protein +FIG01336315 conserved domain protein, putative +FIG01336323 tyrosine decarboxylase, putative +FIG01336330 HtrA2 +FIG01336350 Lipase, alpha/beta hydrolase fold family (EC 3.1.1.3) +FIG01336356 Putative phosphohydrolase, Icc family +FIG01336366 Predicted secreted alpha-N-acetylgalactosaminidase (EC 3.2.1.49) +FIG01336368 FIG01229163: hypothetical protein +FIG01336378 Serine esterase +FIG01336384 Protein of unknown function DUF208 +FIG01336388 FIG00403496: hypothetical protein +FIG01336391 Nucleoside-diphosphate-sugar pyrophosphorylase involved in lipopolysaccharide biosynthesis/translation initiation factor 2B, gamma/epsilon subunits (eIF-2Bgamma/eIF-2Bepsilon) +FIG01336409 Thiol-disulfide isomerase and thioredoxins +FIG01336424 FIG00523785: hypothetical protein +FIG01336429 putative transmembrane efflux protein +FIG01336432 Alpha/beta hydrolase fold (EC 3.8.1.5) +FIG01336439 putative membrane-anchored cell surface protein +FIG01336450 putative transcriptional regulator, AsnC family +FIG01336455 outer membrane protein H1 +FIG01336467 Trx +FIG01336474 FIG00763778: hypothetical protein +FIG01336487 FIG00637946: hypothetical protein +FIG01336501 NADH:ubiquinone oxidoreductase 49 kD subunit 7 +FIG01336502 Chemotaxis-inhibiting protein CHIPS, phage associated +FIG01336514 RNA methyltransferase, TrmH family +FIG01336547 putative membrane protein +FIG01336551 FIG00764990: hypothetical protein +FIG01336562 Conidiation-specific protein 10 +FIG01336581 Uncharacterized protein y4oW +FIG01336592 Pyruvate:Oxaloacetate transcarboxylase domain protein +FIG01336596 exotoxin homolog [Genomic island nu Sa alpha2] +FIG01336605 probable integral membrane protein NMA1899 +FIG01336608 Putative septum formation initiator-related protein +FIG01336613 FIG00639474: hypothetical protein +FIG01336618 FIG00635988: hypothetical protein +FIG01336619 FIG00628920: hypothetical protein +FIG01336627 FIG00350997: hypothetical protein +FIG01336641 FIG00828037: hypothetical protein +FIG01336644 FIG00624182: hypothetical protein +FIG01336657 probable vegetatible incompatibility protein HET-E-1 +FIG01336662 PLP-dependent aminotransferase NCgl2355 (class III) +FIG01336667 peptidoglycan-associated lipoprotein, putative +FIG01336671 FIG00767239: hypothetical protein +FIG01336674 NUDIX-family protein +FIG01336685 comB9 competence protein +FIG01336690 FIG00638911: hypothetical protein +FIG01336693 Putative cytochrome c oxidase, subunit I +FIG01336700 FIG00529943: hypothetical protein +FIG01336709 FIG00410563: hypothetical protein +FIG01336713 Extradiol ring-cleavage dioxygenase, class III enzyme, subunit B +FIG01336730 FIG00765853: hypothetical protein +FIG01336741 Acyltransferase +FIG01336751 Transthyretin-like periplasmic protein +FIG01336752 blr6059; putative cyclase +FIG01336754 O-antigen biosynthesis protein RfbC +FIG01336768 FIG00403275: hypothetical protein +FIG01336773 ABC-type Mn2+/Zn2+ transport systems, permease components +FIG01336779 FIG01230994: hypothetical protein +FIG01336785 transposase +FIG01336792 transcriptional regulator, LysR family protein +FIG01336800 putative fimbrial subunit +FIG01336806 FIG01200331: hypothetical protein +FIG01336807 similar to CG12933-PA [Source:RefSeq_peptide;Acc:XP_392542] +FIG01336810 Possible purine/pyrimidine phosphoribosyltransferase +FIG01336815 FIG00562470: hypothetical protein +FIG01336820 FIG00450334: hypothetical protein +FIG01336839 putative electron transfer flavoprotein (FixA protein) +FIG01336842 A. fulgidus predicted coding region AF1183 +FIG01336843 FIG00660141: hypothetical protein +FIG01336851 putative glycosyltransferase( EC:2.4.1.17 ) +FIG01336852 sporulation kinase A +FIG01336856 Na+ ABC transporter, NATB +FIG01336857 putative phytase precursor +FIG01336858 NADPH:quinone reductase +FIG01336894 FIG00521676: hypothetical protein +FIG01336895 no significant similarities +FIG01336897 FIG00408309: hypothetical protein +FIG01336900 Cys-Xaa-Xaa-Xaa system radical SAM maturase +FIG01336903 FIG00404031: hypothetical protein +FIG01336907 translocated intimin receptor Tir +FIG01336927 4-vinyl reductase 4VR +FIG01336962 beta-ribofuranosylaminobenzene 5'-phosphate synthase +FIG01336971 FIG00472706: hypothetical protein +FIG01336978 5'-methylthioadenosine phosphorylase (EC 2.4.2.28) / putative esterase +FIG01337001 FIG01130755: hypothetical protein +FIG01337005 FIG01116936: hypothetical protein +FIG01337006 prophage MuMc02, terminase, ATPase subunit, putative +FIG01337020 FIG00351328: hypothetical protein +FIG01337039 FIG00411375: hypothetical protein +FIG01337044 hypothetical +FIG01337063 CAAX amino terminal protease +FIG01337066 DNA polymerase III (CHI subunit) protein (EC 2.7.7.7) +FIG01337069 Probable L-amino-acid oxidase (EC 1.4.3.2) +FIG01337084 IS605/IS200-like transposase +FIG01337086 FIG006789: Stage V sporulation protein +FIG01337094 DNA-binding protein hmvA +FIG01337096 FIG01070097: hypothetical protein +FIG01337108 conserved hypothetical protein-putative ATP/GTP-binding protein +FIG01337115 Unspecified monosaccharide ABC transport system, permease component Ia (FIG025991) +FIG01337117 Pyridoxine 5'-phosphate oxidase, Rv1155 +FIG01337131 FIG00946098: hypothetical protein +FIG01337132 FIG00344884: hypothetical protein +FIG01337136 FIG00712798: hypothetical protein +FIG01337146 Membrane protein EccE3, component of Type VII secretion system ESX-3 +FIG01337154 1-Acyl-sn-glycerol-3-phosphate acyltransferase (EC 2.3.1.51) +FIG01337155 FIG00350439: hypothetical protein +FIG01337156 FIG00403009: hypothetical protein +FIG01337175 FIG00944925: hypothetical protein +FIG01337177 Enterotoxin, phage associated +FIG01337186 putative cytochrome P450 hydroxylase +FIG01337189 Phage holin; Phage endolysin +FIG01337190 hypothetical protein +FIG01337193 Prolyl oligopeptidase +FIG01337195 Conjugal transfer protein TraB +FIG01337197 bacteriophage lysin +FIG01337203 PROBABLE SOLUTE-BINDING PERIPLASMIC (PBP) ABC TRANSPORTER PROTEIN +FIG01337215 FIG01048484: hypothetical protein +FIG01337236 FIG00404335: hypothetical protein +FIG01337247 toxin-antitoxin system, toxin component, HicA family +FIG01337282 putative transposase +FIG01337286 Putative ABC transport system permease protein +FIG01337289 FIG00413813: hypothetical protein +FIG01337318 Neutrophil activating factor +FIG01337324 FIG00348027: hypothetical protein +FIG01337345 resolvase domain protein +FIG01337361 antirestriction protein +FIG01337363 FIG00643647: hypothetical protein +FIG01337377 FIG00838162: hypothetical protein +FIG01337380 FIG00350256: hypothetical protein +FIG01337418 FIG00531767: hypothetical protein +FIG01337422 FOG: TPR repeat protein +FIG01337426 Carboxylesterase/phospholipase family protein (EC 3.1.1.1) +FIG01337433 FIG00657800: hypothetical protein +FIG01337457 Hypothetical protein, specific for Vibrio +FIG01337458 conserved hypothetical integral membrane protein +FIG01337464 Protein of unknown function DUF306 +FIG01337465 hypothetical protein +FIG01337474 FIG01120332: hypothetical protein +FIG01337476 tributyrin esterase +FIG01337479 multidrug efflux MFS transporter putative +FIG01337481 Enhancin (EC 3.4.24.-) +FIG01337483 FIG00516734: hypothetical protein +FIG01337485 Protein KIAA0853 +FIG01337494 putative ABC transporter (ATP-binding protein) +FIG01337507 FIG01233045: hypothetical protein +FIG01337515 FIG00763430: hypothetical protein +FIG01337519 PE family protein +FIG01337526 COG1295: Predicted membrane protein +FIG01337531 PROBABLE TWO COMPONENT SENSOR KINASE [SECOND PART] +FIG01337537 Putative O-acetyltransferase SAS0844 (EC 2.3.1.-) +FIG01337547 FIG00765925: hypothetical protein +FIG01337555 Dipeptidyl peptidase IV +FIG01337572 putative periplasmic protein (vacJ homolog) +FIG01337580 orf27 +FIG01337582 YfdE protein +FIG01337590 Phage related transcriptional regulator (Xre family) +FIG01337591 Transposase, IS630-Spn1 related, Orf2 +FIG01337597 Choloylglycine hydrolase family protein +FIG01337610 FIG00512724: hypothetical protein +FIG01337614 FIG00367959: hypothetical protein +FIG01337622 FIG00351785: hypothetical protein +FIG01337623 Mandelate racemase (EC 5.1.2.2) +FIG01337637 FIG00627389: hypothetical protein +FIG01337638 FIG00416574: hypothetical protein +FIG01337641 Amino acid ABC transporter, permease component +FIG01337649 orf7 +FIG01337651 Putative toxin transport protein +FIG01337669 Probable transcription regulator arfM +FIG01337674 very large virion protein (tegument) +FIG01337678 FIG00630491: hypothetical protein +FIG01337680 probable late competence protein +FIG01337684 MFS-type bicyclomycin resistance protein +FIG01337688 COG1109: Phosphomannomutase +FIG01337690 putative phosphoesterase +FIG01337705 FIG00272376: hypothetical protein +FIG01337711 Spindolin-related protein +FIG01337712 hypothetical protein +FIG01337722 syc0674_c +FIG01337732 cytochrome c oxidase, subunit IV +FIG01337747 FIG01114467: hypothetical protein +FIG01337748 Probable c-type cytochrome biogenesis protein +FIG01337753 FIG00418137: hypothetical protein +FIG01337765 collagen-binding surface protein +FIG01337767 EAL domain protein +FIG01337780 phenylalanyl-tRNA synthetase, beta subunit( EC:6.1.1.20 ) +FIG01337783 aminotransferase +FIG01337797 related to TraI protein (partial length) +FIG01337802 COP associated protein +FIG01337812 ribulose-5-phosphate 4-epimerase and related epimerases and aldolases +FIG01337818 3-methylmercaptopropionyl-CoA ligase (DmdB) +FIG01337820 IncI1 plasmid conjugative transfer protein TraS +FIG01337829 Involved in expression of fibrinogen binding protein +FIG01337835 ABC-type transporter, periplasmic domain +FIG01337836 FIG00641069: hypothetical protein +FIG01337849 FIG00531460: hypothetical protein +FIG01337874 Porin B precursor +FIG01337875 FIG00405317: hypothetical protein +FIG01337899 FIG00424012: hypothetical protein +FIG01337908 similarity to probable RND efflux transporter +FIG01337911 phaP protein +FIG01337912 FIG01094671: hypothetical protein +FIG01337918 FIG00350577: hypothetical protein +FIG01337926 FIG00350537: hypothetical protein +FIG01337943 unknown in ISEc8 +FIG01337950 BexA, multidrug efflux pump +FIG01337951 Twin-arginine translocation protein TatAd +FIG01337952 Bll0510 protein +FIG01337979 FIG00411713: hypothetical protein +FIG01337982 Methyltransferase (EC 2.1.1.-) +FIG01337983 protease Do( EC:3.4.21.- ) +FIG01337986 Avirulence protein +FIG01337998 FIG00409633: hypothetical protein +FIG01338019 TPR/glycosyl transferase domain protein +FIG01338030 Transcription regulator protein, response regulator containing CheY- like receiver domain and HTH DNA-binding domain +FIG01338032 FIG00768439: hypothetical protein +FIG01338033 macrolide efflux pump, putative +FIG01338035 B. burgdorferi predicted coding region BB0796 +FIG01338075 similarity to lipopolysaccharide biosynthesis protein +FIG01338077 Resolvase, N-terminal:Recombinase +FIG01338087 FIG00767380: hypothetical protein +FIG01338092 FIG00687870: hypothetical protein +FIG01338103 Probable conserved integral membrane protein +FIG01338127 NADH:flavin oxidoreductases, Old Yellow Enzyme family +FIG01338148 Collagenase and related proteases +FIG01338163 Predicted GTPases (dynamin-related) +FIG01338166 (MTV002.20c), len: 91 aa. hsdS', possible type I restriction/modification system specificity determinant (S protein), similar to the N-terminus of hsdS from Klebsiella pneumoniae TR:G2408222 EMBL:KPU93843 hsdS (439 aa), fasta scores; opt: 303 z-score: 539.0 E(): 7.2e-23, 46.7%identity in 90 aa overlap and Salmonella enterica TR:P72419EMBL:X99719 STY SBLI (434 aa), fasta scores; opt: 278 z-score: 511.0 E(): 2.6e-21, 47.7% identity in 86 aa overlap,but considerably shorter than both. +FIG01338173 PUTATIVE EXCISIONASE +FIG01338175 Slr1117 protein +FIG01338179 FIG00826490: hypothetical protein +FIG01338196 3'-5' exonuclease +FIG01338198 FIG00384926: hypothetical protein +FIG01338201 DNA-binding protein H-NS homolog +FIG01338207 metal dependent hydrolase, putative +FIG01338213 Sugar kinase +FIG01338229 Outer membrane usher protein PmfC +FIG01338230 pXO1-125 +FIG01338232 FIG00523556: hypothetical protein +FIG01338237 Predicted metal-binding protein of ferredoxin fold +FIG01338239 FIG00353310: hypothetical protein +FIG01338255 FIG00385071: hypothetical protein +FIG01338256 acetyltransferase, GNAT family family +FIG01338265 EPS I polysaccharide export outer membrane protein EPSA precursor +FIG01338277 Lipase/esterase LipN +FIG01338294 Hsp20/alpha crystallin family protein +FIG01338306 metabolite:H+ symporter (MHS) family protein +FIG01338329 Outer membrane protein G1b +FIG01338335 Methionine synthase II (cobalamin-independent) +FIG01338339 probable ABC transporter permease protein SMb21204 +FIG01338341 Homeodomain-like +FIG01338348 Dabb +FIG01338355 sodium-dependent transporter +FIG01338371 putative CsbD-like family protein +FIG01338374 FIG00530056: hypothetical protein +FIG01338385 transcriptional regulator, LuxR autoinducer regulated family +FIG01338400 No significant database hits +FIG01338403 MgtC family +FIG01338404 Smr domain family protein +FIG01338428 VirB8 protein +FIG01338429 Type I restriction enzyme EcoR124II M protein (EC 2.1.1.72) +FIG01338433 luciferase-like monooxygenase +FIG01338444 no significant homology. Putative N-terminal signal sequence was found by PSORT +FIG01338445 hypothetical protein +FIG01338447 putative transcriptional regulator ToxR +FIG01338457 FIG00385259: hypothetical protein +FIG01338461 colicin V precursor +FIG01338467 Modulator of drug activity B +FIG01338471 HU-like DNA-binding protein +FIG01338474 MerR-type transcriptional regulator +FIG01338475 PROBABLE CONSERVED LIPOPROTEIN LPPR +FIG01338477 FIG00638982: hypothetical protein +FIG01338489 Glycosyl hydrolase, BNR repeat +FIG01338493 FIG00823996: hypothetical protein +FIG01338495 Type V autotransporter +FIG01338503 Protein ycgK precursor +FIG01338508 FIG00389343: hypothetical protein +FIG01338511 FIG00948954: hypothetical protein YciN +FIG01338514 PAS/PAC domain containing protein +FIG01338522 Uncharacterized paraquat-inducible protein B +FIG01338532 FIG00643033: hypothetical protein +FIG01338533 Wide host range virA protein (EC 2.7.3.-) +FIG01338535 FIG00644547: hypothetical protein +FIG01338553 FIG00518482: hypothetical protein +FIG01338555 Uncharacterized protein conserved in bacteria +FIG01338561 acetylornithine deacetylase/succinyl-diaminopimelate desuccinylase-like protein +FIG01338564 Arabinogalactan endo-1,4-beta-galactosidase precursor (EC 3.2.1.89) +FIG01338576 Hypothetical protein in cluster with DNA polymerase III epsilon subunit +FIG01338579 Hemerythrin-like protein CA_C0069 +FIG01338580 decarboxylase, pyridoxal-dependent +FIG01338595 FIG00408452: hypothetical protein +FIG01338601 General stress protein 16O (GSP16O) +FIG01338603 Glucan-binding protein +FIG01338606 Orf15 +FIG01338608 IcmL-like +FIG01338615 predicted periplasmic lipoprotein +FIG01338626 FIG00530610: hypothetical protein +FIG01338630 FIG00350435: hypothetical protein +FIG01338639 Glycerate dehydrogenase (EC 1.1.1.29) +FIG01338641 FIG01251335: hypothetical protein +FIG01338643 FIG00407655: hypothetical protein +FIG01338644 IS1478 transposase +FIG01338647 ATPase components of ABC transporters with duplicated ATPase domains +FIG01338652 FIG00403100: hypothetical protein +FIG01338661 FIG00922638: hypothetical protein +FIG01338668 hypothetical protein +FIG01338676 FIG00515668: hypothetical protein +FIG01338695 FIG01221066: hypothetical protein +FIG01338701 FIG00767816: hypothetical protein +FIG01338710 stability (stb) locus of IncFII plasmid NR1; similar to SwissProt accession number P11907 +FIG01338721 tail attachment protein +FIG01338727 Prepilin-type N-terminal cleavage/methylation domain-containing protein +FIG01338734 Type II restriction enzyme Eco47II (EC 3.1.21.4) +FIG01338736 Lysine biosynthesis protein LysW +FIG01338737 FIG00775381: hypothetical protein +FIG01338743 conserved protein YnzC +FIG01338774 FIG00352869: hypothetical protein +FIG01338778 possible metallo beta lactamase superfamily protein +FIG01338779 Transcription antiterminator, BglG family +FIG01338791 Small GTP-binding protein domain +FIG01338794 FIG00766539: hypothetical protein +FIG01338798 Predicted lysine transporter, NhaC family +FIG01338800 FIG00408376: hypothetical protein +FIG01338801 FIG00351427: hypothetical protein +FIG01338806 FIG00828220: hypothetical protein +FIG01338818 truncated IS232 IstA protein homolog +FIG01338823 ORF_ID:alr7559 unknown protein +FIG01338833 probable periplasmic protein NMA0556 +FIG01338836 Amino acid ABC transporter, glutamine-binding protein/permease protein +FIG01338843 amine oxidase, flavin-containing +FIG01338851 phospholipase/carboxylesterase family protein +FIG01338852 Transmembrane transport protein MmpL1 +FIG01338866 Hypothetical protein SAV2085 +FIG01338875 FIG01209776: hypothetical protein +FIG01338881 transcriptional repressor of the xylose operon +FIG01338896 BolA-like protein +FIG01338900 Truncated NADH dehydrogenase subunit +FIG01338903 D-aminopeptidase dipeptide-binding protein DppA (EC 3.4.11.-) +FIG01338908 PspA +FIG01338914 Putative ankyrin repeat protein FPV115 +FIG01338922 Putative glycosyl hydrolase of unknown function (DUF1680) +FIG01338948 amidohydrolase +FIG01338951 FIG00822853: hypothetical protein +FIG01338957 FIG00472363: hypothetical protein +FIG01338968 Putative periplasmic protein YibQ, distant homology with nucleoside diphosphatase and polysaccharide deacetylase +FIG01338971 Sugar ABC transporter, sugar permease protein 1 USSDB1C +FIG01338972 FIG00468268: hypothetical protein +FIG01338977 FIG00823201: hypothetical protein +FIG01338978 Benzoate-specific porin +FIG01338983 FIG00822755: hypothetical protein +FIG01338985 Alcohol dehydrogenase, zinc containing (EC 1.1.1.1) +FIG01338993 Uncharacterized protein MJ0545 +FIG01339001 putative phosphatase/phosphohexomutase +FIG01339004 sporulation kinase C( EC:2.7.3.- ) +FIG01339007 PUTATIVE ZINC PROTEASE PROTEIN +FIG01339022 Mlr2351 protein +FIG01339024 FIG01211334: hypothetical protein +FIG01339028 Putative type-1 secretion protein +FIG01339031 FIG00767819: hypothetical protein +FIG01339033 RbsD/FucU transport protein family +FIG01339036 GCN5-like N-acetyltransferase +FIG01339037 periplasmic protein-probably involved in high-affinity Fe2+ transport +FIG01339080 FIG00899452: hypothetical protein +FIG01339093 FIG01204941: hypothetical protein +FIG01339095 NrdR-regulated deoxyribonucleotide transporter, PnuC-like +FIG01339136 Putative 2-acylglycerophosphoethanolamine acyltransferase / acyl-acyl carrier protein synthetase (EC 6.2.1.20) +FIG01339140 probable lipoprotein YPO0703 +FIG01339141 Transcriptional repressor AdcR for Zn(2+)-responsive expression +FIG01339146 FIG00344876: hypothetical protein +FIG01339147 FIG00644871: hypothetical protein +FIG01339152 FIG00667438: hypothetical protein +FIG01339153 ABC-type sugar transport system, permease components +FIG01339155 FIG00623597: hypothetical protein +FIG01339156 FIG01233922: hypothetical protein +FIG01339163 NDP-4-ketoreductase +FIG01339184 FIG00642543: hypothetical protein +FIG01339186 FIG01206062: hypothetical protein +FIG01339193 FIG00385048: hypothetical protein +FIG01339197 Phage endopeptidase +FIG01339202 NADH-ubiquinone oxidoreductase subunit +FIG01339208 FIG00782348: hypothetical protein +FIG01339212 oxidoreductase, putative +FIG01339217 FIG00639203: hypothetical protein +FIG01339218 D-amino acid oxidase +FIG01339225 FIG00352273: hypothetical protein +FIG01339227 Sodium:dicarboxylate symporter precursor +FIG01339229 FIG01069281: hypothetical protein +FIG01339231 FIG00769063: hypothetical protein +FIG01339255 UPF0004 protein MJ0865 +FIG01339284 B. burgdorferi predicted coding region BBG24 +FIG01339285 B. burgdorferi predicted coding region BB0776 +FIG01339293 4-carboxymuconolactone decarboxylase domain/alkylhydroperoxidase AhpD family core domain protein +FIG01339295 transcription regulator, LysR family +FIG01339297 Rieske 2Fe-2S iron-sulfur protein +FIG01339300 type 1 capsular polysaccharide biosynthesis protein J (capJ) +FIG01339301 Mu-like prophage protein gp36 +FIG01339311 oxidoreductase, FAD-binding +FIG01339319 Probable glutathione S-transferase-related transmembrane protein (EC 2.5.1.18) +FIG01339321 putative NAD(P)H dehydrogenase +FIG01339322 FIG00403199: hypothetical protein +FIG01339331 hypothetical protein +FIG01339332 FIG00639685: hypothetical protein +FIG01339343 FIG01339343: possible membrane protein +FIG01339344 FIG00527991: hypothetical protein +FIG01339348 Protein of unknown function DUF348:3D:G5 +FIG01339353 alcohol dehydrogenase, zinc containing +FIG01339355 tRNA dihydrouridine synthase A +FIG01339357 evidence experimental PMID:7883712; cell envelope; murein sacculus and peptidoglycan; muramidase needed for cell separation and responsible for autolysis +FIG01339365 probable oxidoreductase/Short-chain dehydrogenase +FIG01339371 Multi-sensor Hybrid Histidine Kinase( EC:3.1.1.61 ) +FIG01339384 conserved protein of unknown function; putative enzyme +FIG01339386 FIG00349940: hypothetical protein +FIG01339396 PROBABLE SHORT-CHAIN TYPE DEHYDROGENASE/REDUCTASE (EC 1.-.-.-) +FIG01339412 Transcription regulator +FIG01339421 small multidrug export protein (qacE) homolog +FIG01339428 FIG00350628: hypothetical protein +FIG01339429 FIG00425997: hypothetical protein +FIG01339437 isochorismatase family protein +FIG01339438 Na+/H+ exchange protein +FIG01339453 N-acetyltransferase family protein +FIG01339454 probable integral membrane protein NMA0537 +FIG01339470 hydrolase, carbon-nitrogen family +FIG01339476 FIG00632156: hypothetical protein +FIG01339479 putative ATP binding protein of a transporter +FIG01339484 Ydjc like protein +FIG01339487 contains alpha/beta hydrolases domain +FIG01339489 Predicted esterase of the alpha-beta hydrolase superfamily +FIG01339492 Probable two-component system transcriptional regulator +FIG01339499 PhaQ: a PHB-responsive repressor controlling expression of phaP and phaQ +FIG01339513 ECF-family sigma factor +FIG01339517 PROBABLE LIPOPROTEIN LPPT +FIG01339524 ABC-type cobalamin/Fe3+-siderophores transport systems ATPase components-like protein +FIG01339554 Arylesterase +FIG01339564 RGD-containing lipoprotein +FIG01339584 cystathionine beta-synthase( EC:4.2.1.22 ) +FIG01339589 FIG01232189: hypothetical protein +FIG01339590 ParA family protein +FIG01339596 COG4367: Uncharacterized protein conserved in bacteria +FIG01339598 Bacteriophage phi gp55-like protein +FIG01339625 Insertion sequence B9 +FIG01339638 "DNA-binding protein, CopG family" +FIG01339647 Transcriptional regulator, GntR family, homolog 2 +FIG01339650 FIG00632176: hypothetical protein +FIG01339656 Xenobiotic flavin oxidoreductase A +FIG01339665 F-box protein +FIG01339668 gene 36 protein, putative +FIG01339669 FIG035174: membrane protein +FIG01339676 syc0748_d +FIG01339679 FIG01240896: hypothetical protein +FIG01339683 Uncharacterized protein yrzK +FIG01339687 conserved hypothetical protein transmembrane +FIG01339697 AstB/ChuR-related protein +FIG01339710 FIG01236323: hypothetical protein +FIG01339713 Peptidase, M23/M37 family +FIG01339737 Predicted phosphatases +FIG01339742 glutamate ABC transporter permease protein +FIG01339746 FIG00824320: hypothetical protein +FIG01339753 AMP-dependent synthetase and ligase( EC:6.2.1.17 ) +FIG01339771 FIG00350996: hypothetical protein +FIG01339775 Hypothetical protein SAV2300 +FIG01339784 Pyridoxal phosphate-dependent aminotransferase +FIG01339793 Type IIA topoisomerase (DNA gyrase/topo II, topoisomerase IV), A subunit +FIG01339794 DNA gyrase subunit A +FIG01339806 FIG00351189: hypothetical protein +FIG01339842 Sugar ABC transporter, permease protein precursor +FIG01339851 ABC-type phosphate/phosphonate transport system, periplasmic component +FIG01339852 intracellular proteinase I [EC:3.4.-.-] +FIG01339857 FIG00384899: hypothetical protein +FIG01339858 FIG01200276: hypothetical protein +FIG01339866 Probable glutathione s-transferase protein (EC 2.5.1.18) +FIG01339869 DNA primase (EC 2.7.7.-), phage associated +FIG01339875 FIG00388723: hypothetical protein +FIG01339894 Phospholipase C precursor (EC 3.1.4.3) +FIG01339901 DNA-binding response regulator ColR +FIG01339909 Fatty acid desaturase +FIG01339911 Flavin-utilizing monoxygenase +FIG01339934 FIG00531551: hypothetical protein +FIG01339935 Possible periplasmic protein +FIG01339937 Diguanylate cyclase (GGDEF domain) with GAF sensor +FIG01339946 Virulence-associated protein +FIG01339956 FIG00698661: hypothetical protein +FIG01339962 FIG00468512: hypothetical protein +FIG01339963 conserved hypothetical protein +FIG01339965 hypothetical protein, len: 160aa +FIG01339977 Probable periplasmic protein Cj1079 +FIG01339979 FIG00824078: hypothetical protein +FIG01339987 3-oxoacyl reductase (EC 1.1.1.100) +FIG01339989 FIG00385236: hypothetical protein +FIG01340000 Citrate synthase family protein +FIG01340001 FIG00351066: hypothetical protein +FIG01340002 major tail sheath protein +FIG01340003 Predicted redox protein, regulator of disulfide bond formation +FIG01340010 Penicillin acylase II (EC 3.5.1.11) +FIG01340024 VapC23 antibacterial toxin protein +FIG01340047 cation symporter +FIG01340060 Listeria RofA-like transcriptional regulator +FIG01340065 FIG01166625: hypothetical protein +FIG01340082 asparaginase +FIG01340084 Glutaredoxin related protein +FIG01340096 FIG00840240: hypothetical protein +FIG01340106 Alpha-glucosidases, family 31 of glycosyl hydrolases +FIG01340107 FIG014087: hypothetical protein +FIG01340118 hypothetical protein +FIG01340119 FIG00385534: hypothetical protein +FIG01340120 abhydrolase, alpha/beta hydrolase fold +FIG01340131 Cryptic Mu-phage protein com +FIG01340135 Aspartate transaminase (EC 2.6.1.1) +FIG01340139 Putative ABC associated RTX toxin transporter, HlyD/MFP family +FIG01340146 FIG00639970: hypothetical protein +FIG01340165 FIG00454049: hypothetical protein +FIG01340174 putative cAMP-induced cell filamentation protein +FIG01340188 Prophage Lp1 protein 6 +FIG01340192 dim6/ntab flavoprotein family +FIG01340199 FIG00407667: hypothetical protein +FIG01340204 Thioredoxin +FIG01340222 conserved protein, putative degV protein +FIG01340251 FIG00416781: hypothetical protein +FIG01340260 FIG01214840: hypothetical protein +FIG01340271 FIG01115713: hypothetical protein +FIG01340285 FIG00344800: hypothetical protein +FIG01340305 FIG00764994: hypothetical protein +FIG01340306 Peptidase M14, carboxypeptidase A precursor +FIG01340308 Uncharacterized protein MJ1475 +FIG01340311 FIG00414849: hypothetical protein +FIG01340325 FIG00350656: hypothetical protein +FIG01340326 ABC transport protein inner membrane component +FIG01340336 amino acids ABC transporter, ATP-binding protein +FIG01340340 FIG00407608: hypothetical protein +FIG01340342 Queuine tRNA-ribosyltransferase (EC 2.4.2.29) +FIG01340347 FIG00410115: hypothetical protein +FIG01340350 Hypoxia-inducible factor 1 alpha inhibitor (EC 1.14.11.16) +FIG01340357 hypothetical protein +FIG01340366 putative helicase/SNF2 family domain protein +FIG01340367 Preprotein translocase secE subunit +FIG01340371 POSSIBLE CONSERVED SECRETED PROTEIN +FIG01340372 Formate dehydrogenase( EC:1.2.1.2 ) +FIG01340376 FIG00762787: hypothetical protein +FIG01340377 Integrase-like protein +FIG01340379 FIG00450936: hypothetical protein +FIG01340386 C4-dicarboxylate transport sensor protein dctB (EC 2.7.3.-) +FIG01340389 putative Ycf34 +FIG01340419 Flavine-dependent monooxygenase +FIG01340431 FIG00768128: hypothetical protein +FIG01340476 DNA-(Apurinic or apyrimidinic site) lyase, conjectural +FIG01340496 transcriptional regulator, MarR family +FIG01340499 FIG00388912: hypothetical protein +FIG01340509 FIG00640259: hypothetical protein +FIG01340510 OmpA family outer membrane protein +FIG01340511 Uncharacterized conserved protein +FIG01340521 putative L-glutamate ligase +FIG01340522 DNA-binding protein HU (DNA-binding protein II) +FIG01340524 carboxylesterase (EC 3.1.1.1) NP +FIG01340528 PDZ domain family protein +FIG01340534 conserved hypothetical protein; putative phospholipase D endonuclease domain +FIG01340544 transposase and inactivated derivatives-like +FIG01340546 alginate regulatory protein AlgP +FIG01340551 hypothetical protein Rv2283 +FIG01340567 two component transcriptional regulator, winged helix family +FIG01340570 ail and ompX Homolog +FIG01340574 Cell division protein DivIC (FtsB), stabilizes FtsL against RasP cleavage +FIG01340577 biotin synthase +FIG01340581 Glycosyl transferases, related to UDP-glucuronosyltransferase +FIG01340583 Endoglucanase C307 precursor (EC 3.2.1.4) (Endo-1,4-beta-glucanase C307) (Cellulase C307) +FIG01340585 FIG01241157: hypothetical protein +FIG01340586 FIG00405104: hypothetical protein +FIG01340600 FIG00350583: hypothetical protein +FIG01340601 hemagglutinin protein HagC +FIG01340616 outer membrane porin protein precursor +FIG01340627 FIG00348185: hypothetical protein +FIG01340630 FIG00785216: hypothetical protein +FIG01340636 putative Hydrolase, alpha/beta hydrolase fold family( EC:3.1.1.1 ) +FIG01340654 Probable lipoprotein lppI +FIG01340665 transposase +FIG01340669 Multiple antibiotic transporter +FIG01340679 FIG054297: Transcriptional regulator, AraC family +FIG01340680 transcriptional regulator LacI family +FIG01340682 Putative stability/partitioning protein encoded within prophage CP-933T +FIG01340684 CorA, CorA-like Mg2+ transporter protein +FIG01340686 FIG00832926: hypothetical protein +FIG01340695 type III secretion system protein SepD +FIG01340725 GumN family protein +FIG01340734 multidrug resistance protein A +FIG01340738 ATP-dependent RNA helicase, eIF-4A family +FIG01340740 Peptidase M48, Ste24p +FIG01340741 putative hypothetical protein +FIG01340758 FIG00350904: hypothetical protein +FIG01340760 Antirestriction protein klcA +FIG01340763 FIG00747662: hypothetical protein +FIG01340767 FIG01068028: hypothetical protein +FIG01340773 FIG00388641: hypothetical protein +FIG01340777 Colicin I receptor +FIG01340782 FIG00958748: hypothetical protein +FIG01340789 FIG00638428: hypothetical protein +FIG01340815 FIG00641775: hypothetical protein +FIG01340816 conserved membrane-spanning protein +FIG01340825 glycosyl transferase family 39 +FIG01340830 cationic amino acid transporter +FIG01340838 Probable transcriptional regulator lrhA +FIG01340846 FIG00918781: hypothetical protein +FIG01340866 FIG00403203: hypothetical protein +FIG01340869 Probable cation-transporting ATPase I (EC 3.6.3.-) +FIG01340877 Subtilin biosynthesis sensor protein spaK (EC 2.7.3.-) +FIG01340895 Putative uncharacterized protein BCG_3011c +FIG01340900 Hypothetical protein SAV1802 +FIG01340904 YESL protein +FIG01340911 GAF domain-containing proteins +FIG01340914 Carbamoylphosphate synthase large subunit (split gene in MJ) +FIG01340920 val start codon +FIG01340928 conserved hypothetical protein +FIG01340929 endonuclease III domain protein +FIG01340930 lactate/malate dehydrogenase family protein +FIG01340973 TetR family transcriptional regulator probably coupled to RND multidrug efflux transporter +FIG01340974 Copper-exporting ATPase (EC 3.6.3.4) +FIG01340975 PE family protein +FIG01340980 Sortase and related acyltransferases +FIG01340986 DUF350 domain-containing protein +FIG01340995 FIG00351790: hypothetical protein +FIG01340999 protein of unknown function DUF181 +FIG01341001 PQQ enzyme repeat family protein +FIG01341020 FIG00350268: hypothetical protein +FIG01341023 Sensor histidine kinase HpkA (EC 2.7.13.3) +FIG01341033 Esterase/lipase/thioesterase family protein +FIG01341046 putative zinc-binding dehydrogenases +FIG01341050 Probable serine/threonine-protein kinase yabT (EC 2.7.11.1) +FIG01341056 FIG00351016: hypothetical protein +FIG01341058 amino acid carrier family protein +FIG01341069 orf4 +FIG01341090 Glyoxalase/Bleomycin resistance protein/Dioxygenase family protein +FIG01341094 FIG00351518: hypothetical protein +FIG01341103 hypothetical protein Rv1517 +FIG01341115 GAF sensor signal transduction histidine kinase +FIG01341116 Guanosine pentaphosphate phosphohydrolase (EC 3.6.1.11) (EC 3.6.1.40) +FIG01341136 Eps11O +FIG01341147 DNA-binding protein, excisionase family +FIG01341149 FIG00433840: hypothetical protein +FIG01341156 Transposase for transposon Tn554 +FIG01341159 ATP-binding region, ATPase-like:Histidine kinase, HAMP region:Cache:Histidine kinase internal region +FIG01341160 FIG00348431: hypothetical protein +FIG01341166 conserved hypothetical protein NMA0935 +FIG01341168 Vitamin K epoxide reductase +FIG01341180 COMF operon protein 3 +FIG01341191 hypothetical protein +FIG01341205 Predicted ferric reductase +FIG01341209 T. pallidum predicted coding region TP0832 +FIG01341216 COG0119: Isopropylmalate/homocitrate/citramalate synthases +FIG01341221 Intimin +FIG01341225 Type II secretory pathway, pullulanase +FIG01341229 Putative tellurium resistance protein +FIG01341232 putative chlorohydrolase +FIG01341257 Exodeoxyribonuclease encoded by cryptic prophage CP-933P +FIG01341278 N-ethylammeline chlorohydrolase +FIG01341280 FIG007491: hypothetical protein YeeN +FIG01341281 putative RNA polymerase ECF-subfamily sigma factor +FIG01341301 similar to Gp11 [Bacteriophage Mu] gi|6010385|gb|AAF01088.1|AF083977_7 +FIG01341303 PKD repeat protein +FIG01341305 GlcG protein +FIG01341315 ABC transporter membrane-spanning permease - macrolide efflux +FIG01341326 FIG00418218: hypothetical protein +FIG01341327 sugar phosphorylase +FIG01341332 Hypothetical protein within pathogenicity island SaPIn3 +FIG01341341 undecaprenyl pyrophosphate phosphatase +FIG01341342 iron(III) dicitrate transport system permease protein FecE +FIG01341352 Enoyl-CoA hydratase/isomerase family protein +FIG01341355 FIG00351832: hypothetical protein +FIG01341356 Fructose-1-phosphate kinase and related fructose-6-phosphate kinase (PfkB) +FIG01341365 Osmotically inducible protein +FIG01341368 Regulatory protein, LysR:LysR, substrate-binding +FIG01341379 putative ATP /GTP binding protein +FIG01341380 Adenine DNA methyltransferase, phage-associated +FIG01341389 Large extracellular alpha-helical protein +FIG01341390 Surface protein PspC +FIG01341398 cholesterol esterase +FIG01341404 Exo-alpha sialidase +FIG01341424 K+/H+ antiporter +FIG01341426 probable LacI-type transcriptional regulator +FIG01341438 FIG01048798: hypothetical protein +FIG01341456 FIG01047741: hypothetical protein +FIG01341464 Protein involved in cell division +FIG01341468 phage virion protein +FIG01341491 Protein distantly related to SAM-dependent methyltransferases +FIG01341495 Peptide synthetase +FIG01341499 Competence protein ComGF +FIG01341502 Protein implicated in RNA metabolism (PRC-barrel domain) +FIG01341511 FIG00385669: hypothetical protein +FIG01341520 FIG00769702: hypothetical protein +FIG01341522 drug resistance transporter, Bcr-CflA family protein +FIG01341539 FIG01045658: hypothetical protein +FIG01341544 ORF13 (ORF, hypothetical) +FIG01341545 FIG00350466: hypothetical protein +FIG01341552 F0F1-type ATP synthase, alpha subunit +FIG01341559 transcriptional regulator PlcR, putative +FIG01341564 FIG027887: hypothetical protein +FIG01341572 FIG00630060: hypothetical protein +FIG01341589 putative sugar ABC transporter permease +FIG01341594 FIG00733794: hypothetical protein +FIG01341611 PROBABLE ANTIBIOTIC-TRANSPORT INTEGRAL MEMBRANE LEUCINE AND VALINE RICH PROTEIN ABC TRANSPORTER +FIG01341652 Probable phage integrase +FIG01341653 ISSoc3, orfA transposase +FIG01341660 putative surface exclusion protein +FIG01341676 NtrC family transcriptional regulator +FIG01341682 internalin H +FIG01341685 Glycerol-3-phosphate ABC transporter, permease protein GlpQ +FIG01341687 Type II R/M system (EC 2.1.1.72) +FIG01341688 FIG00450562: hypothetical protein +FIG01341697 Probable M18-family aminopeptidase 2 (EC 3.4.11.-) +FIG01341709 L-amino acid oxidase +FIG01341734 FIG01203608: hypothetical protein +FIG01341748 FIG01060707: hypothetical protein +FIG01341750 FIG00412531: hypothetical protein +FIG01341765 FF domain protein +FIG01341798 FIG00406664: hypothetical protein +FIG01341801 FIG00351670: hypothetical protein +FIG01341804 Bll2457 protein +FIG01341808 FIG00667538: hypothetical protein +FIG01341810 FIG00757069: hypothetical protein +FIG01341831 FIG00469308: hypothetical protein +FIG01341834 CsfB protein +FIG01341840 Serine protease mycosin MycP3, component of Type VII secretion system ESX-3 +FIG01341842 some similarities to phage-related terminase small subunit homolog yqaS +FIG01341877 PKD +FIG01341907 Extracellular solute-binding protein, family 3 +FIG01341917 FIG00468864: hypothetical protein +FIG01341920 Possible Fe-S oxidoreductase +FIG01341927 Oxygen-independent coproporphyrinogen III oxidase, putative +FIG01341929 Trehalose/maltose transport inner membrane protein +FIG01341933 SpoIID-like domain containing protein; peptidoglycan-binding domain +FIG01341934 Predicted glycolate dehydrogenase regulator +FIG01341941 FIG00850634: hypothetical protein +FIG01341951 VanZ like protein +FIG01341978 phenoxybenzoate dioxygenase +FIG01341987 TRANSPOSASE +FIG01341991 PnuC-like transporter linked to homoserine kinase and OMR +FIG01341997 hypothetical protein STY3242 +FIG01341998 Small-conductance mechanosensitive channel +FIG01342000 Probable multidrug resistance protein +FIG01342003 FIG00388608: hypothetical protein +FIG01342009 FIG00841706: hypothetical protein +FIG01342013 FIG00849486: hypothetical protein +FIG01342016 FIG00548710: hypothetical protein +FIG01342021 Putative S-adenosyl-L-methionine-dependent methyltransferase +FIG01342032 Low-complexity acidic protein, XCC2875 type +FIG01342050 FIG00406484: hypothetical protein +FIG01342051 DnaJ domain protein +FIG01342053 FIG00350920: hypothetical protein +FIG01342054 Putative iron compound-binding protein of ABC transporter family +FIG01342055 FIG00764764: hypothetical protein +FIG01342057 Putative luxR-family regulatory protein +FIG01342067 FIG00388490: hypothetical protein +FIG01342075 MmcH +FIG01342077 hypothetical protein CPE0714 +FIG01342078 Cholesterol esterase +FIG01342091 FIG00380651: hypothetical protein +FIG01342093 FIG00412830: hypothetical protein +FIG01342104 B. burgdorferi predicted coding region BB0205 +FIG01342125 small molecule metabolism; degradation; carbon compounds +FIG01342132 Major facilitator superfamily transporter-permease +FIG01342140 FIG00768753: hypothetical protein +FIG01342145 FIG01082333: hypothetical protein +FIG01342146 Sodium:sulfate symporter, DASS family +FIG01342153 FIG00349978: hypothetical protein +FIG01342170 Outer membrane usher protein psaC precursor +FIG01342173 Sensor kinase, two-component system +FIG01342179 Acyl dehydratase, MaoC-like domain (EC 2.3.1.8) +FIG01342194 bll5139; probable transglycosylase +FIG01342195 uncharacterized domain / RidA/YER057c/UK114 superfamily, group 5 +FIG01342220 Transmembrane histidine kinase CsrS +FIG01342224 Carbohydrate kinase, FGGY family (EC 2.7.1.12) +FIG01342226 FtsK/SpoIIIE family protein EccC3, component of Type VII secretion system ESX-3 +FIG01342228 ortholog to Borrelia burgdorferi BB0089 +FIG01342244 transcription regulator, probable +FIG01342247 Voltage-gated chloride channel family protein +FIG01342253 Transposase A from transposon Tn554 +FIG01342260 FIG00424055: hypothetical protein +FIG01342284 pyrimidine dimer DNA glycosylase +FIG01342306 FIG01179353: hypothetical protein +FIG01342318 syc1795_c +FIG01342320 High-affinity Fe2+/Pb2+ permease +FIG01342322 putative protein kinase +FIG01342327 Diamine acetyltransferase (EC 2.3.1.57) +FIG01342347 Transglycosylase associated protein +FIG01342359 FIG00356804: hypothetical protein +FIG01342376 DNA topology modulation protein flar-related protein +FIG01342383 endoglucanase-related protein +FIG01342395 Integrase, catalytic region +FIG01342397 cytosine-specific methyltransferase +FIG01342405 possible secreted protein +FIG01342406 FIG01233074: hypothetical protein +FIG01342408 Alkyl sulfatase (EC 3.1.6.-) +FIG01342420 Flotillin-like protein +FIG01342426 syc0778_c +FIG01342427 FIG00644776: hypothetical protein +FIG01342432 DMT permease +FIG01342436 Putative invasin +FIG01342459 Mycarose O-acyltransferase +FIG01342465 PAP2 family phosphatase/haloperoxidase +FIG01342467 FIG00642358: hypothetical protein +FIG01342470 FIG033054: hypothetical protein +FIG01342492 tRNA and rRNA cytosine-C5-methylases +FIG01342505 probable alcohol dehydrogenase +FIG01342510 Putative uncharacterized protein MW0861 +FIG01342516 FIG00639963: hypothetical protein +FIG01342522 FIG00350596: hypothetical protein +FIG01342533 ISPg5, transposase Orf1 +FIG01342543 Drug:proton antiporter +FIG01342552 Transcriptional regulator, CrP/Fnr family +FIG01342578 UPF0230 protein CA_C1624 +FIG01342580 Putative type IV pilin protein +FIG01342586 B. burgdorferi predicted coding region BB0208 +FIG01342587 Gentisate 1,2-dioxygenase +FIG01342593 FIG00897258: hypothetical protein +FIG01342608 FIG00415993: hypothetical protein +FIG01342618 FIG00672548: hypothetical protein +FIG01342625 FIG00899111: hypothetical protein +FIG01342627 FIG00379992: hypothetical protein +FIG01342634 Putative choline kinase, PnuC-associated, THI-regulated +FIG01342635 type IV pilus glycosylation protein +FIG01342647 tail protein X, putative +FIG01342648 site-specific recombinase, resolvase family +FIG01342660 FIG00763091: hypothetical protein +FIG01342699 MFS drug efflux transporter +FIG01342702 Probable resolvase +FIG01342709 Heterodisulfide reductase related protein +FIG01342710 Exotoxin 4 +FIG01342731 FIG00350234: hypothetical protein +FIG01342735 Polysaccharide polymerization protein +FIG01342741 Putative activator of ProP osmoprotectant transporter +FIG01342765 Probable glucarate transporter +FIG01342770 replication protein +FIG01342780 transposase +FIG01342784 Transport transmembrane protein +FIG01342792 CRISPR-associated protein Csc1 +FIG01342795 putative permease, AEC family +FIG01342796 FunZ family protein, (pXO2-71) +FIG01342819 B. burgdorferi predicted coding region BB0756 +FIG01342822 Transcriptional regulator, MutR family +FIG01342829 FIG00350354: hypothetical protein +FIG01342845 3-hydroxyacyl-CoA dehydrogenase +FIG01342846 conserved transmembrane protein +FIG01342865 FIG046226: Probable transmembrane protein +FIG01342873 FIG00623740: hypothetical protein +FIG01342876 ABC-transport system ATP-binding protein +FIG01342882 FIG00350059: hypothetical protein +FIG01342889 Rna-binding protein +FIG01342890 Intracellular PHB depolymerase PhaZ2 +FIG01342892 FIG00350664: hypothetical protein +FIG01342900 FIG00624322: hypothetical protein +FIG01342909 Opacity protein-related protein +FIG01342912 CONSERVED HYPOTHETICAL PROTEIN [FIRST PART] +FIG01342921 sodium- and chloride-dependent transporter +FIG01342922 probable phosphinothricin N-acetyltransferase +FIG01342926 FIG01208006: hypothetical protein +FIG01342932 Beta tubulin, autoregulation binding site +FIG01342946 FIG00765071: hypothetical protein +FIG01342948 putative tellurium resistant protein (KlaA/kilA) +FIG01342954 FIG00356466: hypothetical protein +FIG01342956 FIG00763001: hypothetical protein +FIG01342957 FIG00403620: hypothetical protein +FIG01342959 ISPssy, transposase +FIG01342967 FIG00642250: hypothetical protein +FIG01342974 Regulator of the multidrug efflux pump pmrA +FIG01342985 Mlr8147 protein +FIG01342987 RNA-directed DNA polymerase( EC:2.7.7.49 ) +FIG01342993 SbmA protein +FIG01342997 Related to collagenase +FIG01343003 Ribosomal large subunit pseudouridine synthase B (EC 4.2.1.70) +FIG01343007 Bll5899 protein +FIG01343008 integrase, truncation +FIG01343009 AraC family transcription regulator +FIG01343011 FIG00931662: hypothetical protein +FIG01343020 Uncharacterized protein, homolog of ywsA B.subtilis +FIG01343030 Anaerobic ribonucleoside-triphosphate reductase (EC 1.17.4.2) +FIG01343036 Tll0814 protein +FIG01343047 Type III restriction-modification system restriction subunit (EC 3.1.21.5) +FIG01343050 ParB-like protein +FIG01343072 identified by similarity to PIR:D95307 +FIG01343087 FIG01045690: hypothetical protein +FIG01343095 FIG00350530: hypothetical protein +FIG01343100 Oxidoreductase, short-chain dehydrogenase/reductase family +FIG01343101 Serine/threonine protein phosphatase 2 (EC 3.1.3.16) +FIG01343112 FIG00638919: hypothetical protein +FIG01343118 hypothetical protein +FIG01343121 Carboxylic ester hydrolase +FIG01343122 FinQ +FIG01343125 putative alpha-deoxyribodipyrimidine photolyase-related protein +FIG01343126 OUTER MEMBRANE PROTEIN +FIG01343146 Competence-induced protein Ccs4 +FIG01343149 glutamine amidotransferase, class I +FIG01343156 MCE-family protein Mce1A +FIG01343157 FIG00404051: hypothetical protein +FIG01343158 methylated-DNA--protein-cysteine methyltransferase +FIG01343161 FIG00385324: hypothetical protein +FIG01343169 Transmembrane transport protein MmpL10 +FIG01343177 similar to cyto adherence proteins +FIG01343181 FIG01201108: hypothetical protein +FIG01343185 FIG00404136: hypothetical protein +FIG01343192 Polysaccharide ABC transporter, ATP-binding protein +FIG01343194 FIG01119439: hypothetical protein +FIG01343207 Sll0756 protein +FIG01343216 CO dehydrogenase maturation factor +FIG01343248 Cell division inhibitor SulA, putative +FIG01343254 FIG00350241: hypothetical protein +FIG01343257 FIG00385622: hypothetical protein +FIG01343263 hemagglutinin/hemolysin-related protein +FIG01343266 probable P23 protein +FIG01343267 glycosyl hydrolase family 29 (alpha-L-fucosidase) +FIG01343270 DegT/DnrJ/EryC1/StrS family protein +FIG01343278 putative secreted peptidase +FIG01343279 hypothetical protein +FIG01343285 Bifunctional salicyl-AMP ligase/salicyl-S-arcp synthetase MbtA +FIG01343291 LuxR family regulatory protein +FIG01343295 Putative nitrogen regulatory protein NtrP +FIG01343297 Putative stress-responsive transcriptional regulator +FIG01343303 MaoC-like dehydratase +FIG01343304 Sugar permeases +FIG01343314 ortholog of Bordetella pertussis (BX470248) BP2342 +FIG01343330 FIG00413372: hypothetical protein +FIG01343338 FIG00764430: hypothetical protein +FIG01343360 FIG00746165: hypothetical protein +FIG01343361 Hypothetical SAR0372 homolog in superantigen-encoding pathogenicity islands SaPI +FIG01343366 SceD-like transglycosylase, biomarker for vancomycin-intermediate strains +FIG01343370 ATPase involved in DNA repair, phage associated +FIG01343389 hypothetical protein +FIG01343392 DNA/RNA HELICASE (DEAD/DEAH BOX FAMILY) +FIG01343400 P235 rhoptry protein E5 +FIG01343414 Sodium/bile acid symporter family +FIG01343417 FIG00353495: hypothetical protein +FIG01343418 Putative sodium-dependent transmembrane transport protein +FIG01343429 serine protease pet +FIG01343431 FIG00350786: hypothetical protein +FIG01343447 Polysaccharide biosynthetic protein +FIG01343459 Succinylornithine transaminase, putative +FIG01343463 Smr domain protein +FIG01343465 FIG01201263: hypothetical protein +FIG01343469 Chitinase +FIG01343470 glycosylhydrolase, putative xylanase +FIG01343472 Propanediol utilization protein PduV +FIG01343481 FIG01101636: hypothetical protein +FIG01343490 transposase, IS605-TnpB family +FIG01343508 FIG00424331: hypothetical protein +FIG01343514 Sll1426 protein +FIG01343519 phosphinothricin N-acetyltransferase +FIG01343535 protein of unknown function DUF558 +FIG01343549 phage hypothetical protein +FIG01343572 AdeT +FIG01343582 FIG00828439: hypothetical protein +FIG01343584 FIG00765513: hypothetical protein +FIG01343589 HesB family selenoprotein +FIG01343600 putative acyl-CoA hydrolase +FIG01343630 Endonuclease I +FIG01343631 FIG00515265: hypothetical protein +FIG01343634 Fumarylacetoacetate (FAA) hydrolase +FIG01343651 sensor histidine kinase KinD +FIG01343663 FIG00405194: hypothetical protein +FIG01343670 FadE30 +FIG01343672 hypothetical membrane associated protein +FIG01343676 FmdC precursor +FIG01343678 FIG00940220: hypothetical protein +FIG01343682 FIG01242090: hypothetical protein +FIG01343686 FIG00405237: hypothetical protein +FIG01343700 contains ESTs D41575(S4159),AU097348(S4159) / putative extensin-like protein +FIG01343709 protein of unknown function DUF1624 +FIG01343715 FIG00674330: hypothetical protein +FIG01343733 putative bacterioferritin-associated ferredoxin +FIG01343738 Vibriobactin utilization protein ViuB +FIG01343745 COGs COG0050 +FIG01343747 Protein ecsB +FIG01343762 FIG00350136: hypothetical protein +FIG01343766 P pilus assembly/Cpx signaling pathway, periplasmic inhibitor/zinc-resistance associated protein +FIG01343792 Transcriptional regulator, SorC family +FIG01343795 IPT/TIG domain protein +FIG01343806 Mu-like prophage protein gp29 +FIG01343810 putative amino-acid efflux transmembrane protein +FIG01343814 FIG00822337: hypothetical protein +FIG01343837 Predicted permease +FIG01343839 FIG00350748: hypothetical protein +FIG01343886 FIG00424891: hypothetical protein +FIG01343891 FIG01121868: Possible membrane protein +FIG01343906 FIG00955641: hypothetical protein +FIG01343919 FIG00744264: hypothetical protein +FIG01343924 Helicase +FIG01343933 hypothetical protein +FIG01343934 5'-nucleotidase/2',3'-cyclic phosphodiesterase and related esterases +FIG01343950 YMAD protein +FIG01343956 tail fiber assembly like-protein +FIG01343957 PUTATIVE TWO-COMPONENT SENSOR +FIG01343961 amidase family protein +FIG01343962 NlpC/P60 family protein +FIG01343966 Carbohydrate binding family 25 +FIG01343968 Possible acid phosphatase (EC 3.1.3.2) +FIG01343981 POSSIBLE CONSERVED EXPORTED PROTEIN +FIG01343985 FIG00404296: hypothetical protein +FIG01343993 Subtilin transport ATP-binding protein spaT +FIG01344033 Msr2723 protein +FIG01344035 FIG00350165: hypothetical protein +FIG01344043 FIG00550586: hypothetical protein +FIG01344045 3-oxoacyl-(acyl-carrier-protein) reductase( EC:1.1.1.100 ) +FIG01344054 FIG00350186: hypothetical protein +FIG01344060 Gll3457 protein +FIG01344062 protein of unknown function, ATP binding +FIG01344069 putative outermembrane protein +FIG01344071 FIG00628552: hypothetical protein +FIG01344101 FIG00424277: hypothetical protein +FIG01344107 cation-transporting ATPase, E1-E2 family +FIG01344113 Acetylornithine aminotransferase (EC 2.6.1.11) (ACOAT) +FIG01344115 FIG00970189: hypothetical protein +FIG01344119 PE family protein +FIG01344122 FIG00765861: hypothetical protein +FIG01344137 orf, hypothetical +FIG01344139 Transcriptional regulators of sugar metabolism +FIG01344165 FIG00388301: hypothetical protein +FIG01344181 Putative sugar binding protein, ABC transport system precursor +FIG01344186 permease, putative domain protein +FIG01344191 N-ethylammeline chlorohydrolase +FIG01344195 FIG00424233: hypothetical protein +FIG01344201 FIG01048344: hypothetical protein +FIG01344209 stress response homolog Hsp +FIG01344212 probable phage replication protein NMA0782 +FIG01344216 nucleic acid binding protein, PIN domain +FIG01344243 FIG00425976: hypothetical protein +FIG01344245 serine/threonine protein kinase with TPR repeats +FIG01344251 Secreted protein, containing von Willebrand factor (VWF) type A domain +FIG01344259 FIG00697045: hypothetical protein +FIG01344264 Putative heme oxygenase +FIG01344265 Bll7938 protein +FIG01344266 putative multiple antibiotic resistance protein +FIG01344276 FIG00912479: hypothetical protein +FIG01344279 FIG00387996: hypothetical protein +FIG01344281 Predicted redox disulfide bond formation protein OsmC-like protein +FIG01344282 Aerolysin 4 precursor +FIG01344295 FIG00765412: hypothetical protein +FIG01344322 ISCpe2, transposase orfA +FIG01344328 FIG00821726: hypothetical protein +FIG01344332 Thymidylate_kin, Thymidylate kinase +FIG01344333 FIG00350811: hypothetical protein +FIG01344336 Tfp pilus assembly protein FimT +FIG01344348 DnaJ-related protein +FIG01344358 outer membrane protein 10 +FIG01344363 FIG00820553: hypothetical protein +FIG01344368 FIG00765525: hypothetical protein +FIG01344370 transcriptional regulator, MerR family +FIG01344377 Lactoylglutathione lyase +FIG01344378 similar to Sporulation protein and related proteins +FIG01344384 YCII-related domain protein +FIG01344390 Cof protein +FIG01344423 Protein erfK/srfK precursor +FIG01344428 FIG00516962: hypothetical protein +FIG01344431 Tll1896 protein +FIG01344438 rRNA adenine N-6-methyltransferase (EC 2.1.1.48) +FIG01344439 alternate gene name: yukI +FIG01344449 Transcriptional regulator, AraC family +FIG01344462 P26 +FIG01344465 FIG01114139: hypothetical protein +FIG01344486 FIG00355781: hypothetical protein +FIG01344504 Uncharacterized protein MJ1198 +FIG01344509 FIG00410090: hypothetical protein +FIG01344511 tellurium resistance protein TerC +FIG01344518 putative protease I +FIG01344527 FIG00644081: hypothetical protein +FIG01344528 diguanylate cyclase/phosphodiesterase (GGDEF & EAL domains) with PAS/PAC sensor(s) +FIG01344537 FIG00638514: hypothetical protein +FIG01344551 Septum formation inhibitor-activating ATPase +FIG01344560 TPR-repeat protein, specific for cyanobacteria +FIG01344564 FIG00976011: hypothetical protein +FIG01344575 Von Willebrand factor type A domain protein +FIG01344576 Multidrug resistance protein EbrA +FIG01344588 Putative LuxR-family regulatory proteins +FIG01344595 Spore coat protein C +FIG01344602 FIG00348669: hypothetical protein +FIG01344621 long polar fimbrial outer membrane usher protein +FIG01344626 Cytochrome bd-type quinol oxidase, subunit 1 +FIG01344630 Carboxylate-amine ligase SPO2209 (EC 6.3.-.-) +FIG01344631 glucosyl tranferase II +FIG01344636 signal-transducing histidine kinase +FIG01344637 FIG00406995: hypothetical protein +FIG01344640 hypothetical protein +FIG01344645 Ribose/xylose/arabinose/galactoside ABC-type transport systems, permease components +FIG01344652 syc2100_d +FIG01344653 putative amidase +FIG01344664 Transposase +FIG01344673 Thiol-disulfide isomerase +FIG01344677 FIG00517480: hypothetical protein +FIG01344683 FIG00956635: hypothetical protein +FIG01344684 FIG00623410: hypothetical protein +FIG01344685 FIG00969425: hypothetical protein +FIG01344692 PilT protein domain protein +FIG01344695 lysosomal glucosyl ceramidase-like protein +FIG01344696 DNA topoisomerase IB (poxvirus type) (EC 5.99.1.2) +FIG01344697 FIG00354651: hypothetical protein +FIG01344725 Phage-like element PBSX protein xkdP +FIG01344735 IPPI protein +FIG01344744 Acyl-CoA dehydrogenase (EC 1.3.8.7) +FIG01344750 putative stress-responsive transcriptional regulator +FIG01344764 guanosine-3,5-bis(diphosphate) 3-pyrophosphohydrolase SpoTd +FIG01344772 FIG00830002: hypothetical protein +FIG01344790 dentin sialophosphoprotein preproprotein +FIG01344794 Exotoxin 7 +FIG01344798 HrpA-like helicases +FIG01344802 Inositol phosphate phosphatase sopB (EC 3.1.3.-) +FIG01344808 Diacyglycerol O-acyltransferase (EC 2.3.1.20) +FIG01344812 Transposase (maltose area) +FIG01344816 FIG00764272: hypothetical protein +FIG01344819 Hypothetical protein SAV1801 +FIG01344820 Putative glycosidase +FIG01344822 FIG00622763: hypothetical protein +FIG01344836 FIG00641501: hypothetical protein +FIG01344846 Purine/pyrimidine phosphoribosyl transferase (EC 2.4.2.-) +FIG01344852 FIG00643413: hypothetical protein +FIG01344861 putative lipoprotein oligopeptide binding protein +FIG01344862 FIG00763959: hypothetical protein +FIG01344864 Ribose ABC transporter, ATP-binding protein +FIG01344866 hypothetical protein +FIG01344869 Regulatory protein TspO +FIG01344873 FIG00352841: hypothetical protein +FIG01344880 two-component regulatory system, sensor kinase protein +FIG01344881 FIG00675148: hypothetical protein +FIG01344882 Putative secreted effector protein +FIG01344888 Heat shock protein Hsp20 +FIG01344889 Protein containing diguanylate cyclase/phosphodiesterase domain 2 +FIG01344890 FIG00407332: hypothetical protein +FIG01344900 FIG00390001: hypothetical protein +FIG01344908 CmaU +FIG01344912 hypothetical protein +FIG01344925 putative amino acid transporter +FIG01344926 cytidine and deoxycytidylate deaminase family protein +FIG01344928 CAB/ELIP/HLIP superfamily +FIG01344936 Sel1 domain protein repeat-containing protein +FIG01344937 Uropathogenic specific protein +FIG01344938 putative sensory box-containing diguanylate cyclase +FIG01344966 FIG00347448: hypothetical protein +FIG01344974 6-O-methylguanine DNA methyltransferase, DNA binding domain subfamily( EC:2.1.1.63 ) +FIG01344975 Beta-lactamase-like +FIG01344980 Phage minor structural protein, N-terminal +FIG01345013 UPF0251 protein CTC_01373 +FIG01345036 ADP/ATP Translocase, NTT1 +FIG01345037 D-arabinonate dehydratase (EC 4.2.1.5) +FIG01345042 P35 lipoprotein homolog +FIG01345058 Amino acid permease +FIG01345061 FIG00351441: hypothetical protein +FIG01345084 FIG00767665: hypothetical protein +FIG01345090 FIG01048273: hypothetical protein +FIG01345092 FIG00363118: hypothetical protein +FIG01345096 tetracycline resistance element mobilization regulatory protein rteC +FIG01345108 Extracellular Protein Factor, epf +FIG01345119 Lysophospholipase L1 and related esterases +FIG01345125 DUF369 domain-containing protein +FIG01345129 XRE family transcriptional regulator +FIG01345138 hypothetical protein +FIG01345146 Fe-bacillibactin uptake system FeuA, regulatory component +FIG01345148 TRANSCRIPTIONAL REGULATORY PROTEIN, LYSR FAMILY +FIG01345150 FIG00407711: hypothetical protein +FIG01345157 lemA protein +FIG01345159 B. burgdorferi predicted coding region BB0130 +FIG01345165 FIG00385248: hypothetical protein +FIG01345166 dnaK suppressor protein +FIG01345168 Aminoglycoside 6'-N-acetyltransferase +FIG01345170 naphthalene dioxygenase small subunit +FIG01345171 DsrE-like protein +FIG01345217 COG3507: Beta-xylosidase +FIG01345220 Msr6604 protein +FIG01345224 Similar to gpB bacteriophage P2 +FIG01345229 cytochrome c, putative +FIG01345230 Molecular chaperone (small heat shock protein) +FIG01345233 Secreted antigen GbpB/SagA/PcsB, putative peptidoglycan hydrolase +FIG01345249 FIG00631286: hypothetical protein +FIG01345252 putative cellulose-binding protein +FIG01345257 FIG00404780: hypothetical protein +FIG01345278 FIG00506729: hypothetical protein +FIG01345279 Sulfate transporter family protein +FIG01345284 putative disulphide-isomerase +FIG01345296 Macrophage infectivity potentiator protein +FIG01345303 FIG01212390: hypothetical protein +FIG01345308 FIG00640987: hypothetical protein +FIG01345316 similar to hypothetical proteins +FIG01345343 FIG00405830: hypothetical protein +FIG01345354 FIG00408047: hypothetical protein +FIG01345357 hypothetical protein +FIG01345359 YihE protein, required for LPS synthesis +FIG01345364 FIG01345364: inner membrane protein Yip1 +FIG01345365 pXO1-02 +FIG01345379 Rac prophage repressor +FIG01345386 plobable polysaccharide biosynthesis protein +FIG01345397 Cytochrome P450 132 +FIG01345431 neutral metalloprotease, putative +FIG01345433 FIG00411354: hypothetical protein +FIG01345434 bacterioferritin-associated ferredoxin, putative +FIG01345451 Signal peptide protein +FIG01345460 protein of unknown function DUF303, acetylesterase putative +FIG01345466 Sll0236 protein +FIG01345476 FIG00605934: hypothetical protein +FIG01345478 FIG00764800: hypothetical protein +FIG01345490 putative multidrug-efflux transporter +FIG01345491 Phosphate/sulphate permeases +FIG01345507 Hypothetical protein MW2134 +FIG01345513 FIG00424856: hypothetical protein +FIG01345517 Lipid A core O-antigen ligase related enzyme +FIG01345523 FIG00347419: hypothetical protein +FIG01345524 ATP-dependent endonuclease family protein +FIG01345526 sugar ABC transporter substrate-binding protein +FIG01345528 FIG01197485: hypothetical protein +FIG01345532 FIG00775401: hypothetical protein +FIG01345533 hypothetical protein +FIG01345537 Glucose oligosaccharide ABC transport system, sugar-binding protein +FIG01345553 FIG00450130: hypothetical protein +FIG01345558 Sodium/calcium exchanger membrane region +FIG01345562 FIG016906: hypothetical protein +FIG01345605 acetyltransferase, GNAT family protein +FIG01345611 YihA +FIG01345616 Type II restriction-modification system restriction subunit +FIG01345625 Oxidoreductase, N-terminal:Oxidoreductase, C-terminal, utilizes NADP or NAD +FIG01345634 ATPase of the AAA+ class +FIG01345636 Protein trpH +FIG01345650 BppB +FIG01345657 morphine 6-dehydrogenase( EC:1.1.1.218 ) +FIG01345659 Lipoprotein Bor +FIG01345674 FIG00351627: hypothetical protein +FIG01345675 FIG00385062: hypothetical protein +FIG01345732 SAS076 +FIG01345738 FIG00822366: hypothetical protein +FIG01345740 putative DamX-related protein +FIG01345741 Probable ABC transporter, periplasmic amino acid-binding protein +FIG01345755 Neutral endopeptidase O (EC 3.4.24.-) +FIG01345757 oxidoreductase, short chain dehydrogenase/reductase family +FIG01345772 probable peptidase +FIG01345792 sodium:dicarboxylate symporter +FIG01345797 FIG00380281: hypothetical protein +FIG01345799 B. burgdorferi predicted coding region BB0418 +FIG01345800 homoprotocatechuate 2,3-dioxygenase +FIG01345802 SirA-like:Rhodanese-like +FIG01345807 acetyltransferase, putative +FIG01345817 Predicted dehydrogenase and related proteins +FIG01345819 FIG00792089: hypothetical protein +FIG01345826 3-oxoacyl-[acyl-carrier-protein] synthase III +FIG01345827 C4-dicarboxylate transporter family protein +FIG01345837 colicin V production protein, putative +FIG01345843 D-lyxose isomerase (EC 5.3.1.15) +FIG01345846 erythrocyte invasion and possible binding protein; Rhoptry protein (2401 aa), Plasmodium yoelii (U36927); 520/1194 positive aa (43%) +FIG01345851 FIG00644666: hypothetical protein +FIG01345855 Glucose dehydrogenase [pyrroloquinoline-quinone] +FIG01345856 phage-related putative DNA-binding protein +FIG01345857 uncharacterized protein conserved in bacteria +FIG01345858 FIG00545208: hypothetical protein +FIG01345859 FIG00642193: hypothetical protein +FIG01345861 AdoMet-AdoHcy transporter 2 +FIG01345864 FIG00425039: hypothetical protein +FIG01345867 Alpha amylase, catalytic region +FIG01345878 FIG00346642: hypothetical protein +FIG01345881 L-gulonolactone oxidase +FIG01345904 sodium-dependent transporter, putative +FIG01345921 FIG00628745: hypothetical protein +FIG01345933 probable methyltransferase-related protein +FIG01345945 integrase-like protein +FIG01345949 TonB-dependent outer membrane receptor +FIG01345950 ORF_ID:alr7514 hypothetical protein +FIG01345972 Oligopeptide transport ATP-binding protein oppF (TC 3.A.1.5.1) +FIG01345985 FIG00896371: hypothetical protein +FIG01345989 FIG00854749: hypothetical protein +FIG01346012 Putative integrase +FIG01346016 FIG00624360: hypothetical protein +FIG01346029 FIG00820301: hypothetical protein +FIG01346042 [leader (60) peptide-periplasmic] +FIG01346043 ATP-dependent helicase (hrpA) +FIG01346048 Sodium:alanine symporter family protein +FIG01346051 hypothetical protein clustered with lysine fermentation genes +FIG01346058 FIG00762577: hypothetical protein +FIG01346059 Phage major tail protein phi13 +FIG01346069 nitrite reductase-related protein +FIG01346070 SCO1/SenC family lipoprotein +FIG01346075 OmpA +FIG01346076 putative paralog of HpaA +FIG01346089 FIG00623651: hypothetical protein +FIG01346090 FIG00817184: hypothetical protein +FIG01346095 type III secretion chaperone, putative +FIG01346099 phage-related putative membrane protein +FIG01346100 FIG01122825: hypothetical protein +FIG01346104 hypothetical protein Rv1516c +FIG01346106 acyl carrier protein +FIG01346118 sensory transduction protein +FIG01346124 inhibitor of TRAP, regulated by T-BOX (trp) sequence RtpA +FIG01346137 Histone-like DNA-binding protein +FIG01346150 FIG00457332: hypothetical protein +FIG01346160 FIG00347676: hypothetical protein +FIG01346178 Putative merR-family transcriptional regulator +FIG01346181 FIG00337001: hypothetical protein +FIG01346182 FIG00402765: hypothetical protein +FIG01346189 FIG00349953: hypothetical protein +FIG01346192 possible D12 class N6 adenine-specific DNA met +FIG01346197 contains DUF161 domain +FIG01346202 Hydrolase, alpha/beta hydrolase fold family +FIG01346207 FIG00403648: hypothetical protein +FIG01346212 conserved membrane protein ML1389 +FIG01346217 Uncharacterized small conserved protein, homolog of YUKE/YFJA +FIG01346221 FIG00764226: hypothetical protein +FIG01346229 methyl-accepting chemotaxis sensory transducer precursor +FIG01346230 L-sorbosone dehydrogenase +FIG01346235 IS and transposon related functions +FIG01346244 FIG01232394: hypothetical protein +FIG01346247 FIG00350052: hypothetical protein +FIG01346249 Lipoprotein LprH +FIG01346251 FIG00768033: hypothetical protein +FIG01346253 FIG00344659: hypothetical protein +FIG01346254 putative siderophore biosysnthesis protein +FIG01346268 FIG00519980: hypothetical protein +FIG01346269 Solo B3/4 domain (OB-fold DNA/RNA-binding) of Phe-aaRS-beta +FIG01346278 hypothetical protein +FIG01346285 FIG01108949: hypothetical protein +FIG01346292 cadmium resistance transporter, putative +FIG01346308 Phosphotransferase system, mannitol-specific IIBC component +FIG01346311 Endo/excinuclease domain protein +FIG01346314 FIG01239740: hypothetical protein +FIG01346327 FIG00380622: hypothetical protein +FIG01346333 Possible lipoprotein LppJ +FIG01346334 Excinuclease ABC subunit A +FIG01346341 FIG00351055: hypothetical protein +FIG01346354 FIG00404818: hypothetical protein +FIG01346369 membrane-associated protein p66 +FIG01346375 putative sugar acetyltransferase +FIG01346380 Protein containing acetyltransferase (GNAT family) domain +FIG01346393 FIG00641872: hypothetical protein +FIG01346399 FIG00349674: hypothetical protein +FIG01346411 SqdX +FIG01346413 FIG00946491: hypothetical protein +FIG01346434 Nodulation protein noeE +FIG01346446 Putative uncharacterized protein +FIG01346456 24 kDa outer membrane protein precursor +FIG01346458 Alkaline serine exoprotease A precursor (EC 3.4.21.-) +FIG01346470 Autotransporter adhesin +FIG01346471 FIG00873527: hypothetical protein +FIG01346475 putative PTS system, IIa component +FIG01346485 Phenol 2-monooxygenase (EC 1.14.13.7) +FIG01346491 Epsilon antitoxin +FIG01346508 hypothetical protein +FIG01346510 Zeta toxin +FIG01346529 DsrE/DsrF family oxidoreductase family protein +FIG01346536 Nitrilotriacetate monooxygenase component A (EC 1.14.13.-) +FIG01346537 Aminoglycoside 2'-N-acetyltransferase AAC (AAC(2')-IC) +FIG01346538 hypothetical protein +FIG01346540 hypothetical protein with 50bp hit to Dihydrolipoamide acetyltransferase +FIG01346544 Transmembrane protein, ABC-type multidrug transport system +FIG01346549 Appr-1-p processing enzyme family domain protein +FIG01346554 FIG01046710: hypothetical protein +FIG01346557 putative VGR-related protein +FIG01346559 TonB domain protein +FIG01346562 Pathogenicity island SaPIn2 +FIG01346564 methyltransferase +FIG01346565 Transcriptional regulator, Cro/CI family protein transposon-related +FIG01346580 FIG00762625: hypothetical protein +FIG01346603 hypothetical protein +FIG01346606 probable membrane protein YPO2961 +FIG01346620 Phage regulatory protein like CII +FIG01346633 FIG00405737: hypothetical protein +FIG01346637 DUF2242 domain-containing protein +FIG01346642 hypothetical protein, not 6-phosphogluconolactonase +FIG01346648 Glucose-fructose oxidoreductase +FIG01346671 FIG00896341: hypothetical protein +FIG01346678 pXO1-20 +FIG01346679 FIG00349970: hypothetical protein +FIG01346681 ECF-type sigma factor negative effector +FIG01346686 prophage pi3 protein 34 +FIG01346688 Cytochrome P450 +FIG01346698 Immunoreactive protein Se23.5 (Fragment) +FIG01346701 Oxidoreductase, putative +FIG01346714 conserved hypothetical protein present in several antibiotic biosynthetic clusters +FIG01346731 FIG00361673: hypothetical protein +FIG01346739 PUTATIVE TRANSPOSASE FOR INSERTION SEQUENCE ISRM18 +FIG01346744 FIG00403262: hypothetical protein +FIG01346745 Sodium iodide symporter +FIG01346747 Probable fimbrial chaperone protein +FIG01346755 PROBABLE LIPOPROTEIN LPQS +FIG01346756 COG2853: Surface lipoprotein +FIG01346758 Zn-dependent alcohol dehydrogenase +FIG01346761 FIG00765877: hypothetical protein +FIG01346762 FIG00765864: hypothetical protein +FIG01346765 Site-specific recombinase, resolvase family +FIG01346767 FIG00820753: hypothetical protein +FIG01346780 Zinc-dependent metallopeptidase +FIG01346785 Isoniazid inductible protein IniC +FIG01346799 ankyrin-like protein +FIG01346806 POSSIBLE TRANSCRIPTIONAL REGULATORY PROTEIN +FIG01346809 integrase/recombinase XerD, putative +FIG01346812 FIG00762774: hypothetical protein +FIG01346822 FIG01223476: hypothetical protein +FIG01346824 Phosphatidylserine/phosphatidylglycerophosphate/cardiolipi n synthases and related enzymes +FIG01346827 similar to (EMBL:AL117211) YPMT1.20C, Yersinia pestis CO-92 hypothetical protein from plasmid pMT1; similar to (EMBL:AF074611) Y1035, Yersinia pestis KIM5 hypothetical protein from plasmid pMT1; blastn and dotplot analyses suggest that an insertion event has taken place at this point as compared to Yersinia pestis pMT1 +FIG01346852 COG family: dihydroxyacid dehydratase/phosphogluconate dehydratase +FIG01346857 N-acyl-D-amino-acid deacylase( EC:3.5.1.81 ) +FIG01346858 hypothetical protein +FIG01346861 McbG-like protein +FIG01346862 FIG00632139: hypothetical protein +FIG01346866 Sll1381 protein +FIG01346872 FIG01236913: hypothetical protein +FIG01346894 hypothetical protein( EC:2.3.1.128 ) +FIG01346896 FIG01249501: hypothetical protein +FIG01346898 SNARE-like associated protein +FIG01346902 Aromatic ring-cleaving dioxygenase +FIG01346906 AraC-family transcriptional regulator +FIG01346919 bacteriocin, putative +FIG01346920 Nitrite reductase related protein +FIG01346928 Transcriptional regulator, ArsR family member +FIG01346931 putative MutT-family protein +FIG01346935 FIG00769874: hypothetical protein +FIG01346937 histidine kinase( EC:2.7.13.3 ) +FIG01346939 FIG00385218: hypothetical protein +FIG01346940 putative integrase/recombinase +FIG01346955 FIG01117185: hypothetical protein +FIG01346970 FIG01232786: hypothetical protein +FIG01346979 Phage eae protein +FIG01347008 Methylamine utilization protein mauG +FIG01347018 Rossmann-fold nucleotide-binding protein +FIG01347028 Possible glyoxylase family protein (Lactoylglutathione lyase) (EC 4.4.1.5) +FIG01347029 Protein ybgE +FIG01347033 PTS system, beta-glucoside-specific, IIB component +FIG01347034 ABC transporter oligopeptide-binding protein +FIG01347035 protein of unknown function DUF1094 +FIG01347043 FIG00385291: hypothetical protein +FIG01347045 FIG00350446: hypothetical protein +FIG01347048 FIG00351458: hypothetical protein +FIG01347069 Phage major tail 2 +FIG01347074 phosphoglucomutase/phosphomannomutase family protein +FIG01347084 FIG00765230: hypothetical protein +FIG01347088 FIG014384: hypothetical protein +FIG01347103 lipid A-myristate beta-hydroxylase (EC 1.14.11.-) +FIG01347120 Proline/betaine transporter ProP6 +FIG01347121 FIG01222446: hypothetical protein +FIG01347134 FIG00410119: hypothetical protein +FIG01347137 Putative efflux pump +FIG01347139 YaiI/YqxD family protein +FIG01347141 Hemerythrin-like protein PA1673 +FIG01347142 FIG00404702: hypothetical protein +FIG01347143 NADPH nitroreductase +FIG01347159 Protein cse60 +FIG01347164 FIG00746246: hypothetical protein +FIG01347165 FIG00768255: hypothetical protein +FIG01347168 17 +FIG01347177 Bll7429 protein +FIG01347183 Ycf19 protein +FIG01347187 Serine protease mycosin MycP2, component of Type VII secretion system ESX-2 +FIG01347208 FIG00424341: hypothetical protein +FIG01347224 FIG00385187: hypothetical protein +FIG01347226 Outer membrane protein oprM +FIG01347233 repeat-containing protein C +FIG01347251 FIG00638070: hypothetical protein +FIG01347281 FIG00967058: hypothetical protein +FIG01347283 integrase/recombinase XerD +FIG01347289 DNA-directed RNA polymerase, subunit K/omega +FIG01347297 FIG00733812: hypothetical protein +FIG01347317 FIG00243119: hypothetical protein +FIG01347322 PTS system glucose-specific IIABC component +FIG01347351 FIG00352637: hypothetical protein +FIG01347352 FIG00404411: hypothetical protein +FIG01347369 FIG00532987: hypothetical protein +FIG01347378 COG family: phosphoserine phosphatase +FIG01347381 FIG01044275: hypothetical protein +FIG01347396 FIG00765058: hypothetical protein +FIG01347398 PROBABLE PROTEIN WITH PROLINE-ALANINE-ASPARTIC REPEATED MOTIF +FIG01347402 FIG00823799: hypothetical protein +FIG01347404 FIG00999926: hypothetical protein +FIG01347407 FIG00765974: hypothetical protein +FIG01347416 FIG01001703: hypothetical protein +FIG01347417 Periplasmic molybdate-binding protein/domain +FIG01347418 spore germination protein xc precursor. bacillus +FIG01347422 probable lipoprotein protein YPO1422 +FIG01347448 Protein tyrosine/serine phosphatase +FIG01347460 Metallo-dependent hydrolases, subgroup C +FIG01347470 NOHBY730; no homolog in Saccharomyces cerevisiae +FIG01347471 FIG00629497: hypothetical protein +FIG01347472 Lantibiotic salivaricin A +FIG01347482 Outer membrane autotransporter +FIG01347483 methyltransferase, FkbM family +FIG01347486 outer membrane assembly protein +FIG01347499 alpha-1,3-fucosyltransferase +FIG01347500 Trypanothione synthetase domain protein +FIG01347502 ORF_ID:alr2836 +FIG01347510 FIG00350908: hypothetical protein +FIG01347515 peptidase, M23 family +FIG01347518 ABC-type siderophore export system, fused ATPase and permease components +FIG01347527 Nitric oxide reductase activation protein NorF +FIG01347538 TonB-dependent receptor, putative +FIG01347542 FIG00344040: hypothetical protein +FIG01347544 Protein involved in cellulose biosynthesis (CelD)-like protein +FIG01347551 hypothetical protein +FIG01347553 Barstar +FIG01347555 ABC transporters +FIG01347558 FIG00641317: hypothetical protein +FIG01347570 ABC transporter ATP-binding protein( EC:3.6.3.25 ) +FIG01347626 type II restriction endonuclease, putative +FIG01347644 Acetate permease ActP (cation/acetate symporter) +FIG01347679 4-hydroxybutyrate:acetyl-CoA CoA transferase (EC 2.3.1.-) +FIG01347687 FIG00343877: hypothetical protein +FIG01347698 Putative thiamine biosynthesis related protein +FIG01347708 thiolase +FIG01347713 Immune-responsive protein 1 +FIG01347723 ORF27 +FIG01347724 outer surface protein B (ospB) +FIG01347766 Short-chain dehydrogenase/reductase SDR +FIG01347770 Telomere resolvase resT (EC 3.1.22.-) +FIG01347772 Putative DNA methyltransferase +FIG01347782 FIG00405852: hypothetical protein +FIG01347784 FIG00694897: hypothetical protein +FIG01347810 PUTATIVE PERIPLASMIC PROTEIN +FIG01347812 FIG00425754: hypothetical protein +FIG01347841 Acetyltransferase (isoleucine patch superfamily) +FIG01347847 ABC type sugar transport system, permease protein precursor +FIG01347849 Uncharacterized protein MJ1188 +FIG01347852 FIG00522149: hypothetical protein +FIG01347855 Sensor protein of a two component response regulator +FIG01347870 Oleate hydratase (EC 4.2.1.53) +FIG01347874 FIG00354963: hypothetical protein +FIG01347878 Predicted DNA-binding protein +FIG01347885 FIG00688604: hypothetical protein +FIG01347886 gp12 Burkholderia cepacia phage Bcep1 (e-49), hy p Rhodobact (e-31) +FIG01347888 putative cationic amino acid transporter +FIG01347893 FIG00385231: hypothetical protein +FIG01347902 FIG00769198: hypothetical protein +FIG01347930 similar to Transcriptional regulator +FIG01347931 transposase, mutator type +FIG01347936 FIG00402940: hypothetical protein +FIG01347937 FIG00350092: hypothetical protein +FIG01347938 putative repressor protein +FIG01347939 Soluble secreted antigen MPT53 precursor +FIG01347947 FIG01253263: hypothetical protein +FIG01347954 basic membrane lipoprotein +FIG01347963 Putative lipoprotein lprE precursor +FIG01347969 FIG00411018: hypothetical protein +FIG01347998 FIG00353043: hypothetical protein +FIG01347999 protein of unknown function DUF1460 +FIG01348005 possible transcriptional regulator, WhiB family +FIG01348010 FIG00388662: hypothetical protein +FIG01348015 branched-chain amino acid transport +FIG01348020 Glycosyl hydrolase-related protein +FIG01348025 putative surface layer protein +FIG01348026 2,4-dienoyl-CoA reductase +FIG01348028 FIG00405564: hypothetical protein +FIG01348030 FIG00425114: hypothetical protein +FIG01348040 sulfatase +FIG01348044 hypothetical protein +FIG01348045 FIG00647055: hypothetical protein +FIG01348049 iron-sulfur flavoprotein +FIG01348050 sphingomyelinase C +FIG01348067 FIG00849542: hypothetical protein +FIG01348068 Hypothetical protein SAV2318 +FIG01348078 putative membrane protein +FIG01348081 prophage LambdaBa02, lipoprotein +FIG01348089 GntR family transcriptional regulator VVA0237 @ Transcriptional regulator, GntR family domain +FIG01348093 Calcium/iron-binding protein +FIG01348098 Putative two-component sensor +FIG01348101 FIG00365023: hypothetical protein +FIG01348111 Putative uncharacterized protein YhaL +FIG01348112 general stress protein A +FIG01348134 Enoyl-CoA hydratase/isomerase +FIG01348146 FIG00939314: hypothetical protein +FIG01348183 IncP-type oriT binding protein TraK +FIG01348186 Protein hipA +FIG01348192 Cytosolic protein containing multiple CBS domains +FIG01348201 probable DNA polymerase III epsilon chain +FIG01348209 FIG00468481: hypothetical protein +FIG01348224 FIG00849731: hypothetical protein +FIG01348225 Hypothetical Transcriptional Regulator +FIG01348229 Acyl carrier protein +FIG01348230 Leucine-rich repeat domain protein +FIG01348247 Hypothetical protein SAV2086 +FIG01348250 FIG00403126: hypothetical protein +FIG01348255 FIG00350850: hypothetical protein +FIG01348261 Lsr2 family protein +FIG01348267 FIG00351302: hypothetical protein +FIG01348271 FIG00848773: hypothetical protein +FIG01348272 Intracellular protein transport protein USO1 +FIG01348277 ortholog to Borrelia burgdorferi BB0512 +FIG01348280 FIG00763425: hypothetical protein +FIG01348283 FIG036507: Fimbriae usher protein StdB +FIG01348299 DUF447 family protein +FIG01348302 Adenosine deaminase (EC 3.5.4.5) +FIG01348311 probable methyltransferase +FIG01348324 ABC-type Co2+ transport system, periplasmic component +FIG01348325 putative xylanase +FIG01348339 COG1496: Uncharacterized conserved protein +FIG01348357 FIG01220733: hypothetical protein +FIG01348367 aminoglycoside 3'-phosphotransferase +FIG01348373 Putative cytoplasmic protein +FIG01348390 Uncharacterized protein yddI +FIG01348405 FIG00837829: hypothetical protein +FIG01348406 putative Rhs protein +FIG01348407 response regulator in two-component regulatory system with AtoS, regulates acetoacetate metabolism (EBP family) +FIG01348412 Phosphoribosyl transferase domain protein +FIG01348413 Gll0647 protein +FIG01348429 conserved hypothetical integral membrane protein, putative +FIG01348436 Phosphoribosylanthranilate isomerase( EC:5.3.1.24 ) +FIG01348447 MembA +FIG01348459 Anti-sigma F factor antagonist (spoIIAA-2); Anti-sigma B factor antagonist RsbV +FIG01348461 hexosyltransferase 1 +FIG01348467 FIG00411469: hypothetical protein +FIG01348473 plasmid stability protein StbB +FIG01348481 ABC-type multidrug transport system (daunorubicin resistance), ATPase component +FIG01348494 TraJ protein +FIG01348508 peptidase, T4 family +FIG01348510 pyridoxal-dependent decarboxylase conserved domain [EC:4.1.2.27] +FIG01348513 Purine nucleoside phosphorylase +FIG01348516 oxidoreductase, short chain dehydrogenase-reductase family +FIG01348520 elastin +FIG01348525 probable chlorohydrolase +FIG01348540 FIG00468973: hypothetical protein +FIG01348547 probable integral membrane protein NMA1933 +FIG01348559 possible histidine kinase sensor of two component system +FIG01348565 L-arabinose transport ATP-binding protein araG (EC 3.6.3.17) +FIG01348567 FIG00766380: hypothetical protein +FIG01348573 glycosyltransferase, GT2 family +FIG01348585 FIG00468721: hypothetical protein +FIG01348589 FIG00767418: hypothetical protein +FIG01348637 FIG00406685: hypothetical protein +FIG01348639 Probable phiRv1 phage protein +FIG01348657 FIG01117826: hypothetical protein +FIG01348659 FIG00815577: hypothetical protein +FIG01348662 alternate gene name: ydjQ +FIG01348663 Endo-beta-N-acetylglucosaminidase H precursor (EC 3.2.1.96) (Mannosyl-glycoprotein endo-beta-N-acetyl-glucosaminidase H) (DI-N-acetylchitobiosyl beta-N-acetylglucosaminidase H) (Endoglycosidase H) (Endo H) +FIG01348686 FIG00531667: hypothetical protein +FIG01348693 FIG00764659: hypothetical protein +FIG01348702 MloA +FIG01348706 Enamidase (EC 3.5.2.18) +FIG01348710 FIG00350615: hypothetical protein +FIG01348711 FIG00350034: hypothetical protein +FIG01348717 Intracellular proteinase inhibitor +FIG01348720 FIG00452993: hypothetical protein +FIG01348734 FIG00963002: hypothetical protein +FIG01348736 FIG00632045: hypothetical protein +FIG01348741 FIG01114789: hypothetical protein +FIG01348748 hypothetical protein +FIG01348758 Polysaccharide deacetylase (EC 3.5.1.41) +FIG01348766 transcriptional regulator MvaT, P16 subunit, putative +FIG01348773 B. burgdorferi predicted coding region BB0356 +FIG01348784 FIG01166089: hypothetical protein +FIG01348789 Signaling protein with membrane-bound sensor domain and GGDEF domain +FIG01348795 TagE protein +FIG01348800 Transposase STY4875 +FIG01348809 FIG00411736: hypothetical protein +FIG01348820 putative carboxymethylenebutenolidase +FIG01348849 competence protein F +FIG01348851 Multidrug efflux RND membrane fusion protein MexE +FIG01348856 FIG00354570: hypothetical protein +FIG01348874 FIG01120158: hypothetical protein +FIG01348884 Dihydroneopterin aldolase (EC 4.1.2.25) / Cupin +FIG01348900 FIG00351239: hypothetical protein +FIG01348917 Possible Trypsin +FIG01348922 hypothetical protein +FIG01348928 Transposase, ISLbp4 +FIG01348948 Mll3207 protein +FIG01348971 PROBABLE LIPOPROTEIN +FIG01348972 Diadenosine tetraphosphatase +FIG01348992 unknown +FIG01348999 VirK +FIG01349019 FIG00427518: hypothetical protein +FIG01349022 Resolvase/recombinase +FIG01349023 Glycerol-3-phosphate O-acyltransferase +FIG01349025 predicted cell wall channel +FIG01349032 FIG01349032: hypothetical protein +FIG01349038 Lysine decarboxylase family +FIG01349041 Immunogenic protein MPT63/MPB63 precursor +FIG01349052 All7165 protein +FIG01349057 Proline iminopeptidase +FIG01349059 NanA gene +FIG01349061 FIG00410646: hypothetical protein +FIG01349065 PpkA +FIG01349115 capsular polysaccharide biosynthesis protein Cps4F +FIG01349123 FIG00749460: hypothetical protein +FIG01349132 FIG00355886: hypothetical protein +FIG01349137 possible alpha beta hydrolase +FIG01349138 FIG01239238: hypothetical protein +FIG01349139 Cytochrome P450-type heme-thiolate monooxygenase, N-terminal +FIG01349150 Haemolysin expression modulating protein paralog +FIG01349158 probable methyl-accepting chemotaxis transducer +FIG01349159 Ribonucleases G and E +FIG01349161 encapsulation protein CapA +FIG01349172 hypothetical protein +FIG01349174 FIG00451114: hypothetical protein +FIG01349175 PduO +FIG01349182 Uncharacterized protein y4iI +FIG01349184 Putative metal dependent phosphohydrolase +FIG01349188 Serine/threonine protein phosphatase 1 (EC 3.1.3.16) +FIG01349202 putative fimbriae assembly-related protein +FIG01349205 FIG020268: hypothetical protein +FIG01349211 FIG00623891: hypothetical protein +FIG01349213 Uncharacterized protein YfaD +FIG01349247 hypothetical protein +FIG01349249 Probable cutinase Cut4 (EC 3.1.1.74) +FIG01349266 Possible Early Protein +FIG01349284 FIG00773824: membrane protein +FIG01349296 Uncharacterized protein MJ0274 +FIG01349303 Calcium/calmodulin-dependent protein kinase type II beta chain (EC 2.7.11.17) +FIG01349308 metallo cofactor biosynthesis protein +FIG01349311 FIG00423908: hypothetical protein +FIG01349312 penicillin-binding protein +FIG01349333 FIG01203573: hypothetical protein +FIG01349337 FIG00458113: hypothetical protein +FIG01349343 mechanosensitive ion channel family protein +FIG01349359 Citrate-proton symporter +FIG01349364 Six-hairpin glycosidase-like protein +FIG01349369 outer membrane protein, TonB dependent +FIG01349381 Helicase conserved C-terminal domain protein +FIG01349387 Hot dog fold protein HP0420 +FIG01349402 plasmid pRiA4b ORF-3 family protein +FIG01349403 Membrane protein SPy0796 +FIG01349407 response regulator/anti-anti-sigma factor +FIG01349413 FIG00523922: hypothetical protein +FIG01349418 FIG00472195: hypothetical protein +FIG01349419 probable dicarboxylate transporter +FIG01349422 FIG01118054: hypothetical protein +FIG01349423 Outer membrane protein 40 precursor +FIG01349431 Putative dehydratase protein STM2273 +FIG01349435 FIG00763188: hypothetical protein +FIG01349450 prophage, terminase, ATPase subunit, putative +FIG01349452 FIG00639634: hypothetical protein +FIG01349454 bll2942; probable reductase (EC 1.1.1-) +FIG01349460 Putative uncharacterized protein BCG_1587 +FIG01349466 FIG00641357: hypothetical protein +FIG01349470 FIG00404860: hypothetical protein +FIG01349476 FIG00623488: hypothetical protein +FIG01349488 FIG00351689: hypothetical protein +FIG01349490 hypothetical protein within a prophage +FIG01349494 FIG00848217: hypothetical protein +FIG01349506 ortholog to Borrelia burgdorferi BB0013 +FIG01349510 Truncated integrase +FIG01349516 Conserved domain protein +FIG01349522 probable regulator NMA0959 +FIG01349528 1-carboxy-3-chloro-3,4-dihydroxycyclo hexa-1,5-diene dehydrogenase (EC 1.-.-.-) +FIG01349529 FIG00825126: hypothetical protein +FIG01349533 Hmc operon protein 6 +FIG01349536 ATP-dependent DNA helicase +FIG01349539 putative transport system permease protein +FIG01349544 NADH oxidase (two distinct flavin oxidoreductase domains) +FIG01349547 FIG00407889: hypothetical protein +FIG01349554 Purine-binding chemotaxis protein CheW +FIG01349555 Cupin domain-containing protein +FIG01349556 CsbD-like superfamily +FIG01349580 NADH:flavin oxidoreductases, Old Yellow Enzyme family +FIG01349581 FIG00404196: hypothetical protein +FIG01349584 FIG01136024: hypothetical protein +FIG01349592 FIG00524137: hypothetical protein +FIG01349610 Predicted acyl esterase/dipeptidyl-peptidase +FIG01349616 Uncharacterized protein YqeH +FIG01349620 FIG00350259: hypothetical protein +FIG01349630 hypothetical protein +FIG01349644 FIG00387994: hypothetical protein +FIG01349645 FIG00404109: hypothetical protein +FIG01349647 N-acyl-D-amino-acid deacylase (EC 3.5.1.81) +FIG01349649 FIG00826588: hypothetical protein +FIG01349651 Vegetative cell wall protein gp1 precursor +FIG01349659 FIG00766106: hypothetical protein +FIG01349667 FIG00953846: hypothetical protein +FIG01349691 Micrococcal nuclease (thermonuclease) homologs +FIG01349696 ABC transport ATP-binding subunit +FIG01349698 FIG00385709: hypothetical protein +FIG01349710 FIG00426881: hypothetical protein +FIG01349712 FIG01206678: hypothetical protein +FIG01349713 riboflavin kinase( EC:2.7.1.26 ) +FIG01349714 Oxygenase-like protein +FIG01349718 FIG00403603: hypothetical protein +FIG01349721 Sll1123 protein +FIG01349744 Uncharacterized 35.5 kDa protein in gldA 3'region (ORF4) +FIG01349747 Xylitol ABC transporter, permease component +FIG01349753 Hemin binding protein Hbp +FIG01349756 aldehyde:ferredoxin oxidoreductase +FIG01349758 UvrD/REP helicase +FIG01349768 Resolvase, N terminal domain family +FIG01349770 FIG00424992: hypothetical protein +FIG01349780 FIG00675563: hypothetical protein +FIG01349787 FIG00350365: hypothetical protein +FIG01349791 Putative hemolysin activation/secretion protein +FIG01349794 FIG01089269: hypothetical protein +FIG01349800 Iron (III) ABC transporter, periplasmic-binding protein +FIG01349801 FIG124152: hypothetical protein +FIG01349814 Putative nucleotide sugar epimerase +FIG01349817 protein of unknown function DUF980 +FIG01349818 Secondary glycine betaine transporter BetU +FIG01349819 FIG00939774: hypothetical protein +FIG01349825 protein-export membrane protein-related protein +FIG01349829 Serine/threonine protein kinase (EC 2.7.11.1) +FIG01349835 FIG00899400: hypothetical protein +FIG01349840 FIG00353651: hypothetical protein +FIG01349843 Protein psaF +FIG01349845 FIG00528861: hypothetical protein +FIG01349851 ABC-type sugar transport system, permease component +FIG01349854 alternative bacteriophage tail fiber C-terminus +FIG01349858 candidate polysaccharide lyase, polysaccharide lyase family 14 protein +FIG01349896 Exotoxin 1 +FIG01349907 transmembrane protein, putative +FIG01349909 FIG00896374: hypothetical protein +FIG01349919 hypothetical protein +FIG01349920 Short-chain alcohol dehydrogenase +FIG01349922 ComQ +FIG01349923 putative two-component system sensor histidine kinase +FIG01349927 Protein involved in lantibiotic (srt) production / Tn5252, relaxase +FIG01349929 FIG00364971: hypothetical protein +FIG01349931 FIG00469134: hypothetical protein +FIG01349935 papain cysteine protease family protein +FIG01349942 FIG00468567: hypothetical protein +FIG01349944 RNA metabolism-related protein +FIG01349979 hypothetical protein +FIG01349980 FIG00385531: hypothetical protein +FIG01349983 Replication initiator protein +FIG01349989 PPE-repeat proteins +FIG01349990 Ribose ABC transport system, permease protein RbsC (TC 3.A.1.2.1) +FIG01349997 putative permease +FIG01350002 hypthetical protein SCD63.18c +FIG01350006 MOLYBDOPTERIN OXIDOREDUCTASE, MEMBRANE SUBUNIT +FIG01350035 SpcY +FIG01350036 Secretion system protein PilA like +FIG01350066 Low temperature requirement C protein +FIG01350068 FIG00768878: hypothetical protein +FIG01350092 ABC efflux pump, inner membrane subunit +FIG01350120 SEFIR domain containing protein +FIG01350123 FIG01238684: hypothetical protein +FIG01350126 Teicoplanin resistance protein +FIG01350128 HAD-superfamily phosphatase, subfamily IIIC +FIG01350129 FIG00404706: hypothetical protein +FIG01350141 Collagen pro alpha-chain precursor +FIG01350144 FIG00875314: hypothetical protein +FIG01350147 serine protease C +FIG01350156 Sensory box (GGDEF/EAL domain) regulatory protein +FIG01350170 FIG00589914: hypothetical protein +FIG01350174 FIG00767375: hypothetical protein +FIG01350177 Homolog of virulence protein msgA +FIG01350179 AttM/AiiB family protein +FIG01350191 Putative transcriptional regulator with a sugar kinase domain, GntR family +FIG01350192 AclR protein +FIG01350193 C4-dicarboxylate transport protein +FIG01350250 DNA methylase containing a Zn-ribbon +FIG01350255 EspF +FIG01350261 FIG01042615: hypothetical protein +FIG01350272 epoxide hydrolase +FIG01350293 hypothetical protein +FIG01350299 tail protein D, putative +FIG01350308 thiol:disulfide interchange protein (dsbC), putative +FIG01350311 possible Phosphate-binding protein +FIG01350314 COG2931: RTX toxins and related Ca2+-binding proteins +FIG01350321 hypothetical phagelike protein +FIG01350346 ribonuclease R homolog +FIG01350353 Extracellular neutral metalloprotease, NPRE, fused to ChW-repeats +FIG01350359 outer membrane porin protein +FIG01350384 Putative oxidoreductase protein (EC 1.-.-.-) +FIG01350387 putative N-acetylmuramoyl-L-alanine amidase +FIG01350405 hicB +FIG01350409 FIG01240780: hypothetical protein +FIG01350424 Putative DNA processing chain A +FIG01350426 FIG01049542: hypothetical protein +FIG01350437 ParA protein +FIG01350472 Cobalamine biosynthesis-related hypothetical protein CobX +FIG01350473 COG1340: Uncharacterized archaeal coiled-coil protein +FIG01350481 FIG00385200: hypothetical protein +FIG01350483 Ribosylnicotinamide kinase (EC 2.7.1.22) homolog / Unknown conserved in Flavobacteria +FIG01350485 FIG00897921: hypothetical protein +FIG01350494 FIG00515936: hypothetical protein +FIG01350497 FIG00424305: hypothetical protein +FIG01350507 methyl-accepting chemotaxis protein (mcp-1) +FIG01350511 Probable epoxide hydrolase ephC (EC 3.3.2.9) +FIG01350517 alginate biosynthesis transcriptional regulatory protein AlgB +FIG01350537 citrate transporter, CitM family +FIG01350540 Cocaine esterase (EC 3.1.1.-) +FIG01350543 FIG00350883: hypothetical protein +FIG01350544 FIG00523686: hypothetical protein +FIG01350552 FIG00623866: hypothetical protein +FIG01350559 putative serine/threonine-protein kinase +FIG01350577 MatE efflux family protein +FIG01350619 Prophage antirepressor +FIG01350625 FIG00764727: hypothetical protein +FIG01350634 Putative GerE-family regulatory protein +FIG01350638 COG1028: Dehydrogenases with different specificities (related to short-chain alcohol dehydrogenases) +FIG01350646 HipA +FIG01350659 putative D-alanyl-d-alanine dipeptidase +FIG01350663 Carbonic anhydrase precursor (EC 4.2.1.1) +FIG01350673 ATPase N2B +FIG01350683 FIG01201461: hypothetical protein +FIG01350684 FIG01244116: hypothetical protein +FIG01350690 CONSERVED 13E12 REPEAT FAMILY PROTEIN +FIG01350698 FIG00405061: hypothetical protein +FIG01350700 Hypothetical protein YPO2504 +FIG01350708 protein of unknown function DUF523 +FIG01350709 Disulphide-isomerase +FIG01350717 Predicted nicotinate-regulated transporter BH3254 +FIG01350731 FIG00388827: hypothetical protein +FIG01350734 FIG00424658: hypothetical protein +FIG01350740 putative glucokinase +FIG01350741 Putative uncharacterized protein BCG_2061c +FIG01350743 cag pathogenicity island protein +FIG01350746 HD family hydrolase, diverged +FIG01350750 FIG00408295: hypothetical protein +FIG01350769 tryptophan/tyrosine permease family protein +FIG01350774 FIG01225812: hypothetical protein +FIG01350783 HemN-related protein +FIG01350799 FIG01060674: hypothetical protein +FIG01350805 Decaheme cytochrome c MtrF +FIG01350814 Ribosomal RNA small subunit methyltransferase C (EC 2.1.1.52) +FIG01350840 FIG00413180: hypothetical protein +FIG01350846 FIG01199569: hypothetical protein +FIG01350848 FIG00765128: hypothetical protein +FIG01350849 transposase IS200-like +FIG01350855 FIG00511837: hypothetical protein +FIG01350858 FIG00623302: hypothetical protein +FIG01350859 Probable iron-sulfur binding reductase +FIG01350863 FIG00385518: hypothetical protein +FIG01350880 FIG00346609: hypothetical protein +FIG01350886 protein of unknown function DUF1123 +FIG01350892 FIG00640650: hypothetical protein +FIG01350918 POSSIBLE SECRETED ALANINE RICH PROTEIN +FIG01350929 probable membrane protein YPO2362 +FIG01350935 Serine/threonine-protein kinase pksC (EC 2.7.11.1) +FIG01350946 Antiseptic resistance protein QacA +FIG01350947 Possible glycosyltransferase 2 fused to TPR-repeat domain +FIG01350952 FIG01092925: hypothetical protein +FIG01350953 FIG01165721: hypothetical protein +FIG01350954 Putative uncharacterized protein usfY +FIG01350956 Oxidoreductase alpha (Molybdopterin) subunit +FIG01350958 YcgQ-like protein +FIG01350973 FIG00823263: hypothetical protein +FIG01350974 Putative aminotransferase +FIG01350977 FIG01244191: hypothetical protein +FIG01350979 Exopolyphosphatase-related protein +FIG01350990 Small hydrophobic protein Cj0260c-related protein +FIG01350991 RIKEN cDNA 3110005O21 gene +FIG01350992 FIG01120994: hypothetical protein +FIG01350993 CoA ligase +FIG01351022 FIG00756533: hypothetical protein +FIG01351051 COG2116: Formate/nitrite family of transporters +FIG01351058 sodium-dependent transporter (huNaDC-1) +FIG01351064 FIG00350366: hypothetical protein +FIG01351068 Phospholipid-binding protein +FIG01351082 TonB-dependent receptor plug domain protein +FIG01351083 potassium channel protein, truncated +FIG01351086 PTS system, lactose-specific IIA component (EIIA-LAC) (Lactose- permease IIA component) (Phosphotransferase enzyme II, A component) (EC 2.7.1.69) +FIG01351097 FIG00655893: hypothetical protein +FIG01351114 OsmC family protein +FIG01351119 probable TetR-family transcriptional regulator +FIG01351122 FIG00824650: hypothetical protein +FIG01351126 Capsular polysaccharide biosynthesis protein +FIG01351154 Attachment to host cells and virulence +FIG01351158 FIG00361219: hypothetical protein +FIG01351169 lysine/ornithine N-monooxygenase +FIG01351180 N-acetylmuramoyl-L-alanine amidase, family 4 +FIG01351190 Mrr restriction system protein +FIG01351211 possible cyclomaltodextrinase or neopullalanase +FIG01351214 Putative stress response protein +FIG01351216 cell-division protein ftsA +FIG01351227 Amine oxidase [flavin-containing] (EC 1.4.3.4) +FIG01351235 iron (chelated) transporter ATP-binding protein +FIG01351242 FIG01119440: hypothetical protein +FIG01351248 possible serine recombinase +FIG01351255 AhpC/TSA family protein +FIG01351258 FIG00937423: hypothetical protein +FIG01351267 Hypothetical lipoprotein +FIG01351278 cation-transporting ATPase PacL +FIG01351290 protein of unknown function DUF1089 +FIG01351301 FIG00404513: hypothetical protein +FIG01351314 FIG00668729: hypothetical protein +FIG01351322 sodium-solute symporter, putative +FIG01351324 Predicted metal-binding membrane protein +FIG01351344 FIG00766875: hypothetical protein +FIG01351348 FIG00765948: hypothetical protein +FIG01351355 pXO1-04 +FIG01351366 HicB-like protein +FIG01351371 FIG00403450: hypothetical protein +FIG01351377 FIG00351083: hypothetical protein +FIG01351379 VanZ like family protein +FIG01351381 FIG00754367: hypothetical protein +FIG01351384 putative cell division inhibition protein +FIG01351395 Possible exported protein +FIG01351423 FIG00406448: hypothetical protein +FIG01351444 Na+ ABC transporter natB +FIG01351450 Predicted signal transduction protein containing EAL and modified HD-GYP domains +FIG01351463 putative ribose ABC transporter +FIG01351477 T-DNA border endonuclease VirD2, RP4 TraG-like relaxase +FIG01351482 FIG00413584: hypothetical protein +FIG01351486 FIG01100235: hypothetical protein +FIG01351500 FIG00411422: hypothetical protein +FIG01351511 specificity determining subunit for restriction enzyme belonging to the K family of S proteins +FIG01351515 Aculeacin A acylase +FIG01351516 DNA or RNA helicase of superfamily protein II +FIG01351517 FIG00623861: hypothetical protein +FIG01351539 FIG00769653: hypothetical protein +FIG01351540 FIG00405495: hypothetical protein +FIG01351548 PEP-utilizing enzymes family protein +FIG01351554 protease inhibitor precursor +FIG01351564 Cytochrome b561 family protein +FIG01351587 FIG00385420: hypothetical protein +FIG01351589 transposase, IS204/IS1001/IS1096/IS1165 family protein +FIG01351592 FIG00624279: hypothetical protein +FIG01351603 FIG00424137: hypothetical protein +FIG01351605 FIG00385574: hypothetical protein +FIG01351612 Monocarboxylate transporter 3 +FIG01351616 Glutaminase A +FIG01351637 FIG00953423: hypothetical protein +FIG01351639 Probable disulfide formation protein C 2 +FIG01351645 Protein of unknown function DUF181 +FIG01351648 FIG00765979: hypothetical protein +FIG01351651 HPT domain containing protein +FIG01351661 FIG00712881: hypothetical protein +FIG01351663 FIG01221829: hypothetical protein +FIG01351665 FIG00822681: hypothetical protein +FIG01351666 hypothetical plasmid protein +FIG01351669 possible dihydroflavonol-4-reductase (maize, petunia, tomato)... +FIG01351674 metalloprotease, insulinase family +FIG01351677 FIG00413703: hypothetical protein +FIG01351696 gpR +FIG01351719 COG1434: Uncharacterized conserved protein +FIG01351722 two component transcriptional regulator, winged helix family protein +FIG01351726 Oxidoreductase +FIG01351729 probable membrane protein yqgA +FIG01351734 FIG00774527: hypothetical protein +FIG01351746 FIG00404225: hypothetical protein +FIG01351750 (adenine-N6-)-methyltransferase homolog +FIG01351752 FIG00407458: hypothetical protein +FIG01351759 FIG00767821: hypothetical protein +FIG01351769 probable esterase +FIG01351771 FIG00764085: hypothetical protein +FIG01351782 FIG00687611: hypothetical protein +FIG01351786 FIG00768472: hypothetical protein +FIG01351801 hypothetical protein +FIG01351834 FIG00403816: hypothetical protein +FIG01351835 Maebl +FIG01351841 PE family protein +FIG01351855 Permease of the major facilitator transporter superfamily +FIG01351860 Probable LysR-family transcriptional regulator +FIG01351886 Photopexin A +FIG01351888 FIG00638591: hypothetical protein +FIG01351904 Methylenomycin A resistance protein +FIG01351912 FIG00629331: hypothetical protein +FIG01351928 FIG00820186: hypothetical protein +FIG01351935 Outer membrane component of multidrug efflux pump +FIG01351940 exopolysaccharide synthesis protein ExoD-related protein +FIG01351949 Dinitrogenase reductase activating glycohydrolase +FIG01351951 hypothetical protein +FIG01351957 hypothetical protein +FIG01351958 FIG00385356: hypothetical protein +FIG01351961 FIG00385725: hypothetical protein +FIG01351974 Phospholipase D superfamily protein PLD +FIG01351975 SppA +FIG01351987 POSSIBLE TRANSMEMBRANE PROTEIN +FIG01351990 Oxalate/formate antiporter +FIG01351992 FIG01040533: hypothetical protein +FIG01352000 acetamidase/formamidase( EC:3.5.1.49 ) +FIG01352012 cation efflux family protein +FIG01352018 Putative ATP/GTP-binding protein +FIG01352020 FIG00341809: hypothetical protein +FIG01352032 Transcription termination protein NusB +FIG01352033 Predicted amidohydrolase +FIG01352034 putative endonuclease. +FIG01352038 Alr2762 protein +FIG01352046 antiterminator-like protein +FIG01352048 hypothetical protein +FIG01352059 Phage tail collar-like protein +FIG01352072 Xylose kinase (EC 2.7.1.17) +FIG01352077 Pyrroloquinoline quinone (Coenzyme PQQ) biosynthesis protein C +FIG01352079 OUTER MEMBRANE ASSEMBLY PROTEIN (asmA) +FIG01352082 protein-L-isoaspartate O-methyltransferase +FIG01352103 Putative 3-ketoacyl-acyl carrier protein reductase +FIG01352112 FIG01165968: hypothetical protein +FIG01352113 FIG00349975: hypothetical protein +FIG01352122 FIG00768563: hypothetical protein +FIG01352131 Truncated replication protein for plasmid +FIG01352141 Acyl-CoA dehydrogenase (EC 1.3.8.7) +FIG01352145 Iron-regulated protein frpA +FIG01352166 thermonuclease family protein, (pXO1-141) +FIG01352170 FIG01047943: hypothetical protein +FIG01352181 FIG00387802: hypothetical protein +FIG01352186 Insecticidal toxin complex protein TcaC +FIG01352188 hypothetical protein SC7F9.12c +FIG01352196 possible Paralytic/GBP/PSP peptide +FIG01352209 FIG00413979: hypothetical protein +FIG01352218 Phage transcriptional repressor +FIG01352219 Predicted glutamine amidotransferases +FIG01352221 FIG01139921: hypothetical protein +FIG01352225 FIG00384982: hypothetical protein +FIG01352250 FIG01244530: hypothetical protein +FIG01352256 PorT protein +FIG01352257 Snf2 family helicase +FIG01352267 Protein of unknown function (DUF1232) family +FIG01352272 FIG00415354: hypothetical protein +FIG01352281 flagellar basal-body rod protein +FIG01352282 COG0508: Pyruvate/2-oxoglutarate dehydrogenase complex, dihydrolipoamide acyltransferase (E2) component, and related enzymes +FIG01352284 Type VII secretion integral membrane protein EccD +FIG01352290 conjugative transfer protein +FIG01352292 UPF0301 protein YqgE +FIG01352295 NAD+--asparagine ADP-ribosyltransferase +FIG01352303 FIG00559777: hypothetical protein +FIG01352305 FIG00534705: hypothetical protein +FIG01352312 Lysophospholipase L1 +FIG01352314 FIG00814687: hypothetical protein +FIG01352321 FIG01244544: hypothetical protein +FIG01352324 putative membrane protein +FIG01352334 Antirepressor protein ant +FIG01352349 possibly involved in bacteriocin production or immunity +FIG01352351 Multidrug resistance protein +FIG01352363 probable iron ABC transporter, ATP-binding protein +FIG01352364 ABC-type transport system, involved in lipoprotein release, permease component +FIG01352370 Gll3169 protein +FIG01352397 putative zinc-binding carboxypeptidase +FIG01352398 Uncharacterized protein sll1783 +FIG01352413 FIG00451839: hypothetical protein +FIG01352421 FIG00425838: hypothetical protein +FIG01352426 Rhodanese domain protein / Ankyrin +FIG01352451 FIG00464231: hypothetical protein +FIG01352452 NADH:N-amidino-scyllo-inosamine oxidoreductase +FIG01352456 transposase fragment +FIG01352472 syc2323_c +FIG01352477 FIG00623217: hypothetical protein +FIG01352490 RelE/StbE replicon stabilization toxin +FIG01352495 FIG00762587: hypothetical protein +FIG01352500 FlgN Protein +FIG01352516 FIG00815437: hypothetical protein +FIG01352517 FIG029924: hypothetical protein +FIG01352521 Exopolysaccharide biosynthesis protein related to N-acetylglucosamine-1-phosphodiester alpha-N-acetylglucosaminidase +FIG01352523 Subtilisin precursor +FIG01352555 FIG00769938: hypothetical protein +FIG01352565 Lipolytic enzyme, G-D-S-L precursor +FIG01352574 FIG00350012: hypothetical protein +FIG01352581 hypothetical protein +FIG01352582 FIG00768478: hypothetical protein +FIG01352589 FIG00351599: hypothetical protein +FIG01352596 Nonspecific acid phosphatase +FIG01352617 Possible membrane protein RV0347 +FIG01352622 Insulinase-like:Peptidase M16, C-terminal +FIG01352630 FIG00516048: hypothetical protein +FIG01352637 FIG00354001: hypothetical protein +FIG01352648 FIG00349947: hypothetical protein +FIG01352649 putative signal peptide +FIG01352657 alpha/beta-Hydrolase +FIG01352665 FIG00524480: hypothetical protein +FIG01352673 Phage Gp37Gp68 protein +FIG01352689 FIG00425402: hypothetical protein +FIG01352696 Putative ABC transporter (permease protein) +FIG01352713 Unnamed protein product +FIG01352735 potassium-dependent ATPase G chain +FIG01352753 FIG01201972: hypothetical protein +FIG01352754 zinc-binding dehydrogenase +FIG01352759 FIG00403590: hypothetical protein +FIG01352770 cytolysin immunity CylI domain protein +FIG01352773 fructosyl-amino acid oxidase +FIG01352778 permease-like protein +FIG01352779 hypothetical protein +FIG01352780 protein of unknown function DUF11 +FIG01352782 exonuclease +FIG01352787 FIG00830366: hypothetical protein +FIG01352801 DNA topoisomerase IV subunit A +FIG01352806 Phage integrase +FIG01352808 FIG00520918: hypothetical protein +FIG01352813 Lipoprotein DsbF +FIG01352828 probable outer membrane protein +FIG01352829 Fur regulated protein ORF x171.28 +FIG01352850 transglycosylase associated gene +FIG01352851 2-polyprenyl-6-methoxyphenol hydroxylase and related FAD-dependent oxidoreductases +FIG01352855 Intracellular growth locus, subunit D +FIG01352858 Polyketide synthase associated protein PapA3 +FIG01352866 gsc +FIG01352873 FIG00742348: hypothetical protein +FIG01352878 Putative iron compound permease protein of ABC transporter family +FIG01352879 dTDP-6-deoxy-3,4-keto-hexulose isomerase +FIG01352883 UPF0145 protein lpg0197 +FIG01352899 FIG00385382: hypothetical protein +FIG01352902 FIG00403676: hypothetical protein +FIG01352912 Daunorubicin resistance transmembrane protein +FIG01352920 Disulfide bond formation protein BdbC, competence-related +FIG01352923 RelE/StbE replicon stabilization toxin +FIG01352925 phosphatidylcholine desaturase +FIG01352932 FIG01123783: hypothetical protein +FIG01352945 Fe2+ transport system protein A +FIG01352961 YciO family +FIG01352967 3'-phosphoadenoside 5'-phosphosulfate metabolism (CysQ) +FIG01352971 Lin1741 protein +FIG01352973 Excinuclease ATPase subunit +FIG01352978 glutamine ABC transporter, periplasmic glutamine-binding protein +FIG01352992 FIG01048335: hypothetical protein +FIG01352994 basic membrane protein A +FIG01353003 FIG00823617: hypothetical protein +FIG01353016 Putative acyl-coA hydrolase +FIG01353020 FIG00350566: hypothetical protein +FIG01353026 FIG00837597: hypothetical protein +FIG01353029 Phosphatidylglycerophosphatase A, PgpA +FIG01353037 FIG01045540: hypothetical protein +FIG01353043 predicted protein +FIG01353055 Cyclic nucleotide-binding:Bacterial regulatory protein, Crp +FIG01353065 PE-PGRS FAMILY PROTEIN +FIG01353072 FIG00408501: hypothetical protein +FIG01353078 FIG00384966: hypothetical protein +FIG01353089 periplasmic binding protein, putative +FIG01353093 FIG01116588: hypothetical protein +FIG01353094 Zn finger containing protein [Methanopyrus kandeleri]; COG1779: C4-type Zn finger +FIG01353111 putative phosphatase/kinase +FIG01353112 FMN oxidoreductase +FIG01353114 FIG00350284: hypothetical protein +FIG01353116 FIG00658158: hypothetical protein +FIG01353119 S-layer homology domain protein +FIG01353122 FIG01046320: hypothetical protein +FIG01353125 FIG00767116: hypothetical protein +FIG01353129 NanA gene +FIG01353135 FIG00641118: hypothetical protein +FIG01353138 YPPCP.09C homologue +FIG01353144 FIG00364730: hypothetical protein +FIG01353148 FIG00406507: hypothetical protein +FIG01353154 Choline-sulfatase (EC 3.1.6.6) BUT NOT +FIG01353167 CHLPS 43 kDa protein homolog_2 +FIG01353174 FIG00426247: hypothetical protein +FIG01353175 putative single strand binding protein +FIG01353176 HrpG protein +FIG01353180 small hydrophobic protein +FIG01353198 MORN motif family protein +FIG01353218 Transport ATP Binding Protein +FIG01353220 Haloacetate dehalogenase H-1 (EC 3.8.1.3) +FIG01353236 FIG00405735: hypothetical protein +FIG01353245 multidrug resistance ABC transporter ATP-binding protein +FIG01353252 FIG00389960: hypothetical protein +FIG01353275 Pass1-related protein +FIG01353284 putative lysozyme +FIG01353285 Xylose repressor XylR (ROK family) +FIG01353293 FIG00898258: hypothetical protein +FIG01353299 DNA helicase related to phage enzyme +FIG01353302 FIG00850068: hypothetical protein +FIG01353303 possible transporter, DMT superfamily +FIG01353329 prophage LambdaBa02, membrane protein, putative +FIG01353340 FIG00450081: hypothetical protein +FIG01353353 inositol monophophatase family protein +FIG01353358 Putative secreted protein +FIG01353362 FIG00642476: hypothetical protein +FIG01353367 Undecaprenyl-glycosyltransferase WbkF +FIG01353369 possible ubiquinone/menaquinone biosynthesis methyltransferase +FIG01353385 Possible glycosyl hydrolase +FIG01353393 conserved hypothetical protein-putative thiol-disulfide isomerase or thioredoxin +FIG01353400 Bacterial luciferase family protein +FIG01353401 FIG00769320: hypothetical protein +FIG01353408 Probable nonribosomal peptide synthetase +FIG01353423 FIG00468394: hypothetical protein +FIG01353452 FIG00526642: hypothetical protein +FIG01353455 Probable activation/secretion signal peptide protein +FIG01353463 ABC transporter iron(III)/siderophore transport system ATP-binding protein +FIG01353467 Probable aminotransferase +FIG01353480 FIG00388378: hypothetical protein +FIG01353493 radical SAM domain protein +FIG01353504 bll7128; unknown protein +FIG01353506 major membrane immunogen precursor +FIG01353511 FIG00405789: hypothetical protein +FIG01353512 FIG00352600: hypothetical protein +FIG01353517 FIG00841505: hypothetical protein +FIG01353521 Ribonuclease HI +FIG01353549 Glycosyl transferase( EC:2.4.1.- ) +FIG01353556 similarity to cation efflux system protein +FIG01353564 FIG00638065: hypothetical protein +FIG01353571 Methoxy mycolic acid synthase 1 MmaA1 (EC 2.1.1.-) +FIG01353572 Nonspecific lipid-transfer protein +FIG01353574 putative phage-related hypothetical protein +FIG01353576 COG1801: Uncharacterized conserved protein +FIG01353589 Parvulin-like peptidyl-prolyl isomerase, SurA +FIG01353591 FIG00633684: hypothetical protein +FIG01353599 hypothetical protein +FIG01353602 Possible cytochrome P450 family proteins +FIG01353609 Carbohydrate-selective porin +FIG01353614 FIG00403434: hypothetical protein +FIG01353622 Putative nitrite reductase +FIG01353636 Probable membrane efflux protein +FIG01353639 hypothetical protein +FIG01353643 [2Fe-2S]-binding domain protein +FIG01353658 FIG022199: FAD-binding protein +FIG01353659 Putative uncharacterized protein ycgI +FIG01353667 bacterial extracellular solute-binding proteins, family 3 +FIG01353679 Putative uncharacterized protein YhcG +FIG01353708 Hypothetical protein SAV2135 +FIG01353714 Ankyrin-like protein +FIG01353724 mutT2 [EC:3.6.1.-] +FIG01353725 Hydride transferase 1 (Fragment) +FIG01353726 FIG00409721: hypothetical protein +FIG01353735 FIG00351671: hypothetical protein +FIG01353736 Glutaredoxin and related proteins +FIG01353745 putative MFS metabolite transporter +FIG01353749 icsB product +FIG01353755 heat shock protein HtpG +FIG01353761 FIG00897538: hypothetical protein +FIG01353779 Siderophore/Surfactin synthetase related protein +FIG01353788 Hydrolases of the alpha/beta superfamily +FIG01353790 FIG00385282: hypothetical protein +FIG01353797 FIG01062440: hypothetical protein +FIG01353798 HrpJ +FIG01353802 may contain ATP/GTP binding motif +FIG01353804 yadS protein +FIG01353810 Ankyrin repeats containing protein +FIG01353817 FIG00836067: hypothetical protein +FIG01353827 FIG00415799: hypothetical protein +FIG01353834 Transcription-repair coupling factor (superfamily II helicase) +FIG01353837 METHYL ACCEPTING CHEMOTAXIS PROTEIN +FIG01353839 conserved protein of unknown function; putative membrane protein +FIG01353851 3-Hydroxyacyl-CoA dehydrogenase +FIG01353865 Major coat protein +FIG01353876 probable glycosyltransferase +FIG01353877 competence damage-inducible protein A +FIG01353892 FIG00350162: hypothetical protein +FIG01353900 FIG00410234: hypothetical protein +FIG01353922 FIG00643151: hypothetical protein +FIG01353936 Bacterial regulatory protein, LuxR family +FIG01353939 Predicted acetyltransferase +FIG01353961 ATP binding protein +FIG01353974 YajC +FIG01353975 MlpL-like protein +FIG01353979 FIG00629287: hypothetical protein +FIG01353994 hypothetical genomic island protein +FIG01353998 FIG00764321: hypothetical protein +FIG01354003 Cyanobacterial protein slr0575 +FIG01354016 FIG01017140: hypothetical protein +FIG01354017 phosphoheptose isomerase +FIG01354028 Cystathionine beta-lyase, Bsu PatB (EC 4.4.1.8) +FIG01354046 hypothetical protein +FIG01354055 Plasmid stabilization system toxin protein +FIG01354066 Tetracycline resistance element mobilization regulatory protein rteC +FIG01354105 putative cell surface protein +FIG01354126 probable LysR-type transcriptional regulator +FIG01354128 FIG00821228: hypothetical protein +FIG01354141 FIG00410804: hypothetical protein +FIG01354143 FIG00351042: hypothetical protein +FIG01354147 FIG00356779: hypothetical protein +FIG01354164 FIG00405366: hypothetical protein +FIG01354165 Microcin C7 self-immunity protein mccF +FIG01354184 phosphotransferase system, EIIB +FIG01354191 FIG00624445: hypothetical protein +FIG01354200 Recombinase-related protein +FIG01354205 FIG00350123: hypothetical protein +FIG01354207 Possible transmembrane regulator +FIG01354229 FIG01214622: hypothetical protein +FIG01354244 Hypothetical protein SAV1890 +FIG01354247 catabolite control protein A +FIG01354253 CAAX amino terminal protease family +FIG01354258 FIG00960950: hypothetical protein +FIG01354287 FIG00388462: hypothetical protein +FIG01354305 Restriction endonuclease R.XbaI +FIG01354306 putative transposase, fragment +FIG01354312 FIG00350047: hypothetical protein +FIG01354343 Cell wall hydrolase +FIG01354365 lipase family protein +FIG01354377 FIG00622879: hypothetical protein +FIG01354385 FIG00735085: hypothetical protein +FIG01354386 putative chaperone +FIG01354395 Phage infection protein +FIG01354398 PepR +FIG01354402 YoaT protein +FIG01354408 Adventurous gliding motility protein S +FIG01354420 FIG00526451: hypothetical protein +FIG01354430 Predicted transcriptional regulator containing an HTH domain and an uncharacterized domain shared with the mammalian protein Schlafen +FIG01354433 FIG00450780: hypothetical protein +FIG01354434 thiamine biosynthesis lipoprotein ApbE +FIG01354439 FIG00410283: hypothetical protein +FIG01354441 disulfide bond formation protein, DsbB family +FIG01354442 UPF0192 protein TM0984 precursor +FIG01354454 ROK family protein (putative glucokinase) +FIG01354464 FIG00525424: hypothetical protein +FIG01354478 Cytochrome b561 family +FIG01354479 Thiol:disulfide interchange protein dsbA precursor +FIG01354490 InterPro IPR000792:IPR001789 COGs COG2197 +FIG01354495 protein of unknown function DUF151 +FIG01354496 Histidine protein kinase +FIG01354500 spore peptidoglycan hydrolase (N-acetylglucosaminidase) +FIG01354503 FIG00353505: hypothetical protein +FIG01354508 Prokaryotic ATPase +FIG01354550 UPF0043 inner membrane protein YdjZ +FIG01354561 di- and tricarboxylate transporters +FIG01354563 FIG00405440: hypothetical protein +FIG01354571 PTS system, IIB component +FIG01354582 FIG01200908: hypothetical protein +FIG01354592 Putative uncharacterized protein BCG_3323c (Putative uncharacterized protein BCG_3359c) +FIG01354594 Predicted MDR-type permease +FIG01354595 MATE family drug transporter +FIG01354597 K+ channel, pore region +FIG01354599 pXO2-44 +FIG01354606 peptidase zinc-dependent +FIG01354608 probable lipoprotein YPO0352 +FIG01354610 FIG01202827: hypothetical protein +FIG01354627 Protein flxA +FIG01354628 putative transposase remnant +FIG01354638 Rhamnosyl transferase +FIG01354641 putative iron-sulfur protein +FIG01354648 sugar hydrolase +FIG01354653 FIG01233597: hypothetical protein +FIG01354654 Uncharacterized protein +FIG01354659 K88 minor fimbrial subunit faeJ precursor +FIG01354673 exported protein, conserved +FIG01354674 ribosomal protein S6 glutaminyl transferase related protein +FIG01354679 FIG00528559: hypothetical protein +FIG01354698 Carbohydrate kinase, PfkB family +FIG01354708 FIG00350611: hypothetical protein +FIG01354714 CT568 hypothetical protein +FIG01354723 TraE-like protein +FIG01354725 Superoxide dismutase( EC:1.15.1.1 ) +FIG01354726 Na+/Ca+ antiporter, CaCA family +FIG01354728 FIG00764146: hypothetical protein +FIG01354730 FIG00350008: hypothetical protein +FIG01354733 Transcriptional regulator ptxR +FIG01354738 ribosomal subunit interface protein, putative +FIG01354743 FIG00363613: hypothetical protein +FIG01354748 FIG01048331: hypothetical protein +FIG01354765 Fusobacterium membrane protein +FIG01354768 Uncharacterized protein ynaB +FIG01354774 5'-3' nuclease +FIG01354785 FIG01214573: hypothetical protein +FIG01354788 acyl-CoA thioesterase 1, truncated +FIG01354803 LysR family transcriptional regulator y2377 (Yersinia pestis KIM) +FIG01354815 FIG01047468: hypothetical protein +FIG01354827 Ulx +FIG01354829 FIG00525401: hypothetical protein +FIG01354832 protein of unknown function DUF1037 +FIG01354836 FIG01245217: hypothetical protein +FIG01354845 HAD-superfamily hydrolase-like protein +FIG01354859 Zinc metalloprotease zmpB precursor (EC 3.4.24.-) +FIG01354873 FIG00653255: hypothetical protein +FIG01354898 Putative phage baseplate component +FIG01354902 Immunity protein +FIG01354920 putative ABC-type phosphate transport system permease component +FIG01354921 proteophosphoglycan ppg1 +FIG01354926 FIG055916: Putative cytoplasmic protein +FIG01354936 Tll2454 protein +FIG01354948 Probable transposase for the insertion element IS2606 +FIG01354949 HAMP domain/GAF domain/HD domain protein +FIG01354953 FIG00355287: hypothetical protein +FIG01354959 FIG00630396: hypothetical protein +FIG01354961 InterPro IPR002525:IPR003346 COGs COG3547 +FIG01354966 fibronectin-binding protein +FIG01354973 Molecular chaperone, small heat shock protein +FIG01354996 TioA protein +FIG01355000 YceI family protein +FIG01355002 Tll2177 protein +FIG01355013 similar to gpB bacteriophage P2 +FIG01355022 FIG00350244: hypothetical protein +FIG01355028 M-like proptein Szp +FIG01355037 putative ATP/GTP-binding protein (mrp protein homolog) +FIG01355039 FIG01205601: hypothetical protein +FIG01355042 outer membrane protein CC2294 +FIG01355054 FIG00639757: hypothetical protein +FIG01355080 Superfamily I DNA/RNA helicase protein +FIG01355082 Similar to pyruvate kinase +FIG01355084 Transcriptional regulator PhaD +FIG01355086 Inclusion membrane protein-44 +FIG01355088 C4-dicarboxylate transport transcriptional regulatory protein +FIG01355113 Fumarate/succinate/L-aspartate dehydrogenases +FIG01355118 probable exported protein YPO2426 +FIG01355120 Nitrilase/cyanide hydratase and apolipoprotein N-acyltransferase +FIG01355123 FIG00832145: hypothetical protein +FIG01355161 FIG00949002: hypothetical protein +FIG01355162 FIG00361340: hypothetical protein +FIG01355165 Transmembrane component Dace_2068 of energizing module of predicted ECF transporter +FIG01355166 Phosphoesterase, DHH family protein +FIG01355171 Penicillin G acylase precursor (EC 3.5.1.11) +FIG01355186 NanA gene +FIG01355191 FIG00828279: hypothetical protein +FIG01355194 Putative outer membrane receptor +FIG01355199 hypothetical protein +FIG01355204 Asl4507 protein +FIG01355208 Prophage LambdaBa02, site-specific recombinase, phage integrase family +FIG01355211 RESOLVASE +FIG01355213 putative chemotaxis transducer +FIG01355218 Outer membrane protein +FIG01355229 ATP-dependent Lon protease bacterial type +FIG01355237 HesB-like domain +FIG01355246 Orf3 +FIG01355252 FIG00767753: hypothetical protein +FIG01355253 Lincomycin resistance protein lmrB +FIG01355260 Acetylornithine aminotransferase (EC 2.6.1.11) +FIG01355278 FIG00349990: hypothetical protein +FIG01355299 rhizopine catabolism protein mocA +FIG01355305 Probable sugar transporter +FIG01355317 probable phage-family integrase/recombinase protein +FIG01355354 Helix-hairpin-helix DNA-binding motif class 1 +FIG01355358 Probable phenylacetic acid degradation NADH oxidoreductase paaE (EC 1.-.-.-) +FIG01355360 FIG00388432: hypothetical protein +FIG01355371 PUTATIVE RHS-RELATED PROTEIN +FIG01355373 Heat shock protein HSP33 +FIG01355390 Bll1370 protein +FIG01355395 hydroxylaminobenzene mutase +FIG01355437 putative antitermination protein Q +FIG01355442 putative Metal-dependent phosphohydrolase +FIG01355444 FIG00644673: hypothetical protein +FIG01355455 Putative uncharacterized protein STY3208 (Putative uncharacterized protein) +FIG01355471 FIG00814748: hypothetical protein +FIG01355479 putative Spa29, component of the Mxi-Spa secretion machinery +FIG01355487 FIG00414091: hypothetical protein +FIG01355505 orf; Unknown function +FIG01355520 Chitinase C precursor (EC 3.2.1.14) +FIG01355530 Type II restriction enzyme HpaII (EC 3.1.21.4) +FIG01355534 FIG00756608: hypothetical protein +FIG01355538 ATP-dependent Zn proteases +FIG01355552 hypothetical protein +FIG01355567 FIG01211915: hypothetical protein +FIG01355588 FIG00767652: hypothetical protein +FIG01355589 Probable DNA repair exonuclease +FIG01355593 sigma 54 modulation protein, putative +FIG01355600 FIG01167247: hypothetical protein +FIG01355607 goadsporin biosynthetic protein +FIG01355609 GNAT family acetyltransferase VC2332 +FIG01355614 hypothetical protein +FIG01355630 syc2289_d +FIG01355632 FIG00405727: hypothetical protein +FIG01355638 FIG00746415: hypothetical protein +FIG01355643 Protein containing rhodanese-like domain +FIG01355645 Secretory antigen SsaA +FIG01355648 iron-dependent transcriptional repressor, putative +FIG01355649 FIG00767998: hypothetical protein +FIG01355661 FIG00389852: hypothetical protein +FIG01355663 Putative transcriptional regulator near PqsH +FIG01355673 Phage virion morphogenesis (putative tail completion) protein +FIG01355674 FIG015386: lipoprotein, putative +FIG01355679 phosphopantetheinyltransferase component of enterobactin synthase multienzyme complex +FIG01355682 protein kinase( EC:2.7.11.1 ) +FIG01355690 FAD monooxygenase, PheA/TfdB family +FIG01355697 Ankyrin repeat protein +FIG01355704 FIG00768221: hypothetical protein +FIG01355722 Transfer complex protein +FIG01355723 Hemolysin E, chromosomal +FIG01355734 putative dipeptide/oligopeptide/nickel ABC-type transport system periplasmic component +FIG01355742 Small, acid-soluble spore protein I (SASP I) +FIG01355746 FIG00403980: hypothetical protein +FIG01355757 FIG00350223: hypothetical protein +FIG01355759 FIG00427397: hypothetical protein +FIG01355764 FIG00848207: hypothetical protein +FIG01355773 FIG075279: Conserved domain protein +FIG01355785 Sphingomyelinase C precursor +FIG01355793 TRAP dicarboxylate transporter, DctP subunit +FIG01355801 conserved hypothetical ATPase +FIG01355807 FIG00514412: hypothetical protein +FIG01355827 aminopeptidase I (yscI) +FIG01355832 Hypothetical protein Rv3612c, component of Type VII secretion system ESX-1 +FIG01355835 hypothetical protein +FIG01355841 Possible Helix-turn-helix domain of resolvase +FIG01355854 hypothetical protein +FIG01355855 NADH-ubiquinone oxidoreductase +FIG01355857 stress responsive A/B Barrel Domain superfamily protein +FIG01355858 Efa1-Lymphostatin-like protein +FIG01355866 FIG00344384: hypothetical protein +FIG01355871 putative transcriptional regulator, PaaX family +FIG01355872 FIG00387907: hypothetical protein +FIG01355873 Oxidoreductase protein homolog Oxi +FIG01355876 FIG01202122: hypothetical protein +FIG01355883 putative transmembrane sensor +FIG01355890 Tricorn protease homolog (EC 3.4.21.-) +FIG01355900 predicted transposase +FIG01355910 FIG00425157: hypothetical protein +FIG01355915 FIG00413168: hypothetical protein +FIG01355917 FIG00351591: hypothetical protein +FIG01355921 Transposase OrfAB, subunit B +FIG01355924 Histidine kinase +FIG01355937 Possible sulfatase +FIG01355942 PUTATIVE TRANSPOSASE (FRAGMENT) +FIG01355957 Putative ATP-dependent RNA helicase +FIG01355958 putative phage repressor protein, putative phage associated protein +FIG01355965 Putative outer membrane fimbrial usher porin precursor +FIG01355966 FIG00758437: hypothetical protein +FIG01355970 hypothetical protein +FIG01355983 Sarcosine oxidase (EC 1.5.3.1) +FIG01355984 Acyl-CoA dehydrogenase (EC 1.3.8.7) +FIG01356001 N-acetylmuramoyl alanine amidase +FIG01356017 FIG00688056: hypothetical protein +FIG01356038 FIG00533656: hypothetical protein +FIG01356043 rare lipoprotein A precursor +FIG01356091 Membrane glycoprotein +FIG01356109 Arabinose-proton symporter +FIG01356132 FIG00765555: hypothetical protein +FIG01356175 Putative osmotically inducible protein Y +FIG01356183 FIG00914433: hypothetical protein +FIG01356207 FIG00411102: hypothetical protein +FIG01356210 Cellulose synthase catalytic subunit (EC 2.4.1.12) +FIG01356213 Multidrug resistance protein B +FIG01356215 FIG00406689: hypothetical protein +FIG01356222 Sodium/proline symporter +FIG01356231 FIG01120484: hypothetical protein +FIG01356234 predicted fimbrial-like adhesin protein +FIG01356245 B. burgdorferi predicted coding region BB0321 +FIG01356251 ABC transport protein, inner membrane component +FIG01356252 NAD(P)H dehydrogenase (Quinone), putative( EC:1.6.5.2 ) +FIG01356262 FIG00767071: hypothetical protein +FIG01356267 FIG00072885: hypothetical protein +FIG01356284 sugar-phosphate nucleotidyl transferase, putative +FIG01356285 FIG00768169: hypothetical protein +FIG01356307 putative glucosyl transferase +FIG01356310 glycerol-3-phosphate O-acyltransferase, putative +FIG01356316 Enoyl-CoA hydratase +FIG01356318 Membrane protein LAPB +FIG01356320 polyketide synthase +FIG01356323 Type III secretion transcriptional regulator HilC (= SirC) +FIG01356329 FIG00897857: hypothetical protein +FIG01356351 probable periplasmic protein Cj0413 , putative +FIG01356366 CrcB protein +FIG01356383 FIG00876401: hypothetical protein +FIG01356423 hypothetical protein SC2E1.07 +FIG01356426 FIG00763613: hypothetical protein +FIG01356462 antigen, putative +FIG01356466 MazF8 antibacterial toxin protein +FIG01356468 DNA primase/helicase +FIG01356472 FIG00385695: hypothetical protein +FIG01356474 FIG00412066: hypothetical protein +FIG01356476 excisionase, putative +FIG01356479 FIG01115931: hypothetical protein +FIG01356494 FIG00352115: hypothetical protein +FIG01356500 YD repeat +FIG01356501 FIG01219694: hypothetical protein +FIG01356506 CT566 hypothetical protein +FIG01356520 PROBABLE DEHYDROGENASE +FIG01356521 FIG00640804: hypothetical protein +FIG01356523 FIG01199663: hypothetical protein +FIG01356530 FIG00352276: hypothetical protein +FIG01356534 Mannosyltransferase WbkA +FIG01356554 Putative phage transposase +FIG01356559 FIG00765940: hypothetical protein +FIG01356575 protein of unknown function DUF177 +FIG01356578 FIG00768258: hypothetical protein +FIG01356580 FIG00816356: hypothetical protein +FIG01356583 Phosphodiesterase/alkaline phosphatase D +FIG01356586 Putative inner membrane protein (Fragment) +FIG01356594 FIG00641747: hypothetical protein +FIG01356599 hypothetical protein +FIG01356603 Protein of unknown function DUF1212 +FIG01356605 SULFUR TRANSFERASE PRECURSOR +FIG01356606 FIG00350877: hypothetical protein +FIG01356613 Transcriptional activator protein ahyR/asaR +FIG01356614 FIG00820387: hypothetical protein +FIG01356619 FIG00528633: hypothetical protein +FIG01356629 GnsB protein +FIG01356632 HTH-type transcriptional regulator QacR +FIG01356634 FIG00414732: hypothetical protein +FIG01356642 Putative cytochrome C +FIG01356645 FIG01125135: hypothetical protein +FIG01356671 FIG00514355: hypothetical protein +FIG01356691 hypothetical protein +FIG01356695 Bll6313 protein +FIG01356708 FIG00640576: hypothetical protein +FIG01356719 Paramyx_RNA_pol, Paramyxovirus RNA dependent RNA polymerase +FIG01356727 Nucleotidyltransferase (EC 2.7.7.-) +FIG01356733 Inclusion membrane protein-45 +FIG01356740 Ribbon-helix-helix protein, copG family domain protein +FIG01356751 peptidase S9 prolyl oligopeptidase active site domain protein +FIG01356763 antigen, p83/100 +FIG01356765 FIG00362239: hypothetical protein +FIG01356775 FIG00385100: hypothetical protein +FIG01356777 protein of unknown function DUF1467 +FIG01356794 Aspartyl/Asparaginyl beta-hydroxylase +FIG01356811 FIG00826778: hypothetical protein +FIG01356822 Chondroitinase AC precursor (EC 4.2.2.5) +FIG01356823 D-alanine-D-alanine ligase +FIG01356845 DegP protease +FIG01356866 FIG00364623: hypothetical protein +FIG01356868 PTS system, glucose-specific IIABC component (EC 2.7.1.69) +FIG01356879 putative invertase protein (partial) +FIG01356883 FIG01120689: hypothetical protein +FIG01356888 SifA protein +FIG01356891 FIG01237672: hypothetical protein +FIG01356899 Guanylate kinase (P-loop type) +FIG01356901 FIG00748586: hypothetical protein +FIG01356910 Recombination directionality factor, SLP1 family +FIG01356919 FIG00385639: hypothetical protein +FIG01356925 FIG01060984: hypothetical protein +FIG01356933 FIG00713248: hypothetical protein +FIG01356939 FIG00895281: hypothetical protein +FIG01356967 Putative oxalate:formate antiporter +FIG01356983 hemolysin C +FIG01357008 FIG00822109: hypothetical protein +FIG01357013 FIG00764519: hypothetical protein +FIG01357014 FIG01032573: hypothetical protein +FIG01357027 FIG00350940: hypothetical protein +FIG01357040 reverse transcriptase +FIG01357050 diacylglycerol kinase, catalytic region +FIG01357054 FIG00351361: hypothetical protein +FIG01357055 RDD +FIG01357074 syc1645_c +FIG01357079 acetyl-CoA hydrolase/transferase family protein +FIG01357083 FIG00747541: hypothetical protein +FIG01357084 Single-stranded DNA-binding protein 2 (SSB 2) (Helix-destabilizing protein 2) +FIG01357085 prophage pi2 protein 40 +FIG01357097 transferase, hexapeptide repeat family +FIG01357100 Major intracellular serine protease precursor (EC 3.4.21.-) +FIG01357101 FIG00767889: hypothetical protein +FIG01357111 FIG00424864: hypothetical protein +FIG01357112 Uncharacterized protein MJ0664 +FIG01357136 Predicted phosphoserine phosphatase (EC 3.1.3.3) +FIG01357137 hypothetical phage like protein +FIG01357138 FIG046480: Hypothetical protein +FIG01357141 hypothetical protein +FIG01357144 Plasmid stability protein stbB +FIG01357149 Sortase +FIG01357153 YtcJ-like metal-dependent amidohydrolase +FIG01357178 FIG00938305: hypothetical protein +FIG01357181 NADPH-dependent glutamate synthase (small subunit)( EC:1.4.1.13 ) +FIG01357185 Uncharacterized protein MJ1313 +FIG01357186 inosine-5'-monophosphate dehydrogenase +FIG01357189 FIG00385099: hypothetical protein +FIG01357193 FIG00765734: hypothetical protein +FIG01357199 Acetyltransferase, GNAT family, potentially associated with YqeK +FIG01357205 Zinc resistance-associated protein precursor +FIG01357208 Macrolide-efflux protein +FIG01357226 periplasmic binding protein and sugar binding domain of the LacI family protein +FIG01357229 FIG00410822: hypothetical protein +FIG01357245 photosystem I reaction center subunit IX +FIG01357257 FIG00380283: hypothetical protein +FIG01357263 FIG00530265: hypothetical protein +FIG01357268 D-2-hydroxyglutarate dehydrogenase (EC 1.1.99.2) +FIG01357297 FIG00409920: hypothetical protein +FIG01357329 Amidohydrolase amhX (EC 3.5.1.-) +FIG01357331 RsbR, positive regulator of sigma-B / RsbS, negative regulator of sigma-B +FIG01357337 FIG00643112: hypothetical protein +FIG01357345 carboxypeptidase G2( EC:3.4.17.11 ) +FIG01357350 Phage prohead protease, HK97 family +FIG01357374 FIG00416327: hypothetical protein +FIG01357381 putative universal stress protein +FIG01357399 FIG00518219: hypothetical protein +FIG01357404 Uncharacterized protein MJ0440 +FIG01357406 Capsular polysaccharide synthesis enzyme CpsJ, membrane protein, export of O-antigen and teichoic acid +FIG01357447 LysR family regulatory protein +FIG01357459 Transcriptional regulator of mycobacterial operons of survival, MosR +FIG01357464 Glycosyltransferase, putative +FIG01357475 truncated transposase +FIG01357477 FIG00624231: hypothetical protein +FIG01357479 polysaccharide deacetylase family protein +FIG01357501 FIG00831380: hypothetical protein +FIG01357523 SECRETED PROTEIN ANTIGEN +FIG01357546 conserved hypothetical protein; possible outer membrane protein +FIG01357562 Nitrate reductase [NADH] (EC 1.7.1.1) +FIG01357576 ferric siderophore ABC transporter, ATP-binding protein +FIG01357577 Thiolase +FIG01357583 FIG00641633: hypothetical protein +FIG01357586 Amino acid permease +FIG01357596 FIG00897756: hypothetical protein +FIG01357600 FIG01117754: hypothetical protein +FIG01357602 possible hydride transferase +FIG01357604 hypothetical protein +FIG01357616 FIG00348520: hypothetical protein +FIG01357624 Virulence regulator +FIG01357632 Putative isochorismatase-related protein +FIG01357638 FIG00672227: hypothetical protein +FIG01357642 Predicted phosphatase +FIG01357643 FIG01201994: hypothetical protein +FIG01357650 Protein fixU homolog +FIG01357678 2-phosphoglycerate kinase (EC 2.7.2.-) (2PGK) +FIG01357679 Pyrimidine deaminase +FIG01357689 Coenzyme PQQ synthesis protein F +FIG01357694 Carboxylesterase A (EC 3.1.1.-) +FIG01357701 blasticidin S deaminase, putative +FIG01357707 FIG01008102: hypothetical protein +FIG01357710 Spore protein YkvP +FIG01357717 Malonate permease +FIG01357719 FIG01233644: hypothetical protein +FIG01357720 ABC transporter permease component +FIG01357737 MoaF protein precursor +FIG01357750 FIG01084850: hypothetical protein +FIG01357767 FIG00353670: hypothetical protein +FIG01357774 FIG01162354: hypothetical protein +FIG01357775 Structural protein +FIG01357783 COG3316: Transposase and inactivated derivatives +FIG01357812 Transglutaminase-like domain protein +FIG01357822 putative flavodoxin +FIG01357837 helix-turn-helix protein +FIG01357840 FIG00350121: hypothetical protein +FIG01357849 Transcriptional regulator, MarR family / GCN5-related N-acetyltransferase +FIG01357851 FIG00762705: hypothetical protein +FIG01357876 Response regulator DrrA +FIG01357888 FIG01017650: hypothetical protein +FIG01357902 FIG00769497: hypothetical protein +FIG01357908 FIG00846963: hypothetical protein +FIG01357915 FIG00898950: hypothetical protein +FIG01357933 All1151 protein +FIG01357939 Predicted ATPase +FIG01357940 ORF_ID:alr7649 unknown protein +FIG01357941 PROBABLE MEMBRANE GLYCINE AND PROLINE RICH PROTEIN +FIG01357952 Penicillin-binding protein 4* +FIG01357955 DNA-binding response regulator +FIG01357963 putative phosphomannomutase +FIG01357977 FOG: HEAT repeat +FIG01357983 FIG00628093: hypothetical protein +FIG01357985 DGPF domain protein +FIG01358000 FIG00638024: Transposase ECs5301 +FIG01358002 Formate/nitrite family of transporters +FIG01358007 FIG00451221: hypothetical protein +FIG01358010 FIG00627446: hypothetical protein +FIG01358020 Chaperonin GroEL (HSP60 family) +FIG01358029 Putative sugar ABC transporter +FIG01358033 Putative acidic periplasmic protein +FIG01358050 FIG00403746: hypothetical protein +FIG01358051 IncP-type DNA transfer protein TraN +FIG01358052 FIG00828285: hypothetical protein +FIG01358058 RNA polymerase sigma-70 factor( EC:2.7.7.6 ) +FIG01358070 hypothetical protein +FIG01358087 protein of unknown function DUF881 +FIG01358088 FIG00350226: hypothetical protein +FIG01358107 LonB like ATP-ase no protease domain +FIG01358120 FIG00404151: hypothetical protein +FIG01358125 FIG00413957: hypothetical protein +FIG01358145 Outer membrane protein TolC +FIG01358171 FIG00822167: hypothetical protein +FIG01358172 uncharacterized protein probably involved in trehalose biosynthesis +FIG01358179 FIG01234697: hypothetical protein +FIG01358207 oxidoreductase, 2OG-Fe(II) oxygenase family +FIG01358209 FIG00645039: hypothetical protein +FIG01358212 porin outer membrane protein +FIG01358214 Similar to DicA, regulator of DicB encoded by prophage CP-933O +FIG01358230 Aminoglycoside phosphotransferase +FIG01358232 Possible trypsin protease +FIG01358235 hypothetical protein +FIG01358239 FIG00408180: hypothetical protein +FIG01358241 Peptidase family M23/M37 +FIG01358245 Thioredoxin domain protein, DsbA family +FIG01358252 L-fucose dehydrogenase +FIG01358256 IS256 family transposase +FIG01358277 Antitoxin of toxin-antitoxin (TA) system Phd +FIG01358302 FIG00352151: hypothetical protein +FIG01358303 FIG00654195: hypothetical protein +FIG01358306 FIG00624302: hypothetical protein +FIG01358309 Cytochrome C6 +FIG01358334 putative tautomerase +FIG01358338 ABC-type sugar transport systems, ATPase components +FIG01358340 Putative glycosyl transferase +FIG01358343 Motility gene repressor MogR +FIG01358352 putative Integral membrane protein +FIG01358359 Cytochrome P450 143 +FIG01358362 FIG00406183: hypothetical protein +FIG01358363 FIG00623875: hypothetical protein +FIG01358366 FIG01231524: hypothetical protein +FIG01358369 ABC transporter, periplasmic solute-binding protein +FIG01358375 FIG01170474: hypothetical protein +FIG01358387 FIG00424126: hypothetical protein +FIG01358388 conserved hypotheical protein +FIG01358392 FIG00424439: hypothetical protein +FIG01358393 transcriptional regulator (LysR family) +FIG01358406 FIG00350262: hypothetical protein +FIG01358417 aminoglycoside phophotransferase-related protein +FIG01358420 FIG00350803: hypothetical protein +FIG01358421 FIG00350288: hypothetical protein +FIG01358437 alkanal monooxygenase alpha chain +FIG01358440 COG2764: Uncharacterized protein conserved in bacteria +FIG01358443 FIG00875352: hypothetical protein +FIG01358475 OmpA/MotB +FIG01358478 FIG00836460: hypothetical protein +FIG01358481 solute binding protein of ABC transporter system +FIG01358487 FIG00763364: hypothetical protein +FIG01358520 MEMBRANE NUCLEASE, LIPOPROTEIN +FIG01358521 putative glucosamine-fructose-6-phosphate aminotransferase +FIG01358532 FIG00351079: hypothetical protein +FIG01358553 FIG00734184: hypothetical protein +FIG01358567 FIG00414094: hypothetical protein +FIG01358571 putative ATPase TraE +FIG01358573 FIG01245703: hypothetical protein +FIG01358600 Mlr4090 protein +FIG01358603 FIG00402888: hypothetical protein +FIG01358622 FIG00624856: hypothetical protein +FIG01358624 type IIS restriction enzyme M1 protein (mod) +FIG01358645 LysR family transcriptional regulator YgfI +FIG01358647 FIG00424065: hypothetical protein +FIG01358651 hypothetical protein +FIG01358655 COG0343: Queuine/archaeosine tRNA-ribosyltransferase +FIG01358673 FIG01229679: hypothetical protein +FIG01358683 hypothetical phage protein +FIG01358689 FIG00846823: hypothetical protein +FIG01358704 pXO1-99 +FIG01358710 Xylanase precursor (EC 3.2.1.8) +FIG01358726 Rieske (2Fe-2S) domain-containing protein +FIG01358766 Probable dipeptidase B (EC 3.4.-.-) +FIG01358804 prophage ps3 protein 07 +FIG01358806 FIG01246169: hypothetical protein +FIG01358810 FIG00406930: hypothetical protein +FIG01358839 FIG00351309: hypothetical protein +FIG01358846 FIG01243967: hypothetical protein +FIG01358856 Membrane associated zinc metalloprotease (EC 3.4.24.-) +FIG01358861 Cobalt(II) binding transcription repressor, nmtR +FIG01358864 FIG01152123: hypothetical protein +FIG01358865 FIG00713463: hypothetical protein +FIG01358884 FIG01201244: hypothetical protein +FIG01358894 FIG00412633: hypothetical protein +FIG01358916 FIG00825015: hypothetical protein +FIG01358939 alkaline phosphatase +FIG01358944 FIG00424669: hypothetical protein +FIG01358951 FIG00412493: hypothetical protein +FIG01358959 Lignostilbene-alpha,beta-dioxygenase and related enzymes +FIG01358968 FIG00768184: hypothetical protein +FIG01358973 FIG00748642: hypothetical protein +FIG01358974 FIG00824777: hypothetical protein +FIG01358979 FIG00350065: hypothetical protein +FIG01358981 FIG01046577: hypothetical protein +FIG01358988 hypothetical protein +FIG01358999 cytochrome c +FIG01359004 FtsK/SpoIIIE family +FIG01359006 predicted Zn-dependent hydrolase of the beta-lactamase fold +FIG01359026 FIG00404843: hypothetical protein +FIG01359038 ABC-TYPE TRANSPORTER, ATPASE COMPONENT +FIG01359043 other or unknown (Phage or Prophage Related) +FIG01359062 FIG00412714: hypothetical protein +FIG01359083 FIG00897313: hypothetical protein +FIG01359086 Putative Esat-6 like protein +FIG01359091 putative acetyl-CoA synthetase +FIG01359095 FIG00403458: hypothetical protein +FIG01359097 tRNA (5-methylaminomethyl-2-thiouridylate)-methyltransferase (EC 2.1.1.61) / FAD-dependent cmnm(5)s(2)U34 oxidoreductase +FIG01359108 FIG00630182: hypothetical protein +FIG01359114 Beta-xylosidase +FIG01359132 Integrase +FIG01359142 Bsr1382 protein +FIG01359160 Probable oxidoreductase (EC 1.-.-.-) +FIG01359189 Uncharacterized protein MJ1020 +FIG01359191 Plastocyanin +FIG01359210 L-sorbosone dehydrogenase (EC 1.1.1.-) (SNDH) +FIG01359211 Mlr5572 protein +FIG01359226 putative ALPHA(1,2)FUCOSYLTRANSFERASE +FIG01359232 iron donor protein CyaY +FIG01359233 CsuA +FIG01359235 FIG00384916: hypothetical protein +FIG01359242 FIG00424417: hypothetical protein +FIG01359265 FIG00353188: hypothetical protein +FIG01359272 FIG00351609: hypothetical protein +FIG01359281 Enterotoxin +FIG01359300 hypothetical protein +FIG01359303 FIG00821490: hypothetical protein +FIG01359308 mrr restriction endonuclease +FIG01359331 Putative invasin precursor +FIG01359338 Acetylornithine deacetylase, putative +FIG01359364 FIG00769611: hypothetical protein +FIG01359366 FIG00624723: hypothetical protein +FIG01359376 Phosphosugar-binding transcriptional regulator +FIG01359377 Hypothetical; Conserved within genome +FIG01359386 TPR-domain containing protein +FIG01359395 putative plasmid maintenance system antidote-like protein +FIG01359402 Proton/sodium-glutamate symport protein +FIG01359425 FIG00531693: hypothetical protein +FIG01359428 corresponds to STY1594 from Accession AL513382: Salmonella typhi CT18 +FIG01359429 FIG00765578: hypothetical protein +FIG01359446 ISSoc5, transposase +FIG01359447 CT702 hypothetical protein +FIG01359449 peptidase, M28A family( EC:3.4.- ) +FIG01359450 Molybdopterin-guanine dinucleotide biosynthesis protein B +FIG01359462 Acetyltransferase GNAT family +FIG01359468 FIG00351726: hypothetical protein +FIG01359478 conserved hypothetical protein, fusion +FIG01359483 FIG01136125: hypothetical protein +FIG01359487 Virulence-associated protein D +FIG01359496 Uroporphyrinogen-III decarboxylase +FIG01359499 FIG00409639: hypothetical protein +FIG01359524 Sugar efflux transporter A +FIG01359526 Predicted protein family PM-26 +FIG01359537 FIG01203799: hypothetical protein +FIG01359544 putative type II methylase protein +FIG01359546 TonB protein +FIG01359553 Uncharacterized protein MJ1409 +FIG01359563 FIG01093326: hypothetical protein +FIG01359586 FIG00262634: hypothetical protein +FIG01359618 Aminobutyraldehyde dehydrogenase (EC 1.2.1.19) +FIG01359629 Mature parasite-infected erythrocyte surface antigen (MESA) or PfEMP2 +FIG01359630 Sensor histidine kinase involved in nitrogen fixation and metabolism regulation +FIG01359639 FIG00751322: hypothetical protein +FIG01359642 putative peptidoglycan bound protein +FIG01359643 FIG00407820: hypothetical protein +FIG01359646 Methyl-accepting chemotaxis protein +FIG01359650 Hydrolase, alpha/beta fold family +FIG01359652 putative transporter substrate-binding protein +FIG01359663 Putative transcription regulator +FIG01359666 ISSod3, transposase +FIG01359667 FIG00767368: hypothetical protein +FIG01359685 Calcium-transporting ATPase (EC 3.6.3.8) +FIG01359704 FIG00351070: hypothetical protein +FIG01359721 membrane protein, YbiE/YbiF family +FIG01359724 FIG00767509: hypothetical protein +FIG01359725 HAD superfamily hydrolase +FIG01359745 FIG00388254: hypothetical protein +FIG01359746 hypothetical protein +FIG01359749 FIG01114102: hypothetical protein +FIG01359753 variable surface protein mvspN +FIG01359762 DAK2 domain protein +FIG01359768 FIG00451168: hypothetical protein +FIG01359771 FIG00624413: hypothetical protein +FIG01359777 Holliday junction resolvase +FIG01359778 FIG00364203: hypothetical protein +FIG01359811 transposase, IS605/IS200 family +FIG01359813 possible prophage ps3 protein01-like protein +FIG01359824 putative succinoglycan biosynthesis protein +FIG01359828 probable haloacid dehalogenase-like hydrolase +FIG01359833 putative fimbrial subunit PilA +FIG01359841 FIG00351498: hypothetical protein +FIG01359843 lipoprotein LpqQ +FIG01359862 FIG00468504: hypothetical protein +FIG01359873 FIG00820129: hypothetical protein +FIG01359874 Cox +FIG01359876 putative polymerase +FIG01359879 Cytochrome c-type protein +FIG01359880 FIG00614596: hypothetical protein +FIG01359888 2,3-PDG dependent phosphoglycerate mutase( EC:5.4.2.1 ) +FIG01359890 Kelch domain protein +FIG01359902 FIG00351028: hypothetical protein +FIG01359903 phospholipid biosynthesis +FIG01359908 FIG00897230: hypothetical protein +FIG01359913 FIG00425672: hypothetical protein +FIG01359916 ABC-type Fe3+ transport system, permease component +FIG01359917 NAD kinase (EC 2.7.1.23) +FIG01359934 cell wall lytic activity +FIG01359942 hypothetical protein +FIG01359953 PAS modulated sigma54 specific transcriptional regulator, Fis family +FIG01359967 FIG00629260: hypothetical protein +FIG01359972 Probable acylaminoacyl-peptidase (EC 3.4.19.1) +FIG01359990 Biotin synthase (BioB) (EC 2.8.1.6) +FIG01359997 FIG00688369: hypothetical protein +FIG01360001 similar to Micrococcus luteus uvrB gene product encoded by Swiss-Prot Accession Number P10125 +FIG01360005 putative ABC-transporter +FIG01360006 probable transposase +FIG01360008 Transcriptional regulator, LysR family, homolog 8 +FIG01360009 Plasmid pIB6 ORFA DNA +FIG01360025 Putative beta-lactamase +FIG01360047 CoA-binding domain protein +FIG01360052 Sensory histidine protein kinase +FIG01360070 oxidoreductase, FAD/iron-sulfur cluster-binding domain protein +FIG01360083 RidA/YER057c/UK114 superfamily, group 7, YjgH-like protein +FIG01360105 FIG00696052: hypothetical protein +FIG01360123 putative integral membrane protein; possible branched-chain amino acid permease +FIG01360127 transposase homolog for IS232 [Insertion sequence IS1181] +FIG01360129 Putative cytochrome P450 135B1 (EC 1.14.-.-) +FIG01360150 ISSod6 transposase, IS1301 +FIG01360153 Truncated hemoglobins +FIG01360160 Beta-lactamase superfamily protein +FIG01360177 putative secreted cellulose-binding protein +FIG01360182 FIG00414669: hypothetical protein +FIG01360183 FIG00640651: hypothetical protein +FIG01360184 integrase/recombinase (xerD) +FIG01360196 FIG01202027: hypothetical protein +FIG01360203 Putative starvation-inducible protein +FIG01360205 sterol desaturase-like protein +FIG01360211 ABC family transporter +FIG01360212 Middle operon regulator +FIG01360228 FIG00820632: hypothetical protein +FIG01360243 FIG00765038: hypothetical protein +FIG01360251 FIG00349961: hypothetical protein +FIG01360267 Putative protein; Putative regulatory protein +FIG01360283 FIG00413049: hypothetical protein +FIG01360285 ADP-heptose:LPS heptosyltransferase II +FIG01360298 Ccm2-related protein +FIG01360303 FIG00769742: hypothetical protein +FIG01360305 putative Rif11 homolog +FIG01360306 FIG00659800: hypothetical protein +FIG01360312 PTS system, IIa component +FIG01360314 FIG01255190: hypothetical protein +FIG01360320 FIG00355771: hypothetical protein +FIG01360321 Acetyl-CoA hydrolase +FIG01360334 putative lipopolysaccharide biosynthesis protein +FIG01360335 Aromatic amino acid ammonia-lyase family +FIG01360365 Probable fusion protein +FIG01360367 heparin lyase I precursor( EC:4.2.2.7 ) +FIG01360370 FIG00402685: hypothetical protein +FIG01360371 FIG00426950: hypothetical protein +FIG01360382 FIG00416521: hypothetical protein +FIG01360383 Zn-dependent aminopeptidase +FIG01360387 Predicted glycosyltransferase involved in capsule biosynthesis +FIG01360390 Putative ATP-binding component of a transport system +FIG01360396 FIG00895171: hypothetical protein +FIG01360418 FIG00628135: hypothetical protein +FIG01360424 Bacteriocin BlpU +FIG01360427 FIG086910: Hypothetical protein +FIG01360437 FIG00351490: hypothetical protein +FIG01360438 Putative type III secretion apparatus +FIG01360455 Aliphatic amidase AmiE (EC 3.5.1.4) +FIG01360461 N-acyl-L-homoserine lactone synthetase LasI +FIG01360471 FIG00352302: hypothetical protein +FIG01360501 Similar to Glutamate--cysteine ligase (EC 6.3.2.2) +FIG01360507 FIG00513670: hypothetical protein +FIG01360508 stage II sporulation protein E +FIG01360509 FIG00469035: hypothetical protein +FIG01360524 Peptide chain release factor 1 (eRF1) +FIG01360532 Membrane carboxypeptidase (penicillin-binding protein) +FIG01360535 SULFUR DEPRIVATION RESPONSE REGULATOR +FIG01360551 secreted effector protein +FIG01360555 putative phage-related membrane protein +FIG01360558 FIG00351316: hypothetical protein +FIG01360560 Sel1 domain protein repeat-containing protein precursor +FIG01360563 Hypothetical protein Cj1162c +FIG01360565 outer membrane porin +FIG01360570 FIG00666098: hypothetical protein +FIG01360579 FIG00405798: hypothetical protein +FIG01360581 FIG00385611: hypothetical protein +FIG01360586 Quinone-dependent oxidoreductase domain / Putative aminomethyl transferase domain +FIG01360598 FIG01246612: hypothetical protein +FIG01360618 Phospholipase/carboxylesterase +FIG01360621 YD repeat protein +FIG01360630 Signal transduction response regulator +FIG01360634 Prolyl oligopeptidase family protein (EC 3.4.21.26) +FIG01360635 Lysozyme-related protein +FIG01360645 FIG00643583: hypothetical protein +FIG01360652 serotype 3 fimbrial subunit precursor +FIG01360678 outer surface protein A (ospA) +FIG01360694 putative protein-S-isoprenylcysteine methyltransferase-like protein +FIG01360696 Phage replicative DNA helicase, repA +FIG01360698 FIG00764332: hypothetical protein +FIG01360700 FIG00870999: hypothetical protein +FIG01360702 unknown (contains ferredoxin domain) +FIG01360707 ATPase, AAA family +FIG01360709 FIG00350693: hypothetical protein +FIG01360721 FIG00710152: hypothetical protein +FIG01360726 FOG: WD40 repeat +FIG01360750 methyltransferase, probable +FIG01360752 CdsK +FIG01360766 FIG00640055: hypothetical protein +FIG01360777 FIG00766735: hypothetical protein +FIG01360780 Novel Xylose regulator from LacI family +FIG01360787 hypothetical protein +FIG01360788 putative peptide signal +FIG01360789 POSSIBLE METHYLTRANSFERASE/METHYLASE (FRAGMENT) +FIG01360796 FIG01048051: hypothetical protein +FIG01360799 FIG00803801: hypothetical protein +FIG01360834 Histidinol-phosphatase [alternative form] (EC 3.1.3.15) +FIG01360838 FIG00763284: hypothetical protein +FIG01360853 Secretion system effector SseG +FIG01360856 FIG00388340: hypothetical protein +FIG01360879 FIG01249607: hypothetical protein +FIG01360881 Diaminopimelate decarboxylase +FIG01360882 hypothetical protein; putative membrane protein +FIG01360883 FIG00414427: hypothetical protein +FIG01360890 cag pathogenicity island protein (cag12) +FIG01360903 putative membrane associated hydrolase +FIG01360931 FIG00533740: hypothetical protein +FIG01360938 FIG00641234: hypothetical protein +FIG01360947 putative lioprotein +FIG01360952 putative cell wall hydrolase +FIG01361016 (S)-2-haloacid dehalogenase I (EC 3.8.1.2) +FIG01361039 non-ribosomal peptide synthetase +FIG01361043 Enoyl-[acyl-carrier-protein] reductase [FMN] (EC 1.3.1.9) +FIG01361064 GpE+E' [Enterobacteria phage P2] gb|AAD03292.1| (AF063097) g +FIG01361066 Homoserine/homoserine lactone/threonine efflux protein precursor +FIG01361078 Prophage Lp2 protein 6 +FIG01361111 FIG00822332: hypothetical protein +FIG01361118 ATP binding component of ABC-transporter +FIG01361134 Orf12 +FIG01361135 FIG00769993: hypothetical protein +FIG01361150 LmaC, associated with virulence in Listeria +FIG01361151 FIG018983: hypothetical protein +FIG01361181 FIG00623266: hypothetical protein +FIG01361212 31 kDa outer-membrane immunogenic protein precursor +FIG01361215 macrolide 2-phosphotransferase, putative +FIG01361224 hypothetical protein +FIG01361232 helicase, Snf2 family +FIG01361234 Putative periplasmic ATP/GTP-binding protein +FIG01361236 SAP domain protein +FIG01361243 hypothetical peptidase +FIG01361251 Carboxyl-terminal protease +FIG01361276 Dihydroxyacid dehydratase/phosphogluconate dehydratase +FIG01361278 Protease-related protein +FIG01361295 FIG00426778: hypothetical protein +FIG01361304 possible prolidase (X-Pro dipeptidase) or chlorohydrolase +FIG01361307 FIG00351171: hypothetical protein +FIG01361308 two-component system sensor histidine kinase +FIG01361312 FIG00602470: hypothetical protein +FIG01361325 FIG00754192: hypothetical protein +FIG01361358 Two component system histidine kinase (EC 2.7.3.-) +FIG01361361 hypothetical protein +FIG01361367 mannose-6-phosphate isomerase, class I +FIG01361394 Dicarboxylate/amino acid:cation (Na+ or H+) symporter +FIG01361403 FIG00407680: hypothetical protein +FIG01361406 100aa long hypothetical protein +FIG01361408 TVG1202803 protein +FIG01361421 FIG00658318: hypothetical protein +FIG01361428 Serine type site-specific recombinase +FIG01361431 Ferrous iron transport permease EfeU +FIG01361438 FIG00848099: hypothetical protein +FIG01361484 Methylcobamide:CoM methyltransferase MtbA +FIG01361488 Non-specific DNA-binding protein HBsu +FIG01361501 FAD-linked oxidoreductase family +FIG01361504 zeta toxin +FIG01361523 FIG00350267: hypothetical protein +FIG01361525 Predicted oxidoreductases (related to aryl-alcohol dehydrogenases) +FIG01361526 Formamidopyrimidine-DNA glycolase +FIG01361529 FIG00424097: hypothetical protein +FIG01361540 SSU rRNA (adenine(1518)-N(6)/adenine(1519)-N(6))-dimethyltransferase (EC 2.1.1.182) +FIG01361544 Phenylacetate-CoA oxygenase, PaaH2 subunit +FIG01361546 nucleoside 2-deoxyribosyltransferase superfamily +FIG01361548 FIG01049513: hypothetical protein +FIG01361567 Phosphodiesterase/alkaline phosphatase D-like protein +FIG01361579 PUTATIVE BACTERIOPHAGE-RELATED PROTEIN +FIG01361580 SMALL SECRETED PROTEIN +FIG01361592 phospholipase/carboxylesterase family protein +FIG01361603 thermostable carboxypeptidase 1( EC:3.4.17.- ) +FIG01361604 vWFA-like protein with metal ion dependent adhesion motif (MIDAS) +FIG01361607 putative integral membrane protein (dedA homolog) +FIG01361616 Transposase +FIG01361618 CRO repressor-like DNA-binding protein +FIG01361620 putative SpoOM-related protein +FIG01361622 GTP cyclohydrolase III (methanopterin) +FIG01361625 Twin-arginine translocation protein TatB +FIG01361647 FIG00350051: hypothetical protein +FIG01361650 FIG00427013: hypothetical protein +FIG01361658 FIG00644796: hypothetical protein +FIG01361659 KfrA protein +FIG01361662 Hydride transferase 1 (Fragment) +FIG01361670 sugar-proton symporter +FIG01361693 uncharacterized phage protein (possible DNA packaging) +FIG01361695 FIG00945163: hypothetical protein +FIG01361711 Hypothetical N-acetyltransferase +FIG01361717 pXO2-10 +FIG01361718 Putative Rhs-family protein +FIG01361727 FIG065022: hypothetical protein +FIG01361738 FIG00630787: hypothetical protein +FIG01361743 FIG00822461: hypothetical protein +FIG01361751 M. jannaschii predicted coding region MJ1233 +FIG01361752 Sugar ABC transporter, sugar permease protein 2 USSDB1D +FIG01361775 protein +FIG01361777 Pathogenicity determinant protein C +FIG01361783 FIG01045695: hypothetical protein +FIG01361801 MobA +FIG01361802 Sodium-calcium exchanger +FIG01361803 ortholog of Bordetella pertussis (BX470248) BP0189 +FIG01361809 YbcL +FIG01361810 probable dolichyl-phosphate mannose synthase +FIG01361815 FIG00513676: hypothetical protein +FIG01361821 4-hydroxybenzoate octaprenyltranferase related protein +FIG01361824 Transcriptional regulator, AraC family +FIG01361825 Conserved domain protein SP0160 +FIG01361855 FIG00873501: hypothetical protein +FIG01361867 FIG00385385: hypothetical protein +FIG01361874 type I restriction-modification system, M subunit, putative +FIG01361895 transcriptional regulator ToxR +FIG01361899 Predicted beta-xyloside ABC transporter, permease component +FIG01361923 NADPH-dependent FMN reductase( EC:1.5.1.29 ) +FIG01361926 Hypothetical (Phosphoribosylaminoimidazol (AIR) synthetase) +FIG01361932 hypothetical protein +FIG01361948 FIG00402738: hypothetical protein +FIG01361956 Surface lipoprotein P27 +FIG01361978 FIG01045841: hypothetical protein +FIG01361984 putative acyl-CoA thioesterase +FIG01361985 FIG00688741: hypothetical protein +FIG01361986 PE_PGRS +FIG01361989 FIG00350168: hypothetical protein +FIG01361992 pXO1-134 +FIG01362013 3-phosphoglycerate kinase +FIG01362016 Glycosidase +FIG01362030 Cof family hydrolase +FIG01362032 multimeric flavodoxin WrbA +FIG01362041 FIG00763028: hypothetical protein +FIG01362056 N-ethylammeline chlorohydrolase +FIG01362073 probable peroxidase +FIG01362118 Hypothetical protein, CF-37 family(almost identical) +FIG01362121 Putative homoserine kinase type II, PnuC-associated, THI-regulated branch +FIG01362130 ribulose-phosphate 3-epimerase family protein +FIG01362131 FIG00848431: hypothetical protein +FIG01362138 FIG00847617: hypothetical protein +FIG01362139 FIG00766666: hypothetical protein +FIG01362142 FIG00362015: hypothetical protein +FIG01362150 putative sulfurtransferase +FIG01362174 WD40 repeat-containing protein +FIG01362179 FIG00385195: hypothetical protein +FIG01362187 hypothetical protein Z4912 +FIG01362209 ATPases of the AAA+ class +FIG01362215 TldD protein +FIG01362223 Hypothetical protein, CF-29 family +FIG01362224 Single-strand binding protein family +FIG01362234 Putative glutathione transporter, permease component; Dipeptide transport system permease protein DppC (TC 3.A.1.5.2) +FIG01362242 FIG00766416: hypothetical protein +FIG01362251 FIG00351274: hypothetical protein +FIG01362262 RsbR, positive regulator of sigma-B +FIG01362276 cag pathogenicity island protein (cag3) +FIG01362290 Putative phospholipase C +FIG01362295 FIG00407168: hypothetical protein +FIG01362299 Acyl-CoA dehydrogenase( EC:1.3.99.- ) +FIG01362305 FIG00763398: hypothetical protein +FIG01362306 Arylsulfatase regulator +FIG01362324 FIG00836755: hypothetical protein +FIG01362325 Acyl-CoA synthetases (AMP-forming)/AMP-acid ligases +FIG01362335 Phosphotransferase system IIC components, glucose/maltose/N- acetylglucosamine-specific +FIG01362344 IS1404 transposase +FIG01362348 Lipase (LipP-2) (EC 3.1.1.3) +FIG01362357 DUF1093 domain-containing protein +FIG01362359 ZIP Zinc transporter +FIG01362364 DNA segregation ATPase FtsK/SpoIIIE and related proteins +FIG01362367 Probable sodium-dependent transporter +FIG01362373 V10 pilin +FIG01362387 ApeH acylamino-acid-releasing enzyme (EC 3.4.19.1) +FIG01362400 CshA protein +FIG01362413 Putative secreted protein +FIG01362433 FIG01047497: hypothetical protein +FIG01362441 FIG00406312: hypothetical protein +FIG01362471 Possible phage protein +FIG01362479 FIG00524219: hypothetical protein +FIG01362489 putative dioxygenase +FIG01362511 N-ethylammeline chlorohydrolase +FIG01362524 FIG00362068: hypothetical protein +FIG01362534 Oligopeptide transport system permease protein AppC +FIG01362541 putative periplasmic molybdate-binding protein +FIG01362542 flagellar sheath adhesin hpaA +FIG01362552 FIG00351976: hypothetical protein +FIG01362554 D-aminopeptidase dipeptide-binding protein DppA (EC 3.4.11.-) +FIG01362563 FIG00769613: hypothetical protein +FIG01362576 FIG00350776: hypothetical protein +FIG01362584 VapB2 protein (antitoxin to VapC2) +FIG01362589 transposase is4 family protein +FIG01362597 EAL domain/GGDEF domain protein +FIG01362605 Vitamin B12 ABC transporter, ATPase component BtuD +FIG01362614 FIG00388168: hypothetical protein +FIG01362616 B. burgdorferi predicted coding region BB0631 +FIG01362622 putative glycerol-2-phosphotransferase +FIG01362635 FIG00560864: hypothetical protein +FIG01362649 Phosphotransferase system IIB components +FIG01362651 FIG01201071: hypothetical protein +FIG01362665 Flp pilus assembly CpaB +FIG01362667 Phage protein +FIG01362671 FIG00825228: hypothetical protein +FIG01362673 FIG00637936: hypothetical protein +FIG01362679 metallopeptidase +FIG01362684 type 4 fimbrial assembly protein pilC +FIG01362691 FIG00769785: hypothetical protein +FIG01362704 FIG00452234: hypothetical protein +FIG01362710 FIG00514596: hypothetical protein +FIG01362723 FIG00424503: hypothetical protein +FIG01362726 FIG00387842: hypothetical protein +FIG01362727 Spermine/spermidine acetyltransferase +FIG01362732 aminotransferase class-III +FIG01362733 multi-component regulatory system-11 +FIG01362738 Uncharacterized protein Rv1520/MT1570 +FIG01362745 Hemolysin II +FIG01362758 cytochrome c553 +FIG01362766 FIG00350834: hypothetical protein +FIG01362776 FIG00766577: hypothetical protein +FIG01362794 BNR domain protein +FIG01362798 Phage protein +FIG01362799 hypothetical protein +FIG01362803 Allergen V5/Tpx-1 family protein +FIG01362830 FIG00817758: hypothetical protein +FIG01362831 FIG01047584: hypothetical protein +FIG01362842 FIG00817572: hypothetical protein +FIG01362855 probable lipoprotein NMA0233 +FIG01362858 FIG00402847: hypothetical protein +FIG01362863 ABC transport protein , putative +FIG01362892 Putative cytochrome P450 CypX +FIG01362899 FIG00410975: hypothetical protein +FIG01362901 FIG00526743: hypothetical protein +FIG01362906 contains NAD(P)H dehydrogenase (quinone) domain +FIG01362907 immunity protein, probable +FIG01362913 DUF124 domain-containing protein +FIG01362915 Cysteine ABC transporter, substrate-binding protein +FIG01362919 FIG01230776: hypothetical protein +FIG01362924 FIG00766856: hypothetical protein +FIG01362934 FilF +FIG01362942 Phosphate transport system protein phoU +FIG01362943 ABC transporter ATP-binding protein +FIG01362950 amino acid transporter +FIG01362958 LexA repressor +FIG01362965 Protein DR_1172 +FIG01362970 Two-component hybrid sensor and regulator associated with [RsbQ - PAS domain] sensing module +FIG01362971 Mycobacteriophage Barnyard protein gp56 +FIG01362980 FIG00463758: hypothetical protein +FIG01363002 hyaluronidase +FIG01363012 Carbon monoxide oxidation accessory protein CoxG +FIG01363017 hypothetical protein +FIG01363029 methyl-accepting chemotaxis protein, putative +FIG01363032 Sterol desaturase, putative +FIG01363035 aminotransferase, class III +FIG01363036 Isochorismate synthase (EC 5.4.4.2) [mycobactin] siderophore +FIG01363044 hypothetical protein +FIG01363053 hypothetical protein +FIG01363061 FIG01120675: hypothetical protein +FIG01363064 hypothetical protein +FIG01363092 uncharacterized secreted protein +FIG01363099 Acyltransferase family protein (EC 2.7.7.19) +FIG01363112 glycoside hydrolase family 30, candidate beta-glycosidase +FIG01363116 FIG00513878: hypothetical protein +FIG01363119 Major surface glycoprotein-like +FIG01363125 FIG00350926: hypothetical protein +FIG01363133 hypothetical protein +FIG01363141 major facilitator (MFS) superfamily protein +FIG01363149 FIG00898157: hypothetical protein +FIG01363165 export protein FliQ, family 3 +FIG01363179 IncH1 plasmid conjugative transfer thiol:disulfide interchange protein HtdT +FIG01363181 enzyme; Degradation of DNA +FIG01363184 cell surface hydrolase (putative) +FIG01363186 Peptide pheromone BlpC (Bacteriocin-like peptide, double glycine cleavage type) +FIG01363191 FIG00764499: hypothetical protein +FIG01363196 FIG00388428: hypothetical protein +FIG01363198 FIG00637230: hypothetical protein +FIG01363204 FucR +FIG01363206 FIG01118355: hypothetical protein +FIG01363208 ATP binding protein of ABC transporter +FIG01363219 5,10-Methylenetetrahydrofolate reductase( EC:1.7.99.5 ) +FIG01363220 FIG00765698: hypothetical protein +FIG01363247 FIG01069016: hypothetical protein +FIG01363279 conserved membrane-associated protein +FIG01363287 pirin-like protein +FIG01363295 FIG00897497: hypothetical protein +FIG01363327 FIG00847064: hypothetical protein +FIG01363356 FIG00876815: hypothetical protein +FIG01363363 Putative ATP binding protein SugR +FIG01363382 hypothetical protein +FIG01363383 putative ATPase n2B +FIG01363385 FIG00351429: hypothetical protein +FIG01363390 proteasome-activating nucleotidase +FIG01363393 FIG01247248: hypothetical protein +FIG01363407 FIG00945742: hypothetical protein +FIG01363410 Fructose-26-bisphosphatase +FIG01363425 FIG01092293: hypothetical protein +FIG01363427 Protein SkfH +FIG01363442 FIG01363442: possible membrane protein +FIG01363449 hypothetical protein Rv2998 +FIG01363472 probable aggregation factor core +FIG01363488 FIG01074318: hypothetical protein +FIG01363524 Integral membrane protein +FIG01363560 Putative regulatory, ligand-binding protein related to C-terminal domains of K+ channels +FIG01363578 FIG01200125: hypothetical protein +FIG01363579 FIG00763559: hypothetical protein +FIG01363597 FIG00766803: hypothetical protein +FIG01363639 FIG00424399: hypothetical protein +FIG01363642 FIG00424656: hypothetical protein +FIG01363645 FIG00767848: hypothetical protein +FIG01363662 FIG00353412: hypothetical protein +FIG01363675 Eukaryotic huntingtin interacting protein B +FIG01363684 FIG00361913: hypothetical protein +FIG01363685 Transcriptional regulatory protein ComA (Bsu) +FIG01363689 FIG00410904: hypothetical protein +FIG01363693 FIG00384952: hypothetical protein +FIG01363694 Microbial collagenase precursor (EC 3.4.24.3) (120 kDa collagenase) +FIG01363699 FIG00861818: hypothetical protein +FIG01363703 Enhanced intracellular survival protein +FIG01363704 Putative uncharacterized protein BCG_3858 +FIG01363711 ortholog to Borrelia burgdorferi BB0224 +FIG01363713 POSSIBLE PROTEIN TRANSPORT PROTEIN SECE2 +FIG01363732 two-component sensor, putative +FIG01363734 FIG00356405: hypothetical protein +FIG01363750 FIG00763351: hypothetical protein +FIG01363763 DNA-binding cold-shock protein +FIG01363771 FIG01166355: hypothetical protein +FIG01363775 FIG00763074: hypothetical protein +FIG01363790 FIG00836974: hypothetical protein +FIG01363791 Ferripyochelin binding protein-like +FIG01363813 Microcystin dependent protein +FIG01363820 ABC, transporter, ATP-binding protein +FIG01363830 gnl|WGS:AAAB|ebiP470|gb|EAA02729 +FIG01363833 Lmo0471 protein +FIG01363837 FIG01229164: hypothetical protein +FIG01363844 transposase and inactivated derivatives +FIG01363849 4-hydroxybenzoyl-CoA thioesterase +FIG01363854 putative cytochrome c +FIG01363866 Cell surface hydrolase +FIG01363879 Serine/threonine specific protein phosphatase (EC 3.1.3.16) +FIG01363902 probable endo-1,4-beta-xylanase B +FIG01363907 hypothetical protein +FIG01363910 TRANSPOSASE +FIG01363915 Hydrolase, alpha/beta fold family protein +FIG01363948 5-oxo-L-prolinase, putative +FIG01363984 Phosphoglucomutase( EC:5.4.2.2 ) +FIG01363988 Alkane-1 monooxygenase (EC 1.14.15.3) +FIG01363992 Regulatory protein for C-P lyase +FIG01363998 FIG00408192: hypothetical protein +FIG01364035 SWIM zinc finger domain protein +FIG01364044 NAD-dependent aldehyde dehydrogenase associated with FdhD +FIG01364055 FIG00403861: hypothetical protein +FIG01364060 Spore germination protein QC +FIG01364072 FIG00823025: hypothetical protein +FIG01364108 branched-chain amino acid permease +FIG01364130 FIG00946185: hypothetical protein +FIG01364131 INTERNALIN A +FIG01364147 FIG00468433: hypothetical protein +FIG01364160 FIG00350535: hypothetical protein +FIG01364170 Arginine-binding periplasmic protein 2 precursor +FIG01364172 Senescence marker protein-30 +FIG01364181 membrane protein ykgB +FIG01364187 FIG00579126: hypothetical protein +FIG01364209 FIG00675242: hypothetical protein +FIG01364210 FIG00407972: hypothetical protein +FIG01364214 probable NosR regulatory protein +FIG01364216 Xaa-Pro dipeptidase, putative +FIG01364235 FIG00749726: hypothetical protein +FIG01364239 hypothetical protein +FIG01364240 Inner membrane protein ygiZ +FIG01364259 tRNA-specific adenosine-34 deaminase (EC 3.5.4.-) / domain of unknown function +FIG01364290 FIG00746171: hypothetical protein +FIG01364302 Iron-sulfur binding protein +FIG01364309 DshA protein +FIG01364341 serine_threonine protein kinase +FIG01364343 FIG00414011: hypothetical protein +FIG01364346 YapH protein +FIG01364348 probable alpha helix chain yaiN +FIG01364362 phage minor structural GP20 +FIG01364376 hypothetical protein +FIG01364386 Transcriptional repressor Mce3R, TetR family +FIG01364397 Similarity to thiol:disulfide interchange protein dsbA +FIG01364414 Two component sigma-54-dependent transcriptional regulator, Fis family +FIG01364474 Component of conjugal plasmid transfer system +FIG01364477 CP12 polypeptide +FIG01364487 DNA helicase, UvrD/REP family +FIG01364495 FIG00388342: hypothetical protein +FIG01364498 Putative diguanylate cyclase (GGDEF domain) with PAS/PAC and Chase2 sensors +FIG01364499 FIG00569632: hypothetical protein +FIG01364506 putative transcriptional regulator (partial) +FIG01364510 polysaccharide transporter, putative +FIG01364515 contains short chain fatty acid transporter domain +FIG01364516 Surface protein/Bartonella adhesin +FIG01364518 Sodium:solute symporter family protein +FIG01364539 NADPH quinone oxidoreductase +FIG01364540 Probable phage integrase +FIG01364554 Esterase (EC 3.1.1.-) +FIG01364561 Formyl-CoA transferase( EC:2.8.3.16 ) +FIG01364572 FIG00349738: hypothetical protein +FIG01364573 FIG030830: Hypothetical protein +FIG01364588 SECRETED ANTIGEN 85-B FBPB (85B) (ANTIGEN 85 COMPLEX B) (MYCOLYL TRANSFERASE 85B) (FIBRONECTIN-BINDING PROTEIN B) (EXTRACELLULAR ALPHA-ANTIGEN) +FIG01364589 2-nitropropane dioxygenase, NPD +FIG01364596 Ribosomal-protein-serine acetyltransferase (EC 2.3.1.-) +FIG01364604 transcriptional regulator, Icc related protein +FIG01364621 FIG00262664: hypothetical protein +FIG01364628 Alkylated DNA repair protein +FIG01364633 nitrogen regulator, putative +FIG01364646 Probable glycolate oxidase +FIG01364648 Autolysin, amidase +FIG01364675 Competence lipoprotein ComL +FIG01364676 FIG01045688: hypothetical protein +FIG01364686 ABC-type polar amino acid transport system protein, substrate-binding protein +FIG01364702 Alkaline ceramidase +FIG01364714 FIG00637870: hypothetical protein +FIG01364716 Excinuclease ABC, C subunit-like +FIG01364723 FIG00641526: hypothetical protein +FIG01364727 Quinone oxidoreductase +FIG01364729 FIG00347614: hypothetical protein +FIG01364731 FIG00466505: hypothetical protein +FIG01364732 FIG00351035: hypothetical protein +FIG01364734 FIG00638134: hypothetical protein +FIG01364738 FIG01234510: hypothetical protein +FIG01364744 Hypothetical ABC transporter extracellular binding protein +FIG01364755 FIG00349368: hypothetical protein +FIG01364763 HlyD family secretion protein +FIG01364795 FIG00406426: hypothetical protein +FIG01364805 Peptidase, M20/M25/M40 family +FIG01364807 FIG00353692: hypothetical protein +FIG01364812 Histone-Like Developmental Protein +FIG01364814 4'-phosphopantetheinyl transferase (EC 2.7.8.-) +FIG01364827 FIG00624796: hypothetical protein +FIG01364830 MULTIPLE SUGAR ABC TRANSPORTER PERMEASE PROTEIN +FIG01364836 putative bacterial secretion system protein +FIG01364848 FrgA protein +FIG01364859 Predicted ATP-dependent serine protease +FIG01364863 phi 11 orf41 homolog [SA bacteriophages 11, Mu50B] +FIG01364864 Fatty acid cis/trans isomerase +FIG01364874 FIG00407671: hypothetical protein +FIG01364889 FIG00822640: hypothetical protein +FIG01364907 BNR repeat domain protein +FIG01364916 FIG00351968: hypothetical protein +FIG01364934 FIG00519439: hypothetical protein +FIG01364943 Mechanosensitive ion channel family protein +FIG01364945 Cupin domain protein +FIG01364949 FIG00968664: hypothetical protein +FIG01364953 hypothetical protein +FIG01364955 FIG00351717: hypothetical protein +FIG01364958 Hypothetical protein in cluster with HutR, VCA0067 homolog +FIG01364965 orf, partial conserved hypothetical protein +FIG01364966 putative universal stress protein family +FIG01364987 hypothetical protein +FIG01364991 FIG00402828: hypothetical protein +FIG01364993 FIG00766496: hypothetical protein +FIG01365006 FIG01116405: hypothetical protein +FIG01365016 FIG00350547: hypothetical protein +FIG01365030 FIG01221757: hypothetical protein +FIG01365031 putative phage tail protein I +FIG01365048 serine esterase, cutinase family +FIG01365065 Hypothetical protein PA1329 +FIG01365066 Orbi_VP5, Orbivirus outer capsid protein VP5 +FIG01365067 IMMUNODOMINANT PROTEIN P72 PRECURSOR +FIG01365075 FIG00748983: hypothetical protein +FIG01365091 FIG00406884: hypothetical protein +FIG01365093 Possible beta-ketoadipate enol-lactone hydrolase +FIG01365116 intein homing endonuclease-related protein +FIG01365119 Flagellin protein +FIG01365120 myo-inositol 2-dehydrogenase +FIG01365137 N-hydroxyarylamine O-acetyltransferase( EC:2.3.1.118 ) +FIG01365138 FIG045364: Hypothetical protein +FIG01365151 putative protein +FIG01365162 Monoamine oxidase regulatory protein +FIG01365172 FIG00353531: hypothetical protein +FIG01365186 surface presentation of antigens (SPOA) protein +FIG01365206 FIG01046873: hypothetical protein +FIG01365213 FIG00815187: hypothetical protein +FIG01365219 oxidoreductase of aldo/keto reductase family, subgroup 2 +FIG01365225 FIG00350442: hypothetical protein +FIG01365242 FIG01293316: hypothetical protein +FIG01365243 AHCY transcriptional activator hvrB +FIG01365247 Soluble lytic murein transglycosylase +FIG01365257 FIG00765240: hypothetical protein +FIG01365261 FIG01165824: hypothetical protein +FIG01365272 Na+/H+ antiporter NhaC +FIG01365318 FIG00764380: hypothetical protein +FIG01365321 hypothetical protein +FIG01365322 Molybdopterin oxidoreductase:Molydopterin dinucleotide-binding region +FIG01365326 FIG00640376: hypothetical protein +FIG01365328 aminotransferase, class I +FIG01365356 FIG00847127: hypothetical protein +FIG01365359 drug resistance transporter Bcr/CflA subfamily; possible bicyclomycin resistance protein +FIG01365373 FIG01264951: hypothetical protein +FIG01365378 Helicase-like protein +FIG01365406 Tetracycline resistance protein C +FIG01365410 Glucoamylase precursor (EC 3.2.1.3) +FIG01365415 FIG00409263: hypothetical protein +FIG01365437 FIG00766630: hypothetical protein +FIG01365442 short chain alcohol dehydrogenase +FIG01365452 WavQ +FIG01365458 hypothetical phage protein +FIG01365461 FIG00769966: hypothetical protein +FIG01365463 FIG00409816: hypothetical protein +FIG01365467 Diguanylate-cyclase (DGC) or GGDEF domain +FIG01365479 Type 1 capsular polysaccharide biosynthesis protein J +FIG01365484 ISXo8 transposase +FIG01365485 FIG00361618: hypothetical protein +FIG01365490 Secretion system regulator: Sensor component (EC 2.7.3.-) (EC 2.7.1.40) +FIG01365492 Phosphopantetheine attachment site domain protein +FIG01365497 FIG00350220: hypothetical protein +FIG01365498 FIG00388373: hypothetical protein +FIG01365500 FIG00409771: hypothetical protein +FIG01365504 Endoglucanase A precursor (EC 3.2.1.4) +FIG01365511 Lj965 prophage cro-repressor +FIG01365522 Mll1230 protein +FIG01365523 small acid-soluble spore protein (alpha/beta-type SASP) +FIG01365541 BofA B.subtilis ortholog, SigmaK-factor processing regulatory protein +FIG01365563 FIG00406097: hypothetical protein +FIG01365564 FIG00352875: hypothetical protein +FIG01365568 Phage-associated homing endonuclease +FIG01365573 putative cell surface polysaccharide biosynthesis +FIG01365588 hypothetical protein +FIG01365597 Transcriptional regulator pfoR +FIG01365599 Signaling protein (EAL,CBS,GGDEF domains) +FIG01365622 Mu-like prophage FluMu protein gp29 +FIG01365627 Transport/processing ATP-binding protein comA (EC 3.4.22.-) +FIG01365635 FIG00451678: hypothetical protein +FIG01365637 FIG01242567: hypothetical protein +FIG01365643 EamA-like transporter family protein +FIG01365660 FIG00974765: hypothetical protein +FIG01365668 NADH-flavin oxidoreductase / NADH oxidase familyprotein +FIG01365681 FIG00829332: hypothetical protein +FIG01365682 probable phage protein YPO2110 +FIG01365683 FIG00764973: hypothetical protein +FIG01365691 ATP-DEPENDENT HELICASE HRPB +FIG01365695 FIG00349279: hypothetical protein +FIG01365703 Superinfection exclusion protein B +FIG01365719 Alginate lyase +FIG01365724 FIG00349972: hypothetical protein +FIG01365744 TRAP-type uncharacterized transport system +FIG01365766 Peptidase Lmo0394 homolog +FIG01365770 FIG00850027: hypothetical protein +FIG01365793 Lipid A core - O-antigen ligase and related enzymes +FIG01365811 FIG00766244: hypothetical protein +FIG01365816 hypothetical protein +FIG01365837 Phage-like element PBSX protein xkdN +FIG01365841 aldo/keto reductase family +FIG01365848 EAL domain +FIG01365850 Cell-cell signaling protein, C-factor +FIG01365864 FIG00387894: hypothetical protein +FIG01365876 putative HNH endonuclease domain protein +FIG01365877 (AF101072) ATP synthase subunit +FIG01365886 FIG00403605: hypothetical protein +FIG01365892 FIG00385428: hypothetical protein +FIG01365904 Type IV secretory pathway VirD2 pilin (relaxase)-like protein +FIG01365909 Probable phiRv1 phage protein +FIG01365920 Transcriptional regulator +FIG01365931 FIG00613045: hypothetical protein +FIG01365936 FAD/FMN-containing dehydrogenases +FIG01365940 FIG00762965: hypothetical protein +FIG01365946 serine protease, subtilase family +FIG01365950 Listeria protein LmaD, associated with virulence +FIG01365957 Transcriptional antiterminator, PTS system IIA 2 domain protein +FIG01365986 putative small acid-soluble spore protein +FIG01365988 FIG00408616: hypothetical protein +FIG01365995 putative 3-hydroxybutyryl-CoA dehydratase +FIG01366001 Outer membrane lipoprotein PCP +FIG01366007 FIG01135441: hypothetical protein +FIG01366016 Related to HTH domain of SpoOJ/ParA/ParB/repB family, involved in chromosome partitioning +FIG01366019 Amine oxidase [flavin-containing] (EC 1.4.3.4) +FIG01366027 Protein yeeZ precursor +FIG01366044 Rhodanese domain protein +FIG01366045 FIG00672401: hypothetical protein +FIG01366084 protein of unknown function DUF1312 +FIG01366092 FIG00623247: hypothetical protein +FIG01366096 hypothetical protein +FIG01366114 FIG00364459: hypothetical protein +FIG01366123 Probable serine protease do-like precursor (EC 3.4.21.-) +FIG01366127 O-methyltransferase (EC 2.1.1.-) +FIG01366129 Hypothetical protein with Rieske (2Fe-2S) region +FIG01366130 Putative cytoplasmic protein +FIG01366139 FIG00638701: hypothetical protein +FIG01366141 probable DNA-binding protein STY2007 +FIG01366144 Sll0597 protein +FIG01366149 phage lysozyme-like protein +FIG01366154 transcription regulator, AraC-type +FIG01366167 putative amino acid efflux protein, LysE family +FIG01366173 chromate reductase +FIG01366180 fliB domain protein +FIG01366199 histidine protein kinase AsgD +FIG01366204 FIG00403224: hypothetical protein +FIG01366210 FIG00764039: hypothetical protein +FIG01366224 Iron-sulfur binding electron transfer protein +FIG01366246 FIG00417772: hypothetical protein +FIG01366247 sugar transport ATP-binding protein +FIG01366248 C-di-GMP phosphodiesterase A-related protein +FIG01366258 transcriptional regulatory protein +FIG01366266 FIG00861567: hypothetical protein +FIG01366278 glycosyl transferase family 25 +FIG01366293 Phage tail assembly +FIG01366322 FIG00847203: hypothetical protein +FIG01366330 Muramoyl-tetrapeptide carboxypeptidase (MccF/LdcA family) (EC 3.4.17.13) +FIG01366338 feoA family protein +FIG01366345 FIG00408379: hypothetical protein +FIG01366349 FIG00404632: hypothetical protein +FIG01366365 Streptomycin 3''-kinase (EC 2.7.1.87) +FIG01366374 putative (L31491) ORF2; putative [Plasmid pTOM9] +FIG01366388 Virulence protein +FIG01366392 Serine/threonine protein phosphatase family protein +FIG01366397 Cation transport protein +FIG01366408 Pap2 superfamily protein +FIG01366425 FIG00384881: hypothetical protein +FIG01366434 FIG00530683: hypothetical protein +FIG01366442 Clusters with Methylmalonyl-CoA carboxyltransferase (EC 2.1.3.1) +FIG01366457 FIG00923589: hypothetical protein +FIG01366460 UDP-galactopyranose mutase Glf (EC 5.4.99.9) +FIG01366475 esterase/lipase protein +FIG01366517 ORF_ID:all2291 +FIG01366535 Integral membrane protein, sugar transporter +FIG01366547 FIG00351387: hypothetical protein +FIG01366563 putative membrane-associated alkaline phosphatase +FIG01366566 putative ThiJ family intracellular protease/amidase +FIG01366579 FIG00766560: hypothetical protein +FIG01366585 Hup-type Ni,Fe-hydrogenase cytochrome b subunit +FIG01366589 Putative EsaC protein analog (Listeria type 2) +FIG01366593 CRISPR-associated protein Cas5 +FIG01366615 ferrichrome ABC transporter +FIG01366616 Homology with RecF protein +FIG01366621 16 +FIG01366623 transcriptional regulator, LuxR family, putative +FIG01366632 FIG01118623: hypothetical protein +FIG01366635 B. burgdorferi predicted coding region BB0245 +FIG01366646 possible Fumarate reductase subunit D +FIG01366659 Superfamily II DNA and RNA helicase +FIG01366661 Phenylacetic acid degradation protein paaD +FIG01366674 2-haloalkanoic acid dehalogenase +FIG01366676 Cytochrome P450-like protein +FIG01366678 Protein involved in biosynthesis of mitomycin antibiotics/polyketide fumonisin +FIG01366691 hypothetical protein +FIG01366693 Possible phage phiRv1 protein +FIG01366698 putative hexose phosphate transport protein +FIG01366704 FIG00351606: hypothetical protein +FIG01366722 Type II restriction endonuclease, uncharacterized, truncation +FIG01366728 COG3335: Transposase and inactivated derivatives +FIG01366740 predicted extracellular metal-dependent peptidase +FIG01366751 FIG01211546: hypothetical protein +FIG01366757 protein of unknown function DUF480 +FIG01366759 FIG01277227: hypothetical protein +FIG01366766 FIG00389300: hypothetical protein +FIG01366776 GidA-related protein +FIG01366777 Type II restriction enzyme NgoPII (EC 3.1.21.4) +FIG01366783 prophage MuSo1, F protein, putative +FIG01366795 hypothetical protein Rv1639c +FIG01366797 FIG01247974: hypothetical protein +FIG01366799 FIG00820164: hypothetical protein +FIG01366811 Branched-chain amino acid permeases +FIG01366824 possible Vanadium/alternative nitrogenase delt +FIG01366839 FIG00404263: hypothetical protein +FIG01366846 FIG00385169: hypothetical protein +FIG01366849 PROBABLE ANTIBIOTIC-RESISTANCE PROTEIN +FIG01366870 L-lactate dehydrogenase (FMN-dependent) and related alpha-hydroxy acid dehydrogenases +FIG01366871 FIG01038485: hypothetical protein +FIG01366884 type I restriction-modification system, M subunit, putative +FIG01366896 bifunctional deaminase-reductase domain protein +FIG01366924 phage related tail protein +FIG01366928 FIG00820507: hypothetical protein +FIG01366953 putative Ecf-type RNA polymerase sigma factor +FIG01366958 Probable integral membrane protein Cj0851c +FIG01366960 oligopeptidase B +FIG01366963 FIG00350011: hypothetical protein +FIG01366973 FIG00946406: hypothetical protein +FIG01366976 FIG00410019: hypothetical protein +FIG01366992 FIG00627861: hypothetical protein +FIG01366995 hypothetical oxidoreductase +FIG01367007 FIG00744641: hypothetical protein +FIG01367008 EAL/GGDEF domain protein +FIG01367031 Inositol phosphate phosphatase IpgD (EC 3.1.3.-) +FIG01367037 Protein similar to polyadenylation specificity factor, MJ0047 type +FIG01367040 Probable exosome complex RNA-binding protein 1 +FIG01367081 FIG00643514: hypothetical protein +FIG01367086 FIG00343921: hypothetical protein +FIG01367121 putative F1 operon positive regulatory protein +FIG01367129 Lipoprotein VacJ-like +FIG01367139 Methanol utilization control regulatory protein MoxX +FIG01367150 FIG00427113: hypothetical protein +FIG01367154 Osmotically inducible protein Y precursor +FIG01367172 Probable glutathione S-transferase +FIG01367191 putative cytochrome +FIG01367193 putative protein involved in capsular polysaccharide biosynthesis +FIG01367198 FIG00872066: hypothetical protein +FIG01367203 FIG00827919: hypothetical protein +FIG01367205 putative cytochrome C-type haem-binding periplasmic protein +FIG01367215 predicted xylose isomerase +FIG01367217 hypothetical protein +FIG01367219 FIG00512967: hypothetical protein +FIG01367222 Hypothetical protein COG3496 +FIG01367231 FIG018942: hypothetical protein +FIG01367241 Ribosomal protein S16 +FIG01367242 FIG00387857: hypothetical protein +FIG01367250 xylose repressor +FIG01367293 FIG00644715: hypothetical protein +FIG01367303 FIG00847339: hypothetical protein +FIG01367314 FIG00408674: hypothetical protein +FIG01367315 FIG00404066: hypothetical protein +FIG01367318 predicted flavin-nucleotide-binding protein structurally related to pyridoxine 5'-phosphate oxidase +FIG01367328 Putative PTS system, nitrogen regulatory IIA component +FIG01367349 FIG00746844: hypothetical protein +FIG01367354 FIG00388289: hypothetical protein +FIG01367357 FIG00352571: hypothetical protein +FIG01367369 HAD-superfamily hydrolase, subfamily IA, variant 3( EC:3.1.3.18 ) +FIG01367371 FIG00410316: hypothetical protein +FIG01367377 Oxygen-independent coproporphyrinogen III oxidase, Fe-S oxidoreductase +FIG01367378 FIG00404129: hypothetical protein +FIG01367379 Monooxygenase, flavin-binding family in mymA operon +FIG01367380 hypothetical protein, acetyltransferase, truncated +FIG01367383 LysR-family regulatory protein +FIG01367386 FIG00945470: hypothetical protein +FIG01367390 COGs COG1175 +FIG01367396 hypothetical protein Rv2767c +FIG01367398 FIG00350468: hypothetical protein +FIG01367423 B. burgdorferi predicted coding region BBB28 +FIG01367431 Sphingosine kinase and enzymes related to eukaryotic diacylglycerol kinase +FIG01367435 Dehydrogenases +FIG01367447 Cytochrome P450 +FIG01367451 FIG01049650: hypothetical protein +FIG01367462 FIG01239142: hypothetical protein +FIG01367468 FIG00364109: hypothetical protein +FIG01367470 response regulator protein OmpR +FIG01367502 FIG00434599: hypothetical protein +FIG01367510 Anaerobic dicarboxylate transport protein +FIG01367511 Orf1 +FIG01367513 Cytochrome c biogenesis protein +FIG01367516 FIG00409039: hypothetical protein +FIG01367518 Mb1322, -, len: 104 aa. Equivalent to Rv1290A, len: 104 aa, from Mycobacterium tuberculosis strain H37Rv, (100% identity in 104 aa overlap). Hypothetical unknown protein, equivalent to AAK45590 from Mycobacterium tuberculosis strain CDC1551 (122 aa) but shorter 18 aa. +FIG01367557 DNA invertase-like protein +FIG01367565 contains amino acid permease domain +FIG01367569 FIG00641298: hypothetical protein +FIG01367573 FIG00385352: hypothetical protein +FIG01367587 corresponds to STY3948 from Accession AL513382: Salmonella typhi CT18 +FIG01367600 prophage ps3 protein 13 +FIG01367601 Sb8 +FIG01367613 non-hemolytic phospholipase C +FIG01367614 chemotaxis sensory transducer +FIG01367628 FIG00518103: hypothetical protein +FIG01367632 AraC family regulatory protein +FIG01367647 glycoside hydrolase family 57 +FIG01367648 FIG00765140: hypothetical protein +FIG01367670 Vitamin B12 ABC transporter, permease component BtuC +FIG01367702 Signaling protein with a ligand-binding sensor domain, PAS, GGDEF and EAL domains +FIG01367709 hypothetical lipoprotein +FIG01367720 FIG00424489: hypothetical protein +FIG01367732 N-acetylmuramoyl-L-alanine amidase( EC:3.5.1.28 ) +FIG01367752 FIG00623461: hypothetical protein +FIG01367763 protein of unknown function DUF661 +FIG01367789 ShiA homolog +FIG01367813 Diadenosine 5'5'''-P1,P4-tetraphosphate pyrophosphohydrolase +FIG01367819 DNA-binding protein Bph2 +FIG01367827 FIG01109163: hypothetical protein +FIG01367853 FIG00529928: hypothetical protein +FIG01367855 Replication initiation protein RepE +FIG01367862 ORF_f143 +FIG01367883 Miscellaneous; Hypothetical/Global homology +FIG01367905 microcin M activity protein McmM +FIG01367910 FIG00351014: hypothetical protein +FIG01367919 hypothetical protein-signal peptide prediction +FIG01367944 hypothetical protein +FIG01367945 Probable conserved lipoprotein lppOb +FIG01367952 Putative Diguanylate cyclase/phosphodiesterase domain 1 +FIG01367957 type II R/M system +FIG01367961 toxin-antitoxin system, antitoxin component, HicB family +FIG01367967 hypothetical protein +FIG01367973 putative secretion protein (HlyD family) +FIG01367981 FIG01068988: hypothetical protein +FIG01367990 FIG00829297: hypothetical protein +FIG01368008 hypothetical protein +FIG01368011 Possible methyltransferase +FIG01368020 Aminopeptidase +FIG01368021 FIG00424109: hypothetical protein +FIG01368030 Putative NADPH-quinone reductase (modulator of drug activity B) +FIG01368035 putative porphyrin biosynthetic protein +FIG01368036 FIG01201148: hypothetical protein +FIG01368038 Uncharacterized flavoproteins +FIG01368058 FIG00846915: hypothetical protein +FIG01368062 FIG00469034: hypothetical protein +FIG01368075 FIG00351261: hypothetical protein +FIG01368080 FIG00350949: hypothetical protein +FIG01368085 comB7 putative lipoprotein +FIG01368096 Putative iron transport system exported solute-binding component +FIG01368113 ATP-binding protein-homolog +FIG01368114 FIG00350172: hypothetical protein +FIG01368116 alkaline serine protease +FIG01368126 Prevent-host-death family protein +FIG01368138 YoaK +FIG01368139 FIG00350178: hypothetical protein +FIG01368142 PE-PGRS FAMILY PROTEIN +FIG01368149 mercuric transport protein MerT, putative +FIG01368162 FIG00766417: hypothetical protein +FIG01368171 FIG00351139: hypothetical protein +FIG01368172 putative acetyltransferase [EC:2.3.1.-] [KO:K03830] +FIG01368183 FIG00821507: hypothetical protein +FIG01368199 FIG00850846: hypothetical protein +FIG01368220 FIG00633727: hypothetical protein +FIG01368229 amino-acid metabolism +FIG01368250 putative transposase, fragment +FIG01368254 putative permease, FecCD transport family protein +FIG01368259 rRNA biogenesis protein rrp5, putative +FIG01368270 FIG00674641: hypothetical protein +FIG01368309 FIG01234628: hypothetical protein +FIG01368319 IroE protein +FIG01368323 PI protein +FIG01368331 Type IIA topoisomerase, B subunit +FIG01368340 putative outer membrane usher protein +FIG01368344 PE-PGRS virulence associated protein +FIG01368348 putative Shiga-like toxin A subunit +FIG01368349 Putative prophage antitermination protein +FIG01368373 FIG01118260: hypothetical protein +FIG01368406 FIG00384988: hypothetical protein +FIG01368412 FIG00768130: hypothetical protein +FIG01368416 FIG01028389: hypothetical protein +FIG01368425 FIG00630148: hypothetical protein +FIG01368431 FIG00345018: hypothetical protein +FIG01368439 Protein containing Zn-finger domain +FIG01368459 COG0385 sodium-dependent transporter +FIG01368473 general secretion pathway protein F +FIG01368475 FIG00733233: hypothetical protein +FIG01368481 FIG00415273: hypothetical protein +FIG01368491 homologue of Rhodobacter capsulatus gene transfer agent (GTA) orfg12 +FIG01368495 FIG00643478: hypothetical protein +FIG01368500 3-hydroxyacyl-[acyl-carrier-protein] dehydratase, FabZ form (EC 4.2.1.59) +FIG01368502 FIG00432772: hypothetical protein +FIG01368506 ATP synthase F1, gamma subunit( EC:3.6.3.14 ) +FIG01368523 phenol soluble modulin beta 1/beta 2 +FIG01368534 NADPH dehydrogenase (EC 1.6.99.1) (Xenobiotic reductase) +FIG01368541 FIG00828040: hypothetical protein +FIG01368548 FIG00763038: hypothetical protein +FIG01368563 FIG00407084: hypothetical protein +FIG01368566 Uncharacterized protein Rv0495c/MT0515 +FIG01368580 RNase R-related protein +FIG01368587 NADH dehydrogenase subunit, putative +FIG01368592 putative heme oxygenase +FIG01368622 hypothetical protein +FIG01368623 FIG018217: Phage-associated protein +FIG01368628 FIG00408416: hypothetical protein +FIG01368634 FIG00352711: hypothetical protein +FIG01368636 FIG00403617: hypothetical protein +FIG01368637 putative N-acetylmuramoyl-L-alanine amidase +FIG01368662 similar to Limonene-1 2-epoxide hydrolase +FIG01368670 FKBP-type peptidyl-prolyl cis-trans isomerase +FIG01368680 FIG00350987: hypothetical protein +FIG01368681 putative polysaccharide polymerase +FIG01368684 FIG00766431: hypothetical protein +FIG01368692 COG1405: Transcription initiation factor TFIIIB, Brf1 subunit/Transcription initiation factor TFIIB +FIG01368693 FIG00416145: hypothetical protein +FIG01368698 Tellurite resistance protein +FIG01368704 probable membrane protein YPO3657a +FIG01368707 putative tryptophan transport protein +FIG01368718 FIG00908368: hypothetical protein +FIG01368720 ABC-type amino acid transport system permease component +FIG01368721 B. burgdorferi predicted coding region BB0509 +FIG01368727 putative NADH-flavin reductase +FIG01368735 Inositol polyphosphate related phosphatase +FIG01368743 ABC-type antimicrobial peptide transporter,permease component +FIG01368745 FIG00626109: hypothetical protein +FIG01368761 FIG00349976: hypothetical protein +FIG01368778 FIG00425099: hypothetical protein +FIG01368792 FIG00350062: hypothetical protein +FIG01368808 Lin2548 protein +FIG01368843 predicted dehydrogenase and related proteins +FIG01368844 FIG00515248: hypothetical protein +FIG01368861 FIG00493232: hypothetical protein +FIG01368862 hypothetical protein +FIG01368874 positive control factor +FIG01368883 FIG00384942: hypothetical protein +FIG01368898 Acid shock protein 1 precursor +FIG01368934 nitrogen assimilation regulatory protein NtrX +FIG01368946 FIG01368946: Putative alanine and valine rich exported protein +FIG01368955 contains type I hydrophobic transmembrane region and ATP/GTP binding motif +FIG01368971 FIG00994727: hypothetical protein +FIG01368976 FIG00643597: hypothetical protein +FIG01368977 FIG00945650: hypothetical protein +FIG01368978 FIG00513616: hypothetical protein +FIG01368985 putative methylamine utilization protein MauG precursor +FIG01368996 Methylase of chemotaxis methyl-accepting protein +FIG01368997 FIG00427338: hypothetical protein +FIG01369014 FIG00960662: hypothetical protein +FIG01369033 cytochrome C assembly protein +FIG01369041 Transcriptional activator protein CzcR +FIG01369047 Possible transcriptional regulatory protein, AsnC family +FIG01369082 Oxidoreductase, short chain dehydrogenase/reductase family (EC 1.-.-.- ) +FIG01369087 FIG00351831: hypothetical protein +FIG01369096 FIG00748878: hypothetical protein +FIG01369099 Possible Yersinia enterocolitica-like Orf1 +FIG01369108 putative two-component response regulator +FIG01369116 COG2141: Coenzyme F420-dependent N5,N10-methylene tetrahydromethanopterin reductase and related flavin-dependent oxidoreductases +FIG01369128 Probable ABC transporter +FIG01369134 FIG00710905: hypothetical protein +FIG01369163 DNA replication protein +FIG01369168 Lactacin F ABC transporter permease component +FIG01369175 FIG00792857: hypothetical protein +FIG01369181 cyanate transporter +FIG01369193 Staphostatin B +FIG01369199 Hypothetical secreted protein (fragment) +FIG01369200 ORF120 +FIG01369220 FIG00639214: hypothetical protein +FIG01369221 TPR Domain containing protein +FIG01369237 Putative flagellar regulatory protein +FIG01369239 Putative cyclic beta-1,2-glucan modification protein +FIG01369240 D-alanyl-D-alanine dipeptidase (EC 3.4.13.22) +FIG01369264 FIG00513099: hypothetical protein +FIG01369265 FIG00351117: hypothetical protein +FIG01369268 FIG00764185: hypothetical protein +FIG01369288 PROBABLE PROLINE-RICH TRANSMEMBRANE PROTEIN +FIG01369295 Metal dependent hydrolase (EC 3.-.-.-) +FIG01369306 FIG00352942: hypothetical protein +FIG01369323 class II aldolase/adducin domain protein +FIG01369328 Flavoprotein monooxygenase +FIG01369329 FIG00385659: hypothetical protein +FIG01369336 Putative short chain dehydrogenase +FIG01369338 putative dnaK suppressor protein +FIG01369371 sensory transduction histidine kinase +FIG01369375 Putative LysR-family transcriptional regulator +FIG01369376 putative calcineurin superfamily phosphohydrolase +FIG01369381 two-component system sensor histidine kinase/response +FIG01369398 hypothetical protein +FIG01369405 phage putative head morphogenesis protein +FIG01369412 FIG00793642: hypothetical protein +FIG01369415 Lipoprotein yhcN precursor +FIG01369417 FIG00631527: hypothetical protein +FIG01369423 Two Component Transcriptional Regulator, LuxR family +FIG01369431 FIG00424607: hypothetical protein +FIG01369439 FIG00623134: hypothetical protein +FIG01369443 FIG00989661: hypothetical protein +FIG01369474 Zinc finger protein +FIG01369476 FIG00344121: hypothetical protein +FIG01369481 FIG00350574: hypothetical protein +FIG01369497 FIG00350520: hypothetical protein +FIG01369518 Thiol:disulfide interchange protein, DsbA family +FIG01369520 protein of unknown function DUF182 +FIG01369522 FIG00389047: hypothetical protein +FIG01369524 Phospho-beta-glucosidase, truncation +FIG01369539 Putative membrane protein +FIG01369560 Possible Photosystem II reaction centre T prot +FIG01369581 FIG00545624: hypothetical protein +FIG01369596 MutT/nudix family protein, putative +FIG01369605 Phenylalanyl-tRNA synthetase beta chain (EC 6.1.1.20) +FIG01369610 predicted integral membrane protein +FIG01369619 FIG00406139: hypothetical protein +FIG01369628 Lin2575 protein +FIG01369642 Cytochrome P450 126 +FIG01369650 FIG00733912: hypothetical protein +FIG01369669 hemagglutinin family protein +FIG01369680 putative metal-dependent membrane protease +FIG01369683 FIG01205959: hypothetical protein +FIG01369687 Uncharacterized protein ImpB +FIG01369697 Orf60 (f139) +FIG01369706 uncharacterized protein Vng0256h +FIG01369713 Probable multiple antibiotic resistance protein MarC +FIG01369723 FIG00764027: hypothetical protein +FIG01369725 Sterol desaturase-related protein +FIG01369733 Mll6465 protein +FIG01369735 FIG01119148: hypothetical protein +FIG01369745 Pseudouridine synthase:Pseudouridine synthase, Rlu +FIG01369750 FIG00350153: hypothetical protein +FIG01369806 FIG01069740: hypothetical protein +FIG01369809 lipopolysaccharide biosynthesis protein +FIG01369823 Partial tonB-like membrane protein encoded within prophage CP-933N +FIG01369825 FIG00921902: hypothetical protein +FIG01369829 FIG00765173: hypothetical protein +FIG01369843 FIG00560749: hypothetical protein +FIG01369854 FIG00388934: hypothetical protein +FIG01369866 FIG00533145: hypothetical protein +FIG01369870 Conserved hypothetical protein; putative xylose isomerase +FIG01369879 ORF_ID:all7547 unknown protein +FIG01369881 FIG00350948: hypothetical protein +FIG01369896 protein of unknown function DUF1016 +FIG01369903 FIG00409900: hypothetical protein +FIG01369917 OmpA/MotB domain precursor +FIG01369924 ACT domain-containing conserved hypothetical protein +FIG01369931 COG2369: Uncharacterized protein, homolog of phage Mu protein gp30 +FIG01369933 unknown protein encoded by prophage CP-933R +FIG01369934 CONSERVED 13E12 REPEAT FAMILY PROTEIN +FIG01369937 FIG00639948: hypothetical protein +FIG01369944 FIG00407113: hypothetical protein +FIG01369945 Predicted membrane-associated metal-dependent hydrolase +FIG01369951 guanylate cyclase-related protein +FIG01369953 FIG00697339: hypothetical protein +FIG01369964 FIG00765843: hypothetical protein +FIG01369968 glycosyl transferase domain protein +FIG01369985 oligopeptide ABC transporter substrate-binding protein +FIG01369989 Peptidase, S41 family +FIG01369996 Nitrogen fixation protein +FIG01370021 hypothetical protein clustered with LuxR +FIG01370053 putative membrane-bound metal-dependent hydrolase +FIG01370055 FAD dependent dehydrogenase +FIG01370058 FIG00403235: hypothetical protein +FIG01370061 Uncharacterized membrane protein, possible Na+ channel or pump +FIG01370075 FIG00350563: hypothetical protein +FIG01370085 transcription regulator, MerR family Atu3658 +FIG01370092 EXOPOLYSACCHARIDE PRODUCTION PROTEIN EXOQ +FIG01370095 Methyltransferase-related protein +FIG01370096 chromate transport protein, putative +FIG01370139 FIG00841311: hypothetical protein +FIG01370150 HTransmembrane sensor and HAMP domains precursor +FIG01370160 Outer surface protein precursor +FIG01370163 probable integral membrane protein NMA1898 +FIG01370168 Gll3214 protein +FIG01370173 FIG00468299: hypothetical protein +FIG01370175 Putative GTPases (G3E family) +FIG01370179 FIG00513634: hypothetical protein +FIG01370187 Pyruvate formate-lyase activating enzyme homolog +FIG01370200 Probable glycerol transport protein +FIG01370206 FIG01056702: hypothetical protein +FIG01370223 FIG00987553: hypothetical protein +FIG01370224 Quinoprotein glucose dehydrogenase( EC:1.1.5.2 ) +FIG01370234 Tetratricopeptide TPR_2 repeat protein +FIG01370236 Protein HI0246 precursor +FIG01370237 Dicarboxylate/amino acid:cation (Na+ or H+) symporter +FIG01370245 All0326 protein +FIG01370251 DUF82 domain-containing protein +FIG01370260 FIG00764424: hypothetical protein +FIG01370266 Translation initiation inhibitor +FIG01370286 FIG00763342: hypothetical protein +FIG01370319 Putative pyridine nucleotide-disulphide oxidoreductase +FIG01370320 voltage-gated potassium channel beta subunit +FIG01370327 O-antigen acetylase +FIG01370335 Glycine cleavage system regulatory protein +FIG01370337 FIG00520812: hypothetical protein +FIG01370354 putative Chromosome segregation ATPase +FIG01370362 leucine-rich repeat protein +FIG01370371 FIG00814791: hypothetical protein +FIG01370372 gas vesicle protein V +FIG01370382 FIG00633208: hypothetical protein +FIG01370421 FIG00658411: hypothetical protein +FIG01370433 putative ABC transporter, permease protein +FIG01370447 Putative hemagglutinin-related protein +FIG01370449 FIG01290742: hypothetical protein +FIG01370455 FIG00830966: hypothetical protein +FIG01370466 FIG00405150: hypothetical protein +FIG01370467 hypothetical protein +FIG01370468 ROrf8 +FIG01370469 FIG102772: hypothetical protein +FIG01370476 UPF0333 protein MJ0832.1 +FIG01370494 FIG00385484: hypothetical protein +FIG01370499 FIG00630903: hypothetical protein +FIG01370524 FIG00349946: hypothetical protein +FIG01370532 FIG00349950: hypothetical protein +FIG01370540 FIG00404901: hypothetical protein +FIG01370553 Regulatory protein luxO +FIG01370564 hypothetical protein +FIG01370578 Sua5/YciO/YrdC/YwlC family protein +FIG01370582 Protein P97 +FIG01370592 FIG00424536: hypothetical protein +FIG01370611 FIG00530502: hypothetical protein +FIG01370613 FIG00641337: hypothetical protein +FIG01370622 B. burgdorferi predicted coding region BBJ25 +FIG01370626 FIG00350174: hypothetical protein +FIG01370638 probable exported protease [EC:3.4.-.-] +FIG01370640 FIG00987385: hypothetical protein +FIG01370643 FIG00624348: hypothetical protein +FIG01370655 no significant homology. Putative N-terminal signal sequence and 2 putative transmembrane regions were found by PSORT. +FIG01370665 Outer membrane protein/porin +FIG01370667 FIG00517882: hypothetical protein +FIG01370674 FIG00883918: hypothetical protein +FIG01370711 Protein of unknown function DUF6 +FIG01370713 Cell division inhibitor-related protein +FIG01370717 possible Reverse transcriptase (RNA-dependent +FIG01370722 FIG00637987: hypothetical protein +FIG01370723 Bll2903 protein +FIG01370742 sugar ABC transporter permeases protein +FIG01370749 Small, acid-soluble spore protein gamma-type +FIG01370754 FIG00417751: hypothetical protein +FIG01370773 Amino acid transport protein +FIG01370782 Arylesterase-like protein slr1119 +FIG01370789 Probable sensor/response regulator hybrid +FIG01370793 B. burgdorferi predicted coding region BB0456 +FIG01370806 methyl-accepting chemotaxis transmembrane protein +FIG01370830 FIG00451338: hypothetical protein +FIG01370836 hypothetical protein, unknown function +FIG01370841 FIG00385607: hypothetical protein +FIG01370842 probable 3-demethylubiquinone-9 3-methyltransferase( EC:2.1.1.64 ) +FIG01370843 Conserved hypothetical protein Tiny-TM +FIG01370857 Pseudoazurin precursor +FIG01370858 Mlr1316 protein +FIG01370885 FIG00766719: hypothetical protein +FIG01370887 FIG00767377: hypothetical protein +FIG01370890 proton/glutamate symporter family protein, putative +FIG01370899 Cytochrome P450 130 +FIG01370903 Sugar ABC transporter, periplasmic sugar-binding protein USSDB1B +FIG01370908 FIG01236936: hypothetical protein +FIG01370934 Putative mannosyltransferase involved in polysaccharide biosynthesis +FIG01370938 probable membrane protein YPO0899 +FIG01370940 FIG00630204: hypothetical protein +FIG01370944 FIG00572419: hypothetical protein +FIG01370949 ADP-ribosylglycohydrolase +FIG01370968 Bsr4726 protein +FIG01370998 HLYD FAMILY SECRETION PROTEIN +FIG01371003 cytochrome-c oxidase chain III( EC:1.9.3.1 ) +FIG01371004 B. burgdorferi predicted coding region BBA44 +FIG01371035 FIG00640415: hypothetical protein +FIG01371046 Putative virulence determinant +FIG01371060 Outer membrane protein romA +FIG01371061 F420-dependent dehydrogenase +FIG01371066 Na+/alanine symporter +FIG01371067 BH0244 unknown +FIG01371069 mkiaa2009 protein +FIG01371086 FIG00624722: hypothetical protein +FIG01371095 FIG01166091: hypothetical protein +FIG01371099 Bll4413 protein +FIG01371116 Colicin-5 +FIG01371125 Putative chaperone protein +FIG01371129 Tail fiber assembly protein +FIG01371138 UDP-N-acetylglucosamine pyrophosphorylase related protein +FIG01371142 putative minor F1C fimbrial subunit precursor +FIG01371146 hypothetical protein Rv1119c +FIG01371147 iron(III) ABC transporter, solute-binding protein +FIG01371155 FIG00756804: hypothetical protein +FIG01371159 conserved hypothetical protein +FIG01371167 POSSIBLE CONSERVED MCE ASSOCIATED MEMBRANE PROTEIN +FIG01371168 putative transcription regulator, MerR family +FIG01371170 Methyl-accepting chemotaxis-like protein (chemotaxis sensory transducer) +FIG01371171 hypothetical protein +FIG01371206 bll4815; unknown protein +FIG01371234 Glutamyl-tRNA(Gln) amidotransferase subunit A-like protein +FIG01371240 protein of unknown function DUF1330 +FIG01371243 GlpM protein +FIG01371273 putative 4-hydroxy-2-ketovalerate aldolase +FIG01371280 Multi antimicrobial extrusion protein (Na(+)/drug antiporter), MATE family of MDR efflux pumps +FIG01371284 ABC-type amino acid transport, signal transduction systems, periplasmic component/domain +FIG01371289 FIG00410414: hypothetical protein +FIG01371316 putative coiled-coil protein +FIG01371329 FIG01532326: acyltransferase, putative +FIG01371330 Periplasmic aromatic aldehyde oxidoreductase, iron-sulfur subunit YagT +FIG01371342 FIG01238107: hypothetical protein +FIG01371348 FIG00243524: hypothetical protein +FIG01371352 FIG00425524: hypothetical protein +FIG01371354 Putative peptidoglycan-binding domain-containing protein +FIG01371357 secretion protein, putative +FIG01371368 DNA/RNA endonuclease G +FIG01371382 FIG00353613: hypothetical protein +FIG01371387 FIG00898013: hypothetical protein +FIG01371388 FIG00349370: hypothetical protein +FIG01371398 metal-dependent hydrolase +FIG01371401 arsenate reductase +FIG01371412 Glycosidases +FIG01371437 FIG00424414: hypothetical protein +FIG01371439 dihydrolipoyllysine-residue succinyltransferase( EC:2.3.1.61 ) +FIG01371459 prophage ps1 protein 02 +FIG01371464 hypothetical protein +FIG01371474 FIG005933: hypothetical protein +FIG01371476 AGL035Wp +FIG01371478 Putative thioesterase +FIG01371487 Endothelin-converting enzyme 1 (EC 3.4.24.71) +FIG01371499 Alginate biosynthesis protein AlgK precursor +FIG01371507 Glyoxalase/bleomycin resistance protein/dioxygenase superfamily protein +FIG01371525 Anti-sigma F factor antagonist (spoIIAA-2); Anti-sigma B factor antagonist RsbV +FIG01371534 FIG00912579: hypothetical protein +FIG01371541 FIG00527453: hypothetical protein +FIG01371550 putative heme biosynthesis protein +FIG01371564 putative sensory transduction histidine kinase +FIG01371568 Glyoxalase +FIG01371576 sulfite oxidase( EC:1.8.3.1 ) +FIG01371577 dioxygenase, putative +FIG01371581 protein ynjB domain protein +FIG01371584 FIG00404869: hypothetical protein +FIG01371586 arabinan endo-1,5-alpha-L-arabinosidase A +FIG01371588 branched-chain amino acid ABC tranpsorter, ATP binding protein +FIG01371599 Predicted phosphoesterase +FIG01371605 Uncharacterized conserved membrane protein, YOAK B.subtilis homolog +FIG01371616 FIG00404808: hypothetical protein +FIG01371622 Predicted signal transduction protein containing sensor and EAL domains +FIG01371623 NAD(P)H dehydrogenase +FIG01371641 Predicted sterol carrier protein +FIG01371646 tetracycline resistance protein +FIG01371648 FIG00639579: hypothetical protein +FIG01371659 FIG00414981: hypothetical protein +FIG01371664 FIG00849081: hypothetical protein +FIG01371667 iron(III) dicitrate-binding protein +FIG01371688 protein binding +FIG01371694 FIG01371694: hypothetical protein +FIG01371700 Secreted protein containing N-terminal Zinc-dependent carboxypeptidase related domain +FIG01371701 FIG00769670: hypothetical protein +FIG01371702 Potassium uptake protein, integral membrane component, KtrB +FIG01371711 ORF_ID:alr7661 unknown protein +FIG01371712 FIG00762592: hypothetical protein +FIG01371720 PE-PGRS family protein +FIG01371729 similarity to proline/betaine transporter +FIG01371732 pathogenicity domain protein +FIG01371742 chitosanase +FIG01371748 stage V sporulation protein K +FIG01371769 Acyl-CoA dehydrogenase (EC 1.3.8.7) +FIG01371771 FIG00768206: hypothetical protein +FIG01371783 FIG00850265: hypothetical protein +FIG01371808 FIG00356680: hypothetical protein +FIG01371812 Homolog of plant auxin-responsive GH3-like protein +FIG01371835 glucosyltransferase Lgt6 +FIG01371840 FIG00415043: hypothetical protein +FIG01371845 Multidrug resistance protein EbrB +FIG01371846 FIG00639808: hypothetical protein +FIG01371854 FIG00410669: hypothetical protein +FIG01371857 Hypothetical protein, CF-35 family +FIG01371870 FIG00847557: hypothetical protein +FIG01371877 Acyl-CoA thioesterase I +FIG01371891 FIG00426367: hypothetical protein +FIG01371907 Phenylpropionate dioxygenase and related ring-hydroxylating dioxygenases, large terminal subunit +FIG01371910 helix-turn-helix family protein +FIG01371925 FIG00828083: hypothetical protein +FIG01371926 Sulfite reductase, assimilatory-type (EC 1.8.-.-) +FIG01371950 Prophage PSPPH02, late control gene D protein +FIG01371953 opacity associated protein A +FIG01372002 Antirepressor +FIG01372003 Transport protein transmembrane +FIG01372014 FTR1 family protein +FIG01372023 FIG00347663: hypothetical protein +FIG01372031 putative phosphatidylinositol-4-phosphate 5-kinase +FIG01372043 outer membrane protein P2 +FIG01372046 Chromosome undetermined SCAF14611, whole genome shotgun sequence +FIG01372049 FIG00945100: hypothetical protein +FIG01372059 CG2839-PA +FIG01372060 FIG00629250: hypothetical protein +FIG01372083 Tail-specific protease (EC 3.4.21.-) +FIG01372085 corresponds to STY4824 from Accession AL513382: Salmonella typhi CT18 +FIG01372091 FIG00350276: hypothetical protein +FIG01372093 putative transcriptional regulator, LysR family +FIG01372094 FIG00259691: hypothetical protein +FIG01372107 FIG00409286: hypothetical protein +FIG01372110 Kil protein +FIG01372121 Thermostable carboxylesterase Est50 +FIG01372131 FIG00638905: hypothetical protein +FIG01372132 FIG00352414: hypothetical protein +FIG01372140 FIG00763908: hypothetical protein +FIG01372157 FIG00403811: hypothetical protein +FIG01372166 ROrf2 +FIG01372168 LysR-FAMILY transcriptional regulator +FIG01372172 putative small integral membrane protein +FIG01372181 acetyltransferase, GNAT family +FIG01372185 cell division protein mraZ +FIG01372198 Transcriptional regulator TvrR, TetR family +FIG01372199 FIG00350495: hypothetical protein +FIG01372206 FIG00826238: hypothetical protein +FIG01372211 FIG00763579: hypothetical protein +FIG01372238 3-oxoacyl-[acyl-carrier-protein] synthase 3 (EC 2.3.1.41) +FIG01372250 glutamine-binding periplasmic protein GlnH +FIG01372258 Invasin-like protein +FIG01372286 Caa(3)-type oxidase, subunit IV +FIG01372293 probable flagellar basal-body rod protein FlgB +FIG01372296 outer membrane porin, putative +FIG01372306 FIG00344011: hypothetical protein +FIG01372328 Protease II (EC 3.4.21.83) oligopeptidase family protein +FIG01372334 FIG00764771: hypothetical protein +FIG01372337 METHYLTRANSFERASE( EC:2.1.1.- ) +FIG01372345 Glycerol operon regulatory protein +FIG01372349 DUF1541 domain-containing protein +FIG01372354 McrBC restriction endonuclease system, McrB subunit, putative +FIG01372357 FIG01140028: hypothetical protein +FIG01372365 Exotoxin 15 +FIG01372370 possible Phosphoenolpyruvate carboxykinase +FIG01372371 FOG: Transposase and inactivated derivatives +FIG01372373 FIG00821184: hypothetical protein +FIG01372380 FIG00764493: hypothetical protein +FIG01372386 FIG00350295: hypothetical protein +FIG01372392 Putative NAGC-like transcriptional regulator +FIG01372399 Probable L-amino-acid oxidase (EC 1.4.3.2) +FIG01372464 FIG00823933: hypothetical protein +FIG01372466 FIG00814478: hypothetical protein +FIG01372488 COG4325: Predicted membrane protein +FIG01372491 FIG00380543: hypothetical protein +FIG01372493 SEC-independent protein translocase protein TatC +FIG01372497 Di-haem cytochrome c peroxidase +FIG01372506 probable ferredoxin FdxD +FIG01372508 FIG00766379: hypothetical protein +FIG01372510 Lactoylglutathione lyase (LGUL) family protein, diverged +FIG01372516 Putative ABC transport system, membrane protein +FIG01372517 Senescence marker protein-30 (SMP-30) +FIG01372520 NADH-dependent butanol dehydrogenase +FIG01372523 Phage-like element PBSX protein xkdB +FIG01372524 PZ17b +FIG01372525 FIG00404351: hypothetical protein +FIG01372533 FIG00390121: hypothetical protein +FIG01372546 PHB depolymerase +FIG01372562 Putative amino acid ABC transport system, membrane protein +FIG01372563 FIG00379816: hypothetical protein +FIG01372564 FIG00384911: hypothetical protein +FIG01372601 FIG00404540: hypothetical protein +FIG01372612 FIG01114997: hypothetical protein +FIG01372619 Transposase +FIG01372621 FIG00344977: hypothetical protein +FIG01372662 Glr4039 protein +FIG01372664 molybdenum cofactor biosynthesis protein B +FIG01372668 Hyaluronoglucosaminidase (EC 3.2.1.35) (Phage protein) +FIG01372669 FIG00385119: hypothetical protein +FIG01372672 Hopanoid-associated RND transporter, HpnN +FIG01372680 FIG00385641: hypothetical protein +FIG01372682 FIG00751035: hypothetical protein +FIG01372756 FIG011741: hypothetical protein +FIG01372757 ortholog of Bordetella pertussis (BX470248) BP2233 +FIG01372763 Transcriptional regulator, MarR family; Cinnamoyl ester hydrolase +FIG01372765 Proline dehydrogenase +FIG01372768 pep44b +FIG01372772 FIG00956286: hypothetical protein +FIG01372775 Serum paraoxonase/arylesterase 2 (EC 3.1.1.2) (EC 3.1.8.1) +FIG01372778 probable lipoprotein Cj0457c +FIG01372788 FIG00996939: hypothetical protein +FIG01372791 Membrane fusion-like protein +FIG01372798 FIG01117232: hypothetical protein +FIG01372802 Domain of unknown function DUF1791 +FIG01372813 YgiN protei involved in menadione metabolism +FIG01372822 FIG00765947: hypothetical protein +FIG01372823 Phosphoesterase (EC 3.1.-.-) +FIG01372825 FIG01035411: hypothetical protein +FIG01372830 ABC transporter ATP-binding protein XF2582 +FIG01372846 Probable ABC-transporter, permease +FIG01372850 Bacterial surface proteins containing Ig-like domains +FIG01372851 FIG00743894: hypothetical protein +FIG01372853 FIG00405208: hypothetical protein +FIG01372858 FIG00762721: hypothetical protein +FIG01372864 FIG00403362: hypothetical protein +FIG01372882 FIG00405277: hypothetical protein +FIG01372893 FIG00351292: hypothetical protein +FIG01372907 RepA protein homolog +FIG01372910 Limonene 1,2-monooxygenase +FIG01372919 FIG01238091: hypothetical protein +FIG01372927 probable integral membrane protein Cj0014c +FIG01372946 transcriptional regulators, LysR family +FIG01372954 Mov34/MPN/PAD-1 family protein +FIG01372986 CAAX amino terminal protease family protein (Ste24 endopeptidase) (EC 3.4.24.84) +FIG01372987 FIG00348406: hypothetical protein +FIG01372991 FIG01253573: hypothetical protein +FIG01372993 amino acid transporter-like protein +FIG01372999 DNA-binding protein BpH2 +FIG01373012 lytic transglycosylase +FIG01373027 FIG01070140: hypothetical protein +FIG01373039 B. burgdorferi predicted coding region BB0692 +FIG01373047 FIG01166500: hypothetical protein +FIG01373054 PAS/Putative two-component system sensor kinase +FIG01373062 FIG00947770: hypothetical protein +FIG01373101 FIG00380082: hypothetical protein +FIG01373120 glycosyl hydrolase, family 31 +FIG01373131 FIG00351467: hypothetical protein +FIG01373143 periplasmic serine protease +FIG01373147 Na+/proline symporter +FIG01373155 FIG00764932: hypothetical protein +FIG01373164 prophage LambdaBa02, site-specific recombinase, phage integrase family +FIG01373165 ATPases with chaperone activity, ATP-binding subunit +FIG01373181 FIG00768296: hypothetical protein +FIG01373182 FIG00768334: hypothetical protein +FIG01373187 entericidin B +FIG01373200 FIG00764466: hypothetical protein +FIG01373207 FIG00349148: hypothetical protein +FIG01373212 FIG00896423: hypothetical protein +FIG01373219 putative transport associated protein +FIG01373232 FIG00623886: hypothetical protein +FIG01373236 PTS system, mannitol-specific IIABC component (EIIABC-Mtl) (Mannitol- permease IIABC component) (Phosphotransferase enzyme II, ABC component) (EC 2.7.1.69) +FIG01373240 N-acetyl-D-glucosamine kinase (EC 2.7.1.59) +FIG01373241 FIG00817735: hypothetical protein +FIG01373278 hypothetical protein Rv1667c +FIG01373284 Possible SAM-dependent methyltransferase +FIG01373290 FIG00389187: hypothetical protein +FIG01373295 FIG00403682: hypothetical protein +FIG01373296 FIG00744617: hypothetical protein +FIG01373297 FIG00769063: hypothetical protein +FIG01373311 FIG00405539: hypothetical protein +FIG01373312 PROBABLE SUGAR-TRANSPORT INTEGRAL MEMBRANE PROTEIN SUGI +FIG01373316 NADH dehydrogenase subunit N +FIG01373342 FIG00406239: hypothetical protein +FIG01373353 M. homonis p80-related protein +FIG01373357 FIG00403315: hypothetical protein +FIG01373361 FIG00451569: hypothetical protein +FIG01373363 2,3-dihydroxybenzoate-AMP ligase (EC 2.7.7.58) [brucebactin] siderophore @ 2,3-dihydroxybenzoate-AMP ligase (EC 2.7.7.58) of siderophore biosynthesis +FIG01373396 FIG00624318: hypothetical protein +FIG01373397 hypothetical protein +FIG01373424 FIG00641555: hypothetical protein +FIG01373435 L-2,4-diaminobutyrate decarboxylase +FIG01373445 TonB +FIG01373459 FIG00767847: hypothetical protein +FIG01373501 COGs COG0697 +FIG01373505 FIG01218697: hypothetical protein +FIG01373511 FIG00514490: hypothetical protein +FIG01373520 FIG00516158: hypothetical protein +FIG01373527 FIG00450593: hypothetical protein +FIG01373528 Nucleotidyltransferase +FIG01373536 ribosomal protein serine acetyltransferase +FIG01373558 putative general secretion pathway protein [KO:K02463] +FIG01373559 Mll4602 protein +FIG01373569 mutator mutT protein +FIG01373574 Possible MDR-type permease, YQJV B.subtilis ortholog +FIG01373581 FIG00350184: hypothetical protein +FIG01373588 CTP synthase (UTP-ammonia lyase) +FIG01373606 HEAT +FIG01373609 FIG00622918: hypothetical protein +FIG01373613 FIG01205168: hypothetical protein +FIG01373628 relaxation protein +FIG01373650 FIG00404450: hypothetical protein +FIG01373654 PROBABLE SIGNAL PEPTIDE PROTEIN +FIG01373659 Lysozyme (EC 3.2.1.17) +FIG01373674 putative FAD dependent oxidoreductase +FIG01373678 no significant database hits +FIG01373679 FIG00822893: hypothetical protein +FIG01373690 Phosphosugar isomerase / Mannitol-1-phosphate 5-dehydrogenase (EC 1.1.1.17) +FIG01373709 Two-component response regulator +FIG01373711 putative peptidoglycan bound protein (LPXTG motif) +FIG01373721 N-acetylglucosamine kinase bacterial type predicted (EC 2.7.1.59) homolog / Transcriptional regulator +FIG01373734 Conjugative transfer gene TrsE homolog, ATPase +FIG01373742 DnaJ related chaperone +FIG01373744 General stress protein 17M +FIG01373745 FIG00385256: hypothetical protein +FIG01373751 FIG00389110: hypothetical protein +FIG01373781 hypothetical protein +FIG01373805 FIG00959952: hypothetical protein +FIG01373818 Anaerobic C4-dicarboxylate transporter +FIG01373820 FIG00350150: hypothetical protein +FIG01373822 FIG00351945: hypothetical protein +FIG01373827 FIG00769040: hypothetical protein +FIG01373854 FIG00639234: hypothetical protein +FIG01373870 similar to hypothetical protein (predicted) +FIG01373889 FIG00403729: hypothetical protein +FIG01373907 hypothetical protein +FIG01373912 putative sugar ABC transporter, binding protein +FIG01373931 Serine/threonine-protein kinase PknD (EC 2.7.11.1) +FIG01373933 hypothetical protein +FIG01373937 Superfamily II DNA or RNA helicase +FIG01373946 putative NtrP protein +FIG01373947 Uncharacterized protein conserved in bacteria +FIG01373957 FIG00350619: hypothetical protein +FIG01373968 ABC transport protein, ATP-binding component +FIG01373972 Glutamine ABC transporter, substrate binding and permease protein +FIG01373976 ACT domain containing transcriptional regulators, related to gcvR of E.coli +FIG01373991 FIG00517932: hypothetical protein +FIG01373998 ortholog of Bordetella pertussis (BX470248) BP1188 +FIG01374003 FIG00589271: hypothetical protein +FIG01374004 FIG00633848: hypothetical protein +FIG01374006 Uncharacterized 55.3 kDa protein in gtrB 5'region (ORF485) +FIG01374014 FIG00426633: hypothetical protein +FIG01374023 FIG00424742: hypothetical protein +FIG01374027 adenine phosphoribosyltransferase +FIG01374046 Pai1 protein +FIG01374069 Sugar phosphate isomerases/epimerases +FIG01374073 FIG00674285: hypothetical protein +FIG01374099 FIG01207620: hypothetical protein +FIG01374104 FIG00639244: hypothetical protein +FIG01374127 FIG00403146: hypothetical protein +FIG01374131 FIG00350781: hypothetical protein +FIG01374132 Acetolactate synthase, large subunit (EC 2.2.1.6) +FIG01374158 CBS-domain-containing membrane protein +FIG01374159 sodium:neurotransmitter symporter family protein +FIG01374174 FIG00945577: hypothetical protein +FIG01374177 FIG00405034: hypothetical protein +FIG01374180 FIG00407786: hypothetical protein +FIG01374188 FIG00749320: hypothetical protein +FIG01374208 FIG00407564: hypothetical protein +FIG01374226 Cystine transport system permease protein +FIG01374237 FIG00352230: hypothetical protein +FIG01374240 FIG00350021: hypothetical protein +FIG01374244 putative methylase of polypeptide chain release factor +FIG01374253 FIG00628187: hypothetical protein +FIG01374254 FIG00513093: hypothetical protein +FIG01374257 FIG00848423: hypothetical protein +FIG01374278 FIG00769621: hypothetical protein +FIG01374324 Protein traM +FIG01374326 Putative peptide ABC-transport system periplasmic peptide-binding protein +FIG01374329 FIG00837007: hypothetical protein +FIG01374349 Leucine-responsive regulatory protein +FIG01374372 Mlr5159 protein +FIG01374380 Flavodoxins +FIG01374417 Phage holin +FIG01374440 TETRATRICOPEPTIDE REPEAT FAMILY PROTEIN +FIG01374455 FIG00354662: hypothetical protein +FIG01374458 Methyl-accepting chemotaxis protein II +FIG01374464 hypothetical protein +FIG01374465 Uncharacterized protein MJ1614 +FIG01374476 Forkhead-associated +FIG01374486 FIG00509877: hypothetical protein +FIG01374489 cAMP-binding protein - catabolite gene activator and regulatory subunit of cAMP-dependent protein kinase +FIG01374501 FIG00425041: hypothetical protein +FIG01374540 syc2260_c +FIG01374546 DNA topology modulation protein FlaR +FIG01374560 beta-lactamase II +FIG01374565 2,4-dihydroxyhept-2-ene-1,7-dioic acid aldolase (EC 4.1.2.n4) +FIG01374581 putative ATP/GTP binding protein +FIG01374588 ATP synthase F1, delta subunit +FIG01374597 FIG00750857: hypothetical protein +FIG01374603 Mannose-6-phosphate isomerase +FIG01374607 Nonspecific acid phosphatase precursor (EC 3.1.3.2) +FIG01374614 membrane protein ribonuclease BN-like family protein +FIG01374622 Xaa-Pro dipeptidyl-peptidase +FIG01374645 Putaive Fe-regulated protein B +FIG01374649 Sodium/glutamate symporter +FIG01374658 Peptidase M20:Peptidase M20 +FIG01374661 Chaperone protein hscC (Hsc62) +FIG01374685 probable peptide ABC transporter,substrate-binding protein +FIG01374700 FIG00896613: hypothetical protein +FIG01374708 Dipeptidase (EC 3.4.-.-) +FIG01374722 high molecular weight glutenin x-type subunit +FIG01374735 esterase/lipase/thioesterase family active site:lipase (Class 3) +FIG01374736 FIG00598621: hypothetical protein +FIG01374739 POSSIBLE RESOLVASE +FIG01374757 COG1306 predicted glycoside hydrolase +FIG01374764 Putative hydrolase or acyltransferase +FIG01374786 OmpA/MotB precursor +FIG01374787 FIG00823069: hypothetical protein +FIG01374796 Lipoprotein LppX +FIG01374811 Erythromycin esterase +FIG01374838 sodium/hydrogen exchanger family protein +FIG01374849 O-antigen polymerase precursor +FIG01374872 Carboxylesterase family protein +FIG01374876 prophage LambdaBa03, terminase, large subunit, putative +FIG01374891 Putative multicopper oxidases +FIG01374892 nucleoprotein/polynucleotide-associated enzyme +FIG01374894 Na(+)-linked D-alanine glycine permease +FIG01374899 FIG00638280: hypothetical protein +FIG01374915 Probable zinc protease +FIG01374916 FIG00404078: hypothetical protein +FIG01374919 Mannose-1-phosphate guanylyltransferase/mannose-6-phosphate isomerase( EC:2.7.7.22 ) +FIG01374962 FIG036251: Hypothetical protein +FIG01374966 predicted DNA-binding transcriptional regulator +FIG01374970 putative UV damage endonuclease +FIG01374984 Glucosyltransferase +FIG01374995 orf; Unknown function +FIG01374999 WbjC +FIG01375022 YkuD domain-containing hypothetical lipoprotein +FIG01375038 putative decarboxylase +FIG01375041 FIG00409075: hypothetical protein +FIG01375050 CATION EFFLUX SYSTEM (CZCB-LIKE) +FIG01375056 Putative chemotactic transducer +FIG01375145 FIG00351525: hypothetical protein +FIG01375147 ATP synthase I chain( EC:3.6.3.14 ) +FIG01375149 FIG01068016: hypothetical protein +FIG01375153 Putative secretion ATPase +FIG01375162 FIG00409255: hypothetical protein +FIG01375178 hypothetical protein +FIG01375180 carbonic anhydrase (gamma family Zn(II)-dependent enzymes) +FIG01375197 FIG00450416: hypothetical protein +FIG01375199 Possible amidase enhancer +FIG01375203 Lmo0881 homolog, only in Listeria +FIG01375212 FIG00415464: hypothetical protein +FIG01375242 FIG00390034: hypothetical protein +FIG01375251 FIG00765347: hypothetical protein +FIG01375255 FIG00351971: hypothetical protein +FIG01375256 Ortholog of S. aureus MRSA252 (BX571856) SAR1809a Doubtful CDS +FIG01375272 FIG00350054: hypothetical protein +FIG01375311 LipH +FIG01375314 Hypothetical sugar kinase, ROK family +FIG01375323 CI-like repressor, phage associated +FIG01375325 cellulose-binding family II +FIG01375332 EMAP domain +FIG01375359 FIG00409515: hypothetical protein +FIG01375366 Protein containing cell-adhesion domain +FIG01375372 putative virK protein +FIG01375379 FIG00763635: hypothetical protein +FIG01375407 FIG00384861: hypothetical protein +FIG01375408 Acetyltransferase, including N-acetylase of ribosomal proteins +FIG01375409 Putative acetyltransferase (EC 2.3.1.-) +FIG01375413 Cell wall-associated hydrolase +FIG01375421 Sll0997 protein +FIG01375448 Proline-rich antigen homolog +FIG01375449 FIG00624845: hypothetical protein +FIG01375453 FIG00821119: hypothetical protein +FIG01375460 FIG00641369: hypothetical protein +FIG01375478 FIG00350868: hypothetical protein +FIG01375483 Response regulator (OmpR) +FIG01375508 FIG00817646: hypothetical protein +FIG01375513 Dipeptide transport periplamic dipeptide-binding protein DppA +FIG01375521 CmaB +FIG01375522 pertactin family virulence factor/autotransporter +FIG01375529 syc0719_c +FIG01375533 FIG00628154: hypothetical protein +FIG01375537 FIG00838924: hypothetical protein +FIG01375538 FIG00764479: hypothetical protein +FIG01375555 endoglucanase, family 26; S-layer domain protein +FIG01375564 possible beta-lactamase +FIG01375565 FIG01201812: hypothetical protein +FIG01375571 electron acceptor reductase/NADH oxidase, FAD binding, iron-sulfur cluster binding site( EC:1.3.1.34 ) +FIG01375579 virion morphogenesis protein +FIG01375584 Hydrolase, alpha/beta fold family protein, At1g52510/AT4G12830 homolog, group4 +FIG01375606 FIG00403615: hypothetical protein +FIG01375635 Phage head-tail adaptor +FIG01375644 Integrase regulator RinA +FIG01375665 DNA mismatch repair protein MutS homolog, MutS3 +FIG01375668 B. burgdorferi predicted coding region BBB26 +FIG01375674 probable phage protein YPO2116 +FIG01375678 FIG00356457: hypothetical protein +FIG01375679 Stage 0 sporulation regulatory protein +FIG01375685 FIG00675308: hypothetical protein +FIG01375687 Phage protein +FIG01375696 FIG00639258: hypothetical protein +FIG01375729 FIG00710798: hypothetical protein +FIG01375745 Coiled coil domain protein +FIG01375768 Vanadium haloperoxidase (EC 1.11.1.-) +FIG01375772 FIG00848998: hypothetical protein +FIG01375789 hypothetical protein within prophage phiN315 +FIG01375791 FIG01204168: hypothetical protein +FIG01375795 FIG00765395: hypothetical protein +FIG01375805 Ubiquinone/menaquinone biosynthesis methyltransferase UbiE (EC 2.1.1.-) +FIG01375806 Hemagglutinin/hemolysin-related protein precursor +FIG01375821 Activator of osmoprotectant transporter ProP +FIG01375825 FIG00624475: hypothetical protein +FIG01375828 Type II restriction enzyme BglI (EC 3.1.21.4) (Endonuclease BglI) (R.BglI) +FIG01375830 Alcohol dehydrogenase( EC:1.1.1.1 ) +FIG01375841 FIG00385620: hypothetical protein +FIG01375842 FIG00672255: hypothetical protein +FIG01375847 conjugative transposon hypothetical protein +FIG01375874 FIG00764364: hypothetical protein +FIG01375893 similar to PID:1209841 percent identity: 94.27; identified by sequence similarity; putative +FIG01375896 FIG00555019: hypothetical protein +FIG01375911 alternate gene name: ipa-46d +FIG01375914 Fructose-2,6-bisphosphatase +FIG01375919 FIG01018132: hypothetical protein +FIG01375922 IS, phage, Tn; Transposon-related functions +FIG01375962 Histidine kinase sensor of two-component system +FIG01375965 FIG01132094: hypothetical protein +FIG01375969 FIG00350393: hypothetical protein +FIG01375976 FIG00977328: hypothetical protein +FIG01375985 Putative amino acid activating enzyme (EC 6.3.2.-) +FIG01375990 FIG00352949: hypothetical protein +FIG01375992 FIG00352950: hypothetical protein +FIG01376027 PROTEIN DISULPHIDE ISOMERASE +FIG01376032 protein-L-isoaspartate O-methyltransferase( EC:2.1.1.77 ) +FIG01376039 FIG00899379: hypothetical protein +FIG01376062 putative domain of unknown function +FIG01376077 putative cI-like repressor - phage associated +FIG01376089 Xylosidase/arabinosidase +FIG01376095 Aldose 1-epimerase precursor +FIG01376113 FIG00623865: hypothetical protein +FIG01376115 Poly(3-hydroxybutyrate) depolymerase precursor (EC 3.1.1.75) +FIG01376123 putative ATP-dependent DNA helicase +FIG01376137 Modification methylase LlaI (EC 2.1.1.72) +FIG01376145 Phosphoenolpyruvate carboxykinase (ATP) +FIG01376150 Type IV pilin PilA +FIG01376151 Protein of unknown function DUF599 +FIG01376161 sigma-70, region 4 +FIG01376168 FIG00291025: hypothetical protein +FIG01376180 Surface adhesion protein +FIG01376184 probable periplasmic protein NMA1059 +FIG01376197 Bundle-forming pilus protein BfpM +FIG01376199 Serine protein kinase +FIG01376204 FIG01225126: hypothetical protein +FIG01376212 FIG00427460: hypothetical protein +FIG01376235 O-demethylpuromycin-O-methyltransferase (EC 2.1.1.38) +FIG01376245 amino-acid biosynthesis +FIG01376253 FIG00945536: hypothetical protein +FIG01376257 FIG01115688: hypothetical protein +FIG01376269 sporulation sigma factor SigG +FIG01376270 FIG01161222: hypothetical protein +FIG01376278 COG1914: Mn2+ and Fe2+ transporters of the NRAMP family +FIG01376298 FIG01116319: hypothetical protein +FIG01376332 FIG00385185: hypothetical protein +FIG01376338 putative TYPE II DNA MODIFICATION ENZYME (METHYLTRANSFERASE) +FIG01376355 cell wall-associated serine proteinase( EC:3.4.21.96 ) +FIG01376367 putative neutral zinc metalloprotease +FIG01376368 Conjugal transfer protein TraC +FIG01376376 Channel-forming transporter/cytolysins activator of TpsB family +FIG01376385 ABC-type bacteriocin/lantibiotic exporters, contain an N-terminal double-glycine peptidase domain +FIG01376386 peptidase S1 and S6, chymotrypsin/Hap +FIG01376403 FIG00711189: hypothetical protein +FIG01376406 FIG00816738: hypothetical protein +FIG01376430 FIG00875965: hypothetical protein +FIG01376436 FIG00410772: hypothetical protein +FIG01376437 Pleiotropic regulatory protein homolog +FIG01376441 Type II restriction enzyme DpnI (EC 3.1.21.4) +FIG01376445 FIG01241677: hypothetical protein +FIG01376464 Osmoprotection protein ProWX +FIG01376465 Possible copper-binding protein +FIG01376469 Gll3516 protein +FIG01376492 probable Na+/H+ antiporter +FIG01376496 putative; ORF located using Glimmer/Genemark +FIG01376503 sulfite dehydrogenase( EC:1.7.99.4 ) +FIG01376504 Putative membrane spanning protein +FIG01376518 B. burgdorferi predicted coding region BB0082 +FIG01376520 Extracellular serine protease +FIG01376525 hypothetical protein +FIG01376537 FIG00343820: hypothetical protein +FIG01376540 ABC transporter, fused ATPase and inner membrane subunits (EC 3.6.3.27) +FIG01376546 haloacid dehalogenase-like protein +FIG01376569 FIG00351037: hypothetical protein +FIG01376584 Cyanuric acid amidohydrolase( EC:3.5.2.15 ) +FIG01376587 FIG00407024: hypothetical protein +FIG01376588 protein of unknown function DUF82 +FIG01376590 SidG +FIG01376606 Amidohydrolase AmhX +FIG01376619 FIG00764659: hypothetical protein +FIG01376632 Protein of unknown function DUF1328 +FIG01376635 surface exclusion protein +FIG01376637 beta-ketoacyl synthase, putative +FIG01376646 alkylhydroperoxidase like protein, AhpD family +FIG01376661 FIG00768190: hypothetical protein +FIG01376672 hypothetical protein +FIG01376673 flavin-binding monooxygenase +FIG01376682 GldC +FIG01376709 protein of unknown function DUF121 +FIG01376712 11.6 kDa putative exported protein +FIG01376726 ortholog of Bordetella pertussis (BX470248) BP2782 +FIG01376736 CHLORAMPHENICOL-SENSITIVE PROTEIN RARD +FIG01376763 FIG00766464: hypothetical protein +FIG01376775 HipA N-terminal domain protein +FIG01376777 ISSoc6, orfB transposase +FIG01376796 Similar to (S)-2,3-di-O-geranylgeranylglyceryl phosphate synthase +FIG01376800 CHLTR possible phosphoprotein +FIG01376814 Glutamate decarboxylase (EC 4.1.1.15) +FIG01376815 possible Integrin alpha cytoplasmic region +FIG01376829 FIG00424171: hypothetical protein +FIG01376833 Acetylxylan esterase related enzyme +FIG01376846 putative ABC-type antimicrobial peptide transporter, permease component +FIG01376851 Uncharacterized protein, possible ynzC B.subtilis homolog +FIG01376862 FIG00768109: hypothetical protein +FIG01376866 FIG01046629: hypothetical protein +FIG01376871 putative anti-sigma-28 factor, FlgM +FIG01376873 FIG00409210: hypothetical protein +FIG01376881 FIG00361583: hypothetical protein +FIG01376885 FIG00351818: hypothetical protein +FIG01376887 FIG01119268: hypothetical protein +FIG01376892 FIG00643895: hypothetical protein +FIG01376944 FIG00528440: hypothetical protein +FIG01376950 FIG00838542: hypothetical protein +FIG01376954 Peptidase S15 +FIG01376955 FIG00632379: hypothetical protein +FIG01376968 Flagellin hook IN motif family +FIG01376989 FIG00534730: hypothetical protein +FIG01376991 B. burgdorferi predicted coding region BB0707 +FIG01377007 FIG00411376: hypothetical protein +FIG01377008 ABC-type dipeptide/oligopeptide/nickel transport system, permease component +FIG01377014 histone-like protein +FIG01377016 Porin thermoregulatory protein envY +FIG01377048 Fe-S cluster protein +FIG01377076 Mannosyltransferase (EC 2.4.1.-) +FIG01377083 FIG00390367: hypothetical protein +FIG01377091 FIG00351867: hypothetical protein +FIG01377115 FIG00763257: hypothetical protein +FIG01377116 Amino acid/metabolite permease +FIG01377118 Glucosyltransferase-S (EC 2.4.1.5) +FIG01377126 hypothetical protein +FIG01377128 FIG01201766: hypothetical protein +FIG01377131 FIG00520913: hypothetical protein +FIG01377140 Gll2182 protein +FIG01377149 Chromosome assembly-related protein +FIG01377158 transcriptional regulator, putative catabolite control protein A +FIG01377159 Methyltransferase corrinoid protein +FIG01377160 type-2Aa cytolytic delta-endotoxin +FIG01377161 putative high light inducible protein +FIG01377182 FKBP-type peptidyl-prolyl cis-trans isomerase (PPIase) precursor (EC 5.2.1.8) +FIG01377186 Phage lysin, glycosyl hydrolase, family 25 +FIG01377187 Probable dipeptidase (EC 3.4.-.-) +FIG01377202 putative F1 chaperone protein +FIG01377204 Probable lipase/esterase +FIG01377206 PROBABLE BACTERIOPHAGE-RELATED PROTEIN +FIG01377207 FIG01109006: hypothetical protein +FIG01377208 aminoglycoside N(6')acetyltransferase +FIG01377212 dihydrolipoamide S-acetyltransferase +FIG01377222 FlhB domain protein +FIG01377251 FIG00899038: hypothetical protein +FIG01377253 redox-active disulfide protein 2 +FIG01377254 DNA relaxation protein homolog +FIG01377264 FIG00348439: hypothetical protein +FIG01377267 Uncharacterized homolog of the cytoplasmic domain of flagellar protein FhlB +FIG01377275 Transposase, mutator type +FIG01377279 signal peptide peptidase SppA, 36K type +FIG01377280 ABC transporter, possibly multidrug efflux +FIG01377281 6-aminohexanoate-dimer hydrolase (EC 3.5.1.46) +FIG01377282 Phage tail sheath protein FI +FIG01377294 FIG01113945: hypothetical protein +FIG01377296 FIG00410054: hypothetical protein +FIG01377302 FIG00427659: hypothetical protein +FIG01377307 Uncharacterized protein yjcP +FIG01377310 hypothetical protein +FIG01377316 FIG00423810: hypothetical protein +FIG01377325 integrase +FIG01377353 FIG00410209: hypothetical protein +FIG01377365 ORF17 +FIG01377381 FIG00403985: hypothetical protein +FIG01377393 Degenerate transposase +FIG01377400 FIG01241959: hypothetical protein +FIG01377411 putative nucleotide sugar-1-phosphate transferase +FIG01377430 SdrA +FIG01377440 FIG00350125: hypothetical protein +FIG01377441 Multidrug resistance integral membrane efflux protein EmrB +FIG01377448 FIG00538509: hypothetical protein +FIG01377459 Hemolysin BL lytic component L1 +FIG01377462 iron-sulfur protein +FIG01377473 bicyclomycin resistance protein +FIG01377479 FUPA30 P-type ATPase; putative cation-transporting ATPase pacL( EC:3.6.3.- ) +FIG01377490 FIG00350101: hypothetical protein +FIG01377505 adenine/cytosine DNA methyltransferase +FIG01377521 PASTA domain-containing protein +FIG01377525 FIG00638456: hypothetical protein +FIG01377535 probable membrane associated metalloprotease +FIG01377550 FIG01202528: hypothetical protein +FIG01377590 DNA polymerase III epsilon subunit (dnaQ) +FIG01377599 Possible Elongation factor Tu domain 2 +FIG01377602 Ferredoxin thioredoxin reductase, alpha chain +FIG01377620 bacteriocin ABC transporter, putative +FIG01377632 FIG01117957: hypothetical protein +FIG01377643 Dihydrofolate reductase +FIG01377662 FIG00469334: hypothetical protein +FIG01377685 Ferredoxin domain containing protein +FIG01377696 FIG00529984: hypothetical protein +FIG01377698 Oligopeptide-binding protein AppA +FIG01377714 FIG00633005: hypothetical protein +FIG01377720 FIG00423937: hypothetical protein +FIG01377727 ATP synthase F1, epsilon subunit +FIG01377729 Predicted nucleic-acid-binding protein +FIG01377743 Hexosyltransferase homolog +FIG01377748 Orf, hypothetical +FIG01377751 Probable lipoprotein signal peptide +FIG01377753 Cell division protein ftsQ +FIG01377754 FIG00847691: hypothetical protein +FIG01377757 Cytosolic IMP-GMP specific 5'-nucleotidase +FIG01377759 transcriptional regulator, GntR family protein +FIG01377770 FIG00641924: hypothetical protein +FIG01377774 FIG00347665: hypothetical protein +FIG01377775 FIG01236523: hypothetical protein +FIG01377777 multidrug resistance protein B +FIG01377788 FIG00765432: hypothetical protein +FIG01377801 Porin thermoregulatory protein envY +FIG01377828 FIG00407145: hypothetical protein +FIG01377850 CDP-alcohol phosphatidyltransferase family protein +FIG01377851 FIG00404164: hypothetical protein +FIG01377875 FIG00769299: hypothetical protein +FIG01377884 FIG00768795: hypothetical protein +FIG01377893 Capsular polysaccharide biosynthesis homolog ywqC +FIG01377898 FIG00640912: hypothetical protein +FIG01377905 hypothetical protein +FIG01377924 Predicted conserved membrane protein, possible homolog of CAAX-like membrane endopeptidase +FIG01377939 FIG01244313: hypothetical protein +FIG01377946 FIG00675346: hypothetical protein +FIG01377950 COG1587: Uroporphyrinogen-III synthase +FIG01377952 Glutathione S-transferase +FIG01377958 FIG00766058: hypothetical protein +FIG01377975 probable aldehyde dehydrogenase (NAD+)( EC:1.2.1.3 ) +FIG01377980 FIG00415704: hypothetical protein +FIG01377982 Tn5252, Orf 9 protein +FIG01377983 COG2606: Uncharacterized conserved protein +FIG01377986 FIG00472587: hypothetical protein +FIG01377997 InterPro IPR002173 COGs COG0524 +FIG01378017 Epidermin leader peptide processing serine protease epiP precursor (EC 3.4.21.-) +FIG01378020 putative trp repressor binding protein +FIG01378044 FIG00623858: hypothetical protein +FIG01378048 CDS_ID OB2726 +FIG01378049 Bona fide RidA/YjgF/TdcF/RutC subgroup +FIG01378055 FIG00402683: hypothetical protein +FIG01378058 Prevent-host-death family protein +FIG01378065 FIG00766135: hypothetical protein +FIG01378070 RidA/YER057c/UK114 superfamily, group 7, YjgH-like protein +FIG01378072 FIG00425722: hypothetical protein +FIG01378076 transcriptional regulator, AsnC family protein +FIG01378081 FIG01020807: hypothetical protein +FIG01378117 Putative lipoprotein precursor +FIG01378123 FIG00766234: hypothetical protein +FIG01378132 Propeptide, PepSY amd peptidase M4 precursor +FIG01378136 FIG01167063: hypothetical protein +FIG01378142 FIG01118125: hypothetical protein +FIG01378150 Protein F-related protein +FIG01378152 SAM-dependent methyltransferase MJ0086 +FIG01378159 Serine/threonine protein kinase +FIG01378229 FIG00350723: hypothetical protein +FIG01378236 acyl CoA thioester hydrolase family protein +FIG01378242 Capsule biosynthesis protein capA +FIG01378244 FIG01069086: hypothetical protein +FIG01378245 mobilization protein BmgB +FIG01378249 possible Phosphatidylinositol-specific phospho +FIG01378251 FIG00263499: hypothetical protein +FIG01378259 korA protein +FIG01378274 FIG01009127: hypothetical protein +FIG01378299 SidD +FIG01378301 FIG01235209: hypothetical protein +FIG01378324 FIG01150030: hypothetical protein +FIG01378327 FIG00388952: hypothetical protein +FIG01378338 FIG00351095: hypothetical protein +FIG01378342 HlyB/MsbA family ABC transporter +FIG01378353 Polysulphide reductase, NrfD +FIG01378365 Outer membrane protein P2 precursor (OMP P2) +FIG01378372 Outer membrane protein C precursor +FIG01378393 FIG00623479: hypothetical protein +FIG01378404 IMP dehydrogenase/GMP reductase +FIG01378407 hypothetical protein, putative phage associated protein +FIG01378422 ATP binding cassette (ABC) transporter homolog +FIG01378440 YCII-related protein +FIG01378451 sugar transport system (permease) +FIG01378455 M23/M37 peptidase/aminotransferase, class III +FIG01378457 FIG01046913: hypothetical protein +FIG01378463 FIG00408158: hypothetical protein +FIG01378468 putative Na(+) H(+) antiporter subunit F +FIG01378480 FIG00675508: hypothetical protein +FIG01378502 FIG00350151: hypothetical protein +FIG01378514 Magnesium citrate secondary transporter +FIG01378525 FIG00403719: hypothetical protein +FIG01378529 FIG01378529: Probable response regulator +FIG01378537 FIG00380296: hypothetical protein +FIG01378541 Gas vesicle protein GvpJ +FIG01378558 FIG00551625: hypothetical protein +FIG01378562 FIG00920059: hypothetical protein +FIG01378565 alpha-ketoglutarate permease +FIG01378572 FIG00408816: hypothetical protein +FIG01378575 transporter, monovalent cation:proton antiporter-2 (CPA2) family +FIG01378576 putative AIP processing-secretion protein +FIG01378605 thioredoxin family protein, putative +FIG01378606 FIG00389577: hypothetical protein +FIG01378636 Lipopolysaccharide core biosynthesis glycosyl transferase +FIG01378637 FIG00768693: hypothetical protein +FIG01378641 FIG00405167: hypothetical protein +FIG01378643 FIG00743815: hypothetical protein +FIG01378656 putative transposase of insertion sequence ISRm2011-2, orfA protein +FIG01378671 FIG00639566: hypothetical protein +FIG01378675 zinc uptake transporter +FIG01378700 FIG00604134: hypothetical protein +FIG01378706 FIG00355863: hypothetical protein +FIG01378714 propionate catabolism operon regulatory protein +FIG01378731 FIG00350978: hypothetical protein +FIG01378740 Invasin domain protein +FIG01378741 putative DNA-damage-inducible protein F +FIG01378751 FIG01241449: hypothetical protein +FIG01378757 putative sugar metabolism repressor +FIG01378761 ATP-dependent DNA helicase, UvrD/REP family +FIG01378766 FIG00939469: hypothetical protein +FIG01378770 FIG00388556: hypothetical protein +FIG01378789 FIG00763260: hypothetical protein +FIG01378790 FIG00412904: hypothetical protein +FIG01378807 NADH oxidase, putative +FIG01378812 TRANSPORTER, MFS superfamily +FIG01378814 FIG00353811: hypothetical protein +FIG01378827 ORF41-1 +FIG01378835 FIG00356226: hypothetical protein +FIG01378841 FIG00379712: hypothetical protein +FIG01378859 Tyrosine type site-specific recombinase, probable regulator for PS locus +FIG01378872 FIG00353278: hypothetical protein +FIG01378886 Ankyrin repeat domain protein 28 +FIG01378887 FIG00361864: hypothetical protein +FIG01378890 FIG01134610: hypothetical protein +FIG01378909 FIG00769434: hypothetical protein +FIG01378924 FIG00750317: hypothetical protein +FIG01378937 Acyl-CoA dehydrogenase (EC 1.3.8.7) +FIG01378953 putative tautomerase protein +FIG01378955 Possible nucleotidyltransferase +FIG01379019 FIG00814768: hypothetical protein +FIG01379026 Acyl-CoA thioester hydrolase (EC 3.1.2.-) +FIG01379039 FIG00424666: hypothetical protein +FIG01379055 containing ATPase domain +FIG01379064 hypothetical protein +FIG01379065 TcpE +FIG01379068 iron(III) dicitrate transport ATP-binding protein +FIG01379083 3-oxoacyl-[acyl-carrier protein] reductase (EC 1.1.1.100) homolog +FIG01379087 Chaperone protein fanE precursor +FIG01379092 FIG00849544: hypothetical protein +FIG01379100 LacI family transcriptional regulator +FIG01379101 COG1629: Outer membrane receptor proteins, mostly Fe transport +FIG01379102 FIG00532582: hypothetical protein +FIG01379112 ATP synthase I +FIG01379125 Hypothetical protein, phi-ETA orf16 homolog [SA bacteriophages 11, Mu50B] +FIG01379141 Serine/threonine protein phosphatase I +FIG01379150 Acid phosphatase, class B +FIG01379170 FIG00388501: hypothetical protein +FIG01379178 FIG01109320: hypothetical protein +FIG01379179 oligoendopeptidase, M3 family +FIG01379185 FIG00361866: hypothetical protein +FIG01379187 Uncharacterized protein Rv1829/MT1877 +FIG01379214 putative PARALOG OF HpaA +FIG01379217 WD40-like Beta Propeller +FIG01379218 FIG01166332: hypothetical protein +FIG01379219 Protein GlcG +FIG01379224 ATPase associated with various cellular activities AAA_5 +FIG01379249 FIG01017764: hypothetical protein +FIG01379250 hypothetical protein +FIG01379280 FIG00352150: hypothetical protein +FIG01379283 protein of unknown function DUF481 +FIG01379293 Complete genome; segment 2/5 precursor +FIG01379295 FIG00350203: hypothetical protein +FIG01379298 Putative membrane transporter ATPase,YhiD +FIG01379311 FIG00348482: hypothetical protein +FIG01379313 FIG00385003: hypothetical protein +FIG01379322 prophage Sa05, transcriptional regulator, ArpU family +FIG01379333 FIG00350694: hypothetical protein +FIG01379334 murine toxin +FIG01379365 FIG00468870: hypothetical protein +FIG01379372 PPE family protein +FIG01379389 transglutaminase domain protein +FIG01379398 sulfatase family protein +FIG01379401 Hemin binding protein b +FIG01379406 putative cationic outer membrane protein ompH +FIG01379408 FIG00763605: hypothetical protein +FIG01379413 hemolysin III-like protein +FIG01379425 FIG00898661: hypothetical protein +FIG01379434 Phage-associated cell wall hydrolase +FIG01379438 FIG00352937: hypothetical protein +FIG01379456 Streptococcal extracellular nuclease 3 +FIG01379484 Methylated-DNA-[protein]-cysteine S-methyltransferase +FIG01379488 FIG00350300: hypothetical protein +FIG01379494 FIG00349988: hypothetical protein +FIG01379499 glycoside hydrolase, family 20 +FIG01379506 FIG00525735: hypothetical protein +FIG01379523 FIG00672778: hypothetical protein +FIG01379527 FIG01182702: hypothetical protein +FIG01379528 Protein of unknown function DUF323:NACHT nucleoside triphosphatase +FIG01379530 Protein mutL +FIG01379532 molybdopterin converting factor subunit 1 MoaD +FIG01379534 FIG00350050: hypothetical protein +FIG01379538 sugar transporter integral membrane protein +FIG01379543 FIG00640427: hypothetical protein +FIG01379555 FIG00350872: hypothetical protein +FIG01379573 FIG00353428: hypothetical protein +FIG01379580 Dienelactone hydrolase family protein +FIG01379586 FIG00408992: hypothetical protein +FIG01379598 FIG00623270: hypothetical protein +FIG01379624 Hydrolase, haloacid dehalogenase-like family +FIG01379651 extracellular nuclease, putative +FIG01379673 FIG00638287: hypothetical protein +FIG01379679 FIG01116186: hypothetical protein +FIG01379690 Putative glycoprotein/receptor precursor +FIG01379698 zinc protease, putative +FIG01379700 Peptidase C14, caspase catalytic subunit p20 precursor +FIG01379711 FIG00673889: hypothetical protein +FIG01379715 FIG00353930: hypothetical protein +FIG01379717 FIG00622894: hypothetical protein +FIG01379719 FIG00945776: hypothetical protein +FIG01379720 FIG00348314: hypothetical protein +FIG01379727 FIG00765642: hypothetical protein +FIG01379729 FilA +FIG01379734 Sensor protein rcsC (EC 2.7.3.-) +FIG01379736 MchE protein-like +FIG01379741 Cyanate MFS transporter +FIG01379748 FIG01006146: hypothetical protein +FIG01379770 FIG00763428: hypothetical protein +FIG01379792 FIG00756924: hypothetical protein +FIG01379806 probable multidrug resistance protein +FIG01379808 small acid-soluble spore protein alpha/beta type +FIG01379809 DGPFAETKE domain containing protein +FIG01379812 FIG00849662: hypothetical protein +FIG01379852 Predicted protein family PM-1 +FIG01379853 FIG00763031: hypothetical protein +FIG01379867 hypothetical integrase, catalytic domain,homeodomain-like +FIG01379868 hypothetical protein +FIG01379880 FIG00943397: hypothetical protein +FIG01379883 transcriptional regulator, sugar-binding family +FIG01379890 osmotical inducible protein C like family; inducable by osmotic stress and by organic hydroperoxides +FIG01379893 FIG00523393: hypothetical protein +FIG01379911 KWG Leptospira repeat protein +FIG01379940 Phage Holliday junction resolvase +FIG01379952 Helicase C-terminal domain +FIG01379957 FIG00379692: hypothetical protein +FIG01379959 oxalate decarboxylase( EC:4.1.1.2 ) +FIG01379983 sodium:solute symporter +FIG01379993 FIG00409689: hypothetical protein +FIG01379998 COG1668: ABC-type Na+ efflux pump, permease component +FIG01379999 pyruvate + formaldehyde -> hydroxyacetone + carbon dioxide, thiamine pyrophosphate-dependent +FIG01380036 iron-dependent repressor +FIG01380049 Possible L-talarate permease +FIG01380051 ATP-binding protein, Mrp/Nbp35 family +FIG01380053 Probable acyl-CoA dehydrogenase (EC 1.3.99.-) +FIG01380061 Replication protein 15 +FIG01380081 DUF209 +FIG01380085 redox-sensing transcriptional repressor Rex +FIG01380121 FIG00962751: hypothetical protein +FIG01380122 Biosynthetic Aromatic amino acid aminotransferase beta (EC 2.6.1.57) +FIG01380125 ortholog to Borrelia burgdorferi BB0044 +FIG01380133 FIG00517292: hypothetical protein +FIG01380136 UPF0332 protein MJ0605 +FIG01380153 FIG00697852: hypothetical protein +FIG01380175 485aa long hypothetical protein +FIG01380206 FIG00632656: hypothetical protein +FIG01380207 FIG00388071: hypothetical protein +FIG01380222 Possible polygalacturonase (EC 3.2.1.15) +FIG01380223 FIG00351329: hypothetical protein +FIG01380225 FIG00815948: hypothetical protein +FIG01380242 hypothetical protein +FIG01380245 FIG00624718: hypothetical protein +FIG01380250 FIG01119450: hypothetical protein +FIG01380254 Lipase LipU +FIG01380255 FIG00495427: hypothetical protein +FIG01380264 putative phage lysozyme +FIG01380267 FAD pyrophosphatase (EC 3.6.1.18), putative paralog +FIG01380291 Colicin +FIG01380314 competence locus E-like protein +FIG01380322 single-strand DNA binding protein +FIG01380335 FIG001154: CcsA-related protein +FIG01380337 replication protein +FIG01380338 Putative H-T-H containing protein +FIG01380343 possible ATP binding protein of ABC transporter +FIG01380354 NLP/P60 protein +FIG01380384 conserved hypothetical protein, glutamic acid-rich region +FIG01380404 Enoyl-CoA hydratase/isomerase +FIG01380407 FIG00762936: hypothetical protein +FIG01380408 FIG00351683: hypothetical protein +FIG01380412 BRANCHED-CHAIN AMINO ACID ABC TRANSPORTER, PERIPLASMIC AMINO ACID- BINDING PROTEIN +FIG01380417 outer membrane lipoprotein OmlA +FIG01380420 NrtR-regulated ADP-ribosyl-glycohydrolase DraG +FIG01380427 FIG01212592: hypothetical protein +FIG01380432 probable phage shock protein +FIG01380433 UvrB/UvrC protein +FIG01380485 OXALATE DECARBOXYLASE (EC 4.1.1.2) +FIG01380503 HdtS protein (EC 2.3.1.51) +FIG01380504 two component LuxR family transcriptional regulator +FIG01380509 1-acyl-sn-glycerol-3-phosphate acyltransferase +FIG01380522 FIG00350207: hypothetical protein +FIG01380530 Alr3363 protein +FIG01380536 hypothetical protein +FIG01380537 Biotin synthase-related protein, radical SAM superfamily +FIG01380548 no significant homology. Putative N-terminal signal sequence and 3 putative transmembrane regions were found by PSORT. +FIG01380549 ortholog to Borrelia burgdorferi BB0564 +FIG01380558 FIG00388334: hypothetical protein +FIG01380565 FIG00349943: hypothetical protein +FIG01380577 Mannosyltransferase WboB +FIG01380582 FIG00407435: hypothetical protein +FIG01380593 Membrane protein ydfJ +FIG01380609 Zinc metallohydrolase, glyoxalase II family +FIG01380610 FIG01118859: hypothetical protein +FIG01380621 FIG00769914: hypothetical protein +FIG01380623 FIG00451113: hypothetical protein +FIG01380627 FIG00531286: hypothetical protein +FIG01380630 FIG00350798: hypothetical protein +FIG01380631 pirin family protein +FIG01380632 FIG01118870: hypothetical protein +FIG01380651 FIG00815325: hypothetical protein +FIG01380665 kinase-like protein +FIG01380671 Cell surface antigen Sca13 +FIG01380686 Selenium-binding protein 1 +FIG01380704 Hypothetical phage protein +FIG01380711 DNA cytosine methyltransferase +FIG01380717 structural component; cell exterior constituents: surface structures +FIG01380725 TRAP-type uncharacterized transport system, periplasmic component +FIG01380737 bacterio-opsin linked product +FIG01380740 Molecular chaperone HSP90 family-like protein +FIG01380749 similar to transporter +FIG01380762 Integral membrane protein +FIG01380775 DNA methylase N-4/N-6 domain protein +FIG01380792 FIG00405972: hypothetical protein +FIG01380798 possible Legume lectins alpha domain +FIG01380801 probable transcription regulator VCA0264 +FIG01380810 peptidase S14, ClpP +FIG01380827 ortholog to Borrelia burgdorferi BB0157 +FIG01380866 Tsl2232 protein +FIG01380895 unknown +FIG01380913 contains transcriptional regulator helix-turn-helix domain, AraR family +FIG01380914 Lantibiotic streptin precursor +FIG01380932 FIG00624510: hypothetical protein +FIG01380942 FIG00406060: hypothetical protein +FIG01380946 Replication protein A (two OB fold, one zinc finger) +FIG01380953 ortholog of Bordetella pertussis (BX470248) BP2750 +FIG01380954 Sporulation protein Cse15 +FIG01380957 Site-specific recombinases, DNA invertase Pin homolog +FIG01380968 FIG01047227: hypothetical protein +FIG01380973 Hypothetical protein, CF-40 family +FIG01380995 VapC20 antibacterial toxin protein +FIG01381004 FIG00351804: hypothetical protein +FIG01381021 carboxyl esterase +FIG01381023 Single-strand binding protein +FIG01381024 Extracellular endoglucanase +FIG01381028 FIG00642654: hypothetical protein +FIG01381037 FIG00763349: hypothetical protein +FIG01381039 FIG00624178: hypothetical protein +FIG01381089 FIG00642546: hypothetical protein +FIG01381099 UDP-glucose--Lipooligosaccharide beta 1-4 glucosyltransferase +FIG01381100 Spidroin 1 +FIG01381109 putative O-antigen methyl transferase +FIG01381113 FIG00409119: hypothetical protein +FIG01381168 Glutamine synthetase +FIG01381171 FIG01218638: hypothetical protein +FIG01381179 FIG00821858: hypothetical protein +FIG01381186 FIG00589934: hypothetical protein +FIG01381203 FIG00350513: hypothetical protein +FIG01381207 putative phage associated protein +FIG01381223 Conserved membrane-spanning protein +FIG01381229 FIG01222106: hypothetical protein +FIG01381231 FIG00643426: hypothetical protein +FIG01381276 FIG01115868: hypothetical protein +FIG01381281 FIG00733333: hypothetical protein +FIG01381298 FIG01044451: hypothetical protein +FIG01381309 FIG00468623: hypothetical protein +FIG01381324 Uncharacterized protein yqzI +FIG01381329 putative RNA polymerase ECF sigma factor +FIG01381333 dual specificity protein phosphatase +FIG01381343 Beta-mannanase +FIG01381346 Dihydropyrimidine dehydrogenase homolog +FIG01381355 FIG00450589: hypothetical protein +FIG01381374 FIG00644497: hypothetical protein +FIG01381385 FIG034490: hypothetical protein +FIG01381390 RNAIII (delta-hemolysin) +FIG01381412 probable tail fiber protein +FIG01381420 Heterocyst specific ABC transporter substrate-binding protein +FIG01381422 Cellodextrin-phosphorylase (EC 2.4.1.49) +FIG01381431 gamma-aminobutyrate transporter +FIG01381465 FIG00522791: hypothetical protein +FIG01381486 Carboxylesterase precursor +FIG01381505 FIG00623704: hypothetical protein +FIG01381514 Colicin nuclease family protein +FIG01381528 Bsr7112 protein +FIG01381529 FIG00829687: hypothetical protein +FIG01381533 FIG00523434: hypothetical protein +FIG01381542 FIG00766272: hypothetical protein +FIG01381549 mobilizable transposon, xis protein +FIG01381558 IcmC protein +FIG01381559 FIG01046203: hypothetical protein +FIG01381560 P-hydroxyphenylacetate hydroxylase C1:reductase component +FIG01381567 stationary phase survival protein SurE +FIG01381575 FIG00414698: hypothetical protein +FIG01381581 Tn21 protein of unknown function Urf2 +FIG01381583 Tn554-related, transposase C +FIG01381584 LysR-like transcriptional regulator +FIG01381585 FIG00341078: hypothetical protein +FIG01381588 FIG00763233: hypothetical protein +FIG01381598 putative spermine/spermidine synthase protein( EC:2.5.1.16 ) +FIG01381635 FIG00526893: hypothetical protein +FIG01381640 FIG01054760: hypothetical protein +FIG01381657 Transporter, LysE family +FIG01381688 putative efflux transporter bicyclomycin resistance protein +FIG01381710 N-acetylglutamate synthase and related acetyltransferases +FIG01381711 acyl carrier protein +FIG01381752 hypothetical protein +FIG01381753 FIG00812557: hypothetical protein +FIG01381757 HhH-GPD family protein +FIG01381758 ABC transporter ATP binding protein +FIG01381764 similar to potassium channel protein +FIG01381773 Uncharacterized virulence-associated protein D +FIG01381776 Phage NinX +FIG01381797 insertion element IS466S transposase +FIG01381806 UviB homologous protein +FIG01381815 FIG00996174: hypothetical protein +FIG01381818 FIG00408532: hypothetical protein +FIG01381822 hypothetical protein +FIG01381832 hypothetical protein +FIG01381835 Gsr3505 protein +FIG01381857 hypothetical protein +FIG01381862 FIG00425541: hypothetical protein +FIG01381866 FIG00344931: hypothetical protein +FIG01381871 lichenicidin prepeptide +FIG01381897 Possible hydrolase +FIG01381899 FIG01047431: hypothetical protein +FIG01381916 Limonene-1,2-epoxide hydrolase +FIG01381934 MFS transporter, phthalate permease family +FIG01381936 Thiol-disulfide oxidoreductase resA +FIG01381952 Pyridoxine 5'-phosphate oxidase, Rv1155 +FIG01381976 possible GntR-family transcriptional regulator +FIG01381978 FIG00468240: hypothetical protein +FIG01381985 FIG01214606: hypothetical protein +FIG01382049 FIG00350257: hypothetical protein +FIG01382065 Methyl-accepting chemotaxis protein +FIG01382078 Response regulator/GGDEF domain protein +FIG01382101 FIG00909118: hypothetical protein +FIG01382102 Pyridoxamine 5'-phosphate oxidase-related +FIG01382120 N-acetylglucosamine-6-sulfatase precursor (EC 3.1.6.14) (G6S) (Glucosamine-6-sulfatase) +FIG01382134 FIG00347463: hypothetical protein +FIG01382141 FIG00622991: hypothetical protein +FIG01382171 lipoprotein YlpA +FIG01382172 FIG00623141: hypothetical protein +FIG01382182 FIG00769510: hypothetical protein +FIG01382195 FIG00520993: hypothetical protein +FIG01382203 thioesterase family protein( EC:3.1.2.- ) +FIG01382205 CjrA +FIG01382213 FIG01115311: hypothetical protein +FIG01382224 hypothetical protein +FIG01382234 FIG00836683: hypothetical protein +FIG01382236 Single-stranded DNA-binding protein (SSB) (Helix-destabilizing protein) +FIG01382247 PUTATIVE TRANSPORT TRANSMEMBRANE PROTEIN +FIG01382264 FIG00765638: hypothetical protein +FIG01382278 FIG00640506: hypothetical protein +FIG01382282 FIG00412997: hypothetical protein +FIG01382284 Putative uncharacterized protein BCG_1584c +FIG01382285 FIG00350113: hypothetical protein +FIG01382303 B. burgdorferi predicted coding region BB0762 +FIG01382307 Outer membrane porin protein 32 precursor +FIG01382339 Methylamine utilization protein/Cytochrome c peroxidase +FIG01382370 integral membrane family protein +FIG01382383 FlgM protein +FIG01382387 FIG00380198: hypothetical protein +FIG01382396 hypothetical protein +FIG01382398 Arylamine N-acetyltransferase (EC 2.3.1.5) +FIG01382439 FIG01124667: hypothetical protein +FIG01382441 putative protein involved in transposition +FIG01382481 Pyridoxamine 5'-phosphate oxidase-related +FIG01382484 L-alanine-DL-glutamate epimerase and related enzymes of enolase superfamily +FIG01382487 FIG01043009: hypothetical protein +FIG01382500 Chimeric erythrocyte-binding protein MAEBL +FIG01382501 Lmo2594 protein +FIG01382502 ATP-binding component of molybdate transport system +FIG01382507 2,3-bisphosphoglycerate-independent phosphoglycerate mutase +FIG01382512 hypothetical protein; Some similarities with putative transferase enzyme +FIG01382513 Secreted and surface protein containing fasciclin-like repeats +FIG01382514 putative histidine kinase +FIG01382523 putative chromate transport protein +FIG01382528 IRON(III) DICITRATE TRANSPORT SYSTEM PERMEASE PROTEIN +FIG01382538 Glutathione S-transferase, N-terminal domain +FIG01382548 FIG00406774: hypothetical protein +FIG01382560 Putative amino acid transporter +FIG01382574 uncharacterized conserved protein-like protein +FIG01382586 Ler protein +FIG01382620 methyltransferase domain protein +FIG01382621 oxidoreductase molybdopterin binding protein +FIG01382670 B. burgdorferi predicted coding region BB0324 +FIG01382675 FIG00528562: hypothetical protein +FIG01382681 67 aa, no significant homology +FIG01382690 Nikkomycin biosynthesis protein, carboxylase +FIG01382695 TOLUENE TOLERANCE PROTEIN TTG2B +FIG01382702 CglB +FIG01382721 Polysialic acid capsule expression protein KpsF +FIG01382725 hypothetical protein +FIG01382730 putative hydrolase (partial match) +FIG01382757 tRNA-specific adenosine-34 deaminase (EC 3.5.4.-) / domain of unknown function +FIG01382758 Lipase A +FIG01382759 FIG00525655: hypothetical protein +FIG01382777 Probable 3-oxoacyl-[acyl-carrier-protein] synthase III (EC 2.3.1.41) +FIG01382782 Nucleotidyltransferase/DNA polymerase involved in DNA repair +FIG01382783 domain of unknown function superfamily +FIG01382788 FIG00385132: hypothetical protein +FIG01382792 putative carbohydrate-binding protein +FIG01382814 Protein of unknown function UPF0025 +FIG01382815 putative SAM-dependent methyltransferase +FIG01382822 transposase-related protein +FIG01382823 Glutamine synthetase adenylyltransferase +FIG01382841 nucleotide sugar epimerase/dehydratase WbpM +FIG01382884 Putative oxidoreductase SMc00968 +FIG01382896 FIG01165942: hypothetical protein +FIG01382926 FIG00920181: hypothetical protein +FIG01382930 PAP2 superfamily domain protein +FIG01382946 FIG01115995: hypothetical protein +FIG01382948 FIG00766458: hypothetical protein +FIG01382980 FIG00750707: hypothetical protein +FIG01382985 type II restriction-modification system regulatory protein, putative +FIG01382998 possible integral membrane permease protein +FIG01383010 FIG00964508: hypothetical protein +FIG01383013 carveol dehydrogenase (fabG) +FIG01383015 hypothetical protein, (pXO2-28) +FIG01383037 PemK-Like, possible growth inhibitor +FIG01383043 FIG00623397: hypothetical protein +FIG01383046 tropinesterase homolog tpeA +FIG01383062 FIG00816235: hypothetical protein +FIG01383067 Trans-acting regulatory protein hvrA +FIG01383068 Uncharacterized protein TP_1029 +FIG01383070 FIG00831381: hypothetical protein +FIG01383072 hypothetical protein +FIG01383091 DUF433 domain-containing protein +FIG01383110 hypothetical lipoprotein +FIG01383121 FIG00348919: hypothetical protein +FIG01383123 Sll1386 protein +FIG01383126 FIG00928391: hypothetical protein +FIG01383137 ortholog to Borrelia burgdorferi BB0083 +FIG01383139 FIG00523356: hypothetical protein +FIG01383143 FIG01237209: hypothetical protein +FIG01383150 YqzJ +FIG01383158 Uncharacterized protein, YjiN homolog +FIG01383163 ISXo7 transposase +FIG01383167 FIG00645166: hypothetical protein +FIG01383169 FIG00350938: hypothetical protein +FIG01383170 putative polysaccharide biosynthesis protein +FIG01383171 Acyl-CoA dehydrogenase (EC 1.3.8.7) +FIG01383180 ATPase, putative +FIG01383185 COG0583: Transcriptional regulator +FIG01383190 FIG00350161: hypothetical protein +FIG01383194 FIG00353954: hypothetical protein +FIG01383197 FIG00272092: hypothetical protein +FIG01383200 FIG01016610: hypothetical protein +FIG01383206 Beta-ketoadipate enol-lactone hydrolase, putative +FIG01383212 Guanylate cyclase-related protein +FIG01383214 Putative fimbrial chaperone +FIG01383222 orf; Other or unknown (Phage or Prophage Related) +FIG01383223 FIG00687482: hypothetical protein +FIG01383228 FIG00791002: hypothetical protein +FIG01383233 Plasmid-related protein +FIG01383248 FIG00471537: hypothetical protein +FIG01383249 Uncharacterized flagellar protein FlaG +FIG01383257 Propeptide PepSY amd peptidase M4 +FIG01383273 opacity associated protein B +FIG01383280 Siderophore [Alcaligin] biosynthesis complex, short chain @ Siderophore synthetase small component, acetyltransferase +FIG01383285 FIG00529046: hypothetical protein +FIG01383303 putative chitobiase +FIG01383304 Putative NADH dehydrogenase/NAD(P)H nitroreductase AF_2267 (EC 1.-.-.-) +FIG01383336 FIG00809218: hypothetical protein +FIG01383337 putative sodium/hydrogen exchanger family +FIG01383339 COG family: DNA-directed RNA polymerase specialized sigma subunit +FIG01383340 FIG00415555: hypothetical protein +FIG01383347 Pyruvate,phosphate dikinase (EC 2.7.9.1), partially deleted +FIG01383358 FIG00763405: hypothetical protein +FIG01383382 5-Hydroxyisourate Hydrolase (HIUase) (EC 3.5.2.17) / Monoxygenase +FIG01383411 Trehalose synthase +FIG01383420 PREDICTED: hypothetical protein +FIG01383444 FIG00351367: hypothetical protein +FIG01383445 FIG00388652: hypothetical protein +FIG01383454 putative truncated transcriptional regulator +FIG01383458 FIG00766307: hypothetical protein +FIG01383459 sensory box (GGDEF/EAL domain) regulatory protein +FIG01383472 Hypothetical protein SPy0110 +FIG01383473 hypothetical protein( EC:3.4.24.69 ) +FIG01383485 FIG00413904: hypothetical protein +FIG01383489 Avidin family protein +FIG01383506 Probable lipoprotein envF precursor +FIG01383509 hypothetical protein +FIG01383520 POSSIBLE ALANINE AND PROLINE RICH MEMBRANE PROTEIN +FIG01383527 YhcI +FIG01383530 IS891/IS1136/IS1341 transposase +FIG01383533 Subtilisin-like serine protease-like protein +FIG01383543 D-Tyr-tRNAtyr deacylase +FIG01383565 NADH:flavin oxidoreductase +FIG01383584 FIG00405634: hypothetical protein +FIG01383585 Secreted pectate lyase HrpW +FIG01383586 FIG00632962: hypothetical protein +FIG01383587 FIG00350033: hypothetical protein +FIG01383612 epoxide hydrolase +FIG01383615 Phage related integrase +FIG01383616 protein of unknown function DUF192 +FIG01383635 conserved hypothetical protein IS609-Orf2 +FIG01383643 FIG00825799: hypothetical protein +FIG01383655 NADPH-dependent carbonyl reductase +FIG01383660 Mg chelatase-related protein +FIG01383661 FIG00407264: hypothetical protein +FIG01383669 NADH:ubiquinone oxidoreductase subunit 5 (chain L)/Multisubunit Na+/H+ antiporter, MnhA subunit +FIG01383681 FIG00407710: hypothetical protein +FIG01383688 FIG00389099: hypothetical protein +FIG01383689 putative Na+/H+ antiporter subunit +FIG01383704 Plasmid recombination, MobE mobilization protein +FIG01383717 FIG00733160: hypothetical protein +FIG01383721 Peptide synthetase NRPS0 +FIG01383722 serine/threonine protein kinase domain protein +FIG01383726 Uncharacterized protein ycsD +FIG01383773 Gene Transfer Agent portal protein +FIG01383780 FIG01046712: hypothetical protein +FIG01383783 Glucose-6-phosphate isomerase +FIG01383785 conserved hypothetical protein, secreted +FIG01383809 Capsule expression protein +FIG01383832 protein of unknown function DUF1080 +FIG01383838 protein of unknown function DUF932 +FIG01383852 FIG00525660: hypothetical protein +FIG01383859 FIG00521856: hypothetical protein +FIG01383864 Cytochrome-c peroxidase precursor (EC 1.11.1.5) +FIG01383870 pyruvyl-transferase +FIG01383874 iron-regulated outer membrane protein (frpB) +FIG01383877 FIG00766794: hypothetical protein +FIG01383913 Radical SAM-family protein +FIG01383915 Putative ribosomal protein N-acetyltransferase +FIG01383926 Oxydoreductase, putative +FIG01383928 Response regulator of a two component regulator +FIG01383936 FIG01170036: hypothetical protein +FIG01383996 integration host factor beta subunit +FIG01383999 transcriptional regulator (FIS family) +FIG01384000 Sodium/calcium exchanger membrane protein +FIG01384005 FIG00936395: hypothetical protein +FIG01384008 Mll2607 protein +FIG01384011 Nascent polypeptide-associated complex protein +FIG01384033 FIG00384884: hypothetical protein +FIG01384034 ABC transporter, ATP-binding protein, MDR family +FIG01384046 monooxygenase FAD-binding +FIG01384053 Putative intracellular protease/amidase +FIG01384054 FIG00766675: hypothetical protein +FIG01384055 JmjC domain protein +FIG01384069 hypothetical protein +FIG01384071 putative GPH family sugar transporter +FIG01384085 anti-adapter protein IraM +FIG01384091 Conserved protein YwcB +FIG01384097 FIG00848988: hypothetical protein +FIG01384108 probable N-acyl-D-amino-acid deacylase( EC:3.5.1.81 ) +FIG01384120 putative type III effector protein SipD +FIG01384132 NADPH dehydrogenase +FIG01384156 TWO COMPONENT SENSOR HISTIDINE KINASE DEVS +FIG01384162 FIG00624425: hypothetical protein +FIG01384171 Alkaline proteinase inhibitor precursor +FIG01384182 HtaR suppressor protein +FIG01384183 Exported repetitive protein (Cell surface protein PirG) +FIG01384189 glycosyl hydrolase (secreted protein) +FIG01384196 ABC-type transport system involved in multi-copper enzyme maturation, permease component +FIG01384198 gamma-D-glutamyl-L-diamino acid endopeptidase I +FIG01384204 FIG00638044: hypothetical protein +FIG01384217 FIG00762727: hypothetical protein +FIG01384227 outer membrane porin OpcP +FIG01384285 FIG00847048: hypothetical protein +FIG01384299 O-antigen export system ATP-binding protein RfbE +FIG01384312 Possible carboxymuconolactone decarboxylase family protein (EC 4.1.1.44) +FIG01384315 Protein of unknown function DUF132 +FIG01384324 FIG00538326: hypothetical protein +FIG01384329 bacteriophage f237 ORF4 +FIG01384343 FIG00412668: hypothetical protein +FIG01384348 FIG01202395: hypothetical protein +FIG01384352 FIG00633157: hypothetical protein +FIG01384358 SohB protein, peptidase U7 family +FIG01384378 sporulation and cell division repeat protein +FIG01384379 6'-aminoglycoside N-acetyltransferase (EC 2.3.1.-) (AAC(6')) / 2''-aminoglycoside phosphotransferase (EC 2.7.1.-) +FIG01384381 FIG00423918: hypothetical protein +FIG01384385 6'-N-acetyltransferase +FIG01384391 FIG00780933: hypothetical protein +FIG01384394 Bll0849 protein +FIG01384401 FIG00639409: hypothetical protein +FIG01384461 Putative protease encoded within prophage CP-933X +FIG01384488 FIG01246923: hypothetical protein +FIG01384493 conserved hypothetical protein related to phage +FIG01384498 71ORF2 protein +FIG01384500 FIG00767545: hypothetical protein +FIG01384518 FIG00640585: hypothetical protein +FIG01384558 FIG00385738: hypothetical protein +FIG01384559 FIG01116529: hypothetical protein +FIG01384566 Fumarate and nitrate reduction regulatory protein homolog +FIG01384569 protein of unknown function DUF405 +FIG01384574 probable DNA methylase (modification methylase) (methyltransferase) +FIG01384593 probable membrane protein YPO3565 +FIG01384601 Choline dehydrogenase and related flavoproteins +FIG01384609 FIG00451290: hypothetical protein +FIG01384633 HD-GYP domain (HD superfamily hydrolase) +FIG01384641 ABC transporter permease protein +FIG01384647 FIG00353503: hypothetical protein +FIG01384682 hypothetical protein +FIG01384692 FIG00638486: hypothetical protein +FIG01384698 peptide ABC transporter ATP-binding protein +FIG01384711 putative regulator of late gene expression +FIG01384718 Transcriptional regulator/TPR domain protein +FIG01384721 Helix-turn-helix, Fis-type +FIG01384725 Invasion associated locus B family protein +FIG01384730 syc2296_c +FIG01384732 membrane-integral protein, putative transporter +FIG01384737 NICKEL-COBALT-CADMIUM RESISTANCE PROTEIN NCCN +FIG01384753 signal transduction histidine kinase, LytS +FIG01384759 putative outer membrane protein TolC +FIG01384771 FIG00389587: hypothetical protein +FIG01384789 Beta-lactamase inhibitory protein II +FIG01384792 Phosphomannomutase (EC 5.4.2.8) clustering with Aga operon +FIG01384797 Slr0962 protein +FIG01384805 Nodulation protein B +FIG01384806 FIG00822551: hypothetical protein +FIG01384814 ABC-type nitrate/sulfonate/bicarbonate transport system, periplasmic component +FIG01384825 FIG00641858: hypothetical protein +FIG01384836 FIG00519163: hypothetical protein +FIG01384837 UPF0063 protein MJ0103 +FIG01384847 carbon storage regulator, CsrA +FIG01384852 FIG00834880: hypothetical protein +FIG01384854 transglycosylase-associated protein +FIG01384864 FIG00413549: hypothetical protein +FIG01384890 phosphoribosylaminoimidazole carboxylase ATPase subunit +FIG01384898 NanA gene +FIG01384901 FIG00817778: hypothetical protein +FIG01384945 Probable RTX +FIG01384948 hypothetical protein +FIG01384965 Autoinducer synthesis protein SolI +FIG01384974 possible uridine kinase +FIG01384975 FIG00826147: hypothetical protein +FIG01384977 Ribosomal-protein-alanine acetyltransferase +FIG01385013 FIG00482019: hypothetical protein +FIG01385015 FIG00830098: hypothetical protein +FIG01385031 similar to acetyltransferase +FIG01385034 FIG01108826: hypothetical protein +FIG01385038 FIG00380901: hypothetical protein +FIG01385040 outer membrane protein (tpn50) +FIG01385045 hypothetical protein +FIG01385049 FIG00406500: hypothetical protein +FIG01385055 FIG00710801: hypothetical protein +FIG01385064 FIG00403684: hypothetical protein +FIG01385071 FIG00624611: hypothetical protein +FIG01385072 Transglutaminase-like domain +FIG01385073 FIG00688042: hypothetical protein +FIG01385081 ACR family +FIG01385123 FIG01038451: hypothetical protein +FIG01385128 Jumonji domain containing 5 +FIG01385153 Outer membrane lipoprotein blc precursor +FIG01385164 arylsulfotransferase +FIG01385180 FIG00407219: hypothetical protein +FIG01385187 Peptidyl-prolyl cis-trans isomerase, FKBP-type domain protein +FIG01385194 pentapeptide repeat protein +FIG01385208 Membrane associated methyl-accepting chemotaxis protein (with HAMP domain) +FIG01385211 FIG00640011: hypothetical protein +FIG01385218 FIG00403675: hypothetical protein +FIG01385222 Transglycosylase domain protein +FIG01385248 FIG00820153: hypothetical protein +FIG01385294 FIG00823489: hypothetical protein +FIG01385305 EmbC +FIG01385317 FIG00408656: hypothetical protein +FIG01385318 Changed start to match that seen in other orgs. +FIG01385324 NonF-related protein +FIG01385336 FIG00750486: hypothetical protein +FIG01385337 Asl4146 protein +FIG01385343 S-layer homology domain / putative murein endopeptidase +FIG01385352 FAD dependent oxidoreductase family +FIG01385362 restriction endonuclease, putative +FIG01385365 Glycine-rich RNA binding protein +FIG01385391 FIG01087728: hypothetical protein +FIG01385393 FIG00388721: hypothetical protein +FIG01385418 Alcohol dehydrogenase, zinc-binding domain protein +FIG01385422 Tetracycline efflux protein TetA +FIG01385434 FIG00528816: hypothetical protein +FIG01385438 FIG01209874: hypothetical protein +FIG01385444 HIT-family hydrolase protein +FIG01385448 FIG00424053: hypothetical protein +FIG01385455 phage tail protein, putative +FIG01385459 Predicted transcriptional regulator, dicA/hipB/ansR family +FIG01385468 Probable protease htpX homolog (EC 3.4.24.-) +FIG01385473 Predicted Zn-dependent protease with possible chaperone function +FIG01385474 Ethanolamine utilization protein eutQ +FIG01385488 DnaJ-like protein +FIG01385491 thiol/disulfide interchange protein +FIG01385514 vgrG protein +FIG01385518 helicase domain protein +FIG01385531 FIG00828696: hypothetical protein +FIG01385532 Tex +FIG01385539 FIG00814954: hypothetical protein +FIG01385550 two component repsonse/transcriptional regulator +FIG01385553 2-acylglycerophosphoethanolamine acyltransferase (EC 6.2.1.20) +FIG01385554 Similar to cytochrome c-type biogenesis protein CcsA/ResC +FIG01385571 FIG01114579: hypothetical protein +FIG01385585 Short-chain dehydrogenase family protein +FIG01385589 probable oligoendopeptidase F +FIG01385590 L-lysine dehydrogenase +FIG01385594 FIG00847130: hypothetical protein +FIG01385599 FIG00354846: hypothetical protein +FIG01385607 Nonspecific acid phosphatase precursor( EC:3.1.3.2 ) +FIG01385609 Bsr0038 protein +FIG01385615 putative solute-binding periplasmic protein +FIG01385645 62kDa structural protein +FIG01385646 FIG00623137: hypothetical protein +FIG01385661 Phophatidylinositol-4-phosphate 5-kinase (EC 2.7.1.68) +FIG01385665 hypothetical protein within pathogenicity island SaPIn3 +FIG01385677 ISPsy4, transposase +FIG01385680 FIG00351265: hypothetical protein +FIG01385685 Abortive infection bacteriophage resistance protein +FIG01385688 phosphotransferase enzyme family protein +FIG01385690 probable serine protease DO-like +FIG01385691 Putative outer membrane virulence protein PhoP +FIG01385705 tRNA (guanine46-N7-)-methyltransferase (EC 2.1.1.33) +FIG01385709 putative membrane carboxypeptidase +FIG01385710 possible xylose repressor +FIG01385755 FIG00350076: hypothetical protein +FIG01385760 glycoside hydrolase, family 30 +FIG01385774 tankyrase, TRF1-interacting ankyrin-related ADP-ribose polymerase +FIG01385781 Variable surface protein VspH +FIG01385788 FIG00695166: hypothetical protein +FIG01385798 Phosphotransferase system, phosphocarrier protein HPr +FIG01385814 FIG00816032: hypothetical protein +FIG01385835 FIG00764948: hypothetical protein +FIG01385839 Protein of hypothetical function DUF1829 +FIG01385841 GtgA +FIG01385846 probable assimilatory nitrite reductase [NAD(P)H] small subunit +FIG01385862 Extracellular protease precursor (EC 3.4.24.-) +FIG01385880 Hydrolase of the alpha/beta superfamily-like protein +FIG01385900 YfiQ +FIG01385921 multidrug transporter, putative +FIG01385940 Uncharacterized Fe-S protein +FIG01385952 Resolvase, N-terminal domain protein +FIG01385953 putative sensory box sensor histidine kinase/response regulator +FIG01385959 Tsr1332 protein +FIG01385963 FIG00244437: hypothetical protein +FIG01385971 FIG00350777: hypothetical protein +FIG01385972 Iron compound ABC transporter, iron compound-binding protein +FIG01385981 FIG00766263: hypothetical protein +FIG01386003 Protein SlyX +FIG01386007 FIG01166234: hypothetical protein +FIG01386021 FIG00348306: hypothetical protein +FIG01386025 FIG00750690: hypothetical protein +FIG01386027 Possible glutaminyl transferase clustered with tetrahydromethanopterin biosynthesis genes +FIG01386048 Predicted methylated DNA-protein cysteine methyltransferase +FIG01386080 AAA ATPase central domain protein +FIG01386081 Lmo1139 protein +FIG01386109 RteB, two-component system response regulator +FIG01386124 FIG00412524: hypothetical protein +FIG01386126 FIG01043660: hypothetical protein +FIG01386132 Adenylyl cyclase class-3/4/guanylyl cyclase / Disease resistance domain-containing protein / Tetratricopeptide repeat-containing protein / Transcriptional regulator, LuxR family +FIG01386133 Mn2+/Zn2+ ABC transporter, ATP-binding protein +FIG01386137 Putative major tail sheath protein +FIG01386146 FIG01386146: Possible exported protein, Rv0203 +FIG01386159 Tlr1621 protein +FIG01386169 B. burgdorferi predicted coding region BB0034 +FIG01386181 NCAIR mutase (PurE)-related proteins +FIG01386205 FIG00765079: hypothetical protein +FIG01386218 probably a phosphohydrolase, evidenced by COGnitor +FIG01386226 probably ADP-ribose pyrophosphatase or mutT, evidenced by COGnitor +FIG01386240 FIG00755819: hypothetical protein +FIG01386242 ABC transporter ATP-binding protein Uup +FIG01386244 ATP-dependent transcriptional regulator, MalT-like, LuxR family +FIG01386257 CBS domain protein AcuB +FIG01386269 4Fe-4S binding domain protein/radical SAM domain protein +FIG01386293 FIG00432057: hypothetical protein +FIG01386296 PmgP +FIG01386301 FIG00903983: hypothetical protein +FIG01386312 Type III PLP / low-specificity D-threonine aldolase +FIG01386321 FIG00456162: hypothetical protein +FIG01386338 putative minor structural protein +FIG01386339 Serine protease, rhomboid family +FIG01386350 Pyrrolo-quinoline quinone +FIG01386358 FIG00875129: hypothetical protein +FIG01386375 FIG00622945: hypothetical protein +FIG01386377 FIG00677808: hypothetical protein +FIG01386379 probable exported protein YPO3473 +FIG01386397 FIG00416724: hypothetical protein +FIG01386399 kyphoscoliosis +FIG01386408 Protein yjbJ +FIG01386410 FIG00450575: hypothetical protein +FIG01386412 FIG00519113: hypothetical protein +FIG01386423 Sensor protein (EC 2.7.3.-) +FIG01386429 FIG00766138: hypothetical protein +FIG01386448 Quinohemoprotein amine dehydrogenase radical SAM maturase +FIG01386490 rickettsial conserved +FIG01386492 Protein of unknown function DUF990 +FIG01386495 FIG00514524: hypothetical protein +FIG01386505 FIG00973674: hypothetical protein +FIG01386507 CT567 hypothetical protein +FIG01386510 IS1381, transposase OrfB +FIG01386517 FIG00425784: hypothetical protein +FIG01386520 FIG053235: Diacylglucosamine hydrolase like +FIG01386558 cobalt transport protein CbiM +FIG01386568 lantibiotic transport protein +FIG01386572 extracellular serine protease +FIG01386576 Putative autotransporter protein +FIG01386609 FIG01116006: hypothetical protein +FIG01386622 Succinylglutamate desuccinylase/aspartoacylase +FIG01386623 prophage LambdaW5, ankyrin repeat domain protein +FIG01386647 FIG01386647: hypothetical protein shared among alpha-Proteobacteria +FIG01386650 Late competence protein ComEA +FIG01386662 FIG00451904: hypothetical protein +FIG01386680 toxin secretion ABC transporter, ATP-binding/permease protein +FIG01386682 FIG01016229: hypothetical protein +FIG01386690 carR +FIG01386697 putative arginyl-tRNA--protein transferase( EC:2.3.2.8 ) +FIG01386698 FIG00997051: hypothetical protein +FIG01386703 putative reductive dehalogenase +FIG01386740 Protein yjgK +FIG01386755 FIG00350264: hypothetical protein +FIG01386762 FIG01240016: hypothetical protein +FIG01386765 hypothetical protein +FIG01386771 InaA protein +FIG01386784 2-hydroxyglutaryl-CoA dehydratase (Component D) related protein +FIG01386788 FIG01101783: hypothetical protein +FIG01386789 Possible sigma factor +FIG01386797 CDS_ID OB2502 +FIG01386829 Smr domain protein, DNA mismatch repair protein-like +FIG01386833 FIG00353732: hypothetical protein +FIG01386855 FIG00385310: hypothetical protein +FIG01386858 RNA polymerase signa E (sigma 24) +FIG01386861 PtsG +FIG01386862 CRISPR associated protein Csc3 +FIG01386877 GAF domain-containing protein, involved in signal transduction +FIG01386881 monooxygenase, flavin-binding family +FIG01386895 probable protease precursor +FIG01386920 FIG00742760: hypothetical protein +FIG01386922 Amino acid carrier protein +FIG01386934 FIG00639744: hypothetical protein +FIG01386936 Conjugal transfer protein TraA +FIG01386954 Possible ATP adenylyltransferase (EC 2.7.7.53) +FIG01386973 Tryptophan RNA-binding attenuator protein-inhibitory protein anti-TRAP +FIG01386986 FIG00624162: hypothetical protein +FIG01386992 response regulator receiver domain protein +FIG01387000 FIG00850625: hypothetical protein +FIG01387002 Hydroxyproline-rich glycoprotein DZ-HRGP precursor +FIG01387008 pseudogene (IS1655 transposase) NMA0236 +FIG01387011 MdaB protein homolog +FIG01387044 putative phage inhibition, colicin resistance and tellurite resistance protein +FIG01387047 bacteriophage integrase +FIG01387068 Putative glycosidase +FIG01387073 Sea40 +FIG01387077 FIG01191602: hypothetical protein +FIG01387078 tRNA m(1)G methyltransferase; COG2419: Uncharacterized ACR +FIG01387080 FIG00361378: hypothetical protein +FIG01387083 FIG00347536: hypothetical protein +FIG01387096 FIG00733200: hypothetical protein +FIG01387098 FIG01068746: hypothetical protein +FIG01387105 FIG00351075: hypothetical protein +FIG01387107 LpqP protein +FIG01387122 Phenol hydroxylase +FIG01387127 Protein of unknown function DUF610, YibQ +FIG01387128 putative regulator +FIG01387141 Glutamate/gamma-aminobutyrate antiporter +FIG01387171 FIG00975421: hypothetical protein +FIG01387179 2Fe-2S ferredoxins, iron-sulfur binding protein +FIG01387181 Transmembrane protein PFT27 +FIG01387185 hypothetical protein +FIG01387186 FIG00425069: hypothetical protein +FIG01387211 FIG00411296: hypothetical protein +FIG01387237 Leucine-rich repeats (LRRs), ribonuclease inhibitor (RI)-like subfamily protein +FIG01387240 Acyl-CoA dehydrogenase, type 1 +FIG01387242 putative lipoprotein/thioderoxin +FIG01387254 hypothetical protein +FIG01387259 possible signal peptide peptidase +FIG01387279 opacity associated protein +FIG01387291 FIG00770010: hypothetical protein +FIG01387315 Acetyltransferase, GNAT family (EC 2.3.1.1) +FIG01387320 FIG00767683: hypothetical protein +FIG01387344 FIG00407637: hypothetical protein +FIG01387358 Calichemicin antitumor antibiotic biosynthesis protein (Fragment) +FIG01387361 FIG01230006: hypothetical protein +FIG01387367 Bll0066 protein +FIG01387369 56kDa selenium binding precursor +FIG01387386 Transcriptional regulator, LysR family, homolog 3 +FIG01387393 cadmium-translocating P-type ATPase +FIG01387394 immunoglobulin-binding protein EibE +FIG01387400 FIG00363045: hypothetical protein +FIG01387439 UDP-glucose 4-epimerase related protein +FIG01387445 Mlr6156 protein +FIG01387447 FIG01056973: hypothetical protein +FIG01387449 FIG00751420: hypothetical protein +FIG01387467 YeeE/YedE family protein +FIG01387472 GumN protein +FIG01387493 FIG00904051: hypothetical protein +FIG01387513 FIG00628597: hypothetical protein +FIG01387529 Superfamily II DNA helicase +FIG01387532 ORF_ID:alr7558 unknown protein +FIG01387533 putative C4-dicarboxylate transporter +FIG01387581 licD family protein +FIG01387582 FIG00413035: hypothetical protein +FIG01387594 FIG01199560: hypothetical protein +FIG01387608 protein of unknown function DUF861, cupin_3 +FIG01387621 protein of unknown function DUF1206 +FIG01387622 FIG00689473: hypothetical protein +FIG01387625 Invasion plasmid antigen J +FIG01387642 ortholog of Bordetella pertussis (BX470248) BP2258 +FIG01387660 FIG00814643: hypothetical protein +FIG01387664 conserved hypothetical protein, putative integral membrane protein +FIG01387668 TRNA pseudouridine synthase A (EC 4.2.1.70) +FIG01387700 Na+/H+-exchanging protein +FIG01387712 FIG00687996: hypothetical protein +FIG01387723 FIG00351895: hypothetical protein +FIG01387735 NisK +FIG01387737 Extracellular solute-binding proteins, family 3 protein +FIG01387743 N-formylglutamate amidohydrolase (EC 3.5.1.68) +FIG01387750 COG5495 +FIG01387764 putative amidohydrolase +FIG01387772 FIG00767985: hypothetical protein +FIG01387773 FIG00352281: hypothetical protein +FIG01387777 FIG00364679: hypothetical protein +FIG01387791 FIG00523794: hypothetical protein +FIG01387798 COG2214: DnaJ-class molecular chaperone +FIG01387806 FIG00763981: hypothetical protein +FIG01387807 FIG00343781: hypothetical protein +FIG01387828 FIG00469228: hypothetical protein +FIG01387845 Drug efflux membrane protein +FIG01387848 mannosyltransferase +FIG01387854 FIG00425472: hypothetical protein +FIG01387858 Hypothetical acetyltransferases BadL +FIG01387863 Proton/glutamate symporter +FIG01387871 DEOXYCYTIDYLATE DEAMINASE (EC 3.5.4.12) +FIG01387875 FIG00631735: hypothetical protein +FIG01387886 BH3413 unknown +FIG01387946 putative K+-transporting ATPase, F subunit +FIG01387953 FIG00356130: hypothetical protein +FIG01387957 phosphoesterase, putative +FIG01387959 cytochrome b/b6-like +FIG01387966 heat shock protein, hsp90-family +FIG01387980 FIG00743585: hypothetical protein +FIG01387985 FIG00469033: hypothetical protein +FIG01387992 FIG00416726: hypothetical protein +FIG01388000 putative fatty acid desaturase +FIG01388002 Secreted trypsin-like serine protease +FIG01388011 Bll8149 protein +FIG01388014 spore germination protein KB +FIG01388032 Branched-chain amino acid transport ATP-binding protein livF +FIG01388035 Response regulator receiver domain protein(CheY) +FIG01388056 FIG00871673: hypothetical protein +FIG01388068 Radical SAM domain heme biosynthesis protein +FIG01388069 putative sigma-54-dependent transcriptional regulator +FIG01388073 probable transporter, LysE family +FIG01388079 COG3152: Predicted membrane protein +FIG01388096 histidine kinase-related ATPase, putative +FIG01388134 Serine/Threonine protein kinase with TPR repeats( EC:2.7.1.123 ) +FIG01388136 hypothetical truncated transposase +FIG01388147 FIG00388092: hypothetical protein +FIG01388206 TetR family transcriptional regulator +FIG01388210 FIG00390312: hypothetical protein +FIG01388213 SAM-dependent methyltransferase PA0798 (UbiE paralog) +FIG01388223 hypothetical protein +FIG01388234 FIG00407569: hypothetical protein +FIG01388237 DNA-binding transcriptional regulator +FIG01388262 Esterase A +FIG01388266 FIG00710661: hypothetical protein +FIG01388277 Archaeosine cluster gene X +FIG01388293 FIG00470644: hypothetical protein +FIG01388330 FIG00850400: hypothetical protein +FIG01388347 FIG01232938: hypothetical protein +FIG01388355 Mll5186 protein +FIG01388356 B. burgdorferi predicted coding region BB0346 +FIG01388371 "Probable conserved Proline, Glycine, Valine-rich secreted protein" +FIG01388377 FIG00352595: hypothetical protein +FIG01388418 hypothetical protein APECO1_2271 +FIG01388449 Putative serine/threonine protein phosphatase (EC 3.1.3.16) +FIG01388463 DUF1980 domain-containing protein +FIG01388482 Possible alpha/beta hydrolase superfamily, alr3514 homolog +FIG01388499 Uncharacterized protein yxjJ +FIG01388522 Conserved hypothetical protein 2271, C-terminal +FIG01388528 FIG00415194: hypothetical protein +FIG01388529 FIG00765090: hypothetical protein +FIG01388536 FIG00350146: hypothetical protein +FIG01388540 acetylxylan esterase( EC:3.1.1.72 ) +FIG01388544 PHP N-terminal domain protein +FIG01388551 Phage protein +FIG01388569 FIG01233975: hypothetical protein +FIG01388578 protein of unknown function DUF815 +FIG01388594 FIG00897953: hypothetical protein +FIG01388596 FIG00405810: hypothetical protein +FIG01388597 truncated IS1193 transposase +FIG01388598 Dipeptidyl aminopeptidase/acylaminoacyl-peptidase related protein +FIG01388604 RND-type multidrug efflux pump, membrane permease +FIG01388605 alpha/beta hydrolase superfamily +FIG01388606 Secreted alkaline metalloproteinase (EC 3.4.24.-), PrtA/B/C/G homolog +FIG01388621 FIG01032635: hypothetical protein +FIG01388631 HtpA +FIG01388635 O-unit polymerase-like protein YPO3105 +FIG01388637 FIG00850019: hypothetical protein +FIG01388643 FIG00826613: hypothetical protein +FIG01388646 hypothetical protein +FIG01388649 hemolysin III (yplQ) +FIG01388661 hypothetical protein +FIG01388686 ATP-binding region, ATPase-like:Histidine kinase, HAMP region +FIG01388698 FIG00414131: hypothetical protein +FIG01388712 FIG01048993: hypothetical protein +FIG01388725 Exopolygalacturonase precursor +FIG01388746 FIG01046907: hypothetical protein +FIG01388747 FIG00775233: hypothetical protein +FIG01388748 FIG00409988: hypothetical protein +FIG01388762 FIG01388762: membrane lipoprotein +FIG01388763 3-hydroxyacyl-CoA dehydrogenase [isoleucine degradation] (EC 1.1.1.35) +FIG01388768 DNA for 25-36 DEGREE region containing the AMYE-SRFA region, complete CDS +FIG01388773 COG0762 +FIG01388776 Mur ligase middle domain protein +FIG01388790 Lipoprotein releasing system (ABC transporter) ATP-binding protein lolD +FIG01388807 FIG01279648: hypothetical protein +FIG01388814 FIG00688066: hypothetical protein +FIG01388828 Srm +FIG01388831 Glycogen debranching enzyme +FIG01388846 Raffinose operon transcriptional regulatory protein RafR +FIG01388852 Gll1598 protein +FIG01388854 AAA-type ATPase +FIG01388866 COG0545: FKBP-type peptidyl-prolyl cis-trans isomerases 1 +FIG01388875 Transposase for IS1272 +FIG01388876 biphenyl-2,3-diol 1,2-dioxygenase III-related protein VCA0463 VCA0328 VCA0341 +FIG01388880 FIG00742613: hypothetical protein +FIG01388883 serine/threonine protein kinase +FIG01388886 FIG00532421: hypothetical protein +FIG01388901 MutT/NUDIX family protein +FIG01388905 Protein of unknown function DUF785 +FIG01388915 MutR +FIG01388919 similar to amino acid transport protein (partial length) +FIG01388921 FIG00352794: hypothetical protein +FIG01388924 FIG01243105: hypothetical protein +FIG01388933 POSSIBLE ALANINE AND PROLINE RICH MEMBRANE PROTEIN +FIG01388954 Transcriptional regulator, TetR family +FIG01388958 putative NADH dehydrogenase; NAD(P)H nitroreductase +FIG01388968 FIG00498486: hypothetical protein +FIG01388980 probable anti-SigV factor (Bacillus subtilis ortholog) +FIG01388981 Tyrosine type site-specific recombinase +FIG01388999 late competence protein +FIG01389019 POSSIBLE CONSERVED LIPOPROTEIN LPPE +FIG01389035 FIG00764889: hypothetical protein +FIG01389036 FIG00405993: hypothetical protein +FIG01389063 IclR-family transcriptional regulator +FIG01389078 FIG00361954: hypothetical protein +FIG01389087 FIG00769376: hypothetical protein +FIG01389090 FIG00413250: hypothetical protein +FIG01389115 FIG00384870: hypothetical protein +FIG01389135 IncI1 plasmid conjugative transfer protein TraV +FIG01389146 Probable cell wall-binding protein +FIG01389164 Putative ion:amino acid symporter +FIG01389170 putative ntegral membrane protein +FIG01389178 Lipid A glucosamine oxidase +FIG01389183 FIG00623008: hypothetical protein +FIG01389187 Transposase, IS30 family +FIG01389190 ABC-type protease exporter, ATP-binding component PrtD/AprD +FIG01389193 FIG00413422: hypothetical protein +FIG01389195 Putative dehydrogenase +FIG01389216 Fic family protein +FIG01389218 FIG01047625: hypothetical protein +FIG01389220 FIG00390166: hypothetical protein +FIG01389248 Cytochrome b +FIG01389250 FIG00350677: hypothetical protein +FIG01389263 virulence-associated protein E +FIG01389280 FIG00403804: hypothetical protein +FIG01389286 FIG00350053: hypothetical protein +FIG01389291 FIG00769024: hypothetical protein +FIG01389293 FIG00524900: hypothetical protein +FIG01389315 FIG00763710: hypothetical protein +FIG01389319 RfbT protein +FIG01389334 IS1480 transposase +FIG01389344 FIG00352701: hypothetical protein +FIG01389347 prophage Lp1 protein 5 +FIG01389374 Cupin 2 conserved barrel domain protein +FIG01389390 membrane protein, putative, (pXO2-14) +FIG01389391 ExiS +FIG01389397 Bifidobacterial FemAB-like protein type 1 +FIG01389400 FIG00764583: hypothetical protein +FIG01389421 FIG00532020: hypothetical protein +FIG01389446 Amino acid transporter, permease +FIG01389454 Trichohyalin +FIG01389474 FIG00387927: hypothetical protein +FIG01389502 All2396 protein +FIG01389503 Glycerol dehydratase reactivation factor large subunit +FIG01389511 FIG00355156: hypothetical protein +FIG01389518 ATP-dependent protease La domain protein +FIG01389519 nonstructural protein +FIG01389534 FIG01249566: hypothetical protein +FIG01389537 PII-type proteinase precursor (EC 3.4.21.96) +FIG01389540 FIG00528993: hypothetical protein +FIG01389548 RidA/YER057c/UK114 superfamily, group 1 +FIG01389557 two-component sensor +FIG01389577 ADP-ribosylation/Crystallin J1 +FIG01389585 FIG00451976: hypothetical protein +FIG01389593 FIG00826747: hypothetical protein +FIG01389604 transcriptional regulator, UvrC family +FIG01389626 FIG00348902: hypothetical protein +FIG01389635 UPF0178 protein BB_0029 +FIG01389652 Hypothetical protein FIG029672 +FIG01389657 motif=tubulin-beta mRNA autoregulation signal +FIG01389665 FIG00817246: hypothetical protein +FIG01389673 unknown function +FIG01389677 Outer membrane protein N +FIG01389687 FIG00637914: hypothetical protein +FIG01389689 FIG00671056: hypothetical protein +FIG01389694 MoeA-like, domain I and II +FIG01389702 FIG01021722: hypothetical protein +FIG01389707 FIG01107943: hypothetical protein +FIG01389711 FIG00352107: hypothetical protein +FIG01389715 FIG00423835: hypothetical protein +FIG01389718 Purine catabolism regulatory protein +FIG01389723 corresponds to STY0970 from Accession AL513382: Salmonella typhi CT18 +FIG01389729 FIG00408093: hypothetical protein +FIG01389736 guanine deaminase( EC:3.5.4.3 ) +FIG01389748 hypothetical protein +FIG01389751 FIG00849905: hypothetical protein +FIG01389756 probable serine/threonine protein kinase( EC:2.7.1.- ) +FIG01389759 FIG00764843: hypothetical protein +FIG01389773 FIG00349048: hypothetical protein +FIG01389795 FIG00824260: hypothetical protein +FIG01389825 MmsAB operon regulatory protein +FIG01389850 FIG00640419: hypothetical protein +FIG01389866 RND multidrug efflux transporter +FIG01389870 Putative kinase protein +FIG01389888 COGs COG0823 +FIG01389912 Bll0507 protein +FIG01389918 ABC transporter membrane-spanning permease - Na+ export +FIG01389927 FIG00408277: hypothetical protein +FIG01389938 similar to Cellobiose phosphorylase +FIG01389944 transcriptional activator Trip230 protein +FIG01389948 hypothetical protein +FIG01389970 FIG01077145: hypothetical protein +FIG01389972 FIG00524097: hypothetical protein +FIG01389975 FIG01235237: hypothetical protein +FIG01390005 FIG003879: Predicted amidohydrolase; Nit +FIG01390009 FIG00356776: hypothetical protein +FIG01390035 Enterotoxin-like protein +FIG01390038 DNA for glycosyltransferase, lytic transglycosylase, dTDP-4-rhamnose reductase, complete cds +FIG01390067 FIG01059321: hypothetical protein +FIG01390079 ATP-binding protein of ABC transporter system +FIG01390084 Peptidase E +FIG01390101 Mn-dependent transcriptional regulator +FIG01390106 FIG00607492: hypothetical protein +FIG01390110 antigen, P35, putative +FIG01390113 succinyl-diaminopimelate desuccinylase +FIG01390116 hypothetical protein +FIG01390125 Probable galactose-1-phosphate uridyl transferase (EC 2.7.7.12) (Gal-1-P uridylyltransferase) (UDP-glucose--hexose-1-phosphate uridylyltransferase) +FIG01390126 Anti-anti-sigma regulatory factor +FIG01390140 FIG00341375: hypothetical protein +FIG01390159 CvpA family protein +FIG01390174 Pesticin +FIG01390176 Bsr2878 protein +FIG01390187 Putative Dehydrogenase +FIG01390192 cytochrome c554 +FIG01390195 FIG00427247: hypothetical protein +FIG01390213 possible periplasmic protein +FIG01390225 Phosphotransferase system, HPr-related proteins +FIG01390230 Transmembrane transport protein MmpL14 +FIG01390239 FIG00746020: hypothetical protein +FIG01390279 peptidase/PDZ domain protein +FIG01390288 Putative SAM-dependent methyltransferase +FIG01390297 predicted restriction endonuclease +FIG01390300 2-hydroxyacid dehydrogenase +FIG01390308 FidL-like protein +FIG01390321 HD_GYP hydrolase domain fused to HD hydrolase domain +FIG01390350 Phenolpthiocerol synthesis type-I polyketide synthase PpsD +FIG01390362 HTH-type transcriptional regulator yfmP +FIG01390368 Plasmid stabilization system +FIG01390390 FIG01202473: hypothetical protein +FIG01390404 Protein artA +FIG01390409 putative orphan lipoprotein +FIG01390412 Predicted Fe-S-cluster oxidoreductase +FIG01390418 Diguanylate cyclase +FIG01390420 Phycobilisome degradation protein nblA +FIG01390436 FIG071884: Hypothetical protein +FIG01390441 FIG00380169: hypothetical protein +FIG01390450 surface antigen +FIG01390458 Capsular polysaccharide biosynthesis glycosyltransferase capH (EC 2.-.-.-) +FIG01390464 Putative lyase (EC 4.2.1.52) +FIG01390476 FIG00533085: hypothetical protein +FIG01390510 putative sigma-54 interacting response regulator transcription regulator protein +FIG01390516 Carboxymuconolactone decarboxylase (EC 4.1.1.44) +FIG01390554 Molecular chaperone GrpE (heat shock protein) +FIG01390571 FIG01231704: hypothetical protein +FIG01390576 similar to deacylase +FIG01390577 Ca2+/H+ antiporter +FIG01390582 Phage-like element pbsx protein xkdS +FIG01390597 Pathogenicity island protein +FIG01390611 FIG00632900: hypothetical protein +FIG01390619 Flippase +FIG01390631 FIG01002807: hypothetical protein +FIG01390639 tRNA-(G10-N2) methyltransferase; tRNA-(G10-N2) dimethyltransferase +FIG01390657 Microcin H47 secretion protein +FIG01390664 FIG01026460: hypothetical protein +FIG01390667 Cation-transporting P-type ATPase (EC 3.6.1.-) +FIG01390670 Putative outer membrane protein, probably involved in nutrient binding +FIG01390674 Pli0074 protein +FIG01390682 Oleate hydratase (EC 4.2.1.53) +FIG01390701 possible arabinogalactan endo-beta-galactosidase or galactanase +FIG01390702 putative NADH-dependent flavin oxidoreductase +FIG01390711 Response regulator receiver:Metal-dependent phosphohydrolase, HD subdomain +FIG01390729 LpsA protein +FIG01390741 mercuric transport protein periplasmic component +FIG01390751 hypothetical protein +FIG01390760 FIG00388119: hypothetical protein +FIG01390762 FIG00410178: hypothetical protein +FIG01390765 FIG00764074: hypothetical protein +FIG01390775 Methionyl-tRNA formyltransferase related protein +FIG01390782 putative surface-exposed virulence protein +FIG01390785 possible Glycosyl hydrolases family 11 +FIG01390789 FIG01235830: hypothetical protein +FIG01390806 FIG01189810: hypothetical protein +FIG01390807 FIG00555555: hypothetical protein +FIG01390811 DpnD protein +FIG01390817 bacterial luciferase family protein +FIG01390825 Putative C4-dicarboxylate transport protein +FIG01390826 Transcriptional activator cadC +FIG01390830 FIG00630701: hypothetical protein +FIG01390831 LigA, interaptin +FIG01390835 hypothetical protein +FIG01390845 Putative outer membrane lipoprotein Pcp precursor +FIG01390860 Muramidase-released protein precursor (136 kDa surface protein) +FIG01390869 Hydroxyproline dehydratase putative +FIG01390897 Tll0567 protein +FIG01390904 cation transporting ATPase, P-type ATPase superfamily( EC:3.6.3.8 ) +FIG01390916 FIG00514523: hypothetical protein +FIG01390920 FIG01116901: hypothetical protein +FIG01390931 Non-heme chloroperoxidase +FIG01390934 Adenylyl cyclase class-3/4/guanylyl cyclase +FIG01390939 FIG00765500: hypothetical protein +FIG01390940 sugar ABC transporter, permease protein, putative +FIG01390972 FIG00413440: hypothetical protein +FIG01390977 replication terminator protein +FIG01390979 hypothetical protein +FIG01390984 FIG00404342: hypothetical protein +FIG01390988 hypothetical protein Rv1839c +FIG01390994 iron-sulfur binding domain protein +FIG01390996 putative transcriptional regulator (LysR family) +FIG01391016 Putative secretion protein +FIG01391044 Phosphoglycerate transporter protein +FIG01391046 FIG00363736: hypothetical protein +FIG01391055 FIG00425926: hypothetical protein +FIG01391076 FIG00774504: hypothetical protein +FIG01391081 hypothetical protein +FIG01391085 hypothetical protein +FIG01391105 putative tail fiber assembly protein +FIG01391107 FIG00352776: hypothetical protein +FIG01391115 Collagen alpha 2(IV) chain precursor +FIG01391119 Glycoside hydrolase, family 25 +FIG01391120 FIG00385088: hypothetical protein +FIG01391136 Transposase +FIG01391138 putative regulator of efflux transporter +FIG01391152 Uncharacterized protein potentially involved in peptidoglycan biosynthesis +FIG01391154 FIG00755368: hypothetical protein +FIG01391184 lipoprotein, +FIG01391188 necrosis and ethylene inducing protein +FIG01391200 hypothetical protein +FIG01391209 conserved protein (putative ADP-ribose pyrophosphatase) +FIG01391215 FIG00252301: hypothetical protein +FIG01391228 Similar to glycine cleavage system transcriptional activator GcvA +FIG01391233 FIG00407081: hypothetical protein +FIG01391255 Glucosyltransferase-S (EC 2.4.1.5) +FIG01391260 FIG00350016: hypothetical protein +FIG01391279 FIG00768068: hypothetical protein +FIG01391286 FIG00404680: hypothetical protein +FIG01391292 Alr4238 protein +FIG01391301 ycf34 gene product +FIG01391310 ORF182 +FIG01391315 putative fimbrial chaperone +FIG01391318 MunI regulatory protein +FIG01391327 FIG00527644: hypothetical protein +FIG01391354 cellulose synthase catalytic subunit-like protein +FIG01391357 Ureidoglycolate hydrolase +FIG01391359 catalase, Mn-containing +FIG01391412 probable 3-oxoacyl-[acyl-carrier protein] reductase +FIG01391416 putative non-specific DNA binding protein +FIG01391425 Probable transmembrane sensor +FIG01391433 FIG00356641: hypothetical protein +FIG01391438 FIG01069366: hypothetical protein +FIG01391441 Tetracycline-efflux transporter +FIG01391450 Alkaline protease secretion protein aprE +FIG01391455 hypothetical protein +FIG01391471 bem46 protein +FIG01391496 trans-Golgi membrane protein p230 +FIG01391508 FIG00408855: hypothetical protein +FIG01391511 FIG01230455: hypothetical protein +FIG01391513 vir-repressed protein +FIG01391532 ABC transporter, ATP-binding protein (yhcG) +FIG01391549 porin +FIG01391553 HTH-type transcriptional regulator glxA +FIG01391566 FIG00825370: hypothetical protein +FIG01391580 putative sialic acid-specific acetylesterase +FIG01391586 Calcium-transporting ATPase +FIG01391588 Vitamin K-dependent gamma-carboxylase +FIG01391604 FIG00532294: hypothetical protein +FIG01391615 uncharacterized domain / RidA/YER057c/UK114 superfamily, group 5 +FIG01391624 peptidase C14 caspase catalytic subunit p20 +FIG01391626 Helicase-like +FIG01391631 PfpUB Plasmodium falciparum polyubiquitin +FIG01391633 hemin uptake protein, putative +FIG01391635 Putative ABC transporter +FIG01391638 FIG00388330: hypothetical protein +FIG01391643 ABC transporter (ATP-binding protein)-putative sodium extrusion ABC transporter +FIG01391659 Chitinase family protein +FIG01391671 FIG00352486: hypothetical protein +FIG01391682 FIG00731440: hypothetical protein +FIG01391691 SLH, S-layer homology domain +FIG01391712 Probable ferredoxin subunit of a ring-hydroxylating dioxygenase oxidoreductase protein (EC 1.-.-.-) +FIG01391735 Methyl-accepting chemotaxis protein, homolog 9 +FIG01391748 16S ribosomal RNA m(5)C 967 methyltransferase +FIG01391758 FIG00696737: hypothetical protein +FIG01391764 Iron-sulfur cluster binding protein +FIG01391765 FIG00767275: hypothetical protein +FIG01391784 ISNCY family transposase +FIG01391841 probably ATPase with chaperone activity, ATP-binding domain, evidenced by COGnitor +FIG01391843 Gll2184 protein +FIG01391848 FIG00416118: hypothetical protein +FIG01391858 FIG01229847: hypothetical protein +FIG01391870 Transcriptional regulator, LysR family, homolog 9 +FIG01391882 C5-O-methyltransferase +FIG01391895 syc1254_c +FIG01391902 FIG00351986: hypothetical protein +FIG01391915 Insertion element IS1 protein insA +FIG01391918 K channel inward rectifier conserved region 2 domain protein +FIG01391920 FIG01251922: hypothetical protein +FIG01391924 B. burgdorferi predicted coding region BB0156 +FIG01391932 FIG00631234: hypothetical protein +FIG01391933 DNA-directed RNA polymerase, omega subunit +FIG01391938 FIG00348130: hypothetical protein +FIG01391944 probable serine/threonine protein phosphatase( EC:3.1.3.16 ) +FIG01391949 Putative phage replication protein RstA +FIG01391953 CHAD domain containing protein +FIG01391958 type 3a, cellulose-binding +FIG01391960 protein of unknown function DUF554 +FIG01391972 probable peptidase VC1983 +FIG01391978 FIG00763556: hypothetical protein +FIG01391982 Intermediate filament protein:ATP/GTP-binding site motif A (P-loop):AAA ATPase +FIG01391983 Outer membrane protein 18/16 +FIG01391992 FIG00638051: hypothetical protein +FIG01392042 FIG01252174: hypothetical protein +FIG01392068 FIG00769273: hypothetical protein +FIG01392079 transposase related protein (20) +FIG01392083 transcriptional regulatory component of sensory transduction system +FIG01392094 putative spermidine synthase +FIG01392096 putative conjugative transfer protein TraA +FIG01392100 FIG01049466: hypothetical protein +FIG01392115 direct repeat protein +FIG01392149 hypothetical protein Rv1667c +FIG01392152 DNA uptake lipoprotein-like +FIG01392159 ATP-dependent exoDNAse (exonuclease V) alpha subunit - helicase superfamily I member +FIG01392169 ROrf1 +FIG01392179 Hyaluronate lyase (EC 4.2.2.1) +FIG01392188 Putative membrane protein mmpL5 +FIG01392194 putative cytokinin oxidase +FIG01392200 FIG00406560: hypothetical protein +FIG01392211 Predicted Fe-S protein +FIG01392216 FIG00733226: hypothetical protein +FIG01392219 Oxidoreductase, short chain dehydrogenase/reductase family protein +FIG01392222 FIG00410399: hypothetical protein +FIG01392252 alkaline serine protease, subtilase family +FIG01392256 Disulfide bond formation protein DsbB, putative +FIG01392275 FIG01129788: hypothetical protein +FIG01392276 MchC protein +FIG01392278 UDP-N-acetylmuramoylpentapeptide-lysine N(6)-alanyltransferase (EC 2.3.2.10) +FIG01392280 putative sensor (PAS) domain for methyl-accepting chemotaxis sensory transducer +FIG01392303 RNA helicase +FIG01392308 RND family efflux transporter, MFP subunit +FIG01392310 guanine-specific ribonuclease N1 and T1 +FIG01392312 peptidase, M23/M37 family +FIG01392315 Hypothetical protein Cj0567 +FIG01392316 Subtilase-type protease inhibitor precursor +FIG01392317 FIG00402837: hypothetical protein +FIG01392320 FIG00388411: hypothetical protein +FIG01392328 COG3402: Uncharacterized conserved protein +FIG01392331 FIG00412480: hypothetical protein +FIG01392373 alpha/beta hydrolase fold-3 +FIG01392374 Alginate biosynthesis protein Alg44 +FIG01392377 FIG01156150: hypothetical protein +FIG01392379 Amino acid ABC transporter, permease protein, 3-TM region, His/Glu/Gln/Arg/opine +FIG01392381 Amidohydrolase precursor +FIG01392382 Sll0428 protein +FIG01392394 MafB-related protein +FIG01392416 FIG00945998: hypothetical protein +FIG01392423 FIG00822526: hypothetical protein +FIG01392436 FIG00390376: hypothetical protein +FIG01392437 transposase, IS5 family +FIG01392445 FIG01237302: hypothetical protein +FIG01392497 FIG00348557: hypothetical protein +FIG01392505 Hypothetical protein, CF-13 family +FIG01392515 FIG00734492: hypothetical protein +FIG01392522 FIG00410335: hypothetical protein +FIG01392530 FIG00385258: hypothetical protein +FIG01392544 FIG00404238: hypothetical protein +FIG01392547 Uncharacterized membrane protein, ortholog YYAS B.subtilis +FIG01392555 clindamycin resistance transfer factor BtgA +FIG01392578 putative N-myristoyl transferase +FIG01392590 flagella accessory protein FlaCE +FIG01392599 Bacterial regulatory proteins, crp family +FIG01392632 Hypothetical protein SO_0813 +FIG01392664 putative large ATP-binding protein +FIG01392669 FIG00352177: hypothetical protein +FIG01392700 Cutinase +FIG01392705 FIG00385442: hypothetical protein +FIG01392707 N-acetyltransferase, GNAT family +FIG01392708 no significant database match found. Contains Prenyl group binding site (CAAX box) (Interpro|IPR001230) +FIG01392722 Serine/threonine phosphatase +FIG01392727 COG0393: Uncharacterized conserved protein +FIG01392734 probable integral membrane protein NMA0329 +FIG01392744 putative ABC transporter integral membrane transport protein +FIG01392756 FIG00821256: hypothetical protein +FIG01392764 FIG00405557: hypothetical protein +FIG01392792 FIG00347992: hypothetical protein +FIG01392794 HrpX related protein +FIG01392806 nucleotidyltransferase substrate-binding protein +FIG01392827 FIG00766837: hypothetical protein +FIG01392833 FIG00384859: hypothetical protein +FIG01392835 conserved hypothetical protein SCF56.19 +FIG01392844 Putative dehydrogenase precursor +FIG01392855 probable bacteriophage protein STY1060 +FIG01392890 chromate transport protein +FIG01392897 sulfatase domain protein, putative +FIG01392905 CdsJ +FIG01392909 FIG01205751: hypothetical protein +FIG01392915 2,4'-dihydroxyacetophenone dioxygenase +FIG01392948 X polypeptide +FIG01392951 FIG01108880: hypothetical protein +FIG01392963 Putative cI repressor protein for prophage CP-933H +FIG01392972 Mlr1652 protein +FIG01392981 Serine acetyltransferase( EC:2.3.1.30 ) +FIG01392996 Export protein for polysaccharides and teichoic acids +FIG01393002 Methanol oxidation genes, glmU-like +FIG01393018 hypothetical protein +FIG01393039 FIG00767624: hypothetical protein +FIG01393044 similar to Multimeric flavodoxin WrbA +FIG01393064 Possible Galanin +FIG01393071 syc2324_c +FIG01393078 Pleiotropic regulatory protein +FIG01393107 protein of unknown function DUF885 +FIG01393109 All7590 protein +FIG01393113 putative ATP-binding component of ABC transporter +FIG01393134 core protein +FIG01393143 FIG00640303: hypothetical protein +FIG01393144 UVB-resistance protein UVR8 +FIG01393147 transglycosylase associated protein +FIG01393157 FIG00407922: hypothetical protein +FIG01393167 FIG01202911: hypothetical protein +FIG01393180 FIG00751031: hypothetical protein +FIG01393188 transporter, LysE family protein +FIG01393196 Mitomycin resistance protein +FIG01393208 D-lactate dehydrogenase-related protein +FIG01393212 FIG00384914: hypothetical protein +FIG01393218 probable phasin +FIG01393232 ChW repeat-containing protein +FIG01393236 ortholog to Borrelia burgdorferi BB0325 +FIG01393240 FIG00764645: hypothetical protein +FIG01393264 Uncharacterized protein y4hO +FIG01393269 Chaperone protein lpfB precursor +FIG01393274 FIG00713314: hypothetical protein +FIG01393282 uncharacterized component of anaerobic dehydrogenase +FIG01393289 FIG01240613: hypothetical protein +FIG01393294 Chaperone protein psaB precursor +FIG01393296 Appr-1-p processing enzyme family protein homolog +FIG01393315 FIG00404931: hypothetical protein +FIG01393334 FIG00403272: hypothetical protein +FIG01393335 putative histone-like DNA-binding protein +FIG01393336 FIG00867760: hypothetical protein +FIG01393343 Rieske iron-sulfur protein +FIG01393346 Bifunctional protein: zinc-containing alcohol dehydrogenase; quinone oxidoreductase ( NADPH:quinone reductase) (EC 1.1.1.-); Similar to arginate lyase +FIG01393367 TOPRIM domain protein +FIG01393370 tRNA-specific adenosine-34 deaminase (EC 3.5.4.-) +FIG01393399 ParA family chromosome partitioning protein +FIG01393404 putative recombination protein O +FIG01393407 FIG00352664: hypothetical protein +FIG01393409 N-acetylmuramoyl-L-alanine amidase xlyB precursor (EC 3.5.1.28) +FIG01393412 RarD protein, chloamphenicol sensitive +FIG01393419 FIG00827800: hypothetical protein +FIG01393432 Plasmid stability protein +FIG01393434 Lipoprotein LppS +FIG01393451 FIG00763117: hypothetical protein +FIG01393456 FIG00349431: hypothetical protein +FIG01393460 probable peptidyl-prolyl cis-trans isomerase +FIG01393468 FIG00432976: hypothetical protein +FIG01393480 FIG00610238: hypothetical protein +FIG01393513 FIG00633275: hypothetical protein +FIG01393515 putative regulatory protein. +FIG01393530 Poly(3-hydroxybutyrate) depolymerase-like protein +FIG01393535 RNA polymerase sigma-H factor +FIG01393547 putative DNA binding protein +FIG01393551 hypothetical protein +FIG01393567 Hydrolase of the alpha/beta superfamily in cluster with COG2110 +FIG01393577 putative transmembrane protein +FIG01393579 FIG00769424: hypothetical protein +FIG01393604 ABC transporter (membrane spanning protein) +FIG01393606 Delta(24(24(1)))-sterol reductase (EC 1.3.1.71); Delta(14)-sterol reductase (EC 1.3.1.70); 7-dehydrocholesterol reductase (EC 1.3.1.21) +FIG01393607 Putative glycosyl transferase WbaR +FIG01393610 Protein of unknown function DUF340, prokaryotic membrane +FIG01393611 agglutinin receptor +FIG01393619 FIG00736926: hypothetical protein +FIG01393623 probable 5-valerolactone hydrolase +FIG01393624 Uncharacterized protein Cj0990c +FIG01393631 FIG01244843: hypothetical protein +FIG01393633 conserved hypothetical protein +FIG01393647 Choline kinase involved in LPS biosynthesis +FIG01393653 molybdopterin converting factor subunit 2 +FIG01393661 FIG00545214: hypothetical protein +FIG01393667 FIG00424156: hypothetical protein +FIG01393705 FIG00606595: hypothetical protein +FIG01393712 metal-dependent hydrolase-like +FIG01393728 FIG00361685: hypothetical protein +FIG01393737 FIG00344391: hypothetical protein +FIG01393742 Periplasmic alpha-galactoside-binding protein precursor +FIG01393749 branched-chain amino acid transport ATP-binding protein livF +FIG01393767 thio-disulfide isomerase/thioredoxin +FIG01393812 hypothetical protein-putative related to sulfatases +FIG01393828 Possible fucose ABC transporter, ATP-binding component +FIG01393835 Low molecular weight protein antigen 6 +FIG01393852 FIG00344622: hypothetical protein +FIG01393871 predicted DNA-binding proteins +FIG01393901 FIG00388821: hypothetical protein +FIG01393916 B. burgdorferi predicted coding region BB0823 +FIG01393919 FIG00469754: hypothetical protein +FIG01393929 FIG00883731: hypothetical protein +FIG01393930 FIG00514757: hypothetical protein +FIG01393936 FIG01115883: hypothetical protein +FIG01393940 FIG027348: hypothetical protein +FIG01393964 Nitroreductase family protein fused to ferredoxin domain +FIG01393965 transcriptional regulator of molybdate metabolism, XRE family +FIG01393968 MrpH protein +FIG01393971 chemotaxis protein CheA +FIG01393972 FIG00836492: hypothetical protein +FIG01393976 O-chlorophenol reductive dehalogenase +FIG01393982 3-methyladenine DNA glycosylase, putative +FIG01393988 ATPase, ParA family +FIG01393993 GFO/IDH/MOCA family oxidoreductase +FIG01394010 voltage-gated chloride channel family protein +FIG01394033 FIG00414092: hypothetical protein +FIG01394047 FIG00733270: hypothetical protein +FIG01394052 Amine oxidase [flavin-containing] (EC 1.4.3.4) +FIG01394119 FIG00343918: hypothetical protein +FIG01394123 RhsB protein precursor +FIG01394124 Probable monooxygenase Y4ID (EC 1.14.13.-) +FIG01394156 Alkyldihydroxyacetonephosphate synthase (EC 2.5.1.26) +FIG01394158 Lincosamide nucleotidyltransferase +FIG01394175 FrnE protein +FIG01394185 FIG00564367: hypothetical protein +FIG01394190 Diacyglycerol O-acyltransferase (EC 2.3.1.20) +FIG01394195 transposase (resolvase, DNA invertase) +FIG01394198 FIG00414468: hypothetical protein +FIG01394255 FIG00350230: hypothetical protein +FIG01394278 Soluble lytic murein transglycosylase and related regulatory proteins +FIG01394296 Protein psaE precursor +FIG01394303 ATP binding protein +FIG01394321 Prabable sialidase +FIG01394324 FIG00402811: hypothetical protein +FIG01394327 Tn5252, relaxase +FIG01394347 Hypothetical protein-phage associated +FIG01394358 PapJ protein +FIG01394362 FIG00526296: hypothetical protein +FIG01394388 prophage pi3 protein 59 +FIG01394391 FIG00405022: hypothetical protein +FIG01394408 putative two-component system sensor histidine kinase/response regulator fusion protein +FIG01394418 prophage P2W3, tail protein U, putative +FIG01394422 FIG00624311: hypothetical protein +FIG01394456 NAD/FAD-utilizing enzyme apparently involved in cell division +FIG01394460 FIG01225302: hypothetical protein +FIG01394466 FIG00510982: hypothetical protein +FIG01394502 dipeptidase-related protein +FIG01394510 Probable monooxygenase +FIG01394520 sigma-70 factor, ECF subfamily +FIG01394530 FIG01222582: hypothetical protein +FIG01394533 CinA-like protein +FIG01394543 FIG00471323: hypothetical protein +FIG01394550 candidate type III effector HolPtoQ +FIG01394562 Lipoprotein LprG precursor +FIG01394571 cell wall-associated protein, putative +FIG01394579 Capsule biosynthesis protein capA +FIG01394594 FIG00349653: hypothetical protein +FIG01394610 IS66 family element, Orf1 +FIG01394624 SMF family protein, DNA processing chain A (dprA) +FIG01394628 Copper resistance protein +FIG01394636 putative amino acid transport protein (ABC superfamily, membrane) +FIG01394660 FIG00695970: hypothetical protein +FIG01394680 Type II restriction enzyme Sau3AI (EC 3.1.21.4) +FIG01394725 FIG00904221: hypothetical protein +FIG01394729 FIG01199912: hypothetical protein +FIG01394731 predicted exopolyphosphatase +FIG01394735 FIG00404105: hypothetical protein +FIG01394738 FIG01095481: hypothetical protein +FIG01394758 FIG00514340: hypothetical protein +FIG01394773 Phage-related transcriptional transcriptional regulator +FIG01394830 Mobile element protein +FIG01394852 FIG00673086: hypothetical protein +FIG01394855 FIG00388951: hypothetical protein +FIG01394882 Putative secretion permease +FIG01394916 ORFg protein +FIG01394929 cyclase family protein +FIG01394936 Cell wall-associated hydrolases (invasion-associated proteins) +FIG01394959 hypothetical protein +FIG01394965 BioD-like N-terminal domain of phosphotransacetylase +FIG01394977 pXO1-08 +FIG01394986 Aminoacylase/N-acyl-L-amino acid amidohydrolase/hippurate hydrolase +FIG01394990 Pneumococcal histidine triad protein E precursor, truncation +FIG01394993 FIG00639242: hypothetical protein +FIG01395012 C-factor, putative +FIG01395013 FIG00896590: hypothetical protein +FIG01395024 transport and binding protein +FIG01395033 FIG00764450: hypothetical protein +FIG01395034 Hemin binding protein c +FIG01395041 FIG01108874: hypothetical protein +FIG01395042 FIG00861086: hypothetical protein +FIG01395055 Complete genome; segment 14/17 +FIG01395056 ThiJ/PfpI family +FIG01395058 GNAT family acetyltransferase +FIG01395060 hypothetical protein NMA1079 +FIG01395063 multiple antibiotic resistance (MarC)-related protein +FIG01395072 LacI-family regulatory protein +FIG01395109 FIG00817446: hypothetical protein +FIG01395124 Aminopyrrolnitrin oxidase PrnD +FIG01395125 putative secretory protein +FIG01395127 FIG00450885: hypothetical protein +FIG01395130 putative inner membrane or exported protein +FIG01395144 FIG00766688: hypothetical protein +FIG01395153 Bacterial cell division membrane protein +FIG01395164 similar to Glycine cleavage system H protein +FIG01395166 FIG00631083: hypothetical protein +FIG01395168 Glucanase C +FIG01395171 FIG01232686: hypothetical protein +FIG01395185 Multimeric flavodoxin WrbA family protein +FIG01395187 putative plasmid maintenance protein +FIG01395192 FIG00939142: hypothetical protein +FIG01395209 FIG00425957: hypothetical protein +FIG01395234 DNA-directed RNA polymerase, beta subunit/140 kD subunit +FIG01395240 Putative peptidoglycan hydrolase +FIG01395247 Regulatory sensor-transducer, BlaR1/MecR1 family +FIG01395249 FIG00623513: hypothetical protein +FIG01395254 ComK-like +FIG01395258 FIG00764405: hypothetical protein +FIG01395286 FIG00512697: hypothetical protein +FIG01395287 Hypothetical lipoprotein ybfP precursor +FIG01395302 Mrr restriction protein-related +FIG01395303 FIG01252213: hypothetical protein +FIG01395319 Glyoxalase/Bleomycin resistance protein/dioxygenase domain +FIG01395321 Putative membrane peptidase, contains TPR repeat domain +FIG01395333 FIG00406966: hypothetical protein +FIG01395337 FIG01242369: hypothetical protein +FIG01395338 SpnT +FIG01395340 Glycosyl transferase, group 1:TPR repeat +FIG01395349 lipid A biosynthesis lauroyl acyltransferase +FIG01395357 FIG00733885: hypothetical protein +FIG01395361 DevC-like ABC transporter permease component +FIG01395377 FIG00384951: hypothetical protein +FIG01395382 FIG00404794: hypothetical protein +FIG01395401 FIG00418115: hypothetical protein +FIG01395405 exported protein (tpn38b) +FIG01395437 type II/IV secretion system protein, TadC subfamily protein +FIG01395479 Uncharacterized protein conserved in archaea +FIG01395482 FIG00498671: hypothetical protein +FIG01395484 FIG00363219: hypothetical protein +FIG01395490 FIG00408350: hypothetical protein +FIG01395503 similar to XisI protein +FIG01395507 FIG00353637: hypothetical protein +FIG01395536 GfdT +FIG01395537 FIG00356668: hypothetical protein +FIG01395548 putative type I restriction modification system related protein +FIG01395567 Competence protein ComL precursor +FIG01395580 SN-glycerol-3-phosphate transport system permease protein UgpE (TC 3.A.1.1.3) +FIG01395600 ISSod12, transposase +FIG01395623 FIG00848911: hypothetical protein +FIG01395635 cell division protein +FIG01395678 FIG00763709: hypothetical protein +FIG01395688 Succinyl-diaminopimelate desuccinylase +FIG01395690 FIG00768741: hypothetical protein +FIG01395702 Uncharacterized protein MJ0833 +FIG01395711 retinol dehydrogenase 13 (all-trans and 9-cis) +FIG01395737 ATP binding protein of ABC transporter for pentoses +FIG01395745 seq ID no 1F, putative +FIG01395752 Extracellular endo-1,4-glucanase +FIG01395753 FIG01196669: hypothetical protein +FIG01395755 FIG00352030: hypothetical protein +FIG01395763 negative transcriptional regulator +FIG01395773 ThMPase type I predicted +FIG01395781 glycosyl hydrolase, family 9 +FIG01395785 ORF26 +FIG01395793 cag pathogenicity island protein (cag18) +FIG01395806 putative dihydrolipoamide dehydrogenase +FIG01395807 FIG00344727: hypothetical protein +FIG01395825 FIG00350320: hypothetical protein +FIG01395839 FIG00768390: hypothetical protein +FIG01395842 hypothetical protein +FIG01395846 putative NADH dehydrogenase/NAD(P)H nitroreductase +FIG01395851 FIG00674767: hypothetical protein +FIG01395854 Modular polyketide synthase +FIG01395867 FIG01166964: hypothetical protein +FIG01395884 Serine/threonine-protein kinase PknD (EC 2.7.11.1) +FIG01395897 SNF2 related domain:DEAD/DEAH box helicase:Helicase C-termina... +FIG01395928 FIG00762790: hypothetical protein +FIG01395940 FIG01115748: hypothetical protein +FIG01395958 alkaline amylopullulanase, truncated +FIG01395971 amino acid ABC transporter, inner membrane subunit +FIG01395980 chaperone DnaJ +FIG01395981 CheY-like response regulator domain +FIG01395984 transport protein, putative +FIG01396004 FIG00468711: hypothetical protein +FIG01396009 Putative membrane protein +FIG01396016 putative peptidase M13 family protein +FIG01396017 FIG00534760: hypothetical protein +FIG01396019 FIG00451550: hypothetical protein +FIG01396021 Repeats containing protein +FIG01396022 Serine/Threonine protein kinase( EC:2.7.1.123 ) +FIG01396030 Two component sensor histidine kinase (EC 2.7.3.-) +FIG01396031 Egg case silk protein-1 +FIG01396035 FIG00849766: hypothetical protein +FIG01396041 Glutamate transport ATP-binding protein gluA +FIG01396054 FIG00821010: hypothetical protein +FIG01396062 permease YjgP/YjgQ family protein +FIG01396083 FIG00362255: hypothetical protein +FIG01396095 FIG00624395: hypothetical protein +FIG01396103 Putative hydrogenase cytochrome b subunit +FIG01396111 FIG00841658: hypothetical protein +FIG01396117 Putative esterase/lipase +FIG01396135 ortholog to Borrelia burgdorferi BB0541 +FIG01396147 BH0638 unknown conserved protein +FIG01396154 virulence associated protein D (vapD) +FIG01396157 TcrA +FIG01396180 positive regulation of multidrug-efflux transporter genes (bmr and blt) +FIG01396185 histidine decarboxylase, pyruvoyl type( EC:4.1.1.22 ) +FIG01396189 Transposase, IS4 +FIG01396198 FIG01239348: hypothetical protein +FIG01396200 outer membrane lipoprotein, putative +FIG01396203 FIG00351284: hypothetical protein +FIG01396248 TIORF127 protein +FIG01396250 Staphopain A precursor (EC 3.4.22.48) +FIG01396254 tail fiber protein H, putative +FIG01396261 short chain dehydrogenase family protein +FIG01396268 FIG00350885: hypothetical protein +FIG01396277 Aminotransferase, DegT/DnrJ/EryC1/StrS family (EC 4.2.1.-) +FIG01396280 pyridoxal phosphate-dependent enzyme apparently involved in regulation of cell wall biogenesis-like +FIG01396290 MoxR-related ATPase, AAA superfamily +FIG01396291 FIG00538704: hypothetical protein +FIG01396307 basic membrane protein A (bmpA) +FIG01396312 CHAP domain containing protein +FIG01396354 FIG00630271: hypothetical protein +FIG01396362 FIG00645368: hypothetical protein +FIG01396376 ortholog of Bordetella pertussis (BX470248) BP3140 +FIG01396402 cell wall surface anchor family protein, putative +FIG01396430 Integral membrane protein, DUF6 +FIG01396432 Hsp18_3 +FIG01396447 Acyl-CoA dehydrogenase (EC 1.3.8.7) +FIG01396449 FIG00388469: hypothetical protein +FIG01396466 FIG01166913: hypothetical protein +FIG01396468 Siderophore synthetase superfamily, group A +FIG01396476 COG1484: DNA replication protein +FIG01396534 FIG00245341: hypothetical protein +FIG01396537 putative glutamate dehydrogenase +FIG01396543 Uncharacterized ABC transporter ATP-binding protein Rv1348/MT1390 +FIG01396547 Phage NinG rap recombination +FIG01396560 Putative toxin subunit +FIG01396569 Beta-hydroxylase, bleomycin/phleomycin binding protein, ankyrin homologue, bleomycin and transport protein +FIG01396575 FIG00354202: hypothetical protein +FIG01396581 DNA binding domain protein, excisionase family +FIG01396588 protein of unknown function UPF0150 +FIG01396603 YidE/YbjL duplication +FIG01396607 putative tyrosine-protein kinase +FIG01396620 RecF/RecN/SMC family protein +FIG01396626 FIG00350317: hypothetical protein +FIG01396634 Probable Phospholipase/Carboxylesterase family +FIG01396643 Beta-ketoadipyl CoA thiolase (EC 2.3.1.-) +FIG01396654 FIG00820725: hypothetical protein +FIG01396656 Beta-ketoacyl synthase +FIG01396659 Aspartyl aminopeptidase (EC 3.4.11.21) +FIG01396664 FIG00418546: hypothetical protein +FIG01396676 FIG00468491: hypothetical protein +FIG01396681 membrane protein, MmpL family +FIG01396685 FIG00734235: hypothetical protein +FIG01396698 Putative alpha helical protein +FIG01396715 FIG00384985: hypothetical protein +FIG01396728 putative PAS/PAC sensor protein +FIG01396740 response regulator, putative virR +FIG01396766 probable extracellular solute-binding protein +FIG01396789 Genomic DNA, chromosome 3, BAC clone: T19N8 +FIG01396793 ATP/ADP translocase +FIG01396795 Anti-anti-sigma regulatory factor (antagonist of anti-sigma factor) +FIG01396804 Resolvase domain protein +FIG01396830 putative +FIG01396857 FIG00638450: hypothetical protein +FIG01396870 Carbon storage regulator homolog +FIG01396881 Nikkomycin biosynthesis protein SanQ +FIG01396902 FIG01161525: hypothetical protein +FIG01396905 Type III restriction enzyme, res subunit:DEAD/DEAH box helicase, N- terminal +FIG01396922 Uncharacterized protein y4mH +FIG01396936 FIG01251046: hypothetical protein +FIG01396957 L-ribulose-5-phosphate 4-epimerase( EC:5.1.3.4 ) +FIG01396958 FIG00687368: hypothetical protein +FIG01396963 dehydrogenase/reductase +FIG01396967 FIG069766: hypothetical protein +FIG01396985 Calcium-dependent protease precursor (EC 3.4.21.-) +FIG01396988 nucleotidyltransferase family protein +FIG01397001 NanA gene +FIG01397010 Sll0350 protein +FIG01397031 FIG01231100: hypothetical protein +FIG01397061 FIG00424789: hypothetical protein +FIG01397096 FIG00410158: hypothetical protein +FIG01397103 FIG00385037: hypothetical protein +FIG01397108 FIG00642010: hypothetical protein +FIG01397109 Hypothetical protein, CF-3 family +FIG01397133 Glycosyltransferases involved in cell wall biogenesis +FIG01397134 FIG00827103: hypothetical protein +FIG01397142 FIG00711683: hypothetical protein +FIG01397144 Levansucrase (EC 2.4.1.10) +FIG01397145 FIG01249079: hypothetical protein +FIG01397174 TBP-interacting protein TIP49 +FIG01397177 Alr0786 protein +FIG01397189 ABC transporter-like( EC:3.6.3.25 ) +FIG01397195 FIG00711677: hypothetical protein +FIG01397211 GTPases - translation elongation factors +FIG01397223 Leucyl-tRNA synthetase +FIG01397228 Peptidase M20:Peptidase M28 precursor +FIG01397235 FIG00733800: hypothetical protein +FIG01397236 FIG00624018: hypothetical protein +FIG01397241 ribulose-bisphosphate carboxylase-like protein; rubisco-like protein +FIG01397244 probable resolvase +FIG01397246 Peptidase U4, sporulation factor SpoIIGA +FIG01397248 Predicted protease from collagenase family +FIG01397254 Aldo/keto reductase of diketogulonate reductase family( EC:1.1.1.274 ) +FIG01397266 COG1716: FOG: FHA domain +FIG01397288 Invasion protein IbeA +FIG01397294 putative toxin +FIG01397297 probable integrase/recombinase +FIG01397301 UDP-glucose:sterol glucosyltransferase +FIG01397311 ABC-type multidrug transport system, permease component +FIG01397356 Flagellum-specific muramidase +FIG01397358 FIG01046910: hypothetical protein +FIG01397362 FIG00349560: hypothetical protein +FIG01397368 TraI protein +FIG01397388 doubtful CDS with no significant database hits. Very low G+C conent +FIG01397390 FIG00424387: hypothetical protein +FIG01397393 FIG00637878: hypothetical protein +FIG01397415 FIG00769527: hypothetical protein +FIG01397429 putative GGDEF family protein +FIG01397433 FIG00407857: hypothetical protein +FIG01397438 arginine utilization regulatory protein RocR +FIG01397440 RNA polymerase sigma factor SigX, putative +FIG01397480 FIG00711149: hypothetical protein +FIG01397512 Fimbrial subunit precursor +FIG01397514 Aminoglycoside N (6') -acetyltransferase +FIG01397518 FIG00411514: hypothetical protein +FIG01397524 50S ribosomal protein L22 +FIG01397527 DNA ligase( EC:6.5.1.1 ) +FIG01397542 HNH endonuclease family protein +FIG01397574 Osmotically activated L-carnitine ABC transporter, ATP binding protein, opuCA +FIG01397576 FIG01122933: hypothetical protein +FIG01397582 hypothetical protein +FIG01397610 Hypothetical protein USSDB1A +FIG01397620 prophage Lp1 protein 22 +FIG01397628 Uncharacterized oxidoreductase ydgJ (EC 1.-.-.-) +FIG01397631 FIG01178559: hypothetical protein +FIG01397632 Unknown protein encoded by cryptic prophage +FIG01397652 probable integrase for prophage CP-933R intR +FIG01397653 FIG00767638: hypothetical protein +FIG01397662 FIG00624622: hypothetical protein +FIG01397663 probable integrase for prophage CP-933R intR +FIG01397667 Modification methylase BamHI (EC 2.1.1.113) (N(4)- cytosine-specific methyltransferase BamHI) (M.BamHI) +FIG01397671 FIG00528609: hypothetical protein +FIG01397674 mobilization protein MobC +FIG01397681 FIG00763780: hypothetical protein +FIG01397684 Transcriptional regulator, Cro/CI family +FIG01397690 S-layer-like region +FIG01397691 Possible heat shock protein DnaJ precursor +FIG01397723 immunity protein d +FIG01397735 arabinofuranosidase +FIG01397764 Aminotransferase HpnO, required for aminobacteriohopanetriol +FIG01397772 FIG00821381: hypothetical protein +FIG01397775 repressor protein +FIG01397780 signal peptide containing protein +FIG01397805 17 kDa lipoprotein TUL4 precursor +FIG01397833 FIG00349853: hypothetical protein +FIG01397834 COG1801: Uncharacterized conserved protein +FIG01397839 conserved hypothetical protein in cyanobacteria +FIG01397850 FIG00631854: hypothetical protein +FIG01397855 FIG00514284: hypothetical protein +FIG01397868 Transposase-IS1562 +FIG01397890 FIG00344768: hypothetical protein +FIG01397893 Bll4270 protein +FIG01397896 Modification methylase bstVI (EC 2.1.1.72) +FIG01397927 FIG00425074: hypothetical protein +FIG01397940 Putative zinc metalloprotease MJ0392 (EC 3.4.24.-) +FIG01397951 Transposase and inactivated derivatives, IS5 family +FIG01397952 FIG00405193: hypothetical protein +FIG01397965 conserved integral membrane protein +FIG01397975 Kelch motif domain protein +FIG01397976 hypothetical protein +FIG01397979 FIG00412109: hypothetical protein +FIG01397987 S-layer protein / peptidoglycan endo-beta-N-acetylglucosaminidase +FIG01397996 conserved hypothetical protein, possible membrane protein +FIG01398007 LtrC-like protein +FIG01398009 stearoyl-CoA 9-desaturase( EC:1.14.19.1 ) +FIG01398019 dioxygenase, TauD/TfdA family +FIG01398029 Arylamine N-acetyltransferase 1 (EC 2.3.1.5) +FIG01398081 FIG00529706: hypothetical protein +FIG01398087 Possible transcription regulator +FIG01398111 Acetone carboxylase, beta subunit (EC 6.4.1.6) +FIG01398115 FIG01251821: hypothetical protein +FIG01398124 putative ligase +FIG01398129 no significant homology Putative N-terminal signal sequence and 3 putative transmembrane regions were found by PSORT. +FIG01398143 3-hydroxybutyryl-CoA dehydrogenase precursor (EC 1.1.1.157) +FIG01398154 Putative ferredoxin subunit of ring-hydroxylating dioxygenases +FIG01398159 FIG00623767: hypothetical protein +FIG01398160 antigen, P35 +FIG01398175 Outer membrane protein tolC precursor +FIG01398181 FIG00822992: hypothetical protein +FIG01398189 FIG00385347: hypothetical protein +FIG01398193 Regulatory protein, LuxR +FIG01398200 FIG030567: hypothetical protein +FIG01398208 SatD +FIG01398210 Protein of unknown function DUF1428 +FIG01398228 FIG00946327: hypothetical protein +FIG01398262 nifU-like domain protein +FIG01398269 hypothetical protein; putative exported protein +FIG01398272 PUTATIVE TRANSCRIPTIONAL REGULATORY PROTEIN WHIB-LIKE WHIB5 +FIG01398275 PE-PGRS FAMILY PROTEIN +FIG01398279 FIG01203350: hypothetical protein +FIG01398284 FIG00633527: hypothetical protein +FIG01398285 FIG00846821: hypothetical protein +FIG01398291 serine/threonine protein kinase +FIG01398324 FIG00642305: hypothetical protein +FIG01398331 FIG00766987: hypothetical protein +FIG01398335 hypothetical protein +FIG01398339 Phosphoenolpyruvate-protein kinase +FIG01398346 FIG00623355: hypothetical protein +FIG01398349 ABC transporter, ATPase subunit( EC:3.6.3.25 ) +FIG01398350 DNA polymerase X family +FIG01398369 FIG00638035: hypothetical protein +FIG01398382 FIG00351311: hypothetical protein +FIG01398416 Short-chain alcohol dehydrogenase associated with acetoin utilization +FIG01398443 FIG00350107: hypothetical protein +FIG01398444 FIG00520991: hypothetical protein +FIG01398446 possible excisionase +FIG01398447 Hypothetical membrane spanning Protein +FIG01398458 FIG016551: Putative peptidase +FIG01398460 IncF plasmid conjugative transfer DNA-nicking and unwinding protein TraI +FIG01398467 Sensor histidine kinase/GAF domain protein +FIG01398485 putative oxygenase (putative secreted protein) +FIG01398495 hypothetical protein +FIG01398518 FIG00450060: hypothetical protein +FIG01398558 glutaminase +FIG01398561 Complete nucleotide sequence +FIG01398563 FIG00850790: hypothetical protein +FIG01398565 pleiotropic regulatory protein +FIG01398573 CBS domain protein +FIG01398591 cupin domain protein +FIG01398611 FIG01220283: hypothetical protein +FIG01398617 FIG00946499: hypothetical protein +FIG01398619 FIG00766693: hypothetical protein +FIG01398643 FIG00402873: hypothetical protein +FIG01398646 FIG00359065: hypothetical protein +FIG01398655 FIG00380066: hypothetical protein +FIG01398656 FIG00764699: hypothetical protein +FIG01398663 hypothetical protein co-occurring with urease in Rhizobiales +FIG01398677 FIG00847313: hypothetical protein +FIG01398685 regulator of sigma factor +FIG01398690 Isochorismatase DhbB +FIG01398765 FIG00404275: hypothetical protein +FIG01398790 N-acetylneuraminic acid synthase-like protein +FIG01398839 FIG00764297: hypothetical protein +FIG01398847 Fic family protein, putative +FIG01398904 Protein of unknown function DUF142 +FIG01398905 hypothetical protein +FIG01398936 FIG00411372: hypothetical protein +FIG01398954 FIG01240677: hypothetical protein +FIG01398966 FIG00764486: hypothetical protein +FIG01399010 FIG00568317: hypothetical protein +FIG01399022 GntR family transcriptional regulator +FIG01399029 plasmid mobilization protein, truncated +FIG01399036 COG0584: Glycerophosphoryl diester phosphodiesterase +FIG01399041 FIG00425075: hypothetical protein +FIG01399070 putative insertion element IS1106 transposase +FIG01399083 Cache, type 2 domain protein +FIG01399096 FIG00531268: hypothetical protein +FIG01399103 FIG00388076: hypothetical protein +FIG01399104 FIG01019326: hypothetical protein +FIG01399114 DNA polymerase, bacteriophage-type, putative +FIG01399125 Hypothetical; Conserved +FIG01399145 FIG00356726: hypothetical protein +FIG01399178 FIG00388159: hypothetical protein +FIG01399196 Morphinone reductase +FIG01399220 Cellulosomal protein +FIG01399228 diguanylate cyclase/phosphodiesterase (GGDEF & EAL domains) with PAS/PAC sensor(s) +FIG01399233 Hypothetical protein, CF-18 family +FIG01399241 syrP protein, putative +FIG01399243 protein of unknown function DUF402 +FIG01399244 FIG00410187: hypothetical protein +FIG01399254 Glycoside hydrolase, family 31 +FIG01399264 orf9 +FIG01399302 RhtC-like transporter +FIG01399304 SpoOM-related protein +FIG01399306 conserved hypothetical protein, truncated +FIG01399321 FIG01019781: hypothetical protein +FIG01399323 Integral membrane efflux protein EfpA +FIG01399324 FIG00624572: hypothetical protein +FIG01399369 hypothetical protein +FIG01399370 Phosphatidylinositol kinase and protein kinase of the PI-3 kinase family +FIG01399372 type II restriction modification system, methylation subunit +FIG01399396 FIG00755862: hypothetical protein +FIG01399399 ADP-ribose pyrophosphatase +FIG01399424 GldH +FIG01399448 FIG00642325: hypothetical protein +FIG01399466 H repeat-associated protein +FIG01399471 FIG00405988: hypothetical protein +FIG01399479 Isovaleryl-CoA dehydrogenase like (EC 1.3.99.10) +FIG01399486 sensory box sensor histidine kinase/response regulator +FIG01399488 phage replication protein Cri +FIG01399508 transcriptional regulatory protein (possibly TetR-family) +FIG01399524 Type VII secretion AAA-ATPase EccA +FIG01399525 FIG00769015: hypothetical protein +FIG01399529 CcoP( EC:1.9.3.1 ) +FIG01399530 probable phenylacetic acid degradation protein paaA +FIG01399545 FMN reductase, NADPH-dependent +FIG01399581 Probabale oxalocrotonate tautomerase +FIG01399585 COG1664: Integral membrane protein CcmA involved in cell shape determination +FIG01399597 TPR domain protein, putative +FIG01399605 YCII-related domain-containing protein +FIG01399607 FIG00831246: hypothetical protein +FIG01399608 FIG01166706: hypothetical protein +FIG01399623 FIG00350715: hypothetical protein +FIG01399633 possible acyl dehydratase MaoC +FIG01399644 Hpa1 protein +FIG01399650 secretion protein +FIG01399652 Chitosanase precursor (EC 3.2.1.132) +FIG01399657 FIG00863467: hypothetical protein +FIG01399680 FIG00623499: hypothetical protein +FIG01399689 Paratose synthase +FIG01399693 putative glycosyl transferase, group 1 family protein +FIG01399700 COG4206: Outer membrane cobalamin receptor protein +FIG01399724 Sequestrin (Fragment) +FIG01399725 GumL +FIG01399728 FIG00354558: hypothetical protein +FIG01399735 PapF protein +FIG01399740 EAL domain containing protein +FIG01399748 FIG00756460: hypothetical protein +FIG01399760 FIG01117636: hypothetical protein +FIG01399761 transposase, IS5 family, putative +FIG01399769 Quaternary ammonium compound-resistance protein SugE +FIG01399785 Possible permease +FIG01399800 Putative multidrug resistance efflux pump +FIG01399804 FIG00424262: hypothetical protein +FIG01399842 23S rRNA protein +FIG01399845 FIG00351830: hypothetical protein +FIG01399847 possible glycosyltransferase +FIG01399857 Glycine oxidase +FIG01399861 FIG00385027: hypothetical protein +FIG01399870 FIG00425017: hypothetical protein +FIG01399877 pXO2-80 +FIG01399901 FIG01235320: hypothetical protein +FIG01399915 Subtilase family protein +FIG01399943 hypothetical protein +FIG01399944 ABC transporter protein, ATP-binding component +FIG01399947 FIG01165380: hypothetical protein +FIG01399954 FIG00414627: hypothetical protein +FIG01399958 Glucose uptake protein homolog +FIG01399972 FIG00472361: hypothetical protein +FIG01399979 S-adenosylmethionine-dependent methyltransferase +FIG01399988 DUF209:Cupin domain +FIG01399999 FIG00627717: hypothetical protein +FIG01400033 FIG00898304: hypothetical protein +FIG01400040 Barstar (barnase inhibitor) +FIG01400050 similar to Zn-dependent protease +FIG01400066 FIG00351851: hypothetical protein +FIG01400071 licB-like transmembrane protein +FIG01400079 AatB +FIG01400085 FIG00388032: hypothetical protein +FIG01400087 FIG00848032: hypothetical protein +FIG01400089 FIG00767002: hypothetical protein +FIG01400095 Methylamine utilization protein mauG precursor +FIG01400118 NADH-dependent flavin oxidoreductase +FIG01400172 hypothetical protein +FIG01400173 FIG00379716: hypothetical protein +FIG01400175 FIG00821527: hypothetical protein +FIG01400177 conserved hypothetical protein; RBL00553 +FIG01400180 Toxin subunit S1 precursor +FIG01400186 Lysine-N-methylase (EC 2.1.1.-) +FIG01400199 FIG00624309: hypothetical protein +FIG01400200 FIG00351073: hypothetical protein +FIG01400208 TRANSPOSASE +FIG01400239 lantibiotic efflux protein +FIG01400246 FIG00624159: hypothetical protein +FIG01400251 SanC, putative +FIG01400267 Protein sok +FIG01400271 FIG00769385: hypothetical protein +FIG01400272 FIG00629850: hypothetical protein +FIG01400276 Bacilysin biosynthesis protein BacA +FIG01400278 FIG00631152: hypothetical protein +FIG01400279 FIG00349528: hypothetical protein +FIG01400285 putative membrane-associated CAAX amino terminal protease +FIG01400286 Prophage membrane protein +FIG01400297 putative zinc-binding dehydrogenase +FIG01400317 Uncharacterized protein yhcD +FIG01400332 Possible helix-turn-helix domain of resolvase +FIG01400344 hypothetical protein; putative Thioesterase/thiol ester dehydrase-isomerase domain +FIG01400363 orf; Unknown function +FIG01400377 lipid A export ATP-binding/permease protein MsbA +FIG01400416 FIG01016722: hypothetical protein +FIG01400426 Xylanase +FIG01400432 FIG00353736: hypothetical protein +FIG01400467 FIG00349608: hypothetical protein +FIG01400478 Secreted protease C precursor (EC 3.4.24.-) +FIG01400493 P60-like lipoprotein +FIG01400497 PapE protein +FIG01400534 ORFID:MW0042 +FIG01400541 transposase, IS605 OrfB +FIG01400542 thiamine pyrophosphate enzyme +FIG01400556 FIG00364665: hypothetical protein +FIG01400572 Putative integral membrane zinc-metalloprotease +FIG01400583 FIG00348671: hypothetical protein +FIG01400594 Probable alpha/beta hydrolase fold family esterase +FIG01400613 Transcription initiation factor IIH p80 subunit +FIG01400615 Bll6880 protein +FIG01400627 IS629 transposase orfA +FIG01400638 Uncharacterized protein MJ1158 +FIG01400643 syc0192_c +FIG01400645 Beta-mannanase ManB-like enzyme, contains ChW-repeats +FIG01400646 DegT/DnrJ/EryC1/StrS aminotransferase +FIG01400673 luciferase family protein +FIG01400682 PspC domain protein +FIG01400698 probable DNA-binding phage-related protein YPO2320 +FIG01400715 FIG00352064: hypothetical protein +FIG01400719 phage replication protein +FIG01400720 toxin secretion ABC transporter ATP-binding protein +FIG01400736 PTS system, beta-glucoside-specific, IIA component +FIG01400742 FIG00873169: hypothetical protein +FIG01400745 FIG01045508: hypothetical protein +FIG01400746 type I phosphodiesterase/nucleotide pyrophosphatase family protein +FIG01400779 FIG00870406: hypothetical protein +FIG01400795 predicted protein family PM-3 +FIG01400797 Ortholog of S. aureus MRSA252 SAR2183b, doubtful CDS +FIG01400810 KDO-transferase 2, putative +FIG01400813 GGDEF domain containing protein, (inactivated) +FIG01400833 FIG00764793: hypothetical protein +FIG01400839 surface antigen +FIG01400841 putative CoA-transferase +FIG01400843 FIG00351032: hypothetical protein +FIG01400855 ethanolamine utilization protein eutP +FIG01400857 FIG00769868: hypothetical protein +FIG01400859 sensory box histidine kinase( EC:2.7.3.- ) +FIG01400863 group I intron GIY-YIG endonuclease +FIG01400879 Endoglucanase H precursor (EC 3.2.1.4) +FIG01400892 Transmembrane transport protein +FIG01400903 Hemolysin BL lytic component L2 +FIG01400908 FIG00767814: hypothetical protein +FIG01400912 FIG00351687: hypothetical protein +FIG01400914 blr8216; putative transposase +FIG01400921 FIG00350966: hypothetical protein +FIG01400939 lipid A phosphoethanolamine transferase +FIG01400953 protein of unknown function DUF422 +FIG01400963 FIG00354803: hypothetical protein +FIG01400988 V-type ATP synthase, F subunit +FIG01401007 Protein StbA +FIG01401023 conserved hypothetical protein-putative integral membrane protein +FIG01401047 Signal transduction histidine kinase regulating C4-dicarboxylate transport system +FIG01401048 putative glycine-rich protein +FIG01401058 putative TYPE II RESTRICTION ENZYME +FIG01401064 UPF0178 protein CA_C2825 +FIG01401084 FIG00767454: hypothetical protein +FIG01401089 MS160, putative transposase +FIG01401094 6-phospho-beta-glucosidase +FIG01401103 FIG00388587: hypothetical protein +FIG01401107 hypothetical protein +FIG01401111 Orange Carotenoid Protein +FIG01401141 phage prohead protease, HK97 family +FIG01401168 FIG00388525: hypothetical protein +FIG01401170 putative mobilization protein +FIG01401178 RidA fragment or small ORF +FIG01401184 putative branched-chain amino acid transport system permease protein +FIG01401191 FIG00519875: hypothetical protein +FIG01401214 FIG00847585: hypothetical protein +FIG01401236 possible enhanced intracellular survival protein +FIG01401241 FIG01059867: hypothetical protein +FIG01401248 FIG00388826: hypothetical protein +FIG01401249 FIG01167268: hypothetical protein +FIG01401257 similar to beta-ketoacyl acyl carrier protein synthase II +FIG01401279 pXO2-30 +FIG01401285 Multidrug efflux MFS family transporter precursor +FIG01401293 Acetohydroxy acid synthase +FIG01401297 hypothetical protein +FIG01401303 Exported protein +FIG01401316 FIG00404895: hypothetical protein +FIG01401322 Shwachman-Bodian-Diamond syndrome protein; predicted exosome subunit +FIG01401328 FIG00388143: hypothetical protein +FIG01401373 putative sugar transporter inner membrane protein +FIG01401389 probable secreted peptidase +FIG01401396 ABC transporter, permease protein +FIG01401399 FIG00624186: hypothetical protein +FIG01401401 Hypothetical bacteriophage protein +FIG01401410 Sensory box transcriptional regulator, LuxR family +FIG01401417 Fibronectin type III domain protein +FIG01401422 probable malate dehydrogenase +FIG01401429 Bll8035 protein +FIG01401443 FIG00412136: hypothetical protein +FIG01401450 Rhodanese-like protein +FIG01401463 High-affinity zinc uptake system membrane protein znuB +FIG01401487 FIG00468496: hypothetical protein +FIG01401494 Mce +FIG01401499 FIG01234179: hypothetical protein +FIG01401507 FIG01247877: hypothetical protein +FIG01401518 FIG00623444: hypothetical protein +FIG01401527 cysteine rich repeat domain protein, putative +FIG01401528 Osmolarity sensor protein envZ (EC 2.7.3.-) +FIG01401534 hypothetical protein +FIG01401535 protein of unknown function DUF187 +FIG01401551 Possible apospory-associated protein C +FIG01401552 FIG00641116: hypothetical protein +FIG01401564 ABC transporter, permease protein +FIG01401566 Epoxide hydrolase Cif +FIG01401574 FIG00642236: hypothetical protein +FIG01401579 putative transport permease yfiM +FIG01401584 hypothetical protein +FIG01401587 metal-dependent hydrolase, putative +FIG01401589 DoxX family protein +FIG01401593 Gef protein interferes with membrane function when in excess +FIG01401594 Asparaginyl-tRNA synthetase-related protein +FIG01401628 FIG00409710: hypothetical protein +FIG01401634 ortholog to Borrelia burgdorferi BB0378 +FIG01401643 dihydrolipoamide dehydrogenase +FIG01401645 transposase, IS111A/IS1328/IS1533 +FIG01401668 FIG00424191: hypothetical protein +FIG01401669 cytidine deaminase, homotetrameric +FIG01401684 FIG00764312: hypothetical protein +FIG01401699 iSSod13, transposase +FIG01401726 VapB18 protein (antitoxin to VapC18) +FIG01401745 Involved in expression of fibrinogen binding protein, phage associated +FIG01401746 probable dioxygenase +FIG01401747 peptidase S24 +FIG01401789 putative factor; Extracellular functions: Secreted proteins +FIG01401798 EcoRI methylase/methyltransferase +FIG01401819 putative DNA-binding protein HU-beta +FIG01401828 FIG01044317: hypothetical protein +FIG01401830 B. burgdorferi predicted coding region BBI15 +FIG01401844 FIG00764885: hypothetical protein +FIG01401845 Cation efflux system protein CZCA +FIG01401847 Putative autotransporter +FIG01401851 FIG00897003: hypothetical protein +FIG01401854 identified by similarity to GB:BAB48126.1; match to protein family HMM PF06945 +FIG01401858 FIG01114926: hypothetical protein +FIG01401871 preprotein translocase, SecG subunit, putative +FIG01401873 FIG00957897: hypothetical protein +FIG01401884 FIG00385537: hypothetical protein +FIG01401886 FIG01244726: hypothetical protein +FIG01401890 Conserved hypothetical transmembrane protein +FIG01401891 FIG00408725: hypothetical protein +FIG01401911 FIG00350992: hypothetical protein +FIG01401912 FIG00405101: hypothetical protein +FIG01401925 conserved hypothetical protein NMA0318 +FIG01401930 probable ABC transporter permease +FIG01401947 FIG01111581: hypothetical protein +FIG01401952 IS1236 transposase protein 1 +FIG01401976 Protein teg (EC 3.1.1.-) +FIG01401995 FIG00385426: hypothetical protein +FIG01402003 syc1517_c +FIG01402010 Tungsten-containing aldehyde ferredoxin oxidoreductase cofactor modifying protein +FIG01402019 5'-Nucleotidase domain protein +FIG01402040 TPR domain/radical SAM/B12 binding domain protein +FIG01402058 cell wall lytic activity lytE +FIG01402062 Puromycin N-acetyltransferase (EC 2.3.-.-) +FIG01402069 FIG01117090: hypothetical protein +FIG01402086 polysaccharide deacetylase-related protein +FIG01402090 probable pheromone-responsive regulatory protein R +FIG01402093 monooxygenase (secreted protein) +FIG01402109 FIG00388845: hypothetical protein +FIG01402124 hypothetical protein +FIG01402184 GlpR protein +FIG01402190 FIG00351307: hypothetical protein +FIG01402193 transposase family protein, putative +FIG01402194 FIG00404525: hypothetical protein +FIG01402233 FIG00765704: hypothetical protein +FIG01402240 putative recombinase/mobilization protein +FIG01402245 probable Zinc-binding dehydrogenase +FIG01402246 transposase IS3/IS911 +FIG01402250 DNA repair photolyase-like +FIG01402266 Heat shock protease +FIG01402267 FIG00846855: hypothetical protein +FIG01402270 Methlytransferase, UbiE/COQ5 family +FIG01402277 Endo-1,4-beta-xylanase Z +FIG01402288 COG4307: Uncharacterized protein conserved in bacteria +FIG01402316 Ribosomal RNA adenine dimethylase domain protein +FIG01402349 protein of unknown function DUF1173 +FIG01402359 glycosyl hydrolase, family 5 +FIG01402360 FIG01046354: hypothetical protein +FIG01402411 FIG00354145: hypothetical protein +FIG01402422 Alkylation response protein AidB, acyl-CoA dehydrogenase family +FIG01402435 N-acyl-L-amino acid amidohydrolase +FIG01402438 Pteridine-dependent dioxygenase +FIG01402469 CheX protein (uncharacterized ORF in chemotaxis operon) +FIG01402473 serine esterase +FIG01402477 Inner membrane component of binding-protein-dependent transport system +FIG01402483 FIG00352439: hypothetical protein +FIG01402501 FIG00639401: hypothetical protein +FIG01402523 FIG00751738: hypothetical protein +FIG01402526 FIG00406433: hypothetical protein +FIG01402534 FIG00997045: hypothetical protein +FIG01402554 HRDC domain protein +FIG01402571 putative calcium binding protein +FIG01402576 3-mercaptopyruvate sulfurtransferase (EC 2.8.1.2) +FIG01402588 high light inducible protein +FIG01402591 FIG00425096: hypothetical protein +FIG01402593 FIG00408054: hypothetical protein +FIG01402599 FIG00624455: hypothetical protein +FIG01402636 Probable sensor/response regulator hybrid (EC 2.7.3.-) +FIG01402649 FIG00641551: hypothetical protein +FIG01402667 FIG00950267: hypothetical protein +FIG01402696 lytic enzyme +FIG01402698 FIG00427445: hypothetical protein +FIG01402705 hypothetical protein +FIG01402707 Probable two-domain glycosyltransferase (EC 2.4.1.-) +FIG01402714 acyl-CoA synthetase( EC:6.2.1.- ) +FIG01402717 prophage ps3 protein 06 +FIG01402718 FIG00765436: hypothetical protein +FIG01402744 Metal-dependent hydrolases of the beta-lactamase superfamily, possible sulfatase +FIG01402748 Hypothetical protein yrhA +FIG01402777 FIG00350187: hypothetical protein +FIG01402815 FIG00402724: hypothetical protein +FIG01402827 Intracellular growth locus, subunit C +FIG01402834 Zinc metallohydrolase +FIG01402840 FmtA-like protein +FIG01402845 Two-component system, regulatory protein +FIG01402855 transposase IS116/IS110/IS902 +FIG01402862 InterPro IPR000551 +FIG01402866 Uncharacterized protein MJ1479.1 +FIG01402868 FIG00407895: hypothetical protein +FIG01402871 FIG00468563: hypothetical protein +FIG01402872 glycine-rich cell wall protein +FIG01402879 FIG00627996: hypothetical protein +FIG01402880 N-acetylmuramic acid 6-phosphate etherase (EC 4.2.-.-) (MurNAc-6-P etherase) +FIG01402884 FIG01240862: hypothetical protein +FIG01402892 FIG00817153: hypothetical protein +FIG01402898 Type IIA topoisomerase (DNA gyrase/topo II, topoisomerase IV), B subunit +FIG01402901 FIG00765297: hypothetical protein +FIG01402917 endo-1,4-beta-xylanase (xylanase D) +FIG01402923 Probable sugar-binding lipoprotein +FIG01402943 Heavy-chain fibroin (Fragment) +FIG01402968 FIG00411361: hypothetical protein +FIG01402974 FIG00353217: hypothetical protein +FIG01402998 Putative phage terminase +FIG01403004 FIG00471787: hypothetical protein +FIG01403014 hypothetical protein +FIG01403028 dioxygenase, TauD/TfdA +FIG01403049 Bll3346 protein +FIG01403052 Geranylgeranyl-diphosphate geranylgeranyl-transferase +FIG01403068 HrpB7 protein +FIG01403073 acetoin utilization protein AcuC +FIG01403078 FIG00766124: hypothetical protein +FIG01403080 DNA-binding response regulator TorR +FIG01403093 glucosyltransferase-S( EC:2.4.1.5 ) +FIG01403099 Putative Fe-S oxidoreductase +FIG01403101 ortholog to Borrelia burgdorferi BB0614 +FIG01403116 Two-component system sensor histidine kinase/response regulator hybrid +FIG01403120 SAP DNA-binding domain-containing protein +FIG01403136 FIG00413484: hypothetical protein +FIG01403151 serine esterase, cutinase family +FIG01403152 Gll1812 protein +FIG01403154 Toxic anion resistance +FIG01403172 PTS system, L-Ascorbate family, IIC component +FIG01403184 similar to DBJ:BAB55450.1 (AB051073) percent identity 45 in 140 aa +FIG01403185 Sugar binding protein of sugar ABC transporter +FIG01403203 FIG00723470: hypothetical protein +FIG01403229 peptidoglycan-binding peptidase M23B +FIG01403254 Asl3523 protein +FIG01403255 FIG00756079: hypothetical protein +FIG01403274 Albicidin resistance protein +FIG01403284 prophage Lp1 protein 66, lipoprotein precursor +FIG01403324 FIG00348467: hypothetical protein +FIG01403327 Kanamycin nucleotidyltransferase (EC 2.7.7.-) +FIG01403330 putative nitroreductase family protein +FIG01403345 Putative amino-acid transporter periplasmic solute-binding protein +FIG01403359 FIG00957627: hypothetical protein +FIG01403362 FIG00411772: hypothetical protein +FIG01403365 putative extracellular solute-binding protein +FIG01403375 FIG01212883: hypothetical protein +FIG01403381 FIG00388276: hypothetical protein +FIG01403393 FIG01171753: hypothetical protein +FIG01403400 outer membrane protein B (cell surface antigen sca5) +FIG01403413 FIG00388900: hypothetical protein +FIG01403414 FIG01110679: hypothetical protein +FIG01403422 COG1939: Ribonuclease III family protein +FIG01403453 COG2826: Transposase and inactivated derivatives, IS30 family +FIG01403462 putative molybdopterin-guanine dinucleotide biosynthesis protein A +FIG01403477 Vegetative cell wall protein gp1 precursor +FIG01403489 FIG00713146: hypothetical protein +FIG01403505 FIG00956385: hypothetical protein +FIG01403516 esterase/lipase/thioesterase family protein +FIG01403539 FIG00351059: hypothetical protein +FIG01403567 Periplasmic serine protease +FIG01403583 Thiopurine S-methyltransferase (EC 2.1.1.67) +FIG01403589 Hemin binding protein +FIG01403595 thiamine biosynthesis protein, putative +FIG01403612 transporter, AcrB/AcrD/AcrF family +FIG01403625 Probable histone deacetylase/AcuC/AphA family protein +FIG01403657 Secretion system protein TadB +FIG01403671 putative LysR family transcriptional regulatory protein +FIG01403684 Helix-turn-helix +FIG01403701 TnpR protein +FIG01403713 FIG01166416: hypothetical protein +FIG01403714 D-amino acid oxidase family protein +FIG01403723 hypothetical protein +FIG01403724 Phytoene/squalene synthetase +FIG01403729 Nitrogenase-stabilizing/protective protein nifW +FIG01403736 FIG00408484: hypothetical protein +FIG01403738 MDR-type permease +FIG01403762 putative dihydropyrimidine dehydrogenase [NADP+] precursor +FIG01403766 FIG00385156: hypothetical protein +FIG01403768 Gala protein type 1, 3 or 4 +FIG01403772 FIG00744209: hypothetical protein +FIG01403796 phospholipase D/Transphosphatidylase +FIG01403831 hypothetical protein +FIG01403851 Bll0820 protein +FIG01403859 FIG00644040: hypothetical protein +FIG01403879 Acetyltransferase (EC 2.3.1.-) +FIG01403881 probable PfkB family carbohydrate (sugar) kinase +FIG01403895 FIG00350188: hypothetical protein +FIG01403896 GntR-family putative transcriptional regulatory protein +FIG01403914 FIG00984882: hypothetical protein +FIG01403930 SIGNAL TRANSDUCTION HISTIDINE KINASE +FIG01403935 Rieske [2Fe-2S] iron-sulfur protein +FIG01403944 FIG00353606: hypothetical protein +FIG01403946 FIG00269866: hypothetical protein +FIG01403948 Serine/threonine-protein kinase Chk2 (EC 2.7.11.1) +FIG01403950 Membrane proteins related to metalloendopeptidase +FIG01403952 CspA +FIG01403953 possible Cytochrome b(C-terminal)/b6/petD +FIG01403962 FIG00433732: hypothetical protein +FIG01403986 beta-ketoacyl synthase domain protein +FIG01404014 FIG00639968: hypothetical protein +FIG01404059 type II restriction enzyme +FIG01404068 probable phosphatidylethanolamine N-methyltransferase +FIG01404088 Putative non-specific DNA-binding protein +FIG01404100 Sulfide:quinone oxidoreductase +FIG01404102 FIG00418033: hypothetical protein +FIG01404121 ABC transporter permease protein +FIG01404126 3-hydroxyacid dehydrogenase +FIG01404134 FIG00628168: hypothetical protein +FIG01404138 penicillin acylase II precursor +FIG01404140 Branched-chain amino acid transport protein AzlC +FIG01404144 FIG00361264: hypothetical protein +FIG01404156 FIG00524434: hypothetical protein +FIG01404165 similar to 5-bromo-4-chloroindolyl phosphate hydrolysis protein +FIG01404170 glycopeptide antibiotics resistance protein +FIG01404179 FIG00356211: hypothetical protein +FIG01404189 FIG00821596: hypothetical protein +FIG01404193 type III secretion protein HrpB7 +FIG01404196 FIG00643138: hypothetical protein +FIG01404201 IncF plasmid conjugative transfer regulator TraY +FIG01404206 FIG00406468: hypothetical protein +FIG01404214 FIG00734390: hypothetical protein +FIG01404227 Probable conserved membrane protein +FIG01404245 FIG00418448: hypothetical protein +FIG01404269 elongation factor EF-G( EC:3.6.1.48 ) +FIG01404292 antigen, S2, putative +FIG01404295 glutamine synthetase translation inhibitor +FIG01404311 SIGNAL TRANSDUCTION REGULATORY PROTEIN-CheY like receiver domain +FIG01404314 Methyltransferase corrinoid activation protein MA3972 +FIG01404315 FAD containing monooxygenase( EC:1.14.13.8 ) +FIG01404322 FIG00350507: hypothetical protein +FIG01404329 hypothetical protein +FIG01404334 pXO1-73 +FIG01404372 FIG01167041: hypothetical protein +FIG01404379 Putative methyltransferase +FIG01404384 FIG00350895: hypothetical protein +FIG01404398 Phycobilisome protein +FIG01404406 putative hemerythrin-like protein +FIG01404409 FIG00821003: hypothetical protein +FIG01404423 hypothetical protein +FIG01404450 FIG01236868: hypothetical protein +FIG01404464 IncP-type DNA transfer primase TraC +FIG01404468 FIG00747771: hypothetical protein +FIG01404479 FIG00712606: hypothetical protein +FIG01404504 lysis protein - phage PP7 +FIG01404514 FIG00768001: hypothetical protein +FIG01404530 FIG00409416: hypothetical protein +FIG01404537 FIG00961506: hypothetical protein +FIG01404540 OmpA-like transmembrane domain protein +FIG01404541 hypothetical protein +FIG01404549 Mlr1235 protein +FIG01404575 FIG00628180: hypothetical protein +FIG01404585 COG1836 truncation +FIG01404586 FIG00411266: hypothetical protein +FIG01404595 FIG00817844: hypothetical protein +FIG01404596 Hemolysin-type calcium-binding region, RTX +FIG01404612 possible pectin degradation protein +FIG01404622 FIG00361528: hypothetical protein +FIG01404637 Probable lipoprotein envE precursor +FIG01404646 FIG00403784: hypothetical protein +FIG01404672 protein of unknown function DUF155 +FIG01404695 nuclease domain protein +FIG01404707 putative CbxX/CfqX family protein +FIG01404730 FIG147341: Hypothetical protein +FIG01404749 FIG00623396: hypothetical protein +FIG01404750 Diguanylate cyclase/phosphodiesterase-domain containing protein +FIG01404770 FIG00964414: hypothetical protein +FIG01404804 Putative P4-family integrase +FIG01404806 FIG00623650: hypothetical protein +FIG01404811 hypothetical protein +FIG01404848 putative secreted lipase +FIG01404851 ribosomal-protein-alanine N-acetyltransferase( EC:2.3.1.128 ) +FIG01404852 transferase hexapeptide repeat +FIG01404858 Mobilization protein C +FIG01404880 polyhydroxyalkanoate granule-associated protein PhaF, putative +FIG01404884 FIG00405544: hypothetical protein +FIG01404898 FIG00349640: hypothetical protein +FIG01404923 L-arabinose-binding periplasmic protein +FIG01404941 FIG01046741: hypothetical protein +FIG01404959 FIG00816079: hypothetical protein +FIG01404986 Protein yciE +FIG01404995 FIG00644420: hypothetical protein +FIG01405020 FIG00763319: hypothetical protein +FIG01405054 PEP phosphonomutase and related enzymes +FIG01405071 BASIC MEMBRANE PROTEIN A PRECURSOR +FIG01405127 hypothetical protein +FIG01405164 FIG00768044: hypothetical protein +FIG01405173 COG2246: Predicted membrane protein +FIG01405194 FIG00766872: hypothetical protein +FIG01405195 FIG00766325: hypothetical protein +FIG01405197 hypothetical protein Rv1639c +FIG01405216 Leucine-rich repeat containing protein +FIG01405238 hypothetical extracellular protein +FIG01405256 Putative cation-transporting P-type ATPase +FIG01405257 Related to two-component system response regulator +FIG01405259 FIG01267452: hypothetical protein +FIG01405262 Bacterial leucyl aminopeptidase (EC 3.4.11.10) +FIG01405269 VirE N-terminal domain protein +FIG01405274 FIG00425716: hypothetical protein +FIG01405291 FIG051360: Periplasmic protein TonB, links inner and outer membranes +FIG01405305 Actin-like ATPase involved in cell morphogenesis +FIG01405309 aldehyde dehydrogenase family protein +FIG01405314 (2-pyrone-4,6-)dicarboxylic acid hydrolase +FIG01405325 FIG00531373: hypothetical protein +FIG01405337 Polyribonucleotide nucleotidyltransferase (polynucleotide phosphorylase) +FIG01405379 Raffinose synthase (Sip1 seed imbibition) protein homolog +FIG01405397 Zinc protease-like protein +FIG01405401 FIG00352312: hypothetical protein +FIG01405407 FIG00749275: hypothetical protein +FIG01405414 AP endonuclease, family protein 2 +FIG01405417 FIG01246708: hypothetical protein +FIG01405418 kelch domain protein +FIG01405433 protein of unknown function DUF1112 +FIG01405444 Gll0496 protein +FIG01405448 FIG00413590: hypothetical protein +FIG01405459 nitrate ABC transporter, ATP-binding protein,putative +FIG01405479 Probable phosphotransbutyrylase +FIG01405486 FIG00404955: hypothetical protein +FIG01405496 putrescine-ornithine antiporter +FIG01405511 FIG00388646: hypothetical protein +FIG01405520 FIG00559198: hypothetical protein +FIG01405559 FIG01244615: hypothetical protein +FIG01405586 trans-sialidase +FIG01405604 Sensor-type histidine kinase prrB (EC 2.7.13.3) +FIG01405609 transposase homolog for IS232 [Insertion sequence IS1181] +FIG01405616 FIG00352407: hypothetical protein +FIG01405617 hypothetical protein Rv2742c +FIG01405620 hypothetical conjugation protein +FIG01405636 eR transcriptional regulator +FIG01405637 putativa replication protein +FIG01405643 Mll4877 protein +FIG01405660 PUTATIVE LIPOPROTEIN LPQX +FIG01405665 Serine/threonine-protein kinase A (EC 2.7.11.1) +FIG01405701 FIG00423817: hypothetical protein +FIG01405719 FIG00450334: hypothetical protein +FIG01405754 hypothetical protein +FIG01405804 Sensor histidine kinase of a two component response regulator +FIG01405807 FIG00353025: hypothetical protein +FIG01405844 Bll5268 protein +FIG01405856 Type II restriction enzyme EcoRI +FIG01405871 FIG00764710: hypothetical protein +FIG01405875 MptB, dihydroneopterin 2’,3’-cyclic phosphate phosphodiesterase +FIG01405887 FIG00351197: hypothetical protein +FIG01405900 FIG00822540: hypothetical protein +FIG01405913 Cobalamine biosynthesis protein +FIG01405916 FIG00352736: hypothetical protein +FIG01405919 hypothetical protein +FIG01405922 beta-N-acetylhexosaminidase, putative +FIG01405926 FIG00768484: hypothetical protein +FIG01405936 Undecaprenyl-phosphate glycosyl-1-phosphate transferase( EC:2.7.8.6 ) +FIG01405937 predicted calcium-binding protein +FIG01405942 Fatty acyl responsive regulator +FIG01405945 CdsL +FIG01405958 Protein yobA precursor +FIG01405966 FIG042840: Phage protein +FIG01405967 Exopolysaccharide phosphotransferase SCO6023 (EC 2.7.-.-) +FIG01405972 FIG00764985: hypothetical protein +FIG01405995 FIG01318144: Rieske (2Fe-2S) domain-containing protein +FIG01406002 B. burgdorferi predicted coding region BB0360 +FIG01406003 FIG00835717: hypothetical protein +FIG01406016 COG3547: Transposase and inactivated derivatives +FIG01406025 channel protein, hemolysin III family +FIG01406039 Lipoprotein, NLP/P60 family +FIG01406063 hypothetical protein +FIG01406079 FIG00388567: hypothetical protein +FIG01406090 Transcriptional activator protein SolR +FIG01406095 FIG00409088: hypothetical protein +FIG01406104 FIG00362319: hypothetical protein +FIG01406143 Luciferase +FIG01406145 FIG00623373: hypothetical protein +FIG01406152 hemolysin E, chromosomal domain protein +FIG01406174 FIG00351272: hypothetical protein +FIG01406184 FIG00623581: hypothetical protein +FIG01406214 Putative ankyrin repeat protein MM_0045 +FIG01406216 FIG00765452: hypothetical protein +FIG01406223 FIG00385272: hypothetical protein +FIG01406226 FIG01046500: hypothetical protein +FIG01406228 FIG00623557: hypothetical protein +FIG01406231 FIG00414117: hypothetical protein +FIG01406241 Inorganic pyrophosphatase +FIG01406248 heavy metal-associated domain protein +FIG01406250 CAB/ELIP/HLIP superfamily of protein +FIG01406259 Prophage lysozyme (EC 3.2.1.17); Phage lysin +FIG01406270 Iron-uptake factor PiuB +FIG01406277 hypothetical protein, putative hydrolase +FIG01406279 gp6 +FIG01406291 FIG01239905: hypothetical protein +FIG01406292 Putative ribonucleoprotein related-protein TROVE Domain +FIG01406297 FIG00639806: hypothetical protein +FIG01406299 FIG00411857: hypothetical protein +FIG01406320 FIG00350662: hypothetical protein +FIG01406341 alpha/beta hydrolase fold family +FIG01406364 Tn5252, Orf23 +FIG01406387 FIG00831612: hypothetical protein +FIG01406393 AsnC family transcriptional regulatory protein +FIG01406407 Quinohemoprotein amine dehydrogenase beta subunit (EC 1.4.99.-) +FIG01406408 Probable hydrogenase cytochrome b-type subunit +FIG01406422 transcriptional regulator Xre +FIG01406428 FIG00847574: hypothetical protein +FIG01406464 hypothetical protein +FIG01406487 putative virulence protein +FIG01406496 ATP-dependent helicase PcrA +FIG01406500 CBS domain pair, putative +FIG01406535 Nitrogen-fixing NifU, C-terminal +FIG01406543 COGs COG3737 +FIG01406544 FIG00826611: hypothetical protein +FIG01406560 site-specific recombinase XerD +FIG01406561 hypothetical protein +FIG01406562 FIG00516379: hypothetical protein +FIG01406565 FIG00821445: hypothetical protein +FIG01406573 Stress response protein ysnF +FIG01406578 putative ATP/GTP-binding integral membrane protein +FIG01406599 FIG01129033: hypothetical protein +FIG01406613 FIG00763478: hypothetical protein +FIG01406651 Iron-sulfur protein precursor +FIG01406666 FIG00522136: hypothetical protein +FIG01406682 putative small multi-drug export +FIG01406687 cI +FIG01406700 FIG00385658: hypothetical protein +FIG01406701 FIG00873941: hypothetical protein +FIG01406705 probable NreA protein +FIG01406709 aminotransferase class-III protein +FIG01406719 DNA uptake protein +FIG01406724 dolichyl-phosphate-mannose-protein mannosyltransferase family protein +FIG01406736 putative Zinc-binding dehydrogenase +FIG01406750 FIG01238036: hypothetical protein +FIG01406753 FIG084684: hypothetical protein +FIG01406757 exonuclease( EC:3.1.11.- ) +FIG01406761 pXO1-120 homology; transposase for IS660 +FIG01406763 FIG00734527: hypothetical protein +FIG01406770 No definition line found +FIG01406773 GNAT family acetyltransferase YhhY +FIG01406812 PUTATIVE OSMOTICALLY INDUCIBLE LIPOPROTEIN B2 TRANSMEMBRANE +FIG01406850 histone-like DNA-binding protein +FIG01406857 FIG00350160: hypothetical protein +FIG01406858 FIG01242344: hypothetical protein +FIG01406890 FIG00441814: hypothetical protein +FIG01406892 FIG068338: Hypothetical protein +FIG01406902 endoglycosylceramidase +FIG01406957 COG0791: Cell wall-associated hydrolases (invasion-associated proteins) +FIG01406965 FIG01096133: hypothetical protein +FIG01406977 Nitrogen-fixing NifU-like +FIG01406992 Predicted periplasmic/secreted protein +FIG01407001 FIG00733793: hypothetical protein +FIG01407004 COG1476: Predicted transcriptional regulators +FIG01407005 FIG00350762: hypothetical protein +FIG01407006 b-glycosyltransferase, glycosyltransferase family 2 protein( EC:2.4.1.- ) +FIG01407022 FIG00362388: hypothetical protein +FIG01407028 probable MFS transporter +FIG01407043 FIG00937589: hypothetical protein +FIG01407050 FIG00451487: hypothetical protein +FIG01407059 Molybdopterin oxidoreductase, iron-sulfur binding subunit +FIG01407071 FIG00820043: hypothetical protein +FIG01407103 FIG00936597: hypothetical protein +FIG01407117 Rieske (2Fe-2S) region +FIG01407120 Sensory transduction protein kinase (EC 2.7.3.-) +FIG01407143 Protein of unknown function DUF552 +FIG01407151 Putative pili chaperone protein +FIG01407159 ISPsy11, transposase OrfA +FIG01407196 Cps2A +FIG01407201 endonuclease/exonuclease/phosphatase family precursor (38.1 kD) (5F605) +FIG01407202 putative capsid protein +FIG01407203 FIG00652636: hypothetical protein +FIG01407207 FIG00870321: hypothetical protein +FIG01407224 FIG129294: predicted inner membrane protein +FIG01407230 heavy-metal-associated domain protein +FIG01407240 TPR-repeat-containing proteins +FIG01407265 FIG00409316: hypothetical protein +FIG01407278 FIG00946303: hypothetical protein +FIG01407285 FIG00410894: hypothetical protein +FIG01407297 FIG00349210: hypothetical protein +FIG01407302 NADPH:quinone oxidoreductases or alcohol dehydrogenase +FIG01407306 FIG00351813: hypothetical protein +FIG01407342 Transcription antiterminator, BglG family (EC 2.7.1.69) +FIG01407356 YolB +FIG01407358 Maturase-related protein +FIG01407365 Uncharacterized protein MJ1225 +FIG01407368 Hemerythrin HHE cation binding region +FIG01407376 FIG00354216: hypothetical protein +FIG01407382 Conserved membrane protein, possible homolog of CAAX-like membrane endopeptidase +FIG01407388 possible integrase +FIG01407404 Putative helicase +FIG01407409 hypothetical protein +FIG01407418 Transglutaminase-like enzyme +FIG01407429 Mlr6511 protein +FIG01407436 Valyl-tRNA synthetase +FIG01407445 Putative sgc region protein sgcX +FIG01407451 ferredoxin subunit of phenylpropionate dioxygenase +FIG01407463 flagellar filament outer layer protein +FIG01407465 PknJ +FIG01407473 alpha/beta hydrolase fold +FIG01407486 FIG00406190: hypothetical protein +FIG01407488 Dephospho-CoA kinase +FIG01407506 Fe-S protein +FIG01407519 Capsule biosynthesis protein capA +FIG01407550 putative pirin protein +FIG01407557 FIG00637467: hypothetical protein +FIG01407568 FIG00350344: hypothetical protein +FIG01407580 Prophage CP4-57 regulatory protein alpA +FIG01407581 Protease synthase and sporulation protein PAI 2 +FIG01407590 putative transformation system protein +FIG01407591 hypothetical protein +FIG01407594 conserved protein of unknown function; putative secreted protein +FIG01407607 prophage LambdaBa02, major tail protein, putative +FIG01407613 heavy metal translocating P-type ATPase +FIG01407649 Outer membrane usher protein PapC +FIG01407655 FIG00865752: hypothetical protein +FIG01407665 cell division-related protein +FIG01407667 FIG00762583: hypothetical protein +FIG01407672 D-glycero-D-manno-heptose 1,7-bisphosphate phosphatase (EC 3.1.1.-); possible Histidinol-phosphatase (EC 3.1.3.15) +FIG01407677 surface antigen-related protein +FIG01407699 Anti-repressor protein +FIG01407701 ABC transported MDR-type, permease component +FIG01407712 FIG00469004: hypothetical protein +FIG01407744 Lysozyme (EC 3.2.1.17) +FIG01407747 amine oxidase, flavin containing +FIG01407748 Arginase/agmatinase/formimionoglutamate hydrolase, arginase family +FIG01407768 leucine-responsive regulatory protein +FIG01407777 putative RNA polymerase sigma (70) factor +FIG01407820 FIG00642795: hypothetical protein +FIG01407839 Nucleotide related transporter , NTT family +FIG01407842 Bll3113 protein +FIG01407853 putative methylated-DNA methyltransferase +FIG01407876 FIG01119273: hypothetical protein +FIG01407879 FIG00817288: hypothetical protein +FIG01407912 B. burgdorferi predicted coding region BBG11 +FIG01407914 FIG00631578: hypothetical protein +FIG01407922 PvuII DNA methyltransferase +FIG01407927 Cutinase +FIG01407940 FIG00451669: hypothetical protein +FIG01407949 CAB/ELIP/HLIP-related protein +FIG01407956 secreted protein, putative +FIG01407985 transcriptional repressor +FIG01408032 FIG01116728: hypothetical protein +FIG01408043 similar to superfamily I DNA and RNA helicases and helicase subunits +FIG01408047 FIG00388972: hypothetical protein +FIG01408081 FIG00733768: hypothetical protein +FIG01408088 FAD-dependent oxidoreductase +FIG01408115 FIG00385439: hypothetical protein +FIG01408132 FIG00522570: hypothetical protein +FIG01408142 FIG00685223: hypothetical protein +FIG01408154 COG2856: Predicted Zn peptidase +FIG01408175 transcriptional regulator, MarR family protein +FIG01408177 phosphatidate cytidylyltransferase, putative +FIG01408186 putative +FIG01408206 FIG028274: hypothetical protein +FIG01408208 FIG00364591: hypothetical protein +FIG01408222 FIG00817254: hypothetical protein +FIG01408232 FIG00562183: hypothetical protein +FIG01408254 FIG00653842: hypothetical protein +FIG01408272 HD-domain protein +FIG01408277 FIG00350235: hypothetical protein +FIG01408309 Transposase +FIG01408356 salt-stress induced hydrophobic peptide +FIG01408374 Protein gp41 [Bacteriophage A118] +FIG01408388 FIG00362582: hypothetical protein +FIG01408422 Probable oxoisovalerate dehydrogenase alpha and beta subunits +FIG01408444 COG1977: Molybdopterin converting factor, small subunit +FIG01408446 probable DNA polymerase family X +FIG01408457 L-lysine dehydrogenase +FIG01408463 Multiple sugar-binding transport system permease +FIG01408492 FMN-dependent NADH-azoreductase (EC 1.7.-.-) +FIG01408499 FIG00415457: hypothetical protein +FIG01408503 FIG00403065: hypothetical protein +FIG01408508 Succinate dehydrogenase subunit C sdhC +FIG01408572 Site specific recombinase, phage integrase +FIG01408578 FIG00747721: hypothetical protein +FIG01408587 COG3468: Type V secretory pathway, adhesin AidA +FIG01408597 Hypothetical resolvase +FIG01408608 converved hypothetical protein +FIG01408610 FIG01221916: hypothetical protein +FIG01408616 probable Insertion element IS1016 transposase +FIG01408622 spore coat protein, CotF related +FIG01408623 FIG00767684: hypothetical protein +FIG01408630 membrane metalloprotease +FIG01408633 putative secreted nucleosidase +FIG01408662 FIG00639317: hypothetical protein +FIG01408663 FIG00764141: hypothetical protein +FIG01408666 FIG01117274: hypothetical protein +FIG01408668 Listeria protein LmaB, associated with virulence +FIG01408678 Putative uncharacterized protein BCG_2888 +FIG01408688 FIG00351665: hypothetical protein +FIG01408699 FIG00403391: hypothetical protein +FIG01408712 FIG00762768: hypothetical protein +FIG01408718 FIG00451135: hypothetical protein +FIG01408730 FIG00815367: hypothetical protein +FIG01408739 hypothetical protein NMA0132 +FIG01408752 FIG00385412: hypothetical protein +FIG01408808 FIG00517099: hypothetical protein +FIG01408827 putative acylhydrolase +FIG01408836 Chain A, Restriction Endonuclease Mvai In The Absence Of Dna +FIG01408856 FIG00356773: hypothetical protein +FIG01408863 FIG00380516: hypothetical protein +FIG01408873 FIG01247715: hypothetical protein +FIG01408887 Phosphoenolpyruvate synthase +FIG01408891 Y4hR +FIG01408913 FIG00675555: hypothetical protein +FIG01408943 Putative inner membrane or exported protein +FIG01408958 syc1838_d +FIG01408963 FIG00623910: hypothetical protein +FIG01409016 Putative L-xylulose-5-phosphate 3-epimerase +FIG01409022 FIG00354209: hypothetical protein +FIG01409031 FIG00415200: hypothetical protein +FIG01409046 FIG00623984: hypothetical protein +FIG01409048 transcriptional regulator cII, putative +FIG01409056 Putative phosphatase +FIG01409070 possible porin +FIG01409078 ABC transporter permease protein +FIG01409088 Bifidobacterial FemAB-like protein type 2 +FIG01409096 Mll7507 protein +FIG01409116 putative surface protein +FIG01409124 FIG00425325: hypothetical protein +FIG01409136 FIG00413175: hypothetical protein +FIG01409138 FIG00409156: hypothetical protein +FIG01409161 FIG00410156: hypothetical protein +FIG01409167 Unkown +FIG01409173 FIG00623934: hypothetical protein +FIG01409174 trwL8 protein +FIG01409180 FIG00689806: hypothetical protein +FIG01409183 FIG00385514: hypothetical protein +FIG01409189 FIG00403293: hypothetical protein +FIG01409201 Methyl-viologen-reducing hydrogenase, delta subunit +FIG01409218 flp/Fap pilin component family protein +FIG01409229 FIG00350931: hypothetical protein +FIG01409230 serine/threonine protein kinase related protein +FIG01409259 predicted catabolite control protein A +FIG01409263 FIG00849470: hypothetical protein +FIG01409284 Potential TolA +FIG01409285 Dicarboxylate-carrier protein +FIG01409310 FIG00527251: hypothetical protein +FIG01409312 IFN-response binding factor 1 +FIG01409325 FIG00756146: hypothetical protein +FIG01409327 contains Hsp20/alpha crystallin domain +FIG01409329 SEC-C motif +FIG01409333 hypothetical protein +FIG01409342 FIG00815270: hypothetical protein +FIG01409352 FIG00675343: hypothetical protein +FIG01409360 FIG00349965: hypothetical protein +FIG01409382 putative type III secretion apparatus protein +FIG01409399 cell division protein FtsQ +FIG01409407 FIG00734007: hypothetical protein +FIG01409420 FIG00351119: hypothetical protein +FIG01409424 DNA adenine methylase( EC:2.1.1.72 ) +FIG01409435 Putative adenylate/guanylate cyclase +FIG01409457 FIG00755509: hypothetical protein +FIG01409464 FIG00628755: hypothetical protein +FIG01409469 FIG00622799: hypothetical protein +FIG01409479 Transposase +FIG01409485 FIG01128703: hypothetical protein +FIG01409490 bacteriophage f237 ORF3 +FIG01409505 protein of unknown function DUF1416 +FIG01409518 putative efflux protein +FIG01409520 FIG00744017: hypothetical protein +FIG01409525 FIG00350465: hypothetical protein +FIG01409536 Possible type I restriction/modification system specificity determinant hsdS' +FIG01409539 FIG00946027: hypothetical protein +FIG01409543 hypothetical protein +FIG01409546 FIG00380159: hypothetical protein +FIG01409551 FIG00385123: hypothetical protein +FIG01409552 FIG00413905: hypothetical protein +FIG01409556 putative sugar ABC transporter (permease protein) +FIG01409563 Protein of unknown function DUF676, hydrolase domain protein +FIG01409565 probable flavodoxin +FIG01409589 plasmid partitioning family protein ParA +FIG01409594 FIG00767498: hypothetical protein +FIG01409607 FIG00641459: hypothetical protein +FIG01409654 ABR064Wp +FIG01409670 FIG00913705: hypothetical protein +FIG01409701 FIG00827041: hypothetical protein +FIG01409705 FIG00624357: hypothetical protein +FIG01409715 putative IRON-REGULATED OUTER MEMBRANE PROTEIN +FIG01409739 FIG01164266: hypothetical protein +FIG01409748 FIG00385000: hypothetical protein +FIG01409753 dTDP-glucose 4,6-dehydratase +FIG01409756 Ribosomal protein L14 +FIG01409771 ABC-type sugar transport systems ATPase components +FIG01409788 FIG00350575: hypothetical protein +FIG01409797 FIG00767785: hypothetical protein +FIG01409807 Acyl-CoA dehydrogenases +FIG01409812 putative protein kinase C inhibitor +FIG01409860 Cobalt-zinc-cadmium resistance protein +FIG01409864 integrase-related protein +FIG01409872 Guanosine polyphosphate pyrophosphohydrolase/synthetase-like protein SpoT4 +FIG01409880 FIG00623724: hypothetical protein +FIG01409887 antibiotic resistance protein +FIG01409894 FIG00424813: hypothetical protein +FIG01409900 Gll2780 protein +FIG01409926 FIG00350325: hypothetical protein +FIG01409942 FIG00823792: hypothetical protein +FIG01409959 Nudix hydrolase 3 (EC 3.6.1.-) +FIG01409962 FIG00361216: hypothetical protein +FIG01409963 FIG00410009: hypothetical protein +FIG01409979 MarR-family transcriptional regulatory protein +FIG01410015 HEAT SHOCK PROTEIN HSP +FIG01410033 PUTATIVE ACYL-CoA DEHYDROGENASE +FIG01410037 FIG00344297: hypothetical protein +FIG01410041 Sugar phosphate permease-like +FIG01410043 FIG00470802: hypothetical protein +FIG01410047 FIG00765980: hypothetical protein +FIG01410058 FIG00675066: hypothetical protein +FIG01410072 FIG00347487: hypothetical protein +FIG01410080 Iron-regulated protein FrpC +FIG01410095 FIG00660596: hypothetical protein +FIG01410096 FIG00994570: hypothetical protein +FIG01410100 FIG00361343: hypothetical protein +FIG01410105 FIG00756329: hypothetical protein +FIG01410117 FIG00641942: hypothetical protein +FIG01410130 Type II restriction enzyme BglII (EC 3.1.21.4) (Endonuclease BglII) (R.BglII) +FIG01410139 FIG01129605: hypothetical protein +FIG01410144 putative hemin receptor +FIG01410148 FIG00355841: hypothetical protein +FIG01410157 FIG00352575: hypothetical protein +FIG01410162 Sll1884 protein +FIG01410164 pyrimidine-ribonucleotide metabolism +FIG01410171 putative cell wall biogenesis protein +FIG01410176 Nitrogen regulation protein NtrY (EC 2.7.3.-) +FIG01410187 FIG00957384: hypothetical protein +FIG01410193 POSSIBLE METHYLTRANSFERASE/METHYLASE +FIG01410206 Flagellar rod protein flaI +FIG01410211 ortholog to Borrelia burgdorferi BB0460 +FIG01410220 Lambda gpG analog +FIG01410230 FIG00406555: hypothetical protein +FIG01410256 CapA protein +FIG01410273 FIG00763401: hypothetical protein +FIG01410279 FIG00350569: hypothetical protein +FIG01410287 PAS domain protein +FIG01410291 4-hydroxybutyrate dehydrogenase (EC 1.1.1.61) +FIG01410301 Hydrogenase 3 maturation protease (EC 3.4.-.-) +FIG01410310 putative pyrogenic exotoxin B +FIG01410313 ABC transporter, membrane spanning protein [amino acid] +FIG01410314 putative two-component system sensor histidine kinase, no kinase domain +FIG01410324 putative integral membrane protein. +FIG01410345 FIG00734074: hypothetical protein +FIG01410348 Putative outermembrane protein +FIG01410376 Uncharacterized protein MJ1127 +FIG01410400 putative plasmid replication-associated protein +FIG01410405 ORF_ID:alr7532 unknown protein +FIG01410411 FIG00766841: hypothetical protein +FIG01410412 FIG00733532: hypothetical protein +FIG01410424 Kelch repeat protein +FIG01410434 FIG00380021: hypothetical protein +FIG01410439 Pilin-like protein +FIG01410447 FIG00385649: hypothetical protein +FIG01410451 FIG00415160: hypothetical protein +FIG01410457 Para-aminobenzoate synthase, amidotransferase component (EC 6.3.5.8) +FIG01410477 Phenylacetic acid degradation B +FIG01410483 FIG045343: Transcriptional regulator, MarR family +FIG01410492 sucraseferredoxin family protein +FIG01410522 ThiF family protein, ubiquitin-activating enzyme +FIG01410529 FIG00352445: hypothetical protein +FIG01410531 FIG00424814: hypothetical protein +FIG01410584 FIG01055022: hypothetical protein +FIG01410586 Two component sensor and regulator, histidine kinase response regulator +FIG01410608 Mosquitocidal toxin +FIG01410625 thermolysin precursor +FIG01410634 flavoprotein WrbA +FIG01410647 hypothetical protein +FIG01410651 FIG00847076: hypothetical protein +FIG01410696 putative protein Ymh +FIG01410720 PLASMID TRANSFER PROTEIN traF +FIG01410734 Mu-like prophage I protein-like +FIG01410765 Uncharacterized protein yxeC +FIG01410770 FIG00848247: hypothetical protein +FIG01410774 FIG00769415: hypothetical protein +FIG01410781 hypothetical protein +FIG01410785 FIG00530694: hypothetical protein +FIG01410821 bacterioferritin-associated ferredoxin +FIG01410823 FIG00768842: hypothetical protein +FIG01410824 Lipoprotein releasing system transmembrane protein lolC +FIG01410826 TWO COMPONENT SENSOR HISTIDINE KINASE DEVS +FIG01410834 FIG01047138: hypothetical protein +FIG01410837 Asr4678 protein +FIG01410839 DNA primase; involved in replication, phage related +FIG01410840 FIG01203332: hypothetical protein +FIG01410841 putative conjugative transposon recombinase +FIG01410852 lipid A biosynthesis acyltransferase +FIG01410853 FIG00407403: hypothetical protein +FIG01410865 BICP4 positive and negative gene regulator +FIG01410887 Type III secretion chaperone BicP +FIG01410894 probable DNA-binding protein NMA1198 +FIG01410918 MltA-interacting protein +FIG01410966 FIG00767987: hypothetical protein +FIG01411002 Lmo0660 protein +FIG01411009 formyl transferase domain protein +FIG01411015 FIG00348153: hypothetical protein +FIG01411032 Mlr0912 protein +FIG01411036 probable short-chain dehydrogenase +FIG01411048 COG0476: Dinucleotide-utilizing enzymes involved in molybdopterin and thiamine biosynthesis family 2 +FIG01411078 FIG00414501: hypothetical protein +FIG01411084 Mlr8156 protein +FIG01411088 Cyanothece PCC 8801 NifK +FIG01411103 FIG01235711: hypothetical protein +FIG01411127 Ig-like repeat domain protein 3 +FIG01411135 FIG00350327: hypothetical protein +FIG01411139 FIG01042532: hypothetical protein +FIG01411154 FIG00351688: hypothetical protein +FIG01411169 putative SAM-dependant methyltransferase( EC:2.1.1.- ) +FIG01411190 tRNA pseudouridine synthase +FIG01411193 IncI1 plasmid conjugative transfer protein PilK +FIG01411213 FIG00407231: hypothetical protein +FIG01411220 Cellulose 1,4-beta-cellobiosidase( EC:3.2.1.91 ) +FIG01411221 FIG00350983: hypothetical protein +FIG01411222 FIG00629245: hypothetical protein +FIG01411223 FIG00411700: hypothetical protein +FIG01411231 sodium-dependent transporter +FIG01411261 FIG00469064: hypothetical protein +FIG01411269 unknown, predicted membrane protein (TMS5) +FIG01411292 ISBm1, transposase orfA +FIG01411305 FIG00769214: hypothetical protein +FIG01411309 FIG00415342: hypothetical protein +FIG01411321 FIG00402915: hypothetical protein +FIG01411326 FIG00751893: hypothetical protein +FIG01411330 Type IV pili fiber building block protein +FIG01411332 Putative homoserine kinase type II +FIG01411335 FIG00793325: hypothetical protein +FIG01411385 FIG00459526: hypothetical protein +FIG01411392 Lipase/acylhydrolase domain protein +FIG01411395 Probable ABC transport system permease protein +FIG01411405 FIG00768047: hypothetical protein +FIG01411410 MOBD protein +FIG01411411 FIG00404444: hypothetical protein +FIG01411422 FIG00985326: hypothetical protein +FIG01411447 FIG01170112: hypothetical protein +FIG01411450 FIG00388199: hypothetical protein +FIG01411454 FIG00659855: hypothetical protein +FIG01411460 FIG00639340: hypothetical protein +FIG01411466 FIG00406258: hypothetical protein +FIG01411484 cytidine/deoxycytidylate deaminase/NUDIX/methyltransferase domains protein +FIG01411503 short-chain type dehydrogenase/reductase +FIG01411509 FIG00412418: hypothetical protein +FIG01411531 reductive dehalogenase anchoring protein, putative +FIG01411547 FIG00530781: hypothetical protein +FIG01411606 predicted phosphatase/phosphohexomutase +FIG01411628 FIG00753692: hypothetical protein +FIG01411646 FIG00468802: hypothetical protein +FIG01411652 COG1396: Predicted transcriptional regulators +FIG01411678 FIG00712082: hypothetical protein +FIG01411699 Serine/Threonine protein kinase with TPR repeats +FIG01411702 FIG00351463: hypothetical protein +FIG01411716 Type II restriction enzyme HgAI (EC 3.1.21.4) (Endonuclease HgAI) (R.HgAI) +FIG01411722 putative PnuC protein +FIG01411730 Vitamin B12 ABC transporter, B12-binding component BtuF +FIG01411735 Sugar ABC transporter, permease protein +FIG01411739 Phage N-acetylmuramoyl-L-alanine amidase (EC 3.5.1.28) +FIG01411798 P2-like prophage tail protein X +FIG01411811 FIG00755961: hypothetical protein +FIG01411812 cell surface antigen +FIG01411821 Possible DnaB-like helicase +FIG01411836 FIG01059512: hypothetical protein +FIG01411853 FIG00840532: hypothetical protein +FIG01411866 protein of unknown function DUF395, YeeE/YedE +FIG01411867 FIG00654445: hypothetical protein +FIG01411872 putative mutant sensor protein +FIG01411875 sodium/pantothenate symporter , putative +FIG01411887 Kef-type K+ transport systems, predicted NAD-binding component +FIG01411893 FIG01048878: hypothetical protein +FIG01411897 FIG00628767: hypothetical protein +FIG01411905 erythromycin biosynthesis sensory transduction protein eryC1 +FIG01411913 PlaP4 +FIG01411923 FIG01166921: hypothetical protein +FIG01411931 C-P lyase regulatory protein +FIG01411941 FIG00775821: hypothetical protein +FIG01411948 putative general secretion pathway protein +FIG01411952 Hypothetical protein DUF1470, with CGNR zinc finger motif +FIG01411960 Flagellar biosynthesis/type III secretory pathway protein-like protein +FIG01411964 FIG00529004: hypothetical protein +FIG01411981 FIG00388028: hypothetical protein +FIG01411990 Gll1939 protein +FIG01411993 hypothetical protein +FIG01412010 3'-5' exonuclease +FIG01412034 FIG00774855: hypothetical protein +FIG01412038 Transcriptional regulator AsnC +FIG01412065 FIG00407338: hypothetical protein +FIG01412094 P pilus assembly/Cpx signaling pathway, periplasmic inhibitor/zinc- resistance associated protein +FIG01412101 oxidoreductase, molybdopterin binding +FIG01412139 FIG00958147: hypothetical protein +FIG01412144 FIG00503679: hypothetical protein +FIG01412152 FIG00820757: hypothetical protein +FIG01412156 FIG00623060: hypothetical protein +FIG01412161 Transcriptional regulator sirC +FIG01412169 FIG00769722: hypothetical protein +FIG01412177 CMP-binding-factor 1 +FIG01412199 FIG00765725: hypothetical protein +FIG01412215 UPF0033 protein TM_0983 +FIG01412235 FIG00733397: hypothetical protein +FIG01412236 FIG00644120: hypothetical protein +FIG01412237 UDP-glucoronosyl and UDP-glucosyltransferases family protein +FIG01412247 Probable hemagglutinin-related protein +FIG01412254 FIG00767792: hypothetical protein +FIG01412260 FIG00406056: hypothetical protein +FIG01412270 FIG00402681: hypothetical protein +FIG01412275 FIG00631899: hypothetical protein +FIG01412283 Replication protein Rep +FIG01412284 KpLE2 phage-like element; predicted protein (pseudogene) +FIG01412303 PaxA, putative +FIG01412307 FIG00623748: hypothetical protein +FIG01412321 Heme/copper-type cytochrome/quinol oxidases, subunit 2 +FIG01412329 Cyclohexanone monooxygenase (EC 1.14.13.22) +FIG01412331 FIG00387925: hypothetical protein +FIG01412368 Phosphohydrolase, MutT/Nudix family +FIG01412379 FIG00350801: hypothetical protein +FIG01412395 Tiorf30 protein +FIG01412404 DNA-binding protein; possible transcriptional regulator +FIG01412409 Xanthine/uracil permease family +FIG01412447 ORF137 +FIG01412454 transposase OrfA, IS3 family +FIG01412463 FIG00406172: hypothetical protein +FIG01412486 TRNA/rRNA methyltransferase +FIG01412500 molybdopterin-converting factor chain 2 +FIG01412502 All0324 protein +FIG01412512 macrolide efflux protein, putative +FIG01412522 Predicted phosphatase of HAD hydrolase superfamily protein +FIG01412527 hypothetical protein NMA1257 +FIG01412531 Nitrogen regulation protein ntrY homolog (EC 2.7.3.-) +FIG01412535 FIG00537505: hypothetical protein +FIG01412537 FIG00762954: hypothetical protein +FIG01412555 FIG00822783: hypothetical protein +FIG01412560 FIG00388668: hypothetical protein +FIG01412561 cell wall teichoic acid glycosylation protein GtcA +FIG01412574 FIG01243891: hypothetical protein +FIG01412582 FIG00711929: hypothetical protein +FIG01412586 FIG00412260: hypothetical protein +FIG01412601 FIG00362087: hypothetical protein +FIG01412604 FIG00412724: hypothetical protein +FIG01412605 M. jannaschii predicted coding region MJ0455 +FIG01412615 FIG00425477: hypothetical protein +FIG01412617 FIG00749156: hypothetical protein +FIG01412655 Ig-like repeat domain protein 1 +FIG01412668 unknown protein encoded in prophage CP-933I +FIG01412681 FIG01197536: hypothetical protein +FIG01412682 hypothetical protein +FIG01412686 DNA cytosine methylase +FIG01412688 FIG00412533: hypothetical protein +FIG01412691 putative ABC transporter sugar binding protein +FIG01412705 FIG00385404: hypothetical protein +FIG01412706 FIG00468633: hypothetical protein +FIG01412709 FIG00733319: hypothetical protein +FIG01412731 FIG00426649: hypothetical protein +FIG01412735 Protein similar to polyadenylation specificity factor, MJ1236 type +FIG01412740 Pyridoxal phosphate-dependent transferase +FIG01412754 FIG00409213: hypothetical protein +FIG01412758 Nitrilase( EC:3.5.5.1 ) +FIG01412768 FIG00469655: hypothetical protein +FIG01412782 FIG00388599: hypothetical protein +FIG01412794 conjugative pilus assembly protein +FIG01412808 Sll1863 protein +FIG01412854 transglycosylase, SLT family +FIG01412859 FIG00632207: hypothetical protein +FIG01412872 ABC-type transporter ATP-binding protein +FIG01412878 FIG00352329: hypothetical protein +FIG01412879 Possible Protein phosphatase 2A regulatory B s +FIG01412902 Hypothetical protein, CF-3 family K28 +FIG01412913 FIG00380099: hypothetical protein +FIG01412926 ABC transporter ATP-binding-Pr1 +FIG01412948 putative YhfP protein +FIG01412957 UPF0310 protein in gntR 5'region +FIG01412967 NAD(P)H-dependent glycerol-3-phosphate dehydrogenase( EC:1.1.1.94 ) +FIG01412994 trypsin +FIG01412998 FIG00766048: hypothetical protein +FIG01413025 FIG00352410: hypothetical protein +FIG01413043 Uncharacterized HTH-type transcriptional regulator yfiF +FIG01413055 putative factor; Integration, recombination (Phage or Prophage Related) +FIG01413057 4-hydroxybenzoyl-CoA thioesterase (EC 3.1.2.23) +FIG01413063 D-alanyl-D-alanine dipeptidase (EC 3.4.13.22) +FIG01413065 FIG00831245: hypothetical protein +FIG01413066 InterPro IPR000209 COGs COG1404 +FIG01413070 FIG00766250: hypothetical protein +FIG01413077 Ribonuclease precursor (EC 3.1.27.-) +FIG01413088 FIG00872647: hypothetical protein +FIG01413102 caax amino protease family protein +FIG01413151 FIG00450506: hypothetical protein +FIG01413167 FIG00534171: hypothetical protein +FIG01413173 FIG00385128: hypothetical protein +FIG01413174 FIG00412616: hypothetical protein +FIG01413175 TRANSCRIPTIONAL ACTIVATOR, LUXR FAMILY +FIG01413176 FIG00468426: hypothetical protein +FIG01413178 putative ABC transporter periplasmic sugar-binding protein +FIG01413200 FIG01032240: hypothetical protein +FIG01413220 FIG00387981: hypothetical protein +FIG01413222 Cell wall hydrolyses involved in spore germination +FIG01413227 FIG00978931: hypothetical protein +FIG01413245 FIG01068760: hypothetical protein +FIG01413252 ATP-dependent efflux pump essential for phthiocerol dimycocerosates translocation, integral membrane protein DrrC-like +FIG01413299 syc2143_c +FIG01413302 Probable cation-transporting ATPase +FIG01413303 Radical SAM +FIG01413309 Methicillin resistance regulatory sensor-transducer MecR1 +FIG01413311 PROBABLE TRANSPOSASE FOR INSERTION SEQUENCE ELEMENT IS1533 +FIG01413336 FIG00763885: hypothetical protein +FIG01413344 FilE +FIG01413347 mobile element transfer protein SpdA +FIG01413348 Outer membrane receptor proteins, mostly Fe transport +FIG01413353 FIG00643565: hypothetical protein +FIG01413354 IcmP protein +FIG01413371 VapC toxin protein +FIG01413380 probable acid phosphatase +FIG01413415 FIG01075454: hypothetical protein +FIG01413439 FIG00529998: hypothetical protein +FIG01413441 FIG00847246: hypothetical protein +FIG01413451 conjugal transfer protein, TraD +FIG01413456 FIG00468460: hypothetical protein +FIG01413469 transposase (12) BH0978 +FIG01413474 YhbX/YhjW/YijP/YjdB family protein +FIG01413492 FIG172108: hypothetical protein +FIG01413505 EbhA protein +FIG01413540 Basic protein +FIG01413554 hicB protein +FIG01413556 Hot dog fold protein HP0420 / Methylthioribose-1-phosphate isomerase (EC 5.3.1.23) +FIG01413562 MocB-like protein +FIG01413570 FIG01043878: hypothetical protein +FIG01413588 Lmo0748 protein +FIG01413592 Regulator of cell morphogenesis and NO signaling +FIG01413597 F420H2-dehydrogenase, beta subunit +FIG01413610 Conserved expressed protein +FIG01413613 alkaline D-peptidase +FIG01413619 Gll0826 protein +FIG01413629 FIG00347450: hypothetical protein +FIG01413657 Mll0159 protein +FIG01413683 putative terminase large subunit protein +FIG01413685 FIG00563848: hypothetical protein +FIG01413689 recombinase +FIG01413694 membrane-fusion protein +FIG01413707 Aspartate aminotransferase +FIG01413714 FIG01069783: hypothetical protein +FIG01413717 FIG01028625: hypothetical protein +FIG01413726 Succinoglycan biosynthesis protein ExoI-like +FIG01413761 L-sorbosone dehydrogenase, putative +FIG01413762 bsl3029; unknown protein +FIG01413770 LppJ +FIG01413786 hypothetical protein +FIG01413801 putative Rhs-family protein +FIG01413830 Kil protein +FIG01413832 FIG00469239: hypothetical protein +FIG01413844 plasmid replication protein RepA +FIG01413848 histidine kinase-like ATPase +FIG01413861 Putative MCP-domain signal transduction protein +FIG01413912 Probable flavoprotein +FIG01413918 FIG00814467: hypothetical protein +FIG01413932 threonine efflux related porin +FIG01413946 hypothetical protein +FIG01413947 Translation initiation inhibitor +FIG01413976 similar to site-specific integrase-resolvase +FIG01413980 FIG00744915: hypothetical protein +FIG01413985 alanine-rich protein +FIG01414000 FIG00424005: hypothetical protein +FIG01414041 bacitracin ABC transporter, permease protein +FIG01414047 putative ferric aerobactin receptor +FIG01414048 hypothetical protein +FIG01414052 lipopolysaccharide biosynthesis protein wbpB +FIG01414068 FIG00388458: hypothetical protein +FIG01414072 Fructosyltransfearse Ftf +FIG01414076 FIG00863276: hypothetical protein +FIG01414091 Entericidin A precursor +FIG01414096 FIG00743597: hypothetical protein +FIG01414103 FIG01237946: hypothetical protein +FIG01414163 putative excisionase +FIG01414166 signal peptide, putative +FIG01414175 Uncharacterized protein yisI +FIG01414176 FIG00415662: hypothetical protein +FIG01414178 FIG01253089: hypothetical protein +FIG01414180 FIG00642002: hypothetical protein +FIG01414183 Lj928 prophage portal protein +FIG01414196 Delta(24(24(1)))-sterol reductase (EC 1.3.1.71); Delta(14)-sterol reductase (EC 1.3.1.70); 7-dehydrocholesterol reductase (EC 1.3.1.21) +FIG01414212 Poly (3-hydroxybutyrate) depolymerase (EC 3.1.1.75) +FIG01414227 FIG00849489: hypothetical protein +FIG01414229 Teicoplanin resistance protein vanZ +FIG01414238 possible VHS domain +FIG01414246 putative CAAX amino terminal protease family protein +FIG01414261 2-polyprenyl-6-methoxyphenol hydroxylase and related FAD-dependent oxidoreductases +FIG01414266 3-ketosteroid-delta-1-dehydrogenase +FIG01414277 ISRSO5-transposase protein +FIG01414279 Fibroin 1a +FIG01414285 Sec-independent protein secretion pathway component +FIG01414305 ATP binding protein of ABC transporter for sugars +FIG01414308 FIG00310351: hypothetical protein +FIG01414327 FIG00353892: hypothetical protein +FIG01414332 FIG01118923: hypothetical protein +FIG01414340 FIG00766517: hypothetical protein +FIG01414357 Aspartyl/asparaginyl beta-hydroxylase and related dioxygenases +FIG01414359 putative sugar efflux transpoter +FIG01414370 FIG00385786: hypothetical protein +FIG01414386 FIG00849829: hypothetical protein +FIG01414406 luciferase-alpha subunit +FIG01414409 Prophage ps3 protein 01 +FIG01414420 FIG00361736: hypothetical protein +FIG01414444 FIG01157355: hypothetical protein +FIG01414447 FIG01232743: hypothetical protein +FIG01414449 Glycoside hydrolase, family 28 +FIG01414454 FIG00514989: hypothetical protein +FIG01414470 non-ribosomal peptide synthase +FIG01414472 Transcriptional regulator, LysR family +FIG01414473 isoniazid inductible gene protein IniA +FIG01414478 cytochrome B6 +FIG01414497 FIG00949475: hypothetical protein +FIG01414499 Aspartoacylase( EC:3.5.1.15 ) +FIG01414502 Alpha-N-arabinofuranosidase( EC:3.2.1.55 ) +FIG01414505 FIG00353995: hypothetical protein +FIG01414516 bacterioferritin (cytochrome b1) +FIG01414519 hypothetical protein +FIG01414534 FIG00388292: hypothetical protein +FIG01414544 FIG00448820: hypothetical protein +FIG01414562 Sugar ABC transporter +FIG01414565 FAD dependent oxidoreductase precursor +FIG01414571 FIG00351049: hypothetical protein +FIG01414574 Transcriptional regulator merR family +FIG01414579 Glycosyl transferase, group 1 (EC 2.-.-.-) +FIG01414584 ZINC PROTEASE +FIG01414588 FIG01120515: hypothetical protein +FIG01414589 FIG00513713: hypothetical protein +FIG01414603 FIG00835658: hypothetical protein +FIG01414608 Phosphoglycolate phosphatase +FIG01414617 FIG00642428: hypothetical protein +FIG01414619 FIG00946120: hypothetical protein +FIG01414626 competence locus E, putative +FIG01414627 Colicin V production protein +FIG01414664 FIG00679259: hypothetical protein +FIG01414708 Low temperature requirement C protein +FIG01414716 Kef-type K+ transport system, predicted NAD-binding component +FIG01414736 hypothetical protein +FIG01414746 FIG01046087: hypothetical protein +FIG01414751 serine/threonine protein phosphatase +FIG01414755 Alpha-(1,3)-fucosyltransferase (EC 2.4.1.65) +FIG01414759 Predicted transcriptional regulator, containing DNA-binding domain of xre family +FIG01414763 Tyrosine protein kinase +FIG01414781 Acetamidase/Formamidase precursor +FIG01414785 FIG00624367: hypothetical protein +FIG01414797 hypothetical protein +FIG01414799 conserved hypothetical protein; putative membrane protein. +FIG01414802 amino acid ABC transporter, permease protein, 3-TM region, His/Glu/Gln/Arg/opine +FIG01414819 Amylopullulanase precursor (Alpha-amylase/pullulanase) (Pullulanase type II) [Includes: Alpha-amylase (EC 3.2.1.1) (1,4-alpha-D-glucan glucanohydrolase); Pullulanase (EC 3.2.1.41) (1,4-alpha-D-glucan glucanohydrolase) (Alpha-dextrin endo-1,6-alpha-glucosidase)] +FIG01414822 paraoxonase 3-like protein +FIG01414824 Dolichyl-phosphate mannoosyltransferase, involved in cell wall biogenesis +FIG01414827 putative sigma 54 modulation protein/ribosomal protein S30EA +FIG01414835 Uncharacterized protein MJ0003 +FIG01414849 FIG01227350: hypothetical protein +FIG01414868 Trifolitoxin immunity protein +FIG01414870 RNA-binding region RNP-1 +FIG01414888 Diguanylate cyclase/phosphodiesterase domain 2 +FIG01414896 FIG00426069: hypothetical protein +FIG01414904 proteophosphoglycan ppg4 +FIG01414912 chpAI protein +FIG01414918 FIG00409720: hypothetical protein +FIG01414924 Transcription antiterminator, LytR family +FIG01414945 FIG00632719: hypothetical protein +FIG01414950 probable membrane protein YPO1144 +FIG01414951 membrane protein CvpA, putative +FIG01414952 FIG01233957: hypothetical protein +FIG01414953 nitrite and sulphite reductase 4Fe-4S region +FIG01414971 FIG00389644: hypothetical protein +FIG01414979 phage-related membrane protein +FIG01415001 PROBABLE CONSERVED LIPOPROTEIN LPPR +FIG01415002 FIG00815689: hypothetical protein +FIG01415024 FIG00352343: hypothetical protein +FIG01415067 similar to ABC-type branched-chain amino acid transport systems periplasmic component +FIG01415070 Putative secretion activating protein +FIG01415088 FIG01028768: hypothetical protein +FIG01415093 FIG00623485: hypothetical protein +FIG01415097 FIG00945062: hypothetical protein +FIG01415108 hypothetical methyltransferase +FIG01415109 FIG00352026: hypothetical protein +FIG01415117 Germination-specific N-acetylmuramoyl-L-alanine amidase (EC 3.5.1.28) +FIG01415118 FIG00823478: hypothetical protein +FIG01415119 Resolvase helix-turn-helix region +FIG01415125 FIG01200934: hypothetical protein +FIG01415126 DHH superfamily protein +FIG01415128 FIG00385006: hypothetical protein +FIG01415143 Putative ABC transport system, substrate-binding protein +FIG01415144 FIG00361518: hypothetical protein +FIG01415174 Putative periplasmic protein +FIG01415183 COG family: septum formation inhibitor-activating ATPase +FIG01415190 Type IV fimbrial biogenesis protein PilW +FIG01415191 Hypothetical protein with RNA-binding region RNP-1 +FIG01415198 FIG00767261: hypothetical protein +FIG01415200 Rhs core protein with extension +FIG01415201 Penicillin binding protein +FIG01415210 Probable nucleotide pyrophosphatase homolog +FIG01415218 Protein of unknown function DUF490 +FIG01415235 FIG00363392: hypothetical protein +FIG01415272 iron transport periplasmic binding protein, putative (ceuE) +FIG01415289 FIG01114387: hypothetical protein +FIG01415292 Putative permease protein +FIG01415318 general secretion pathway protein E +FIG01415335 FIG01211551: hypothetical protein +FIG01415350 FIG00411172: hypothetical protein +FIG01415351 putative membrane transporter of cations and cationic drugs, multidrug resistance protein +FIG01415359 FIG00406954: hypothetical protein +FIG01415366 conserved hypothetical protein; possible hydrolase +FIG01415388 FIG00350864: hypothetical protein +FIG01415398 FIG00824716: hypothetical protein +FIG01415404 FIG00764536: hypothetical protein +FIG01415411 probable DNA alkylation repair enzyme +FIG01415422 COG0265: Trypsin-like serine proteases, typically periplasmic, contain C-terminal PDZ domain +FIG01415426 FIG00384857: hypothetical protein +FIG01415435 FIG01043682: hypothetical protein +FIG01415436 probable LysR family transcriptional regulator +FIG01415440 Conserved possible transposase +FIG01415448 Transposase of IS1604-like element +FIG01415462 FIG00344799: hypothetical protein +FIG01415476 short-chain dehydrogenase/reductase, Mmcs_1643 homolog +FIG01415487 putative beta (1-6) glucans synthase +FIG01415505 Membrane fusion protein +FIG01415506 Bll4412 protein +FIG01415510 anti-sigma factor homolog yrhM +FIG01415513 tRNA (adenine-N(1)-)-methyltransferase( EC:2.1.1.36 ) +FIG01415531 Medium-chain-fatty-acid--CoA ligase +FIG01415541 tRNA (Adenine-N(1)-) -methyltransferase (EC 2.1.1.36) +FIG01415559 putative TraC conjugal transfer protein +FIG01415566 tRNA methylase YGL050w homolog Wyeosine biosynthesis type 2 +FIG01415616 FIG01249230: hypothetical protein +FIG01415620 Family 115-like protein +FIG01415638 Uncharacterized protein aq_796 precursor +FIG01415640 Probable mobilization protein MobA +FIG01415647 Phage resolvase +FIG01415661 probable exported protein YPO3798 +FIG01415664 FIG00451755: hypothetical protein +FIG01415670 FIG01202031: hypothetical protein +FIG01415688 bifunctional ABC transporter +FIG01415698 ABC transport protein BldKB +FIG01415743 PE-PGRS FAMILY PROTEIN +FIG01415745 putative ABC transporter (permease) [KO:K02029] +FIG01415747 Probable non-ribosomal peptide synthetase +FIG01415782 hydrolase, haloacid dehalogenase-like family protein +FIG01415791 FIG00426996: hypothetical protein +FIG01415792 FIG00347887: hypothetical protein +FIG01415794 Possible glycosyltransferase group 1 +FIG01415795 putative disulfide oxidoreductase +FIG01415856 FIG00818530: hypothetical protein +FIG01415874 Truncated response regulator +FIG01415880 Phospholipase C 4 precursor (EC 3.1.4.3) +FIG01415899 Rhodanese domain protein / Ankyrin +FIG01415904 FIG00733278: hypothetical protein +FIG01415911 Endoglucanase (EC 3.2.1.4) (Endo-1,4-beta-glucanase) (Cellulase) +FIG01415912 FIG00364661: hypothetical protein +FIG01415916 ORF044 +FIG01415923 Calcium-binding acidic-repeat protein precursor +FIG01415933 FIG00451283: hypothetical protein +FIG01415935 Core component YkoE of thiamin-regulated ECF transporter for HydroxyMethylPyrimidine +FIG01415938 Probable molybdopterin-guanine dinucleotide biosynthesis protein A +FIG01416008 transposase, IS3 +FIG01416027 hypothetical protein +FIG01416034 PROBABLE OXIDOREDUCTASE +FIG01416039 FIG00642248: hypothetical protein +FIG01416049 Orf18 +FIG01416067 FIG00350929: hypothetical protein +FIG01416087 FIG00409304: hypothetical protein +FIG01416093 FIG00915490: hypothetical protein +FIG01416100 MEMBRANE FUSION PROTEIN MTRC +FIG01416145 FIG00350579: hypothetical protein +FIG01416179 Putative CrcB protein (Integral membrane protein possibly involved in chromosome condensation) +FIG01416180 FIG00350945: hypothetical protein +FIG01416183 FIG00417806: hypothetical protein +FIG01416210 PROTEIN TRANSLOCASE SUBUNIT SECE +FIG01416239 FIG01220454: hypothetical protein +FIG01416253 COG0738: Fucose permease +FIG01416267 Preprotein translocase secG subunit (Protein transport protein SEC61 subunit beta homolog) +FIG01416279 FIG00452174: hypothetical protein +FIG01416289 sorbitol dehydrogenase +FIG01416299 FIG00639853: hypothetical protein +FIG01416315 phage protein +FIG01416319 FIG00417360: hypothetical protein +FIG01416329 similar to ribulose-1,5-bisphosphate carboxylase, Type III, too +FIG01416347 FIG00823450: hypothetical protein +FIG01416358 Glycosyltransferase fused to TPR-repeat domain +FIG01416373 ferredoxin, 2Fe-2S +FIG01416374 FIG00643727: hypothetical protein +FIG01416406 protein tyrosine/serine phosphatase +FIG01416412 putative peptidyl-prolyl cis-trans isomerase +FIG01416422 FIG00388867: hypothetical protein +FIG01416455 protein of unknown function UPF0236 +FIG01416473 hypothetical protein +FIG01416476 hypothetical protein +FIG01416502 FIG00633122: hypothetical protein +FIG01416524 BarA +FIG01416536 PROBABLE RESUSCITATION-PROMOTING FACTOR RPFE +FIG01416543 ribosomal protein S13 +FIG01416548 FIG00344196: hypothetical protein +FIG01416549 plasmid stabilization system +FIG01416566 FIG00349499: hypothetical protein +FIG01416571 FIG00414138: hypothetical protein +FIG01416631 sensor histidine kinase/response regulator/transporter hybrid protein +FIG01416636 PAS factor +FIG01416641 Exopolysaccharide synthesis protein ExoD-related protein +FIG01416661 FIG00640251: hypothetical protein +FIG01416663 FIG00641946: hypothetical protein +FIG01416676 Glutathione S-transferase-related protein-like +FIG01416715 putative hemolysin +FIG01416751 miscellaneous; unknown +FIG01416777 bll2446; hypothetical protein +FIG01416795 Carbohydrate binding family 6 +FIG01416805 FIG00350886: hypothetical protein +FIG01416829 FIG00871004: hypothetical protein +FIG01416830 hypothetical protein +FIG01416844 BolA family protein +FIG01416882 FIG00350700: hypothetical protein +FIG01416899 related to CAAX prenyl protease +FIG01416905 conserved hypothetical protein 103 +FIG01416939 L-kynurenine aminotransferase (EC 2.6.1.7) +FIG01416954 Nucleotidyl transferase +FIG01416955 Predicted secreted nucleic acid binding protein +FIG01416965 FIG01219896: hypothetical protein +FIG01416972 Alanyl dipeptidyl peptidase +FIG01416978 FIG00874507: hypothetical protein +FIG01416979 chloride channel +FIG01417017 FIG01130818: hypothetical protein +FIG01417018 FIG00353968: hypothetical protein +FIG01417025 Sll0939 protein +FIG01417027 FIG00641996: hypothetical protein +FIG01417032 hypothetical protein +FIG01417038 FIG00544133: hypothetical protein +FIG01417057 similar to Response regulator of the LytR/AlgR family +FIG01417063 FIG01417063: possible membrane protein +FIG01417068 SAM (And some other nucleotide) binding motif +FIG01417084 H-REV 107-related protein +FIG01417091 FIG00766783: hypothetical protein +FIG01417098 FIG00384940: hypothetical protein +FIG01417103 FIG00768155: hypothetical protein +FIG01417146 FIG00639894: hypothetical protein +FIG01417173 Phage DNA invertase +FIG01417177 FIG00354317: hypothetical protein +FIG01417179 FIG00515841: hypothetical protein +FIG01417180 FIG00764499: hypothetical protein +FIG01417203 FIG00468489: hypothetical protein +FIG01417216 peptidase A24A prepilin type IV +FIG01417217 FIG00404205: hypothetical protein +FIG01417226 Type IV pilin PilA +FIG01417229 hypothetical protein +FIG01417240 Beta-lactamase precursor (EC 3.5.2.6) +FIG01417243 FIG01169683: hypothetical protein +FIG01417246 Hypothetical protein, SAV0849 homolog [SA bacteriophages 11, Mu50B] +FIG01417255 PUTATIVE LIPOPROTEIN +FIG01417257 FIG00849730: hypothetical protein +FIG01417261 sigma-70 region 2 +FIG01417267 glycosyltransferase family 23 +FIG01417293 two component diguanylate cyclase +FIG01417307 YESV protein +FIG01417333 FIG00767445: hypothetical protein +FIG01417344 FIG01125579: hypothetical protein +FIG01417347 WcbG +FIG01417360 Transporter +FIG01417368 FIG00514075: hypothetical protein +FIG01417371 FIG00957675: hypothetical protein +FIG01417396 Conserved protein with osmC domain +FIG01417461 FIG00350590: hypothetical protein +FIG01417462 FIG00524189: hypothetical protein +FIG01417478 Cation-transporting ATPase PacL +FIG01417494 FIG00405052: hypothetical protein +FIG01417511 FIG00350843: hypothetical protein +FIG01417528 FIG00768283: hypothetical protein +FIG01417537 unknown function +FIG01417542 FIG00769700: hypothetical protein +FIG01417550 FIG01245991: hypothetical protein +FIG01417580 FIG00946193: hypothetical protein +FIG01417588 FIG00385232: hypothetical protein +FIG01417601 FIG00351416: hypothetical protein +FIG01417629 putative DNA-binding protein +FIG01417634 Possible RND efflux membrane fusion protein +FIG01417640 FIG00361813: hypothetical protein +FIG01417654 FIG00766160: hypothetical protein +FIG01417661 FIG00425731: hypothetical protein +FIG01417681 similar to serine/threonine protein kinase related protein +FIG01417682 Putative EsaC protein analog (Listeria type 4) +FIG01417693 FIG00410267: hypothetical protein +FIG01417696 syc0355_c +FIG01417714 glycoside hydrolase family 2, sugar binding +FIG01417727 Cell division protein YlmG/Ycf19 (putative), YggT family +FIG01417728 FIG01167038: hypothetical protein +FIG01417738 Transposase +FIG01417753 formate dehydrogenase, alpha subunit +FIG01417755 gram positive anchor domain protein +FIG01417758 Putative oxidoreductase SMc00968 +FIG01417778 2',3'-cyclic nucleotide 3'-phosphodiesterase (EC 3.1.4.37) +FIG01417810 2-oxoglutarate/malate translocator +FIG01417820 Short-chain dehdyrogenase (EC 1.-.-.-) +FIG01417821 FIG00385528: hypothetical protein +FIG01417828 Putative sugar-binding protein +FIG01417831 CapM protein, capsular polysaccharide biosynthesis +FIG01417841 FIG00408957: hypothetical protein +FIG01417845 putative phosphohistidine phosphatase +FIG01417879 DNA helicase, SNF2/RAD54 family domain protein +FIG01417880 FIG00928874: hypothetical protein +FIG01417893 FIG00763679: hypothetical protein +FIG01417898 Uncharacterized protein MJ1673 +FIG01417902 Phthalate 4,5-dioxygenase oxygenase subunit (EC 1.14.12.7) +FIG01417904 Internalin-like protein Lin0295 homolog +FIG01417906 Antigen 43 precursor +FIG01417908 FIG00412438: hypothetical protein +FIG01417928 FIG01048371: hypothetical protein +FIG01417947 ortholog to Borrelia burgdorferi BB0398 +FIG01417957 FIG00361637: hypothetical protein +FIG01417966 short-chain dehydrogenase +FIG01417992 p-cumate dioxygenase large subunit (CmtAb) +FIG01417998 Benzoyl-CoA reductase subunit BadF (EC 1.3.99.15) +FIG01418002 Uncharacterized conserved protein, yaiN/yohL family +FIG01418019 FIG00524432: hypothetical protein +FIG01418020 FIG00349414: hypothetical protein +FIG01418021 Probable aminoglycoside efflux pump +FIG01418025 FIG00388920: hypothetical protein +FIG01418041 FIG01046939: hypothetical protein +FIG01418071 contains DUF174 domain +FIG01418079 FIG00349932: hypothetical protein +FIG01418098 putative hyperosmotically inducible periplasmic protein +FIG01418125 ABC-type transport system periplasmic component +FIG01418138 Tagatose-1-phosphate kinase TagK +FIG01418147 Glucosyltransferase GtfG +FIG01418155 prokaryotic dksA/traR C4-type zinc finger family protein +FIG01418160 nucleotide-binding protein, UspA family +FIG01418170 FIG00624365: hypothetical protein +FIG01418188 FIG00785263: hypothetical protein +FIG01418189 FIG00350593: hypothetical protein +FIG01418201 Probable nonspecific lipid-transfer protein +FIG01418220 Essential recombination function protein +FIG01418227 N-methylhydantoinase B/acetone carboxylase, alpha subunit +FIG01418243 exodeoxyribonuclease VII, large subunit( EC:3.1.11.6 ) +FIG01418247 FIG00937290: hypothetical protein +FIG01418301 FIG00570871: hypothetical protein +FIG01418368 FIG00388684: hypothetical protein +FIG01418372 FIG00351124: hypothetical protein +FIG01418384 FIG01048298: hypothetical protein +FIG01418398 Hypothetical protein. Weak similarity to zinc finger domain, blast hit to HATPase_c domain at the N-terminus. HMMPfam hit to PF00642, Zinc finger C-x8-C-x5-C-x3-H type (and similar);HMMSmart hit to SM00356, zinc finger +FIG01418400 FIG00388746: hypothetical protein +FIG01418462 FIG00350859: hypothetical protein +FIG01418501 putative diheme Cytochrome c +FIG01418508 Alanine racemase +FIG01418511 FIG01118537: hypothetical protein +FIG01418523 FtsK/SpoIIIE family +FIG01418537 FIG00348538: hypothetical protein +FIG01418541 FIG00764236: hypothetical protein +FIG01418567 Tetracenomycin polyketide synthesis O-methyltransferase TcmP (EC 2.1.1.-) +FIG01418572 FIG00351951: hypothetical protein +FIG01418578 possible Josephin +FIG01418585 FIG01055157: hypothetical protein +FIG01418588 Rhomboid family protein +FIG01418603 putative host-nuclease inhibitor protein +FIG01418635 uncharacterized protein probably involved in trehalose biosynthesis +FIG01418636 truncated Pre protein +FIG01418649 Uncharacterized protein MJ0912 +FIG01418669 Putative amino-acid transport protein +FIG01418672 type III secretion system apparatus protein YscQ/HrcQ +FIG01418680 mucin-desulfating sulfatase (N-acetylglucosamine-6-sulfatase)( EC:3.1.6.14 ) +FIG01418683 FIG00353849: hypothetical protein +FIG01418719 FIG00624772: hypothetical protein +FIG01418725 Permease MDR-related +FIG01418730 hypothetical protein, putative transcription regulator with helix-turn-helix domain +FIG01418735 corresponds to STY0019 from Accession AL513382: Salmonella typhi CT18 +FIG01418769 FIG00356012: hypothetical protein +FIG01418782 Type III effector HopG1 +FIG01418793 ABC transporter ATPase and permease components +FIG01418797 hypothetical protein +FIG01418802 FIG00624040: hypothetical protein +FIG01418813 FIG00425565: hypothetical protein +FIG01418859 FIG01114183: hypothetical protein +FIG01418872 FIG00351276: hypothetical protein +FIG01418904 putative leu/ile/val-binding protein precursor +FIG01418937 FIG00623432: hypothetical protein +FIG01418942 FIG00642348: hypothetical protein +FIG01418946 Kinase similar to eukaryotic-like N-acetylglucosamine kinase +FIG01418951 FIG00639978: hypothetical protein +FIG01418952 putative protein-S-isoprenylcysteine methyltransferase +FIG01418956 hypothetical protein +FIG01418963 IS1 ORF +FIG01418965 FIG00513758: hypothetical protein +FIG01418991 23S rRNA (Uracil-5-) -methyltransferase RumA (EC 2.1.1.-) +FIG01419020 PE-PGRS FAMILY PROTEIN WAG22B [SECOND PART] +FIG01419026 Lmo0747 protein +FIG01419044 FIG00418142: hypothetical protein +FIG01419045 LPXTG-motif cell wall anchor domain protein +FIG01419057 ChaC-related protein +FIG01419097 FIG00413762: hypothetical protein +FIG01419112 galactose/glucose-binding lipoprotein +FIG01419147 putative replication regulatory protein +FIG01419156 FIG01134253: hypothetical protein +FIG01419184 FIG00816268: hypothetical protein +FIG01419187 BioH protein, putative +FIG01419188 FIG00551755: hypothetical protein +FIG01419190 FIG00385222: hypothetical protein +FIG01419212 DNA packaging protein, phage associated +FIG01419230 putative acyl-peptide hydrolase +FIG01419231 Cell-envelope associated proteinase +FIG01419246 Immunity protein of pyocin S3 +FIG01419294 FIG00554931: hypothetical protein +FIG01419302 glycerol dehydrogenase +FIG01419315 FIG00938731: hypothetical protein +FIG01419324 FIG00410196: hypothetical protein +FIG01419339 putative capsule O-acetyl transferase +FIG01419394 FIG00418171: hypothetical protein +FIG01419422 Acetyl transferase +FIG01419443 FIG00350550: hypothetical protein +FIG01419468 conserved hypothetical archaeal protein with 2 CBS domains. +FIG01419469 Putative peptidoglycan bound protein (LPXTG motif) Lmo0835 homolog +FIG01419475 Secreted von Willebrand factor-binding protein VWbp +FIG01419494 excisionase family DNA binding protein +FIG01419500 dTDP-glucose 4,6-dehydratase( EC:4.2.1.46 ) +FIG01419501 Putative ATP:guanido phosphotransferase YacI (EC 2.7.3.-) +FIG01419531 Putative transmembrane protein +FIG01419533 putative thioesterase family domain protein +FIG01419534 lipase( EC:3.1.1.3 ) +FIG01419551 nucleoid-associated protein NdpA +FIG01419561 SAM (and some other nucleotide) binding motif +FIG01419574 pXO1-38 +FIG01419593 N-terminal acetyltransferase, GNAT family +FIG01419601 Os05g0188900 +FIG01419610 serine/threonine kinase +FIG01419613 syc1463_d +FIG01419634 isopentenyl transferase +FIG01419639 FIG00848974: hypothetical protein +FIG01419645 ResB protein required for cytochrome c biosynthesis +FIG01419680 Probable chromosome partitioning protein parB +FIG01419683 FIG00350823: hypothetical protein +FIG01419689 MtfA protein +FIG01419694 FIG00624680: hypothetical protein +FIG01419699 UV-endonuclease, putative +FIG01419702 ATPase, AAA+ superfamily +FIG01419707 Putative activity regulator of membrane protease YbbK +FIG01419716 Oxidoreductase FAD-binding domain protein +FIG01419743 Predicted metal-dependent hydrolase with the TIM-barrel fold +FIG01419771 conserved hypothetical protein +FIG01419779 thiJ/pfpI family protein +FIG01419804 FIG00672705: hypothetical protein +FIG01419811 COG1073: Hydrolases of the alpha/beta superfamily +FIG01419818 FIG00848835: hypothetical protein +FIG01419829 Surface exclusion protein +FIG01419840 conserved exported protein +FIG01419865 FIG00350630: hypothetical protein +FIG01419902 FIG00820823: hypothetical protein +FIG01419919 fdxD-related protein +FIG01419928 FIG00404178: hypothetical protein +FIG01419932 hypothetical protein Fphi_0438 +FIG01419938 iron ABC transporter, substrate binding protein +FIG01419954 FIG00874897: hypothetical protein +FIG01419958 sigma-54 dependent transcriptional regulator/response regulator +FIG01419983 FIG00520773: hypothetical protein +FIG01419985 FIG00945483: hypothetical protein +FIG01419999 dipeptidyl peptidase IV-related protein +FIG01420003 Protease II +FIG01420013 Bll1083 protein +FIG01420032 Choline monooxygenase, chloroplast precursor (EC 1.14.15.7) +FIG01420042 FIG00361812: hypothetical protein +FIG01420044 FIG01070892: hypothetical protein +FIG01420053 FIG00829591: hypothetical protein +FIG01420070 FIG00953910: hypothetical protein +FIG01420071 putative bacitracin transport ATP-binding protein BcrA +FIG01420072 Probable ATP-binding component of ABC transporter +FIG01420084 phosphohistidine phosphatase SixA( EC:3.1.3.- ) +FIG01420102 ccdC protein +FIG01420106 Glycine Rich Secreted Protein +FIG01420108 BsaG protein +FIG01420121 Metal ion transporter +FIG01420123 FIG00352383: hypothetical protein +FIG01420128 SiaD +FIG01420130 binding-protein dependent transport protein +FIG01420138 FIG00623483: hypothetical protein +FIG01420165 FIG00388685: hypothetical protein +FIG01420173 FIG00816793: hypothetical protein +FIG01420190 Protease IV +FIG01420191 FIG00820467: hypothetical protein +FIG01420227 FIG00385264: hypothetical protein +FIG01420247 FIG00719702: hypothetical protein +FIG01420249 Sorbitol dehydrogenase (EC 1.1.1.14) (L-iditol 2-dehydrogenase) (Glucitol dehydrogenase) +FIG01420261 multidrug resistance protein MexA +FIG01420275 Twin-arginine translocation pathway signal( EC:1.1.3.6 ) +FIG01420293 FIG00385631: hypothetical protein +FIG01420297 blr7258; probable sulfite:cytochrome c oxidoreductase subunit B +FIG01420302 DNA polymerase III, delta subunit +FIG01420313 Indolepyruvate oxidoreductase subunit iorB (EC 1.2.7.8) +FIG01420328 dnaK family protein HscC domain protein +FIG01420336 Putative GAF sensor protein +FIG01420382 FIG00530215: hypothetical protein +FIG01420403 FIG00814695: hypothetical protein +FIG01420419 Di-and tricarboxylate transporter +FIG01420425 gntR family regulatory protein +FIG01420432 Heparin lyase I precursor (EC 4.2.2.7) (Heparinase I) +FIG01420435 Putative primase, superantigen-encoding pathogenicity islands SaPI +FIG01420451 putative nucleotidyltransferase protein +FIG01420457 FIG00385345: hypothetical protein +FIG01420468 orf36 +FIG01420469 acyl-CoA dehydrogenase( EC:1.3.99.2 ) +FIG01420482 FIG00514842: hypothetical protein +FIG01420490 Transport/processing ATP-binding protein comA (EC 3.4.22.-) +FIG01420506 FIG00632944: hypothetical protein +FIG01420509 FIG00622760: hypothetical protein +FIG01420514 Protein of unknown function DUF815 +FIG01420525 FIG01101828: hypothetical protein +FIG01420529 FIG01166652: hypothetical protein +FIG01420537 cyanate MFS transporter +FIG01420540 Hypothetical protein, CF-30 family +FIG01420546 putative enoyl-CoA hydratase +FIG01420554 FIG01093408: hypothetical protein +FIG01420555 Ferredoxin domain-containing integral membrane protein +FIG01420579 FIG00361559: hypothetical protein +FIG01420583 Uncharacterized protein MJ1211 +FIG01420608 DEAD/DEAH box helicase domain protein +FIG01420615 FIG00527006: hypothetical protein +FIG01420623 cell division membrane protein +FIG01420625 FIG00837308: hypothetical protein +FIG01420648 FIG00766885: hypothetical protein +FIG01420654 FIG00409677: hypothetical protein +FIG01420658 conserved hypothetical protein TIGR00252 +FIG01420668 putative iron-siderophore binding lipoprotein +FIG01420675 metal-binding protein-like protein +FIG01420677 dolichol-phosphate mannosyltransferase +FIG01420682 possible Borrelia lipoprotein +FIG01420704 Porin B precursur +FIG01420705 metal ion transporters (Cu(2+), Fe(2+), etc.) +FIG01420719 Transcriptional regulator, MarR family +FIG01420751 Lmo2276 protein +FIG01420774 Glutamate--cysteine ligase, GCS2 +FIG01420790 2-haloalkanoic acid dehalogenase-related protein +FIG01420796 FIG00850062: hypothetical protein +FIG01420817 GNAT family acetyltransferase +FIG01420826 FIG00960894: hypothetical protein +FIG01420837 S-layer repressor +FIG01420850 FIG00622873: hypothetical protein +FIG01420855 FIG01046484: hypothetical protein +FIG01420864 Probably cellulosomal scaffolding protein precursor, secreted; cellulose-binding and cohesin domain +FIG01420895 FIG00624582: hypothetical protein +FIG01420911 cyclic nucleotide-binding domain (cNMP-BD) protein +FIG01420949 ABC-type anion transport system permease component +FIG01420952 ErfK/YbiS/YcfS/YnhG family protein +FIG01420964 lipolytic protein G-D-S-L family +FIG01421022 FIG00688420: hypothetical protein +FIG01421034 toprim domain protein +FIG01421050 FIG00846947: hypothetical protein +FIG01421075 stress response protein +FIG01421089 S-layer homology domain +FIG01421100 Possible adhesin/hemolysin precursor +FIG01421105 FIG00528581: hypothetical protein +FIG01421123 FIG01116486: hypothetical protein +FIG01421134 protein of unknown function DUF917 +FIG01421138 Asr4457 protein +FIG01421144 Lin2592 protein +FIG01421156 hypothetical protein +FIG01421159 putative oxidoreductase iron-sulfur subunit +FIG01421165 FIG00768925: hypothetical protein +FIG01421173 Zinc-transporting ATPase( EC:3.6.3.5 ) +FIG01421175 predicted NADPH-dependent reductase +FIG01421199 Oligoketide cyclase/lipid transport protein +FIG01421225 acyl carrier protein phosphodiesterase [EC:3.1.4.14] [KO:K01118] +FIG01421230 FIG01049028: hypothetical protein +FIG01421250 Plasmid replication initiator protein +FIG01421251 leucine-, isoleucine-, valine-, threonine-, and alanine- binding protein +FIG01421267 FIG00733917: hypothetical protein +FIG01421272 putative competence protein +FIG01421298 FIG00574326: hypothetical protein +FIG01421319 transcriptional factor-related protein +FIG01421320 GPR1/FUN34/yaaH family protein +FIG01421333 FIG00469237: hypothetical protein +FIG01421335 FIG00417154: hypothetical protein +FIG01421347 Uncharacterized protein sll0103 +FIG01421368 DNA-binding transcriptional activator +FIG01421373 WGR domain protein +FIG01421414 putative transmembrane sensor protein +FIG01421424 Mg++ transporter +FIG01421429 Protein containing cell adhesion domain +FIG01421439 Tetratricopeptide repeat-containing protein +FIG01421457 FIG00827381: hypothetical protein +FIG01421461 Phage repressor protein cI +FIG01421492 contains LysM domain +FIG01421514 FIG00493339: hypothetical protein +FIG01421531 retron-type reverse transcriptase +FIG01421534 dihydrouridine synthase family protein +FIG01421567 FIG00404086: hypothetical protein +FIG01421600 FIG01015734: hypothetical protein +FIG01421608 Phosphotransferase +FIG01421620 putative phospholipase protein +FIG01421635 FIG00385369: hypothetical protein +FIG01421656 FIG00712356: hypothetical protein +FIG01421674 Family S45 unassigned peptidase (EC 3.5.1.11) +FIG01421679 FIG00672486: hypothetical protein +FIG01421692 hypothetical protein +FIG01421725 ATP-dependent DNA helicase recG (EC 3.6.1.-) +FIG01421785 PROBABLE TRANSPORTER TRANSMEMBRANE PROTEIN +FIG01421792 FIG00768717: hypothetical protein +FIG01421839 conserved inner membrane protein +FIG01421857 nisin-resistance protein, putative +FIG01421891 FIG01094257: hypothetical protein +FIG01421920 CDS_ID OB0857 +FIG01421921 BsmB +FIG01421931 Protein OSA +FIG01421936 FIG00351196: hypothetical protein +FIG01421943 Integrase, catalytic region +FIG01421984 FIG00469806: hypothetical protein +FIG01421996 FIG00411032: hypothetical protein +FIG01422016 Sll1414 protein +FIG01422017 FIG00451506: hypothetical protein +FIG01422039 FIG00743540: hypothetical protein +FIG01422041 Phage transcriptional activator, Ogr/Delta +FIG01422055 Uncharacterized protein AF_0701 +FIG01422068 FIG00468212: hypothetical protein +FIG01422071 putative cytochrome c biogenesis protein +FIG01422076 prophage LambdaBa01, acyltransferase, putative +FIG01422082 FIG00344549: hypothetical protein +FIG01422083 Fusaric acid resistance domain protein +FIG01422096 FIG00847051: hypothetical protein +FIG01422112 FIG00672966: hypothetical protein +FIG01422146 FIG00385335: hypothetical protein +FIG01422153 FIG00352971: hypothetical protein +FIG01422154 hypothetical protein PA0941 +FIG01422164 Transcriptional regulator, TetR/AcrR family +FIG01422169 FIG00558550: hypothetical protein +FIG01422174 FIG00628134: hypothetical protein +FIG01422176 Mlr7972 protein +FIG01422192 FIG01169552: hypothetical protein +FIG01422199 FIG00640379: hypothetical protein +FIG01422228 FIG00350398: hypothetical protein +FIG01422233 FIG00403691: hypothetical protein +FIG01422234 FIG00517016: hypothetical protein +FIG01422238 Deoxyribonuclease II (EC 3.1.22.1) +FIG01422248 hypothetical protein-putative membrane lipoprotein +FIG01422251 FIG00632560: hypothetical protein +FIG01422252 FIG00786174: hypothetical protein +FIG01422253 FIG00526915: hypothetical protein +FIG01422266 FIG01055268: hypothetical protein +FIG01422276 3'-Phosphoadenosine 5'-phosphosulfate (PAPS) 3'-phosphatase +FIG01422287 sigma-54 dependent response regulator +FIG01422293 FIG00425139: hypothetical protein +FIG01422338 restriction modification system DNA specificity domain +FIG01422342 FIG00390514: hypothetical protein +FIG01422344 Hypothetical transmembrane protein +FIG01422348 DegT/DnrJ/EryC1/StrS aminotransferase family protein +FIG01422360 Metal binding protein +FIG01422383 Choloylglycine hydrolase +FIG01422392 FIG01214556: hypothetical protein +FIG01422397 FIG00745494: hypothetical protein +FIG01422405 FIG00766479: hypothetical protein +FIG01422420 Possible GTPases, GTP1/OBG family +FIG01422450 isoniazid inductible gene protein IniC +FIG01422455 carbohydrate-binding protein +FIG01422456 immunity protein PlnM +FIG01422459 FIG00389829: hypothetical protein +FIG01422460 hypothetical protein NMA1068 +FIG01422462 Enhanced entry protein EnhB +FIG01422473 Bleomycin resistance protein +FIG01422485 putative surface/cell-adhesion protein +FIG01422490 tail fiber assembly protein, putative +FIG01422494 Sll1736 protein +FIG01422561 Superfamily I DNA/RNA helicase +FIG01422576 hypothetical protein +FIG01422583 FIG00687899: hypothetical protein +FIG01422591 FIG00347680: hypothetical protein +FIG01422608 83 kDa decaheme outer membrane cytochrome c +FIG01422611 probable integral membrane protein +FIG01422624 FIG00428013: hypothetical protein +FIG01422659 hypothetical protein NMA1071 +FIG01422675 FIG00350382: hypothetical protein +FIG01422677 flagellar protein, putative +FIG01422695 FIG00350416: hypothetical protein +FIG01422712 YqeJ protein +FIG01422714 Cellulase precursor +FIG01422724 virulence factor MVIN-like +FIG01422741 FIG00499822: hypothetical protein +FIG01422779 FIG00750930: hypothetical protein +FIG01422783 putative secreted or membrane protein +FIG01422808 Enoyl-CoA hydratase +FIG01422819 FIG00624272: hypothetical protein +FIG01422842 Uncharacterized protein yozH +FIG01422875 FIG00623101: hypothetical protein +FIG01422893 putative MutT-like protein +FIG01422909 protein p23 +FIG01422916 FIG01114792: hypothetical protein +FIG01422924 LipL45 homologue +FIG01422938 putative EA31 gene protein, phage lambda +FIG01422957 putative cyclase-dehydratase +FIG01422968 FIG01167073: hypothetical protein +FIG01422969 hypothetical protein +FIG01422990 FIG00344660: hypothetical protein +FIG01423002 Toxin co-regulated pilus biosynthesis protein R +FIG01423007 pXO1-26 +FIG01423048 FIG00514685: hypothetical protein +FIG01423059 phage Tail Collar domain protein +FIG01423063 FIG00673521: hypothetical protein +FIG01423079 4'-phosphopantetheinyl transferase entD (EC 2.7.8.-) +FIG01423086 FIG01246949: hypothetical protein +FIG01423092 COG1247: Sortase and related acyltransferases +FIG01423094 FIG01088413: hypothetical protein +FIG01423106 carbonyl reductase +FIG01423112 FIG00675083: hypothetical protein +FIG01423114 FIG00820626: hypothetical protein +FIG01423118 putative peptidase inhibitor +FIG01423138 FIG00748742: hypothetical protein +FIG01423145 Type III restriction enzyme, res subunit +FIG01423146 probable UV endonuclease +FIG01423148 FIG00815147: hypothetical protein +FIG01423157 HlyC domain protein +FIG01423190 DNA-binding ferritin-like protein (oxidative damage protectant) +FIG01423192 FIG00385520: hypothetical protein +FIG01423208 Cell surface antigen-like protein Sca7 +FIG01423236 FIG01093417: hypothetical protein +FIG01423242 hypothetical protein +FIG01423267 sodium/glutamate symporter +FIG01423270 FIG00354958: hypothetical protein +FIG01423284 identified by similarity to GB:BAC51725.1 +FIG01423285 FIG00363591: hypothetical protein +FIG01423319 Bll2250 protein +FIG01423341 Conserved repeat domain protein +FIG01423360 COG2152 predicted glycoside hydrolase +FIG01423370 type II restriction-modification system DNA adenine-specific methylase +FIG01423371 protein of unknown function DUF344 +FIG01423374 CRISPR-associated protein, Csx3 family +FIG01423387 FIG00767820: hypothetical protein +FIG01423392 Outer membrane protein Imp, required for envelope biogenesis / Organic solvent tolerance protein precursor +FIG01423397 pyruvate decarboxylase alpha subunit-like protein +FIG01423412 FIG00450841: hypothetical protein +FIG01423416 FIG01237069: hypothetical protein +FIG01423418 hypothetical protein +FIG01423440 FIG00693688: hypothetical protein +FIG01423448 Integrase/recombinase, XerC/XerD family +FIG01423456 Helix-turn-helix repressor protein family +FIG01423457 Methyl-accepting chemotaxis protein I (serine chemoreceptor protein) +FIG01423458 Probable integral membrane protein Cj1166c +FIG01423470 FIG01200472: hypothetical protein +FIG01423496 Bll3817 protein +FIG01423512 possible Kunitz/Bovine pancreatic trypsin inhib +FIG01423589 hypothetical protein +FIG01423597 FIG00624758: hypothetical protein +FIG01423601 FIG00351376: hypothetical protein +FIG01423602 aldose epimerase family protein +FIG01423608 FIG00350028: hypothetical protein +FIG01423616 FIG00385552: hypothetical protein +FIG01423617 DNA alkylation repair enzyme, truncation +FIG01423629 FIG00527550: hypothetical protein +FIG01423630 FIG00351857: hypothetical protein +FIG01423637 General L-amino acid transport system permease protein aapM +FIG01423638 FIG00350469: hypothetical protein +FIG01423642 Hypothetical NagD-like phosphatase, Actinobacterial subfamily +FIG01423645 FIG00743222: hypothetical protein +FIG01423653 alternate gene name: yztA +FIG01423674 Chain A, Nmr Structure Of Bacillus Subtilis Protein Yqai, Northeast Structural Genomics Target Sr450 +FIG01423709 NAD(P)H dehydrogenase, quinone family( EC:1.6.99.2 ) +FIG01423730 Predicted zinc regulator, ArsR family +FIG01423764 FIG00848544: hypothetical protein +FIG01423765 probable ketosteroid isomerase +FIG01423794 abortive phage resistance protein +FIG01423812 Putative peptidase U32 family protein (EC 3.4.-.-) +FIG01423829 FIG00816525: hypothetical protein +FIG01423839 FIG01151177: hypothetical protein +FIG01423840 GST-loxP-cre recombinase fusion protein +FIG01423845 FIG00412864: hypothetical protein +FIG01423858 Uridine monophosphate kinase (EC 2.7.4.22) +FIG01423883 transporter permease +FIG01423903 FIG00353857: hypothetical protein +FIG01423937 FIG00766064: hypothetical protein +FIG01423942 large transmembrane protein possibly involved in transport +FIG01423950 Transcriptional regulatory protein EmbR +FIG01423976 RebB protein +FIG01423978 FIG01025825: hypothetical protein +FIG01423982 FIG00767304: hypothetical protein +FIG01423993 Competence-stimulating peptide ABC transporter ATP-binding protein ComA +FIG01424010 Oligosaccharide biosynthesis protein Alg14 like +FIG01424025 Hypothetical protein MW1780 +FIG01424029 FIG00350282: hypothetical protein +FIG01424035 FIG01124483: hypothetical protein +FIG01424036 Bll5419 protein +FIG01424040 FIG00405769: hypothetical protein +FIG01424043 FIG00841323: hypothetical protein +FIG01424044 Major outer membrane protein +FIG01424049 MutT domain protein-like +FIG01424074 B. burgdorferi predicted coding region BB0748 +FIG01424094 FIG00898139: hypothetical protein +FIG01424103 FIG00344225: hypothetical protein +FIG01424107 FIG00768080: hypothetical protein +FIG01424109 PQQ-dependent oxidoreductase, gdhB family +FIG01424147 FIG00346611: hypothetical protein +FIG01424171 FIG00426344: hypothetical protein +FIG01424176 Beta-lactamase related protein +FIG01424177 Histidine protein kinase; sensor protein (EC 2.7.3.-) +FIG01424187 putative molybdenum containing oxidoreductase +FIG01424202 FIG00775343: hypothetical protein +FIG01424206 FIG053621: hypothetical protein +FIG01424211 protein of unknown function DUF306, Meta and HslJ +FIG01424213 OUTER MEMBRANE PORIN F PRECURSOR +FIG01424225 ABC sugar transporter, periplasmic ligand binding protein +FIG01424230 YhhW family protein +FIG01424234 glutaryl-7-ACA acylase precursor +FIG01424249 FIG00754785: hypothetical protein +FIG01424277 FIG00351861: hypothetical protein +FIG01424278 PilA-like type-IV pilus protein +FIG01424289 Tellurite resistance protein-related protein +FIG01424290 FIG00765218: hypothetical protein +FIG01424308 conjugative transposon protein +FIG01424318 FIG040428: Phage-associated protein +FIG01424320 FIG00379754: hypothetical protein +FIG01424340 FIG00711088: hypothetical protein +FIG01424348 DNA-binding response regulator +FIG01424357 putative branched chain amino acid transport protein +FIG01424362 RNase PH +FIG01424371 transcriptional regulatory +FIG01424391 Cobalamin biosynthesis protein CobN and related Mg-chelatases +FIG01424397 FIG00389244: hypothetical protein +FIG01424421 FIG00763099: hypothetical protein +FIG01424422 FIG01166460: hypothetical protein +FIG01424426 Protein of unknown function DUF29 +FIG01424433 conserved hypothetical protein; putative nucleic acid binding and endonuclease domains +FIG01424434 ISSod11, transposase +FIG01424444 TonB-like +FIG01424447 FMN-binding negative transcriptional regulator +FIG01424455 lipopolysaccharide glycosyltransferase +FIG01424456 COG4861: Uncharacterized protein conserved in bacteria +FIG01424493 Chain length determinant protein +FIG01424499 hypothetical protein +FIG01424502 Probable type II secretion system protein +FIG01424517 FIG00380965: hypothetical protein +FIG01424519 Type IV secretory pathway, protease TraF +FIG01424535 Osmotic signal transduction related protein +FIG01424540 MorD +FIG01424544 FIG00746049: hypothetical protein +FIG01424554 RNA polymerase sigma factor CarQ +FIG01424558 thermonuclease +FIG01424564 Orf50 +FIG01424568 cell surface protein, ErfK family +FIG01424579 Methionyl-tRNA formyltransferase-like protein 2 +FIG01424603 Uncharacterized conserved protein, YGIN family +FIG01424623 WbpN +FIG01424626 FIG00364477: hypothetical protein +FIG01424633 FIG01032653: hypothetical protein +FIG01424651 hypothetical protein-putative a gene in the purF operon involved in colicin V biosynthesis +FIG01424654 transcriptional regulator, ROK family protein +FIG01424655 Chimeric AFGP/trypsinogen-like serine protease +FIG01424661 FIG00414817: hypothetical protein +FIG01424664 FIG01070974: hypothetical protein +FIG01424673 putative RecF protein +FIG01424684 possible Glycosyl transferase +FIG01424703 Z1225 protein +FIG01424717 FIG00408572: hypothetical protein +FIG01424720 Pirin-like +FIG01424721 FIG00513475: hypothetical protein +FIG01424723 multicopper oxidase, type 3 +FIG01424734 Possible Signal peptide binding domain +FIG01424737 Penicillin acylase II +FIG01424746 FIG00698210: hypothetical protein +FIG01424760 FIG01131959: hypothetical protein +FIG01424767 RloF +FIG01424768 FIG00408312: hypothetical protein +FIG01424798 unknown protein encoded by cryptic prophage CP-933M +FIG01424801 Putative polymerase +FIG01424807 Bifunctional deaminase-reductase domain protein +FIG01424809 Predicted nucleic acid-binding protein, contains PIN domain +FIG01424814 FIG00815015: hypothetical protein +FIG01424817 Transcriptional regulator of N-acetylglucosamine utilization, AraC family +FIG01424832 putative metallopeptidase +FIG01424848 FIG00470419: hypothetical protein +FIG01424858 FIG00515417: hypothetical protein +FIG01424864 FIG00408583: hypothetical protein +FIG01424866 Glucan-binding protein B +FIG01424888 transcriptional regulator, MerR family +FIG01424907 N-acetyl-beta-hexosaminidase +FIG01424918 putative DNA polymerase III epsilon chain +FIG01424926 Transcriptional regulator, LysR family, homolog 5 +FIG01424953 COG3951: Rod binding protein +FIG01424972 DNA topoisomerase III domain +FIG01424978 Putative lipoprotein, specific for Pseudomonas, in cluster with COG2110 +FIG01425004 FIG00350418: hypothetical protein +FIG01425029 FIG00349858: hypothetical protein +FIG01425034 peptide deformylase (PDF) (polypeptide deformylase) [EC:3.5.1.88] +FIG01425090 chromosome segregation ATPase +FIG01425094 Homoserine/homoserine lactone efflux protein +FIG01425115 FIG00946055: hypothetical protein +FIG01425127 lipase/acylhydrolase with GDSL-like motif +FIG01425128 Type IV pilus assembly protein PilZ +FIG01425141 gnl|WGS:AAAB|ebiP6313|gb|EAA03793 +FIG01425147 FIG01093838: hypothetical protein +FIG01425148 FIG01229280: hypothetical protein +FIG01425150 Nucleotide sugar epimerase +FIG01425151 FIG00515520: hypothetical protein +FIG01425152 Flagellar motor rotation protein motB +FIG01425168 Amidase related to nicotinamidase +FIG01425172 FIG00406487: hypothetical protein +FIG01425196 peptidase S9, prolyl oligopeptidase +FIG01425207 Putative uncharacterized protein STY3345 (Putative uncharacterized protein) +FIG01425210 Probable transposase for insertion sequence element +FIG01425214 Error-prone repair protein UmuD (EC 3.4.21.-) +FIG01425243 JHP0747 family +FIG01425250 FIG00674037: hypothetical protein +FIG01425261 FIG00768287: hypothetical protein +FIG01425268 FIG00768330: hypothetical protein +FIG01425271 FIG00406025: hypothetical protein +FIG01425275 Outer membrane protein (porin) +FIG01425288 regulation of penicillin binding protein 5 production +FIG01425307 FIG00624384: hypothetical protein +FIG01425316 Merozoite surface protein 3 alpha (Fragment) +FIG01425319 FIG00849488: hypothetical protein +FIG01425331 Ribosomal protein L1 +FIG01425359 Twin-arginine translocation protein TatA +FIG01425362 conserved hypothetical protein, putative S-layer related protein precursor +FIG01425374 hypothetical protein +FIG01425377 FIG00566416: hypothetical protein +FIG01425388 possible puromycin N-acetyltransferase +FIG01425400 Acid membrane antigen A +FIG01425411 FIG00352332: hypothetical protein +FIG01425419 Band 7 protein +FIG01425426 FIG01229590: hypothetical protein +FIG01425453 cGMP-dependent protein kinase 1, alpha isozyme (EC 2.7.11.1) +FIG01425456 FIG00468454: hypothetical protein +FIG01425460 Lysophospholipid acyltransferase +FIG01425464 LmbV protein +FIG01425465 FIG00403079: hypothetical protein +FIG01425469 proteinase inhibitor I4, serpin +FIG01425477 prophage LambdaSa2, site-specific recombinase, phage integrase family +FIG01425483 similarity to histon and other protein acetyltransferase +FIG01425486 FIG00769258: hypothetical protein +FIG01425487 mobilization/transfer protein +FIG01425519 maltose/maltodextrin transport permease +FIG01425531 FIG00514133: hypothetical protein +FIG01425538 Uncharacterized protein MJ1487 +FIG01425562 FIG01093581: hypothetical protein +FIG01425566 Transcriptional regulator, cro family +FIG01425569 Conserved membrane protein YtaF +FIG01425577 FIG00946010: hypothetical protein +FIG01425580 Uncharacterized methylase SCO7062 +FIG01425581 arylsulfatase regulator +FIG01425621 syc2186_d +FIG01425635 FIG00874035: hypothetical protein +FIG01425660 putative ABC-transporter transmembrane component +FIG01425664 FIG00959066: hypothetical protein +FIG01425665 predicted transcriptional regulator, DicA/HipB/AnsR family +FIG01425672 CDP-6-deoxy-delta-3,4-glucoseen reductase +FIG01425708 molybdenum cofactor biosynthesis protein D +FIG01425709 FIG01047312: hypothetical protein +FIG01425711 Glycosyltransferase domain containing protein +FIG01425760 FIG01118155: hypothetical protein +FIG01425762 regulation of the bltD operon +FIG01425767 Bll3360 protein +FIG01425813 FIG00241420: hypothetical protein +FIG01425823 FIG00404181: hypothetical protein +FIG01425830 FIG00530988: hypothetical protein +FIG01425838 FIG01116309: hypothetical protein +FIG01425878 secreted protein containing domain of murein hydrolase (MLTA homolog) +FIG01425889 Cro-like repressor [SA bacteriophages 11, Mu50B] +FIG01425891 FIG00344540: hypothetical protein +FIG01425900 permease of oligopeptide ABC transporter +FIG01425903 FIG00624615: hypothetical protein +FIG01425919 27kDa outer membrane protein +FIG01425922 Probable esterase +FIG01425928 FIG00826561: hypothetical protein +FIG01425939 COG2378: Predicted transcriptional regulator +FIG01425948 FIG00350780: hypothetical protein +FIG01425950 hypothetical arginase family protein +FIG01425955 FIG00352272: hypothetical protein +FIG01425968 Putative uncharacterized protein yjeJ +FIG01425973 modification methylase dpniia, putative +FIG01425974 ABC-type multidrug transport system, ATPase component +FIG01426006 FIG00426934: hypothetical protein +FIG01426014 FIG00410248: hypothetical protein +FIG01426022 FUPA25 P-type ATPase +FIG01426033 pca operon transcriptional activator PcaQ +FIG01426046 POSSIBLE phiRv2 PROPHAGE PROTEIN +FIG01426049 Glucuronyl hydrolase +FIG01426064 FIG00361278: hypothetical protein +FIG01426074 FIG00403158: hypothetical protein +FIG01426080 MltA-interacting MipA +FIG01426094 FIG00769639: hypothetical protein +FIG01426113 FIG00410367: hypothetical protein +FIG01426117 Glycosyl transferase (EC 2.4.1.-) +FIG01426131 Fascin +FIG01426136 Aspartyl/asparaginyl beta-hydroxylase family protein +FIG01426137 FIG00403862: hypothetical protein +FIG01426141 ATP-citrate (pro-S-)-lyase, subunit 2 (EC 2.3.3.8) +FIG01426147 plasmid recombination protein +FIG01426185 FIG00348369: hypothetical protein +FIG01426215 Azurin +FIG01426219 Unnamed hypothetical gene product in the file!! +FIG01426226 unknown function +FIG01426231 putative cell wall-associated hydrolase +FIG01426242 FIG00410540: hypothetical protein +FIG01426243 UvrX +FIG01426252 heterogeneous nuclear ribonucleoprotein R +FIG01426263 UpdZ protein +FIG01426267 FIG00402768: hypothetical protein +FIG01426283 FIG00350835: hypothetical protein +FIG01426288 Dinitrogenase iron-molybdenum cofactor biosynthesis +FIG01426289 FIG01047436: hypothetical protein +FIG01426292 FIG01117440: hypothetical protein +FIG01426301 FIG00350711: hypothetical protein +FIG01426305 Hypothetical ABC transporter ATP-binding protein ybbA +FIG01426318 FIG00711334: hypothetical protein +FIG01426333 putative Bax protein +FIG01426336 FIG00403918: hypothetical protein +FIG01426386 hypothetical protein +FIG01426394 InterPro IPR000160 COGs COG3706 +FIG01426400 syc1930_d +FIG01426429 short chain dehydrogenase family protein [imported] +FIG01426460 PROBABLE CONSERVED LIPOPROTEIN LPQN +FIG01426463 Virulence associated gene hudA (PA0254), similar to UbiD +FIG01426485 FIG01009617: hypothetical protein +FIG01426487 putative CG2 omega domain +FIG01426489 FIG00644632: hypothetical protein +FIG01426503 conserved protein of unknown function; putative unknown membrane associated protein +FIG01426509 FIG00344698: hypothetical protein +FIG01426531 tonB protein +FIG01426541 FIG00766121: hypothetical protein +FIG01426544 endo-1,4-beta-D-glucanase +FIG01426552 uracil-DNA glycosylase( EC:3.2.2.- ) +FIG01426571 enzyme; Central intermediary metabolism: Sugar-nucleotide biosynthesis, conversions +FIG01426585 Transcriptional regulator +FIG01426600 hypothetical protein VSAK1_18934 +FIG01426602 Putative trypsin +FIG01426622 hypothetical protein +FIG01426653 IS66 Orf2 like +FIG01426656 protein containing hemopexin repeats +FIG01426660 Major facilitator superfamily (MFS) metabolite(sugar)/H symporter +FIG01426685 pentachlorophenol 4-monooxygenase; PcpB +FIG01426700 Pyruvate/2-oxoglutarate dehydrogenase complex, dihydrolipoamide dehydrogenase component +FIG01426708 FIG01169388: hypothetical protein +FIG01426712 putative riboflavin-specific deaminase +FIG01426746 VCBS precursor +FIG01426749 Photosystem II PsbY protein +FIG01426758 Imm +FIG01426762 FIG00815100: hypothetical protein +FIG01426772 FIG01045518: hypothetical protein +FIG01426787 two-component sensor histidine kinase, phosphate sensing( EC:2.7.3.- ) +FIG01426797 FIG00426123: hypothetical protein +FIG01426800 Amino acid permease-associated region precursor +FIG01426804 FIG00404951: hypothetical protein +FIG01426808 COG2270: Permeases of the major facilitator superfamily +FIG01426812 FIG00409225: hypothetical protein +FIG01426819 4-hydroxy-2-oxovalerate aldolase +FIG01426822 FIG00848965: hypothetical protein +FIG01426829 FIG00824830: hypothetical protein +FIG01426831 FIG00351407: hypothetical protein +FIG01426832 protein of unknown function DUF1559 +FIG01426849 iron (iii) abc transporter, atp-binding protein (hemv-3) +FIG01426863 thyroglobulin type-1 repeat domain protein +FIG01426876 D12 class N6 adenine-specific DNA methyltransferase +FIG01426891 Possible phosphatase +FIG01426904 FIG00767540: hypothetical protein +FIG01426934 FIG00767522: hypothetical protein +FIG01426936 putative AAA family ATPase +FIG01426947 Predicted zinc-binding protein +FIG01426955 FIG00404128: hypothetical protein +FIG01427043 Small multidrug export protein +FIG01427063 pediocin immunity protein, PedB +FIG01427070 FIG00623805: hypothetical protein +FIG01427104 FIG00764812: hypothetical protein +FIG01427119 L-fucose isomerase related protein +FIG01427141 FIG00344728: hypothetical protein +FIG01427146 FIG00629581: hypothetical protein +FIG01427184 Ubiquinone/menaquinone biosynthesis methlytransferase UbiE +FIG01427191 FIG00350064: hypothetical protein +FIG01427196 FIG01053901: hypothetical protein +FIG01427207 Probable dipeptidase (EC 3.4.-.-) +FIG01427218 FIG172214: hypothetical protein +FIG01427256 Putative oxidoreductase SMc00968 +FIG01427257 Putative ribose ABC transporter +FIG01427259 FIG00412007: hypothetical protein +FIG01427265 FIG00697680: hypothetical protein +FIG01427286 FIG00759503: hypothetical protein +FIG01427303 Superfamily I DNA and RNA helicase +FIG01427307 FIG00379751: hypothetical protein +FIG01427342 ORF_ID:alr7530 unknown protein +FIG01427354 Transposase IS200-like +FIG01427360 FIG00768648: hypothetical protein +FIG01427362 putative cation efflux system +FIG01427375 oligopeptide transporter, OPT family +FIG01427387 Uncharacterized protein MJ1433 +FIG01427388 Decaheme cytochrome c MtrA +FIG01427411 FIG00821808: hypothetical protein +FIG01427412 FIG00767959: hypothetical protein +FIG01427456 Type III secretion target BipC +FIG01427459 FIG00468244: hypothetical protein +FIG01427470 FIG00351676: hypothetical protein +FIG01427479 Endoglucanase A precursor (EC 3.2.1.4) (Endo-1,4-beta-glucanase A) (Cellulase A) (EGCCA) +FIG01427494 ORF107 +FIG01427514 hypothetical protein - phage associated +FIG01427515 DNA-entry nuclease +FIG01427520 FIG00764681: hypothetical protein +FIG01427521 Branched-chain amino acid transporter +FIG01427541 FIG00831710: hypothetical protein +FIG01427549 FIG00762776: hypothetical protein +FIG01427571 FIG00404431: hypothetical protein +FIG01427575 FIG01108762: hypothetical protein +FIG01427598 Probable efflux transporter +FIG01427601 pXO1-11 +FIG01427603 FIG01166059: hypothetical protein +FIG01427616 FIG00769038: hypothetical protein +FIG01427628 Mll3743 protein +FIG01427645 33-36 kDa outer membrane protein +FIG01427653 contains Pfam profile PF00300: phosphoglycerate mutase family; go_function: catalytic activity [goid 0003824]; go_process: metabolism [goid 0008152] / phosphoglycerate/bisphosphoglycerate mutase family protein +FIG01427659 Methyltransferase MA3459 +FIG01427660 FIG00385079: hypothetical protein +FIG01427668 Lipoprotein LprJ +FIG01427670 FIG00412189: hypothetical protein +FIG01427672 FIG00767598: hypothetical protein +FIG01427680 FIG01234222: hypothetical protein +FIG01427681 Bll6863 protein +FIG01427693 FIG00815477: hypothetical protein +FIG01427703 Ant protein +FIG01427705 FIG00350084: hypothetical protein +FIG01427725 Sll0252 protein +FIG01427726 FIG00751823: hypothetical protein +FIG01427735 Predicted redox protein +FIG01427785 FIG00404985: hypothetical protein +FIG01427829 FIG01250362: hypothetical protein +FIG01427834 sugar isomerase +FIG01427846 Transcriptional Regulator, LysR family +FIG01427854 putative membrane-associated oxidoreductase +FIG01427857 DTW domain protein +FIG01427866 surface protein, putative +FIG01427890 FIG00764980: hypothetical protein +FIG01427897 Glycoside hydrolase, family 16:S-layer protein (SLH domain) :Carbohydrate-binding, CenC-like precursor +FIG01427903 COG0055: F0F1-type ATP synthase, beta subunit +FIG01427908 ApbE family protein +FIG01427911 FIG00385698: hypothetical protein +FIG01427923 DNA/RNA helicase +FIG01427925 FIG00532782: hypothetical protein +FIG01427941 FIG00643839: hypothetical protein +FIG01427946 FIG01116121: hypothetical protein +FIG01427948 hypothetical protein +FIG01427954 UPF0113 protein MJ1410 +FIG01427962 Extracellular ribonuclease precursor (EC 3.1.-.-) +FIG01427965 FIG01244665: hypothetical protein +FIG01427994 Acyl-CoA reductase LuxC +FIG01427997 Pleiotropic regulator of exopolysaccharide synthesis, competence and biofilm formation Ftr, XRE family +FIG01428017 Membrane associated GTPase +FIG01428029 Transglutaminase domain protein +FIG01428033 FIG00351539: hypothetical protein +FIG01428049 bll0215; hypothetical protein +FIG01428093 FIG00632686: hypothetical protein +FIG01428097 FIG00521728: hypothetical protein +FIG01428108 FIG00749950: hypothetical protein +FIG01428141 FIG00361822: hypothetical protein +FIG01428151 putative alpha-arabinofuranosidase II +FIG01428173 hypothetical protein +FIG01428175 Restriction endonuclease S subunits +FIG01428232 Ribosome-associated endonuclease, involved in final steps of 23S rRNA maturation +FIG01428253 Oligoendopeptidase F +FIG01428258 COG3677: Transposase and inactivated derivatives +FIG01428262 DNA-binding protein BpH2 +FIG01428279 conserved hypothetical protein SCD8A.23 +FIG01428282 protein of unknown function RIO1 +FIG01428287 FIG00387909: hypothetical protein +FIG01428297 putative protein (DcaP-like) +FIG01428314 FIG00767287: hypothetical protein +FIG01428334 FIG00551470: hypothetical protein +FIG01428339 transcriptional regulator, LuxR family protein +FIG01428355 two-component system sensor histidine kinase/response regulator, hybrid ('one-component system') +FIG01428359 FIG00623007: hypothetical protein +FIG01428360 Putative excinuclease ABC, C subunit +FIG01428397 Acyl-CoA thioesterase 1 +FIG01428401 Amino acid ABC transporter, permease protein SP1502 +FIG01428410 VacJ lipoprotein precursor +FIG01428424 Thermolabile hemolysin precursor +FIG01428443 UPF0290 protein VNG2119C +FIG01428449 phosphoglyceromutase( EC:5.4.2.1 ) +FIG01428451 FIG00631109: hypothetical protein +FIG01428462 Hemin binding protein d +FIG01428463 HTH-type transcriptional regulator malT +FIG01428483 hypothetical protein +FIG01428486 FIG00466148: hypothetical protein +FIG01428492 FIG00631148: hypothetical protein +FIG01428493 Putative oxidoreductase( EC:1.1.1.- ) +FIG01428573 aldehyde dehydrogenase +FIG01428579 FIG00525169: hypothetical protein +FIG01428583 putative protein-tyrosine phosphatase +FIG01428595 putative Cap64-like protein +FIG01428615 Probable ABC transporter permease +FIG01428623 Glutathione S-transferase-like (EC 2.5.1.18) +FIG01428631 FruR leader peptide +FIG01428647 putative ATP-binding protein of a transporter +FIG01428650 Polysaccharide pyruvyl transferase +FIG01428662 Type VII secretion-associated serine protease mycosin +FIG01428666 sensor histidine kinase KdpD( EC:2.7.3.- ) +FIG01428669 acylamino-acid-releasing enzyme +FIG01428671 filamentation induced by cAMP protein Fic-like protein +FIG01428691 Uncharacterized protein yjiK +FIG01428699 TraG-like protein +FIG01428705 FIG00624073: hypothetical protein +FIG01428718 ORFj protein +FIG01428724 nicotinic acid mononucleotide adenyltransferase( EC:2.7.7.18 ) +FIG01428725 Salt-stress induced protein +FIG01428741 FIG01232422: hypothetical protein +FIG01428746 AtsE +FIG01428768 syc1759_c +FIG01428778 FIG00750525: hypothetical protein +FIG01428783 FIG00814563: hypothetical protein +FIG01428825 FIG00351422: hypothetical protein +FIG01428851 Signal Transduction Histidine Kinase (STHK) , LytS +FIG01428866 FIG00841495: hypothetical protein +FIG01428886 Unknown +FIG01428937 putative Cro-like protein, phage associated +FIG01428978 Probable protein farnesyltransferase beta subunit (EC 2.5.1.58) +FIG01428996 FIG00405424: hypothetical protein +FIG01428998 zinc-responsive transcriptional regulator +FIG01429005 Outer membrane receptor protein +FIG01429008 Fimbrial assembly protein (PilN) +FIG01429041 Pesticin immunity protein +FIG01429060 FIG00764938: hypothetical protein +FIG01429067 Adhesin +FIG01429068 FIG00351170: hypothetical protein +FIG01429095 NTP pyrophosphohydrolase including oxidative damage repair enzymes +FIG01429101 FIG00523580: hypothetical protein +FIG01429111 FIG01232736: hypothetical protein +FIG01429112 Cdc6-related protein +FIG01429116 FIG107774: hypothetical protein +FIG01429124 InterPro IPR000694:IPR001734 +FIG01429149 conserved hypothetical protein; putative secreted protein. +FIG01429179 FIG01081494: hypothetical protein +FIG01429182 chlorosome envelope protein B +FIG01429191 ankyrin domain protein ank2 +FIG01429209 VirK protein +FIG01429210 sigma subunit sigma24 -like protein +FIG01429229 Putative NADH dehydrogenase/NAD(P)H nitroreductase AF_0226 (EC 1.-.-.-) +FIG01429238 FIG01084722: hypothetical protein +FIG01429250 FIG00764376: hypothetical protein +FIG01429252 PUTATIVE AMINO ACID EFFLUX PROTEIN +FIG01429259 FIG00388675: hypothetical protein +FIG01429266 Probable periplasmic tail-specific proteinase +FIG01429280 Chitinase Jessie 3 +FIG01429292 outer membrane heme receptor +FIG01429299 OrfD +FIG01429342 FIG00519465: hypothetical protein +FIG01429358 FIG00350640: hypothetical protein +FIG01429363 4Fe-4S binding domain +FIG01429389 Fatty acid metabolism regulator protein +FIG01429431 segregation and condensation protein B +FIG01429445 Probable membrane protein +FIG01429452 Conserved protein, permease-related +FIG01429485 hypothetical protein +FIG01429502 FIG01047640: hypothetical protein +FIG01429509 FIG00692090: hypothetical protein +FIG01429531 similar to nuclear scaffold-like protein p76 +FIG01429552 Ring hydroxylating dioxygenase alpha-subunit +FIG01429554 FIG00350888: hypothetical protein +FIG01429565 ABC transporter, transmembrane region:ABC transporter +FIG01429567 FIG00765505: hypothetical protein +FIG01429571 RIKEN cDNA 2310076O21 gene +FIG01429572 FIG00356627: hypothetical protein +FIG01429574 FIG00347825: hypothetical protein +FIG01429580 Acetylpolyamine aminohydolase +FIG01429581 Putative hydroxybenzoate transporter +FIG01429583 FIG00241737: hypothetical protein +FIG01429589 ATPase of the AAA superfamily +FIG01429598 no significant homology. S.D. unclear. +FIG01429606 FIG00353492: hypothetical protein +FIG01429622 putative sulfate permease +FIG01429645 FIG00733310: hypothetical protein +FIG01429658 CylF +FIG01429714 ComB3 protein +FIG01429722 FIG01114338: hypothetical protein +FIG01429729 Tryptophan 2,3-dioxygenase (EC 1.13.11.11) homolog +FIG01429734 Acyl-CoA hydrolase +FIG01429763 COG family: ABC-type transport systems, involved in lipoprotein release, permease components +FIG01429785 FIG00411211: hypothetical protein +FIG01429788 putative integrase/recombinase protein +FIG01429790 transcriptional regulator PrtN +FIG01429799 FIG00767661: hypothetical protein +FIG01429820 HIT hydrolase +FIG01429833 Putative resolvase +FIG01429856 hypothetical protein +FIG01429859 Peptidase S1C, Do +FIG01429870 FIG00631254: hypothetical protein +FIG01429885 FIG00764752: hypothetical protein +FIG01429894 FIG01211227: hypothetical protein +FIG01429951 FIG00744222: hypothetical protein +FIG01429972 Co/Zn/Cd efflux system component +FIG01430053 Putative Zn-dependent hydrolase +FIG01430055 Putative cell wall-binding domain +FIG01430062 FIG00403399: hypothetical protein +FIG01430068 FIG00404176: hypothetical protein +FIG01430087 DNA-binding response regulator RprY +FIG01430089 LPS biosynthesis protein WbpG +FIG01430099 FIG01046502: hypothetical protein +FIG01430110 BRO family protein +FIG01430112 ABC-transporter, ATPase component +FIG01430122 Copper amine oxidase-like +FIG01430130 YceI like family protein +FIG01430136 Probable acetyl transferase +FIG01430143 FIG00549311: hypothetical protein +FIG01430144 FIG00385266: hypothetical protein +FIG01430161 FIG00353111: hypothetical protein +FIG01430192 FIG00385538: hypothetical protein +FIG01430209 Isochorismatase family +FIG01430217 FIG01267717: hypothetical protein +FIG01430232 FIG01060481: hypothetical protein +FIG01430233 centromere protein F, 350/400ka (mitosin) +FIG01430249 Predicted polymerase +FIG01430255 enhanced entry protein EnhB, putative +FIG01430256 ortholog to Borrelia burgdorferi BB0701 +FIG01430286 Putative two-component responsible histidine kinase +FIG01430296 FIG00388713: hypothetical protein +FIG01430304 probable phage sheath protein +FIG01430326 FIG00764950: hypothetical protein +FIG01430327 FIG00351703: hypothetical protein +FIG01430350 FIG00937153: hypothetical protein +FIG01430357 Lignostilbene-alpha,beta-dioxygenase +FIG01430364 hypothetical protein-transmembrane prediction +FIG01430385 FIG00412253: hypothetical protein +FIG01430391 hypothetical protein +FIG01430396 FIG00408066: hypothetical protein +FIG01430399 Long-chain fatty-acid-CoA ligase (EC 6.2.1.3), Mycobacterial subgroup FadD16 +FIG01430426 COG3110: Uncharacterized protein conserved in bacteria +FIG01430432 Hypothetical protein Cj1300 +FIG01430442 conserved hypothetical protein, putative non-specific DNA-binding protein +FIG01430455 Protein of unknown function UPF0175 +FIG01430479 FIG00404849: hypothetical protein +FIG01430481 TPR domain protein +FIG01430513 hypothetical protein +FIG01430515 FIG00623038: hypothetical protein +FIG01430525 FIG00632812: hypothetical protein +FIG01430604 Alcohol dehydrogenase class III (EC 1.1.1.1) +FIG01430610 Membrane protein containing C-terminal PDZ domain +FIG01430630 (2Fe-2S)-binding domain protein +FIG01430633 integrase-like protein +FIG01430634 TPR-repeat protein +FIG01430641 putative ATP-binding cassette protein, nasD +FIG01430655 FIG01196477: hypothetical protein +FIG01430660 FIG00766346: hypothetical protein +FIG01430663 Universal stress protein, UspA +FIG01430672 FIG00623788: hypothetical protein +FIG01430720 FIG00356604: hypothetical protein +FIG01430727 FIG01117261: hypothetical protein +FIG01430731 FIG00623100: hypothetical protein +FIG01430746 cellulosome enzyme, dockerin type I +FIG01430750 FAD-linked oxidoreductase +FIG01430757 FIG00423922: hypothetical protein +FIG01430762 FIG00385192: hypothetical protein +FIG01430775 protein of unknown function DUF52 +FIG01430781 FIG00756547: hypothetical protein +FIG01430797 no significant homology. Putative N-terminal signal sequence and 8 putative transmembrane regions were found by PSORT. +FIG01430812 Transmission trait enhancer protein LetE +FIG01430859 YngA +FIG01430883 Primosomal replication protein N'' +FIG01430890 Conjugal transfer protein TrbG/VirB9/CagX +FIG01430913 insertion sequence protein +FIG01430916 FIG00527811: hypothetical protein +FIG01430921 FIG00766472: hypothetical protein +FIG01430941 hypothetical protein +FIG01430964 Cro-like protein +FIG01430967 UbiC transcription regulator-associated +FIG01430996 [Fe] hydrogenase, HymD subunit, putative +FIG01430998 diguanylate cyclase +FIG01430999 FIG00849248: hypothetical protein +FIG01431002 FIG01213407: hypothetical protein +FIG01431013 FIG00405373: hypothetical protein +FIG01431021 Transcriptional activator TbuT +FIG01431040 FIG00380940: hypothetical protein +FIG01431042 PE_PGRS family protein +FIG01431046 Uncharacterized oxidoreductase yqjQ +FIG01431062 FIG00770014: hypothetical protein +FIG01431082 Acetyltransferase, including N-acetylase of ribosomal protein +FIG01431104 FIG00405607: hypothetical protein +FIG01431119 Immunodominant antigen B +FIG01431120 FIG01135944: hypothetical protein +FIG01431142 FIG00405858: hypothetical protein +FIG01431148 FIG00624631: hypothetical protein +FIG01431158 bll8283; unknown protein +FIG01431160 FIG00350353: hypothetical protein +FIG01431167 FIG01251400: hypothetical protein +FIG01431192 N-acetylneuraminate transport system permease protein +FIG01431193 Transporter MFS superfamily +FIG01431208 FIG00385365: hypothetical protein +FIG01431227 FIG00820962: hypothetical protein +FIG01431234 FIG00427152: hypothetical protein +FIG01431255 FIG00405064: hypothetical protein +FIG01431263 FIG00425283: hypothetical protein +FIG01431289 thiol:disulfide interchange protein +FIG01431292 Transposase +FIG01431293 pilin glycosylation protein +FIG01431311 inner membrane component of binding-protein-dependent transport system +FIG01431324 FIG00840392: hypothetical protein +FIG01431326 FIG00711501: hypothetical protein +FIG01431348 Ymf77 +FIG01431365 Uncharacterized membrane-anchored protein conserved in bacteria +FIG01431367 FIG00764992: hypothetical protein +FIG01431400 bacterial luciferase family protein +FIG01431406 FIG00528276: hypothetical protein +FIG01431420 NADPH:quinone oxidoreductase (EC 1.6.5.5) +FIG01431456 transcriptional activator domain +FIG01431462 Probable acrA1 protein +FIG01431469 cytochrome c oxidase assembly factor +FIG01431487 DsbA-like thioredoxin domain protein +FIG01431514 Putative virulence-associated protein +FIG01431519 Lysine exporter protein (LYSE/YGGA) +FIG01431540 iron chelatin ABC transporter, ATP-binding protein +FIG01431541 Hdf +FIG01431543 FIG00768576: hypothetical protein +FIG01431560 FIG00352158: hypothetical protein +FIG01431567 FIG01203163: hypothetical protein +FIG01431570 FIG00672621: hypothetical protein +FIG01431571 putative potassium channel, VIC family +FIG01431578 M23 peptidase domain protein +FIG01431589 UxpB protein +FIG01431593 prophage P4 integrase +FIG01431595 enhanced entry protein EnhA, putative +FIG01431600 Adenylylsulfate kinase and related kinases +FIG01431609 hypothetical protein +FIG01431627 Glr2365 protein +FIG01431628 Type II secretory pathway, component PulK +FIG01431638 Transcriptional regulator +FIG01431646 Predicted lactoylglutathione lyase +FIG01431651 Bll5482 protein +FIG01431660 PefB protein +FIG01431661 Gp45 protein +FIG01431665 FIG00416267: hypothetical protein +FIG01431692 Enhanced entry protein EnhA +FIG01431720 Uncharacterized protein HP_0190 +FIG01431730 COG0270: Site-specific DNA methylase +FIG01431771 FIG00403751: hypothetical protein +FIG01431778 hypothetical protein +FIG01431799 COG1872 +FIG01431825 pseudogene (IS1655 transposase) NMA0236 +FIG01431842 FIG00766953: hypothetical protein +FIG01431863 Possible transferase +FIG01431869 FIG00958143: hypothetical protein +FIG01431872 putative ABC-transport protein, membrane component +FIG01431873 copper amine oxidase N- domain family +FIG01431874 hypothetical protein +FIG01431901 Short-chain dehydrogenase/reductase SDR +FIG01431905 FIG00822596: hypothetical protein +FIG01431913 FIG00763690: hypothetical protein +FIG01431921 FIG00968140: hypothetical protein +FIG01431930 electron transport proteins +FIG01431931 FIG00764887: hypothetical protein +FIG01431955 isopenicillin N epimerase( EC:5.1.1.17 ) +FIG01431972 hypothetical protein +FIG01431987 FIG01028685: hypothetical protein +FIG01431988 hypothetical protein +FIG01431997 PUTATIVE ALPHA-KETOGLUTARATE PERMEASE TRANSMEMBRANE PROTEIN +FIG01432007 FIG00763419: hypothetical protein +FIG01432019 glycosyl transferase, family 2 +FIG01432022 Phage integrase, phage integrase family +FIG01432055 Putative oxidoreductase YcjS (EC 1.-.-.-), NADH-binding +FIG01432073 FIG00385747: hypothetical protein +FIG01432087 FIG00403216: hypothetical protein +FIG01432089 FIG00674216: hypothetical protein +FIG01432112 FIG00751177: hypothetical protein +FIG01432120 no significant homology. Putative N-terminal signal sequence and 5 putative transmembrane regions were found by PSORT. +FIG01432133 ABC-type transport system permease protein +FIG01432135 Capsule polysaccharide biosynthesis +FIG01432158 baseplate assembly protein, putative +FIG01432177 Lj965 prophage protein +FIG01432187 FIG01119355: hypothetical protein +FIG01432201 Regulatory protein cysR +FIG01432206 YDFR protein +FIG01432232 FIG00640497: hypothetical protein +FIG01432247 FIG00641665: hypothetical protein +FIG01432252 Macrophage migration inhibitory factor family +FIG01432253 FIG00641246: hypothetical protein +FIG01432261 PcbR +FIG01432263 Copper resistance protein CopZ +FIG01432270 syc2175_d +FIG01432298 syc0127_d +FIG01432331 FIG00766697: hypothetical protein +FIG01432336 hemolysin secretion protein D +FIG01432337 FIG00353610: hypothetical protein +FIG01432342 MGC82361 protein +FIG01432346 putative TPR repeat protein +FIG01432361 hemerythrin HHE cation binding protein +FIG01432371 Riboflavin kinase (EC 2.7.1.26) / FMN adenylyltransferase (EC 2.7.7.2) +FIG01432377 FIG00451799: hypothetical protein +FIG01432380 FIG00351025: hypothetical protein +FIG01432389 PUTATIVE TRANSCRIPTIONAL REGULATOR +FIG01432393 putative ABC transport proteins, inner membrane component +FIG01432396 FIG01022145: hypothetical protein +FIG01432402 Phage FAD/FMN-containing dehydrogenase +FIG01432440 predicted metal-dependent phosphoesterase (PHP family) +FIG01432479 Putative D-2-hydroxyacid dehydrogenase +FIG01432534 FIG01240809: hypothetical protein +FIG01432547 FIG00403632: hypothetical protein +FIG01432553 FIG00762798: hypothetical protein +FIG01432559 Bll0596 protein +FIG01432564 FIG00588917: hypothetical protein +FIG01432580 hsp20/alpha crystallin family protein +FIG01432583 virulence factors transcription regulator +FIG01432585 IG hypothetical 18565 +FIG01432594 hypothetical protein P3TCK_12944 +FIG01432596 FIG00963812: hypothetical protein +FIG01432597 Uncharacterized protein MJ0665 +FIG01432620 putative penicillin acylase +FIG01432657 FIG00409095: hypothetical protein +FIG01432690 probable potassium efflux transporter +FIG01432707 Feruloyl esterase( EC:3.1.1.73 ) +FIG01432709 ortholog of Bordetella pertussis (BX470248) BP2698 +FIG01432728 D-serine deaminase (EC 4.3.1.18) +FIG01432734 FIG00344004: hypothetical protein +FIG01432745 drug resistance MFS transporter, drug:H+ antiporter-1 (14 Spanner) (DHA2) family +FIG01432754 ORF_ID:all0265 +FIG01432781 Roadblock/LC7 family protein +FIG01432803 FIG00572123: hypothetical protein +FIG01432837 FIG00715019: hypothetical protein +FIG01432849 molybdopterin-guanine dinucleotide biosynthesis protein A +FIG01432868 FIG01127267: hypothetical protein +FIG01432873 Peptidoglycan hydrolase, Autolysin1 (EC 3.5.1.28) +FIG01432884 FIG00388574: hypothetical protein +FIG01432887 FIG00623870: hypothetical protein +FIG01432920 FIG00710162: hypothetical protein +FIG01432932 FIG00640104: hypothetical protein +FIG01432935 SidC protein +FIG01432943 FIG00412424: hypothetical protein +FIG01432952 ABC-2 type transport system, membrane protein +FIG01432965 FIG00675620: hypothetical protein +FIG01432975 Major facilitator superfamily (MFS_1) transporter +FIG01432986 FIG00632339: hypothetical protein +FIG01432995 Glutaredoxin-like protein GlrX +FIG01433001 FIG01119620: hypothetical protein +FIG01433064 flavoprotein +FIG01433069 PRD domain protein +FIG01433073 FIG01069107: hypothetical protein +FIG01433113 FIG00344283: hypothetical protein +FIG01433116 Uncharacterized HAD-hydrolase PYRAB05140 (EC 3.-.-.-) +FIG01433119 FIG00415945: hypothetical protein +FIG01433150 Multidrug efflux protein, outer membrane component +FIG01433160 hypothetical protein +FIG01433174 Oleate hydratase (EC 4.2.1.53) +FIG01433188 FIG00390015: hypothetical protein +FIG01433189 transcriptional regulator, Cro/CI family protein +FIG01433191 hypothetical protein +FIG01433207 outer membrane protein, OmpA/MotB family +FIG01433211 FIG00939822: hypothetical protein +FIG01433215 FIG00364518: hypothetical protein +FIG01433238 Cardiac ankyrin repeat protein +FIG01433267 FIG00643779: hypothetical protein +FIG01433271 FIG00764844: hypothetical protein +FIG01433290 FIG00639888: hypothetical protein +FIG01433291 capsular polysaccharide biosythesis protein, putative +FIG01433301 COG4973: Site-specific recombinase XerC +FIG01433306 permease protein +FIG01433317 protein of unknown function DUF399 +FIG01433342 FIG00351669: hypothetical protein +FIG01433347 N-ethylmaleimide reductase +FIG01433353 FIG00468194: hypothetical protein +FIG01433357 ABC-type transport system, ATP-binding component +FIG01433365 Aminotransferase class-III +FIG01433368 dnaK suppressor, putative +FIG01433372 Small HspC2 heat shock protein +FIG01433444 NanA gene +FIG01433449 Putative mucR family transcriptional regulatory protein RA0938 +FIG01433450 FIG00623585: hypothetical protein +FIG01433460 hypothetical protein +FIG01433477 flagellin protein +FIG01433480 FIG00361977: hypothetical protein +FIG01433482 PPE family protein +FIG01433490 Gram-positive signal peptide protein, YSIRK family +FIG01433528 FIG00526973: hypothetical protein +FIG01433538 cytoplasmic chaperone TorD family protein +FIG01433575 Possible abortive infection phage resistance protein +FIG01433576 other cellular organization +FIG01433602 FIG00385612: hypothetical protein +FIG01433606 large-conductance mechanosensitive channel +FIG01433607 FIG00350032: hypothetical protein +FIG01433628 FIG00637922: hypothetical protein +FIG01433653 phage virion morphogenesis protein, putative +FIG01433664 FadB4 +FIG01433666 FIG00344649: hypothetical protein +FIG01433675 FIG00825050: hypothetical protein +FIG01433691 acyltransferase PapA5 +FIG01433693 FIG00850031: hypothetical protein +FIG01433719 peptidyl-prolyl cis-trans isomerase, FkbP-type +FIG01433747 Uncharacterized protein yjcN precursor +FIG01433780 ortholog of Bordetella pertussis (BX470248) BP3011 +FIG01433794 Probable 30S ribosomal protein PSRP-3 +FIG01433805 FIG00765906: hypothetical protein +FIG01433812 FIG00514182: hypothetical protein +FIG01433829 flagellar biosynthesis protein R +FIG01433865 Subtilisin like protease (two fused domains) +FIG01433871 FIG01198578: hypothetical protein +FIG01433872 zinc-resistance associated protein +FIG01433877 Gll3359 protein +FIG01433888 hypothetical protein +FIG01433923 haloacid dehalogenase, IA family protein +FIG01433931 ABC-type amino acid transport system, permease component +FIG01433934 endonuclease IV( EC:3.1.21.2 ) +FIG01433961 Branched-chain amino acid transport, AzlC +FIG01433978 microsomal dipeptidase( EC:3.4.13.19 ) +FIG01433980 virulence-associated protein +FIG01434008 Ferric siderophore receptor, TonB dependent +FIG01434026 hypothetical protein +FIG01434039 FIG00787995: hypothetical protein +FIG01434055 FIG00520097: hypothetical protein +FIG01434061 FIG00627395: hypothetical protein +FIG01434068 FIG00452075: hypothetical protein +FIG01434083 Orf37 +FIG01434094 FIG00624492: hypothetical protein +FIG01434140 FIG00623404: hypothetical protein +FIG01434144 putative mucus binding precursor +FIG01434146 FIG00744707: hypothetical protein +FIG01434181 lipase activator protein, putative +FIG01434182 hypothetical protein +FIG01434194 ABC-type transport system, permease component +FIG01434197 FIG00672260: hypothetical protein +FIG01434204 FIG00385397: hypothetical protein +FIG01434217 FIG01200650: hypothetical protein +FIG01434231 TrkA-N domain family +FIG01434274 FIG018599: Phage-associated protein +FIG01434277 FIG00643467: hypothetical protein +FIG01434307 FIG00642591: hypothetical protein +FIG01434309 FIG00412973: hypothetical protein +FIG01434312 FIG00350559: hypothetical protein +FIG01434320 Heavy-chain fibroin (Fragment) +FIG01434321 FIG00837314: hypothetical protein +FIG01434335 3-oxo-5-alpha-steroid 4-dehydrogenase +FIG01434336 Uncharacterized protein ykzH +FIG01434343 Putative prohead protease +FIG01434351 Alr2628 protein +FIG01434364 FIG00516080: hypothetical protein +FIG01434370 FIG00404751: hypothetical protein +FIG01434381 Extracellular serine protease precursor (EC 3.4.21.-) +FIG01434394 Possible pectin degradation protein (sugar phosphate isomerase family) +FIG01434408 Chemotactic transduction protein chpE +FIG01434411 MCE family protein +FIG01434433 FIG00350837: hypothetical protein +FIG01434451 immunoglobulin-binding protein EibA +FIG01434467 COG4230: Delta 1-pyrroline-5-carboxylate dehydrogenase +FIG01434498 putative phage-related secreted protein +FIG01434533 FIG00624770: hypothetical protein +FIG01434542 FIG235422: hypothetical protein +FIG01434551 FIG00406429: hypothetical protein +FIG01434560 putative ATP binding protein of ABC transporter +FIG01434561 IS1533 transposase +FIG01434567 orf; Unknown function +FIG01434570 ABC transporter, periplasmic substrate-binding protein-related protein +FIG01434597 FIG00524842: hypothetical protein +FIG01434610 FIG00348489: hypothetical protein +FIG01434641 RNA polymerase sigma-70 factor, putative +FIG01434645 FIG00967552: hypothetical protein +FIG01434662 putative pathogenesis related protein +FIG01434679 FIG00640298: hypothetical protein +FIG01434688 FIG00380156: hypothetical protein +FIG01434696 Tail protein I +FIG01434698 FIG00688605: hypothetical protein +FIG01434721 phosphoadenosine phosphosulfate reductase +FIG01434730 FIG00838769: hypothetical protein +FIG01434732 FIG00841575: hypothetical protein +FIG01434745 FIG00179874: hypothetical protein +FIG01434746 bll1134; hypothetical protein +FIG01434768 FIG00350455: hypothetical protein +FIG01434785 response regulator/sensor histidine kinase AsgD +FIG01434831 hypothetical protein +FIG01434842 FIG01166533: hypothetical protein +FIG01434856 FIG01236490: hypothetical protein +FIG01434886 ORF_ID:all7674 unknown protein +FIG01434894 ERCC4 domain protein +FIG01434911 putative sigma factor-like positive control protein +FIG01434929 FIG00629878: hypothetical protein +FIG01434931 observed by proteomics Citation: Proteomics from VerBerkmoes et al. (2003) unpublished +FIG01434933 FIG01236546: hypothetical protein +FIG01434955 FIG00316759: hypothetical protein +FIG01434961 para-nitrobenzyl esterase (intracellular esterase B) +FIG01434977 IS1167, transposase, ISL3 family, truncated +FIG01434986 FIG00622741: hypothetical protein +FIG01434989 probable MPT-synthase sulfurylase +FIG01435008 FIG01194264: hypothetical protein +FIG01435014 ABC-type transport system involved in Fe-S cluster assembly, ATPase component +FIG01435036 FIG00405319: hypothetical protein +FIG01435048 High affinity transport system protein p37 precursor +FIG01435061 serine/threonine protein kinase-like protein +FIG01435093 Possible ATP synthase protein 8 precursor +FIG01435104 FIG00628305: hypothetical protein +FIG01435121 FIG00423914: hypothetical protein +FIG01435175 FIG037792: hypothetical protein +FIG01435178 glutamine ABC transporter, ATP-binding protein +FIG01435180 R body protein RebB homolog +FIG01435193 periplasmic protein, LipL45 homologue +FIG01435210 Transcriptional regulators, marR/emrR family +FIG01435211 PKD domain containing protein +FIG01435222 bacteriophage DNA transposition B protein, putative +FIG01435236 FIG00351614: hypothetical protein +FIG01435268 Uncharacterized protein MJ0733 +FIG01435273 FIG00898831: hypothetical protein +FIG01435289 Bbs27 protein +FIG01435296 putative repressor - phage associated +FIG01435301 FIG00693687: hypothetical protein +FIG01435334 UPF0043 membrane protein YdjX +FIG01435339 Protein containing transglutaminase-like domain, putative cysteine protease +FIG01435360 FIG00364990: hypothetical protein +FIG01435371 FIG00348050: hypothetical protein +FIG01435379 putative acyl-CoA transferase +FIG01435406 Membrane protein containing sporulation/cell division related domain +FIG01435408 transporter +FIG01435409 phage lysis protein S +FIG01435430 Proline/betaine transporter +FIG01435434 Integral membrane acyltransferase +FIG01435438 Clp, N terminal +FIG01435442 FIG00389093: hypothetical protein +FIG01435447 transcriptional regulator (MarR family) +FIG01435479 FIG00828339: hypothetical protein +FIG01435514 FIG00425314: hypothetical protein +FIG01435517 FIG01021106: hypothetical protein +FIG01435550 Bll7352 protein +FIG01435566 heat shock protease +FIG01435573 FIG01236891: hypothetical protein +FIG01435664 Glr2085 protein +FIG01435676 FIG00407976: hypothetical protein +FIG01435689 ATP-dependent protease LonB Type II +FIG01435690 FIG00351372: hypothetical protein +FIG01435740 cag pathogenicity island protein C +FIG01435742 FIG00774473: hypothetical protein +FIG01435748 Uncharacterized protein yxcA +FIG01435757 FIG00961373: hypothetical protein +FIG01435762 FIG01047206: hypothetical protein +FIG01435773 CBS domain protein +FIG01435776 FIG00675921: hypothetical protein +FIG01435779 FIG00384932: hypothetical protein +FIG01435803 FIG00623350: hypothetical protein +FIG01435839 transcriptional regulator, TrmB +FIG01435844 HipA-like +FIG01435856 Succinate-semialdehyde dehydrogenase, CoA-dependent +FIG01435907 protease-associated PA domain protein +FIG01435948 FIG00403631: hypothetical protein +FIG01435958 Thioredoxin domain 2 +FIG01435967 FIG01167075: hypothetical protein +FIG01435971 FIG01207922: hypothetical protein +FIG01436010 HNH endonuclease, putative +FIG01436027 Lin2896 protein +FIG01436088 cytidine/deoxycytidylate deaminase family protein( EC:3.5.4.3 ) +FIG01436152 bacterial extracellular solute-binding protein, family 3 +FIG01436162 putative Tra3-like protein +FIG01436165 Type II restriction enzyme HgiDI (EC 3.1.21.4) +FIG01436166 FIG00351193: hypothetical protein +FIG01436168 FIG00351904: hypothetical protein +FIG01436172 FIG00627681: hypothetical protein +FIG01436176 Siderophore synthetase superfamily, group C +FIG01436187 FIG00687570: hypothetical protein +FIG01436192 IS1327 transposase +FIG01436221 possible Uncharacterized protein family UPF005 +FIG01436225 PE-PGRS FAMILY PROTEIN +FIG01436229 Probable conserved integral membrane transport protein +FIG01436244 Halocyanin +FIG01436265 Dolichyl-phosphate beta-D-mannosyltransferase( EC:2.4.1.83 ) +FIG01436290 FIG01155722: hypothetical protein +FIG01436335 transcriptional regulator (DeoR family) +FIG01436365 Steroid 5-alpha reductase, C-terminal domain +FIG01436373 CELL SURFACE PROTEIN +FIG01436376 glycoside hydrolase family 16 +FIG01436399 Dolichol-P-glucose synthetase +FIG01436402 FIG234577: hypothetical protein +FIG01436417 malate permease +FIG01436420 glycosyltransferase, group I +FIG01436496 FIG00920107: hypothetical protein +FIG01436498 hypothetical protein +FIG01436500 Type II restriction enzyme RsrI (EC 3.1.21.4) (Endonuclease RsrI) (R.RsrI) +FIG01436502 FIG00351770: hypothetical protein +FIG01436517 FIG00744515: hypothetical protein +FIG01436518 syc2267_c +FIG01436526 FIG00764910: hypothetical protein +FIG01436527 YehQ protein +FIG01436556 phosphatidylglycerophosphate synthase +FIG01436565 FIG01092183: hypothetical protein +FIG01436571 Filament integrity protein fraC +FIG01436577 transposase and inactivated derivative +FIG01436592 spore germination protein +FIG01436594 Sulfite oxidase and related enzyme +FIG01436599 TraA +FIG01436608 ortholog of Bordetella pertussis (BX470248) BP2232 +FIG01436613 Transcriptional regulator, AraC family +FIG01436621 FIG00821186: hypothetical protein +FIG01436653 YkzH; RBL04896 +FIG01436663 putative glyoxalase +FIG01436676 putative regulatory protein, AlpA family +FIG01436693 FIG00624024: hypothetical protein +FIG01436739 FIG01066935: hypothetical protein +FIG01436759 FIG00415110: hypothetical protein +FIG01436762 syc1365_d +FIG01436779 FIG00385190: hypothetical protein +FIG01436805 FIG00763798: hypothetical protein +FIG01436814 13 kDa major membrane protein +FIG01436819 FIG00764072: hypothetical protein +FIG01436823 FIG00764607: hypothetical protein +FIG01436828 FIG00433630: hypothetical protein +FIG01436841 putative (ceramide) glucosyltransferase +FIG01436846 possible cell division protein +FIG01436867 type I secretion target repeat protein +FIG01436870 Alpha-glucuronidase +FIG01436900 FIG01116232: hypothetical protein +FIG01436909 Pectinesterase +FIG01436911 Gifsy-2 prophage +FIG01436914 Phage-related tail fiber protein +FIG01436929 biotin/lipoyl attachment +FIG01436951 Phosphorelay protein luxU +FIG01436958 Chain I, Chymotrypsin Inhibitor 2 (Ci2) Mutant With Ile 76 Replaced By Val (I76v) +FIG01436962 FIG00347566: hypothetical protein +FIG01436974 Gll1952 protein +FIG01436981 surface-located membrane protein 1 (lmp1) +FIG01436990 probable tanscriptional regulator +FIG01436995 FIG00350942: hypothetical protein +FIG01437001 putative aspartate aminotransferase +FIG01437041 FIG01093760: hypothetical protein +FIG01437042 putative glycosyltransferase family 2 +FIG01437052 Hexapeptide transferase family protein +FIG01437063 Peptidyl-prolyl cis-trans isomerase, FKBP-type +FIG01437065 FIG00405719: hypothetical protein +FIG01437087 Ankrin repeat protein +FIG01437097 HNH nuclease / phage PHI-105 holin-like protein +FIG01437111 FIG014338: Hypothetical protein +FIG01437115 Glycosyltransferase, family 8 +FIG01437116 FIG00764152: hypothetical protein +FIG01437147 FIG00767129: hypothetical protein +FIG01437158 FIG00103665: hypothetical protein +FIG01437250 FIG00876808: hypothetical protein +FIG01437277 transposase of Tn10 +FIG01437306 3-oxoacyl-[acyl-carrier-protein ] synthase +FIG01437339 D-ribose-binding periplasmic protein +FIG01437340 chemotaxis response regulator (cheY-1) +FIG01437372 FIG00348837: hypothetical protein +FIG01437389 XisI +FIG01437391 DEAD/DEAH box helicase-like +FIG01437392 High-affinity leucine-specific transport system, periplasmic binding protein LivK (TC 3.A.1.4.1) +FIG01437397 FIG00628084: hypothetical protein +FIG01437412 Cupin 2 barrel domain-containing protein +FIG01437419 COG family: predicted metal-dependent membrane protease; PFAM_ID: Abi +FIG01437436 FIG00816650: hypothetical protein +FIG01437439 Similarities with transcriptional regulator +FIG01437443 bll5595; hypothetical protein +FIG01437479 DNA-directed RNA polymerase specialized sigma subunit, sigma24-like protein +FIG01437525 FIG00385721: hypothetical protein +FIG01437532 thiol:disulphide interchange protein, putative +FIG01437539 Sterol desaturase family protein +FIG01437545 Type IV secretory pathway, VirD2 component +FIG01437572 FIG00764662: hypothetical protein +FIG01437591 FIG00385029: hypothetical protein +FIG01437593 PdcA +FIG01437603 Transposase +FIG01437629 thiamine biosynthesis protein ThiS +FIG01437640 FIG00768048: hypothetical protein +FIG01437646 ANTAR domain protein with unknown sensor +FIG01437686 divergent AAA domain protein +FIG01437704 FIG00949741: hypothetical protein +FIG01437732 Complete genome; segment 13/17 +FIG01437745 PapX protein +FIG01437748 T. pallidum predicted coding region TP0245 +FIG01437758 FIG00967049: hypothetical protein +FIG01437767 HAD family hydrolase, a +FIG01437801 acetyltransferase GNAT family +FIG01437807 FIG00765389: hypothetical protein +FIG01437826 short-chain dehydrogenase/reductase SDR( EC:1.1.1.276 ) +FIG01437841 Ribosomal RNA methyltransferase (EC 2.1.1.-) (Gentamicin-resistance methyltransferase) +FIG01437853 FIG01196977: hypothetical protein +FIG01437858 FIG00352222: hypothetical protein +FIG01437880 hypothetical protein +FIG01437887 Slr1170 protein +FIG01437896 FIG00380714: hypothetical protein +FIG01437910 FIG00946351: hypothetical protein +FIG01437934 FIG01437934: possible transcriptional regulator +FIG01437957 FIG00524417: hypothetical protein +FIG01437959 FIG01120155: hypothetical protein +FIG01437962 uncharacterized low-complexity protein +FIG01437967 Phosphate regulon transcriptional regulator, PhoR +FIG01437990 Cytochrome c peroxidase family protein +FIG01438005 YvlC-like protein +FIG01438006 acetoin utilization acuB protein +FIG01438040 cell wall protein, putative +FIG01438058 FIG00521437: hypothetical protein +FIG01438071 Fe-S-cluster domain +FIG01438110 FIG01064526: hypothetical protein +FIG01438126 FIG00516719: hypothetical protein +FIG01438141 FIG00388415: hypothetical protein +FIG01438144 FIG01001448: hypothetical protein +FIG01438147 FIG00321242: hypothetical protein +FIG01438158 hypothetical protein +FIG01438175 FIG00528168: hypothetical protein +FIG01438186 Mannose-1-phosphate guanylyltransferase +FIG01438237 Ferric aerobactin receptor +FIG01438239 putative transciptional regulator +FIG01438244 FIG00388588: hypothetical protein +FIG01438265 ribosomal protein, putative +FIG01438268 HAMP domain +FIG01438274 FIG00352773: hypothetical protein +FIG01438276 B. burgdorferi predicted coding region BBA30 +FIG01438283 FIG00624843: hypothetical protein +FIG01438284 Modification methylase HgiDII +FIG01438286 carbon dioxide concentrating mechanism protein +FIG01438300 gpL [Enterobacteria phage P2] sp|P25475|VPL_BPP2 HEAD COMPLE... +FIG01438312 Modification methylase DdeI +FIG01438325 High potential iron-sulfur protein +FIG01438337 IncI1 plasmid conjugative transfer prepilin PilS +FIG01438341 FIG00904431: hypothetical protein +FIG01438351 FIG00405513: hypothetical protein +FIG01438359 FIG01218972: hypothetical protein +FIG01438371 Amino acid permease-associated region +FIG01438374 similar to pir:B70351 ribosomal-protein-alanine acetyltransferase from Aquifex aeolicus (154 aa); 28.2% identity in 78 aa overlap +FIG01438381 FIG00733434: hypothetical protein +FIG01438384 putataive branched-chain amino acid transport protein AzlC +FIG01438387 L-ornithine 5-monooxygenase +FIG01438391 FIG01234611: hypothetical protein +FIG01438392 ABC transporter, permease protein (putative) +FIG01438408 Predicted protein family PM-17 +FIG01438410 FIG00870426: hypothetical protein +FIG01438437 hemerythrin-like protein +FIG01438442 FIG01117505: hypothetical protein +FIG01438463 Putative amino acid ABC transporter, periplasmic amino acid-binding protein +FIG01438475 Uncharacterized small membrane protein, homolog of ykvA B.subtilis +FIG01438480 FIG00784338: hypothetical protein +FIG01438484 Iron compound ABC transporter, periplasmic iron compound-binding protein +FIG01438491 FIG01230404: hypothetical protein +FIG01438494 Sec-independent protein secretion pathway component TatC +FIG01438521 FIG01047539: hypothetical protein +FIG01438532 protein of unknown function DUF1003 +FIG01438533 FIG00361547: hypothetical protein +FIG01438552 Iron-regulated outer membrane protein +FIG01438563 FIG00945879: hypothetical protein +FIG01438568 putative transposase (partial) +FIG01438582 FIG00450151: hypothetical protein +FIG01438615 FIG00689733: hypothetical protein +FIG01438661 Two component Transcriptional regulator, Winged helix family +FIG01438663 probable membrane protein YPO1990 +FIG01438665 FIG00642488: hypothetical protein +FIG01438667 FIG00647030: hypothetical protein +FIG01438679 FIG00409845: hypothetical protein +FIG01438691 ISHa1152 transposase B fragment 2 +FIG01438694 FIG00632904: hypothetical protein +FIG01438702 Glyoxalase/Bleomycin resistance protein/Dioxygenase superfamily +FIG01438710 Rtn-like protein +FIG01438726 Methylated-DNA protein - cysteine methyltransferase +FIG01438773 Lysine biosynthesis protein LysW +FIG01438853 putative outer membrane (scaffolding) protein +FIG01438857 FIG00640877: hypothetical protein +FIG01438863 outermembrane protein +FIG01438901 ATP phosphoribosyltransferase( EC:2.4.2.17 ) +FIG01438907 exporters of the RND superfamily +FIG01438911 Excisionase +FIG01438935 FIG00752753: hypothetical protein +FIG01438956 phosphate starvation-inducible protein precursor +FIG01438966 GMC oxidoreductase +FIG01438979 Antiseptic resistance protein +FIG01439000 FIG00425361: hypothetical protein +FIG01439010 FIG00352300: hypothetical protein +FIG01439056 COG3395: Uncharacterized protein conserved in bacteria +FIG01439075 FIG00352246: hypothetical protein +FIG01439079 FIG00551563: hypothetical protein +FIG01439099 syc0160_c +FIG01439162 FIG00389484: hypothetical protein +FIG01439180 YbbR-like +FIG01439190 Sulfide:quinone oxidoreductase +FIG01439203 FIG00846735: hypothetical protein +FIG01439204 ATPase involved in chromosome partitioning Rv8888c +FIG01439223 PUTATIVE ACETYLTRANSFERASE( EC:2.3.1.- ) +FIG01439226 FIG01169331: hypothetical protein +FIG01439231 carboxyphosphonoenolpyruvate phosphonomutase +FIG01439240 Guanosine polyphosphate pyrophosphohydrolase/synthetase +FIG01439247 DIOXYGENASE (EC 1.13.11.-) +FIG01439257 FIG00769239: hypothetical protein +FIG01439278 putative acyltransferase, putative +FIG01439284 FIG00403140: hypothetical protein +FIG01439288 FIG01259408: hypothetical protein +FIG01439293 putative phosphate ABC transporter, periplasmic phosphate-binding protein +FIG01439295 COG3515: Uncharacterized protein conserved in bacteria +FIG01439298 DnaJ/DnaK assembly factor DafA +FIG01439311 glycosyl transferase, putative( EC:2.4.1.- ) +FIG01439321 Mu-like prophage protein gp16 +FIG01439349 FIG00517043: hypothetical protein +FIG01439351 FIG00403641: hypothetical protein +FIG01439397 NGG1-interacting factor 3 +FIG01439400 Transformation system protein +FIG01439416 glycosyl transferase, group 1 family protein( EC:2.4.1.- ) +FIG01439448 glutaredoxin, putative +FIG01439473 FIG01115865: hypothetical protein +FIG01439474 endo-beta-1,4-glucanase (celulase B) +FIG01439498 alpha-1,2-mannosidase, putative +FIG01439503 FIG00520425: hypothetical protein +FIG01439510 Putative MFS transporter +FIG01439537 FIG00533420: hypothetical protein +FIG01439559 xre family DNA-binding domain and TPR-repeat containing protein +FIG01439564 contains Pfam profile PF04654: Protein of unknown function, DUF599 / expressed protein +FIG01439567 hypothetical protein +FIG01439578 FIG00767806: hypothetical protein +FIG01439579 Succinyl-CoA:(R)-benzylsuccinate CoA-transferase subunit BbsE (EC 2.8.3.15) +FIG01439587 FIG00407757: hypothetical protein +FIG01439589 Putative nucleic-acid-binding protein +FIG01439591 chaperone protein DnaJ +FIG01439629 FIG00362163: hypothetical protein +FIG01439632 Disulfide oxidoreductase +FIG01439634 19 kDa lipoprotein antigen LpqH-like protein +FIG01439661 FIG00254669: hypothetical protein +FIG01439673 FIG00848183: hypothetical protein +FIG01439702 FIG01161959: hypothetical protein +FIG01439711 FIG035554: Phage-associated protein +FIG01439723 FIG00763138: hypothetical protein +FIG01439728 Probable sigma54-dependent transcriptional regulator +FIG01439736 FIG01120341: hypothetical protein +FIG01439748 putative head-tail joining protein of prophage +FIG01439749 hypothetical protein +FIG01439763 FIG00687986: hypothetical protein +FIG01439764 FIG00405478: hypothetical protein +FIG01439766 probable conjugal transfer protein traD +FIG01439798 probable di-trans,poly-cis-decaprenylcistransferase (EC 2.5.1.31) yteR +FIG01439814 no significant homology Putative N-terminal signal sequence was found by PSORT +FIG01439815 FIG00388647: hypothetical protein +FIG01439816 Rho-associated protein kinase 2 (EC 2.7.11.1) +FIG01439825 Metal-dependent hydrolases of the metallobeta-lactamase superfamily +FIG01439853 possible Type I restriction modification DNA s +FIG01439857 efflux transporter, RND family, MFP subunit +FIG01439862 Uncharacterized protein, homolog of phage Mu protein gp30 +FIG01439873 FIG00407473: hypothetical protein +FIG01439902 Transcription initiation factor IIIB 70 kDa subunit +FIG01439920 tRNA (cytidine(34)-2'-O)-methyltransferase (EC 2.1.1.207) +FIG01439939 FIG01048048: hypothetical protein +FIG01439981 Bll1004 protein +FIG01439984 FIG01020103: hypothetical protein +FIG01440013 Uncharacterized protein conserved in bacteria with the myosin-like domain +FIG01440026 Phage terminase small subunit +FIG01440032 glycine-rich protein +FIG01440039 FIG01246638: hypothetical protein +FIG01440053 UPF0229 protein YeaH +FIG01440059 FIG00351808: hypothetical protein +FIG01440064 FIG00644081: hypothetical protein +FIG01440070 Slr1676 protein +FIG01440083 putative nucleotidyltransferase +FIG01440085 alcohol oxidase-related +FIG01440093 FIG01239291: hypothetical protein +FIG01440125 FIG00765918: hypothetical protein +FIG01440132 FIG00767581: hypothetical protein +FIG01440134 FIG00896759: hypothetical protein +FIG01440139 FIG00385402: hypothetical protein +FIG01440156 FIG00633472: hypothetical protein +FIG01440160 FIG00452220: hypothetical protein +FIG01440174 FIG00514057: hypothetical protein +FIG01440196 Protein of unknown function DUF559 +FIG01440219 FIG00348237: hypothetical protein +FIG01440235 FIG00768419: hypothetical protein +FIG01440239 sporulation-control gene +FIG01440252 Phage portal protein +FIG01440270 Conserved domain protein, histidine-rich +FIG01440287 FIG00361779: hypothetical protein +FIG01440336 hypothetical protein +FIG01440337 Protein of unknown function DUF975 +FIG01440345 Nitrogen regulation protein NIFR3 +FIG01440352 FIG00768955: hypothetical protein +FIG01440366 FIG00380451: hypothetical protein +FIG01440367 daunorubicin resistance ABC transporter, ATP-binding protein +FIG01440391 peptidase M10A and M12B matrixin and adamalysin +FIG01440408 FIG01114746: hypothetical protein +FIG01440413 possible ABC transporter, permease protein +FIG01440422 hypothetical protein in Thermus iron scavenging cluster +FIG01440464 FIG00768651: hypothetical protein +FIG01440473 Bll4691 protein +FIG01440477 Rhodanese domain protein UPF0176, cyanobacterial/alphaproteobacterial subgroup +FIG01440478 outer membrane receptor for ferric iron uptake +FIG01440486 transposase IS3/IS911 family protein +FIG01440494 FIG00530914: hypothetical protein +FIG01440501 conserved protein (pathogens) +FIG01440516 FIG01076514: hypothetical protein +FIG01440535 HIT domain protein +FIG01440543 proton/glutamate symporter +FIG01440547 FIG01134346: hypothetical protein +FIG01440566 Chromosome I, complete sequence, strain 2308 +FIG01440584 major surface protein 1a-like protein 22 +FIG01440587 FIG00403426: hypothetical protein +FIG01440595 FIG00408527: hypothetical protein +FIG01440596 FIG00850543: hypothetical protein +FIG01440601 probable membrane protein YPO2863 +FIG01440603 protein of unknown function DUF1674 +FIG01440633 multi-component regulatory system-8 +FIG01440638 Iron-dependent repressor +FIG01440643 GTP pyrophosphokinase( EC:2.7.6.5 ) +FIG01440654 FIG00417979: hypothetical protein +FIG01440659 FIG01239565: hypothetical protein +FIG01440661 FIG00271470: hypothetical protein +FIG01440712 FIG00452185: hypothetical protein +FIG01440727 FIG00388539: hypothetical protein +FIG01440749 putative permease protein, subunit of ABC transporter +FIG01440752 FIG01083931: hypothetical protein +FIG01440770 FIG00875260: hypothetical protein +FIG01440782 conventional protein tyrosine phosphatase +FIG01440789 FIG00410184: hypothetical protein +FIG01440791 putative sodium:solute symport protein +FIG01440802 FIG00624151: hypothetical protein +FIG01440806 FIG00767677: hypothetical protein +FIG01440815 FIG00743881: hypothetical protein +FIG01440846 Epf-like protein +FIG01440853 DeoR-type transcriptional regulator YihW +FIG01440933 FIG01239700: hypothetical protein +FIG01440936 FIG00408097: hypothetical protein +FIG01440938 FIG00629775: hypothetical protein +FIG01440939 type IV pilus assembly PilZ +FIG01440956 Small hydrophobic protein +FIG01440966 Two-component system response regulator protein +FIG01440967 FIG01114634: hypothetical protein +FIG01440978 8-OXOGUANINE DNA GLYCOSYLASE (EC 3.2.2.-) / DNA-(APURINIC OR APYRIMIDINIC SITE) LYASE (EC 4.2.99.18) +FIG01440989 FIG00390405: hypothetical protein +FIG01441007 choline sulfatase +FIG01441008 FIG00388882: hypothetical protein +FIG01441015 FIG00361456: hypothetical protein +FIG01441023 FIG00385726: hypothetical protein +FIG01441044 LSU ribosomal protein L33p +FIG01441050 hypothetical protein +FIG01441053 Possible Sema domain +FIG01441061 Gll1113 protein +FIG01441082 Daunorubicin resistance ATP-binding protein drrA +FIG01441083 FeoA family protein +FIG01441084 FIG00526906: hypothetical protein +FIG01441123 FIG00847863: hypothetical protein +FIG01441165 hypothetical protein +FIG01441174 Alkanesulfonates-binding protein BUT NOT +FIG01441182 syc0365_c +FIG01441197 FIG01085109: hypothetical protein +FIG01441199 FIG00624540: hypothetical protein +FIG01441211 Enoyl-CoA hydratase II 1 (EC 4.2.1.17) +FIG01441216 protein of unknown function DUF583 +FIG01441234 putative sarcosine oxidase +FIG01441235 ABC-type sulfate transport system, permease component +FIG01441236 B. burgdorferi predicted coding region BBA53 +FIG01441243 FIG00955292: hypothetical protein +FIG01441252 FIG00639042: hypothetical protein +FIG01441254 Argininosuccinate lyase like +FIG01441267 FIG01046466: hypothetical protein +FIG01441269 IS630 family transposase +FIG01441288 Domain of unknown function, putative +FIG01441291 D-octopine dehydrogenase (EC 1.5.1.11) +FIG01441306 Ribosomal protein S6 modification enzyme (glutaminyl transferase) related +FIG01441313 FIG00402998: hypothetical protein +FIG01441319 FIG00384889: hypothetical protein +FIG01441332 cell wall hydrolase SleB +FIG01441345 FIG00389812: hypothetical protein +FIG01441347 Ure cluster protein +FIG01441366 Probable cytochrome P450 4s3 (EC 1.14.-.-) (CYPIVS3) +FIG01441398 putative glutaredoxin-like protein +FIG01441410 Endoglucanase H precursor (EC 3.2.1.4) (EgH) (Endo-1,4-beta-glucanase H) (Cellulase H) +FIG01441430 HTH_3 family transcriptional regulator protein +FIG01441432 bacterial microcompartments family protein +FIG01441461 FIG00545626: hypothetical protein +FIG01441476 esterase EstC, putative +FIG01441508 Transcriptional activator protein phzR +FIG01441510 FIG00425886: hypothetical protein +FIG01441524 FIG00350371: hypothetical protein +FIG01441537 FIG00528697: hypothetical protein +FIG01441545 Uncharacterized protein MJ1492 +FIG01441551 FIG00624372: hypothetical protein +FIG01441570 Transmembrane transport protein MmpL6 +FIG01441581 FIG00409837: hypothetical protein +FIG01441584 Endo-1,3-1,4-beta-glycanase exsH (EC 3.2.1.-) (Succinoglycan biosynthesis protein exsH) +FIG01441619 FIG00734278: hypothetical protein +FIG01441624 FIG00711048: hypothetical protein +FIG01441632 Mll1641 protein +FIG01441650 FIG00349496: hypothetical protein +FIG01441659 FIG060329: hypothetical protein +FIG01441669 conserved hypothetical protein-putative acyltransferase +FIG01441677 FIG01240067: hypothetical protein +FIG01441698 isoflavone reductase +FIG01441699 B. burgdorferi predicted coding region BB0700 +FIG01441705 Uncharacterized conserved protein, YitT family protein +FIG01441738 short-chain dehydrogenase/reductase SDR( EC:1.1.1.269 ) +FIG01441748 FIG00624295: hypothetical protein +FIG01441789 Protein YjgL, putative CCAAT-box DNA binding protein subunit B +FIG01441791 Succinate-semialdehyde dehydrogenase (NAD(P)+) (EC 1.2.1.16) +FIG01441803 putative acetyltransferase +FIG01441821 putative oxidoreductase, oxygen dependent, FAD-dependent protein +FIG01441830 FIG00380680: hypothetical protein +FIG01441833 Metabolite MFS transporter +FIG01441839 possible serine protease homolog +FIG01441840 probable gluconolactonase precursor-hypothetical secreted or membrane associated protein +FIG01441861 Short-chain dehydrogenase/reductase +FIG01441865 Sll0051 protein +FIG01441877 FIG00744497: hypothetical protein +FIG01441886 Guanine-specific ribonuclease N1 and T1 precursor +FIG01441904 probable two-component sensor kinase +FIG01441931 Response regulator receiver:Transcriptional regulatory protein, C- terminal +FIG01441946 Putative DNA transposition protein +FIG01441959 nitrate ABC transporter, ATP-binding proteins NtrC +FIG01441963 FIG00426426: hypothetical protein +FIG01441975 FIG01253679: hypothetical protein +FIG01441977 flagellin-like protein +FIG01441978 ABC transporter, ATP-binding protein homolog +FIG01441995 FIG00471098: hypothetical protein +FIG01441998 Dipeptidyl anminopeptidase precursor +FIG01442003 pyruvate phosphate dikinase( EC:2.7.9.1 ) +FIG01442005 Predicted transcriptional regulators containing the CopG/Arc/MetJ DNA-binding domain +FIG01442009 FIG00640070: hypothetical protein +FIG01442017 FIG00408272: hypothetical protein +FIG01442052 Cysteate synthase +FIG01442100 Lmo0941 protein +FIG01442112 Tn916, hypothetical protein +FIG01442121 FIG00385543: hypothetical protein +FIG01442136 Di/tricarboxylate transporter +FIG01442141 FIG00764298: hypothetical protein +FIG01442154 Pectin lyase precursor (EC 4.2.2.10) +FIG01442173 FIG00762609: hypothetical protein +FIG01442189 Lytic transglycosylase catalytic +FIG01442261 Protein of unknown function DUF1469 +FIG01442266 FIG00622935: hypothetical protein +FIG01442289 D-aminopeptidase dipeptide-binding protein DppA (EC 3.4.11.-) +FIG01442293 cytosine deaminase( EC:3.5.4.1 ) +FIG01442299 Two-component system sensor histidine kinase/response regulator, hybrid +FIG01442303 widely conserved hypothetical protein +FIG01442304 Transcriptional regulator XdhR, TetR family +FIG01442312 Rare lipoprotein B +FIG01442330 Possible integrase-like protein +FIG01442361 FIG01240402: hypothetical protein +FIG01442375 FIG00769829: hypothetical protein +FIG01442395 FIG00534170: hypothetical protein +FIG01442411 PHOSPHOHYDROLASE (MUTT/NUDIX FAMILY PROTEIN) +FIG01442423 radical enzyme activating protein +FIG01442446 Heat shock protein, HSP20 family +FIG01442453 ThiF domain protein +FIG01442460 FIG00822091: hypothetical protein +FIG01442487 Putative LuxO repressor protein +FIG01442497 Uncharacterized protein YtfN +FIG01442498 FIG00687493: hypothetical protein +FIG01442504 FIG01022369: hypothetical protein +FIG01442552 SMS protein +FIG01442555 B. burgdorferi predicted coding region BB0595 +FIG01442579 probable ABC transporter (substrate-binding protein) +FIG01442585 FIG00848970: hypothetical protein +FIG01442590 FIG00406026: hypothetical protein +FIG01442605 TPR Domain protein +FIG01442662 Protein of unknown function DUF11:Surface protein from Gram-positive cocci, anchor region +FIG01442681 Extracytoplasmic thiamin (pyrophosphate?) binding lipoprotein p37, specific for Mycoplasma +FIG01442691 FIG00818786: hypothetical protein +FIG01442722 Mature parasite-infected erythrocyte surface antigen +FIG01442732 Serine/threonine protein kinase related protein +FIG01442758 putative mechanosensitive ion channel protein +FIG01442781 FIG00832291: hypothetical protein +FIG01442790 Putative MutT-family protein +FIG01442796 FIG00533697: hypothetical protein +FIG01442828 FIG00606117: hypothetical protein +FIG01442854 cartilage oligomeric matrix protein +FIG01442858 Structural protein P5 +FIG01442862 putative cholesterol oxidase +FIG01442876 Nuclease sbcCD subunit C +FIG01442882 predicted ATPase (AAA+ superfamily) +FIG01442890 FIG00352954: hypothetical protein +FIG01442917 FIG01195464: hypothetical protein +FIG01442924 acetyl xylan esterase A +FIG01442931 putative excinuclease ATPase subunit +FIG01442958 FIG00361526: hypothetical protein +FIG01442968 putative metal-dependent hydrolase +FIG01442969 putative prophage Hp1 family Holin +FIG01442984 Carbohydrate-selective porin OprB +FIG01442997 sigma-54 dependent transcriptional regulator, putative/response regulator +FIG01443002 putative phosphotriesterase-family protein +FIG01443016 FIG00529662: hypothetical protein +FIG01443017 L-malyl-CoA/beta-methylmalyl-CoA lyase (EC 4.1.3.24) +FIG01443019 putative tail fiber protein +FIG01443077 Threonine and homoserine efflux system +FIG01443080 Acyl CoA thioester hydrolase family protein +FIG01443081 Spore cortex-lytic enzyme pre-pro-form +FIG01443120 Lipase/acyltransferase (EC 2.3.1.-) +FIG01443130 putative spore cortex-lytic enzyme +FIG01443141 COG family: predicted transcriptional regulator +FIG01443147 FIG00561142: hypothetical protein +FIG01443173 FIG01214976: hypothetical protein +FIG01443178 2,4-dienoyl-CoA reductase [NADPH] (EC 1.3.1.34) +FIG01443180 Phage protein gp13 +FIG01443226 FIG00629515: hypothetical protein +FIG01443231 N-ethylammeline chlorohydrolase +FIG01443235 FIG00622816: hypothetical protein +FIG01443242 FIG00344254: hypothetical protein +FIG01443257 protein of unknown function DUF799 +FIG01443283 FIG00468655: hypothetical protein +FIG01443284 Integrase protein +FIG01443286 hypothetical protein +FIG01443297 Choloylglycine hydrolase (EC 3.5.1.24) +FIG01443302 putative MmcQ-like protein +FIG01443326 H+/gluconate symporter related permease +FIG01443344 glycoprotein/polysaccharide metabolism +FIG01443355 phage-related conserved hypothetical protein +FIG01443402 Sigma-54 dependent DNA-binding transcriptional regulator +FIG01443409 FIG00363942: hypothetical protein +FIG01443415 FIG01205630: hypothetical protein +FIG01443422 FIG00764357: hypothetical protein +FIG01443425 FIG00767092: hypothetical protein +FIG01443444 putative acyl-CoA synthetase +FIG01443452 FIG00641977: hypothetical protein +FIG01443465 FIG01232886: hypothetical protein +FIG01443468 FIG00350502: hypothetical protein +FIG01443469 FIG01180763: hypothetical protein +FIG01443478 conserved protein of unknown function (lipoprotein) +FIG01443517 sodium pump decarboxylase, gamma subunit +FIG01443529 Peptidoglycan-binding LysM +FIG01443540 Phytoene dehydrogenase and related proteins +FIG01443541 FIG00350464: hypothetical protein +FIG01443544 Putative periplasmic protein +FIG01443573 FIG01250895: hypothetical protein +FIG01443592 ErfK/YbiS/YcfS/YnhG family +FIG01443593 FIG01136062: hypothetical protein +FIG01443597 Nitrogen regulation protein ntrB (EC 2.7.13.3) +FIG01443599 FIG00424896: hypothetical protein +FIG01443604 acetyl-CoA hydrolase/transferase +FIG01443632 probable hexosyltransferase +FIG01443644 putative secreted tripeptidylaminopeptidase +FIG01443646 FIG00353828: hypothetical protein +FIG01443654 putative Galf transferase +FIG01443670 FIG00356379: hypothetical protein +FIG01443680 FIG00834167: hypothetical protein +FIG01443687 Phosphatidylglycerophosphate synthase +FIG01443708 FIG00763124: hypothetical protein +FIG01443725 probable extracellular protease [EC:3.4.24.-] +FIG01443741 Glycosyl transferase WecB/TagA/CpsF family (EC 2.4.1.-) +FIG01443752 FIG00353264: hypothetical protein +FIG01443764 PE_PGRS (wag22) +FIG01443783 glutamine amidotransferases, class-II +FIG01443801 sensor kinase citA VC0791 [imported], putative +FIG01443826 Bacteriophage phi 1.45 protein-like protein +FIG01443829 Salmonella enterica serovar Choleraesuis 50k virulence plasmid DNA, complete sequence +FIG01443833 FIG00424397: hypothetical protein +FIG01443835 FIG00344455: hypothetical protein +FIG01443838 Ferric vibriobactin, enterobactin transport system, permease protein VctG (TC 3.A.1.14.6) +FIG01443840 dihydroorotase +FIG01443859 FIG00768620: hypothetical protein +FIG01443864 Protein of unknown function DUF664 +FIG01443877 Quinolone resistance protein NorA +FIG01443886 Maltose/maltodextrin transport ATP-binding protein MalK (EC 3.6.3.19) +FIG01443888 pXO1-10 +FIG01443897 FIG01221250: hypothetical protein +FIG01443898 syc2207_c +FIG01443905 Allophanate hydrolase subunit 1 (EC 3.5.1.54) +FIG01443935 Hypothetical protein, CF-10 family +FIG01443962 FIG00426279: hypothetical protein +FIG01443964 ChaX protein +FIG01443969 FIG00762565: hypothetical protein +FIG01444010 Mlr6550 protein +FIG01444013 Sigma-54 dependent transcriptional regulator/response regulator +FIG01444061 ortholog of Bordetella pertussis (BX470248) BP1188A +FIG01444067 FIG00405933: hypothetical protein +FIG01444069 Uncharacterized conserved protein, YQXD B.subtilis ortholog +FIG01444072 FIG00643724: hypothetical protein +FIG01444100 Cation transporting ATPase, N-terminal:Haloacid dehalogenase-like hydrolase:Cation transporting ATPase, C-terminal:E1-E2 ATPase- associated region +FIG01444109 gas vesicle protein, GvpA family +FIG01444159 sporulation protein; SpoIID +FIG01444164 TPR-repeat-containing protein; Cell-adhesion domain +FIG01444176 Pyruvate/2-oxoglutarate dehydrogenase complex, dehydrogenase (E1) component, eukaryotic type, beta subunit +FIG01444187 FIG01070805: hypothetical protein +FIG01444192 hns-dependent expression protein A (HdeA) +FIG01444197 FIG007317: Chromosome segregation protein SMC-like +FIG01444203 Transcriptional activator nprA +FIG01444232 FIG00403097: hypothetical protein +FIG01444238 Putative integrase of prophage CP-933X +FIG01444242 MGA_0931; [M] COG0510 Predicted choline kinase involved in LPS biosynthesis; pfam01636 Phosphotransferase enzyme family; MGR_183 +FIG01444279 Signal peptide peptidase SppA, 36K type (EC 3.4.-.-) +FIG01444289 FIG00754394: hypothetical protein +FIG01444290 glycine betaine/proline ABC transporter, periplasmic substrate-binding protein +FIG01444293 Probable disulfide formation protein +FIG01444302 FIG00846708: hypothetical protein +FIG01444315 Roadblock/LC7 protein +FIG01444316 FIG01242067: hypothetical protein +FIG01444327 HAD-superfamily subfamily IB, PSPase-like +FIG01444368 Protease lasA precursor (EC 3.4.24.-) +FIG01444373 FIG00848714: hypothetical protein +FIG01444386 mRNA-binding protein +FIG01444395 Protein of unknown function DUF1971 +FIG01444416 FIG00953732: hypothetical protein +FIG01444423 conserved hypothetical membrane protein +FIG01444425 FIG01166032: hypothetical protein +FIG01444452 Ribonuclease domain protein +FIG01444476 putative poly A polymerase +FIG01444495 Mycolyl transferase (EC 2.3.1.-), Antigen 85 complex C +FIG01444496 311aa long hypothetical NAD-dependent alcohol dehydrogenase +FIG01444507 FIG00402975: hypothetical protein +FIG01444512 putative glucose dehydrogenase precursor( EC:1.1.- ) +FIG01444540 putative signalling component +FIG01444565 FIG00414211: hypothetical protein +FIG01444568 FIG00385488: hypothetical protein +FIG01444572 FIG00412960: hypothetical protein +FIG01444578 FIG00766519: hypothetical protein +FIG01444603 FIG00534405: hypothetical protein +FIG01444609 FIG00669707: hypothetical protein +FIG01444648 Transcriptional regulator, CopG family +FIG01444652 LidA protein, substrate of the Dot/Icm system +FIG01444665 CsfB +FIG01444666 putative Na+/H+ antiporter, CPA2 family +FIG01444678 hypothetical protein +FIG01444682 FIG00824664: hypothetical protein +FIG01444694 FIG00765870: hypothetical protein +FIG01444717 putative DNA primase/helicase +FIG01444720 Branched-chain amino acid binding protein +FIG01444722 Uncharacterized protein MJ1110 +FIG01444728 FIG00673562: hypothetical protein +FIG01444734 transporter accessory protein, putative +FIG01444738 Cytochrome oxidase subunit 1 (EC 1.9.3.1) +FIG01444739 AMP-binding enzyme domain protein +FIG01444774 FIG01241489: hypothetical protein +FIG01444785 FIG00356707: hypothetical protein +FIG01444788 putative (R)-specific enoyl-CoA hydratase +FIG01444793 Putative exported protein. precursor +FIG01444795 DNA helicase, phage-associated; Type III restriction enzme +FIG01444808 BcrR +FIG01444816 no significant homology. 4 putative transmembrane regions were found by PSORT. +FIG01444822 COG1514: 2'-5' RNA ligase +FIG01444852 FIG00388800: hypothetical protein +FIG01444853 putative YCII-related domain protein +FIG01444872 Predicted hydrolase from alpha/beta family, YQKD B.subtilis ortholog +FIG01444888 FIG00349722: hypothetical protein +FIG01444904 FIG00645318: hypothetical protein +FIG01444927 putative transposase +FIG01444929 FIG00520941: hypothetical protein +FIG01444931 Endoglucanase C (EC 3.2.1.4) (EgC) (Endo-1,4-beta-glucanase C) (Cellulase C) +FIG01444938 FIG01229591: hypothetical protein +FIG01444953 FIG00764148: hypothetical protein +FIG01444955 putative sensor protein +FIG01444958 FIG00344623: hypothetical protein +FIG01444961 FIG047698: hypothetical protein, Rv1744c +FIG01444990 Protein of unknown function DUF736 +FIG01445023 FIG00628946: hypothetical protein +FIG01445025 FIG00631921: hypothetical protein +FIG01445039 FIG01037144: hypothetical protein +FIG01445051 FIG00629246: hypothetical protein +FIG01445064 FIG00412133: hypothetical protein +FIG01445066 Carboxyl esterase, a/b hydrolase +FIG01445068 FIG00765057: hypothetical protein +FIG01445074 FIG00418272: hypothetical protein +FIG01445075 FIG00517357: hypothetical protein +FIG01445100 FIG00624105: hypothetical protein +FIG01445108 Alpha-amylase( EC:3.2.1.1 ) +FIG01445112 GTPases - Sulfate adenylate transferase subunit 1 +FIG01445146 putative component of cation transport for cbb3-type oxidase +FIG01445153 Bacterial outer membrane protein +FIG01445191 200 kDa antigen p200 +FIG01445194 FIG00385201: hypothetical protein +FIG01445202 FIG00715790: hypothetical protein +FIG01445211 FIG00348203: hypothetical protein +FIG01445226 hypothetical protein +FIG01445238 FIG00518470: hypothetical protein +FIG01445239 Major surface protein 2 +FIG01445245 Phage related protein, YonJ B.subtilis homolog +FIG01445267 putative signal transduction histidine kinase with PAS/PAC domains +FIG01445268 FIG00529827: hypothetical protein +FIG01445282 FIG00385153: hypothetical protein +FIG01445284 FIG01241678: hypothetical protein +FIG01445287 FIG00642644: hypothetical protein +FIG01445293 Acetyltransferase, GNAT family, putative +FIG01445299 FIG00897698: hypothetical protein +FIG01445323 transmembrane signal peptide protein +FIG01445325 Oxidoreductase dehydrogenase, short chain +FIG01445330 FIG01241736: hypothetical protein +FIG01445333 ferric uptake regulator, Fur family +FIG01445337 glutamate-ammonia ligase +FIG01445338 putative branched-chain amino acid-binding protein +FIG01445339 FIG00381017: hypothetical protein +FIG01445352 Hypothertical protein, coexpressed with pyoverdine biosynthesis regulon +FIG01445353 putative mannose-resistant/Proteus-like fimbrial protein +FIG01445365 hypothetical protein +FIG01445375 late embryogenesis abundant family protein / LEA family protein / similar to ethylene-responsive late embryogenesis-like protein [Lycopersicon esculentum] GI:1684830; contains Pfam profile PF03168: Late embryogenesis abundant protein; go_process: response to dessication [goid 0009269]; go_process: embryonic development (sensu Magnoliophyta) [goid 0009793] +FIG01445390 Possible ABC transport system periplasmic substrate-binding protein +FIG01445391 mannan endo-1,4-beta-mannosidase +FIG01445392 Serine/threonine-protein kinase Pkn1 (EC 2.7.11.1) +FIG01445396 FIG01234963: hypothetical protein +FIG01445409 COG1051: ADP-ribose pyrophosphatase +FIG01445429 FIG00640250: hypothetical protein +FIG01445472 hypothetical protein +FIG01445488 FIG00847030: hypothetical protein +FIG01445499 FIG01131951: hypothetical protein +FIG01445509 FIG00347779: hypothetical protein +FIG01445518 Protease precursor +FIG01445524 Nucleotidyl transferase/aminotransferase, class V +FIG01445541 COG5562: Phage envelope protein +FIG01445542 Propionyl-CoA:succinyl-CoA transferase +FIG01445545 coenzyme PQQ synthesis protein E +FIG01445556 FIG00514770: hypothetical protein +FIG01445559 hypothetical protein +FIG01445579 FIG00385515: hypothetical protein +FIG01445585 Glutamine cyclotransferase +FIG01445602 PTS system, cellobiose-specific IIC component +FIG01445617 Probable serine peptidase (U7 family) protein +FIG01445652 putative NDP-hexose methyltransferase protein +FIG01445657 fog:tpr repeat protein +FIG01445660 FIG00356600: hypothetical protein +FIG01445661 putative glucan-binding protein D; BglB-like protein +FIG01445669 FIG00344495: hypothetical protein +FIG01445676 putative C-type natriuretic protein +FIG01445706 DNA integration/recombination protein +FIG01445713 integral membrane protein-like protein +FIG01445720 FIG00425238: hypothetical protein +FIG01445744 FIG00763097: hypothetical protein +FIG01445752 hypothetical protein +FIG01445758 FIG00766606: hypothetical protein +FIG01445782 Coenzyme F420-reducing hydrogenase related protein +FIG01445826 hypothetical protein +FIG01445828 FIG01237641: hypothetical protein +FIG01445834 putative IS6 family transposase +FIG01445836 FIG00688280: hypothetical protein +FIG01445859 FIG00765665: hypothetical protein +FIG01445867 dihydrolipoamide acyltransferase +FIG01445913 putative outer membrane lipoprotein Pcp +FIG01445919 major facilitator superfamily permease +FIG01445986 FIG00404774: hypothetical protein +FIG01446008 Nodulin 21-related protein +FIG01446031 FIG00944042: hypothetical protein +FIG01446035 FIG00344742: hypothetical protein +FIG01446044 Mlr7179 protein +FIG01446057 methanol dehydrogenase regulatory protein +FIG01446078 Divergent AAA region +FIG01446100 FIG00405116: hypothetical protein +FIG01446183 FIG00349625: hypothetical protein +FIG01446187 FIG017415: ydiI hotdog fold superfamily +FIG01446234 Omp2b, porin +FIG01446239 Cyanophycin synthetase (EC 6.-.-.-) +FIG01446269 IS6120, transposase +FIG01446289 FIG00954730: hypothetical protein +FIG01446297 FIG00348303: hypothetical protein +FIG01446317 Signal-transduction and transcriptional-control protein +FIG01446329 FIG00385199: hypothetical protein +FIG01446346 Aldo/keto reductases, related to diketogulonate reductase +FIG01446357 FIG00515984: hypothetical protein +FIG01446397 glycosyl transferase family 2 +FIG01446406 Replication regulatory protein repA2 +FIG01446419 Putative ESAT-6 like protein 11 +FIG01446428 ABC-type transport system,membrane ATPase component +FIG01446459 RNA polymerase sigma factor, ECF subfamily +FIG01446462 FIG00380500: hypothetical protein +FIG01446464 ATP-dependent protease La +FIG01446487 FIG00955967: hypothetical protein +FIG01446529 FIG01126864: hypothetical protein +FIG01446531 FIG00734353: hypothetical protein +FIG01446540 FIG00424325: hypothetical protein +FIG01446552 Membrane spanning protein, GtrA-family +FIG01446558 putative DNA topology modulation FlaR protein +FIG01446561 Oligopeptide transporter, OPT family +FIG01446586 putative PTS IIA-like nitrogen-regulatory protein PtsN +FIG01446607 FIG01134282: hypothetical protein +FIG01446608 FIG099973: hypothetical protein +FIG01446620 Putative sodium-dependent transporter +FIG01446622 microcompartment protein +FIG01446636 FIG00424999: hypothetical protein +FIG01446640 Osmotically inducible protein Y +FIG01446641 conserved hypothetical protein with relaxase/mobilization nuclease domain +FIG01446648 Bacteriophage-type DNA helicase +FIG01446650 FIG01103153: hypothetical protein +FIG01446654 FIG00351766: hypothetical protein +FIG01446667 hypothetical protein +FIG01446686 invasion-associated secreted protein. +FIG01446705 Galactoside O-acetyltransferase (EC 2.3.1.18) +FIG01446756 FIG00624595: hypothetical protein +FIG01446773 5,10-methylenetetrahydromethanopterin reductase (EC 1.5.99.11) (Coenzyme F420-dependent N(5),N(10)-methylenetetrahydromethanopterin reductase) (Methylene-H(4)MPT reductase) +FIG01446776 Predicted signaling protein consisting of a modified GGDEF domain and a DHH domain +FIG01446817 putative preprotein translocase YajC subunit +FIG01446818 FIG00917859: hypothetical protein +FIG01446831 FIG00912888: hypothetical protein +FIG01446839 FIG00847349: hypothetical protein +FIG01446851 Superfamily I DNA helicase +FIG01446860 FIG00624779: hypothetical protein +FIG01446880 Probable Ferredoxin FdxD +FIG01446895 Manganese-binding protein +FIG01446910 Putative Tic22 +FIG01446921 N-ACETYLGLUCOSAMINE KINASE( EC:2.7.1.59 ) +FIG01446927 Fibronectin-binding protein SFS +FIG01446991 CDS_ID OB3334 +FIG01446993 SdbB protein +FIG01447009 ferritin 1 +FIG01447031 FIG00352009: hypothetical protein +FIG01447044 hypothetical protein SCD39.11 +FIG01447072 FIG01242465: hypothetical protein +FIG01447078 FIG00407362: hypothetical protein +FIG01447103 Lipoprotein LppN +FIG01447108 putative transcriptional regulator, ModE family +FIG01447110 membrane-bound lytic murein transglycosylase C +FIG01447111 FIG00361587: hypothetical protein +FIG01447117 FIG01203543: hypothetical protein +FIG01447118 FIG00406605: hypothetical protein +FIG01447131 Possible Rhomboid family protein +FIG01447154 FIG00986753: hypothetical protein +FIG01447164 Uncharacterized protein AF_2041 +FIG01447179 Sensor histidine kinase mtrB (EC 2.7.3.-) +FIG01447186 Surface polysaccharide biosynthesis protein, transferase +FIG01447196 FIG00537670: hypothetical protein +FIG01447205 FIG00768683: hypothetical protein +FIG01447209 integrase, putative +FIG01447220 FIG00242816: hypothetical protein +FIG01447225 ORF_5; potential multiple membrane spanning domains. +FIG01447237 FIG00469114: hypothetical protein +FIG01447250 GumL protein +FIG01447254 leader peptidase (prepilin peptidase) / N-methyltransferase [EC:3.4.23.43 2.1.1.-] +FIG01447256 FIG01242536: hypothetical protein +FIG01447267 FIG00674736: hypothetical protein +FIG01447268 FIG061213: hypothetical protein +FIG01447271 FIG01129941: hypothetical protein +FIG01447286 ferrous ion transport protein, putative +FIG01447298 5-oxoprolinase (EC 3.5.2.9) +FIG01447316 Periplasmic sugar-binding domain protein +FIG01447317 flocculin repeat domain +FIG01447326 ABC transporter for amino acids, ATP binding component +FIG01447330 FIG00712340: hypothetical protein +FIG01447350 FIG00520713: hypothetical protein +FIG01447404 FIG00425372: hypothetical protein +FIG01447414 Predicted membrane protein; CF-20 family +FIG01447449 FIG00518699: hypothetical protein +FIG01447492 Preprotein translocase subunit-like protein +FIG01447497 probable O-linked GlcNAc transferase-putative TPR-containing transmembrane protein +FIG01447504 COG0442: Prolyl-tRNA synthetase +FIG01447512 SOS responce UmuC protein +FIG01447515 L-asparaginase II +FIG01447517 FIG00774947: hypothetical protein +FIG01447548 FIG00351946: hypothetical protein +FIG01447551 gamma-tocopherol methyltransferase (EC 2.1.1.95) +FIG01447566 FIG00764733: hypothetical protein +FIG01447581 FIG00424756: hypothetical protein +FIG01447584 surface protein-related protein +FIG01447586 hypothetical protein +FIG01447596 FIG00817394: hypothetical protein +FIG01447620 N-acyl-D-aspartate deacylase (EC 3.5.1.83) (N-acyl-D-aspartate amidohydrolase) +FIG01447658 Glycosyltransferase, family 4 +FIG01447710 LPS biosynthesis O-acetyl transferase +FIG01447713 FIG00350552: hypothetical protein +FIG01447740 FIG00622863: hypothetical protein +FIG01447746 FIG00425206: hypothetical protein +FIG01447754 hypothetical protein +FIG01447763 Uncharacterized lipoprotein TP_0839 precursor +FIG01447766 FIG00847473: hypothetical protein +FIG01447770 FIG00519420: hypothetical protein +FIG01447793 phage-related baseplate assembly protein +FIG01447795 Cytochrome b561 +FIG01447799 FIG00467471: hypothetical protein +FIG01447891 Mll3172 protein +FIG01447907 FIG00385371: hypothetical protein +FIG01447914 FIG00351215: hypothetical protein +FIG01447923 proline-rich 28 kDa antigen +FIG01447955 FIG00641350: hypothetical protein +FIG01447963 FIG01005449: hypothetical protein +FIG01447971 multidrug efflux transporter transcriptional regulatory protein +FIG01447983 transcriptional activator +FIG01447986 Arginase/agmatinase/formimionoglutamate hydrolase +FIG01447990 acetyl transferase GNAT family +FIG01448041 FIG01229301: hypothetical protein +FIG01448042 hypothetical alanine rich protein +FIG01448045 HemK family modification methylase PA2179 +FIG01448046 FIG00641119: hypothetical protein +FIG01448051 FIG01116759: hypothetical protein +FIG01448083 probable chromate transport protein, putative +FIG01448100 hypothetical protein +FIG01448110 Transmembrane transport protein MmpL4 +FIG01448118 Capsular polysaccharide synthesis enzyme CpsI, glycosyltransferase +FIG01448129 Cytochrome c family protein precursor +FIG01448131 methionine sulfoxide reductase A +FIG01448148 probable porin +FIG01448169 Pseudouridylate synthases 23S RNA-specific +FIG01448180 FIG00746052: hypothetical protein +FIG01448182 FIG00351709: hypothetical protein +FIG01448190 FIG01166730: hypothetical protein +FIG01448249 IS605 transposase (tnpA) +FIG01448257 FIG00451396: hypothetical protein +FIG01448262 branched-chain amino acid transport system permease +FIG01448273 FIG00764293: hypothetical protein +FIG01448284 FIG00699498: hypothetical protein +FIG01448288 GGDEF/response regulator receiver domain protein +FIG01448292 ORF_ID:asr7542 unknown protein +FIG01448300 surface layer protein, (pXO1-54) +FIG01448309 FIG01143526: hypothetical protein +FIG01448336 FIG002003: Protein YdjA +FIG01448384 Multiple sugar transport system permease protein +FIG01448401 FIG00623819: hypothetical protein +FIG01448404 FIG00468474: hypothetical protein +FIG01448408 FIG00837335: hypothetical protein +FIG01448416 Molybdenum cofactor biosynthesis protein MoaD +FIG01448419 beta-lactam resistance protein +FIG01448435 putative ATP/GTP-binding protein, doubtful CDS +FIG01448446 Oligopeptide ABC transporter, ATP-binding protein +FIG01448452 FIG01113955: hypothetical protein +FIG01448453 FIG00643650: hypothetical protein +FIG01448454 FIG01118498: hypothetical protein +FIG01448478 FIG00350424: hypothetical protein +FIG01448486 hypothetical protein +FIG01448501 hypothetical protein +FIG01448513 FIG00385189: hypothetical protein +FIG01448543 transcriptional regulator domain protein +FIG01448570 predicted sugar phosphatase of the HAD superfamily +FIG01448584 FIG00350659: hypothetical protein +FIG01448600 FIG00433286: hypothetical protein +FIG01448619 FIG00747813: hypothetical protein +FIG01448628 Transcriptional regulator, AsnC family +FIG01448634 Uncharacterized protein MJ0678 +FIG01448644 FIG01221494: hypothetical protein +FIG01448648 FIG00767259: hypothetical protein +FIG01448652 FIG00361672: hypothetical protein +FIG01448667 bacteriocin transport accessory protein, putative +FIG01448694 Glucose oligosaccharide ABC transport system, ATP-binding protein 1 +FIG01448727 Uncharacterized 25.9 kDa protein in CS5 3'region precursor +FIG01448746 FIG00348484: hypothetical protein +FIG01448755 FIG01204250: hypothetical protein +FIG01448793 FIG00830361: hypothetical protein +FIG01448802 translocator protein, LysE family +FIG01448841 macrolide glycosyltransferase +FIG01448846 methyl-accepting chemotaxis protein (tlpB), putative +FIG01448849 FIG01194862: hypothetical protein +FIG01448852 COG3415: Transposase and inactivated derivatives +FIG01448861 Msl2237 protein +FIG01448874 probable peptidoglycan binding protein +FIG01448890 Predicted beta-xyloside ABC transporter, substrate-binding component +FIG01448899 cytochrome P450 CYP136( EC:1.14.13.70 ) +FIG01448906 ORF_ID:all7578 unknown protein +FIG01448914 hypothetical protein; putative conserved domain +FIG01448939 hypothetical protein +FIG01448943 FIG00353010: hypothetical protein +FIG01448946 Mll4891 protein +FIG01448958 FIG00624169: hypothetical protein +FIG01448967 Qnr +FIG01448976 FIG00660473: hypothetical protein +FIG01449031 blr6231; hypothetical protein +FIG01449036 ABC-2 transporter, permease protein, putative +FIG01449087 plasmid pRiA4b ORF-3-like +FIG01449103 FIG00352470: hypothetical protein +FIG01449123 FIG00945969: hypothetical protein +FIG01449134 FIG00349205: hypothetical protein +FIG01449149 FIG01031993: hypothetical protein +FIG01449178 FIG00425379: hypothetical protein +FIG01449207 FIG00344636: hypothetical protein +FIG01449217 ferredoxin-like protein +FIG01449233 Lj928 prophage replication protein +FIG01449237 FIG00767701: hypothetical protein +FIG01449243 FIG00406883: hypothetical protein +FIG01449260 FIG00405994: hypothetical protein +FIG01449274 Bll5088 protein +FIG01449286 hypothetical protein, phage associated +FIG01449291 FIG00522222: hypothetical protein +FIG01449301 sulfate permease (SulP) +FIG01449304 putative phospholipase +FIG01449308 type IV pilus secretin PilQ +FIG01449314 FIG00388130: hypothetical protein +FIG01449338 FIG01201356: hypothetical protein +FIG01449343 CymJ protein +FIG01449345 FIG00763223: hypothetical protein +FIG01449354 FIG01150927: hypothetical protein +FIG01449366 P. aerophilum family 577 protein +FIG01449381 Putative HTH-type transcriptional regulator ywaE +FIG01449382 FIG01228554: hypothetical protein +FIG01449388 FIG00348512: hypothetical protein +FIG01449437 FIG01201558: hypothetical protein +FIG01449439 FIG00898503: hypothetical protein +FIG01449448 putative ATPase +FIG01449452 OmpA-like transmembrane domain +FIG01449466 FIG00390397: hypothetical protein +FIG01449467 zinc-finger protein +FIG01449505 hypothetical protein +FIG01449521 FIG00469196: hypothetical protein +FIG01449534 Polysaccharide ABC transporter, ATP binding protein +FIG01449537 hypothetical protein +FIG01449541 FIG00411245: hypothetical protein +FIG01449595 FIG00734185: hypothetical protein +FIG01449604 Bll2871 protein +FIG01449616 FIG00362154: hypothetical protein +FIG01449631 putative permease protein +FIG01449723 ISMsm4, transposase +FIG01449730 FIG00622791: hypothetical protein +FIG01449731 FIG01228874: hypothetical protein +FIG01449732 FIG00622773: hypothetical protein +FIG01449755 capsular synthesis regulator component B, putative +FIG01449761 putative amino acid-binding periplasmic protein +FIG01449765 FIG00528060: hypothetical protein +FIG01449767 FIG00623564: hypothetical protein +FIG01449774 Na/H antiporter +FIG01449778 amino acid ABC transporter, amino acid-binding protein/permease protein, His/Glu/Gln/Arg/opine family +FIG01449783 putative permease (MFS superfamily) +FIG01449786 Patatin family protein +FIG01449796 Putative exported protein +FIG01449813 similar to mKIAA0378 protein +FIG01449830 CpmD protein involved in carbapenem biosynthesis +FIG01449832 protein of unknown function UPF0261 +FIG01449834 quaternary ammonium compound-resistance protein +FIG01449852 40-residue YVTN beta-propeller repeat protein +FIG01449877 FIG00426696: hypothetical protein +FIG01449894 FIG00645042: hypothetical protein +FIG01449903 Small heat shock protein HspC2 +FIG01449908 putative glycosyl hydrolase, family 43 +FIG01449909 FIG00403655: hypothetical protein +FIG01449913 predicted glycosyl transferase +FIG01449915 FIG00385489: hypothetical protein +FIG01449923 putative resolvase +FIG01449932 FIG00774977: hypothetical protein +FIG01449938 Cytochrome P-450:NADPH-P-450 reductase +FIG01449950 retron reverse transcriptase +FIG01449953 FIG00471895: hypothetical protein +FIG01450007 endo-beta-N-acetylglucosaminidase F1 precursor +FIG01450058 conserved protein YyaQ +FIG01450090 Polymerase epsilon subunit +FIG01450102 putative acyl carrier protein +FIG01450119 putative membrane protein TraJ +FIG01450128 ortholog of Bordetella pertussis (BX470248) BP3819 +FIG01450130 FIG00696772: hypothetical protein +FIG01450158 small protein A +FIG01450166 ana29 +FIG01450198 probable peptide synthase +FIG01450204 FIG00745953: hypothetical protein +FIG01450231 FIG00644703: hypothetical protein +FIG01450240 Transposase +FIG01450243 probable transcription regulator, MerR family +FIG01450281 major capsid protein, HK97 family +FIG01450305 MloA protein, putative +FIG01450336 Peptide methionine sulfoxide reductase +FIG01450338 Predicted Fe-S oxidoreductase +FIG01450363 FIG00767122: hypothetical protein +FIG01450377 FIG00412200: hypothetical protein +FIG01450379 Putative metabolite transport protein yaaU +FIG01450391 Predicted protein family PM-11 +FIG01450424 FIG00384860: hypothetical protein +FIG01450425 FIG00513157: hypothetical protein +FIG01450440 FIG00627214: hypothetical protein +FIG01450454 Putative sugar ABC transport system, substrate-binding protein +FIG01450480 CoB--CoM-reducing hydrogenase (Cys) alpha subunit +FIG01450494 Lipopolysaccharide core biosynthesis protein LpsA +FIG01450503 FIG00764215: hypothetical protein +FIG01450538 YdfG +FIG01450543 FIG01205351: hypothetical protein +FIG01450551 Asl3112 protein +FIG01450567 phenylacetic acid degradation protein +FIG01450576 Methylcobalamin:coenzyme M methyltransferase, methylamine-specific +FIG01450577 Brp-like protein-like +FIG01450593 FIG01118132: hypothetical protein +FIG01450594 similar to Capsular polysaccharide biosynthesis protein +FIG01450612 hypothetical protein +FIG01450645 Alpha-amylase precursor (EC 3.2.1.1) +FIG01450654 AAA superfamily ATPase +FIG01450659 Sporulation cortex protein coxA +FIG01450707 FIG00412494: hypothetical protein +FIG01450730 Basic proline-rich protein precursor +FIG01450733 Cytochrome c-552 precursor (Cytochrome c552) +FIG01450741 lacI-family transcriptional regulator +FIG01450753 FIG01191956: hypothetical protein +FIG01450762 Sll0647 protein +FIG01450796 FIG00769932: hypothetical protein +FIG01450817 coenzyme F420 hydrogenase domain protein +FIG01450863 FIG00384880: hypothetical protein +FIG01450883 multidomain protein with s-layer homology region, glug motif, ig motif, i-set domain +FIG01450919 DNA-binding response regulator LytR +FIG01450935 Uncharacterized protein Rv0093c/MT0102 +FIG01450936 Slr0489 protein +FIG01450958 FIG00871622: hypothetical protein +FIG01450966 FIG00517955: hypothetical protein +FIG01450969 FIG00961846: hypothetical protein +FIG01450975 Protein ybiS precursor +FIG01450978 FIG01118286: hypothetical protein +FIG01451008 Uncharacterized protein yoaW +FIG01451038 ABC-type phosphate transport system periplasmic component-like protein +FIG01451039 Oxidoreductase, 2OG-Fe(II) oxygenase family +FIG01451049 FIG00385408: hypothetical protein +FIG01451065 Dienelactone hydrolase +FIG01451073 ORF_ID:alr7580 unknown protein +FIG01451081 FIG00412175: hypothetical protein +FIG01451092 FIG00633282: hypothetical protein +FIG01451118 Putative acetyl-CoA synthetase +FIG01451120 FIG00687689: hypothetical protein +FIG01451124 Unknown, probable toxin +FIG01451126 FIG00834289: hypothetical protein +FIG01451150 FIG00733684: hypothetical protein +FIG01451163 N5,N10-methylenetetrahydromethanopterin reductase homolog +FIG01451177 FIG00799041: hypothetical protein +FIG01451180 Putative membrane GGDEF domain involved in signal transduction +FIG01451187 hypothetical protein +FIG01451189 nitrate reductase associated protein +FIG01451238 FIG00631204: hypothetical protein +FIG01451256 Mobilization protein BmpH +FIG01451286 FIG00514478: hypothetical protein +FIG01451302 FIG00947428: hypothetical protein +FIG01451337 Putative hemagglutinin protein +FIG01451342 Uncharacterized protein Rv0940c/MT0967 +FIG01451346 FIG066418: Hypothetical protein +FIG01451376 FIG00522505: hypothetical protein +FIG01451387 FIG00349311: hypothetical protein +FIG01451392 Predicted membrane protein; CF-9 family +FIG01451403 putative mut-like protein +FIG01451409 Putative molybdopterin cofactor synthesis protein A +FIG01451418 FIG00765783: hypothetical protein +FIG01451419 TelA-like protein associated with cryptic tellurite resistance +FIG01451422 FIG00525353: hypothetical protein +FIG01451433 Coenzyme F390 synthetase-like protein +FIG01451447 FIG00763705: hypothetical protein +FIG01451455 regulatory protein GntR, HTH +FIG01451461 hypothetical protein +FIG01451463 Uncharacterized protein MJ0607 +FIG01451475 Probable aminopeptidase +FIG01451485 putaive immunity repressor protein - phage associated +FIG01451514 RNA polymerase III transcription initiation factor B'' +FIG01451553 NADPH-dependent fmn reductase +FIG01451562 FIG00385374: hypothetical protein +FIG01451588 FIG00639213: hypothetical protein +FIG01451596 Permease of the drug/metabolite transporter, DMT superfamily +FIG01451603 transposition protein, putative +FIG01451608 FIG00361396: hypothetical protein +FIG01451610 C protein +FIG01451645 serine/threonine kinase with WD-40 repeat +FIG01451648 FIG00387958: hypothetical protein +FIG01451661 putative sialidase +FIG01451670 AnkB protein +FIG01451699 Protein of unknown function DUF72 +FIG01451709 Pectin lyase like protein +FIG01451711 Tll2024 protein +FIG01451712 Aldehyde dehydrogenase (EC 1.2.1.8) +FIG01451715 Complete genome; segment 5/5 precursor +FIG01451729 sigma-24 (FecI-like) protein +FIG01451738 InterPro IPR002656 COGs COG1835 +FIG01451753 DNA damage-responsive protein, expression is increased in response to heat-shock stress or treatments that produce DNA lesions; contains multiple repeats of the amino acid sequence NNNDSYGS +FIG01451756 putative Metapyrocatechase (MPC) (CatO2ase) (Catechol 2,3- dioxygenase)( EC:1.13.11.2 ) +FIG01451772 Putative oxidoreductase protein +FIG01451798 tetratricopeptide repeat domain protein +FIG01451806 Diacyglycerol O-acyltransferase (EC 2.3.1.20) +FIG01451815 hypothetical protein +FIG01451829 fumarate reductase/succinate dehydrogenase flavoprotein-like protein +FIG01451831 conserved hypothetical protein; putative signal peptide +FIG01451861 FIG00388258: hypothetical protein +FIG01451890 hypothetical protein TTE2374 +FIG01451900 GLYCEROL-3-PHOSPHATE-BINDING PERIPLASMIC PROTEIN +FIG01451908 SsrA-binding protein +FIG01451910 cellulase( EC:3.2.1.4 ) +FIG01451916 Phage head-tail adapter +FIG01451919 Multidrug-efflux transporter 2 regulator +FIG01451954 corresponds to STY4589 from Accession AL513382: Salmonella typhi CT18 +FIG01451982 ACT domain-containing protein +FIG01451984 Ceramide glucosyltransferase( EC:2.4.1.80 ) +FIG01452005 FIG00413708: hypothetical protein +FIG01452009 FIG00841068: hypothetical protein +FIG01452010 FIG01235096: hypothetical protein +FIG01452025 FIG01037687: hypothetical protein +FIG01452087 ORF_ID:alr7568 unknown protein +FIG01452116 Response regulator containing CheY-like receiver and SARP domains +FIG01452139 FIG00630697: hypothetical protein +FIG01452165 putative multidrug efflux transporter +FIG01452167 FIG00412750: hypothetical protein +FIG01452200 FIG00405232: hypothetical protein +FIG01452212 FIG00845977: hypothetical protein +FIG01452213 FIG00966810: hypothetical protein +FIG01452230 ABC transporter, quaternary amine uptake transporter (QAT) family, permease/periplasmic amine-binding protein +FIG01452234 FIG00631435: hypothetical protein +FIG01452245 alpha-L-arabinofuranosidase( EC:3.2.1.55 ) +FIG01452260 FIG01129639: hypothetical protein +FIG01452269 FIG00763803: hypothetical protein +FIG01452284 FIG00817826: hypothetical protein +FIG01452287 Oar protein +FIG01452290 putative glycosyl transferase family 2/4 protein +FIG01452294 Peptidase S8 and S53, subtilisin, kexin, sedolisin +FIG01452355 bsr3854; hypothetical protein +FIG01452362 FIG00349255: hypothetical protein +FIG01452370 FIG00766947: hypothetical protein +FIG01452382 FIG00351294: hypothetical protein +FIG01452402 NADH dehydrogenase( EC:1.6.99.3 ) +FIG01452403 Streptopain inhibitor +FIG01452408 FIG01198445: hypothetical protein +FIG01452413 (R)-2-hydroxyglutaryl-CoA dehydratase activator-related protein +FIG01452414 putative lipopolysaccharide A protein +FIG01452423 FIG00623120: hypothetical protein +FIG01452441 FIG00480706: hypothetical protein +FIG01452449 FIG00765096: hypothetical protein +FIG01452482 zinc-binding dehydrogenase family +FIG01452483 putative ammonium transporter +FIG01452486 FIG01117501: hypothetical protein +FIG01452510 Uncharacterized protein MJ0008 +FIG01452515 DNA polymerase X family +FIG01452531 competence protein ComGC +FIG01452534 FIG00823495: hypothetical protein +FIG01452544 FIG00350131: hypothetical protein +FIG01452566 FIG00633400: hypothetical protein +FIG01452569 FIG00846783: hypothetical protein +FIG01452597 membrane-flanked domain +FIG01452608 Chitinase, +FIG01452609 FIG00344105: hypothetical protein +FIG01452618 capA domain protein +FIG01452625 hypothetical protein +FIG01452631 Possible sensorory transduction protein, containing AAA ATPase domain, TPR repeats domain, GGDEF domain and GAF domain +FIG01452639 FIG00407391: hypothetical protein +FIG01452647 FIG00733851: hypothetical protein +FIG01452676 helix-hairpin-helix DNA-binding, class 1 +FIG01452696 probable N-acetylmuramoyl-L-alanine amidase +FIG01452733 probable NADPH:quinone reductase( EC:1.6.5.5 ) +FIG01452741 FIG00563526: hypothetical protein +FIG01452752 ATPase component of ABC transporters with duplicated ATPase domains +FIG01452766 Adult brain protein 239 homolog +FIG01452796 Uroporphyrinogen-III methylase +FIG01452811 FIG00361344: hypothetical protein +FIG01452816 FIG00641821: hypothetical protein +FIG01452824 HTH transcriptional regulator, XRE family, cupin domain +FIG01452836 COG3729: General stress protein +FIG01452837 FIG00414347: hypothetical protein +FIG01452852 glycosyl hydrolase, family 20 +FIG01452868 FIG00384941: hypothetical protein +FIG01452873 conserved hypothetical conserved protein +FIG01452875 L-arabinose transport system permease protein araQ (EC 3.6.3.17) +FIG01452896 involved in early competence +FIG01452924 FIG00390369: hypothetical protein +FIG01452928 polyketide hydroxylase +FIG01452929 putative AraC family/two component family regulatory protein +FIG01452931 FIG01233332: hypothetical protein +FIG01452934 DNA-binding protein, histone-like family +FIG01452985 FIG00350820: hypothetical protein +FIG01452989 acyl-CoA thioester hydrolase +FIG01453042 FIG00527301: hypothetical protein +FIG01453048 peptidase +FIG01453052 Ferritin, Dps family protein +FIG01453055 Outer membrane protein H.8 precursor +FIG01453072 Glutaminyl-peptide cyclotransferase (EC 2.3.2.5) +FIG01453095 FIG00597186: hypothetical protein +FIG01453134 FIG00630943: hypothetical protein +FIG01453135 Putative two-component system response regulator, no kinase domain +FIG01453153 FIG00733483: hypothetical protein +FIG01453166 Replicative DNA helicase +FIG01453168 FIG00766028: hypothetical protein +FIG01453187 FIG01048854: hypothetical protein +FIG01453212 FIG00416031: hypothetical protein +FIG01453238 FIG00624714: hypothetical protein +FIG01453256 abortive infection protein, putative +FIG01453274 capsular polysaccharide biosynthesis +FIG01453277 FIG00350246: hypothetical protein +FIG01453283 cytochrome oxidase C subunit VIb-like +FIG01453316 OriT nickase Nes +FIG01453320 FIG00822787: hypothetical protein +FIG01453321 FIG00354087: hypothetical protein +FIG01453334 FIG00629925: hypothetical protein +FIG01453342 middle operon regulator-related protein +FIG01453351 extracellular factor protein +FIG01453378 Portal protein, truncation +FIG01453386 FIG00468362: hypothetical protein +FIG01453398 Possible phage infection protein +FIG01453406 probable bacteriophage-related protein +FIG01453410 FIG00351530: hypothetical protein +FIG01453424 FIG00363779: hypothetical protein +FIG01453428 Possible AIR synthase related protein, C-termi +FIG01453436 FIG01027852: hypothetical protein +FIG01453450 hypothetical protein +FIG01453467 FIG00743340: hypothetical protein +FIG01453471 FIG00711531: hypothetical protein +FIG01453486 putative membrane protein +FIG01453490 FecR-like transmembrane sensor +FIG01453501 FIG00403267: hypothetical protein +FIG01453551 FIG00425408: hypothetical protein +FIG01453562 Uncharacterized protein yyzB +FIG01453565 putative transmembrane transporter +FIG01453577 2-aminophenol-1,6-dioxygenase, alpha subunit (EC 1.13.11.n1) +FIG01453579 pyridoxamine 5'-phosphate oxidase-related,FMN-binding protein +FIG01453585 FIG00641706: hypothetical protein +FIG01453616 FIG00352497: hypothetical protein +FIG01453625 Glucose inhibited division protein +FIG01453645 Conjugation pore forming protein EbsA +FIG01453646 hypothetical protein +FIG01453655 chromosome segregation SMC protein +FIG01453659 Hypothetical SAV2027 homolog in superantigen-encoding pathogenicity islands SaPI +FIG01453705 FIG01117504: hypothetical protein +FIG01453707 MGC89088 protein +FIG01453714 FIG00623492: hypothetical protein +FIG01453716 FIG00746886: hypothetical protein +FIG01453717 FIG00816135: hypothetical protein +FIG01453727 Ribbon-helix-helix protein +FIG01453732 transcriptional regulator of GntR family +FIG01453760 FIG00631380: hypothetical protein +FIG01453775 Metal dependent membrane associated protease, S2P family +FIG01453802 tail stability; region of aa 277-403 similar to region aa 1061-1186 of non-muscle myosin II heavy chain (MYSN_ACACA; 1509 aa) and to region of aa 113-230 of Pseudomonas aeruginosa TolA (TOLA_PSEAE; 347 aa) and homologous TolA proteins +FIG01453824 Tetracycline-resistance determinant tetV +FIG01453834 Alr1085 protein +FIG01453870 2,4-dienoyl-CoA reductase, mitochondrial precursor (EC 1.3.1.34) +FIG01453874 Nucleoside-binding protein +FIG01453875 NifU family protein +FIG01453879 Alcohol dehydrogenase GroES-like +FIG01453899 FIG00848771: hypothetical protein +FIG01453919 ISChy9, transposase orfB +FIG01453923 Similar to 6-phosphofructokinase +FIG01453924 FIG00347740: hypothetical protein +FIG01453927 putative ribosomal-protein-alanine acetyltransferase +FIG01453980 InterPro IPR003416 COGs COG3174 +FIG01453988 FIG00816454: hypothetical protein +FIG01454007 Cytidylate kinase-like +FIG01454028 BH2053 unknown conserved protein in B. subtilis +FIG01454039 hypothetical protein +FIG01454058 cell wall/surface repeat protein +FIG01454098 Bll3153 protein +FIG01454100 FIG01084360: hypothetical protein +FIG01454136 Aldose epimerase family protein +FIG01454150 FIG00425478: hypothetical protein +FIG01454151 Acetyl-CoA carboxylase alpha subunit +FIG01454166 POSSIBLE CONSERVED MEMBRANE ALANINE RICH PROTEIN +FIG01454176 putative 3',5'-cyclic-nucleotide phosphodiesterase +FIG01454196 FIG00468204: hypothetical protein +FIG01454210 FIG00742165: hypothetical protein +FIG01454219 FIG00830217: hypothetical protein +FIG01454226 putative methylaspartate ammonia-lyase +FIG01454276 FIG00423801: hypothetical protein +FIG01454326 FIG00623922: hypothetical protein +FIG01454350 Alanyl-tRNA synthetase +FIG01454367 putative structure +FIG01454383 lysine N6-hydroxylase( EC:1.14.13.59 ) +FIG01454396 FIG00822113: hypothetical protein +FIG01454403 FIG01166197: hypothetical protein +FIG01454424 putative bifunctional protein [Includes: sulfite reductase [NADPH] flavoprotein alpha-component; iron-uptake factor]( EC:1.8.1.2 ) +FIG01454430 probable conserved integral membrane protein +FIG01454432 All7121 protein +FIG01454451 phospholipase accessory protein PlcR precursor +FIG01454461 formate dehydrogenase beta subunit +FIG01454489 putative transposase (IS605) +FIG01454493 integrase +FIG01454507 Lyzozyme M1 (1,4-beta-N-acetylmuramidase) (EC 3.2.1.17) +FIG01454510 probable phosphotransferase +FIG01454515 Gll1766 protein +FIG01454523 FIG01066212: hypothetical protein +FIG01454531 putative transcriptional regulator (AraC family) +FIG01454550 Barstar-like protein, ribonuclease (barnase) inhibitor +FIG01454559 FIG00524532: hypothetical protein +FIG01454562 ATPase, C subunit family protein +FIG01454563 FIG00756787: hypothetical protein +FIG01454572 Organic solvent tolerance protein +FIG01454594 Signal transduction histidine-protein kinase/phosphatase MprB (EC 2.7.13.3) (EC 3.1.3.-) +FIG01454602 Electron transfer protein +FIG01454619 ORF147 +FIG01454623 transglycosylase associated protein, (integral membrane protein) +FIG01454624 FIG00379848: hypothetical protein +FIG01454636 RelB/StbD replicon stabilization protein (antitoxin to RelE/StbE) +FIG01454637 FIG00356294: hypothetical protein +FIG01454656 Lipopolysaccharide N-acetylglucosaminyltransferase I +FIG01454662 FIG00622784: hypothetical protein +FIG01454677 FIG00521345: hypothetical protein +FIG01454679 transposase, Mutator family protein +FIG01454696 putative superinfection exclusion protein +FIG01454715 carboxymuconolactone decarboxylase family protein +FIG01454737 Nitrilotriacetate monooxygenase +FIG01454828 amino acid ABC transporter, periplasmic amino acid-binding protein, putative +FIG01454841 Helicase subunit of the DNA excision repair complex +FIG01454854 FIG00528036: hypothetical protein +FIG01454865 Sll1765 protein +FIG01454894 Uncharacterized protein MJ1493 +FIG01454915 Glucosylceramidase( EC:3.2.1.45 ) +FIG01454975 Bll0489 protein +FIG01454988 FIG01166480: hypothetical protein +FIG01454993 InterPro IPR001128 COGs COG2124 +FIG01454998 FIG00553532: hypothetical protein +FIG01455016 VrlE +FIG01455021 FIG00362151: hypothetical protein +FIG01455033 FIG00517859: hypothetical protein +FIG01455045 FIG00577947: hypothetical protein +FIG01455074 FIG01244532: hypothetical protein +FIG01455086 Transcriptional regulator, MarR/EmrR family +FIG01455090 probable phage protein +FIG01455104 FIG00403513: hypothetical protein +FIG01455189 FIG00997708: hypothetical protein +FIG01455214 mobilization protein C +FIG01455230 Beta-1,3(4)-glucanase precursor (EC 3.2.1.6) +FIG01455238 UPF0335 protein R02793 +FIG01455240 O-methyltransferase (EC 2.1.1.-) +FIG01455242 hygromycin-B-phosphotransferase +FIG01455246 FIG01027639: hypothetical protein +FIG01455248 FIG00411823: hypothetical protein +FIG01455250 Abortive infection protein AbiGII +FIG01455251 FIG01117373: hypothetical protein +FIG01455260 heme/steroid binding domain protein +FIG01455262 FIG00733632: hypothetical protein +FIG01455303 Chaperone +FIG01455333 DNA polymerase, gamma and tau subunits (EC 2.7.7.7) +FIG01455347 Peptidase T (EC 3.4.11.-) +FIG01455351 Peptidase M20B, peptidase T +FIG01455354 Putative MCP-type signal transduction protein +FIG01455374 Predicted enzyme involved in methoxymalonyl-ACP biosynthesis +FIG01455377 ATP-dependent helicase hrpA (hrpA) +FIG01455383 DUF2383 domain-containing protein +FIG01455405 Uncharacterized protein MJ0201 +FIG01455414 hypothetical protein +FIG01455418 Pleiotropic drug resistance protein yfiN1 +FIG01455427 Cytochrome P450-pinF1, plant-inducible (EC 1.14.-.-) +FIG01455439 FIG00768967: hypothetical protein +FIG01455447 Hexose transporter 2 +FIG01455500 FIG00414252: hypothetical protein +FIG01455501 Modification methylase Sau96I (EC 2.1.1.37) +FIG01455505 Phage tail component protein X +FIG01455522 lysine decarboxylase +FIG01455545 FIG00639703: hypothetical protein +FIG01455553 FIG00389139: hypothetical protein +FIG01455563 FIG00931986: hypothetical protein +FIG01455567 Vng2370c +FIG01455568 putative DNA/RNA helicase +FIG01455571 capsular polysaccharide biosynthesis glycosyltransferase +FIG01455580 FIG00532198: hypothetical protein +FIG01455582 heptosyltransferase family protein +FIG01455586 NADH-ubiquinone oxidoreductase, chain 4L +FIG01455587 FIG00388757: hypothetical protein +FIG01455599 hypothetical protein +FIG01455600 putative ribose phosphate pyrophosphokinase +FIG01455608 FIG00407521: hypothetical protein +FIG01455621 Probable enoyl-CoA hydratase paaF (EC 4.2.1.17) +FIG01455650 FIG00526101: hypothetical protein +FIG01455658 GntR family transcriptional regulator PA0120 @ Transcriptional regulator, GntR family domain +FIG01455670 FIG01235141: hypothetical protein +FIG01455685 Exo-alpha-sialidase +FIG01455709 hypothetical protein +FIG01455750 MtN3 and saliva related transmembrane protein +FIG01455776 virion host shutoff protein-like +FIG01455792 FIG00385753: hypothetical protein +FIG01455793 FIG00767926: hypothetical protein +FIG01455797 FIG00407666: hypothetical protein +FIG01455818 hypothetical protein +FIG01455831 FIG00623515: hypothetical protein +FIG01455840 FIG00348944: hypothetical protein +FIG01455842 putative branched-chain amino acid transporter +FIG01455846 FIG00768426: hypothetical protein +FIG01455861 possible peptidase +FIG01455876 FIG136752 family, hypothetical protein +FIG01455880 Pseudouridine synthase, RluD +FIG01455905 FIG00354837: hypothetical protein +FIG01455910 hypothetical protein +FIG01455925 FIG00385640: hypothetical protein +FIG01455965 FIG00343872: hypothetical protein +FIG01455971 putative drug-binding lipoprotein +FIG01455972 C4-type zinc finger protein (TraR family) +FIG01455981 FIG00471689: hypothetical protein +FIG01455989 FIG00379988: hypothetical protein +FIG01456001 FIG00733283: hypothetical protein +FIG01456005 site-specific DNA-methyltransferase (cytosine-specific) +FIG01456050 FIG00385443: hypothetical protein +FIG01456055 FIG00415473: hypothetical protein +FIG01456059 DJ-1 family protein +FIG01456061 FIG00871331: hypothetical protein +FIG01456102 FIG01234779: hypothetical protein +FIG01456117 ortholog to Borrelia burgdorferi BB0662 +FIG01456118 putative sortase +FIG01456132 FIG00344626: hypothetical protein +FIG01456161 C4-dicarboxylate-transport transmembrane protein DctA +FIG01456176 FIG01233340: hypothetical protein +FIG01456193 Uncharacterized protein containing predicted cell adhesion domain and ChW-repeats +FIG01456200 FIG00875474: hypothetical protein +FIG01456203 FIG00955807: hypothetical protein +FIG01456267 FIG00765075: hypothetical protein +FIG01456287 FIG00413224: hypothetical protein +FIG01456293 FIG01237190: hypothetical protein +FIG01456303 hypothetical protein +FIG01456327 FIG00408365: hypothetical protein +FIG01456338 Late competence protein ComC, processing protease +FIG01456389 Prebacteriocin +FIG01456392 hypothetical protein +FIG01456394 glycosyl transferase family 8 protein +FIG01456399 FIG00741966: hypothetical protein +FIG01456437 FIG00767520: hypothetical protein +FIG01456468 FIG00409562: hypothetical protein +FIG01456472 Aldo/keto reductase family oxidoreductase +FIG01456474 FIG00352436: hypothetical protein +FIG01456478 FIG00766624: hypothetical protein +FIG01456479 Phage integrase:Phage integrase, N-terminal SAM-like +FIG01456490 FIG00409117: hypothetical protein +FIG01456492 Uncharacterized small protein +FIG01456500 PROBABLE CONSERVED TRANSMEMBRANE PROTEIN +FIG01456513 FIG01234120: hypothetical protein +FIG01456527 Probable helicase +FIG01456556 C4-dicarboxylate transport protein 1 +FIG01456563 Cytochrome P-450 +FIG01456585 Putative dienelactone hydrolase +FIG01456590 FIG01046688: hypothetical protein +FIG01456620 FIG00384893: hypothetical protein +FIG01456659 fimbrial Usher family protein +FIG01456662 Uncharacterized membrane protein-like +FIG01456674 FIG00821344: hypothetical protein +FIG01456688 Re face-specific citrate synthase (EC 2.3.3.3) / extracellular cache domain +FIG01456704 Internalin G +FIG01456707 FIG01233033: hypothetical protein +FIG01456713 peptidase S41 +FIG01456742 FIG01246027: hypothetical protein +FIG01456743 FIG00624154: hypothetical protein +FIG01456758 TRX family +FIG01456773 Ortholog of S. aureus MRSA252 (BX571856) SAR1351 +FIG01456782 Mll5901 protein +FIG01456785 FIG00995295: hypothetical protein +FIG01456788 FIG00406662: hypothetical protein +FIG01456798 protein of unknown function DUF427 +FIG01456813 invertase +FIG01456827 FIG00530758: hypothetical protein +FIG01456829 NimC/NimA family protein +FIG01456834 FIG00364081: hypothetical protein +FIG01456842 FnuDI restriction endonuclease +FIG01456844 Adsorption protein +FIG01456869 FIG00521501: hypothetical protein +FIG01456895 hypothetical protein, truncated +FIG01456914 Predicted histidine transporter +FIG01456936 Lantibiotic ABC transporter permease +FIG01456938 COG2343: Uncharacterized protein conserved in bacteria +FIG01456980 Lipase chaperone +FIG01456981 FIG00763108: hypothetical protein +FIG01456983 minor tail protein, putative +FIG01457003 Putative variable surface prolipoprotein +FIG01457029 COGs COG1934 +FIG01457043 hypothetical protein +FIG01457065 hypothetical protein +FIG01457073 FIG01077410: hypothetical protein +FIG01457078 FIG00405468: hypothetical protein +FIG01457079 putative fibronectin-binding protein +FIG01457087 FIG00350140: hypothetical protein +FIG01457092 FIG01240963: hypothetical protein +FIG01457115 FIG00406556: hypothetical protein +FIG01457126 protein containing ChW-repeats and cell-adhesion domain +FIG01457129 FIG00534838: hypothetical protein +FIG01457165 FIG00640069: hypothetical protein +FIG01457183 Peptidase M28 +FIG01457184 probable lipopolysaccharide biosynthesis glycosyltransferase VC0224 , putative +FIG01457189 hypothetical protein +FIG01457199 putative corrinoid ABC transporter permease +FIG01457207 FIG00388962: hypothetical protein +FIG01457208 FIG00710757: hypothetical protein +FIG01457209 BexA, multidrug efflux pump +FIG01457216 lycopene e-cyclase isoprenoid transferase B +FIG01457222 FIG00775020: hypothetical protein +FIG01457227 hypothetical protein +FIG01457228 Aspartyl/asparaginyl beta-hydroxylase (EC 1.14.11.16) +FIG01457232 Peyer's patch-specific virulence factor GipA +FIG01457255 putative lipoprotein signal peptide +FIG01457257 FIG00411575: hypothetical protein +FIG01457265 HAD-superfamily phosphatase subfamily IIIC/FkbH domain protein +FIG01457290 probable lipoprotein YPO3274 +FIG01457297 COG0028: Thiamine pyrophosphate-requiring enzymes +FIG01457301 possible ring-cleaving dioxygenase +FIG01457306 Integrase/recombinase, phage associated +FIG01457309 FIG00351389: hypothetical protein +FIG01457313 two-components system response regulator +FIG01457334 Colicin V secretion protein cvaA +FIG01457341 FIG00672354: hypothetical protein +FIG01457365 FIG00407789: hypothetical protein +FIG01457372 FIG00388142: hypothetical protein +FIG01457375 phosphatidylcholine-hydrolyzing phospholipase D (PLD) family +FIG01457380 MOSC domain containing protein +FIG01457389 SCO2/SenC family protein +FIG01457392 FIG00344290: hypothetical protein +FIG01457393 FIG00673683: hypothetical protein +FIG01457407 transporter ATP-binding protein +FIG01457409 Ead protein +FIG01457414 Diguanylate cyclase/phosphodiesterase domain 1 +FIG01457423 FIG00832988: hypothetical protein +FIG01457427 protein with similarity to CrcB +FIG01457431 FIG00385618: hypothetical protein +FIG01457440 TraL +FIG01457457 nosX protein, putative +FIG01457468 Na+ ABC transporter (ATP-binding protein), NATA +FIG01457471 Transposase IS3/IS911 +FIG01457492 FIG00347781: hypothetical protein +FIG01457516 FIG00350241: hypothetical protein +FIG01457526 putative DNa-binding protein +FIG01457540 Acyl carrier protein of polyletide synthase +FIG01457544 RecA-family ATPase-like +FIG01457554 GTP cyclohydrolase I( EC:3.5.4.16 ) +FIG01457568 FIG00640235: hypothetical protein +FIG01457572 acetyltransferase, GNAT family family protein +FIG01457602 DNA processing protein smf +FIG01457645 FIG00409546: hypothetical protein +FIG01457655 FIG00414507: hypothetical protein +FIG01457668 FIG00350668: hypothetical protein +FIG01457671 YjhS +FIG01457700 FIG00751146: hypothetical protein +FIG01457712 Mlr9349 protein +FIG01457718 repB protein, putative +FIG01457729 Interphotoreceptor retinoid binding protein +FIG01457745 FIG00654214: hypothetical protein +FIG01457770 XylSArg41Pro +FIG01457776 FIG00944276: hypothetical protein +FIG01457779 putative sodium-glucose/galactose cotransporter +FIG01457792 probable iron transport system ATP-binding protein +FIG01457810 FIG00734150: hypothetical protein +FIG01457857 Cell wall lytic activity endopeptidase +FIG01457881 Transposase, ISLbp1 +FIG01457884 Pectin degradation protein KdgF +FIG01457898 oxidoreductase, FAD/FMN-binding +FIG01457900 N-methyltransferase homolog +FIG01457907 Salivaricin A modification enzyme +FIG01457912 phage tail protein domain +FIG01457918 Protein MbtH +FIG01457921 FIG00385214: hypothetical protein +FIG01457922 ORF_ID:alr7556 unknown protein +FIG01457932 FIG01130246: hypothetical protein +FIG01457968 FIG00426941: hypothetical protein +FIG01457971 hypothetical protein +FIG01457983 FIG00828468: hypothetical protein +FIG01457993 HAMP domain/HD domain protein +FIG01458009 FIG172065: hypothetical protein +FIG01458012 putative amino acid amidohydrolase +FIG01458074 conserved domain protein +FIG01458080 predicted coding region +FIG01458082 Putative high-affinity branched-chain amino acid transporter membrane protein +FIG01458110 FIG00330653: hypothetical protein +FIG01458127 heavy metal transport/detoxification protein +FIG01458138 OLIGOPEPTIDE TRANSPORT ATP-BINDING PROTEIN OPPD +FIG01458148 putative cold-shock RNA methyltransferase +FIG01458152 FIG00523090: hypothetical protein +FIG01458179 CDS_ID OB0983 +FIG01458200 FIG00352119: hypothetical protein +FIG01458205 Prophage antirepressor +FIG01458262 FIG00848098: hypothetical protein +FIG01458270 Asl0060 protein +FIG01458275 orf3 +FIG01458287 FIG00426356: hypothetical protein +FIG01458296 FIG00674752: hypothetical protein +FIG01458323 FIG00639663: hypothetical protein +FIG01458337 Phosphomannomutase +FIG01458351 FIG01246534: hypothetical protein +FIG01458375 Bsr4717 protein +FIG01458379 FIG00385497: hypothetical protein +FIG01458406 InterPro IPR002110 COGs COG0666 +FIG01458410 FIG00640276: hypothetical protein +FIG01458427 FIG01287850: hypothetical protein +FIG01458432 putative hydrolase/phosphatase protein +FIG01458478 FIG00341261: hypothetical protein +FIG01458479 FIG00406051: hypothetical protein +FIG01458487 FIG00643334: hypothetical protein +FIG01458490 Transposase B from transposon Tn554 +FIG01458508 FIG00641488: hypothetical protein +FIG01458511 hypothetical protein +FIG01458524 FIG00743665: hypothetical protein +FIG01458555 signal transduction protein containing diguanilate cyclase/phosphodiesterase domain +FIG01458594 cyclopropane-fatty-acyl-phospholipid synthase/methyltransferase +FIG01458609 MxiK protein +FIG01458629 FIG00384883: hypothetical protein +FIG01458632 insecticidal toxin complex protein +FIG01458633 Hypothetical protein, CF-24 family +FIG01458640 Possible membrane efflux protein +FIG01458646 prophage Lp1 protein 2 +FIG01458653 acyl-CoA synthase +FIG01458661 FIG00623533: hypothetical protein +FIG01458665 FIG01206390: hypothetical protein +FIG01458684 FIG00350337: hypothetical protein +FIG01458699 FIG00424795: hypothetical protein +FIG01458716 FIG01047560: hypothetical protein +FIG01458747 serine/arginine repetitive matrix 2 +FIG01458751 type III effector Hrp-dependent outers +FIG01458754 hypothetical protein +FIG01458760 CDP-4-keto-6-deoxy-D-glucose-3-dehydratase +FIG01458769 putative iron complex outermembrane recepter protein +FIG01458774 hypothetical protein +FIG01458792 protoporphyrinogen oxidase( EC:1.3.3.4 ) +FIG01458812 type II restriction modification system, restriction subunit +FIG01458835 putative NADPH dehydrogenase +FIG01458838 FIG00404535: hypothetical protein +FIG01458846 FIG172199: hypothetical thioredoxin family protein +FIG01458849 Late promoter-activating protein (Gp10) +FIG01458887 FIG00688683: hypothetical protein +FIG01458893 FIG00405755: hypothetical protein +FIG01458910 FIG00764004: hypothetical protein +FIG01458922 Holin, phage associated +FIG01458923 FIG00747119: hypothetical protein +FIG01458926 Conserved domain associated with flavoprotein oxygenases, DIM6/NTAB family +FIG01458937 hypothetical protein +FIG01458941 transposase A +FIG01458946 FIG00487358: hypothetical protein +FIG01458947 retrotransposons, viral and plasmid proteins; recombination and DNA repair +FIG01458957 FIG01022281: hypothetical protein +FIG01458967 Micrococcal nuclease precursor (EC 3.1.31.1) +FIG01458974 FIG00532202: hypothetical protein +FIG01459004 FIG00402937: hypothetical protein +FIG01459018 uncharacterized conserved protein, YciI family +FIG01459019 Histidine kinase, HAMP region +FIG01459030 FIG00388811: hypothetical protein +FIG01459059 FIG01245416: hypothetical protein +FIG01459082 possible AtsE +FIG01459084 FIG00532264: hypothetical protein +FIG01459101 30 kDa GTP-binding protein lepA +FIG01459113 Predicted protein family PM-9 +FIG01459157 Methicillin resistance regulatory sensor-transducer MecR1, truncated +FIG01459160 FIG00270615: hypothetical protein +FIG01459189 possible reductase +FIG01459213 COG0765: ABC-type amino acid transport system, permease component +FIG01459220 FIG00409833: hypothetical protein +FIG01459256 FIG00361701: hypothetical protein +FIG01459260 hypothetical protein +FIG01459278 syc0812_d +FIG01459279 Trp operon leader peptide +FIG01459295 3-deoxy-D-manno-octulosonic-acid transferase-like protein +FIG01459308 FIG00527561: hypothetical protein +FIG01459327 hypothetical protein +FIG01459341 FIG01246843: hypothetical protein +FIG01459348 Uncharacterized protein yoaF +FIG01459349 FIG00347823: hypothetical protein +FIG01459360 oxidoreductase-aldo/keto reductase family +FIG01459367 syc0081_d +FIG01459369 Bacteriophage P4 DNA primase (EC 2.7.7.-) +FIG01459376 zinc finger, RAN-binding domain containing 3 +FIG01459378 FIG00624068: hypothetical protein +FIG01459379 Bsl0560 protein +FIG01459383 FIG00351780: hypothetical protein +FIG01459385 FIG00522070: hypothetical protein +FIG01459386 hypothetical protein +FIG01459391 FIG01124894: hypothetical protein +FIG01459397 FIG00385304: hypothetical protein +FIG01459424 threonine efflux protein +FIG01459425 Uncharacterized protein TP_0811 +FIG01459427 putative membrane protein P80 +FIG01459428 proton-dependent oligopeptide transporter (POT) family protein, di- or tripeptide:H+ symporter +FIG01459438 ompA family protein +FIG01459440 Protein required for the initiation of cell division +FIG01459441 Predicted protein family PM-24 +FIG01459444 hypothetical protein +FIG01459446 probable S-adenosylmethionine-dependent methltransferase +FIG01459452 hypothetical protein +FIG01459492 FIG00639773: hypothetical protein +FIG01459497 putative partition protein +FIG01459518 transcriptional regulators, marR/emrR family +FIG01459520 Transcriptional activator; ToxR +FIG01459524 FIG00630211: hypothetical protein +FIG01459553 FIG00349219: hypothetical protein +FIG01459556 conserved hypothetical protein VrlI +FIG01459603 Probable tpr domain protein +FIG01459618 Wiskott-Aldrich syndrome protein interacting protein +FIG01459626 FIG01246927: hypothetical protein +FIG01459651 FIG00850137: hypothetical protein +FIG01459668 FIG00363141: hypothetical protein +FIG01459702 FIG00932980: hypothetical protein +FIG01459717 putative two-component response regulator (LuxR family with receiver domain) +FIG01459727 putative dioxygenase hydroxylase component +FIG01459744 TAP domain-containing protein +FIG01459746 FIG00521746: hypothetical protein +FIG01459758 transposase (05) +FIG01459767 hypothetical protein +FIG01459783 glycosyl hydrolase, BNR repeat +FIG01459793 putative amino acid deaminase +FIG01459806 FIG00511143: hypothetical protein +FIG01459807 dTDP-6-deoxy-L-hexose 3-O-methyltransferase +FIG01459847 FIG00762864: hypothetical protein +FIG01459850 FIG01084627: hypothetical protein +FIG01459851 lycopene cyclase family protein +FIG01459872 putative toluene-tolerance protein (Ttg2E) +FIG01459873 insertion sequence transposase protein +FIG01459875 Bll0061 protein +FIG01459900 cell wall surface protein, putative +FIG01459908 FIG00350277: hypothetical protein +FIG01459926 putatitve membrane protein +FIG01459944 Complete genome; segment 9/17 +FIG01459959 FIG01239815: hypothetical protein +FIG01459971 FG-GAP repeat protein +FIG01459972 Cold shock domain family protein +FIG01459978 Bacterial regulatory proteins, ArsR family protein +FIG01459985 FIG00817729: hypothetical protein +FIG01459988 ABC transporter (permease) +FIG01460000 GAF sensor hybrid histidine kinase +FIG01460003 Outer membrane protein N, non-specific porin +FIG01460011 FIG00353605: hypothetical protein +FIG01460033 hypothetical protein +FIG01460037 deoxycytidylate deaminase-related protein +FIG01460038 FIG00590446: hypothetical protein +FIG01460054 hypothetical protein +FIG01460069 peptidase M61 domain protein +FIG01460106 Mrp protein +FIG01460146 FIG00361201: hypothetical protein +FIG01460162 N5,N10-methylenetetrahydromethanopterin reductase-related protein +FIG01460176 FIG00555047: hypothetical protein +FIG01460206 hypothetical protein +FIG01460209 probable dienelactone hydrolase protein +FIG01460226 FIG00867383: hypothetical protein +FIG01460232 alkaline phosphatase synthesis sensor protein +FIG01460239 putative peptidoglycan binding protein +FIG01460251 Phenolpthiocerol synthesis type-I polyketide synthase PpsD +FIG01460279 hcp protein +FIG01460290 Diacyglycerol O-acyltransferase (EC 2.3.1.20) +FIG01460311 FIG00764062: hypothetical protein +FIG01460312 putative CP4-57-type integrase +FIG01460344 outer membrane protein 14 +FIG01460358 FIG00682890: hypothetical protein +FIG01460361 ABC-type export system, membrane fusion protein +FIG01460462 FIG00449918: hypothetical protein +FIG01460484 PilL domain protein +FIG01460498 hypothetical protein +FIG01460506 FIG00355874: hypothetical protein +FIG01460511 3-carboxymuconate cyclase-like +FIG01460539 Multiple resistance and pH regulation protein F +FIG01460559 cobalamin synthesis protein, P47K +FIG01460567 FIG00623230: hypothetical protein +FIG01460591 copper resistance protein CopC +FIG01460603 FIG00460048: hypothetical protein +FIG01460616 periplasmic mercuric ion binding protein +FIG01460628 Pyruvate kinase family protein +FIG01460643 Rhs family protein-like +FIG01460672 Probable lipase +FIG01460679 Chemotactic transducer-related protein +FIG01460680 FIG028455: hypothetical protein +FIG01460689 FIG00733276: hypothetical protein +FIG01460728 Lmo0737 protein +FIG01460736 hypothetical protein +FIG01460745 FIG01244210: hypothetical protein +FIG01460749 RNA-directed DNA polymerase (Reverse transcriptase) +FIG01460766 possible BdrC3 +FIG01460770 Sodium/glucose cotransporter 1 +FIG01460784 Lipoprotein Blc +FIG01460823 Pyridoxamine-phosphate oxidase +FIG01460831 Tyrosine type site-specific recombinase, Mpi regulator +FIG01460880 FIG01116385: hypothetical protein +FIG01460884 FIG00348336: hypothetical protein +FIG01460893 Transcriptional activator +FIG01460907 hypothetical protein FP1254 +FIG01460927 hypothetical protein +FIG01460930 ISSod1, transposase OrfB +FIG01460949 hypothetical protein +FIG01460961 von Willebrand factor, type A +FIG01460967 Branched-chain amino acid ABC transporter, permease protein +FIG01460971 Phosphotransferase system mannitol/fructose-specific IIA domain (Ntr-type) +FIG01460988 Allergen V5/Tpx-1-like protein +FIG01460997 Uncharacterized protein MJ0093 +FIG01460998 FIG00640079: hypothetical protein +FIG01461001 FIG00380015: hypothetical protein +FIG01461022 purine NTPase +FIG01461039 YdeA protein +FIG01461050 putative serine protein kinase, PrkA +FIG01461066 FIG00528067: hypothetical protein +FIG01461074 Zinc/manganese ABC transporter substrate binding protein +FIG01461083 FIG005121: SAM-dependent methyltransferase (EC 2.1.1.-) +FIG01461110 secreted sugar binding protein +FIG01461157 putative flavin reductase +FIG01461166 Uncharacterized protein yqaR +FIG01461168 LipL36, outer membrane lipoprotein +FIG01461176 Pirin-like protein CC_1473 +FIG01461182 Amino acid transporter (permease) +FIG01461260 FIG00631997: hypothetical protein +FIG01461301 SoxB-like sarcosine oxidase, subunit beta related +FIG01461304 COG4300: Predicted permease, cadmium resistance protein +FIG01461317 FIG00362274: hypothetical protein +FIG01461354 FIG00468850: hypothetical protein +FIG01461369 Ketosteroid isomerase +FIG01461419 Glyoxalase/bleomycin resistance protein/dioxygenase +FIG01461450 Predicted acyl-CoA transferases/carnitine dehydratase +FIG01461460 FIG00516323: hypothetical protein +FIG01461463 FIG00413215: hypothetical protein +FIG01461476 Dihydrodipicolinate reductase +FIG01461478 Polysaccharide deacetylase family protein +FIG01461492 Protein, containing LuxR family transcriptional regulator HTH domain +FIG01461507 putative A transposase +FIG01461512 FIG00674232: hypothetical protein +FIG01461516 M. jannaschii predicted coding region MJ0686 +FIG01461521 Transcriptional regulator, AraC family +FIG01461529 Hemerythrin HHE cation binding domain protein +FIG01461531 FIG01098430: hypothetical protein +FIG01461547 DafA protein +FIG01461566 FIG00829425: hypothetical protein +FIG01461583 probable LacI-family transcriptional regulator +FIG01461589 hypothetical protein +FIG01461614 FIG00384976: hypothetical protein +FIG01461634 sodium symporter transmembrane region protein +FIG01461641 Opacity protein and related surface antigens +FIG01461662 DNA-binding heavy metal response regulator, putative +FIG01461668 DNA topology modulation protein +FIG01461678 FIG00764106: hypothetical protein +FIG01461686 Ankyrin repeat protein chloroplast-like +FIG01461688 FIG00402672: hypothetical protein +FIG01461710 FIG00764695: hypothetical protein +FIG01461712 putative periplasmic membrane protein +FIG01461734 FIG00954246: hypothetical protein +FIG01461736 Transcriptional regulator of sugar metabolism +FIG01461795 FIG00674898: hypothetical protein +FIG01461802 FIG00623834: hypothetical protein +FIG01461804 NDP-C-methyltransferase +FIG01461811 FIG00847815: hypothetical protein +FIG01461823 putative transporter, LysE family +FIG01461844 FIG01232431: hypothetical protein +FIG01461846 FIG01047106: hypothetical protein +FIG01461854 FIG00791771: hypothetical protein +FIG01461871 FIG00385255: hypothetical protein +FIG01461888 FIG00769675: hypothetical protein +FIG01461901 nucleoside:H+ symporter +FIG01461921 putative cell wall binding repeat 2 +FIG01461943 FIG00754671: hypothetical protein +FIG01461945 FIG00407623: hypothetical protein +FIG01461966 conserved hypothetical thioredoxin +FIG01461968 FIG00642355: hypothetical protein +FIG01461972 prophage Lp2 protein 31 +FIG01461986 YDCP protein +FIG01462004 FIG00527060: hypothetical protein +FIG01462008 FIG00932349: hypothetical protein +FIG01462017 Outer membrane protein W +FIG01462039 FIG00641643: hypothetical protein +FIG01462040 bacterial type II secretion system protein F +FIG01462077 phosphopantetheinyl transferase +FIG01462094 hypothetical protein +FIG01462097 FIG00829016: hypothetical protein +FIG01462102 inner membrane transport protein YdiN +FIG01462106 putative malonyl transferase +FIG01462108 FIG00351359: hypothetical protein +FIG01462112 FIG01119384: hypothetical protein +FIG01462119 FIG00413360: hypothetical protein +FIG01462121 FIG00957965: hypothetical protein +FIG01462140 FIG00630171: hypothetical protein +FIG01462142 FIG00817567: hypothetical protein +FIG01462148 Response regulator with TPR repeat +FIG01462152 tail assembly protein, putative +FIG01462172 FIG00424617: hypothetical protein +FIG01462186 Permease, MDR related, probably tetracycline resistance protein +FIG01462207 Carbapenem antibiotics biosynthesis protein carD +FIG01462210 integrase core domain protein +FIG01462232 phosphate-selective porin O and P +FIG01462233 FIG01165453: hypothetical protein +FIG01462244 FIG00403569: hypothetical protein +FIG01462262 FIG00946169: hypothetical protein +FIG01462266 FIG01048347: hypothetical protein +FIG01462267 UV damage endonuclease UvdE +FIG01462279 phage exonuclease, putative +FIG01462293 AAA+ class-like ATPase +FIG01462296 probable transport protein +FIG01462336 COG1961: Site-specific recombinases, DNA invertase Pin homologs +FIG01462340 Aminotransferase class-III (EC 2.6.1.40) +FIG01462345 Putative cytochrome c-type protein +FIG01462346 DNA-binding protein, similar to histone-like nucleoid-structuring protein H-NS +FIG01462361 cytochrome c biogenesis (thioredoxin) related protein +FIG01462367 phage repressor protein, putative +FIG01462380 ribonuclease H +FIG01462388 Mandelate racemase/muconate lactonizing protein +FIG01462405 no significant homology Putative N-terminal signal sequence and 1 putative transmembrane region were found by PSORT +FIG01462427 FIG00818231: hypothetical protein +FIG01462452 possible lipoprotein +FIG01462456 COG0236: Acyl carrier protein +FIG01462459 FIG00769896: hypothetical protein +FIG01462461 Endoglucanase family 5 +FIG01462463 Membrane-associated phospholipid phosphatase (EC 3.1.3.27) +FIG01462469 High light inducible protein hli2 +FIG01462501 similar to two hypothetical proteins from Mycobacterium tuberculosis TR:O53468 (EMBL:O53468) MTV018.09C (Rv2022c); similar to TR:O53332 (EMBL:AL021646) MTV014.26 (Rv3182) +FIG01462512 ABC transporter solute-binding protein +FIG01462519 TRANSCRIPTIONAL REGULATOR, CRP/FNR FAMILY +FIG01462574 Bsr0701 protein +FIG01462592 FIG00417770: hypothetical protein +FIG01462603 magnesium chelatase +FIG01462626 FIG00389698: hypothetical protein +FIG01462631 FIG00525854: hypothetical protein +FIG01462656 PTS system, fructose-specific family, IIABC components( EC:2.7.1.69 ) +FIG01462681 integral membrane protein, putative permease +FIG01462687 FIG00967400: hypothetical protein +FIG01462691 Flagellar hook-length control protein FliK +FIG01462694 ECF subfamily RNA polymerase sigma factor +FIG01462711 B. burgdorferi predicted coding region BB0213 +FIG01462734 4Fe-4S ferredoxin iron-sulfur binding domain protein +FIG01462735 ORF61 (o129) +FIG01462739 FIG00768625: hypothetical protein +FIG01462748 FIG00450300: hypothetical protein +FIG01462754 FIG01078324: hypothetical protein +FIG01462779 FIG00639839: hypothetical protein +FIG01462782 CheW-like protein +FIG01462793 FIG00388846: hypothetical protein +FIG01462801 FIG01200367: hypothetical protein +FIG01462818 FIG00408007: hypothetical protein +FIG01462828 FIG00623059: hypothetical protein +FIG01462870 FIG00350456: hypothetical protein +FIG01462871 FIG00351038: hypothetical protein +FIG01462874 Pli0008 protein +FIG01462884 Transposase and inactivated derivatives, IS30 family +FIG01462899 Glucan 1,6-alpha-glucosidase (EC 3.2.1.70) +FIG01462929 hypothetical protein +FIG01462959 FIG00403360: hypothetical protein +FIG01462997 ATP-dependent Clp protease ATP-binding subunit clpA +FIG01463000 Putative cytochrome +FIG01463009 DNA-binding protein SMUBP-2 +FIG01463012 Phosphoribosylanthranilate isomerase like (EC 5.3.1.24) +FIG01463016 FIG00344217: hypothetical protein +FIG01463062 Stress-responsive transcriptional regulator +FIG01463076 FIG00523612: hypothetical protein +FIG01463108 prohibitin +FIG01463110 predicted Fe-S oxidoreductases +FIG01463131 FIG00766572: hypothetical protein +FIG01463144 Alr5319 protein +FIG01463188 FIG00379790: hypothetical protein +FIG01463192 arginyl-tRNA synthetase( EC:6.1.1.19 ) +FIG01463194 conserved domain protein +FIG01463199 GDP-mannose 4,6-dehydratase (EC 4.2.1.47) +FIG01463208 Sll1542 protein +FIG01463219 agaA +FIG01463235 Bll1129 protein +FIG01463256 narL (narL) +FIG01463330 transcriptional regulator, AraC family, truncated +FIG01463384 Outer membrane usher protein HtrE +FIG01463459 FIG00629618: hypothetical protein +FIG01463468 B. burgdorferi predicted coding region BBB08 +FIG01463473 probable periplasmic protein Cj0093 , putative +FIG01463480 FIG00640418: hypothetical protein +FIG01463484 Tetratricopeptide repeat domain 8 +FIG01463485 Plasmid mobilization protein +FIG01463505 FIG00519149: hypothetical protein +FIG01463508 FIG00349562: hypothetical protein +FIG01463526 FIG01234579: hypothetical protein +FIG01463536 FIG00404447: hypothetical protein +FIG01463538 Transcriptional antiterminator, BglG +FIG01463550 Pentitol PTS system enzyme II B component +FIG01463579 Zinc/iron permease precursor +FIG01463616 FIG00353560: hypothetical protein +FIG01463638 FIG00624702: hypothetical protein +FIG01463644 Hydroxymethylpyrimidine ABC transporter, periplasmic component +FIG01463655 putative plasmid stability protein +FIG01463680 Acyl-CoA dehydrogenase (EC 1.3.8.7) +FIG01463694 WD-40 repeat-protein +FIG01463713 CELL PROCESSES; Adaptation; osmotic adaptation +FIG01463723 FIG00424454: hypothetical protein +FIG01463733 virulence factor family protein +FIG01463738 conserved hypothetical protein 156 +FIG01463762 Putative replication protein +FIG01463826 probable zinc metalloprotease +FIG01463854 FIG01068212: hypothetical protein +FIG01463858 molybdopterin biosynthesis MoaE +FIG01463889 FIG00751980: hypothetical protein +FIG01463891 FIG00385507: hypothetical protein +FIG01463901 FIG00404648: hypothetical protein +FIG01463913 Porin 41 (Por41) precursor +FIG01463955 Acyl-coenzyme A synthetases/AMP-(fatty) acid ligases +FIG01463958 Gentamicin 3'-N-acetyltransferase( EC:2.3.1.60 ) +FIG01463966 Probable lipase (EC 3.1.1.1) +FIG01463995 ISSod6 transposase, IS1301 +FIG01464009 Polygalacturonase +FIG01464011 transposase +FIG01464039 PTS system, maltose-specific IIA component +FIG01464049 FIG00414387: hypothetical protein +FIG01464053 histidine kinase-response regulator hybrid protein +FIG01464092 FIG00953635: hypothetical protein +FIG01464099 FIG00630640: hypothetical protein +FIG01464108 parallel beta-helix repeat protein +FIG01464118 Protein of unknown function (DUF497) superfamily +FIG01464121 COG0656: Aldo/keto reductases, related to diketogulonate reductase +FIG01464166 FIG00407626: hypothetical protein +FIG01464173 surface array protein +FIG01464201 Transcriptional repressor CifR, TetR family +FIG01464232 FIG00350685: hypothetical protein +FIG01464239 regulatory protein +FIG01464247 FIG00348101: hypothetical protein +FIG01464255 Rieske [2Fe-2S] domain +FIG01464274 HTH-type transcriptional regulator GlnR +FIG01464281 URF 4 +FIG01464291 type I restriction-modification system, subunit S +FIG01464298 FIG00385512: hypothetical protein +FIG01464308 ATP/GTP-binding protein, SA1392 homolog +FIG01464314 FIG01049629: hypothetical protein +FIG01464322 FIG00350406: hypothetical protein +FIG01464344 FIG00385571: hypothetical protein +FIG01464362 Bll4815 protein +FIG01464369 FIG00409506: hypothetical protein +FIG01464386 FIG00404247: hypothetical protein +FIG01464387 Putative acetyltransferase( EC:2.3.1.- ) +FIG01464393 flagellar biosynthetic protein FlhB +FIG01464398 Similar to: Y. pestis YPO0620 putative exported protein precursor +FIG01464401 Peptidase M23/M37 +FIG01464436 Co/Zn/Cd efflux system +FIG01464444 FIG00859851: hypothetical protein +FIG01464445 FIG00354262: hypothetical protein +FIG01464449 Zn-finger DNA-binding domain +FIG01464468 Bll5076 protein +FIG01464479 FIG00874660: hypothetical protein +FIG01464497 Alpha-rhamnosidase +FIG01464499 Spore coat protein F (CotF) family protein +FIG01464514 Secretion system protein GspE,PulE,PilB like +FIG01464532 putative rhamnosyl transferase +FIG01464541 Bll2618 protein +FIG01464544 FIG00364212: hypothetical protein +FIG01464599 FIG00531661: hypothetical protein +FIG01464606 Putative hemolysin activation/secretion protein +FIG01464614 FIG00823731: hypothetical protein +FIG01464615 FIG00631796: hypothetical protein +FIG01464633 Transposase for ISSha1 +FIG01464650 FIG00850502: hypothetical protein +FIG01464653 FIG00388228: hypothetical protein +FIG01464654 FIG01119514: hypothetical protein +FIG01464678 probable ATPase +FIG01464695 FIG00606858: hypothetical protein +FIG01464730 Uncharacterized protein MJ0606 +FIG01464734 FIG00405599: hypothetical protein +FIG01464768 FIG00385578: hypothetical protein +FIG01464772 putative cytochrome c-type biogenesis protein +FIG01464775 Hydroxylase +FIG01464813 UPF0276 protein VV3194 +FIG01464874 Glycerophosphoryl diester phosphodiesterase +FIG01464884 FIG01222944: hypothetical protein +FIG01464886 Family of unknown function (DUF450) family +FIG01464897 putative hyaluronoglucosaminidase +FIG01464900 Modification methylase HgiBI (EC 2.1.1.37) (Cytosine-specific methyltransferase HgiBI) (M.HgiBI) +FIG01464906 Hyaluronoglucosaminidase precursor (EC 3.2.1.35) +FIG01464923 DSBH domain containing protein +FIG01464928 FIG00837887: hypothetical protein +FIG01464958 COG1275: Tellurite resistance protein and related permeases +FIG01464967 Uncharacterized protein PA2301 +FIG01464968 PTS system, unknown pentitol phosphotransferase enzyme IIB component( EC:2.7.1.69 ) +FIG01464985 Arabinosidase +FIG01465004 putative SanA protein +FIG01465013 Uncharacterized peroxidase-related +FIG01465055 FIG00417050: hypothetical protein +FIG01465083 universal stress protein family domain protein +FIG01465090 Type IV pilus biogenesis protein PilN +FIG01465107 18 Kd antigen-like protein +FIG01465117 Hydrolase, alpha/beta fold family protein, At1g52510/AT4G12830 homolog 2 +FIG01465128 ring finger protein HAC1 +FIG01465140 FIG00427520: hypothetical protein +FIG01465169 peptidase, M50 family +FIG01465181 FIG00763340: hypothetical protein +FIG01465186 Uncharacterized protein yozJ +FIG01465199 FIG00742980: hypothetical protein +FIG01465200 hypothetical protein +FIG01465203 iron-siderophore uptake ABC system ATP-binding component +FIG01465219 FIG00622899: hypothetical protein +FIG01465231 FIG01000384: hypothetical protein +FIG01465235 FIG00744984: hypothetical protein +FIG01465241 FIG00624452: hypothetical protein +FIG01465316 Possible malate permease +FIG01465330 FIG00623398: hypothetical protein +FIG01465368 FIG00623647: hypothetical protein +FIG01465387 FIG00939684: hypothetical protein +FIG01465437 FIG00766905: hypothetical protein +FIG01465439 outer membrane protein P1, putative +FIG01465482 Large exoproteins involved in heme utilization or adhesion +FIG01465492 FIG00408175: hypothetical protein +FIG01465498 iron(III)-transport ATP-binding protein sfuC( EC:3.6.3.30 ) +FIG01465511 oxidoreductase, molybdopterin-binding +FIG01465524 site-specific recombinase (resolvase family) +FIG01465527 Predicted CDP-4-keto-6-deoxy-D-glucose-3-dehydrase +FIG01465557 Putative aldose-1-epimerase (EC 5.1.3.3) +FIG01465559 chitinase domain protein +FIG01465581 FIG00389919: hypothetical protein +FIG01465584 ABC transporter of LPS O-antigen, Wzm +FIG01465607 SLH, S-layer homology domain W +FIG01465608 protein similar to YcbI of B. subtilis +FIG01465618 FIG00747795: hypothetical protein +FIG01465619 FIG01235567: hypothetical protein +FIG01465623 Succinate-semialdehyde dehydrogenase [NAD(P)+] (EC 1.2.1.16) +FIG01465627 FIG00413724: hypothetical protein +FIG01465658 cyanate transport system protein CynX, putative +FIG01465664 Putative trans-acting regulator pXO2-62/BXB0076/GBAA_pXO2_0076 +FIG01465667 FIG00835612: hypothetical protein +FIG01465675 conjugal transfer protein (traG) +FIG01465690 Putative HTH-type transcriptional regulator +FIG01465714 FIG01192194: hypothetical protein +FIG01465731 redoxin +FIG01465740 flotillin 1 +FIG01465773 FIG00850356: hypothetical protein +FIG01465774 ISSth4, transposase, IS30 family, truncated +FIG01465783 FIG00515986: hypothetical protein +FIG01465791 Prophage LysC protein +FIG01465821 probable acyl carrier protein +FIG01465823 putative methyltransferase +FIG01465827 Serralysin-like metalloprotease +FIG01465833 TniA putative transposase +FIG01465867 FIG00640727: hypothetical protein +FIG01465871 PglZ domain +FIG01465882 Probable ATP-binding protein NMA0346 +FIG01465900 putative peptidase( EC:3.5.1.14 ) +FIG01465931 pyridine nucleotide-disulphide oxidoreductase +FIG01465960 HrgA protein (Fragment) +FIG01465979 dihydrodipicolinate synthetase +FIG01465981 RarD protein +FIG01466008 Protein of unknown function UPF0236 +FIG01466015 Possible sulfotransferase +FIG01466023 FIG00767173: hypothetical protein +FIG01466035 Uncharacterized protein MJ0714 +FIG01466039 possible hydrolase, HAD superfamily protein +FIG01466087 GAF domain/GGDEF domain protein +FIG01466088 COG1164: Oligoendopeptidase F +FIG01466102 prophage ps1 protein 07 +FIG01466114 Serine/threonine-protein kinase pkn6 (EC 2.7.11.1) +FIG01466118 FIG00884085: hypothetical protein +FIG01466126 FIG00356092: hypothetical protein +FIG01466156 FIG01132221: hypothetical protein +FIG01466187 nitrogen fixation-related protein +FIG01466188 FIG00765136: hypothetical protein +FIG01466206 Putative traG-family protein +FIG01466209 Probable HTH-type transcriptional regulator lrrA +FIG01466220 Sulfur oxidation protein +FIG01466225 L-gulono-gamma-lactone oxidase (EC 1.1.3.8) +FIG01466226 BH0950 unknown conserved protein +FIG01466229 FIG00471201: hypothetical protein +FIG01466241 GNAT family N-acetyltransferase +FIG01466249 FIG00769365: hypothetical protein +FIG01466251 Response regulator containing CheY-like receiver domain and AraC-type DNA-binding domain +FIG01466284 FIG00644482: hypothetical protein +FIG01466286 pipeptidyl-peptidase VI +FIG01466313 FIG00567499: hypothetical protein +FIG01466354 epoxide hydrolase +FIG01466368 fatty acid hydroxylase family protein +FIG01466374 B. burgdorferi predicted coding region BB0614 +FIG01466375 putative nucleoside-diphosphate-sugar epimerase +FIG01466383 FIG00624399: hypothetical protein +FIG01466388 Glucoamylase and related glycosyl hydrolases +FIG01466390 FIG01080591: hypothetical protein +FIG01466396 FIG01046668: hypothetical protein +FIG01466401 FIG00451104: hypothetical protein +FIG01466407 Mll7704 protein +FIG01466423 FIG00385413: hypothetical protein +FIG01466432 hydroxylaminobenzene mutase +FIG01466474 FIG00821429: hypothetical protein +FIG01466482 F5/8 type C domain protein +FIG01466490 FIG00389709: hypothetical protein +FIG01466495 FIG01132163: hypothetical protein +FIG01466497 FIG01241543: hypothetical protein +FIG01466502 FIG01120048: hypothetical protein +FIG01466504 FIG00746353: hypothetical protein +FIG01466507 oxidoreductase, aldo-keto reductase family +FIG01466540 FIG00531508: hypothetical protein +FIG01466543 hypothetical protein +FIG01466552 aminotransferase, class V +FIG01466553 ATPase involved in DNA replication +FIG01466573 FIG00632267: hypothetical protein +FIG01466583 Ser-Asp rich fibrinogen-binding, bone sialoprotein-binding protein +FIG01466587 THUA +FIG01466588 FIG00385091: hypothetical protein +FIG01466594 FIG00412435: hypothetical protein +FIG01466596 Transposase +FIG01466617 similarity to competence locus E protein 3 +FIG01466640 FIG00959816: hypothetical protein +FIG01466650 FIG00741086: hypothetical protein +FIG01466653 IS903 transposase +FIG01466670 resolvase family recombinase +FIG01466678 O-GlcNAcase NagJ( EC:3.2.1.52 ) +FIG01466683 Rhodanese-like membrane protein +FIG01466692 FIG01248887: hypothetical protein +FIG01466703 FIG00364892: hypothetical protein +FIG01466704 FIG00344194: hypothetical protein +FIG01466709 FIG00768493: hypothetical protein +FIG01466735 Predicted O-linked N-acetylglucosamine transferase, SPINDLY family +FIG01466736 Predicted metalloendopeptidase +FIG01466739 heat shock protein HSP20 +FIG01466747 putative conserved membrane protein +FIG01466759 Zinc finger, SWIM-type +FIG01466797 FIG00518342: hypothetical protein +FIG01466798 FIG00351584: hypothetical protein +FIG01466819 FIG00347434: hypothetical protein +FIG01466831 FIG00361879: hypothetical protein +FIG01466844 FIG00549266: hypothetical protein +FIG01466866 VRR-NUC domain protein +FIG01466876 Lysine biosynthesis enzyme LysX +FIG01466921 FIG00524103: hypothetical protein +FIG01466928 FIG00826886: hypothetical protein +FIG01466940 FIG00633318: hypothetical protein +FIG01466944 PUTATIVE TWO-COMPONENT REGULATOR +FIG01466958 Polymorphic membrane protein( EC:3.4.24.40 ) +FIG01466969 FIG00350819: hypothetical protein +FIG01466981 possible ABC transporter component, ATP binding protein +FIG01466983 FIG01018879: hypothetical protein +FIG01466985 3D domain-containing protein +FIG01466986 dihydrodipicolinate synthase +FIG01466989 FIG00385163: hypothetical protein +FIG01467026 FIG00344124: hypothetical protein +FIG01467031 FIG00745899: hypothetical protein +FIG01467049 clindamycin resistance transfer factor BtgB +FIG01467063 FIG00472059: hypothetical protein +FIG01467068 FIG00361630: hypothetical protein +FIG01467078 FIG00956946: hypothetical protein +FIG01467120 FIG01041216: hypothetical protein +FIG01467152 penicillin-binding protein 4* +FIG01467178 FIG00876371: hypothetical protein +FIG01467225 FIG00353269: hypothetical protein +FIG01467226 Bll2291 protein +FIG01467233 membrane protein, putative +FIG01467265 hypothetical lipoportein SCF5531 +FIG01467267 Uncharacterized protein MJ0540 +FIG01467283 FIG00353107: hypothetical protein +FIG01467294 TatD-related deoxyribonuclease +FIG01467307 FIG00402893: hypothetical protein +FIG01467314 hypothetical protein +FIG01467317 iron-sulfur cluster-binding protein +FIG01467324 Bll0285 protein +FIG01467326 FIG00627700: hypothetical protein +FIG01467391 FIG00627422: hypothetical protein +FIG01467394 protein of unknown function UPF0180 +FIG01467400 Addiction module component +FIG01467414 cell division protein FtsH +FIG01467428 Hit family protein +FIG01467433 Sugar kinase, ribokinase family protein +FIG01467437 FIG00403395: hypothetical protein +FIG01467463 FIG01008164: hypothetical protein +FIG01467465 YwoG +FIG01467487 FIG00624267: hypothetical protein +FIG01467492 FIG00513709: hypothetical protein +FIG01467512 ABC transporter ATP-binding protein SkfF +FIG01467545 Mucin 5 +FIG01467549 FIG00384905: hypothetical protein +FIG01467563 Putative ATP-dependent helicase +FIG01467574 FIG00380100: hypothetical protein +FIG01467583 Response regulator receiver:CheW-like protein:ATP-binding region, ATPase-like:Hpt +FIG01467585 protein kinase C inhibitor (HIT family) +FIG01467606 FIG00361987: hypothetical protein +FIG01467631 phage head completion protein (GPL) +FIG01467634 Mandelate racemase/muconate lactonizing enzyme, C-terminal domain protein +FIG01467645 heat-inducible protein +FIG01467651 FIG00384869: hypothetical protein +FIG01467664 Drug resistance transporter, EmrB/QacA family protein +FIG01467680 Osmotically inducible lipoprotein B +FIG01467682 FIG00816435: hypothetical protein +FIG01467685 FIG01165641: hypothetical protein +FIG01467686 plasmid encoded RepA protein +FIG01467687 FIG01166669: hypothetical protein +FIG01467738 FIG00514687: hypothetical protein +FIG01467741 P-loop containing nucleoside triphosphate hydrolase +FIG01467742 FIG01115519: hypothetical protein +FIG01467750 contains protein-disulfide isomerase domain +FIG01467797 acyl-CoA dehydrogenase domain protein +FIG01467804 putative sugar transport system (permease) +FIG01467835 FIG00624696: hypothetical protein +FIG01467869 methyltransferase( EC:2.1.- ) +FIG01467882 Glycine-rich cell wall protein +FIG01467883 putative glucosylglycerolphosphate phosphatase +FIG01467966 FIG00623477: hypothetical protein +FIG01467972 Protein of unknown function DUF1255 +FIG01468000 Lipopolysaccharide core biosynthesis glycosyl transferase LpsE +FIG01468012 FIG01038720: hypothetical protein +FIG01468093 Transcriptional regulator PqrA, TetR family +FIG01468097 POSSIBLE BACTERIOFERRITIN BFRB +FIG01468098 FIG00673720: hypothetical protein +FIG01468118 UPF0331 protein MJ1216 +FIG01468127 Uncharacterized methyltransferase Rv0089/MT0098 (EC 2.1.1.-) +FIG01468141 diamine acetyltransferase 2( EC:2.3.1.57 ) +FIG01468142 Hemolysin C +FIG01468151 FIG00764451: hypothetical protein +FIG01468163 PUTATIVE VGR-RELATED PROTEIN +FIG01468180 FIG00424626: hypothetical protein +FIG01468202 FIG00768734: hypothetical protein +FIG01468219 syc2005_c +FIG01468235 FIG00519929: hypothetical protein +FIG01468238 FIG00461465: hypothetical protein +FIG01468246 alternate gene name: ipa-59d +FIG01468262 Putative mitochondrial protein, with 2 coiled coil-4 domains, of bilaterial origin, Nuclear Pore complex Protein NPP-11 (77.2 kD) (npp-11) [Source:;Acc:Cel.17399] +FIG01468269 transporter, major facilitator family +FIG01468271 Sensory box protein/sigma-54 dependent DNA-binding response regulator +FIG01468292 FIG01068911: hypothetical protein +FIG01468298 Surface protein SdrI +FIG01468367 Rhodanese domain protein / Ankyrin +FIG01468370 transcription response regulator-like protein +FIG01468381 Probable aminopeptidase (EC 3.4.11.-) +FIG01468389 nuclear transport factor 2 (NTF2) domain family protein +FIG01468416 FIG00406415: hypothetical protein +FIG01468434 Hypothetical membrane spanning protein YojJ +FIG01468462 prophage LambdaSa04, LysM domain protein +FIG01468465 FIG00385149: hypothetical protein +FIG01468473 FIG00406539: hypothetical protein +FIG01468475 Ribose 5-phosphate isomerase (EC 5.3.1.6) +FIG01468481 FIG01130232: hypothetical protein +FIG01468488 Zinc protease, insulinase family +FIG01468490 transglutaminase-like superfamily member +FIG01468526 FIG00424882: hypothetical protein +FIG01468528 Choline binding protein G +FIG01468530 ORF_ID:asr8054 unknown protein +FIG01468538 putative N-acetylmuramoyl-L-alanine amidase +FIG01468559 Transposase and inactivated derivative, IS30 family +FIG01468618 metal transporter family GufA protein +FIG01468620 cytochrome c' +FIG01468621 FIG00848755: hypothetical protein +FIG01468622 FIG00388990: hypothetical protein +FIG01468632 FIG00406898: hypothetical protein +FIG01468653 exchangeable effector locus protein +FIG01468659 FIG00406272: hypothetical protein +FIG01468666 FIG00749960: hypothetical protein +FIG01468700 DoxD family protein, putative +FIG01468724 Carbon-nitrogen hydrolase family protein (EC 3.5.-.-) +FIG01468751 hypothetical protein +FIG01468760 FIG00513237: hypothetical protein +FIG01468783 Dehydrogenase with different specificities (related to short-chain alcohol dehydrogenase) +FIG01468794 Lipoprotein NlpD +FIG01468832 FIG00623812: hypothetical protein +FIG01468860 HAD superfamily protein +FIG01468866 FIG00639591: hypothetical protein +FIG01468867 FIG00517887: hypothetical protein +FIG01468893 FIG00384872: hypothetical protein +FIG01468898 FIG00766869: hypothetical protein +FIG01468915 FIG01222773: hypothetical protein +FIG01468946 Deca-heme C-type cytochrome-like +FIG01468961 FIG00623194: hypothetical protein +FIG01469007 FIG01166035: hypothetical protein +FIG01469028 FIG00644695: hypothetical protein +FIG01469032 IS, phage, Tn; Transposon-related functions +FIG01469035 IS1647-like transposase +FIG01469057 FIG00687966: hypothetical protein +FIG01469066 prophage LambdaBa04, DNA-binding protein +FIG01469080 major facilitator superfamily (MFS) transporter +FIG01469090 Uncharacterized protein ysnD +FIG01469134 Protein of unknown function DUF342 +FIG01469142 FIG01046957: hypothetical protein +FIG01469159 FIG00385737: hypothetical protein +FIG01469185 sugar-non-specific nuclease inhibitor +FIG01469257 M-like protein +FIG01469281 putative mobilization protein MobS +FIG01469296 Putative SPFH domain protein +FIG01469304 Dyp-type peroxidase family protein +FIG01469307 COG3038: Cytochrome B561 +FIG01469312 Mlr1315 protein +FIG01469319 FIG00937950: hypothetical protein +FIG01469331 FIG00964222: hypothetical protein +FIG01469390 126aa long conserved hypothetical protein +FIG01469393 FIG00765851: hypothetical protein +FIG01469406 PatA subfamily protein +FIG01469417 FIG00387988: hypothetical protein +FIG01469458 putative transposase +FIG01469461 Lactoylglutation lyase +FIG01469471 FIG00362153: hypothetical protein +FIG01469472 Lin1295 protein +FIG01469474 FIG00361382: hypothetical protein +FIG01469475 glucosamine-6-phosphate isomerase, putative +FIG01469478 Transcriptional regulator, CadC +FIG01469490 response regulator receiver modulated diguanylate phosphodiesterase +FIG01469495 FIG01133913: hypothetical protein +FIG01469503 FIG00631685: hypothetical protein +FIG01469522 FIG00362291: hypothetical protein +FIG01469530 FIG00568965: hypothetical protein +FIG01469547 FIG00900591: hypothetical protein +FIG01469548 FIG00846766: hypothetical protein +FIG01469554 Uncharacterized protein MJ1676 +FIG01469570 FIG00351570: hypothetical protein +FIG01469572 FIG00411845: hypothetical protein +FIG01469574 FIG00639568: hypothetical protein +FIG01469582 FIG00758617: hypothetical protein +FIG01469583 Rod shape determination protein +FIG01469584 FIG00569180: hypothetical protein +FIG01469596 Antitoxin of toxin-antitoxin stability system +FIG01469613 hypothetical protein +FIG01469614 FIG00521972: hypothetical protein +FIG01469622 esterase/lipase/thioesterase +FIG01469677 ROrf10 +FIG01469684 putative transport transmembrane protein +FIG01469693 galactosyltransferase protein +FIG01469699 putative cyanate transporter +FIG01469700 FIG00846944: hypothetical protein +FIG01469704 Macrocin-O-methyltransferase +FIG01469711 FIG00873469: hypothetical protein +FIG01469715 Hydroxymethylpyrimidine phosphate kinase ThiD (EC 2.7.4.7) +FIG01469721 Ribosomal large subunit pseudouridine synthase B +FIG01469735 Modification methylase PaeR7I (EC 2.1.1.72) +FIG01469751 Pyridoxamine 5'-phosphate oxidase-like, FMN-binding domain +FIG01469758 FIG00825025: hypothetical protein +FIG01469773 FIG00923444: hypothetical protein +FIG01469782 glycosyltransferase homolog +FIG01469784 ATP-binding region, ATPase-like +FIG01469796 FIG00351277: hypothetical protein +FIG01469801 FIG00766806: hypothetical protein +FIG01469811 FIG00634356: hypothetical protein +FIG01469831 putative superinfection immunity protein +FIG01469835 metabolite transporter, MFS superfamily +FIG01469849 FIG00361799: hypothetical protein +FIG01469870 pXO1-41 +FIG01469874 FIG00352258: hypothetical protein +FIG01469881 hypothetical protein +FIG01469885 hypothetical protein +FIG01469889 FIG00639459: hypothetical protein +FIG01469915 ribose ABC transporter, permease protein +FIG01469919 FIG00622854: hypothetical protein +FIG01469922 FIG00632585: hypothetical protein +FIG01469923 similarity to tryptophan repressor binding protein +FIG01469939 FIG00468812: hypothetical protein +FIG01469961 nuclear antigen EBNA1 +FIG01469994 Transmembrane transport protein MmpL1 +FIG01470000 FIG00409752: hypothetical protein +FIG01470014 cobalt dependent X-Pro dipeptidase +FIG01470028 FIG00509706: hypothetical protein +FIG01470030 putative hemolysin secretion protein +FIG01470045 collagenase, putative +FIG01470054 Sll1774 protein +FIG01470057 2-Hydroxy-6-Oxo-6-Phenylhexa-2,4-Dienoate hydrolase +FIG01470100 type I restriction-modification system specificity subunit +FIG01470120 probable sodium-dependent transporter +FIG01470145 FIG00348156: hypothetical protein +FIG01470149 Conserved putative membrane protein +FIG01470171 FIG00937161: hypothetical protein +FIG01470172 transposase for IS3509b +FIG01470202 type 3a, cellulose-binding domain protein +FIG01470205 ferredoxin-thioredoxin reductase, variable subunit +FIG01470219 FIG00756143: hypothetical protein +FIG01470223 FIG00978246: hypothetical protein +FIG01470225 FIG00688734: hypothetical protein +FIG01470243 3-methyl-2-oxobutanoate hydroxymethyltransferase( EC:2.1.2.11 ) +FIG01470247 FIG00388240: hypothetical protein +FIG01470255 pXO1-30 +FIG01470260 FIG00512722: hypothetical protein +FIG01470264 FIG01117408: hypothetical protein +FIG01470271 IcmP +FIG01470277 FIG00450046: hypothetical protein +FIG01470301 baseplate assembly protein W, putative +FIG01470305 hypothetical protein +FIG01470331 two component response regulator protein +FIG01470364 Em-like protein GEA1 (EM1) +FIG01470365 FIG00748715: hypothetical protein +FIG01470372 Quinol oxidase (SoxABC), subunit II (soxA) +FIG01470373 FIG00410169: hypothetical protein +FIG01470381 FIG00640145: hypothetical protein +FIG01470388 DNA-directed RNA polymerase, alpha subunit/40 kD subunit +FIG01470390 FIG00642438: hypothetical protein +FIG01470403 outer membrane efflux family protein +FIG01470404 putative conserved secreted protein +FIG01470424 para-aminobenzoate synthase, subunit I +FIG01470426 Transposase and inactivated derivatives, IS1 family +FIG01470428 FIG00352116: hypothetical protein +FIG01470432 Possible lipoprotein lprI +FIG01470451 putative outer membrane protein HomB +FIG01470453 FIG00756738: hypothetical protein +FIG01470457 RecG-like helicase +FIG01470464 FIG00361885: hypothetical protein +FIG01470473 ATP-dependent RNA helicase, DEAD box family protein +FIG01470484 FIG01166001: hypothetical protein +FIG01470505 spore germination protein KC +FIG01470508 Transcriptional regulatory protein dcuR +FIG01470509 Peptidyl-dipeptidase A precursor (EC 3.4.15.1) +FIG01470510 possible 5'-3' exonuclease, C-terminal SAM fol +FIG01470524 hypothetical protein +FIG01470527 FIG00641443: hypothetical protein +FIG01470534 lytic transglycolase +FIG01470536 negative regulation of the citrate synthase I gene (citA) +FIG01470541 DNA topoisomerase VI, subunit A +FIG01470543 Uncharacterized conserved protein clustered to carbohydrate kinase +FIG01470555 Phage terminase large subunit GpA +FIG01470587 FIG00408760: hypothetical protein +FIG01470591 solute-binding lipoprotein +FIG01470600 Possible epoxide hydrolase-related protein +FIG01470605 FIG00623099: hypothetical protein +FIG01470625 conserved hypothetical protein-putative tRNA adenylyltransferase +FIG01470632 FIG01114578: hypothetical protein +FIG01470639 probable 4-hydroxybenzoyl-CoA thioesterase +FIG01470662 cytochrome P-450 +FIG01470678 general secretion pathway protein G +FIG01470695 FIG00408765: hypothetical protein +FIG01470723 FIG00414623: hypothetical protein +FIG01470745 Putative pectinesterase (EC 3.1.1.11) +FIG01470747 Aminopeptidase PepA-related protein +FIG01470751 possible regulatory protein +FIG01470753 FIG01017991: hypothetical protein +FIG01470781 Glyscosyl transferase, group 1 family protein +FIG01470797 Uroporphyrinogen-III decarboxylase-like protein +FIG01470813 hypothetical protein +FIG01470824 FIG00956682: hypothetical protein +FIG01470841 Aklanonic acid methyltransferase +FIG01470852 FIG00816822: hypothetical protein +FIG01470864 peptidase, S41 family +FIG01470867 FIG00385457: hypothetical protein +FIG01470887 DNA metabolism; DNA replication, recombination, and repair +FIG01470888 FIG00410222: hypothetical protein +FIG01470889 Probable periplasmic protein Cj0776c +FIG01470903 thioredoxin M +FIG01470921 replication protein C +FIG01470942 Possible efflux permease +FIG01470945 rubrerythrin family protein +FIG01471006 5'-methylthioadenosine nucleosidase-related protein +FIG01471007 Eae protein +FIG01471012 Acyl-CoA dehydrogenase +FIG01471046 FIG042921: similarity to aminoacyl-tRNA editing enzymes YbaK, ProX +FIG01471063 photosystem I reaction center subunit VIII +FIG01471091 transposase (class V) +FIG01471093 Ribonucleotide reductase of class II (coenzyme B12-dependent), alpha subunit (EC 1.17.4.1) +FIG01471113 FIG01202292: hypothetical protein +FIG01471137 ABC transporter family protein +FIG01471139 MchD protein +FIG01471140 6-pyruvoyl tetrahydropterin synthase and hypothetical protein +FIG01471157 iron-dependent transcriptional repressor +FIG01471160 hypothetical protein +FIG01471161 FIG01117287: hypothetical protein +FIG01471192 Prophage Lp1 protein 19 +FIG01471197 Ornithine utilization regulator +FIG01471198 Chloramphenicol phosphotransferase-like +FIG01471201 FIG00826641: hypothetical protein +FIG01471213 3-hydroxyisobutyrate dehydrogenase related beta-hydroxyacid dehydrogenase +FIG01471218 FIG00531169: hypothetical protein +FIG01471256 ABC TRANSPORTER SUBSTRATE-BINDING PROTEIN +FIG01471268 FIG00343887: hypothetical protein +FIG01471273 FIG00356643: hypothetical protein +FIG01471276 Asl2557 protein +FIG01471294 UPF0154 protein MG335.1 homolog +FIG01471295 FIG00746144: hypothetical protein +FIG01471296 FIG00411411: hypothetical protein +FIG01471318 Quinolone resistence NorA protein +FIG01471338 FIG00522895: hypothetical protein +FIG01471375 Similar to C-ter. fragment of UDP-glucuronosyltransferases, YpfP B.subtilis related +FIG01471376 putative carboxy-phosphonoenolpyruvate mutase +FIG01471378 FIG00623549: hypothetical protein +FIG01471402 Thiamine pyrophosphate-requiring protein PA2108 +FIG01471410 2-[hydroxy(phenyl)methyl]-succinyl-CoA dehydrogenase beta subunit (EC 1.1.1.35) +FIG01471414 ferredoxin +FIG01471431 NysM +FIG01471433 hypothetical protein +FIG01471442 Flagellar hook-basal body protein +FIG01471502 Protease inhibitor I4 +FIG01471516 Alpha-helical coiled coil protein +FIG01471525 conserved domain protein +FIG01471542 Integrase catalytic region +FIG01471583 putative cyanate ABC transporter, substrate binding protein +FIG01471591 Transcriptional regulator, LysR family +FIG01471612 Hypothetical outer membrane usher protein yraJ precursor +FIG01471643 Mll8244 protein +FIG01471656 FIG00766553: hypothetical protein +FIG01471660 acetoin dehydrogenase E2 component, probable +FIG01471666 FIG01228831: hypothetical protein +FIG01471669 aerobic aromate catabolism +FIG01471681 FIG00385377: hypothetical protein +FIG01471683 CHLPS 43 kDa protein homolog_1 +FIG01471686 FIG00523424: hypothetical protein +FIG01471691 FIG00767787: hypothetical protein +FIG01471707 FIG00898834: hypothetical protein +FIG01471753 probable beta-1,3-exoglucanase +FIG01471759 Hvp 32 +FIG01471760 Hydrolase of the alpha/beta superfamily +FIG01471813 FIG00624130: hypothetical protein +FIG01471820 FIG00388785: hypothetical protein +FIG01471831 hypothetical protein Psyc020233 +FIG01471850 FIG00550186: hypothetical protein +FIG01471871 ORF_ID:alr7515 unknown protein +FIG01471873 FIG00623026: hypothetical protein +FIG01471892 FIG00522693: hypothetical protein +FIG01471896 FIG033577: Phage protein +FIG01471906 FIG00766671: hypothetical protein +FIG01471909 hypothetical protein +FIG01471915 UbiC transcription regulator-associated domain protein +FIG01471923 Hypothetical protein, CF-19 family +FIG01471936 7,8 dihydropteroate synthase (methanopterin) +FIG01471948 Surface antigen (D15) precursor +FIG01471977 DNA recombinase +FIG01471984 putative beta-glucanase precursor +FIG01472029 hypothetical protein +FIG01472061 FIG01231228: hypothetical protein +FIG01472077 Probable serine/threonine-protein kinase pkwA (EC 2.7.11.1) +FIG01472084 FIG00982399: hypothetical protein +FIG01472123 DNA-binding domain, excisionase family +FIG01472124 FIG00351041: hypothetical protein +FIG01472152 FIG00363834: hypothetical protein +FIG01472161 NagC-like transcriptional regulator of glucosamine ABC transporter and kinase cluster +FIG01472185 possible lipase/esterase +FIG01472191 FIG00404088: hypothetical protein +FIG01472192 ABC TRANSPORTER INTEGRAL MEMBRANE PROTEIN +FIG01472208 FIG01227062: hypothetical protein +FIG01472210 FIG00402852: hypothetical protein +FIG01472247 Gll1135 protein +FIG01472251 hypothetical protein +FIG01472286 ArsR family transcriptional regulator +FIG01472288 Myo-inositol 2-dehydrogenase like (EC 1.1.1.18) +FIG01472311 N-acetylmuramoyl-L-alanine amidase-like protein +FIG01472326 Putative amidase +FIG01472340 putative RNA-binding protein rbpA +FIG01472382 putative; ORF located using Glimmer/Genemark +FIG01472404 1,4-beta-N-acetylmuramidase +FIG01472410 TrfA +FIG01472422 probable integral membrane protein Cj1053c +FIG01472430 transposon gamma-delta resolvase +FIG01472443 FIG00350639: hypothetical protein +FIG01472446 nisin-resistance protein, putative +FIG01472448 Lipase precursor (EC 3.1.1.3) +FIG01472482 probable type II restriction enzyme similar to Sau3AI +FIG01472503 PTS system, lactose/cellobiose-specific IIB component +FIG01472545 RNA polymerase sigma factor sigk +FIG01472558 Putative sugar acetyltransferase +FIG01472570 FIG01048676: hypothetical protein +FIG01472592 protein of unknown function DUF610, YibQ +FIG01472609 FIG00622871: hypothetical protein +FIG01472628 FIG00362307: hypothetical protein +FIG01472639 FIG01182661: hypothetical protein +FIG01472647 ABC transporter ATP-binding protein, putative +FIG01472648 FIG00469031: hypothetical protein +FIG01472660 cassette chromosome recombinase B1 +FIG01472661 Putative phage prohead protease +FIG01472664 rhs core protein with extension +FIG01472665 syc0785_c +FIG01472682 dolichol-P-glucose synthetase +FIG01472720 FIG00938292: hypothetical protein +FIG01472731 protein of unknown function DUF1284 +FIG01472734 FIG00361487: hypothetical protein +FIG01472754 FIG00482511: hypothetical protein +FIG01472761 hypothetical protein +FIG01472768 FIG00841678: hypothetical protein +FIG01472775 FIG00870598: hypothetical protein +FIG01472795 putative integral membrane protein SCJ12.13c +FIG01472874 FIG00904252: hypothetical protein +FIG01472886 phosphoribosylamine--glycine ligase +FIG01472913 FIG00733701: hypothetical protein +FIG01472929 ribose phosphate isomerase B +FIG01472934 FIG00770865: hypothetical protein +FIG01472935 Roi protein +FIG01472937 FIG00347684: hypothetical protein +FIG01472955 FIG00353483: hypothetical protein +FIG01472962 CoA-binding domain +FIG01472975 FIG00350766: hypothetical protein +FIG01472977 FIG00828758: hypothetical protein +FIG01473012 FIG00764627: hypothetical protein +FIG01473060 putative cell Surface Protein +FIG01473072 Predicted glycerol-1-phosphate dehydrogenase, arabinose operon +FIG01473094 FIG00356770: hypothetical protein +FIG01473106 FIG01113972: hypothetical protein +FIG01473109 restriction endonuclease-related protein +FIG01473115 [Bacteriophage phi Sa 3mw] +FIG01473120 probable ABC transport system permease protein for sugars +FIG01473136 sensor protein kinase +FIG01473142 FIG00633411: hypothetical protein +FIG01473144 phosphate-binding protein, putative +FIG01473148 FIG01238918: hypothetical protein +FIG01473163 FIG00684568: hypothetical protein +FIG01473171 FIG01255177: hypothetical protein +FIG01473182 Bona fide RidA/YjgF/TdcF/RutC subgroup +FIG01473189 FIG01235942: hypothetical protein +FIG01473192 FIG00361990: hypothetical protein +FIG01473198 FIG01048356: hypothetical protein +FIG01473204 FIG00362267: hypothetical protein +FIG01473211 FIG00525207: hypothetical protein +FIG01473223 FIG00782166: hypothetical protein +FIG01473238 EpsP +FIG01473248 evdI +FIG01473262 FIG00515535: hypothetical protein +FIG01473269 FIG00494594: hypothetical protein +FIG01473285 phage-like element pbsx protein XkdM +FIG01473286 Probable glycosyltransferase (EC 2.4.1.58) +FIG01473311 FIG00351013: hypothetical protein +FIG01473316 FIG01214210: hypothetical protein +FIG01473320 FIG00623699: hypothetical protein +FIG01473337 hypothetical protein +FIG01473338 FIG01213564: hypothetical protein +FIG01473341 Glycolate oxidase subunit +FIG01473362 Hybrid sensory histidine kinase +FIG01473373 translation initiation factor IF-2 +FIG01473425 FIG01239463: hypothetical protein +FIG01473464 COG3422: Uncharacterized conserved protein +FIG01473493 EA59 gene protein +FIG01473534 Predicted secreted protein +FIG01473539 FIG00624604: hypothetical protein +FIG01473549 FIG00513502: hypothetical protein +FIG01473550 syc2440_c +FIG01473573 FIG00817395: hypothetical protein +FIG01473579 IstB domain protein ATP-binding protein +FIG01473606 FIG00351699: hypothetical protein +FIG01473620 FIG00412264: hypothetical protein +FIG01473623 tRNA methylase Trm12p Wyeosine biosynthesis +FIG01473631 prophage pi2 protein 27 +FIG01473642 hypothetical protein +FIG01473648 transcriptional regulator, LuxR-family +FIG01473653 hypothetical protein +FIG01473663 FIG01166426: hypothetical protein +FIG01473673 FIG01116447: hypothetical protein +FIG01473681 Possible membrane protein +FIG01473702 FIG146484: Hypothetical protein +FIG01473705 YvhJ +FIG01473707 putative reductase +FIG01473723 putative transport protein +FIG01473728 FIG00769636: hypothetical protein +FIG01473743 FIG01245624: hypothetical protein +FIG01473765 membrane fusion protein +FIG01473802 Synaptic vesicle membrane protein VAT-1 homolog (EC 1.-.-.-) +FIG01473804 Ferrichrome-binding protein +FIG01473808 FIG00644346: hypothetical protein +FIG01473809 Collagen adhesin +FIG01473813 hypothetical protein +FIG01473834 FIG00451342: hypothetical protein +FIG01473877 probable multidrug efflux transporter +FIG01473879 putative ORF +FIG01473889 Glycosyltransferase-like protein +FIG01473894 peptidyl-prolyl cis-trans isomerase, PpiB( EC:5.2.1.8 ) +FIG01473899 similar to CONJUGAL TRANSFER PROTEIN TRBI +FIG01473910 Gll3447 protein +FIG01473914 FIG00643687: hypothetical protein +FIG01473925 FIG00385636: hypothetical protein +FIG01473934 Small integral membrane protein +FIG01473937 FIG00425647: hypothetical protein +FIG01473938 hypothetical protein +FIG01473942 FIG00409813: hypothetical protein +FIG01473964 Lignostilbene-alpha, beta-dioxygenase +FIG01473980 Nucleoside-diphosphate-sugar pyrophosphorylase +FIG01474023 RNA polymerase sigma-70 factor, ECF subfamily +FIG01474028 putative transcriptional regulator, lacI family protein +FIG01474049 FIG00632832: hypothetical protein +FIG01474085 FIG00640229: hypothetical protein +FIG01474090 putative sporulation protein (partial match) +FIG01474105 probable oxidoreductase( EC:5.1.3.- ) +FIG01474107 Poly(3-hydroxyalkanoate) depolymerase (EC 3.1.1.-) +FIG01474112 FIG00814996: hypothetical protein +FIG01474128 S-layer-like protein region +FIG01474140 CCAAT-box DNA binding protein subunit B +FIG01474144 FIG00388956: hypothetical protein +FIG01474160 molecular chaperone +FIG01474174 sulfite oxidase-like oxidoreductase +FIG01474194 DJ-1/PfpI-family transcriptional regulator +FIG01474201 AviX12 +FIG01474204 Putative membrane protein +FIG01474213 Conserved protein containing a Zn-ribbon-like motif, possibly RNA-binding +FIG01474222 FIG00424076: hypothetical protein +FIG01474224 protein of unknown function DUF711 +FIG01474228 putative transcriptional regulator (lysR family) +FIG01474231 FIG00895408: hypothetical protein +FIG01474246 probable sensory box/GGDEF family protein +FIG01474256 FIG00767593: hypothetical protein +FIG01474283 FIG00388813: hypothetical protein +FIG01474284 FliB family protein +FIG01474322 FIG00767035: hypothetical protein +FIG01474376 FIG01048448: hypothetical protein +FIG01474383 no significant database hits. CDS DNA has a low G+C content, 40.61 % +FIG01474401 FIG00734133: hypothetical protein +FIG01474409 putative Lsr2-like protein +FIG01474419 probable neprilysin( EC:3.4.24.11 ) +FIG01474437 FIG00533155: hypothetical protein +FIG01474459 DNA/RNA-binding protein Alba +FIG01474460 FIG00698372: hypothetical protein +FIG01474478 FIG00688112: hypothetical protein +FIG01474480 FIG00385503: hypothetical protein +FIG01474490 UDP-glucoronosyl and UDP-glucosyltransferases family protein +FIG01474512 FIG01245856: hypothetical protein +FIG01474515 FIG00527233: hypothetical protein +FIG01474557 blr2607; unknown protein +FIG01474560 FIG00347686: hypothetical protein +FIG01474568 FIG01055033: hypothetical protein +FIG01474572 FIG00426188: hypothetical protein +FIG01474575 hypothetical protein +FIG01474576 FIG01117434: hypothetical protein +FIG01474583 FIG01119523: hypothetical protein +FIG01474597 FIG00353912: hypothetical protein +FIG01474611 FIG00623265: hypothetical protein +FIG01474612 FIG00405172: hypothetical protein +FIG01474629 hypothetical protein +FIG01474633 hypothetical protein +FIG01474638 FIG01203597: hypothetical protein +FIG01474645 FIG00690019: hypothetical protein +FIG01474661 UPF0337 protein PP_2059 +FIG01474664 FIG00407519: hypothetical protein +FIG01474715 hypothetical protein +FIG01474738 Zn-dependent hydrolase, glyoxylase II family +FIG01474755 monoheme cytochrome c +FIG01474798 putative alkaline serine protease +FIG01474815 FIG00766516: hypothetical protein +FIG01474844 FIG00352537: hypothetical protein +FIG01474902 FIG00346647: hypothetical protein +FIG01474922 FIG00408357: hypothetical protein +FIG01474937 SC1B5.06c, unknown, len: 249 aa +FIG01474941 FIG00734215: hypothetical protein +FIG01474943 Transport system permease protein p69 +FIG01474964 alternate gene name: jojD +FIG01474978 FIG00350198: hypothetical protein +FIG01474999 beta-lactamase Toho-1( EC:3.5.2.6 ) +FIG01475000 possible (U92432) ORF4 [Nitrosospira sp. NpAV] +FIG01475020 AFG1-like ATPase +FIG01475025 FIG00402862: hypothetical protein +FIG01475031 FIG00362043: hypothetical protein +FIG01475033 histidinol-phosphate aminotransferase +FIG01475050 FIG00533646: hypothetical protein +FIG01475056 secreted subtilisin-like protease +FIG01475058 Huntington interacting protein HYPE +FIG01475065 putative formylmethanofuran dehydrogenase, subunit C( EC:1.2.99.5 ) +FIG01475066 Mn2+ and Fe2+ transporter, NRAMP family +FIG01475103 hypothetical protein +FIG01475119 ferrichrome-binding periplasmic protein +FIG01475124 FIG00527944: hypothetical protein +FIG01475129 nickel resistance protein +FIG01475144 putative glycosyltransferase yibD +FIG01475153 Histidine decarboxylase proenzyme (EC 4.1.1.22) +FIG01475159 chitin deacetylase +FIG01475169 immunoreactive 23 kDa antigen PG66 +FIG01475177 FIG00711698: hypothetical protein +FIG01475183 Methyl-accepting chemotaxis transducer/sensory box protein +FIG01475188 FIG01016971: hypothetical protein +FIG01475201 FIG00850057: hypothetical protein +FIG01475203 FIG00348920: hypothetical protein +FIG01475214 hypothetical protein +FIG01475233 FIG00356661: hypothetical protein +FIG01475249 FIG00230277: hypothetical protein +FIG01475260 Chain A, D20c mutant of T4 lysozyme +FIG01475270 signal peptide protein +FIG01475271 FIG01118546: hypothetical protein +FIG01475326 FIG00407137: hypothetical protein +FIG01475336 GRAMICIDIN S BIOSYNTHESIS GRST PROTEIN (EC 3.1.2.-) +FIG01475344 Conserved hyperthetical protein +FIG01475351 Uncharacterized protein yeeG +FIG01475364 FIG01154384: hypothetical protein +FIG01475381 FIG00388262: hypothetical protein +FIG01475384 FIG00763826: hypothetical protein +FIG01475389 Tetracycline efflux protein TetA +FIG01475403 FIG01228911: hypothetical protein +FIG01475405 FIG00389170: hypothetical protein +FIG01475407 hypothetical protein +FIG01475413 MotA/TolQ/ExbB proton channel +FIG01475457 ferritin family protein +FIG01475461 flagellin modification protein FlmE +FIG01475476 UDP-N-acetylglucosamine enolpyruvyl transferase +FIG01475480 predicted nitroreductase +FIG01475500 ABC transporter, ATP binding domain, possibly Mn transporter +FIG01475513 SdhA, substrate of the Dot/Icm system +FIG01475581 FIG01115295: hypothetical protein +FIG01475590 FIG00523849: hypothetical protein +FIG01475611 Possible Zn-finger containing protein +FIG01475637 FIG01081580: hypothetical protein +FIG01475640 FIG01080988: hypothetical protein +FIG01475647 NADPH-dependent FMN reductase family protein( EC:1.5.1.29 ) +FIG01475690 FIG00697692: hypothetical protein +FIG01475692 serine protease inhibitor serpin homolog +FIG01475701 uncharacterized protein/domain associated with GTPase +FIG01475709 PmbA protein +FIG01475711 FIG00528593: hypothetical protein +FIG01475729 POSSIBLE TRANSCRIPTIONAL REGULATORY PROTEIN +FIG01475733 COG1397: ADP-ribosylglycohydrolase +FIG01475763 Carboxyl-terminal-processing protease precursor (EC 3.4.21.102) +FIG01475767 FIG00966182: hypothetical protein +FIG01475768 FIG00559136: hypothetical protein +FIG01475784 FIG00347935: hypothetical protein +FIG01475791 ORFtxe3 +FIG01475800 FIG00816852: hypothetical protein +FIG01475812 Orf-66 +FIG01475816 FIG00350097: hypothetical protein +FIG01475840 Replication initiation protein REP +FIG01475849 aspartate carbamoyltransferase regulatory chain +FIG01475876 N-acetylmuramoyl-L-alanine amidase domain protein +FIG01475892 FIG00533393: hypothetical protein +FIG01475918 LydB +FIG01475919 arginine-binding periplasmic protein 1 +FIG01475930 FIG00827728: hypothetical protein +FIG01475932 hypothetical protein +FIG01475937 hypothetical protein-transmembrane region and signal peptide prediction +FIG01475940 FIG00623252: hypothetical protein +FIG01475971 FIG01146971: hypothetical protein +FIG01475997 Mercuric ion-binding protein +FIG01476005 FIG00353518: hypothetical protein +FIG01476006 FIG00938232: hypothetical protein +FIG01476019 FIG01231407: hypothetical protein +FIG01476052 Chemotaxis protein cheY +FIG01476067 Putative aldolase (EC 4.2.1.-) +FIG01476074 toluene tolerance protein Ttg2D +FIG01476078 FIG00641297: hypothetical protein +FIG01476084 putative major facilitator superfamily (MFS) transporter +FIG01476124 clostripain +FIG01476132 probable alkaline phosphatase D [Precursor]( EC:3.1.3.1 ) +FIG01476136 FIG00743091: hypothetical protein +FIG01476162 FIG00246348: hypothetical protein +FIG01476164 FIG00385165: hypothetical protein +FIG01476165 FIG00388163: hypothetical protein +FIG01476208 FIG00817687: hypothetical protein +FIG01476214 FIG00410732: hypothetical protein +FIG01476220 PROBABLE CONSERVED TRANSMEMBRANE ALANINE AND LEUCINE RICH PROTEIN +FIG01476242 ECF-type sigma factor +FIG01476243 mutator mutT protein homolog +FIG01476246 FIG00355967: hypothetical protein +FIG01476260 FagA protein +FIG01476262 FIG00854143: hypothetical protein +FIG01476273 protein disulphide isomerase +FIG01476294 Extensin-like, C-terminal precursor +FIG01476296 ATP/GTP binding protein +FIG01476299 FIG00849873: hypothetical protein +FIG01476315 Agglutinin receptor precursor (SSP-5) +FIG01476320 auxin efflux carrier family protein +FIG01476338 FIG00642251: hypothetical protein +FIG01476340 identified by match to protein family HMM PF02661 +FIG01476344 FIG00349270: hypothetical protein +FIG01476355 FIG00350476: hypothetical protein +FIG01476362 Permease precursor +FIG01476371 Hemoprotein HemQ, essential component of heme biosynthetic pathway in Gram-positive bacteria +FIG01476376 Type I restriction-modification system, specificity subunit S (EC 3.1.21.3) +FIG01476392 FIG00385170: hypothetical protein +FIG01476419 protein of unknown function UPF0132 +FIG01476435 Small, acid-soluble spore protein alpha (SASP)P +FIG01476436 Conjugative transfer protein TrbK +FIG01476444 FIG00412566: hypothetical protein +FIG01476454 FIG00643135: hypothetical protein +FIG01476455 FIG00624457: hypothetical protein +FIG01476470 FIG00384921: hypothetical protein +FIG01476473 NLP/P60 family protein +FIG01476478 ADP-heptose--LPS heptosyltransferase II, putative +FIG01476479 filamentous hemagglutinin/adhesin +FIG01476501 DNA-binding protein tfx +FIG01476507 FIG00835112: hypothetical protein +FIG01476519 FIG01046281: hypothetical protein +FIG01476529 Chloramphenicol acetyltransferase +FIG01476535 putative regulatory protein RteC-like protein +FIG01476546 unnamed protein product, putative +FIG01476557 FIG00242642: hypothetical protein +FIG01476589 Sulfur oxidation molybdopterin C protein +FIG01476594 Type I phosphodiesterase / nucleotide pyrophosphatase family protein +FIG01476607 peptidase T( EC:3.4.11.4 ) +FIG01476616 Methylase homolog (CspR) (Fragment) +FIG01476626 Heat shock protein DnaJ, N-terminal +FIG01476646 FIG00755229: hypothetical protein +FIG01476664 Glycosyltransferases involved in cell wall biogenesis +FIG01476666 Methyl accepting chemotaxis protein +FIG01476670 putative bacteriophage-related protein +FIG01476672 probable prepilin peptidase +FIG01476681 FIG00350005: hypothetical protein +FIG01476705 drug transport protein +FIG01476707 DNA-directed RNA polymerase (EC 2.7.7.6) +FIG01476761 FIG01224136: hypothetical protein +FIG01476777 hypothetical protein +FIG01476783 FIG00516089: hypothetical protein +FIG01476785 Feruloyl esterase B precursor (EC 3.1.1.73) (Ferulic acid esterase B) (Esterase A) (EstA) (Cinnamoyl ester hydrolase) +FIG01476791 FIG00350119: hypothetical protein +FIG01476813 FIG00850628: hypothetical protein +FIG01476816 type I restriction-modification system specificity determinant +FIG01476817 Sulfide:quinone oxidoreductase +FIG01476826 hypothetical protein +FIG01476840 immunity protein, probable +FIG01476883 FIG00732346: hypothetical protein +FIG01476895 FIG01049080: hypothetical protein +FIG01476914 FIG00673451: hypothetical protein +FIG01476919 Hemagglutinin domain protein +FIG01476951 HrgA protein +FIG01476952 syc1998_c +FIG01476965 ulcer associated adenine specific DNA methyltransferase +FIG01476979 peptidase, A24 (type IV prepilin peptidase) family protein +FIG01476992 Naringenin-chalcone synthase +FIG01476997 Exoribonuclease R +FIG01477005 O-linked GlcNAc transferase +FIG01477012 phage tail fiber-like protein +FIG01477015 lipopolysaccharide core biosynthesis protein LpsA +FIG01477026 iron ABC transporter, permease protein +FIG01477123 FIG00242661: hypothetical protein +FIG01477137 FIG00470664: hypothetical protein +FIG01477148 Putative oxidoreductase, short chain dehydrogenase/reductase +FIG01477161 TM2 domain containing protein+B7201 +FIG01477173 FIG01229601: hypothetical protein +FIG01477179 Methionyl-tRNA synthetase-related protein 2 +FIG01477211 rhizobiocin rzcA +FIG01477221 GH3 auxin-responsive promoter +FIG01477227 teichoic acid biosynthesis protein C +FIG01477235 FIG00494634: hypothetical protein +FIG01477253 Hydroxylamine oxidoreductase (Fragment) +FIG01477269 putative hemagglutinin-related protein +FIG01477278 mobilisation protein +FIG01477292 FIG00849706: hypothetical protein +FIG01477308 Histidine-binding protein precursor +FIG01477309 flaz protein, putative +FIG01477344 transposase, fragment (putative) +FIG01477354 FIG00939636: hypothetical protein +FIG01477394 FIG00354258: hypothetical protein +FIG01477408 FIG00389088: hypothetical protein +FIG01477419 peptidase M1 family protein +FIG01477425 FIG00531189: hypothetical protein +FIG01477426 Transposase, IS4 +FIG01477428 Bacterial regulatory protein, LacI family +FIG01477442 FIG00747947: hypothetical protein +FIG01477448 Pyruvoyl-dependent arginine decarboxylase (EC 4.1.1.19) +FIG01477464 bll0546; hypothetical protein +FIG01477500 Probable NADH-dependent dehydrogenase (EC 1.-.-.-) +FIG01477520 FIG00385471: hypothetical protein +FIG01477531 FIG00769524: hypothetical protein +FIG01477544 transposase-like protein A +FIG01477546 FIG00425421: hypothetical protein +FIG01477570 PrpF, AcnD-accessory +FIG01477576 31 kDa outer-membrane immunogenic protein +FIG01477601 FIG00520950: hypothetical protein +FIG01477606 Putative ATP-binding component of a transport system +FIG01477608 virD4 protein, putative +FIG01477628 FIG00424886: hypothetical protein +FIG01477641 FIG00745108: hypothetical protein +FIG01477649 FIG00734368: hypothetical protein +FIG01477650 FIG00817501: hypothetical protein +FIG01477652 Protein ygiW precursor +FIG01477660 possible EPSP synthase (3-phosphoshikimate 1-c +FIG01477711 Epidermin leader peptide processing serine protease EPIP precursor (EC 3.4.21.-) +FIG01477726 FIG00385095: hypothetical protein +FIG01477728 FIG00520817: hypothetical protein +FIG01477730 FIG00404593: hypothetical protein +FIG01477740 Type II restriction-modification system methylation subunit +FIG01477741 sigma-70 region 3 domain protein +FIG01477756 FIG00763614: hypothetical protein +FIG01477759 FIG00848069: hypothetical protein +FIG01477773 FIG00912340: hypothetical protein +FIG01477804 heat shock protein +FIG01477812 FIG00355098: hypothetical protein +FIG01477815 hypothetical protein +FIG01477816 Propeptide, PepSY amd peptidase M4 +FIG01477844 FIG00712090: hypothetical protein +FIG01477866 Hypothetical protein in cluster with Ecs transporter (in Lactococci) +FIG01477878 FIG00733442: hypothetical protein +FIG01477881 protein of unknown function DUF938 +FIG01477884 Secreted protease metal-dependent protease +FIG01477903 Glutamine amidotransferase class-II:Asparagine synthase (EC 6.3.5.4) +FIG01477904 putative type III cell invasion protein SipB +FIG01477938 predicted glutamine amidotransferase +FIG01477951 Oligoendopeptidase F (EC 3.4.24.-) +FIG01477964 FIG00628011: hypothetical protein +FIG01477986 putative cAMP-binding regulatory protein +FIG01477991 hypothetical GTP-binding protein +FIG01478023 Transporter, LysE family +FIG01478034 Polyferredoxin +FIG01478037 FIG00351436: hypothetical protein +FIG01478056 DcaP +FIG01478058 MbpA +FIG01478075 FIG01244845: hypothetical protein +FIG01478106 FIG00766505: hypothetical protein +FIG01478115 FIG01116067: hypothetical protein +FIG01478118 protein activator +FIG01478127 FIG00520034: hypothetical protein +FIG01478136 Protein of unknown function DUF6, transmembrane +FIG01478139 FIG01251320: hypothetical protein +FIG01478147 hypothetical D-alanyl-D-alanine dipeptidase +FIG01478172 UPF0052 protein DR_1435 +FIG01478183 FIG00530889: hypothetical protein +FIG01478197 Putative ATP-sensitive potassium channel protein +FIG01478211 FIG00733306: hypothetical protein +FIG01478224 putative carbamoyl phosphate synthase large subunit +FIG01478238 FIG027937: secreted protein +FIG01478242 FIG01094561: hypothetical protein +FIG01478243 COG2860: Predicted membrane protein +FIG01478258 hypothetical protein +FIG01478285 ATP-binding protein (P-loop) +FIG01478290 FIG00424639: hypothetical protein +FIG01478313 FIG00348458: hypothetical protein +FIG01478342 FIG01048089: hypothetical protein +FIG01478343 Molybdopterin converting factor, large subunit +FIG01478378 DNA helicase-related protein +FIG01478387 Na+/H+-dicarboxylate symporter +FIG01478392 FIG01230495: hypothetical protein +FIG01478403 Metallo-beta-lactamase superfamily protein +FIG01478407 FIG00531038: hypothetical protein +FIG01478419 FIG00711535: hypothetical protein +FIG01478426 putative sugarkinase( EC:2.7.1.2 ) +FIG01478446 FIG00517991: hypothetical protein +FIG01478501 probable iron-sulfur binding protein YPO1417 +FIG01478505 DotC +FIG01478511 KluA +FIG01478523 Putative Zn-dependent oxidoreductase PA5234 +FIG01478531 Putative phage integrase +FIG01478534 FIG00496275: hypothetical protein +FIG01478554 Transcriptional activator of acetoin metabolism +FIG01478556 Light-harvesting LHII, alpha subunit G +FIG01478572 FIG00766746: hypothetical protein +FIG01478577 FIG00764311: hypothetical protein +FIG01478579 MOSQUITOCIDAL TOXIN PROTEIN +FIG01478636 FIG00416692: hypothetical protein +FIG01478726 syc0025_c +FIG01478728 FIG00363335: hypothetical protein +FIG01478737 YehQ protein +FIG01478745 Transposase, IS256 family +FIG01478769 Peyer's patch-specific virulence factor GipA +FIG01478779 ORF_ID:slr6100 hypothetical protein +FIG01478780 putative transcription regulator TxR +FIG01478787 putative translocator +FIG01478793 FIG00765262: hypothetical protein +FIG01478834 Peptidase M18, aminopeptidase I +FIG01478844 FIG00364916: hypothetical protein +FIG01478859 response regulator receiver domain +FIG01478873 glycoside hydrolase 15-related +FIG01478878 hmga2e, putative +FIG01478890 probable suger ABC transporter +FIG01478891 Regulator of plasmid mcrB operon +FIG01478899 ATP synthase subunit C +FIG01478922 ABC-type Fe3+ transport system periplasmic component-like protein +FIG01478935 SyrB2 transcriptional regulator +FIG01478963 FIG00766238: hypothetical protein +FIG01478973 Glycosyl transferase, family 2:Mitochondrial substrate carrier +FIG01479006 Zinc responsive transcriptional repressor +FIG01479020 FIG00379843: hypothetical protein +FIG01479022 Leader peptidase (Prepilin peptidase) (EC 3.4.23.43) / N-methyltransferase (EC 2.1.1.-) +FIG01479045 FIG00624807: hypothetical protein +FIG01479067 FIG00955041: hypothetical protein +FIG01479074 p5482_32 +FIG01479089 FIG00515681: hypothetical protein +FIG01479122 FIG00416115: hypothetical protein +FIG01479139 Hsp33 protein with redox-regulated chaperone activity / C-terminal domain of CinA type S +FIG01479143 probable mercuric ion binding protein NMA1476 +FIG01479150 Membrane spanning protein +FIG01479180 DUF2236 +FIG01479183 Uncharacterized protein MJ0206 +FIG01479186 FIG00641562: hypothetical protein +FIG01479193 O-methyltransferase-like protein +FIG01479210 Pli0007 protein +FIG01479217 FIG01022057: hypothetical protein +FIG01479225 Bacteriophage SPP1 complete nucleotide sequence +FIG01479238 prohibitin homolog +FIG01479259 FIG01047459: hypothetical protein +FIG01479280 FIG00628469: hypothetical protein +FIG01479321 FIG00350090: hypothetical protein +FIG01479348 YtaF +FIG01479351 pXO1-123 +FIG01479355 FIG00642739: hypothetical protein +FIG01479361 mobilization protein BmgB +FIG01479365 carbonic anhydrases/acetyltransferases +FIG01479396 Putative bacteriophage tail fiber assembly protein +FIG01479399 FIG00624201: hypothetical protein +FIG01479411 Putative protease protein +FIG01479417 Galactoside-O-acetyltransferase (EC 2.3.1.18) +FIG01479441 iron(III) ABC transporter, ATP-binding protein, putative +FIG01479472 FIG00531733: hypothetical protein +FIG01479497 Acetyltransferase (GNAT) family, putative +FIG01479504 nuclear export factor GLE1 +FIG01479543 Probable transcriptional regulator; ThiJ/PfpI family protein +FIG01479573 FIG00754203: hypothetical protein +FIG01479574 Pli0068 protein +FIG01479582 transporter, gluconate:H+ symporter family protein +FIG01479583 17 kDa surface antigen +FIG01479591 ISSod13, transposase +FIG01479592 possible transmembrane sensor +FIG01479625 substrate-binding protein of ABC transporter +FIG01479631 FIG00733404: hypothetical protein +FIG01479634 baseplate assembly protein J, putative +FIG01479637 FIG00794429: hypothetical protein +FIG01479643 ulcer-associated gene restriction endonuclease (iceA) +FIG01479653 probable deca-heme c-type cytochrome +FIG01479654 ABC-transporter, ATP-binding component +FIG01479706 NdaD D-aminoacylase +FIG01479744 FIG00564493: hypothetical protein +FIG01479747 FIG00816657: hypothetical protein +FIG01479750 putative Cytochrome b561 family protein +FIG01479777 histidine decarboxylase +FIG01479809 Enhanced entry protein EnhA +FIG01479810 DNA polymerase III delta prime subunit (EC 2.7.7.7) +FIG01479835 Activator of ProP osmoprotectant transporter +FIG01479851 lipopolysaccharide biosynthesis( EC:2.7.10.1 ) +FIG01479852 thymidylate synthase-like protein +FIG01479913 Beta-lactamase domain protein +FIG01479931 Pseudouridine synthase +FIG01479970 Predicted membrane ancor connecting MutS2 with cell-division Z-ring +FIG01479974 Peptidase S1, chymotrypsin:PDZ/DHR/GLGF +FIG01480033 Benzoate anaerobic degradation transcriptional regulator BadR, MarR family +FIG01480048 FIG01202523: hypothetical protein +FIG01480050 FIG00762762: hypothetical protein +FIG01480064 Xanthomonapepsin precursor (EC 3.4.21.101) +FIG01480076 Major acid phosphatase Map +FIG01480087 COG0108: 3,4-dihydroxy-2-butanone 4-phosphate synthase +FIG01480120 ABC-2 type transporter superfamily +FIG01480137 FIG00768667: hypothetical protein +FIG01480147 transcriptional regulator, IclR family +FIG01480149 FIG00747343: hypothetical protein +FIG01480166 FIG00924289: hypothetical protein +FIG01480169 Probable solute-binding protein of ABC transporter for peptides +FIG01480186 AidA-I adhesin-like protein +FIG01480219 mobilization protein +FIG01480223 Bacteriophage N4 adsorption protein A precursor +FIG01480237 protein of unknown function DUF1538 +FIG01480243 FIG00407803: hypothetical protein +FIG01480254 FIG00826554: hypothetical protein +FIG01480296 FIG00362159: hypothetical protein +FIG01480320 PROBABLE PHAGE HK97 GP17-RELATED PROTEIN +FIG01480371 FIG00769553: hypothetical protein +FIG01480375 putative heat shock protein +FIG01480390 PepSY-associated TM helix +FIG01480391 DNA circulation protein, putative +FIG01480394 HlyB family protein +FIG01480401 SULFUR DEPRIVATION RESPONSE REGULATOR +FIG01480402 FIG00364300: hypothetical protein +FIG01480409 FIG01120262: hypothetical protein +FIG01480411 FIG00424613: hypothetical protein +FIG01480413 FIG01205064: hypothetical protein +FIG01480415 FIG00751181: hypothetical protein +FIG01480417 Response regulator receiver and ANTAR domain protein +FIG01480451 FIG00343869: hypothetical protein +FIG01480457 bacteriocin precursor peptide PlnN (putative) +FIG01480472 short chain dehydrogenase( EC:1.1.1.- ) +FIG01480483 FIG00529715: hypothetical protein +FIG01480489 hypothetical protein +FIG01480499 LPS biosynthesis protein +FIG01480511 FIG00823312: hypothetical protein +FIG01480541 lipopolysaccharide biosynthesis protein (SAM-dependent methyltransferase protein) +FIG01480567 Histamine dehydrogenase +FIG01480577 FIG00403938: hypothetical protein +FIG01480580 possible TetR-type transcriptional regulator +FIG01480590 hypothetical protein +FIG01480596 hypothetical protein +FIG01480597 Putative sugar efflux protein +FIG01480601 COG0189: Glutathione synthase/Ribosomal protein S6 modification enzyme (glutaminyl transferase) +FIG01480618 possible sec-independent protein translocase protein TatC +FIG01480664 FIG00362752: hypothetical protein +FIG01480675 FIG01128673: hypothetical protein +FIG01480676 Probable cytochrome b561 +FIG01480692 FIG00764320: hypothetical protein +FIG01480711 FIG01222230: hypothetical protein +FIG01480720 glycine betaine/L-proline ABC transporter, ATPase subunit +FIG01480745 FIG00847877: hypothetical protein +FIG01480747 DNA-cytosine methyltransferase +FIG01480777 HTH-type transcriptional regulator LysM +FIG01480778 FIG00471324: hypothetical protein +FIG01480787 probable molybdenum transport regulator mopA +FIG01480809 FIG00513238: hypothetical protein +FIG01480813 Possible type I restriction-modification system, S subunit (EC 3.1.21.3) +FIG01480821 FIG01250104: hypothetical protein +FIG01480897 FIG00623256: hypothetical protein +FIG01480899 Flagelliform silk protein +FIG01480914 FIG00532564: hypothetical protein +FIG01480922 Putative FecR +FIG01480932 FIG00389005: hypothetical protein +FIG01480937 conserved hypothetical protein TIGR00730 +FIG01480943 FIG00462688: hypothetical protein +FIG01480945 Periplasmic serine protease, ClpP family protein +FIG01480960 putative Na(+)/H(+) antiporter +FIG01480965 FLAVIN-CONTAINING MONOOXYGENASE +FIG01480981 Pli0046 protein +FIG01480990 FIG00515032: hypothetical protein +FIG01480992 FIG00734473: hypothetical protein +FIG01481012 FIG00849781: hypothetical protein +FIG01481015 FIG00626483: hypothetical protein +FIG01481081 FIG00688336: hypothetical protein +FIG01481098 protein of unknown function DUF1667 +FIG01481125 1-acyl-sn-glycerol-3-phosphate acyltransferase( EC:2.3.1.51 ) +FIG01481144 competence/damage-inducible protein CinA +FIG01481162 methyltransferase( EC:2.1.1.- ) +FIG01481164 FIG00816880: hypothetical protein +FIG01481206 Pli0010 protein +FIG01481227 Lantibiotic response regulator +FIG01481243 L-lysine dehydrogenase +FIG01481254 FIG00344142: hypothetical protein +FIG01481264 hypothetical protein +FIG01481295 Putative phosphopantetheinyl transferase PptA +FIG01481298 N-ethylammeline chlorohydrolase +FIG01481341 ORF_ID:asl7669 unknown protein +FIG01481356 FIG01165958: hypothetical protein +FIG01481358 Branched-chain amino acid transport protein, putative +FIG01481369 acyl-CoA dehydrogenase, putative +FIG01481382 Spermidine/putrescine ABC transporter, ATP-binding protein +FIG01481386 probable glyoxalase protein +FIG01481398 FIG00696161: hypothetical protein +FIG01481406 AMINO ACID PERMEASE +FIG01481422 COG4104: Uncharacterized conserved protein +FIG01481424 outer membrane protein (omp3) +FIG01481439 Phage protein +FIG01481441 conserved ypothetical protein +FIG01481444 25 KDA OUTER-MEMBRANE IMMUNOGENIC PROTEIN PRECURSOR +FIG01481449 FIG00405289: hypothetical protein +FIG01481453 Bll1944 protein +FIG01481460 hypothetical protein +FIG01481477 FIG00351923: hypothetical protein +FIG01481503 FIG00530916: hypothetical protein +FIG01481518 ferritin A +FIG01481533 Probable phiRv1 integrase +FIG01481547 FIG00766714: hypothetical protein +FIG01481548 S23 ribosomal +FIG01481564 Conserved hypothetical exported protein +FIG01481567 NADH:flavin oxidoreductase, Old Yellow Enzyme family +FIG01481572 BRANCHED-CHAIN AMINO ACID ABC TRANSPORTER, PERIPLASMIC AMINO ACID- BINDING PROTEIN +FIG01481576 FIG01228137: hypothetical protein +FIG01481580 FIG00639629: hypothetical protein +FIG01481596 FIG00641120: hypothetical protein +FIG01481615 possible Etk-like tyrosine kinase involved in Eps biosynthesis +FIG01481625 FIG00403902: hypothetical protein +FIG01481653 FIG00405053: hypothetical protein +FIG01481661 putative acetyltransferase +FIG01481669 large transcriptional regulator +FIG01481703 FIG00352804: hypothetical protein +FIG01481704 FIG00344945: hypothetical protein +FIG01481706 periplasmic serine protease, putative +FIG01481710 FIG00623278: hypothetical protein +FIG01481719 FIG01203926: hypothetical protein +FIG01481724 Integrase catalytic region +FIG01481750 Glucosyltransferase (side chain biosynthesis) (EC 2.4.1.-) +FIG01481756 FIG00688799: hypothetical protein +FIG01481766 Aldo/keto reductase (EC 1.1.1.274) +FIG01481820 FIG00850317: hypothetical protein +FIG01481846 FIG00410462: hypothetical protein +FIG01481868 Cu+ P-type ATPase fragment +FIG01481914 blr1932; hypothetical protein +FIG01481927 NADH-ubiquinone oxidoreductase 39 kDa subunit related protein +FIG01481965 FIG00449759: hypothetical protein +FIG01481979 Beta-lytic metalloendopeptidase precursor (EC 3.4.24.32) (Beta-lytic protease) +FIG01481982 hypothetical protein +FIG01481983 PROBABLE CONSERVED EXPORTED PROTEIN +FIG01481988 FIG00956222: hypothetical protein +FIG01482024 FIG00356416: hypothetical protein +FIG01482028 FIG00750323: hypothetical protein +FIG01482033 phage shock protein C +FIG01482061 FIG00533106: hypothetical protein +FIG01482064 FIG01117618: hypothetical protein +FIG01482072 cytochrome b561 family protein +FIG01482077 FIG00764818: hypothetical protein +FIG01482080 putative transposase fragment +FIG01482082 FIG00457488: hypothetical protein +FIG01482129 alkaline phosphatase-like protein +FIG01482156 FIG00528323: hypothetical protein +FIG01482179 Transposase +FIG01482193 ortholog to Borrelia burgdorferi BB0246 +FIG01482196 hypothetical protein +FIG01482204 serine protease (secreted protein) +FIG01482207 SREBP protease/CBS domain +FIG01482213 FIG00344346: hypothetical protein +FIG01482254 putative aminopeptidase 1 +FIG01482279 FIG00743117: hypothetical protein +FIG01482287 B. burgdorferi predicted coding region BB0743 +FIG01482326 FIG00356799: hypothetical protein +FIG01482329 DNA replication, restriction, modification, recombination, and repair +FIG01482384 FIG00517864: hypothetical protein +FIG01482403 FIG00765283: hypothetical protein +FIG01482406 FMN-dependent oxidoreductase, nitrilotriacetate monooxygenase family +FIG01482444 exclusion of bacteriophage Ap1 +FIG01482480 FIG01243401: hypothetical protein +FIG01482481 NADH:ubiquinone oxidoreductase, NADH-binding (51 kD) subunit +FIG01482495 Possible plasmid transfer factor, TraK +FIG01482498 Rrf2-like transcriptional regulator protein +FIG01482516 FIG00361780: hypothetical protein +FIG01482521 EftLSL.A +FIG01482528 FIG00522629: hypothetical protein +FIG01482535 FIG00674565: hypothetical protein +FIG01482540 Hnh endonuclease +FIG01482558 3-demethylubiquinone-9 3-methyltransferase, putative +FIG01482581 FIG00623315: hypothetical protein +FIG01482589 exopolysaccharide biosynthesis protein, putative +FIG01482615 putative prolyl oligopeptidase family protein +FIG01482633 FIG00380355: hypothetical protein +FIG01482656 C4-dicarboxylate like transporter +FIG01482714 FIG01119318: hypothetical protein +FIG01482725 Autoinducer synthetase protein SolI +FIG01482737 Methyl-accepting chemotaxis protein A +FIG01482744 Efa1-Lymphostatin-like protein +FIG01482764 Chitinase( EC:3.2.1.14 ) +FIG01482786 RhoGEF Guanine nucleotide exchange factor for Rho/Rac/Cdc42-like GTPases-like +FIG01482787 FIG01020318: hypothetical protein +FIG01482791 Sugar ABC transporter, periplasmic sugar-bindind protein +FIG01482835 Sll0062 protein +FIG01482847 FIG00769021: hypothetical protein +FIG01482858 Carotenoid oxygenase +FIG01482873 merR family regulatory protein +FIG01482875 FIG00347521: hypothetical protein +FIG01482913 Mll3732 protein +FIG01482928 conserved hypothetical phage AbiD protein +FIG01482931 Short-chain dehydrodenase (gene dltE) +FIG01482943 Probable tesA-like protease +FIG01482967 Acyl-CoA synthetases (AMP-forming)/AMP-acid ligases II +FIG01483004 hypothetical protein; hypothetical protein of the Tn5613 transposon +FIG01483005 Protein ybgE +FIG01483039 FIG00352444: hypothetical protein +FIG01483046 Fe(3+)-transporting ATPase +FIG01483053 POSSIBLE COENZYME F420-DEPENDENT OXIDOREDUCTASE (EC 1.-.-.-) +FIG01483058 putative regulatory protein RecX +FIG01483074 hypothetical protein, phage-related +FIG01483076 FIG00406514: hypothetical protein +FIG01483079 Glutaryl 7-ACA acylase precursor +FIG01483106 suppressor of fused homolog +FIG01483114 ThiS, thiamine-biosynthesis +FIG01483160 hypothetical protein-putative related to sulfatase +FIG01483186 hypothetical protein +FIG01483200 Probable short chain oxidoreductase +FIG01483208 putative antirestriction protein +FIG01483218 FIG00388096: hypothetical protein +FIG01483222 FIG01239685: hypothetical protein +FIG01483230 FIG00686558: hypothetical protein +FIG01483238 OmpA-related protein +FIG01483269 transposase, IS4 family protein +FIG01483285 Electron transfer protein azurin I +FIG01483286 bacteriolytic lipoprotein entericidin B. +FIG01483294 FIG00385104: hypothetical protein +FIG01483295 protein of unknown function DUF599 +FIG01483296 FIG01116709: hypothetical protein +FIG01483300 FIG00388396: hypothetical protein +FIG01483306 FIG00726508: hypothetical protein +FIG01483308 FIG00801812: hypothetical protein +FIG01483312 FIG00665646: hypothetical protein +FIG01483336 FIG00597725: hypothetical protein +FIG01483347 FIG01242111: hypothetical protein +FIG01483352 trypsin domain protein +FIG01483361 Carbon storage regulator CsrA +FIG01483387 FIG00640306: hypothetical protein +FIG01483427 COG0042: tRNA-dihydrouridine synthase +FIG01483435 FIG01165965: hypothetical protein +FIG01483459 FIG00414437: hypothetical protein +FIG01483472 FIG00832151: hypothetical protein +FIG01483490 oxidoreductase, Gfo/Idh/MocA family protein +FIG01483510 ABC transporter permease protein +FIG01483511 FIG00767865: hypothetical protein +FIG01483516 FIG00575296: hypothetical protein +FIG01483526 FIG00746552: hypothetical protein +FIG01483540 FIG00424890: hypothetical protein +FIG01483541 Acyl-CoA dehydrogenase (EC 1.3.8.7) +FIG01483568 FIG00409904: hypothetical protein +FIG01483571 NLP/P60 family domain protein +FIG01483582 FIG00414089: hypothetical protein +FIG01483600 Lipoprotein NlpD +FIG01483601 glycosidase, PH1107-related +FIG01483603 Rhomboid family membrane protein +FIG01483609 branched chain amino acid transport system substrate binding protein +FIG01483616 COG0504: CTP synthase (UTP-ammonia lyase) +FIG01483631 FIG00343880: hypothetical protein +FIG01483654 probable acylaminoacyl-peptidase( EC:3.4.19.1 ) +FIG01483662 FIG01205670: hypothetical protein +FIG01483664 YxaD +FIG01483669 FIG00715066: hypothetical protein +FIG01483672 molybdopterin-guanine dinucleotide biosynthesis protein B +FIG01483678 Pur operon repressor +FIG01483682 FIG00409688: hypothetical protein +FIG01483691 PTS system, IIB component, putative +FIG01483718 FIG01071402: hypothetical protein +FIG01483728 Uncharacterized protein y4dW +FIG01483753 FIG00407633: hypothetical protein +FIG01483757 Guanyl-specific ribonuclease St (EC 3.1.27.3) (RNase St) +FIG01483772 FIG00640582: hypothetical protein +FIG01483795 hypothetical protein +FIG01483797 FIG00385032: hypothetical protein +FIG01483831 hypothetical protein +FIG01483843 Inulin fructotransferase [DFA-I-forming] (EC 4.2.2.17) (Inulin fructotransferase [depolymerizing, difructofuranose-1,2':2',1-dianhydride-forming]) +FIG01483847 FIG00657908: hypothetical protein +FIG01483851 hypothetical protein +FIG01483878 FIG00416332: hypothetical protein +FIG01483897 plantaricin biosynthesis protein PlnY (putative) +FIG01483930 Avirulence A protein +FIG01483952 FIG00673855: hypothetical protein +FIG01483971 possible Paired amphipathic helix repeat +FIG01483979 FIG00404705: hypothetical protein +FIG01483980 Oxidoreductase-related protein +FIG01483986 HTH-type transcriptional regulator zrp +FIG01483992 fibronectin, type III +FIG01484031 hypothetical signal peptide protein +FIG01484035 Lin2984 protein +FIG01484055 large terminase +FIG01484091 FIG00643423: hypothetical protein +FIG01484092 motif=eukaryotic putative RNA-binding region RNP-1 signature +FIG01484124 Uncharacterized protein MJ1451 +FIG01484128 FIG01202588: hypothetical protein +FIG01484139 feoA protein +FIG01484144 FIG00659577: hypothetical protein +FIG01484151 FIG00767503: hypothetical protein +FIG01484174 FIG076926: outer membrane protein +FIG01484178 probable O-linked GlcNAc transferase +FIG01484205 Related to methyl-accepting chemotaxis protein +FIG01484213 FIG00344088: hypothetical protein +FIG01484227 glucokinase, transcriptional regulator( EC:2.7.1.2 ) +FIG01484240 Peptide ABC transporter, periplasmic peptide-binding protein +FIG01484265 Plasma membrane protein involved in salt tolerance +FIG01484305 FIG01042960: hypothetical protein +FIG01484321 FIG235216: hypothetical protein +FIG01484328 FIG01252311: hypothetical protein +FIG01484343 FIG01160920: hypothetical protein +FIG01484356 Uncharacterized MFS-type transporter MJ1560 +FIG01484365 hypothetical protein; identical to NP_536384 +FIG01484372 CrtK protein +FIG01484393 Histone H1 +FIG01484400 hypothetical protein +FIG01484404 ortholog to Borrelia burgdorferi BB0049 +FIG01484410 Transposase +FIG01484418 Transposase (class I) +FIG01484434 Pseudomonas aeruginosa phage phi CTX, complete genome sequence +FIG01484448 FIG01206310: hypothetical protein +FIG01484467 FIG00622971: hypothetical protein +FIG01484468 FIG00530366: hypothetical protein +FIG01484471 FIG00629785: hypothetical protein +FIG01484481 FIG00351282: hypothetical protein +FIG01484493 FIG01133747: hypothetical protein +FIG01484522 FIG01217202: hypothetical protein +FIG01484538 OrfZ protein +FIG01484541 Protein C14orf101 homolog +FIG01484557 esterase, homolog +FIG01484560 FIG01118436: hypothetical protein +FIG01484563 cytochrome oxidase subunit IV-like protein +FIG01484567 modification methyltransferase +FIG01484571 putative ABC oligo/dipeptide transport, ATP-binding protein +FIG01484602 FIG00768645: hypothetical protein +FIG01484615 SMC peptidase +FIG01484623 FIG00403486: hypothetical protein +FIG01484637 Transposase +FIG01484655 sensor histidine kinase/response regulator LuxN +FIG01484675 FIG00352480: hypothetical protein +FIG01484699 Asparagine synthetase +FIG01484703 Exonuclease sbcC (EC 3.1.11.-) +FIG01484711 Ribonuclease, T2 family +FIG01484740 Serine/threonine protein kinase (EC 2.7.1.-) +FIG01484766 putative; ORF located using Glimmer +FIG01484791 hypothetical protein +FIG01484795 glutamine-binding protein of glutamine ABC transporter +FIG01484801 FIG00348739: hypothetical protein +FIG01484815 Effector protein B, substrate of the Dot/Icm secretion system +FIG01484829 OLIGOPEPTIDE TRANSPORT SYSTEM PERMEASE PROTEIN APPB +FIG01484833 FIG00424816: hypothetical protein +FIG01484834 FIG00129991: hypothetical protein +FIG01484844 putative two-component system sensor +FIG01484857 nodulation efficiency protein D (NfeD) +FIG01484865 hypothetical protein +FIG01484879 FIG00361300: hypothetical protein +FIG01484908 Succinyl-CoA:(R)-benzylsuccinate CoA-transferase subunit BbsF (EC 2.8.3.15) +FIG01484917 molybdate ABC transporter, ATPase subunit +FIG01484926 poly(hydroxyalcanoate) granule associated protein +FIG01484927 FIG00624072: hypothetical protein +FIG01484929 Conserved protein YqjP +FIG01484944 Possible membrane protein +FIG01484956 probable tail fiber assembly-like protein +FIG01484959 FIG00839873: hypothetical protein +FIG01484977 FIG00766345: hypothetical protein +FIG01484982 FIG01229482: hypothetical protein +FIG01485042 repA +FIG01485068 2-polyprenyl-6-methoxyphenol hydroxylase and related FAD-dependent oxidoreductases +FIG01485077 FIG00351023: hypothetical protein +FIG01485079 Endoglucanase B precursor (EC 3.2.1.4) (Endo-1,4-beta-glucanase B) (Cellulase B) (EGB) +FIG01485092 contains haloacid dehalogenase-like hydrolase domain +FIG01485093 FIG00769709: hypothetical protein +FIG01485122 modification methylase EcoRI (Adenine-specificmethyltransferase EcoRI) (M.EcoRI)( EC:2.1.1.72 ) +FIG01485124 FIG00821342: hypothetical protein +FIG01485141 lysozyme +FIG01485143 FIG00344922: hypothetical protein +FIG01485170 FIG00769804: hypothetical protein +FIG01485188 B. burgdorferi predicted coding region BB0007 +FIG01485195 AAC-rich mRNA clone AAC11 protein +FIG01485212 FIG00426835: hypothetical protein +FIG01485223 FIG00409533: hypothetical protein +FIG01485227 UDP-glucose:tetrahydrobiopterin glucosyltransferase [EC:2.4.1.-] +FIG01485280 FIG01244633: hypothetical protein +FIG01485292 ABC TRANSPORTER ATP-BINDING AND PERMEASE PROTEIN +FIG01485308 Uncharacterized protein MJ1374 +FIG01485315 very hypothetical protein Cj0974 +FIG01485318 Late competence protein ComC, processing protease +FIG01485326 FIG01114456: hypothetical protein +FIG01485329 FIG00350478: hypothetical protein +FIG01485348 FIG00633599: hypothetical protein +FIG01485353 FIG00361486: hypothetical protein +FIG01485362 FIG00675040: hypothetical protein +FIG01485364 Preprotein translocase subunit YajC +FIG01485377 putative small heat shock protein, hsp20 family +FIG01485424 Ankyrin-repeat containing protein +FIG01485447 FIG00817744: hypothetical protein +FIG01485451 Multidrug-efflux transporter quinolene resistance protein NorA +FIG01485458 FIG01166350: hypothetical protein +FIG01485523 Bsr5508 protein +FIG01485548 FIG01136100: hypothetical protein +FIG01485612 trypsin-like serine proteases +FIG01485645 UspA domain / CBS domain protein +FIG01485659 subtilisin-like serine protease, probable +FIG01485661 two-component system response-regulator +FIG01485667 N-terminal domain of CinA protein, COG1058 +FIG01485672 putative DNA-binding protein Roi +FIG01485728 FIG00241939: hypothetical protein +FIG01485739 FIG00733323: hypothetical protein +FIG01485755 Outer membrane protein tolC +FIG01485767 FIG00527953: hypothetical protein +FIG01485781 Secreted protein EspB, component of Type VII secretion system ESX-1 +FIG01485802 FIG00834295: hypothetical protein +FIG01485808 FIG00887074: hypothetical protein +FIG01485818 ISPpu14, transposase Orf2 +FIG01485844 hypothetical protein +FIG01485848 FIG00348268: hypothetical protein +FIG01485861 Aeromonas caviae phaC PHA synthase,complete cds +FIG01485872 FIG00380310: hypothetical protein +FIG01485882 helicase related protein +FIG01485904 Lactocepin (Cell wall-associated serine proteinase) (EC 3.4.21.96) +FIG01485924 FIG00998208: hypothetical protein +FIG01485932 Uncharacterized protein MJ0981 +FIG01485937 ABC-type sugar transport system periplasmic component-like +FIG01485941 signal transduction histidine kinase, nitrogen specific, NtrB +FIG01485968 Acetyltransferases, including N-acetylases of ribosomal proteins +FIG01485982 Streptokinase B +FIG01485994 possible exonuclease +FIG01485999 FIG00350516: hypothetical protein +FIG01486016 FIG00403120: hypothetical protein +FIG01486021 SpoVS-related protein, type 6 +FIG01486074 FIG00344948: hypothetical protein +FIG01486081 Phage/plasmid primase P4, C-terminal +FIG01486084 Putative tRNA ligase +FIG01486087 FIG00350210: hypothetical protein +FIG01486096 Leucine rich repeat variant +FIG01486104 Germacradienol/germacrene D synthase (EC 4.2.3.22) +FIG01486192 Ribosomal protein S6 modification protein-related protein +FIG01486206 FIG00404587: hypothetical protein +FIG01486207 Putative 3-alpha-hydroxysteroid dehydrogenase/carbonyl reductase oxidoreductase protein (EC 1.1.1.50) +FIG01486212 Cytochrome P450 +FIG01486216 Alr4850 protein +FIG01486217 FIG00755083: hypothetical protein +FIG01486251 Endoglucanase A precursor (endo-1,4-beta-glucanase) (cellulase A), secreted; dockerin domain +FIG01486284 FIG00361597: hypothetical protein +FIG01486319 FIG00653594: hypothetical protein +FIG01486322 FIG01230683: hypothetical protein +FIG01486344 FIG00343788: hypothetical protein +FIG01486360 FIG00966283: hypothetical protein +FIG01486377 GNAT family acetyltransferase PA5433 +FIG01486437 Hypothetical outer membrane usher protein yraJ precursor +FIG01486480 molybdopterin biosynthesis protein MoeB +FIG01486509 FIG00353015: hypothetical protein +FIG01486511 FIG01201161: hypothetical protein +FIG01486512 Metal-dependent hydrolase related to alanyl-tRNA synthetase +FIG01486514 FIG00767394: hypothetical protein +FIG01486542 FIG00643225: hypothetical protein +FIG01486546 hypothetical protein +FIG01486550 putative flagellar motor protein MotB +FIG01486551 FIG00848859: hypothetical protein +FIG01486556 FIG00356318: hypothetical protein +FIG01486575 FIG00515877: hypothetical protein +FIG01486579 Uncharacterized protein R02474 +FIG01486602 FIG00349117: hypothetical protein +FIG01486613 FIG00938000: hypothetical protein +FIG01486614 FIG00835238: hypothetical protein +FIG01486618 Putative alpha-1,2-mannosidase +FIG01486631 hypothetical protein +FIG01486632 FIG00945295: hypothetical protein +FIG01486644 FIG00529118: hypothetical protein +FIG01486652 Site-specific recombinase Mpi +FIG01486660 hypothetical phosphosugar isomerases +FIG01486694 FIG00624571: hypothetical protein +FIG01486698 IS6770 transposase +FIG01486716 UPF0333 protein MMP1283 +FIG01486731 FIG00761201: hypothetical protein +FIG01486739 Bsr0071 protein +FIG01486752 Helicase/SNF2 family domain protein +FIG01486776 KorA protein +FIG01486777 phosphodiesterase/alkaline phosphatase D +FIG01486793 ISSod4, transposase +FIG01486812 FIG00643924: hypothetical protein +FIG01486848 hypothetical protein +FIG01486903 sugar transport symporter +FIG01486919 BpmI endonuclease-methyltransferase fusion protein type IIG +FIG01486929 protein of unknown function DUF458 +FIG01486974 FIG01165967: hypothetical protein +FIG01486983 FIG00863159: hypothetical protein +FIG01486996 (Outer) membrane protein +FIG01487005 FIG00673184: hypothetical protein +FIG01487033 FIG00531333: hypothetical protein +FIG01487040 Probable L-amino-acid oxidase (EC 1.4.3.2) +FIG01487059 FIG00767408: hypothetical protein +FIG01487071 type IV pilus biogenesis protein PilF +FIG01487097 hypothetical protein SC1B2.06 +FIG01487098 acylamino-acid-releasing enzyme( EC:3.4.19.1 ) +FIG01487114 blr3478; hypothetical protein +FIG01487148 Hypothetical MW0754 homolog in superantigen-encoding pathogenicity islands SaPI +FIG01487159 ABC transport system periplasmic substrate binding protein +FIG01487185 bacteriophage DNA transposition protein A, putative +FIG01487198 EutQ-like protein clustered with pyruvate formate-lyase +FIG01487246 Amylovoran biosynthesis glycosyl transferase amsE (EC 2.-.-.-) +FIG01487259 RagB/SusD domain protein +FIG01487274 amino acid ABC transporter, permease protein +FIG01487293 Uncharacterized protein ypuB (ORFX1) +FIG01487304 methyl-accepting chemotaxis-like protein +FIG01487305 Metal-dependent hydrolase of the metallobeta-lactamase superfamily +FIG01487315 TPR repeat-containing protein +FIG01487365 FIG00344852: hypothetical protein +FIG01487368 Probable brix domain-containing ribosomal biogenesis protein +FIG01487376 PUTATIVE ACYL-COA SYNTHETASE PROTEIN +FIG01487392 FIG00850733: hypothetical protein +FIG01487414 FIG00427104: hypothetical protein +FIG01487418 FIG00535739: hypothetical protein +FIG01487419 FIG00767643: hypothetical protein +FIG01487469 ortholog of Bordetella pertussis (BX470248) BP2487 +FIG01487481 FIG00390378: hypothetical protein +FIG01487483 lipoprotein signal peptidase( EC:3.4.23.36 ) +FIG01487512 exopolysaccharide synthesis protein ExoD +FIG01487521 FIG01118166: hypothetical protein +FIG01487529 FIG00471746: hypothetical protein +FIG01487558 FIG00632476: hypothetical protein +FIG01487565 FIG00823724: hypothetical protein +FIG01487568 putative IS transposase (OrfB) +FIG01487573 6-phosphogluconolactonase +FIG01487575 FIG00822136: hypothetical protein +FIG01487578 FIG01206260: hypothetical protein +FIG01487585 FIG00675385: hypothetical protein +FIG01487597 Probable mobilization protein MobA +FIG01487629 hemolysin-3 +FIG01487668 Sll6055 protein +FIG01487690 Uncharacterized ACR, COG1434 family protein +FIG01487691 Cadmium-transporting ATPase (EC 3.6.1.-) +FIG01487716 zinc-binding alcohol dehydrogenase +FIG01487731 FIG071193: hypothetical protein +FIG01487734 Flp pilus assembly protein CpaC +FIG01487738 FIG00817119: hypothetical protein +FIG01487762 H(+):sodium-glutamate symporter +FIG01487776 Sucrose transport protein +FIG01487793 possible Ribosomal RNA adenine dimethylase +FIG01487798 FIG00409559: hypothetical protein +FIG01487818 Spermidine Putrescine ABC transporter permease component potB (TC_3.A.1.11.1) +FIG01487853 FIG00623187: hypothetical protein +FIG01487857 FIG00411497: hypothetical protein +FIG01487874 Hypothetical UPF0306 protein Cj1449c +FIG01487914 hypothetical protein +FIG01487916 FIG00533680: hypothetical protein +FIG01487924 FIG00834676: hypothetical protein +FIG01487968 carotenogenesis protein carS +FIG01487986 FIG00639900: hypothetical protein +FIG01488000 rfbN protein +FIG01488003 FIG00821789: hypothetical protein +FIG01488006 FIG00350364: hypothetical protein +FIG01488018 Isochorismatase family hydrolase +FIG01488024 FIG01252586: hypothetical protein +FIG01488031 hypothetical protein +FIG01488043 FIG00633342: hypothetical protein +FIG01488056 probable acetyl xylan esterase AxeA +FIG01488059 FIG00349635: hypothetical protein +FIG01488066 FIG01226524: hypothetical protein +FIG01488074 ABC-type transport system involved in resistance to organic solvents permease component +FIG01488077 Isomalto-dextranase precursor (EC 3.2.1.94) (Glucan 1,6-alpha-isomaltosidase) (Exo-isomaltohydrolase) +FIG01488087 uroporphyrin-III C-methyltransferase +FIG01488094 COG1373: Predicted ATPase (AAA+ superfamily) +FIG01488108 ORF_ID:alr7566 unknown protein +FIG01488131 FIG00815128: hypothetical protein +FIG01488135 putative amino acid transporter +FIG01488171 Tricorn protease N-terminal domain-containing protein +FIG01488183 FIG00821532: hypothetical protein +FIG01488187 IS3 family transposase orfA +FIG01488200 putative site-specific recombinase, integrase/recombinase RipX (xerC) +FIG01488233 orfB +FIG01488285 FIG01236934: hypothetical protein +FIG01488302 phosphoribosyltransferase +FIG01488308 putative efflux transporter, RND family, MFP subunit +FIG01488309 putative prepilin peptidase-like protein +FIG01488314 Protein of unknown function DUF305 +FIG01488325 Chaperone ipgA +FIG01488339 FIG00350112: hypothetical protein +FIG01488353 FIG01140477: hypothetical protein +FIG01488383 FIG00828989: hypothetical protein +FIG01488409 FIG00403698: hypothetical protein +FIG01488417 putative Orf27; P2 LysB homolog; control of lysis [Ente... +FIG01488429 Bll5492 protein +FIG01488433 FIG00385159: hypothetical protein +FIG01488435 putative major tail protein +FIG01488456 Thiaminase I precursor (EC 2.5.1.2) +FIG01488505 Conserved protein YesF +FIG01488552 FIG00643938: hypothetical protein +FIG01488602 polysaccharide lyase +FIG01488603 Anaerobic glycerol-3-phosphate dehydrogenase subunit A precursor (EC 1.1.99.5) +FIG01488605 FIG00427239: hypothetical protein +FIG01488626 NADH:flavin oxidoreductases +FIG01488644 FIG060329: MOSC domain protein / Molybdenum cofactor biosynthesis protein MoaB +FIG01488648 FIG00643850: hypothetical protein +FIG01488651 FIG00644396: hypothetical protein +FIG01488677 FIG00954500: hypothetical protein +FIG01488680 ortholog of Bordetella pertussis (BX470248) BP2101 +FIG01488682 FIG00385197: hypothetical protein +FIG01488697 FIG00356814: hypothetical protein +FIG01488738 FIG00459532: hypothetical protein +FIG01488744 Legionella secretion system protein B +FIG01488777 B. burgdorferi predicted coding region BBB25 +FIG01488800 FIG00361626: hypothetical protein +FIG01488806 similar to methyltransferase +FIG01488816 Glycoprotease protein family +FIG01488829 161 aa, no significant homology +FIG01488835 hypothetical protein SC9B2.15c +FIG01488846 FIG00624099: hypothetical protein +FIG01488854 FIG00533041: hypothetical protein +FIG01488866 FIG00427145: hypothetical protein +FIG01488875 aldose 1-epimerase family protein +FIG01488883 FIG00835591: hypothetical protein +FIG01488892 FIG00582414: hypothetical protein +FIG01488914 putative surface antigen +FIG01488917 Transcriptional regulator WhiB-like WhiB6 +FIG01488920 FIG00348829: hypothetical protein +FIG01488922 Biotin synthesis protein BioH +FIG01488968 putative ChaB family protein +FIG01488970 Oxidoreductase, short-chain dehydrogenase/reductase family +FIG01488999 hypothetical protein +FIG01489003 FIG00351594: hypothetical protein +FIG01489011 Type I site-specific restriction-modification system, R (restriction) subunit +FIG01489031 FIG00823034: hypothetical protein +FIG01489037 FIG01237733: hypothetical protein +FIG01489040 exodeoxyribonuclease-like protein +FIG01489042 COML, COMPETENCE LIPOPROTEIN +FIG01489052 hypothetical protein +FIG01489066 vitamin-B12 independent methionine synthase family protein +FIG01489090 Probable oxidoreductase yajO1 +FIG01489118 FIG00640921: hypothetical protein +FIG01489124 Alr0576 protein +FIG01489128 Phosphoglycerol transferase and related proteins, alkaline phosphatase superfamily +FIG01489195 FIG00632847: hypothetical protein +FIG01489209 Xanthine/uracil permeases +FIG01489234 Regulator protein TrbA +FIG01489240 FIG00528726: hypothetical protein +FIG01489242 Histidine triad family protein +FIG01489259 Histidine kinase internal region +FIG01489269 ORF025 +FIG01489302 FIG00423788: hypothetical protein +FIG01489307 FIG00623667: hypothetical protein +FIG01489359 FIG00388661: hypothetical protein +FIG01489365 Possible copper-binding protein +FIG01489417 FIG00356630: hypothetical protein +FIG01489431 aldehyde reductase( EC:1.1.1.2 ) +FIG01489435 mobilization protein mbeD +FIG01489453 FIG01048950: hypothetical protein +FIG01489454 Swarming motility protein SwrA +FIG01489486 Tail tape meausure protein +FIG01489517 Lmo1973 protein +FIG01489525 pentapeptide repeat-containing protein +FIG01489526 Gll2891 protein +FIG01489555 TspO and MBR related proteins +FIG01489596 FIG00406027: hypothetical protein +FIG01489597 FIG01248349: hypothetical protein +FIG01489633 putative sugar-phosphate isomerase +FIG01489641 FIG01231814: hypothetical protein +FIG01489648 COG3843: Type IV secretory pathway, VirD2 components (relaxase) +FIG01489664 FIG01114143: hypothetical protein +FIG01489675 FIG00623826: hypothetical protein +FIG01489683 Acetyltransferase, including N-acetylases of ribosomal proteins +FIG01489698 FIG00385181: hypothetical protein +FIG01489706 FIG01212322: hypothetical protein +FIG01489723 FIG00343796: hypothetical protein +FIG01489736 Lipooligosaccharide biosynthesis protein lpsA +FIG01489766 FIG00407373: hypothetical protein +FIG01489776 hypothetical dipeptidase +FIG01489802 Autolysin sensor kinase( EC:2.7.3.- ) +FIG01489808 Mu-like prophage protein gpG +FIG01489820 FIG01006909: hypothetical protein +FIG01489823 Paclitaxel/taxanoid biosynthesis susceptibility protein TS1 +FIG01489863 probable lactose uptake ABC transporter periplasmic solute-binding protein precursor +FIG01489888 FIG00641278: hypothetical protein +FIG01489894 FIG00404622: hypothetical protein +FIG01489956 FIG00743554: hypothetical protein +FIG01489966 hypothetical protein +FIG01489997 Putative periplasmic ATP /GTP-binding protein +FIG01489999 Conserved hypothetical prolipoprotein +FIG01490024 FIG00425236: hypothetical protein +FIG01490047 FIG00351009: hypothetical protein +FIG01490054 FIG00687486: hypothetical protein +FIG01490080 hypothetical protein +FIG01490091 anaerobic dimethyl sulfoxide reductase chain B +FIG01490092 FIG00385678: hypothetical protein +FIG01490103 FIG00385806: hypothetical protein +FIG01490127 mannan endo-1,4-beta-mannosidase precursor +FIG01490130 Group II intron maturase-specific domain protein +FIG01490138 similar to response regulator +FIG01490148 FIG00781233: hypothetical protein +FIG01490158 Uncharacterized protein MJ1450 +FIG01490159 sensory box sensor histidine kinase/response regulator VC0622 +FIG01490170 protein of unknown function DUF955 +FIG01490209 FIG00745137: hypothetical protein +FIG01490218 Accessory gene regulator protein D +FIG01490227 putative hydrolase (HD domain) +FIG01490244 TIR +FIG01490254 FIG00767195: hypothetical protein +FIG01490269 maltose-binding protein +FIG01490278 Calmodulin-dependent protein kinase (EC 2.7.11.17) +FIG01490280 FIG00356345: hypothetical protein +FIG01490306 Hypothetical protein YaeR with similarity to glyoxylase family +FIG01490308 3-oxoacid CoA-transferase, A subunit( EC:2.8.3.8 ) +FIG01490316 Conserved hypothetical protein Acg +FIG01490318 Glycosyltransferase of PMT family +FIG01490320 BpoB +FIG01490339 FIG01248374: hypothetical protein +FIG01490355 GDP-L-fucose synthase( EC:1.1.1.271 ) +FIG01490364 FIG00344628: hypothetical protein +FIG01490388 FIG00769249: hypothetical protein +FIG01490419 FIG00520057: hypothetical protein +FIG01490448 ORF056 +FIG01490458 FIG00406980: hypothetical protein +FIG01490502 Phosphatidylserine decarboxylase-related +FIG01490507 InterPro IPR000694:IPR002528 COGs COG0534 +FIG01490512 Ethanolamin permease +FIG01490553 Uncharacterized protein MJ1083 +FIG01490557 lactose phosphotransferase system repressor +FIG01490584 FIG00404621: hypothetical protein +FIG01490590 FIG00733474: hypothetical protein +FIG01490621 hypothetical protein +FIG01490623 FIG00409166: hypothetical protein +FIG01490624 Histidinol-phosphate phosphatase +FIG01490661 108aa long hypothetical protein +FIG01490664 Putative exonuclease +FIG01490670 hexosyltransferase; glycosyltransferase +FIG01490688 FIG00624744: hypothetical protein +FIG01490693 hypothetical protein +FIG01490704 Serpulina hyodysenteriae variable surface protein +FIG01490706 FIG00425928: hypothetical protein +FIG01490707 FIG00344967: hypothetical protein +FIG01490714 Peptidase S8 and S53, subtilisin, kexin, sedolisin (EC 3.4.21.62) +FIG01490725 FIG00687840: hypothetical protein +FIG01490727 UPF0104 membrane protein MTH_887 +FIG01490731 2-deoxyglucose-6-phosphate phosphatase 1 (EC 3.1.3.68) +FIG01490747 FIG00688855: hypothetical protein +FIG01490766 Type IV secretion system protein VirD4 +FIG01490798 FIG00627584: hypothetical protein +FIG01490802 FIG00350937: hypothetical protein +FIG01490824 SdbC +FIG01490832 mobilization protein BmpH +FIG01490836 FIG00361437: hypothetical protein +FIG01490838 probable transglycosylase +FIG01490853 FIG00440157: hypothetical protein +FIG01490865 FIG00344175: hypothetical protein +FIG01490868 FIG00351459: hypothetical protein +FIG01490869 regulatory protein BvgR +FIG01490871 putative two component response regulator +FIG01490873 protein of unknown function DUF1446 +FIG01490879 prophage LambdaBa01, TPR domain protein, putative +FIG01490887 FIG00733706: hypothetical protein +FIG01490901 FIG00932736: hypothetical protein +FIG01490915 Uncharacterized protein MJ0175 +FIG01490925 High light-inducible protein +FIG01490930 Regulatory protein GntR, HTH:GntR, C-terminal +FIG01490933 Borrelia virulent strain associated lipoprotein +FIG01490954 FIG00388613: hypothetical protein +FIG01490962 Possible methyltransferases +FIG01490969 Cytosolic acyl coenzyme A thioester hydrolase, inducible (EC 3.1.2.2) +FIG01490975 hydrolase, CocE/NonD family protein +FIG01490978 putative phage shock protein E +FIG01490979 FIG00409801: hypothetical protein +FIG01490981 glycosyltransferase family 11 +FIG01490986 FIG00380885: hypothetical protein +FIG01491007 heparan N-sulfatase( EC:3.1.6.- ) +FIG01491026 FIG00348288: hypothetical protein +FIG01491029 Carboxypeptidase-related protein +FIG01491033 FIG00451158: hypothetical protein +FIG01491034 Porin-like protein H precursor +FIG01491076 Putative ATP-dependent RNA helicase MJ1505 (EC 3.6.1.-) +FIG01491096 Transcription initiation factor IIF alpha subunit +FIG01491101 FIG00762803: hypothetical protein +FIG01491113 FIG00350299: hypothetical protein +FIG01491116 homolog to stress response protein +FIG01491146 PUTATIVE LIPOPROTEIN THIREDOXIN +FIG01491148 Probable xanthan lyase +FIG01491154 FIG00945095: hypothetical protein +FIG01491159 FIG00847568: hypothetical protein +FIG01491174 FIG00388221: hypothetical protein +FIG01491197 FIG00403877: hypothetical protein +FIG01491204 FIG00822212: hypothetical protein +FIG01491206 alpha/beta hydrolase superfamily, putative +FIG01491207 zinc transporter Slc39a7 +FIG01491222 ECF subfamily sigma factor +FIG01491254 FIG00388639: hypothetical protein +FIG01491263 FIG00363446: hypothetical protein +FIG01491277 nosL-related protein +FIG01491294 FIG00521502: hypothetical protein +FIG01491296 FIG01047528: hypothetical protein +FIG01491307 Pyrogallol hydroxytransferase( EC:1.97.1.2 ) +FIG01491310 FIG00388984: hypothetical protein +FIG01491316 FIG00351257: hypothetical protein +FIG01491334 ABC transporter ATP-binding and permease protein +FIG01491373 Collagenase family protease +FIG01491397 FIG00385129: hypothetical protein +FIG01491412 FIG00407344: hypothetical protein +FIG01491413 FIG01117424: hypothetical protein +FIG01491482 glucose dehydrogenase +FIG01491498 Multidrug efflux system outer membrane subunit +FIG01491549 ABC-type transport system +FIG01491576 FIG01190809: hypothetical protein +FIG01491603 putative DNA processing protein +FIG01491610 Adh +FIG01491633 FIG01251961: hypothetical protein +FIG01491637 unknown +FIG01491662 transferase hexapeptide repeat containing protein( EC:2.3.1.79 ) +FIG01491669 Uncharacterized protein encoded in hypervariable junctions of pilus gene clusters +FIG01491675 putative glucosyltransferase +FIG01491678 aminoglycoside N3-acetyltransferase +FIG01491684 FIG00895001: hypothetical protein +FIG01491707 FIG00356488: hypothetical protein +FIG01491779 FIG00554401: hypothetical protein +FIG01491794 FIG00379771: hypothetical protein +FIG01491818 FIG00443205: hypothetical protein +FIG01491862 POSSIBLE ACID PHOSPHATASE (ACID PHOSPHOMONOESTERASE) (PHOSPHOMONOESTERASE) (GLYCEROPHOSPHATASE) (EC 3.1.3.2) +FIG01491869 LipL45 protein +FIG01491976 LmbE-like protein protein +FIG01491977 Raffinose permease +FIG01491986 hypothetical protein Rv2661c +FIG01491994 Rv0623-like transcription factor +FIG01492005 subtilisin-like protease( EC:3.4.21.- ) +FIG01492008 FIG00353399: hypothetical protein +FIG01492014 FIG01165896: hypothetical protein +FIG01492027 FIG00688273: hypothetical protein +FIG01492046 FIG00411412: hypothetical protein +FIG01492050 FIG00351382: hypothetical protein +FIG01492057 oxalate-formate antiporter, putative +FIG01492059 Glycerol-3-phosphate ABC transporter, ATP-binding protein UgpC (TC 3.A.1.1.3) +FIG01492065 ortholog to Borrelia burgdorferi BB0097 +FIG01492073 COG4339: Uncharacterized protein conserved in bacteria +FIG01492086 FIG01250880: hypothetical protein +FIG01492100 hypothetical protein +FIG01492137 FIG00762751: hypothetical protein +FIG01492168 FIG00354112: hypothetical protein +FIG01492209 FIG00424307: hypothetical protein +FIG01492213 FIG00404829: hypothetical protein +FIG01492272 FIG00469011: hypothetical protein +FIG01492280 similarity to cell filamentation proteins (fic) +FIG01492294 iron-sulfur binding oxidoreductase +FIG01492299 enterotoxin H +FIG01492369 FIG00640927: hypothetical protein +FIG01492378 FIG00710758: hypothetical protein +FIG01492408 FIG00344061: hypothetical protein +FIG01492413 Recombination protein BET +FIG01492419 FIG01046471: hypothetical protein +FIG01492458 Uncharacterized protein aq_2175 precursor +FIG01492460 FIG00654408: hypothetical protein +FIG01492514 putative 2-pyrone-4,6-dicarboxylic acid hydrolase +FIG01492516 FIG00898875: hypothetical protein +FIG01492520 FIG00388871: hypothetical protein +FIG01492527 DNA-directed RNA polymerase subunit delta +FIG01492528 putative glycosyl transferase, WecB/TagA/CpsF family protein +FIG01492541 hypothetical protein +FIG01492572 FIG00762947: hypothetical protein +FIG01492575 Staphylocoagulase precursor +FIG01492579 ABC-type amino acid transport/signal transduction systems +FIG01492598 probable cytochrome c-554 +FIG01492604 FIG01248233: hypothetical protein +FIG01492610 ORF_ID:alr7557 unknown protein +FIG01492616 FIG01046508: hypothetical protein +FIG01492632 FIG00412155: hypothetical protein +FIG01492637 ComC family-like +FIG01492669 FIG00532174: hypothetical protein +FIG01492677 FIG00769820: hypothetical protein +FIG01492715 Oxidoreductase, short chain dehydrogenase/reductase +FIG01492723 Cytochrome P450 enzyme +FIG01492736 FIG00385693: hypothetical protein +FIG01492784 putative ABC transporter, permease component +FIG01492788 Hypothetical precursor +FIG01492795 FIG00424211: hypothetical protein +FIG01492812 argininosuccinate lyase +FIG01492833 conserved hypothetical protein; K08995 putative membrane protein +FIG01492842 FIG00747851: hypothetical protein +FIG01492850 FIG00519783: hypothetical protein +FIG01492858 Two component response regulator with GGDEF domain +FIG01492866 FIG00349444: hypothetical protein +FIG01492872 GGDEF domain-containing protein +FIG01492879 All0876 protein +FIG01492885 Probable lysophospholipase, alpha/beta hydrolase superfamily +FIG01492897 Cobalt transport protein CbiN +FIG01492921 FIG00353596: hypothetical protein +FIG01492950 FIG00854435: hypothetical protein +FIG01492952 FIG01167025: hypothetical protein +FIG01492953 UPF0047 protein Bsu YugU +FIG01492960 FIG00380379: hypothetical protein +FIG01492983 hypothetical protein +FIG01492994 MOSC domain +FIG01493041 FIG00689769: hypothetical protein +FIG01493057 ABC-type multidrug transport system, ATPase component, putative +FIG01493063 ISSod10, transposase OrfB +FIG01493064 FIG00524564: hypothetical protein +FIG01493112 hypothetical protein +FIG01493118 nucleotide sugar epimerase/dehydratase +FIG01493140 Relaxosome component +FIG01493157 fatty acid cistrans isomerase +FIG01493158 FIG00412729: hypothetical protein +FIG01493166 hypothetical protein; Unknown protein +FIG01493173 FIG00864317: hypothetical protein +FIG01493181 ORF Y +FIG01493198 hypothetical protein +FIG01493226 FIG00746655: hypothetical protein +FIG01493252 DEAD box helicase family protein +FIG01493294 FIG00302026: hypothetical protein +FIG01493297 flagellar protein FlgA +FIG01493339 Outer membrane protein YfgL, lipoprotein component of the protein assembly complex (forms a complex with YaeT, YfiO, and NlpB) +FIG01493346 FIG00406145: hypothetical protein +FIG01493360 UPF0110 protein Mb0640 +FIG01493391 Complete genome; segment 15/17 +FIG01493395 PDZ domain +FIG01493418 Probable flagellum biosynthesis repressor protein flbT +FIG01493421 FIG01220739: hypothetical protein +FIG01493438 FIG00623526: hypothetical protein +FIG01493439 Gsl3115 protein +FIG01493446 FIG00515046: hypothetical protein +FIG01493451 ISSpn1, transposase, IS3 family, truncated +FIG01493457 FIG00385502: hypothetical protein +FIG01493460 FIG00896785: hypothetical protein +FIG01493471 major outer membrane protein OmpA +FIG01493472 FIG00850611: hypothetical protein +FIG01493487 transposase IS111A/IS1328/IS1533 +FIG01493497 hypothetical protein +FIG01493502 conserved hypothetical protein +FIG01493521 FIG00344619: hypothetical protein +FIG01493525 Putative ABC transport system, integral membrane protein +FIG01493537 Hypothetical protein, PV83 orf 20 homolog [SA bacteriophages 11, Mu50B] +FIG01493547 FIG00404777: hypothetical protein +FIG01493553 degenerated cellulase +FIG01493554 conserved hypothetical protein 341 +FIG01493556 FIG00750419: hypothetical protein +FIG01493567 FIG00361941: hypothetical protein +FIG01493581 FIG00765019: hypothetical protein +FIG01493583 FIG00541306: hypothetical protein +FIG01493594 asparaginase( EC:3.5.1.1 ) +FIG01493617 FIG01276786: hypothetical protein +FIG01493624 hypothetical protein +FIG01493625 Probable cation-transporting ATPase E (EC 3.6.3.-) +FIG01493647 glycosyltransferase WbpX +FIG01493660 Type IV pilus biogenesis protein PilM +FIG01493664 FIG00734385: hypothetical protein +FIG01493668 hypothetical protein +FIG01493723 Iron/Ascorbate oxidoreductase +FIG01493730 FIG01047155: hypothetical protein +FIG01493787 FIG00413343: hypothetical protein +FIG01493791 putative ribosomal-protein-alanine N-acetyltransferase +FIG01493822 glycerol-3-phosphate ABC transporter, ATP-binding protein +FIG01493831 hypothetical protein +FIG01493832 RND family efflux transporter +FIG01493846 COG1629: Outer membrane receptor proteins, mostly Fe transport +FIG01493853 GIY-YIG domain protein +FIG01493867 FIG00816005: hypothetical protein +FIG01493878 Phage exonuclease +FIG01493885 hypothetical protein +FIG01493907 probable radical-forming protein PH1164 +FIG01493932 Probable Hsp20-family chaperone +FIG01493951 YDDB protein +FIG01493954 Isoniazid inductible protein IniC +FIG01493958 efflux PumP antibiotic resistance protein +FIG01493978 Cation transport regulator ChaB +FIG01493994 FIG00513548: hypothetical protein +FIG01494011 FIG00349194: hypothetical protein +FIG01494027 transposase (IS4 family) domain protein +FIG01494035 FIG00425862: hypothetical protein +FIG01494040 COG0030: Dimethyladenosine transferase (rRNA methylation) +FIG01494042 FIG00409343: hypothetical protein +FIG01494062 FIG01212931: hypothetical protein +FIG01494074 chitinase, class II( EC:3.2.1.14 ) +FIG01494086 fibronectin type III repeat domain containing se creted glycoside hydrolase, family 43( EC:3.2.1.- ) +FIG01494097 FIG00344055: hypothetical protein +FIG01494108 FIG028593: membrane protein +FIG01494113 putative mechanosensitive channel protein +FIG01494132 ORF_ID:all7644 unknown protein +FIG01494152 VirB4 protein precursor +FIG01494169 FIG00413705: hypothetical protein +FIG01494170 Bll7551 protein +FIG01494181 COG1225: Peroxiredoxin +FIG01494185 predicted membrane-associated +FIG01494196 putative alkylmercury lyase +FIG01494234 FIG00271907: hypothetical protein +FIG01494280 Putative beta-D-galactosidase +FIG01494281 FIG00425971: hypothetical protein +FIG01494287 hypothetical protein +FIG01494295 FIG00409120: hypothetical protein +FIG01494310 ubiquinone/menaquinone biosynthesis methyltransferase +FIG01494312 FIG01118722: hypothetical protein +FIG01494314 putative dihydrokaempferol 4-reductase +FIG01494318 Putative bacteriophage P2 tail protein gpT +FIG01494326 FIG00388993: hypothetical protein +FIG01494327 Chaperone protein SicA (Salmonella invasin chaperone) +FIG01494352 Soluble epoxide hydrolase (EC 3.3.2.10) (SEH) (Epoxide hydratase) (Cytosolic epoxide hydrolase) (cEH) +FIG01494359 ISSfl1 ORF2 +FIG01494386 Predicted oxidoreductases of the aldo/keto reductase family +FIG01494388 FIG00379989: hypothetical protein +FIG01494403 Histone H1-beta, late embryonic +FIG01494404 FIG01152677: hypothetical protein +FIG01494445 Uncharacterized protein MJ0858 +FIG01494463 IS1630-like transposase +FIG01494495 putative ATP-binding transporter +FIG01494503 SirA-like protein +FIG01494532 FIG01047938: hypothetical protein +FIG01494541 FIG00710954: hypothetical protein +FIG01494543 FIG00353614: hypothetical protein +FIG01494549 putative orphan protein; putative membrane protein +FIG01494585 hypothetical protein +FIG01494589 FIG00874915: hypothetical protein +FIG01494621 FIG00353235: hypothetical protein +FIG01494629 transcriptional regulator (MarR family) protein +FIG01494641 probable regulator +FIG01494659 FIG00763694: hypothetical protein +FIG01494661 similar to hydrolase or acyltransferase (alpha/beta hydrolase superfamily) +FIG01494665 DNA polymerase III delta subunit( EC:2.7.7.7 ) +FIG01494709 FIG00424504: hypothetical protein +FIG01494711 FIG01117230: hypothetical protein +FIG01494730 FIG00847524: hypothetical protein +FIG01494753 carboxyvinyl-carboxyphosphonate phosphorylmutase +FIG01494787 syc2051_d +FIG01494795 FIG00385579: hypothetical protein +FIG01494804 METHOXY MYCOLIC ACID SYNTHASE 3 MMAA3 (METHYL MYCOLIC ACID SYNTHASE 3) (MMA3) (HYDROXY MYCOLIC ACID SYNTHASE) +FIG01494813 FIG028220: hypothetical protein co-occurring with HEAT repeat protein +FIG01494815 FIG01135719: hypothetical protein +FIG01494837 FIG01181850: hypothetical protein +FIG01494845 stress responsive A/B Barrel Domain superfamily +FIG01494866 ortholog of Bordetella pertussis (BX470248) BP2255 +FIG01494871 FIG00767555: hypothetical protein +FIG01494875 glutamate binding protein +FIG01494880 Ribose import ATP-binding protein rbsA 2 (EC 3.6.3.17) +FIG01494889 Aromatic compounds dioxygenase +FIG01494909 Sll1942 protein +FIG01494910 IcmE protein +FIG01494929 corresponds to STY4075 from Accession AL513382: Salmonella typhi CT18 +FIG01494933 putative phage membrane protein +FIG01494967 hypothetical protein +FIG01494971 possible metallopeptidase +FIG01494974 FIG00471233: hypothetical protein +FIG01495012 Glutamate/aspartate periplasmic binding protein precursor +FIG01495024 FIG00348791: hypothetical protein +FIG01495038 Mll2991 protein +FIG01495052 hypothetical protein-putative secreted oxidoreductase +FIG01495073 FIG00525545: hypothetical protein +FIG01495074 hypothetical protein +FIG01495097 B. burgdorferi predicted coding region BBI12 +FIG01495102 FIG01214103: hypothetical protein +FIG01495111 Blr1411 protein +FIG01495117 Luciferase-like monooxygenase superfamily +FIG01495124 Chloramphenicol acetyltransferase (EC 2.3.1.28) +FIG01495145 FIG00631861: hypothetical protein +FIG01495163 FIG00387823: hypothetical protein +FIG01495165 Cytotoxin K +FIG01495222 DNA-binding protein, HU family +FIG01495237 FIG00847953: hypothetical protein +FIG01495250 Catechol 2,3-dioxygenase +FIG01495262 FIG01119037: hypothetical protein +FIG01495274 FIG00849095: hypothetical protein +FIG01495275 bacterioferritin comigratory protein +FIG01495294 ribosomal RNA adenine dimethylase +FIG01495315 FIG00635626: hypothetical protein +FIG01495316 prophage LambdaBa01, repressor protein, putative +FIG01495328 P2 GpE family protein +FIG01495348 FIG00569193: hypothetical protein +FIG01495349 Alkyl hydroperoxide reductase and/or thiol-specific antioxidant family (AhpC/TSA) protein +FIG01495352 putative diguanylate phosphodiesterase +FIG01495361 FIG00700125: hypothetical protein +FIG01495362 FIG00551644: hypothetical protein +FIG01495375 FIG01205182: hypothetical protein +FIG01495388 Enterochelin esterase and related enzymes +FIG01495396 FIG00362583: hypothetical protein +FIG01495436 Alkylhydroperoxidase AhpD core +FIG01495450 arginine-binding periplasmic protein 1 precursor +FIG01495458 Phage shock protein A +FIG01495459 HpnA protein +FIG01495481 Unknown, probable insecticidal toxin +FIG01495485 FIG00424744: hypothetical protein +FIG01495509 PREDICTED: hypothetical protein, partial +FIG01495523 FIG00834376: hypothetical protein +FIG01495528 hemin-binding protein B +FIG01495531 putative transposition protein +FIG01495537 DNA binding transcriptional repressor, conjectural +FIG01495546 FIG00524163: hypothetical protein +FIG01495554 FIG00639002: hypothetical protein +FIG01495557 lambda tail assembly I +FIG01495559 FIG00746055: hypothetical protein +FIG01495574 FIG00424179: hypothetical protein +FIG01495618 Probable conserved lipoprotein lppOb +FIG01495633 FIG00863870: hypothetical protein +FIG01495641 Alcohol dehydrogenase superfamily, zinc-containing +FIG01495642 DnaD and phage-associated region +FIG01495650 FIG00939280: hypothetical protein +FIG01495691 POSSIBLE HISTONE-LIKE PROTEIN HNS +FIG01495737 FIG00767764: hypothetical protein +FIG01495743 Outer surface protein VlsE +FIG01495758 Orf24 +FIG01495771 Integrase/recombinase (xerD/xerC family) +FIG01495781 FIG00745894: hypothetical protein +FIG01495787 Secreted protein containing tetratricopeptide re peats +FIG01495804 FIG172111: hypothetical protein +FIG01495812 FIG00756778: hypothetical protein +FIG01495837 FIG00354102: hypothetical protein +FIG01495852 DNA-binding response regulator, putative +FIG01495865 FIG00361519: hypothetical protein +FIG01495872 Holin, toxin secretion/phage lysis +FIG01495881 hypothetical protein +FIG01495898 translation initiation factor, eIF-2B alpha subunit-related +FIG01495920 FIG00522917: hypothetical protein +FIG01495944 FIG00765728: hypothetical protein +FIG01495951 FIG00514850: hypothetical protein +FIG01495959 cyclase, putative +FIG01495969 haloacid dehalogenase-like hydrolase domain/phosphoribulokinase domain protein +FIG01495975 FIG00552926: hypothetical protein +FIG01495983 regulatory protein, FmdB family +FIG01495985 FIG00524940: hypothetical protein +FIG01496004 Phosphoenolpyruvate-protein phosphotransferase +FIG01496029 Ucharacterized protein, CGEB homolog +FIG01496051 Methylcobalamin methyltransferase MMP0830 +FIG01496084 hypothetical protein +FIG01496097 2-amino-4-hydroxy-6-hydroxymethyldihydropteridi ne pyrophosphokinase( EC:2.7.6.3 ) +FIG01496107 FIG00670356: hypothetical protein +FIG01496133 possible Pancreatic hormone peptide +FIG01496140 FIG00344610: hypothetical protein +FIG01496177 putative mandelate racemase/muconate lactonizing enzyme +FIG01496180 POSSIBLE TRANSFERASE (EC 2.-.-.-) +FIG01496203 mannosyl-glycoprotein endo-beta-N-acetylglucosamidase domain protein, possible enterotoxin +FIG01496213 Virulence regulon transcriptional activator virF +FIG01496216 FIG00385712: hypothetical protein +FIG01496236 ABC-type uncharacterized transport system, permease component +FIG01496246 FIG00405623: hypothetical protein +FIG01496249 FIG00818298: hypothetical protein +FIG01496252 Hypothetical protein, CF-25 family +FIG01496324 FIG00623787: hypothetical protein +FIG01496328 phage virion morphogenesis protein +FIG01496348 FIG00348246: hypothetical protein +FIG01496352 FIG00411855: hypothetical protein +FIG01496360 heterocyst differentiation related protein +FIG01496421 FIG00413840: hypothetical protein +FIG01496431 FIG00451752: hypothetical protein +FIG01496505 FIG00380314: hypothetical protein +FIG01496509 Possible beta-xylosidase, family 43 of glycosyl hydrolases +FIG01496516 FIG00946354: hypothetical protein +FIG01496652 virulence protein +FIG01496656 von Willebrand factor type A +FIG01496704 hypothetical protein +FIG01496727 hypothetical protein +FIG01496731 FIG00545197: hypothetical protein +FIG01496754 FIG00665723: hypothetical protein +FIG01496796 putative electron-transfer protein +FIG01496801 FIG00524743: hypothetical protein +FIG01496808 FIG00426300: hypothetical protein +FIG01496820 FIG00423826: hypothetical protein +FIG01496834 ribosomal protein S10 homolog +FIG01496837 FIG00350250: hypothetical protein +FIG01496840 B. burgdorferi predicted coding region BB0708 +FIG01496844 regulatory protein TetR +FIG01496850 corresponds to STY1597 from Accession AL513382: Salmonella typhi CT18 +FIG01496858 FIG00450676: hypothetical protein +FIG01496866 COGs COG2329 +FIG01496917 Uncharacterized protein MJ0581 +FIG01496978 syc1057_d +FIG01496979 transposon-related protein +FIG01497009 putative chaperonin +FIG01497014 FIG01114120: hypothetical protein +FIG01497027 hypothetical protein +FIG01497061 protein tRNA-associated locus protein +FIG01497065 CELL PROCESSES; Transport of small molecules; amino acids, amines, peptides +FIG01497125 uncharacterised conserved protein UCP032025 +FIG01497134 Putative acyl-CoA dehydrogenase +FIG01497146 Von Willebrand factor type A domain / COG2110, Macro domain, possibly ADP-ribose binding module +FIG01497163 type II site-specific deoxyribonuclease (Sau96I-li +FIG01497184 FIG00163379: hypothetical protein +FIG01497203 FIG00767632: hypothetical protein +FIG01497246 FIG00529690: hypothetical protein +FIG01497248 FIG00385350: hypothetical protein +FIG01497252 Dipeptidyl-peptidase VI (EC 3.4.22.-) +FIG01497288 Alr4814 protein +FIG01497316 VfmD protein +FIG01497335 FIG00470960: hypothetical protein +FIG01497399 VirS +FIG01497404 FIG01128954: hypothetical protein +FIG01497408 Pli0073 protein +FIG01497409 probable membrane protein b0302 +FIG01497428 FIG00945407: hypothetical protein +FIG01497463 FIG00633605: hypothetical protein +FIG01497484 FIG00761275: hypothetical protein +FIG01497485 FIG00633113: hypothetical protein +FIG01497488 hypothetical protein co-occurring with urease in Rhizobiales +FIG01497499 AraC-type DNA-binding transcriptional regulator +FIG01497500 FIG00654603: hypothetical protein +FIG01497503 probable sensory transduction histidine kinase +FIG01497505 Vng1744h +FIG01497516 FIG00643971: hypothetical protein +FIG01497517 FIG00529897: hypothetical protein +FIG01497523 pyrophosphatase, MutT/nudix family +FIG01497543 FIG00530817: hypothetical protein +FIG01497563 Bll6708 protein +FIG01497566 FIG00411666: hypothetical protein +FIG01497568 Putative salt-induced outer membrane protein-like protein +FIG01497572 FKBP-type peptidyl-prolyl cis-trans isomerase (Rotamase) (EC 5.2.1.8) +FIG01497605 FIG01119699: hypothetical protein +FIG01497620 FIG00767610: hypothetical protein +FIG01497636 BH1517-unknown conserved protein +FIG01497645 FIG00384989: hypothetical protein +FIG01497688 outer membrane hemin receptor +FIG01497693 Bll5531 protein +FIG01497707 Cytochrome c peroxidase (EC 1.11.1.5) +FIG01497712 hypothetical conserved transmembrane protein in the DedA family +FIG01497728 Aldehyde dehydrogenase, thermostable (EC 1.2.1.5) +FIG01497737 hypothetical protein +FIG01497747 NusG antitermination factor +FIG01497759 NfnB protein +FIG01497779 outer membrane protein, porin family +FIG01497801 FIG00623928: hypothetical protein +FIG01497803 Helix-turn-helix motif:Peptidase S24, S26A and S26B +FIG01497806 Glutamate Aspartate periplasmic binding protein precursor GltI (TC 3.A.1.3.4) +FIG01497833 FIG01022713: hypothetical protein +FIG01497834 FIG00688902: hypothetical protein +FIG01497843 MccB-like protein +FIG01497851 signal peptide peptidase SppA, 36K type( EC:3.4.- ) +FIG01497854 putative haloacid-type dehydrogenase +FIG01497856 small membrane protein +FIG01497861 hypothetical protein +FIG01497883 FIG01213232: hypothetical protein +FIG01497886 putative YrbE family protein +FIG01497969 FIG00631617: hypothetical protein +FIG01497999 FIG00356647: hypothetical protein +FIG01498005 epoxide hydrolase-related protein +FIG01498010 FIG01092719: hypothetical protein +FIG01498038 syc0474_d +FIG01498043 Nodulation protein A +FIG01498092 site-specific DNA-methyltransferase, putative +FIG01498119 Isopenicillin-N epimerase( EC:5.1.1.17 ) +FIG01498125 Accessory gene regulator C (sensor histidine kinase) +FIG01498127 carboxylate-amine ligase +FIG01498150 FIG01129245: hypothetical protein +FIG01498160 Thiol oxidoreductase +FIG01498166 FIG00766243: hypothetical protein +FIG01498194 Signal transduction inhibitor +FIG01498202 FIG00390484: hypothetical protein +FIG01498251 FIG00351492: hypothetical protein +FIG01498258 FIG00388592: hypothetical protein +FIG01498265 ParA +FIG01498304 FIG00631874: hypothetical protein +FIG01498321 FIG01119232: hypothetical protein +FIG01498346 FIG00765004: hypothetical protein +FIG01498347 urease cluster protein, truncated +FIG01498356 Vi polysaccharide export ATP-binding protein vexC +FIG01498380 probable integration host factor +FIG01498412 FIG00388493: hypothetical protein +FIG01498436 FIG00353375: hypothetical protein +FIG01498437 FIG00643691: hypothetical protein +FIG01498475 FIG00388674: hypothetical protein +FIG01498487 FIG00352786: hypothetical protein +FIG01498501 FIG00559232: hypothetical protein +FIG01498518 conserved hypothetical protein, with a conserved domain +FIG01498540 Transcriptional regulators of sugar metabolism (deoR family) +FIG01498554 FIG01204866: hypothetical protein +FIG01498580 FIG00638234: hypothetical protein +FIG01498590 PUTATIVE CYTOSINE-SPECIFIC METHYLTRANSFERASE PROTEIN( EC:2.1.1.73 ) +FIG01498594 endoproteinase Arg-C +FIG01498642 FIG00404779: hypothetical protein +FIG01498655 Peptidase S1 and S6, chymotrypsin/Hap +FIG01498661 Ste24 endopeptidase( EC:3.4.24.84 ) +FIG01498662 glutaredoxin +FIG01498667 Copper resistance protein CopC precursor +FIG01498669 hypothetical protein +FIG01498692 Spore coat protein T precursor +FIG01498693 dipeptide/oligopeptide ABC transporter, permease protein +FIG01498702 M20 Peptidase Aminoacylase 1 family +FIG01498719 hypothetical protein +FIG01498729 Transport integral membrane protein +FIG01498746 cyclin domain protein +FIG01498752 suppressor for copper-sensitivity D, putative +FIG01498757 FIG00525917: hypothetical protein +FIG01498759 Peptidoglycan-binding, LysM family protein +FIG01498764 FIG00839085: hypothetical protein +FIG01498775 FIG00351002: hypothetical protein +FIG01498788 ATP binding protein-like protein +FIG01498793 MmgE/PrpD family protein, putative +FIG01498825 CHLPS 43 kDa protein homolog_4 +FIG01498834 secreted esterase +FIG01498842 InterPro IPR001584 COGs COG2801 +FIG01498847 hypothetical protein +FIG01498865 FIG00380590: hypothetical protein +FIG01498875 hypothetical protein +FIG01498876 FIG00766301: hypothetical protein +FIG01498910 FIG00629043: hypothetical protein +FIG01498917 FIG00978337: hypothetical protein +FIG01498921 FIG00719640: hypothetical protein +FIG01498932 Immediate-early protein +FIG01498948 hypothetical protein +FIG01498957 FIG00641889: hypothetical protein +FIG01499010 FIG00522571: hypothetical protein +FIG01499013 putative Bdr protein +FIG01499020 putative glycosyl transferase +FIG01499037 Bll8026 protein +FIG01499038 FIG00406423: hypothetical protein +FIG01499045 FIG00435100: hypothetical protein +FIG01499076 FIG01287890: hypothetical protein +FIG01499096 Extracellular solute-binding protein, family 3/GGDEF domain protein +FIG01499097 FIG00410562: hypothetical protein +FIG01499113 LMBE-RELATED PROTEIN +FIG01499134 Succinoglycan biosynthesis protein ExoA +FIG01499176 FIG00768286: hypothetical protein +FIG01499188 PROBABLE ESTERASE/LIPASE PROTEIN( EC:3.1.1.- ) +FIG01499200 COG1403: Restriction endonuclease +FIG01499214 FIG00385608: hypothetical protein +FIG01499238 FIG00380618: hypothetical protein +FIG01499253 fatty acid desaturase family protein +FIG01499256 FIG01137239: hypothetical protein +FIG01499258 beta-lactamase related protein +FIG01499292 FIG00529503: hypothetical protein +FIG01499297 transposase (class II) +FIG01499331 FIG01211785: hypothetical protein +FIG01499348 FIG01242977: hypothetical protein +FIG01499363 FIG00640956: hypothetical protein +FIG01499387 Capsular polysaccharide biosynthesis protein I +FIG01499393 Signaling protein with a GGDEF domain +FIG01499399 FIG00798773: hypothetical protein +FIG01499401 flagellar basal body rod protein +FIG01499445 Hvp 101 +FIG01499448 possible serine protease, C-terminal +FIG01499461 FIG00849779: hypothetical protein +FIG01499462 deoxyuridine 5-triphosphate nucleotidohydrolase( EC:3.6.1.23 ) +FIG01499468 FIG00870880: hypothetical protein +FIG01499470 FIG01206889: hypothetical protein +FIG01499471 Probable ATP-dependent RNA helicase +FIG01499482 hypothetical protein +FIG01499487 FIG00385025: hypothetical protein +FIG01499492 possible glyoxylase +FIG01499495 UPF0204 protein MJ0166 +FIG01499501 Hypothetical protein DUF454 +FIG01499511 protein of unknown function DUF74 +FIG01499515 Protein of unknown function DUF938 +FIG01499518 Protein of unknown function DUF348:Transglycosylase-like:G5 +FIG01499550 FIG00672498: hypothetical protein +FIG01499556 Putaive isomerase +FIG01499558 Serine/threonine-protein kinase pknE (EC 2.7.11.1) +FIG01499560 calcium binding protein +FIG01499566 Cytochrome P450 116 (EC 1.14.-.-) +FIG01499574 FIG00351827: hypothetical protein +FIG01499608 Putative DNA binding protein +FIG01499611 PTS system, L-Ascorbate family, IIA component +FIG01499650 InterPro IPR001902 COGs COG0659 +FIG01499652 FIG028593: membrane protein +FIG01499705 phospholipase, patatin family +FIG01499732 hypothetical protein +FIG01499744 FIG00388235: hypothetical protein +FIG01499777 FIG00361671: hypothetical protein +FIG01499789 FIG00648522: hypothetical protein +FIG01499820 Inorganic pyrophospatase PpaX (EC 3.1.3.18) +FIG01499825 conserved hypothetical protein with a conserved domain +FIG01499855 FIG01222427: hypothetical protein +FIG01499896 Uncharacterized RNA pseudouridine synthase ZMO0505 (EC 5.4.99.-) (RNA-uridine isomerase) (RNA pseudouridylate synthase) +FIG01499912 Gll3207 protein +FIG01499921 ATPase +FIG01499922 Possible sugar transferase +FIG01499929 membrane protein involved in aromatic hydrocarbon degradation +FIG01499937 Uncharacterized membrane protein +FIG01499950 Probable rhs-related protein +FIG01500010 FIG00416510: hypothetical protein +FIG01500033 ABC-transporter ATP-binding component +FIG01500038 FIG00589379: hypothetical protein +FIG01500045 hypothetical protein, putative ribonuclease E +FIG01500057 FIG00817315: hypothetical protein +FIG01500062 FIG00623570: hypothetical protein +FIG01500068 UPF0272 protein CA_C0774 +FIG01500088 FIG00446734: hypothetical protein +FIG01500091 NtrC family transcriptional regulator (PAS and AAA domains) +FIG01500194 hypothetical homeodomain-like +FIG01500197 FIG00766979: hypothetical protein +FIG01500228 Procyclic form specific polypeptide precursor +FIG01500229 hypothetical protein +FIG01500233 toluene tolerance protein +FIG01500243 Substrate-specific component NikM of nickel ECF transporter +FIG01500245 transcriptional regulator PlcR, putative +FIG01500296 Proline dipeptidase +FIG01500344 conserved hypothetical transmembrane signal peptide protein +FIG01500359 Putative sugar uptake protein SpyM3_1856/SPs1852 +FIG01500405 FIG01240545: hypothetical protein +FIG01500449 FIG00416767: hypothetical protein +FIG01500451 COG0146: N-methylhydantoinase B/acetone carboxylase, alpha subunit +FIG01500464 Type V secretory pathway protein +FIG01500485 cobS protein, putative +FIG01500498 Putative lyase +FIG01500499 FIG01205217: hypothetical protein +FIG01500502 Putative exported protein +FIG01500538 cytochrome c5530 family protein +FIG01500541 toxin-antitoxin system, toxin component, HicA domain protein +FIG01500546 FIG00769846: hypothetical protein +FIG01500552 FIG00532158: hypothetical protein +FIG01500557 Transposase and inactivated derivatives, IS30 family +FIG01500561 FIG00344215: hypothetical protein +FIG01500577 FIG00403846: hypothetical protein +FIG01500592 hypothetical protein +FIG01500634 leucine-rich-repeat protein +FIG01500638 FIG00631165: hypothetical protein +FIG01500705 Acidic cytochrome c3 precursor +FIG01500756 hypothetical protein +FIG01500760 FIG00766616: hypothetical protein +FIG01500773 site-specific recombinase, putative +FIG01500780 Lmo0312 protein +FIG01500787 FIG00630538: hypothetical protein +FIG01500793 High-affinity leucine-specific transport system, periplasmic binding protein LivK (TC 3.A.1.4.1) +FIG01500835 Putative acetamidase/formamidase +FIG01500845 FIG00525142: hypothetical protein +FIG01500864 FIG01240583: hypothetical protein +FIG01500871 Asparagine-rich ORFan next to Sag operon +FIG01500873 endonuclease precursor (nucA) +FIG01500879 n-terminal acetyltransferase +FIG01500896 Modification methylase BglII (EC 2.1.1.113) (N(4)- cytosine-specific methyltransferase BglII) (M.BglII) +FIG01500908 FIG00658186: hypothetical protein +FIG01500914 ComX pheromone precursor +FIG01500924 possible efflux transporter protein +FIG01500932 ADP/ATP carrier protein +FIG01500935 RedA +FIG01500939 FIG00526015: hypothetical protein +FIG01500941 CylJ protein +FIG01500950 protective antigen MAA2 +FIG01500964 FIG00538321: hypothetical protein +FIG01500966 putative export associated protein +FIG01500991 COG3467: Predicted flavin-nucleotide-binding protein +FIG01501009 FIG00385373: hypothetical protein +FIG01501024 UPF0059 membrane protein DVU_2910 +FIG01501049 Uncharacterized NAD(FAD)-dependent dehydrogenase +FIG01501058 FIG00385468: hypothetical protein +FIG01501107 FIG00483037: hypothetical protein +FIG01501108 MoeB/thiF family protein +FIG01501114 Mercuric resistance operon regulatory protein +FIG01501119 Predicted transmembrane transcriptional regulator (anti-sigma factor) +FIG01501139 FIG00919474: hypothetical protein +FIG01501169 Ovarian-specific serine/threonine-protein kinase (EC 2.7.1.-) +FIG01501185 Nitrite extrusion protein NarK +FIG01501221 ABC transporter (ATP-binding protein) +FIG01501223 hypothetical protein +FIG01501224 femA protein (femA) +FIG01501236 FIG00385220: hypothetical protein +FIG01501241 FIG00674338: hypothetical protein +FIG01501275 FIG00385296: hypothetical protein +FIG01501278 Putative glycosyl transferase +FIG01501340 Tfp type 4 fimbrial pilin related signal peptide protein domain +FIG01501342 FIG00353482: hypothetical protein +FIG01501349 FIG00642944: hypothetical protein +FIG01501353 predicted amidohydrolase +FIG01501356 EXTRACYTOPLASMIC FUNCTION ALTERNATIVE SIGMA FACTOR +FIG01501364 FIG00816281: hypothetical protein +FIG01501370 Uncharacterized predicted metal-binding protein +FIG01501413 hypothetical protein +FIG01501423 FIG00702704: hypothetical protein +FIG01501454 MoeA +FIG01501461 formate dehydrogenase family accessory protein FdhD +FIG01501462 femAB family protein +FIG01501471 esterase/lipase( EC:3.1.1.- ) +FIG01501473 FIG00518334: hypothetical protein +FIG01501496 FIG00623440: hypothetical protein +FIG01501501 FIG01109033: hypothetical protein +FIG01501504 probable phytoene dehydrogenase +FIG01501530 protein of unknown function DUF6 transmembrane +FIG01501538 Cdd1 protein +FIG01501545 putative molybdopterin oxidoreductase, membrane subunit +FIG01501546 FIG00499706: hypothetical protein +FIG01501552 FIG00644824: hypothetical protein +FIG01501557 prophage Kil protein +FIG01501562 FIG00458038: hypothetical protein +FIG01501587 CelA +FIG01501599 FIG00688832: hypothetical protein +FIG01501630 Putative large secreted protein +FIG01501653 2,5-didehydrogluconate reductase( EC:1.1.1.274 ) +FIG01501673 conserved hypothetical protein, CF-44 family +FIG01501681 Cytosine-specific DNA methyltransferase (EC 2.1.1.37) +FIG01501683 NADH-dependent flavin dehydrogenase +FIG01501691 phage-related protein, putative +FIG01501736 Universal stress protein family, tandem domain +FIG01501740 Putative uncharacterized protein YtzB +FIG01501751 FIG00826889: hypothetical protein +FIG01501753 PROBABLE ANTIBIOTIC-TRANSPORT ATP-BINDING PROTEIN ABC TRANSPORTER +FIG01501788 putative ArsR-family regulator +FIG01501808 FIG00364790: hypothetical protein +FIG01501826 FIG00632524: hypothetical protein +FIG01501845 Hypothetical protein Cj0566 +FIG01501853 Oligosaccharyl transferase STT3 homolog +FIG01501855 Sensory transduction protein containing HD_GYP domain +FIG01501870 succinoglycan biosynthesis +FIG01501907 FIG01197990: hypothetical protein +FIG01501908 FIG00409403: hypothetical protein +FIG01501956 FIG00384973: hypothetical protein +FIG01501962 hypothetical protein +FIG01501985 Ap4A phosphorylase II +FIG01501997 FIG00750493: hypothetical protein +FIG01502000 Fucolectin tachylectin-4 pentraxin-1 +FIG01502012 hypothetical protein +FIG01502013 nucleotidyltransferase substrate binding protein, HI0074 family +FIG01502039 putative Protein of unknown function (DUF664) +FIG01502054 outer membrane cobalamin receptor protein +FIG01502056 COG2879: Uncharacterized small protein +FIG01502071 FIG00633044: hypothetical protein +FIG01502086 FIG00754667: hypothetical protein +FIG01502102 transposase for insertion sequence +FIG01502104 FIG01118583: hypothetical protein +FIG01502108 puromycin N-acetyltransferase, homolog +FIG01502110 putative ABC transporter (substrate-binding protein) +FIG01502122 FIG00768238: hypothetical protein +FIG01502124 FIG01069762: hypothetical protein +FIG01502142 hypothetical protein +FIG01502149 hypothetical protein( EC:3.4.21.- ) +FIG01502175 LpqM protein +FIG01502176 HTH-type transcriptional regulator skgA +FIG01502203 FIG01238052: hypothetical protein +FIG01502222 FIG00384882: hypothetical protein +FIG01502223 keratin associated protein +FIG01502227 FIG00766687: hypothetical protein +FIG01502254 FIG00582816: hypothetical protein +FIG01502270 Transposase ERLG_01310 +FIG01502275 Amino acid ABC transporter, periplasmic amino acid-binding protein +FIG01502278 FIG00472700: hypothetical protein +FIG01502280 FIG00414595: hypothetical protein +FIG01502310 Homolog of BLC protein +FIG01502312 Conserved membrane protein, possible 4-hydroxybenzoate octaprenyltranferase +FIG01502318 probable ECF sigma factor +FIG01502356 transcriptional regulator DUF24 family +FIG01502366 FIG00658180: hypothetical protein +FIG01502380 FIG00349523: hypothetical protein +FIG01502400 FIG00416192: hypothetical protein +FIG01502437 FIG00768882: hypothetical protein +FIG01502470 endonuclease/exonuclease/phosphatase +FIG01502488 Isrso8-transposase orfb protein +FIG01502490 FIG00353296: hypothetical protein +FIG01502527 Conserved protein/domain typically associated with flavoprotein oxygenases DIM6/NTAB family-like +FIG01502552 FIG00385546: hypothetical protein +FIG01502581 2-hydroxy-3-oxopropionate reductase +FIG01502586 COG1082: Sugar phosphate isomerases/epimerases +FIG01502618 protein of unknown function DUF419 +FIG01502682 transposase Tn3 +FIG01502703 Delta-lactam-biosynthetic de-N-acetylase +FIG01502722 uracil phosphoribosyltransferase +FIG01502724 probable ring-cleaving dioxygenase +FIG01502728 predicted alpha-L-rhamnosidase +FIG01502744 FIG00769468: hypothetical protein +FIG01502747 Abortive infection bacteriophage resistance protein +FIG01502752 FIG00750324: hypothetical protein +FIG01502755 ornithine carbamoyltransferase +FIG01502789 FIG00570594: hypothetical protein +FIG01502793 putative integrase prophage protein +FIG01502800 integrase/recombinase plasmid associated, putative +FIG01502811 FIG00385154: hypothetical protein +FIG01502818 probable histone H1-like protein +FIG01502829 hypothetical protein +FIG01502852 pentapeptide repeat domain protein +FIG01502879 FIG00811308: hypothetical protein +FIG01502904 Complete genome; segment 4/17 +FIG01502908 Probable L-proline 4-hydroxylase +FIG01502914 FIG00675159: hypothetical protein +FIG01502949 FIG00516469: hypothetical protein +FIG01502966 Protein of unknown function DUF892 +FIG01502994 3-oxoacyl-[acyl-carrier protein] synthase( EC:2.3.1.41 ) +FIG01502997 Putative glutathione S-transferase (EC 2.5.1.18) +FIG01503006 hypothetical protein Psyc020245 +FIG01503049 putative formate hydrogenlyase subunit 7 +FIG01503062 restriction enzyme BcgI alpha chain-like protein( EC:2.1.1.72 ) +FIG01503111 FIG00753762: hypothetical protein +FIG01503121 acetoacetyl CoA reductase [imported] (relatedtoshort-) +FIG01503124 FIG00405073: hypothetical protein +FIG01503150 FIG00344504: hypothetical protein +FIG01503160 putative polysaccharide ABC transporter, ATP-binding protein +FIG01503168 PixH protein +FIG01503175 FIG00877238: hypothetical protein +FIG01503241 FIG00387848: hypothetical protein +FIG01503248 FIG00423774: hypothetical protein +FIG01503259 aerotaxis receptor +FIG01503262 Pathogenicity island SaPIn1 +FIG01503270 Merozoite surface protein 3 alpha +FIG01503295 FIG00343956: hypothetical protein +FIG01503298 protein of unknown function UPF0227 +FIG01503322 SecD export membrane protein +FIG01503334 FIG00641712: hypothetical protein +FIG01503346 allophanate hydrolase( EC:3.5.1.54 ) +FIG01503364 Hypothetical protein, CF-22 family +FIG01503367 FIG00350457: hypothetical protein +FIG01503380 FIG00527047: hypothetical protein +FIG01503393 COG1020: Non-ribosomal peptide synthetase modules and related proteins +FIG01503418 N-carbamoyl-D-amino acid hydrolase (EC 3.5.1.77), putative +FIG01503444 degV family protein , putative +FIG01503476 Putative Gp2 +FIG01503497 cheU protein +FIG01503506 hypothetical protein +FIG01503548 hypothetical protein +FIG01503551 Threonyl-tRNA synthetase +FIG01503563 FIG00753574: hypothetical protein +FIG01503571 Phage excisionase +FIG01503586 keratin complex 1, acidic, gene 9 +FIG01503602 PaaX domain protein, C-terminal domain +FIG01503608 HicB family protein +FIG01503654 PAS:Response regulator receiver +FIG01503699 Integral membrane protein +FIG01503707 N-ethylammeline chlorohydrolase +FIG01503708 FIG00364508: hypothetical protein +FIG01503710 cell wall hydrolase/autolysin +FIG01503716 FIG01251566: hypothetical protein +FIG01503719 phage transcriptional activator-related protein +FIG01503729 DAG-kinase catalytic domain +FIG01503764 uncharacterized protein with a C-terminal OMP (outer membrane protein) domain +FIG01503786 hypothetical protein +FIG01503803 acetyltransferase-like +FIG01503811 CAIB-BAIF family family +FIG01503825 transposase, ISlxx1 +FIG01503835 FIG00347916: hypothetical protein +FIG01503843 VI polysaccharide biosynthesis protein VIPC/TVIE +FIG01503853 putative esterase/lipase YbfF +FIG01503860 PTS system, galactitol-specific IIB component( EC:2.7.1.69 ) +FIG01503874 hypothetical protein +FIG01503883 FIG01202382: hypothetical protein +FIG01503889 Cytidylate kinase +FIG01503906 Serine protease, V8 family +FIG01503910 Cyc1 protein +FIG01503941 Possible lipoprotein LppJ +FIG01503968 Replication gene A protein +FIG01503972 ABC-type MDR transporter, ATPase component +FIG01503977 FIG01070796: hypothetical protein +FIG01503978 FIG01116060: hypothetical protein +FIG01503983 hypothetical protein +FIG01503994 Protein recA (Recombinase A) [Contains: Mfl recA intein] (Fragment) +FIG01504006 possible MutT-like domain +FIG01504008 FIG00640686: hypothetical protein +FIG01504015 nogalonic acid methyl ester cyclase +FIG01504023 phage portal protein, SPP1 +FIG01504036 hypothetical protein +FIG01504043 type IIS restriction enzyme R protein (BCGIB) +FIG01504051 FIG01272121: hypothetical protein +FIG01504063 FIG01161051: hypothetical protein +FIG01504080 Bll7506 protein +FIG01504143 FIG00630635: hypothetical protein +FIG01504153 FIG00763414: hypothetical protein +FIG01504169 FIG00769361: hypothetical protein +FIG01504174 putative integrase/transposase +FIG01504177 putative ryanodine receptor +FIG01504186 Chain A, Crystal Structure Of A Mesophilic Xylanase A From Bacillus Subtilis 1a1 +FIG01504211 putative phage baseplate protein +FIG01504237 FIG00850301: hypothetical protein +FIG01504291 RNA modification enzyme, MiaB family +FIG01504294 FIG00623214: hypothetical protein +FIG01504300 Two-component system sensor protein +FIG01504312 FIG00624732: hypothetical protein +FIG01504325 Acetoin utilization protein +FIG01504330 FIG00640118: hypothetical protein +FIG01504363 COG family: ribosomal protein L11 +FIG01504375 FIG00416149: hypothetical protein +FIG01504379 hypothetical protein +FIG01504383 prophage pi3 protein 49 +FIG01504394 Degenerate transposase +FIG01504421 FIG00632653: hypothetical protein +FIG01504427 FIG00757079: hypothetical protein +FIG01504433 hypothetical protein +FIG01504436 Putative subunit of hydroxybenzoyl reductase +FIG01504439 FIG00745227: hypothetical protein +FIG01504470 hypothetical protein Francci3_0125 +FIG01504486 FIG00532167: hypothetical protein +FIG01504501 FIG00623627: hypothetical protein +FIG01504512 FIG00518185: hypothetical protein +FIG01504520 putative enzyme; Not classified +FIG01504539 YabP-like protein +FIG01504548 Putative siderophore receptor protein +FIG01504552 FIG00622812: hypothetical protein +FIG01504558 FIG01119243: hypothetical protein +FIG01504574 acyl-CoA dehydrogenase-like +FIG01504614 Uncharacterized protein fadG +FIG01504653 conserved hypothetical protein; possible membrane protein +FIG01504667 comE operon protein 1, putative +FIG01504705 4-alpha-L-fucosyltransferase (EC 2.4.1.-) +FIG01504729 putative hemolysin-like protein +FIG01504730 Zinc finger domain +FIG01504757 FIG01048133: hypothetical protein +FIG01504758 FIG00763100: hypothetical protein +FIG01504764 similar to Citrate synthase +FIG01504767 ABC-3 protein +FIG01504774 uncharacterized FlgJ-related protein +FIG01504778 FIG00361774: hypothetical protein +FIG01504808 methyltransferase, UbiE/COQ5 family +FIG01504832 choline/proline/glycine betaine ABC uptake transporter membrane-spanning protein +FIG01504871 RelB/StbD replicon stabilization protein (antitoxin to RelE/StbE) +FIG01504886 Trimethylamine-N-oxide reductase (Cytochrome c) (EC 1.7.2.3) +FIG01504902 Putative vimentin +FIG01504922 hypothetical protein +FIG01504939 FIG00388323: hypothetical protein +FIG01504970 putative halogenase( EC:3.8.1.1 ) +FIG01504984 putative low complexity hydrophilic protein +FIG01504986 putative HspC2 heat shock protein +FIG01505017 Vegetative cell wall protein gp1 precursor +FIG01505047 fimbrial biogenesis domain protein +FIG01505048 Tup1 like transcriptional repressor +FIG01505051 FIG00830798: hypothetical protein +FIG01505064 FIG00633241: hypothetical protein +FIG01505069 FIG00527662: hypothetical protein +FIG01505072 DNA-binding protein/cupin domain protein +FIG01505084 Deoxyribonuclease +FIG01505086 HIGH-AFFINITY BRANCHED-CHAIN AMINO ACID TRANSPORT SYSTEM PERMEASE PROTEIN LIVM / HIGH-AFFINITY BRANCHED-CHAIN AMINO ACID TRANSPORT ATP-BINDING PROTEIN LIVG +FIG01505119 Cephamycin export protein cmcT +FIG01505137 ABC transporter ATP-binding protein MJ0796 +FIG01505157 Terminal quinol oxidase, subunit, putative (doxD-like) +FIG01505165 FIG01046700: hypothetical protein +FIG01505168 Protein chain release factor A +FIG01505171 hypothetical protein +FIG01505174 FIG00341004: hypothetical protein +FIG01505175 Uncharacterized protein TM_0928 +FIG01505191 FIG00385664: hypothetical protein +FIG01505209 SHORT CHAIN DEHYDROGENASE +FIG01505217 TnpA transposase +FIG01505218 putative ABC-type sugar/spermidine/putrescine transport system ATPase component +FIG01505219 FIG00640443: hypothetical protein +FIG01505236 sigma-54 dependent DNA-binding response regulator, interruption-C +FIG01505239 FIG00243360: hypothetical protein +FIG01505252 FIG01228323: hypothetical protein +FIG01505259 ParA protein +FIG01505275 FIG00769949: hypothetical protein +FIG01505284 FIG00623367: hypothetical protein +FIG01505289 FIG01251228: hypothetical protein +FIG01505290 UPF0291 protein BCE_3725 +FIG01505309 Phage integrase , site-specific tyrosine recombinase +FIG01505330 phospholipase C +FIG01505381 Iron(III) ABC transporter periplasmic iron-binding protein +FIG01505383 FIG00821025: hypothetical protein +FIG01505457 FIG00344771: hypothetical protein +FIG01505481 YwpJ +FIG01505517 FIG00533922: hypothetical protein +FIG01505520 BH3008 unknown conserved protein +FIG01505539 Phage EaE protein +FIG01505570 Aegerolysin Aa-Pri1 precursor +FIG01505625 FIG00557980: hypothetical protein +FIG01505653 YolD-like protein +FIG01505666 hypothetical cytosolic protein +FIG01505669 generated by GeneMarkS +FIG01505694 FIG01115328: hypothetical protein +FIG01505716 FIG00624599: hypothetical protein +FIG01505721 FIG00569107: hypothetical protein +FIG01505731 FIG00770050: hypothetical protein +FIG01505746 hypothetical protein +FIG01505759 FIG01236012: hypothetical protein +FIG01505769 putative ABC-type uncharacterized transport system, permease component +FIG01505770 FIG00762756: hypothetical protein +FIG01505780 hypothetical protein +FIG01505784 FIG00765779: hypothetical protein +FIG01505786 Transposase IS630 family +FIG01505788 COG0527: Aspartokinases +FIG01505792 Heavy metal translocating P-type ATPase +FIG01505793 Transposase for transposon Tn1546 +FIG01505808 PLP-dependent aminotransferase, +FIG01505813 PERIPLASMIC IMMUNOGENIC PROTEIN +FIG01505823 FIG00632254: hypothetical protein +FIG01505836 FIG00407850: hypothetical protein +FIG01505857 homoserine/homoserine lactone efflux protein +FIG01505935 FIG00385703: hypothetical protein +FIG01505942 Phosphonoacetaldehyde hydrolase +FIG01505949 diaminopimelate epimerase +FIG01505969 FIG00665232: hypothetical protein +FIG01505979 NA+/H+ ANTIPORTER +FIG01505982 FIG00405850: hypothetical protein +FIG01505984 FIG00379801: hypothetical protein +FIG01505988 FIG00675675: hypothetical protein +FIG01505992 protein of unknown function DUF690 +FIG01505996 FIG01165966: hypothetical protein +FIG01506012 Bll4271 protein +FIG01506046 IS1193, transposase, ISL3 family +FIG01506051 hypothetical protein +FIG01506053 FIG00348129: hypothetical protein +FIG01506071 FIG00425297: hypothetical protein +FIG01506076 DNA mismatch repair protein [MutS] +FIG01506121 FIG00883467: hypothetical protein +FIG01506166 FIG00521033: hypothetical protein +FIG01506168 type II DNA modification methyltransferase +FIG01506185 FIG00762516: hypothetical protein +FIG01506187 FIG00624628: hypothetical protein +FIG01506203 RbsD or FucU transport +FIG01506213 FIG00833915: hypothetical protein +FIG01506231 beta 2 toxin +FIG01506235 glycerol dehyrdratase activator +FIG01506255 YhhN family protein +FIG01506288 Tungsten-containing aldehyde ferredoxin oxidoreductase cofactor-modifying protein +FIG01506324 FIG00388269: hypothetical protein +FIG01506336 FIG00405357: hypothetical protein +FIG01506352 FIG01214463: hypothetical protein +FIG01506361 FIG00734079: hypothetical protein +FIG01506362 syc1358_d +FIG01506366 COG0318: Acyl-CoA synthetases (AMP-forming)/AMP-acid ligases II +FIG01506367 phage terminase, small subunit, putative +FIG01506369 Dipeptidyl aminopeptidases/acylaminoacyl-peptidase-like protein +FIG01506374 FIG01069958: hypothetical protein +FIG01506379 FIG00632492: hypothetical protein +FIG01506401 hypothetical protein +FIG01506454 Predicted CoA-binding protein +FIG01506461 Succinoglycan biosynthesis transport protein exoT +FIG01506478 acetyl transferase +FIG01506487 hypothetical protein +FIG01506499 GTP-binding protein, HSR1-related +FIG01506522 conserved hypothetical protein-putative phosphohydrolase +FIG01506527 putative acetyl transferase +FIG01506530 Copper export protein +FIG01506547 Spore germination protein-like +FIG01506558 sigma-B-controlled gene +FIG01506590 Secreted protein containing SH3 domain homolog +FIG01506604 probable glucosyltransferase +FIG01506626 Spo0A homolog +FIG01506631 FIG00426365: hypothetical protein +FIG01506657 FIG00417995: hypothetical protein +FIG01506711 PpiC-type peptidyl-prolyl cis-trans isomerase +FIG01506712 TnpA +FIG01506721 transposase +FIG01506732 FIG00688262: hypothetical protein +FIG01506734 Squalene/phytoene synthase +FIG01506779 hypothetical protein +FIG01506787 FIG00767519: hypothetical protein +FIG01506788 FIG00362372: hypothetical protein +FIG01506825 Acetyl xylan esterase +FIG01506830 Guanine-specific ribonuclease N1 and T1 precursor +FIG01506849 FIG01115552: hypothetical protein +FIG01506857 putative ECF-type sigma factor +FIG01506891 Na+/H+ antiporter NapA +FIG01506924 Proline dehydrogenase +FIG01506958 vitamin K epoxide reductase family/thioredoxin domain protein +FIG01506966 oxidoreductase, short-chain dehydrogenase/reductase family +FIG01506990 Mll0473 protein +FIG01506992 FIG00622917: hypothetical protein +FIG01506999 resolvase-like protein +FIG01507000 FIG00414546: hypothetical protein +FIG01507018 ABC transporter ATP-binding protein +FIG01507029 Glycoside hydrolase, family 1 +FIG01507042 FIG00350269: hypothetical protein +FIG01507053 putative amino acid amidase +FIG01507067 Glutathione-dependent formaldehyde dehydrogenase (EC 1.2.1.1) +FIG01507077 rrf2 family protein +FIG01507115 Orf-232 +FIG01507144 FIG01116969: hypothetical protein +FIG01507149 hypothetical protein +FIG01507163 Multi-drug-type permease +FIG01507164 FIG01055240: hypothetical protein +FIG01507165 Multidrug-efflux transporter related protein +FIG01507167 two-component system sensor protein +FIG01507171 FIG00469085: hypothetical protein +FIG01507177 InterPro IPR000179 COGs COG1423 +FIG01507222 Uncharacterized protein TP_0869 +FIG01507244 probable short chain oxidoreductase +FIG01507254 putative cation efflux system protein czcB +FIG01507260 FIG00767077: hypothetical protein +FIG01507279 Cof protein:HAD-superfamily hydrolase subfamily IIB +FIG01507289 FIG00537295: hypothetical protein +FIG01507291 Fatty acid desaturase precursor +FIG01507295 FIG00343875: hypothetical protein +FIG01507306 FIG01049483: hypothetical protein +FIG01507321 FIG00765084: hypothetical protein +FIG01507332 FIG00895478: hypothetical protein +FIG01507337 peptidoglycan binding domain protein +FIG01507345 Amino acid ABC transporter ATP-binding protein +FIG01507363 Vng2582h +FIG01507366 heat shock protein HslJ +FIG01507367 triacyl glycerol lipase( EC:3.1.1.3 ) +FIG01507377 probable metal-binding protein +FIG01507407 C4-type zinc finger protein, DksA/TraR family protein +FIG01507464 FIG00352953: hypothetical protein +FIG01507465 27.5 kDa virulence protein +FIG01507476 FIG00732118: hypothetical protein +FIG01507486 AbrB-like transcriptional regulator +FIG01507487 FIG01094042: hypothetical protein +FIG01507490 FIG00389720: hypothetical protein +FIG01507491 putative surface antigen BspA +FIG01507522 FIG01165486: hypothetical protein +FIG01507523 Putative ABC transport system solute-binding secreted protein +FIG01507524 FIG00244619: hypothetical protein +FIG01507532 SCP-like extracellular +FIG01507541 Orf97 +FIG01507564 FIG00698532: hypothetical protein +FIG01507566 FIG00838607: hypothetical protein +FIG01507567 Putative maturase-related protein +FIG01507595 FIG00405909: hypothetical protein +FIG01507623 FIG00623051: hypothetical protein +FIG01507646 FIG00352334: hypothetical protein +FIG01507665 ISBma2, transposase +FIG01507678 FIG00817485: hypothetical protein +FIG01507680 FIG00525750: hypothetical protein +FIG01507720 FIG00642971: hypothetical protein +FIG01507728 FIG00404218: hypothetical protein +FIG01507747 FIG01170632: hypothetical protein +FIG01507749 FIG00850606: hypothetical protein +FIG01507763 Type II DNA modification enzyme (Modification methylase) (Cytosine-specific methyltransferase) +FIG01507767 FIG00343797: hypothetical protein +FIG01507777 Oleate hydratase (EC 4.2.1.53) +FIG01507799 TcdD +FIG01507829 putative MbtH family protein +FIG01507846 Uncharacterized protein YaiN in in formaldehyde detoxification operon +FIG01507859 FIG00850729: hypothetical protein +FIG01507863 FIG01049668: hypothetical protein +FIG01507864 FIG00859666: hypothetical protein +FIG01507885 HspR +FIG01507913 FIG00630168: hypothetical protein +FIG01507918 ORF_ID:all8003 unknown protein +FIG01507923 Iron (III)-transport system permease HitB +FIG01507930 FIG00409799: hypothetical protein +FIG01507933 FIG01120517: hypothetical protein +FIG01507940 putative secreted tripeptidyl aminopeptidase +FIG01507949 pyridoxine kinase +FIG01507950 GPW/gp25 +FIG01507979 possible MFS family transporter +FIG01507992 lambda repressor-like DNA-binding protein +FIG01508017 NADH-FMN oxidoreductase +FIG01508037 putative hyaluronidase +FIG01508044 acyl-CoA dehydrogenase( EC:1.3.99.- ) +FIG01508051 Nitrilotriacetate monooxygenase component A +FIG01508076 Rhs element Vgr protein +FIG01508079 FIG01016622: hypothetical protein +FIG01508080 FIG00389624: hypothetical protein +FIG01508086 FIG00424464: hypothetical protein +FIG01508104 Subtilisin-like serine protease +FIG01508118 Carboxypeptidase G2 +FIG01508119 FIG00424090: hypothetical protein +FIG01508137 FIG027385: Putative type III secretion apparatus +FIG01508151 FIG00624642: hypothetical protein +FIG01508178 Zinc metallopeptidases +FIG01508179 membrane bound his kinase A +FIG01508197 Lysine-specific permease +FIG01508215 FIG00387839: hypothetical protein +FIG01508216 hexapeptide transferase family protein +FIG01508230 FIG00672614: hypothetical protein +FIG01508244 Large subunit terminase +FIG01508280 probable nitrilotriacetate monooxygenase, component A +FIG01508283 FIG00563914: hypothetical protein +FIG01508285 Polysaccharide biosynthesis glycosyl transferase CpsN +FIG01508299 gas vesicle protein W +FIG01508308 glutamine amidotransferase (GATase1) +FIG01508337 Toxin coregulated pilus biosynthesis protein I +FIG01508343 FIG00659177: hypothetical protein +FIG01508365 Type II restriction-modification system restriction subunit( EC:3.1.24.1 ) +FIG01508374 Phage integrase precursor +FIG01508383 Long-chain fatty-acid-CoA ligase (EC 6.2.1.3), Mycobacterial subgroup FadD16 +FIG01508388 Regulator of nonsense transcripts 1 homolog +FIG01508390 FIG01165759: hypothetical protein +FIG01508397 predicted Fe-S protein +FIG01508410 colicin V secretion protein +FIG01508439 Menaquinone-specific polyprenyl reductase +FIG01508447 FIG00623244: hypothetical protein +FIG01508453 FIG00628387: hypothetical protein +FIG01508461 Rhodanese-related sulfurtransferase +FIG01508465 FIG00845319: hypothetical protein +FIG01508476 putative outer membrane protein, probably involved in nutrient binding +FIG01508479 hypothetical 16 Kd protein; partially homologous to Y4jB and Y4rG +FIG01508502 FIG00525403: hypothetical protein +FIG01508507 Rhodopirellula transposase +FIG01508514 FIG00742910: hypothetical protein +FIG01508515 exotoxin A precursor +FIG01508537 FIG00628740: hypothetical protein +FIG01508538 glycosyltransferase family 2 protein +FIG01508572 transposase, IS605 OrfB family +FIG01508590 conserved hypothetical protein Msm_1285 +FIG01508596 bll5683; probable serine/threonine phosphatase +FIG01508617 Glyceraldehyde-3-phosphate dehydrogenase, putative +FIG01508618 FIG00954436: hypothetical protein +FIG01508621 FIG00404245: hypothetical protein +FIG01508623 transcriptional regulator OruR, AraC family +FIG01508681 FIG01226381: hypothetical protein +FIG01508683 FIG00385759: hypothetical protein +FIG01508714 FIG00348764: hypothetical protein +FIG01508716 FIG00430960: hypothetical protein +FIG01508727 FIG00814683: hypothetical protein +FIG01508729 phosphoglycerate mutase( EC:5.4.2.1 ) +FIG01508777 gamma-butyrolactone biosynthesis protein +FIG01508787 Hydrolase, nudix family protein +FIG01508802 FIG00348641: hypothetical protein +FIG01508805 FIG00348234: hypothetical protein +FIG01508808 hypothetical protein NMA1077 +FIG01508823 Putative peptide synthetase +FIG01508840 FIG00385004: hypothetical protein +FIG01508841 Aminoglycoside 3'-phosphotransferase (EC 2.7.1.95) (Kanamycin kinase, type V) (Neomycin-kanamycin phosphotransferase type V) (APH(3')V) +FIG01508869 Biotin carboxylase +FIG01508870 FIG00405135: hypothetical protein +FIG01508881 hypothetical protein +FIG01508893 alkylhydroperoxidase AhpD core +FIG01508902 putative glucose transferase +FIG01508919 FIG00390289: hypothetical protein +FIG01508923 FIG00432044: hypothetical protein +FIG01508947 FIG00822244: hypothetical protein +FIG01508951 glycine betaine/L-proline transport, ATP-binding protein +FIG01508996 Virulence associated transcriptional regulator hudR (PA0253) +FIG01509007 ORF_ID:all7662 unknown protein +FIG01509021 FIG00847398: hypothetical protein +FIG01509038 FIG00361475: hypothetical protein +FIG01509087 FIG00416710: hypothetical protein +FIG01509102 Excinuclease ABC, C subunit-like protein +FIG01509112 Transcriptional regulator, pbsX family +FIG01509132 hypothetical protein +FIG01509134 Sensor histidine kinase/response regulator LuxN +FIG01509173 filament integrity protein +FIG01509179 FIG01118454: hypothetical protein +FIG01509216 FIG00631723: hypothetical protein +FIG01509256 putative DNA-binding protein +FIG01509283 FIG01047976: hypothetical protein +FIG01509308 glutamate transport ATP-binding protein GluA +FIG01509311 FIG00756200: hypothetical protein +FIG01509321 FIG00696636: hypothetical protein +FIG01509326 FIG01227691: hypothetical protein +FIG01509331 FIG00765926: hypothetical protein +FIG01509348 similar to ATPases +FIG01509355 Conjugal transfer protein trbB +FIG01509367 FIG00353701: hypothetical protein +FIG01509370 Cytochrome c-L precursor (Cytochrome c551I) (Cytochrome c552) +FIG01509387 putative MucR family transcriptional regulatory protein +FIG01509394 anti-sigma-factor antagonist +FIG01509397 Probable transcriptional regulatory protein sgaR +FIG01509411 peptidase, S8A (subtilisin) family( EC:3.4.21.- ) +FIG01509428 putative DNA glycosylase (DNA repair protein) +FIG01509429 Archaeal histone +FIG01509461 frnE protein +FIG01509466 FIG00816926: hypothetical protein +FIG01509470 FIG00549624: hypothetical protein +FIG01509477 teichoic acid glycosylation protein, putative +FIG01509481 FIG00769862: hypothetical protein +FIG01509498 probable phage tail protein +FIG01509510 uncharacterized conserved protein, IL-2 family +FIG01509534 hypothetical protein +FIG01509537 Pyoverdine biosynthesis regulatory gene SyrP-like +FIG01509540 Asl4482 protein +FIG01509574 FIG00713459: hypothetical protein +FIG01509588 FIG00763415: hypothetical protein +FIG01509615 FIG00628392: hypothetical protein +FIG01509646 DeoR family transcriptional regulator +FIG01509648 putative stabilisation protein +FIG01509652 entericidin B-like bacteriolytic toxin +FIG01509665 hypothetical protein +FIG01509690 FIG00696359: hypothetical protein +FIG01509708 FIG01201049: hypothetical protein +FIG01509717 Transposase for insertion sequence element IS21-like +FIG01509736 taurine transport system permease protein +FIG01509746 Amine oxidase, flavin-containing (EC 1.4.3.4) +FIG01509751 FIG01200240: hypothetical protein +FIG01509760 FIG00623034: hypothetical protein +FIG01509766 FIG01228385: hypothetical protein +FIG01509798 syc2432_d +FIG01509825 FIG00407631: hypothetical protein +FIG01509832 FIG00745608: hypothetical protein +FIG01509835 Ydi +FIG01509866 Protein of unknown function DUF2523 +FIG01509891 FIG00518350: hypothetical protein +FIG01509898 ORF_ID:all7680 unknown protein +FIG01509911 FIG00624251: hypothetical protein +FIG01509916 FIG00767510: hypothetical protein +FIG01509942 SOS operon TUM protein +FIG01509957 FIG00343965: hypothetical protein +FIG01509964 ISONIAZID INDUCTIBLE GENE PROTEIN INIA +FIG01509970 putative D-tagatose 3-epimerase +FIG01509991 UPF0145 protein BT_3410 +FIG01510008 pertactin precursor +FIG01510017 FIG00624590: hypothetical protein +FIG01510025 FIG00766590: hypothetical protein +FIG01510046 Phage lysin, N-acetylmuramoyl-L-alanine amidase +FIG01510051 FIG01044932: hypothetical protein +FIG01510059 hypothetical protein +FIG01510061 FIG00631317: hypothetical protein +FIG01510081 Possible sugar kinase (EC 2.7.-.-) +FIG01510091 FIG00733305: hypothetical protein +FIG01510127 hypothetical WASP N-WASP MENA proteins +FIG01510136 FIG00354088: hypothetical protein +FIG01510145 FIG00410044: hypothetical protein +FIG01510150 FIG00640038: hypothetical protein +FIG01510174 putative ISXo8 transposase +FIG01510176 FIG00344250: hypothetical protein +FIG01510226 FIG01229521: hypothetical protein +FIG01510251 FIG00762752: hypothetical protein +FIG01510259 ROK-family transcriptional regulator +FIG01510287 hypothetical protein +FIG01510316 50S ribosomal protein L4 +FIG01510341 ISSpo6, transposase orf A +FIG01510386 Carbohydrate-selective porin, OprB family superfamily +FIG01510388 FIG01150183: hypothetical protein +FIG01510405 Kynurenine formamidase (EC 3.5.1.9) homolog +FIG01510410 FIG00767362: hypothetical protein +FIG01510470 FIG00388937: hypothetical protein +FIG01510475 FIG00847660: hypothetical protein +FIG01510477 Conserved domain protein +FIG01510488 Cell surface antigen Sca3 +FIG01510494 FIG01229373: hypothetical protein +FIG01510501 fosmidomycin resistance protein, putative +FIG01510518 FIG00817825: hypothetical protein +FIG01510540 D-aminoacylase-like protein( EC:3.5.1.81 ) +FIG01510571 Putative monooxygenase (EC 1.14.13.-) +FIG01510578 FIG00345008: hypothetical protein +FIG01510585 putative secreted serine protease +FIG01510601 TetR family transcriptional regulator? +FIG01510627 FIG00384984: hypothetical protein +FIG01510662 FIG00387948: hypothetical protein +FIG01510705 Uncharacterized protein in hlv 5'region +FIG01510707 COG2755: Lysophospholipase L1 and related esterases +FIG01510720 Photopigment and puc expression activator, putative +FIG01510784 Phage lysin, 1,4-beta-N-acetylmuramidase +FIG01510797 FIG00341077: hypothetical protein +FIG01510799 FIG00978512: hypothetical protein +FIG01510808 putative thiol-disulfide isomerase +FIG01510825 FIG00425387: hypothetical protein +FIG01510840 FIG00403584: hypothetical protein +FIG01510841 FIG00361776: hypothetical protein +FIG01510844 Purine NTPase +FIG01510859 anthrone oxygenase +FIG01510881 hypothetical protein +FIG01510883 FIG00877281: hypothetical protein +FIG01510887 Polysaccharide deacetylase in N-acetylglucoamine utilization gene cluster +FIG01510892 probable sensor kinase +FIG01510912 FIG00388140: hypothetical protein +FIG01510925 possible protocatechuate dioxygenase +FIG01510944 delta-6 desaturase( EC:1.14.19.3 ) +FIG01510948 related to glycosyltransferase +FIG01510962 Permease protein of ABC transporter +FIG01510977 putative transcriptional activator srcap homolog +FIG01510999 putative partition-related protein +FIG01511062 FIG00410214: hypothetical protein +FIG01511068 IS3-family transposase, OrfB +FIG01511114 FIG00521382: hypothetical protein +FIG01511118 two-component system sensor histidine kinase/response regulator, hybrid ('one component system') +FIG01511122 FIG00514303: hypothetical protein +FIG01511129 FIG00468798: hypothetical protein +FIG01511137 FIG00520178: hypothetical protein +FIG01511175 FIG01109972: hypothetical protein +FIG01511177 BEC protein +FIG01511187 acetylornithine aminotransferase +FIG01511203 FIG00898863: hypothetical protein +FIG01511229 FIG00687338: hypothetical protein +FIG01511243 FIG01092483: hypothetical protein +FIG01511253 minor pilin subunit PapH +FIG01511264 superoxide dismutase [Fe-Zn] 1 (FeSOD I)( EC:1.15.1.1 ) +FIG01511295 FIG00521738: hypothetical protein +FIG01511299 FIG00763446: hypothetical protein +FIG01511302 FIG00623177: hypothetical protein +FIG01511317 1,3-propanediol dehydrogenase (EC 1.1.1.202) +FIG01511324 putative pirin-related protein +FIG01511340 transposase, degenerate +FIG01511356 protein gp13 +FIG01511383 Secreted repeat of unknown function +FIG01511396 COG family: predicted phosphohydrolases +FIG01511413 FIG00468557: hypothetical protein +FIG01511432 FIG00664783: hypothetical protein +FIG01511434 Epidermin biosynthesis protein epiC +FIG01511442 FIG00355995: hypothetical protein +FIG01511475 Middle cell wall protein precursor (MWP) +FIG01511526 FIG00410281: hypothetical protein +FIG01511530 FIG01230600: hypothetical protein +FIG01511534 histone-like nucleoid-structuring protein H-NS +FIG01511536 FIG00766761: hypothetical protein +FIG01511538 FIG00824579: hypothetical protein +FIG01511566 Type IV fimbrial biogenesis protein FimT +FIG01511571 putative macrolide O-acyltransferase +FIG01511577 FIG00385221: hypothetical protein +FIG01511601 FIG01027288: hypothetical protein +FIG01511631 ortholog of Bordetella pertussis (BX470248) BP3545 +FIG01511639 hypothetical protein, lipoprotein? +FIG01511653 conserved hypothetical protein with rhodanese-like domain +FIG01511656 Mu-like prophage I protein, putative +FIG01511658 titin +FIG01511672 subunit of oxygen-sensitive 2-hydroxyisocaproyl-CoA dehydratase +FIG01511712 FIG01230783: hypothetical protein +FIG01511716 Periplasmic phosphoanhydride phosphohydrolase +FIG01511719 FIG00830864: hypothetical protein +FIG01511721 NAD-dependent protein deacetylases, SIR2 family +FIG01511724 IMP dehydrogenase subunit +FIG01511740 ORF_ID:alr7540 unknown protein +FIG01511781 Menaquinone biosynthesis methyltransferase +FIG01511813 transglutaminase family protein +FIG01511816 prophage LambdaBa04, DNA packaging protein +FIG01511852 short-chain alcohol dehydrogenase +FIG01511872 FIG00666688: hypothetical protein +FIG01511898 Colicin E3 (EC 3.1.-.-) +FIG01511937 LtrC protein +FIG01511946 FIG00755660: hypothetical protein +FIG01511951 major surface protein 1a-like protein 3 +FIG01511955 transcriptional regulator, MarR family +FIG01511957 Two-component response regulator yvqC +FIG01511970 Putative cytoplasmic protein +FIG01511972 phenazine biosynthesis protein, PhzF family +FIG01511979 FIG00409341: hypothetical protein +FIG01511994 SSU ribosomal protein S3p (S3e) +FIG01512004 FIG00388611: hypothetical protein +FIG01512013 FIG00424677: hypothetical protein +FIG01512038 FIG00848246: hypothetical protein +FIG01512039 hypothetical protein +FIG01512088 FIG00403263: hypothetical protein +FIG01512104 hypothetical phage protein +FIG01512122 FIG00407157: hypothetical protein +FIG01512137 FIG00523319: hypothetical protein +FIG01512150 Peptidase S58, DmpA +FIG01512171 MoxJ protein +FIG01512173 FIG00464907: hypothetical protein +FIG01512175 secreted hydrolase( EC:3.2.1.39 ) +FIG01512189 IS231-related transposase +FIG01512193 Mobile element protein +FIG01512240 D-nopaline dehydrogenase (EC 1.5.1.19) +FIG01512246 Possible ABC transporter, ATP binding protein +FIG01512285 FIG00403604: hypothetical protein +FIG01512288 FIG00416381: hypothetical protein +FIG01512294 hypothetical protein +FIG01512341 FIG00748228: hypothetical protein +FIG01512362 putative S-layer protein +FIG01512364 FIG00389934: hypothetical protein +FIG01512401 FIG01242304: hypothetical protein +FIG01512414 FIG00389248: hypothetical protein +FIG01512415 Uncharacterized protein aq_914 +FIG01512420 Phage lysozyme (EC 3.2.1.17) +FIG01512428 Phage regulatory Com-like protein, containing Zn-finger +FIG01512430 heavy metal binding protein +FIG01512468 histidyl-tRNA synthetase( EC:6.1.1.21 ) +FIG01512477 Ribose/xylose/arabinose/galactoside ABC-type transport systems, substrate-binding component +FIG01512518 FIG01202646: hypothetical protein +FIG01512521 FIG00385805: hypothetical protein +FIG01512525 oxidoreductase family protein +FIG01512526 ortholog of Bordetella pertussis (BX470248) BP3013 +FIG01512557 Transporter, EamA family +FIG01512566 FIG00518700: hypothetical protein +FIG01512585 prophage Lp2 protein 3 +FIG01512599 1-Acyl-sn-glycerol-3-phosphate acyltransferase( EC:2.3.1.51 ) +FIG01512633 porin signal peptide protein +FIG01512635 FIG00410384: hypothetical protein +FIG01512644 FIG01259249: hypothetical protein +FIG01512649 DNA polymerase III delta subunit +FIG01512657 FIG00990791: hypothetical protein +FIG01512695 FIG00770018: hypothetical protein +FIG01512696 hypothetical protein +FIG01512741 FIG00639649: hypothetical protein +FIG01512775 Sll0783 protein +FIG01512801 Purine catabolism PurC-like protein +FIG01512817 FIG00846986: hypothetical protein +FIG01512848 hypothetical protein +FIG01512927 spidroin 1 +FIG01512930 TrbP protein +FIG01512940 FIG00766859: hypothetical protein +FIG01512963 FIG00348559: hypothetical protein +FIG01512970 putative acetyl esterase +FIG01512981 Fe-S cluster assembly protein NifU +FIG01512986 FIG00456599: hypothetical protein +FIG01512989 Acyl-CoA dehydrogenase (EC 1.3.8.7) +FIG01512998 FIG01165543: hypothetical protein +FIG01513010 FIG00965783: hypothetical protein +FIG01513012 FIG00524767: hypothetical protein +FIG01513019 FIG01232042: hypothetical protein +FIG01513022 proposed amino acid ligase found clustered with an amidotransferase / Putative amidotransferase similar to cobyric acid synthase +FIG01513073 FIG01119320: hypothetical protein +FIG01513079 Integrase +FIG01513083 3,4-dihydroxy-2-butanone 4-phosphate synthase (EC 4.1.99.12) / GTP cyclohydrolase II +FIG01513087 5-methylcytosine-specific restriction enzyme A (EC 3.1.21.-) +FIG01513143 FIG00411348: hypothetical protein +FIG01513148 hypothetical bacteriophage protein +FIG01513196 FIG01055254: hypothetical protein +FIG01513201 putative transcriptional regulator, MarR family +FIG01513212 Predicted secretion system W transmembrane protein 1 +FIG01513215 allergen V5/TPX-1 related +FIG01513227 FIG00402774: hypothetical protein +FIG01513313 FIG00750359: hypothetical protein +FIG01513342 FIG00950150: hypothetical protein +FIG01513352 PAAR motif family protein +FIG01513360 StbA protein +FIG01513373 Uncharacterized protein aq_2172 precursor +FIG01513401 FIG00388874: hypothetical protein +FIG01513456 FIG00624548: hypothetical protein +FIG01513469 6-aminohexanoate-dimer hydrolase (EC 3.5.1.46) +FIG01513475 AQUAPORIN-LIKE TRANSPORT PROTEIN +FIG01513483 uncharacterized phage-encoded protein +FIG01513506 transposase, IS3 +FIG01513513 sec-independent translocation protein mttA/Hcf106 +FIG01513529 COG3121: P pilus assembly protein, chaperone PapD +FIG01513541 C4-dicarboxylate transporter (mae1) +FIG01513546 FIG00413271: hypothetical protein +FIG01513581 FIG01281286: hypothetical protein +FIG01513599 Probable serine/threonine-protein kinase pknA (EC 2.7.11.1) +FIG01513603 Uncharacterized protein MJ1638 +FIG01513607 Protein of unknown function DUF1345 +FIG01513608 YvdP +FIG01513613 YchA +FIG01513633 Sensor histidine kinase with PAS/PAC and response regulator receiver domains (EC 2.7.3.-) +FIG01513649 COG0454: Histone acetyltransferase HPA2 and related acetyltransferases +FIG01513655 FIG00348631: hypothetical protein +FIG01513718 FIG00780407: hypothetical protein +FIG01513731 Glyoxylate reductase (EC 1.1.1.26) +FIG01513740 FIG00388502: hypothetical protein +FIG01513746 FIG00946315: hypothetical protein +FIG01513783 FIG00944972: hypothetical protein +FIG01513806 3',5'-cyclic-nucleotide phosphodiesterase +FIG01513843 possible transposase +FIG01513851 phage terminase, small subunit, putative, P27 +FIG01513857 Ser/Thr protein phosphatase family +FIG01513859 FIG00413453: hypothetical protein +FIG01513899 alpha-2-macroglobulin domain protein +FIG01513923 glycine cleavage H-protein +FIG01513938 FIG00769674: hypothetical protein +FIG01513974 glycosyltransferase family 4 +FIG01513992 adenylate cyclase +FIG01514008 FIG00352446: hypothetical protein +FIG01514010 S-layer-related protein precursor +FIG01514026 ribosomal RNA methyltransferase +FIG01514043 FIG00385074: hypothetical protein +FIG01514050 hypothetical protein +FIG01514084 peptidase M14 carboxypeptidase A +FIG01514126 FIG00516799: hypothetical protein +FIG01514127 chloramphenicol 3-O phosphotransferase +FIG01514145 Oxygen-insensitive NAD(P)H nitroreductase (EC 1.-.-.-) / Dihydropteridine reductase (EC 1.6.99.7) +FIG01514177 Transporter, permease +FIG01514195 FIG00410426: hypothetical protein +FIG01514236 FIG00624383: hypothetical protein +FIG01514252 Endoglucanase A precursor (EC 3.2.1.4) (Endo-1,4-beta-glucanase) (Cellulase A) (EG-A) +FIG01514269 Probable integral membrane transmembrane protein +FIG01514284 putative porin for benzoate transport (BenP) +FIG01514294 Possible Cytochrome C biogenesis protein trans +FIG01514339 FIG00850369: hypothetical protein +FIG01514350 Sodium Bile acid symporter family +FIG01514352 Multimeric flavodoxin WrbA family protein, diverged or disrupted +FIG01514354 hypothetical protein +FIG01514366 Eukaryotic homologs including metalloproteinase, bone morphogenetic protein, and alveolin +FIG01514395 TonB-dependent receptor, homolog 3 +FIG01514431 FIG00521047: hypothetical protein +FIG01514436 FIG00781922: hypothetical protein +FIG01514490 Sulfotransferase:TPR repeat +FIG01514508 FIG00623142: hypothetical protein +FIG01514513 dual specificity protein phosphatase +FIG01514536 ortholog of Bordetella pertussis (BX470248) BP3497 +FIG01514542 FIG00528406: hypothetical protein +FIG01514546 FIG00426400: hypothetical protein +FIG01514553 putative carbamoyl-phosphate-synthetase +FIG01514557 putative TetR family receptor protein +FIG01514572 Integrase/recombinase (XerC/CodV family) +FIG01514602 Subtilisin-like serine proteases-like +FIG01514613 2-hydroxy-3-keto-5-methylthiopentenyl-1-phosphate phosphatase related protein +FIG01514630 FIG00462759: hypothetical protein +FIG01514651 Adenylate kinase +FIG01514684 hypothetical protein +FIG01514688 DUF2225 domain-containing protein +FIG01514691 RNA polymerase sigma-70 factor, ECF subfamily protein +FIG01514693 FIG00426033: hypothetical protein +FIG01514712 hypothetical protein +FIG01514724 Predicted permease PerM family +FIG01514744 alcohol dehydrogenase, zinc-containing +FIG01514758 3'(2'),5'-bisphosphate nucleotidase +FIG01514784 probable NADPH--hemoprotein reductase( EC:1.6.2.4 ) +FIG01514787 FIG00624679: hypothetical protein +FIG01514792 mucin-associated surface protein (MASP) +FIG01514809 FIG01127905: hypothetical protein +FIG01514814 Transthyretin-like protein +FIG01514838 FIG00362183: hypothetical protein +FIG01514839 FIG01166258: hypothetical protein +FIG01514849 Predicted phosphatase/phosphohexomutase +FIG01514852 Bsl0098 protein +FIG01514863 Ribonuclease Z( EC:3.1.26.11 ) +FIG01514877 branched-chain amino acid transport system permease protein +FIG01514880 FIG00356266: hypothetical protein +FIG01514882 Amino acid ABC transporter permease +FIG01514898 FIG00721771: hypothetical protein +FIG01514914 Molybdopterin-guanine dinucleotide biosynthesis protein MobB / FeS domain +FIG01514961 FIG00849503: hypothetical protein +FIG01514980 RNA polymerase, sigma 70 subunit, RpoD family +FIG01515015 endopeptidase-related protein +FIG01515017 CDP-diglyceride synthetase +FIG01515038 Growth inhibitor +FIG01515045 FIG00385297: hypothetical protein +FIG01515049 AIDA autotransporter-like protein +FIG01515060 FIG00829942: hypothetical protein +FIG01515097 FIG00769241: hypothetical protein +FIG01515114 FIG01132222: hypothetical protein +FIG01515120 FIG00349570: hypothetical protein +FIG01515149 PAAR domain protein +FIG01515165 VirC1 protein promotes T-DNA transfer, ParA/MinD-like +FIG01515170 Arc-like DNA-binding protein +FIG01515177 transcriptional control; transcription +FIG01515183 xenobiotic reductase B +FIG01515185 3-hydroxyisobutyrate dehydrogenase +FIG01515187 alpha-2-HS-glycoprotein +FIG01515203 Mll2898 protein +FIG01515219 InterPro IPR004923 COGs COG0672 +FIG01515239 4-aminobutyrate transaminase( EC:2.6.1.19 ) +FIG01515244 Uncharacterized protein conserved in bacteria, NMA0228-like +FIG01515263 FIG00342571: hypothetical protein +FIG01515280 protein of unknown function DUF849 +FIG01515286 Colicin immunity protein/pyocin immunity protein +FIG01515296 FIG00767710: hypothetical protein +FIG01515322 FIG00632378: hypothetical protein +FIG01515327 Inter-alpha-trypsin inhibitor heavy chain H3 precursor +FIG01515329 probable zinc-binding alcohol dehydrogenase +FIG01515365 Nodulation protein L +FIG01515423 FIG01126940: hypothetical protein +FIG01515497 phage shock protein A +FIG01515518 FIG00524797: hypothetical protein +FIG01515538 FIG00825332: hypothetical protein +FIG01515547 FIG00641019: hypothetical protein +FIG01515554 FIG01234207: hypothetical protein +FIG01515580 FIG01220709: hypothetical protein +FIG01515586 Cell surface glycoprotein 1 precursor +FIG01515620 FIG00642740: hypothetical protein +FIG01515622 calcium-binding protein, putative +FIG01515623 FIG00764163: hypothetical protein +FIG01515642 Histone H1-like protein HC2 +FIG01515663 B. burgdorferi predicted coding region BBA65 +FIG01515664 Succinic semialdehyde dehydrogenase (EC 1.2.1.16) +FIG01515667 FIG00415062: hypothetical protein +FIG01515685 FIG00526162: hypothetical protein +FIG01515688 probable NhaP-type Na(+)/H(+) exchanger +FIG01515697 Unknown, probable export and assembly of type 1 fimbriae +FIG01515727 Major facilitator superfamily protein +FIG01515732 CalR2 protein +FIG01515775 Virulence-associated protein 2 +FIG01515793 Modification methylase, putative( EC:2.1.1.37 ) +FIG01515800 Probable manganese catalase (EC 1.11.1.6) +FIG01515801 FIG00521604: hypothetical protein +FIG01515823 nitrogen assimilation control protein +FIG01515838 FIG01200517: hypothetical protein +FIG01515858 FIG00388562: hypothetical protein +FIG01515877 FIG00403772: hypothetical protein +FIG01515883 FIG00643128: hypothetical protein +FIG01515894 Cell filamentation protein +FIG01515907 O antigen polymerase +FIG01515910 host-nuclease inhibitor protein Gam, putative +FIG01515932 protein crcB homolog 2 +FIG01515951 FIG00623720: hypothetical protein +FIG01515956 FIG00385650: hypothetical protein +FIG01515966 xylanase +FIG01515972 3-methyladenine DNA glycosylase +FIG01516039 FIG00964377: hypothetical protein +FIG01516077 FIG00353223: hypothetical protein +FIG01516090 FIG00385196: hypothetical protein +FIG01516105 Transposase IS4 family +FIG01516133 FIG00769490: hypothetical protein +FIG01516146 FIG01081881: hypothetical protein +FIG01516201 Dipeptide transport permease +FIG01516202 cro +FIG01516207 putative D-alanyl carrier protein +FIG01516239 Protein containing ChW-repeats and cell-adhesion domain +FIG01516259 putative ClpX protein +FIG01516270 pyochelin synthetase( EC:6.3.2.- ) +FIG01516296 agmatinase, putative +FIG01516308 FIG00528788: hypothetical protein +FIG01516345 major facilitator transporter +FIG01516373 saccharopine dehydrogenase +FIG01516376 FIG00756898: hypothetical protein +FIG01516383 FIG00380701: hypothetical protein +FIG01516390 hypothetical conserved membrane spanning protein +FIG01516398 FIG00570065: hypothetical protein +FIG01516402 Transcriptional regulator, TetR family precursor +FIG01516411 rpsU-divergently transcribed protein +FIG01516427 FIG00364228: hypothetical protein +FIG01516456 Zinc-regulated outer membrane porin +FIG01516472 Glyoxalase/bleomycin resistance protein/dioxygenase +FIG01516494 Polyketide synthase +FIG01516501 syc1277_c +FIG01516559 FIG00874340: hypothetical protein +FIG01516573 Virulence-associated protein and related proteins +FIG01516581 NanA gene +FIG01516603 uncharacterized conserved secreted or membrane protein +FIG01516608 conserved hypothetical rhodanese-domain protein +FIG01516610 FIG00407111: hypothetical protein +FIG01516620 InterPro IPR000104:IPR003660:IPR004089 COGs COG0840 +FIG01516641 FIG00388528: hypothetical protein +FIG01516654 FIG00385146: hypothetical protein +FIG01516660 hypothetical protein +FIG01516685 Putative cytoplasmic protein +FIG01516693 probable phospholipase C-beta-2 +FIG01516701 D,D-heptose 1,7-bisphosphate phosphatase (EC 3.1.3.-) (D-glycero-D-manno-heptose 1,7-bisphosphate phosphatase) +FIG01516718 ATP dependent DNA ligase +FIG01516719 ORF_ID:asl7677 unknown protein +FIG01516733 FIG00622800: hypothetical protein +FIG01516736 TcsBorf2 +FIG01516780 type III secretion apparatus protein, YscI/HrpB family +FIG01516794 FIG00387261: hypothetical protein +FIG01516798 FIG00520802: hypothetical protein +FIG01516816 Carboxylesterase/phospholipase +FIG01516828 GAF domain/HD domain protein +FIG01516839 FIG00879885: hypothetical protein +FIG01516842 FIG00945479: hypothetical protein +FIG01516858 25 KDA OUTER-MEMBRANE IMMUNOGENIC PROTEIN PRECURSOR +FIG01516882 FIG00468230: hypothetical protein +FIG01516883 putative transcription regulator (MarR family) +FIG01516886 Uncharacterized protein aq_1088 +FIG01516917 hemolysin secretion protein B +FIG01516918 CinA-related protein +FIG01516933 FIG00450862: hypothetical protein +FIG01516951 FIG00348861: hypothetical protein +FIG01516953 Xylanase, glycosyl hydrolase family 10 +FIG01516966 Biotin carboxylase-like +FIG01516992 ribosome-binding factor A +FIG01517037 phage tail sheath protein +FIG01517060 alcohol dehydrogenase (zinc-binding) +FIG01517084 FIG01119452: hypothetical protein +FIG01517109 Conserved hypothetical protein, Fic protein family +FIG01517123 FIG00613368: hypothetical protein +FIG01517138 FIG00765259: hypothetical protein +FIG01517148 FIG00352554: hypothetical protein +FIG01517153 FIG01097640: hypothetical protein +FIG01517169 similar to acyl-CoA thioesterase I( EC:3.1.2.- ) +FIG01517194 Water Stress and Hypersensitive response domain protein +FIG01517219 N-hydroxyarylamine O-acetyltransferase +FIG01517263 hypothetical protein +FIG01517268 FIG00349646: hypothetical protein +FIG01517295 FIG01002363: hypothetical protein +FIG01517308 uncharacterized protein-like protein +FIG01517328 FIG00407853: hypothetical protein +FIG01517345 FIG00256590: hypothetical protein +FIG01517356 FIG00352831: hypothetical protein +FIG01517371 archaeal ATPase +FIG01517376 FIG00403410: hypothetical protein +FIG01517378 Probable sigma-70 factor, ECF subfamily +FIG01517390 FIG01190364: hypothetical protein +FIG01517416 probable two-component regulatory protein +FIG01517424 FIG00631359: hypothetical protein +FIG01517436 Methyl-accepting chemotaxis sensory transducer precursor +FIG01517447 FIG00389721: hypothetical protein +FIG01517515 hypothetical protein +FIG01517543 FIG00380090: hypothetical protein +FIG01517577 protein export protein, putative +FIG01517594 Spermidine N1-acetyltransferase +FIG01517611 FIG00641088: hypothetical protein +FIG01517638 NADH:flavin oxidoreductase, Old Yellow Enzyme family +FIG01517641 FIG00354376: hypothetical protein +FIG01517645 contains maoC-like domain +FIG01517680 uncharacterized Fe-S protein +FIG01517684 cytosolic long-chain acyl-CoA thioester hydrolase family protein +FIG01517686 protein of unknown function DUF347 +FIG01517717 Putative branched-chain amino acid transporter ATP-binding protein +FIG01517723 FIG00519257: hypothetical protein +FIG01517764 auxin-responsive GH3 protein homolog, putative +FIG01517778 Uncharacterized protein, related to enterotoxins of other Clostridiales +FIG01517810 FIG00713409: hypothetical protein +FIG01517820 FIG01020471: hypothetical protein +FIG01517830 FIG00351950: hypothetical protein +FIG01517835 FIG172205: hypothetical protein +FIG01517864 C-terminal part of two-component system sensor histidine kinase/response regulator hybrid +FIG01517897 FIG00434290: hypothetical protein +FIG01517908 lipoprotein, putative +FIG01517910 aminopeptidase +FIG01517958 aspartate/glutamate/uridylate kinase-like protein +FIG01518065 FIG00764210: hypothetical protein +FIG01518083 DNA-binding response regulator, LytTr family +FIG01518091 Phage DNA and RNA binding protein +FIG01518094 hypothetical protein +FIG01518156 FIG00517866: hypothetical protein +FIG01518188 FIG01054629: hypothetical protein +FIG01518214 putative PrgN protein +FIG01518225 O-acetyl transferase +FIG01518242 transcriptional activator of adhA-yraA and yraC +FIG01518254 FIG00530908: hypothetical protein +FIG01518255 hypothetical protein +FIG01518264 possible membrane protein; possible peptidase, M23/M37 family +FIG01518276 hypothetical Immunity protein +FIG01518328 ADP-ribosylglycohydrolase-like +FIG01518331 FIG00341015: hypothetical protein +FIG01518364 FIG00811418: hypothetical protein +FIG01518369 FIG01128530: hypothetical protein +FIG01518384 tryptophan halogenase +FIG01518387 Rhodanese-like family protein +FIG01518396 FIG00468620: hypothetical protein +FIG01518404 Elongator protein 3/MiaB/NifB +FIG01518420 Asr4498 protein +FIG01518439 FIG00733815: hypothetical protein +FIG01518446 Transcriptional activator protein irlR +FIG01518447 FIG00531078: hypothetical protein +FIG01518466 FIG00388866: hypothetical protein +FIG01518473 CHAP domain protein +FIG01518503 putative transcriptional regulator, ArsR family +FIG01518507 outer membrane insertion signal domain protein +FIG01518510 FIG00768997: hypothetical protein +FIG01518517 blr1246; unknown protein +FIG01518520 probable two-component sensor histidine kinase +FIG01518525 FIG00525508: hypothetical protein +FIG01518568 TnpR resolvase C-terminal fragment +FIG01518574 FIG00348795: hypothetical protein +FIG01518581 FIG00404373: hypothetical protein +FIG01518583 Nodulation protein n +FIG01518584 Phosphoglycerol transferase and related proteins,alkaline phosphatase superfamily +FIG01518630 ABC-type Mn/Zn transport systems, ATPase component +FIG01518644 competence transcription factor +FIG01518652 FIG00385172: hypothetical protein +FIG01518669 Amino acid/polyamine transporter +FIG01518698 probable autolytic lysozyme +FIG01518703 FIG00407501: hypothetical protein +FIG01518723 FIG00414836: hypothetical protein +FIG01518744 Modification methylase CviBIII (EC 2.1.1.72) (Adenine-specific methyltransferase CviBIII) (M.CviBIII) +FIG01518746 Probable transcription regulator +FIG01518806 7-beta-(4-carbaxybutanamido)cephalosporanic acid acylase +FIG01518807 FIG00361380: hypothetical protein +FIG01518819 FIG00734290: hypothetical protein +FIG01518856 Beta 1,4-mannosyltransferase bre-3 (EC 2.4.1.-) (Bt toxin-resistant protein 3) +FIG01518912 FIG00523113: hypothetical protein +FIG01518977 L-fucose kinase (EC 2.7.1.52) +FIG01519026 FIG01109631: hypothetical protein +FIG01519030 FIG01245438: hypothetical protein +FIG01519053 FIG00351805: hypothetical protein +FIG01519058 FIG00409736: hypothetical protein +FIG01519065 conserved hypothetical protein, putative outer membrane protein +FIG01519078 FIG00519865: hypothetical protein +FIG01519090 Orotate phosphoribosyltransferase +FIG01519098 Uncharacterized protein MJ0658 +FIG01519106 FIG01109023: hypothetical protein +FIG01519113 FIG00733391: hypothetical protein +FIG01519123 CAAX amino terminal protease family protein, +FIG01519124 PTS system, trehalose-specific IIBC component (EC 2.7.1.69) +FIG01519153 Periplasmic aromatic aldehyde oxidoreductase, molybdenum binding subunit YagR +FIG01519168 FIG00361505: hypothetical protein +FIG01519203 Streptococcal superantigen A (SSA) +FIG01519209 Putative transport protein +FIG01519229 DNA-directed RNA polymerase, beta' subunit/160 kD subunit +FIG01519234 FIG00412337: hypothetical protein +FIG01519237 Sensory transduction protein +FIG01519274 FIG00765131: hypothetical protein +FIG01519286 FIG01057005: hypothetical protein +FIG01519302 Putative bacteriophage tail protein +FIG01519314 Membrane protein containing C-terminal PDZ domain +FIG01519322 FIG00815835: hypothetical protein +FIG01519323 FIG00353039: hypothetical protein +FIG01519339 FIG00768581: hypothetical protein +FIG01519342 FIG00913749: hypothetical protein +FIG01519352 FIG00410577: hypothetical protein +FIG01519370 blr3303; putative recemase +FIG01519405 ISPsy6, transposase +FIG01519406 Xaa-Pro dipeptidase (Proline dipeptidase) (EC 3.4.13.9) +FIG01519407 possible Early Protein (E6) +FIG01519434 probable glutathione S-transferase +FIG01519444 Mobile element protein +FIG01519459 P-hydroxyphenylacetate hydroxylase C2:oxygenase component +FIG01519472 phage recombination protein Bet +FIG01519486 FIG01243848: hypothetical protein +FIG01519488 putative ErfK/YbiS/YcfS/YnhG family protein +FIG01519499 monocarboxylate MFS permease +FIG01519503 FIG00537399: hypothetical protein +FIG01519527 Putative Histidine ammonia-lyase (EC 4.3.1.3); Putative Allantokinase +FIG01519540 Slr1918 protein +FIG01519543 SWI/SNF family helicase +FIG01519567 moxR-like ATPase +FIG01519635 COG1821 family protein +FIG01519641 putative cinnamoyl-CoA reductase +FIG01519648 FIG00848548: hypothetical protein +FIG01519660 Phage protein +FIG01519693 FIG00931781: hypothetical protein +FIG01519695 FIG00750832: hypothetical protein +FIG01519709 Cell surface lipoprotein MPT83 precursor +FIG01519772 FIG00410113: hypothetical protein +FIG01519804 FIG00849551: hypothetical protein +FIG01519807 FIG00817169: hypothetical protein +FIG01519832 Fic protein family +FIG01519835 FIG00624834: hypothetical protein +FIG01519850 FIG00470698: hypothetical protein +FIG01519889 FIG00418635: hypothetical protein +FIG01519892 putative patatin-like protein +FIG01519896 HIT-like protein +FIG01519904 FIG00380568: hypothetical protein +FIG01519981 FIG00404326: hypothetical protein +FIG01519984 Acetylxylan esterase, acyl-CoA esterase or GDSL lipase family, strong similarity to C-terminal region of endoglucanase E precursor +FIG01520004 FIG00768517: hypothetical protein +FIG01520005 integrase, phage family +FIG01520014 FIG01110712: hypothetical protein +FIG01520017 glycolate oxidase iron-sulfur subunit +FIG01520023 NLPA lipoprotein +FIG01520057 FIG00470699: hypothetical protein +FIG01520064 FIG00385715: hypothetical protein +FIG01520073 Metalloproteinase domain +FIG01520076 Beta-glucosidase/6-phospho-beta-glucosidase/beta- galactosidase +FIG01520097 hypothetical protein +FIG01520134 FIG00965950: hypothetical protein +FIG01520160 FIG00629131: hypothetical protein +FIG01520187 FIG00468775: hypothetical protein +FIG01520207 FIG00769559: hypothetical protein +FIG01520227 zinc ABC transporter, permease protein +FIG01520228 Methylmalonyl-CoA decarboxylase, delta-subunit (EC 4.1.1.41) +FIG01520253 two-component sensor kinase +FIG01520277 methyltransferase, ubiE/COQ5 family +FIG01520291 Peptidoglycan-binding domain 1 protein +FIG01520296 Transcriptional regulator, ArsR +FIG01520298 FIG00471148: hypothetical protein +FIG01520341 DNA-damage-inducible protein d +FIG01520342 conserved hypothetical protein, putative surface protein +FIG01520347 Molybdenum cofactor biosynthesis domain protein +FIG01520357 Sll1274 protein +FIG01520363 Protease sohB +FIG01520392 FIG00350060: hypothetical protein +FIG01520402 FadE17 protein (PROBABLE ACYL-COA DEHYDROGENASE FADE17) (EC 1.3.99.-) +FIG01520403 FIG00623162: hypothetical protein +FIG01520423 Uncharacterized protein MJ0418 +FIG01520424 P-hydroxybenzaldehyde dehydrogenase +FIG01520449 FIG01237752: hypothetical protein +FIG01520476 Oxidoreductase, 2OG-Fe(II) oxygenase family +FIG01520482 VlmB +FIG01520485 FIG01125088: hypothetical protein +FIG01520499 FIG00414056: hypothetical protein +FIG01520502 FIG01078107: hypothetical protein +FIG01520506 NifT/FixU +FIG01520509 FIG00404400: hypothetical protein +FIG01520537 FIG01095752: hypothetical protein +FIG01520538 FIG00390948: hypothetical protein +FIG01520539 Uncharacterized protein YpeP +FIG01520546 FIG00824340: hypothetical protein +FIG01520552 FIG00352843: hypothetical protein +FIG01520576 FIG00352849: hypothetical protein +FIG01520588 Putative cytoplasmic protein +FIG01520593 Hypothetical protein Cj0417 +FIG01520614 FIG00623702: hypothetical protein +FIG01520615 FIG00406542: hypothetical protein +FIG01520624 FIG00453648: hypothetical protein +FIG01520639 Protein ycgK precursor +FIG01520663 Protease IV( EC:3.4.- ) +FIG01520688 putative GnaT-family acetyltransferase +FIG01520694 conserved protein +FIG01520706 maturation protein +FIG01520713 FIG00529947: hypothetical protein +FIG01520715 FIG00414729: hypothetical protein +FIG01520719 FIG00415902: hypothetical protein +FIG01520720 two-component response regulator, citrate/malate, C-terminus +FIG01520744 FIG00520926: hypothetical protein +FIG01520750 Thioesterase( EC:3.1.2.- ) +FIG01520754 FIG00385143: hypothetical protein +FIG01520759 protein of unknown function DUF1023 +FIG01520788 FIG00765401: hypothetical protein +FIG01520818 ABO glycosyltransferase +FIG01520827 zinc-metalloprotease( EC:3.4.24.- ) +FIG01520874 COF family HAD hydrolase protein +FIG01520892 Membrane associated methyl-accepting chemotaxis protein with HAMP domain +FIG01520928 rhodanese-like domain/cysteine-rich domain protein +FIG01520931 Oxidoreductase FAD/NAD(P)-binding (EC 1.18.1.3) +FIG01520939 Endothelin-converting enzyme 1 precursor (EC 3.4.24.71) +FIG01520943 FIG00630291: hypothetical protein +FIG01520944 FIG00531367: hypothetical protein +FIG01520953 addiction module toxin +FIG01520957 Bifidobacterial FemAB-like protein type 3 +FIG01520980 FIG00348846: hypothetical protein +FIG01520982 CcrB +FIG01520985 FIG00899089: hypothetical protein +FIG01520996 Protein of unknown function DUF350 +FIG01520999 FIG00643154: hypothetical protein +FIG01521003 syc1737_d +FIG01521016 Sporulation integral membrane protein YtvI +FIG01521036 FIG00645100: hypothetical protein +FIG01521056 Sll1318 protein +FIG01521064 Late competence protein comEC, DNA transport +FIG01521082 beta-1,4-galactosyltransferase +FIG01521114 FIG00534088: hypothetical protein +FIG01521139 CoB--CoM-reducing hydrogenase (Cys) gamma subunit +FIG01521152 Regulatory protein, DeoR +FIG01521163 Plasmid maintenance system antidote protein +FIG01521176 FIG00640849: hypothetical protein +FIG01521221 FIG00385229: hypothetical protein +FIG01521238 FIG00623055: hypothetical protein +FIG01521262 FIG00630840: hypothetical protein +FIG01521340 FIG00424946: hypothetical protein +FIG01521353 posssible DNA-binding protein +FIG01521357 PROBABLE ACETYL-CoA ACETYLTRANSFERASE FADA5 (ACETOACETYL-CoA THIOLASE) (EC 2.3.1.9) +FIG01521372 FIG00530960: hypothetical protein +FIG01521397 protein of unknown function DUF62 +FIG01521399 FIG00406077: hypothetical protein +FIG01521437 FIG00353279: hypothetical protein +FIG01521449 FIG00450359: hypothetical protein +FIG01521484 IscA-like protein, DsrR +FIG01521505 Transcriptional Regulator, AraC family protein +FIG01521509 Fatty acid hydroxylase FAH1P, putative +FIG01521520 Type I restriction-modification system restriction subunit (EC 3.1.21.3) +FIG01521539 FIG00961347: hypothetical protein +FIG01521547 YobA +FIG01521557 FIG01205358: hypothetical protein +FIG01521584 FIG01093232: hypothetical protein +FIG01521597 FIG00544549: hypothetical protein +FIG01521605 CDS_ID OB0427 +FIG01521623 putative glycerophosphatase +FIG01521627 Alcohol dehydrogenase (EC 1.1.1.1) +FIG01521637 Hydride transferase 1 +FIG01521661 Mll6598 protein +FIG01521675 General secretion pathway protein A; P-loop containing NTP Hydrolase; Type II secretory pathway, component ExeA (predicted ATPase) +FIG01521695 Metal-dependent phosphohydrolase, HD subdomain:Hpt +FIG01521717 uncharacterized protein homolog YKRK B. subtilis +FIG01521759 MATE efflux family protein DinF, truncated +FIG01521768 ORF_ID:tll1487 hypothetical protein +FIG01521774 UvrD/Rep helicase family protein +FIG01521789 glycoside hydrolase, family 3 domain protein +FIG01521793 FIG01068347: hypothetical protein +FIG01521800 transposase, IS4 +FIG01521824 putative RNA polymerase ECF-type sigma factor +FIG01521844 excinuclease ABC subunit A +FIG01521854 Hemolysin, putative +FIG01521858 YrkR-like protein +FIG01521863 Hypothetical protein +FIG01521868 orf113 +FIG01521881 FIG00711673: hypothetical protein +FIG01521891 putative dienelactone hydrolase and related enzymes +FIG01521942 DUF54 conserved in archaea +FIG01521984 Acetyl-CoA acetyltransferase-like protein +FIG01521996 phospholipase C +FIG01522003 FIG00765479: hypothetical protein +FIG01522009 Halogenase PrnC +FIG01522011 Predicted hydrolase or acyltransferase PA1621 +FIG01522014 FIG00580411: hypothetical protein +FIG01522052 FIG01059409: hypothetical protein +FIG01522073 Omt +FIG01522087 FIG00532241: hypothetical protein +FIG01522089 phage glycoprotein +FIG01522090 Putative peptidoglycan bound protein (LPXTG motif) Lmo1799 homolog +FIG01522094 phage-related minor tail protein +FIG01522100 FIG00622927: hypothetical protein +FIG01522104 FIG00794862: hypothetical protein +FIG01522128 ABC transporter, efflux permease protein +FIG01522134 FIG00953611: hypothetical protein +FIG01522140 unknown, without homologous in databases +FIG01522158 Translation initiation factor 1 (IF-1) +FIG01522165 oligopeptide ABC transporter (oligopeptide-binding protein) +FIG01522257 phage-tail assembly-like protein +FIG01522278 FIG00513859: hypothetical protein +FIG01522310 FIG01048776: hypothetical protein +FIG01522311 FIG00388891: hypothetical protein +FIG01522321 FIG01069599: hypothetical protein +FIG01522322 conserved hypothetical regulator protein +FIG01522376 probable acyl-CoA dehydrogenase +FIG01522381 FIG00763974: hypothetical protein +FIG01522398 FIG00733236: hypothetical protein +FIG01522456 Pectin degradation protein KdgF +FIG01522462 yecA family protein +FIG01522470 putative LysR-family regulatory protein +FIG01522483 FIG00763352: hypothetical protein +FIG01522503 FIG00457151: hypothetical protein +FIG01522504 FIG00956635: hypothetical protein +FIG01522514 FIG00689819: hypothetical protein +FIG01522515 bacteriocin-type signal domain protein +FIG01522527 FIG00417517: hypothetical protein +FIG01522563 putative type III chaperone +FIG01522577 Probable 1-acyl-sn-glycerol-3-phosphate acyltransferase transmembrane protein (EC 2.3.1.51) +FIG01522591 FIG00763543: hypothetical protein +FIG01522604 FIG00849493: hypothetical protein +FIG01522660 FIG00538160: hypothetical protein +FIG01522666 sucrose synthase +FIG01522672 FIG00389379: hypothetical protein +FIG01522724 similar to Signal transduction histidine kinase +FIG01522732 PemK +FIG01522736 outer membrane efflux protein, putative +FIG01522742 hypothetical protein +FIG01522756 transmembrane protein affecting septum formation and cell membrane permeability +FIG01522768 FIG00410658: hypothetical protein +FIG01522778 FIG00471428: hypothetical protein +FIG01522795 FIG00384995: hypothetical protein +FIG01522811 Glu-tRNAGln amidotransferase A subunit +FIG01522827 Uncharacterized protein aq_545 +FIG01522865 FIG00350190: hypothetical protein +FIG01522902 GAF/GGDEF domain protein +FIG01522928 FIG00847560: hypothetical protein +FIG01522951 cell surface protein (putative) +FIG01522953 CHP03435 domain-containing protein +FIG01522967 Peptidase C45, acyl-coenzyme A:6-aminopenicillanic acid acyl-transferase +FIG01522969 UPF0179 protein MJ1627 +FIG01522992 FIG00350608: hypothetical protein +FIG01523035 Bll6692 protein +FIG01523037 FOG: LysM repeat +FIG01523062 FIG00352046: hypothetical protein +FIG01523078 hypothetical protein +FIG01523081 FIG00622980: hypothetical protein +FIG01523097 Fibrillin +FIG01523143 Stage II sporulation protein R +FIG01523155 Mlr3822 protein +FIG01523207 FIG00623592: hypothetical protein +FIG01523248 FIG00765849: hypothetical protein +FIG01523249 ABC-type nitrate/sulfonate/bicarbonate transport systems periplasmic components-like +FIG01523252 mbtG +FIG01523283 phage family integrase +FIG01523328 FIG00425487: hypothetical protein +FIG01523333 FIG01022842: hypothetical protein +FIG01523369 Histidine kinase-like ATPase +FIG01523420 FIG00352811: hypothetical protein +FIG01523423 Possible phage integrase family +FIG01523431 FIG00931065: hypothetical protein +FIG01523437 recombination protein U +FIG01523460 helix-turn-helix motif +FIG01523461 Immunogenic protein MPB70 precursor +FIG01523481 FIG00518539: hypothetical protein +FIG01523485 FIG00356002: hypothetical protein +FIG01523513 Zinc-dependent alcohol dehydrogenases +FIG01523549 FIG00350321: hypothetical protein +FIG01523605 FIG01118145: hypothetical protein +FIG01523624 FIG00847483: hypothetical protein +FIG01523632 CcdB-like toxin protein +FIG01523646 FIG01114810: hypothetical protein +FIG01523650 Type II restriction enzyme HgiCI (EC 3.1.21.4) (Endonuclease HgiCI) (R.HgiCI) +FIG01523659 probable electron transfer flavoprotein +FIG01523687 FIG00763711: hypothetical protein +FIG01523698 AttT protein +FIG01523710 Site-specific DNA-methyltransferase (adenine-specific)( EC:2.1.1.72 ) +FIG01523744 Lin2574 protein +FIG01523756 FIG00562703: hypothetical protein +FIG01523759 CCAAT-box DNA binding protein subunit B +FIG01523767 probable phosphoglycolate phosphatase +FIG01523833 ISCps8, transposase +FIG01523853 FIG00632067: hypothetical protein +FIG01523860 FIG01202308: hypothetical protein +FIG01523864 hypothetical protein Npun02002808 +FIG01523869 transcriptional regulator, winged helix family +FIG01523873 Beta-1,3-glucanase C +FIG01523876 FIG01077094: hypothetical protein +FIG01523896 phage and prophage; structural proteins +FIG01523904 molybdopterin-binding oxidoreductase +FIG01523914 Transcriptional regulator, LysR family protein +FIG01523926 toxin resistance protein +FIG01523940 FIG01109277: hypothetical protein +FIG01523956 FIG00361563: hypothetical protein +FIG01523978 ABC-type nitrate/sulfonate/bicarbonate transport systems, periplasmic component +FIG01524003 heme-hemopexin utilization protein C +FIG01524015 ATP12 ATPase +FIG01524024 FIG00855176: hypothetical protein +FIG01524078 outer membrane porin F precursor +FIG01524109 HIGH-AFFINITY BRANCHED-CHAIN AMINO ACID TRANSPORT SYSTEM PERMEASE PROTEIN LIVM / HIGH-AFFINITY BRANCHED-CHAIN AMINO ACID TRANSPORT ATP-BINDING PROTEIN LIVG +FIG01524112 Mer P, periplasmic mercuric ion binding protein +FIG01524130 beta strand repeat-containing protein +FIG01524144 membrane-anchored protein +FIG01524146 Flagellar basal-body rod protein flgF +FIG01524196 similar to hexosyltransferase +FIG01524236 FIG01248366: hypothetical protein +FIG01524252 COG2363 +FIG01524276 Secreted TPR repeats containing protein +FIG01524279 Oleate hydratase (EC 4.2.1.53) +FIG01524281 Possible kynurenine formamidase +FIG01524297 pseudo transposase +FIG01524319 Polyvinyl-alcohol dehydrogenase, PQQ-dependent (EC 1.1.99.23) +FIG01524344 FIG00521594: hypothetical protein +FIG01524345 DNA-formamidopyrimidine glycosylase( EC:3.2.2.23 ) +FIG01524356 Outer membrane lipoprotein precursor +FIG01524373 Unknown, putative toxin +FIG01524390 Xis-Tn protein +FIG01524398 SIS domain protein +FIG01524400 FIG00354148: hypothetical protein +FIG01524414 pyridoxal-phosphate dependent enzyme +FIG01524418 Chemotaxis protein CheA (EC 2.7.3.-) +FIG01524422 Sll1132 protein +FIG01524436 intracellular signaling protein (PAS,GAF,GGDEF domains) +FIG01524462 2-methylcitrate dehydratase( EC:4.2.1.79 ) +FIG01524486 FIG00407539: hypothetical protein +FIG01524493 similar to lipoprotein +FIG01524517 FIG00519620: hypothetical protein +FIG01524524 FIG00385184: hypothetical protein +FIG01524532 disulfide isomerase/thiol-disulfide oxidase +FIG01524566 putative binding protein +FIG01524568 FIG00746596: hypothetical protein +FIG01524591 FIG00488346: hypothetical protein +FIG01524593 FIG00406864: hypothetical protein +FIG01524651 similar to Acyl-CoA synthetase (AMP-forming)/AMP-acid ligase II +FIG01524668 probable polyketide cyclase +FIG01524671 Phosphotransferase family protein +FIG01524682 AstB/chuR/nirj-related protein +FIG01524685 FIG00592809: hypothetical protein +FIG01524689 TchA +FIG01524704 virulence-associated protein VapG3 +FIG01524758 FIG00964155: hypothetical protein +FIG01524769 Autotransporter adhesin +FIG01524849 actinorhodin polyketide dimerase +FIG01524870 FIG00663179: hypothetical protein +FIG01524874 peptidase M20D, amidohydrolase( EC:3.5.1.32 ) +FIG01524893 FIG00755653: hypothetical protein +FIG01524901 FIG00522446: hypothetical protein +FIG01524920 Cell wall lytic activity +FIG01524942 FIG01217497: hypothetical protein +FIG01524956 FIG01049284: hypothetical protein +FIG01524980 FIG00684819: hypothetical protein +FIG01524983 FIG00426416: hypothetical protein +FIG01525007 ORF265 +FIG01525047 FIG00350808: hypothetical protein +FIG01525087 N-ethylammeline chlorohydrolase +FIG01525120 FIG00351020: hypothetical protein +FIG01525131 Asl3923 protein +FIG01525216 Nitrite reductase (Cytochrome C) , conjectural +FIG01525235 Rieske (2Fe-2S) protein +FIG01525255 FIG00836550: hypothetical protein +FIG01525259 LuxR family transcriptional regulatory protein +FIG01525260 YVMC +FIG01525272 hypothetical protein YpbB +FIG01525300 Mll4935 protein +FIG01525331 2-polyprenyl-6-methoxyphenol hydroxylase and related FAD-dependent oxidoreductases +FIG01525337 FIG014461: putative endonuclease containing a URI domain +FIG01525338 Glycosyl transferase family protein +FIG01525342 FIG00643217: hypothetical protein +FIG01525348 FIG00384910: hypothetical protein +FIG01525363 Na+ ABC transporter (ATP-binding protein) +FIG01525398 FIG00384890: hypothetical protein +FIG01525401 FIG01047708: hypothetical protein +FIG01525407 Uncharacterized protein ydcS +FIG01525420 FIG00514070: hypothetical protein +FIG01525424 amino acid transporter protein +FIG01525443 Pseudoazurin +FIG01525471 FIG00817575: hypothetical protein +FIG01525562 FIG00816432: hypothetical protein +FIG01525564 hypothetical protein +FIG01525575 FIG00522274: hypothetical protein +FIG01525577 FIG00411624: hypothetical protein +FIG01525587 Phage encoded transcriptional regulator, ArpU family +FIG01525595 conserved hypothetical GTP-binding protein +FIG01525609 phage head-tail adaptor, putative +FIG01525615 FIG00348541: hypothetical protein +FIG01525638 sugar specific permease +FIG01525645 Dolichyl-phosphate-mannose-protein mannosyltransferase family +FIG01525662 phage major tail tube protein, putative +FIG01525695 FIG00530256: hypothetical protein +FIG01525699 FIG00623331: hypothetical protein +FIG01525701 hypothetical protein +FIG01525702 Colicin E6 immunity protein +FIG01525739 FIG01291992: hypothetical protein +FIG01525747 FIG00344257: hypothetical protein +FIG01525764 conserved hypothetical protein-putative membrane bound transporter +FIG01525776 Uncharacterized membrane protein, homolog of YNGA/YWCD B.suntilis +FIG01525783 FIG00562300: hypothetical protein +FIG01525803 similar to sp:LSPA_STACA LIPOPROTEIN SIGNAL PEPTIDASE (EC 3.4.23.36) (PROLIPOPROTEIN SIGNAL PEPTIDASE) (SIGNAL PEPTIDASE II) (SPASE II) from Staphylococcus carnosus (159 aa); 23.4% identity in 145 aa overlap. Putative N-terminal signal sequence and 5 putative transmembrane regions were found by PSORT. +FIG01525861 tetrapyrrole methylase family protein +FIG01525913 FIG00767769: hypothetical protein +FIG01525914 putative Dyp-type peroxidase family protein +FIG01525919 FIG00963137: hypothetical protein +FIG01525923 Long chain fatty acid transport protein +FIG01525942 hypothetical protein +FIG01525953 FIG00388407: hypothetical protein +FIG01525963 ferredoxin subunits of nitrite reductase and ring-hydroxylating dioxygenase +FIG01525967 FIG01047218: hypothetical protein +FIG01525997 FIG00426159: hypothetical protein +FIG01526013 FIG00618085: hypothetical protein +FIG01526051 FIG00764287: hypothetical protein +FIG01526052 Type II restriction endonuclease +FIG01526081 FIG00402663: hypothetical protein +FIG01526108 Type V secretory pathway, adhesin protein +FIG01526124 drug sensory protein A +FIG01526125 FIG00943198: hypothetical protein +FIG01526160 Sensory transduction histidine kinase (EC 2.7.3.-) +FIG01526170 Phage protein +FIG01526177 Rhodanese domain protein / Ankyrin +FIG01526195 flagellin FlaG, putative +FIG01526206 possible cell surface protein with gram positive anchor domain +FIG01526229 FIG00624183: hypothetical protein +FIG01526259 ankyrin repeat-containing protein 07_03 +FIG01526318 Conserved repeat domain precursor +FIG01526332 Uncharacterized MobA-related protein-like protein +FIG01526343 FIG00605705: hypothetical protein +FIG01526351 Uncharacterized protein MJ0408 +FIG01526381 FIG00512925: hypothetical protein +FIG01526424 FIG00632701: hypothetical protein +FIG01526428 putative transcriptional regulator (WhiB family) +FIG01526463 multidrug ABC transporter permease +FIG01526464 FIG00742862: hypothetical protein +FIG01526479 POTASSIUM CHANNEL PROTEIN +FIG01526501 FIG00479413: hypothetical protein +FIG01526508 Extracellular nuclease +FIG01526520 FIG00697315: hypothetical protein +FIG01526531 FIG00426120: hypothetical protein +FIG01526543 carboxypeptidase G2 precursor +FIG01526551 hypothetical protein SC7F9.19c +FIG01526565 ABC transporter domain protein +FIG01526592 FIG00776142: hypothetical protein +FIG01526597 HRPII +FIG01526604 FIG00797733: hypothetical protein +FIG01526618 putative cation transport regulator +FIG01526642 COG0491: Zn-dependent hydrolases, including glyoxylases +FIG01526643 ORF_ID:all7675 unknown protein +FIG01526652 FIG00658962: hypothetical protein +FIG01526678 ORF_ID:alr7524 hypothetical protein +FIG01526690 hypothetical protein +FIG01526739 FIG00622789: hypothetical protein +FIG01526741 FIG00413241: hypothetical protein +FIG01526746 FIG00623198: hypothetical protein +FIG01526761 hypothetical protein +FIG01526767 FIG00532449: hypothetical protein +FIG01526771 FIG00840942: hypothetical protein +FIG01526793 FIG00522885: hypothetical protein +FIG01526810 FIG00628794: hypothetical protein +FIG01526818 FIG00931821: hypothetical protein +FIG01526859 hypothetical protein +FIG01526868 H+-transporting two-sector ATPase, C subunit +FIG01526919 GLYCOSYL TRANSFERASE( EC:2.4.1.- ) +FIG01526921 FIG00576346: hypothetical protein +FIG01526942 FIG00767379: hypothetical protein +FIG01526944 FIG00418067: hypothetical protein +FIG01526964 autoinducer prepeptide +FIG01526991 FIG00624041: hypothetical protein +FIG01527009 FIG00880045: hypothetical protein +FIG01527013 NADPH dehydrogenase NamA +FIG01527033 Transforming growth factor-beta induced protein IG-H3 precursor +FIG01527037 Phosphopantetheine-binding protein +FIG01527056 FIG00513277: hypothetical protein +FIG01527057 FIG00751665: hypothetical protein +FIG01527058 FIG00385370: hypothetical protein +FIG01527144 FIG00352288: hypothetical protein +FIG01527190 FIG00468080: hypothetical protein +FIG01527334 conserved hypothetical protein +FIG01527417 Xaa-His dipeptidase (EC 3.4.13.3) +FIG01527418 FIG00520678: hypothetical protein +FIG01527427 FIG00624293: hypothetical protein +FIG01527458 putative DedA family protein +FIG01527465 FIG00672737: hypothetical protein +FIG01527487 Sensory box/GGDEF/EAL domain protein +FIG01527500 Transposase KP1_0723 +FIG01527507 Transcriptional regulator, AcrR family +FIG01527511 Probable oxalate/formate antiporter +FIG01527527 Metallo-beta-lactamase family protein( EC:3.1.2.6 ) +FIG01527530 Conserved hypothetical transmembrane protein, CAAX amino terminal protease family +FIG01527533 Sakacin-A immunity factor +FIG01527575 Latent nuclear antigen (Fragment) +FIG01527582 CpmC protein involved in carbapenem biosynthesis +FIG01527607 FIG01240940: hypothetical protein +FIG01527622 FIG00372174: hypothetical protein +FIG01527639 FIG00769740: hypothetical protein +FIG01527656 hypothetical protein +FIG01527679 FIG00850448: hypothetical protein +FIG01527688 DevC protein precursor +FIG01527695 Sulfate transporter/antisigma-factor antagonist domain +FIG01527731 putative iron-siderophore uptake system integral membrane component +FIG01527737 2-deoxy-D-gluconate 3-dehydrogenase +FIG01527743 orf; Unknown function +FIG01527753 FIG01022652: hypothetical protein +FIG01527775 ribosomal small subunit pseudouridylate synthase +FIG01527783 transcriptional activator of the formate hydrogenlyase system +FIG01527801 FIG00389962: hypothetical protein +FIG01527816 Amidase from nicotinamidase family +FIG01527826 Agarase( EC:3.2.1.81 ) +FIG01527836 site-specific recombinase +FIG01527847 Phosphinothricin N-acetyltransferase (EC 2.3.1.-) +FIG01527866 Virulence-associated protein E +FIG01527881 NUDIX hydrolase domain-containing protein +FIG01527885 FIG00362184: hypothetical protein +FIG01527904 peptidase, M28D family protein +FIG01527915 phosphodiesterase +FIG01527922 prophage pi2 protein 38 +FIG01527958 similar to surface protein +FIG01527966 caax amino protease family protein, putative +FIG01527977 apolipoprotein N-acyltransferase +FIG01528014 Serine protease DO-like +FIG01528029 FIG00351346: hypothetical protein +FIG01528035 FIG00385714: hypothetical protein +FIG01528040 putative transmembrane hexose transporter +FIG01528043 IS1167, transposase +FIG01528064 putative MFS transporter +FIG01528080 Sll0369 protein +FIG01528083 Probable sialidase (EC 3.2.1.18) +FIG01528092 FIG00515512: hypothetical protein +FIG01528141 hypothetical protein +FIG01528169 FIG00898418: hypothetical protein +FIG01528180 Phage protein +FIG01528183 phage protein, HK97 gp10 family +FIG01528193 FIG00733920: hypothetical protein +FIG01528208 Inner membrane protein ybaN +FIG01528219 LysM domain / Lipoprotein NlpD +FIG01528222 Sigma-54 activated regulatory protein +FIG01528226 drug resistance transporter EmrB/QacA subfamily protein +FIG01528261 Putative cyclase +FIG01528269 Soluble cytochrome b558 +FIG01528297 ABC transporter BlpC or comB +FIG01528321 Isoamylase N-terminal domain protein +FIG01528322 MEMBRANE FUSION PROTEIN MTRC +FIG01528364 hypothetical protein +FIG01528380 Hypothetical purine NTPase +FIG01528400 MULTIDRUG-EFFLUX TRANSPORTER +FIG01528406 f5/8 type C domain protein +FIG01528416 conserved protein MbtH_2 +FIG01528420 FIG00639608: hypothetical protein +FIG01528436 Zn-dependent aminopeptidase, putative +FIG01528447 variable surface protein mvspI +FIG01528460 flavoprotein NADH-dependent oxidoreductase +FIG01528484 FIG00406490: hypothetical protein +FIG01528500 FIG00045458: hypothetical protein +FIG01528517 FIG00337082: hypothetical protein +FIG01528520 FIG00451348: hypothetical protein +FIG01528524 Hydroxylamine oxidoreductase (EC 1.7.3.4) +FIG01528530 FIG00641824: hypothetical protein +FIG01528557 FIG00530055: hypothetical protein +FIG01528558 conserved hypothetical protein - phage associated +FIG01528569 hypothetical protein +FIG01528576 Sensor protein baeS (EC 2.7.3.-) +FIG01528581 nuclease, putative +FIG01528595 Site-specific tyrosine recombinase +FIG01528625 FIG00688564: hypothetical protein +FIG01528666 Hypothetical protein, CF-39 family +FIG01528685 FIG00836220: hypothetical protein +FIG01528689 FIG00850276: hypothetical protein +FIG01528717 POSSIBLE phiRv2 PROPHAGE PROTEIN +FIG01528722 Dinucleotide-utilizing enzymes involved in molybdopterin and thiamine biosynthesis family 2 +FIG01528742 FIG00898264: hypothetical protein +FIG01528755 bacteriocin self-immunity protein, putative +FIG01528769 FIG01240251: hypothetical protein +FIG01528774 isjp4 transposase +FIG01528800 FIG01166748: hypothetical protein +FIG01528854 FIG01238370: hypothetical protein +FIG01528858 FIG00688000: hypothetical protein +FIG01528885 FIG00877486: hypothetical protein +FIG01528887 Small molecule metabolism +FIG01528897 FIG00407510: hypothetical protein +FIG01528913 putative GTP pyrophosphokinase +FIG01529003 FIG01120384: hypothetical protein +FIG01529045 FIG01241207: hypothetical protein +FIG01529047 FIG00713008: hypothetical protein +FIG01529050 FIG00344752: hypothetical protein +FIG01529054 protein of unknown function DUF1555 +FIG01529078 putative DNA N-4 cytosine methyltransferase +FIG01529080 probable phage antitermination protein Q +FIG01529157 DNA adenine methylase (EC 2.1.1.72) +FIG01529174 sulfite/nitrite reductase, putative +FIG01529247 FIG01135697: hypothetical protein +FIG01529256 Protein of unknown function DUF1289 +FIG01529294 putative exported protein +FIG01529401 FIG00450769: hypothetical protein +FIG01529410 Na(+)/H(+) antiporter homolog +FIG01529447 NADH dehydrogenase (quinone) +FIG01529466 Putative cytochrome c, associated with quino(hemo)protein alcohol dehydrogenase +FIG01529484 glycosyl hydrolase 53 +FIG01529485 Putative transport protein +FIG01529502 FIG00348250: hypothetical protein +FIG01529529 FIG00816301: hypothetical protein +FIG01529540 FIG01017928: hypothetical protein +FIG01529552 FIG00349719: hypothetical protein +FIG01529554 putative mRNA-binding protein +FIG01529574 H. pylori predicted coding region HP1056 +FIG01529669 N-acetylmuramidase( EC:3.5.1.28 ) +FIG01529684 FIG00898356: hypothetical protein +FIG01529695 Methylcobalamin methyltransferase MMP0831 +FIG01529724 YoaW +FIG01529733 FIG00518489: hypothetical protein +FIG01529740 ORF114 +FIG01529767 prophage MuSo1, DNA transposition protein, putative +FIG01529774 conserved hypothetical protein-putative tagatose 3-epimerase( EC:5.3.1.- ) +FIG01529778 Transposase +FIG01529793 FIG00388099: hypothetical protein +FIG01529802 FIG00623011: hypothetical protein +FIG01529803 Gll3803 protein +FIG01529805 hypothetical protein +FIG01529827 FIG00356147: hypothetical protein +FIG01529844 FIG00945212: hypothetical protein +FIG01529873 Predicted GTPases +FIG01529874 FIG00697497: hypothetical protein +FIG01529915 Putative ion transport protein +FIG01529917 helicase, SNF2/RAD54 family +FIG01529932 FIG00520794: hypothetical protein +FIG01529961 FIG01199622: hypothetical protein +FIG01529975 FIG01120683: hypothetical protein +FIG01529987 2-acylglycerophosphoethanolamine acyltransferase +FIG01529998 N-acetylglutamate synthase/acetyltransferase +FIG01529999 PilT protein, N-terminal +FIG01530010 phosphatase, putative +FIG01530045 bacteriocin +FIG01530066 hypothetical protein +FIG01530085 FIG00734241: hypothetical protein +FIG01530097 homolog to phycocyanobilin lyase subunit( EC:4.- ) +FIG01530185 putative IS element transposase +FIG01530203 hydrolase or acyltransferase (alpha/beta hydrolase superfamily)-like protein +FIG01530214 All4885 protein +FIG01530230 NADH-ubiquinone oxidoreductase-related protein +FIG01530270 IstB-like ATP-binding protein +FIG01530300 haloalkane dehalogenase, putative +FIG01530321 Tn5741 family transposase +FIG01530324 hemagglutinin +FIG01530331 hypothetical protein +FIG01530337 Cytidyltransferase-related domain protein +FIG01530343 FIG00469843: hypothetical protein +FIG01530371 FIG00354134: hypothetical protein +FIG01530375 FIG00624835: hypothetical protein +FIG01530377 FIG00674132: hypothetical protein +FIG01530380 FIG00344018: hypothetical protein +FIG01530384 MOSC +FIG01530385 FIG00572228: hypothetical protein +FIG01530400 ribose ABC transporter, substrate-binding protein +FIG01530417 putative mini-circle protein +FIG01530423 FIG00891719: hypothetical protein +FIG01530440 FIG01166611: hypothetical protein +FIG01530441 Dimethylaniline monooxygenase [N-oxide-forming] 5 (EC 1.14.13.8) +FIG01530449 putative type II DNA modification enzyme (methyltransferase) +FIG01530453 FIG00352179: hypothetical protein +FIG01530479 FIG00996748: hypothetical protein +FIG01530489 FIG00434411: hypothetical protein +FIG01530529 FIG00352047: hypothetical protein +FIG01530537 FIG01198984: hypothetical protein +FIG01530581 GGDEF:EAL +FIG01530616 FIG00624364: hypothetical protein +FIG01530618 ferric exochelin biosynthesis (fxbA) +FIG01530642 FIG00388853: hypothetical protein +FIG01530664 FIG00817211: hypothetical protein +FIG01530685 Beta-lactamase class A-like protein +FIG01530693 FIG01119400: hypothetical protein +FIG01530694 FIG01048569: hypothetical protein +FIG01530702 FIG00838222: hypothetical protein +FIG01530704 Sulfate transporter family protein in cluster with carbonic anhydrase +FIG01530714 FIG00765562: hypothetical protein +FIG01530724 hypothetical phage protein +FIG01530742 beta-Ig-H3/fasciclin +FIG01530762 endonuclease I( EC:3.1.21.1 ) +FIG01530796 FIG01133590: hypothetical protein +FIG01530805 TM2 domain containing protein +FIG01530816 Nucleotidyltransferase domain +FIG01530852 Cobyrinic acid ac-diamide synthase +FIG01530878 Uncharacterized protein MJ0928 (M.MjaHemkP) +FIG01530886 small acid-soluble spore protein, alpha/beta type +FIG01530900 syc0974_d +FIG01530916 Sll0886 protein +FIG01530921 large Ala/Glu-rich protein +FIG01530932 phosphoesterase, PAP2 family +FIG01530935 Probable tautomerase +FIG01530939 Reverse transcriptase +FIG01530963 blr1245; unknown protein +FIG01530987 FIG00768960: hypothetical protein +FIG01530990 putative flavocytochrome +FIG01531021 At1g73650/F25P22_7 +FIG01531025 conserved membrane protein YvgT +FIG01531026 COG1872 +FIG01531033 lipopolysaccharide cholinephosphotransferase( EC:2.7.8.- ) +FIG01531039 FIG00521306: hypothetical protein +FIG01531045 Thioredoxin-like +FIG01531061 putative vgr-related protein +FIG01531065 Conserved hypothetical protein, internal deletion +FIG01531068 FIG01224591: hypothetical protein +FIG01531104 FIG00352667: hypothetical protein +FIG01531170 FIG00768066: hypothetical protein +FIG01531183 FIG00408455: hypothetical protein +FIG01531188 FIG00689762: hypothetical protein +FIG01531191 hypothetical protein +FIG01531206 Tetratricopeptide repeat-containing protein / Transcriptional regulator, LuxR family +FIG01531210 phage integrase-like SAM-like +FIG01531251 FIG00388958: hypothetical protein +FIG01531254 syc2367_d +FIG01531259 FIG00860065: hypothetical protein +FIG01531278 FIG00936597: hypothetical protein +FIG01531284 Ice-structuring glycoprotein precursor (ISGP) (Antifreeze glycopeptide polyprotein) (AFGP polyprotein) [Contains: AFGP7 (AFGP 7); AFGP8 (AFGP 8); AFGP8-like] (Fragment) +FIG01531290 NAD glycohydrolase, hvnA; Halovibrin +FIG01531311 Putative diguanylate cyclase (GGDEF domain) +FIG01531325 HemK, Methylase of polypeptide chain release factors +FIG01531347 Putative GntR-family transcriptional regulator +FIG01531367 Putative membrane protein MT1655 +FIG01531368 FIG00624340: hypothetical protein +FIG01531377 Sugar binding protein +FIG01531388 uropathogenic specific protein +FIG01531418 Plastocyanin precursor +FIG01531452 FIG01107872: hypothetical protein +FIG01531473 FIG00723172: hypothetical protein +FIG01531504 Leucin rich protein +FIG01531508 FIG00426811: hypothetical protein +FIG01531515 competence protein F, putative +FIG01531536 FIG00385081: hypothetical protein +FIG01531542 FIG00680829: hypothetical protein +FIG01531561 trwL5 protein +FIG01531582 Putative ribitolphosphotransferase (EC 2.7.8.-) +FIG01531590 FIG00688383: hypothetical protein +FIG01531642 sodium/calcium exchanger family protein +FIG01531711 RepB/MobA-like protein +FIG01531713 Acetaldehyde dehydrogenase 2, clustered with pyruvate formate-lyase +FIG01531744 Conjugal transfer protein TraC +FIG01531753 putative histone +FIG01531766 FIG00380493: hypothetical protein +FIG01531773 Fucolectin-related protein +FIG01531789 Outer membrane protein alpha precursor +FIG01531791 Putative permease of the Na+:galactoside symporter family +FIG01531812 Glutathione S-transferase, theta (EC 2.5.1.18) +FIG01531836 COG2201: Chemotaxis response regulator containing a CheY-like receiver domain and a methylesterase domain +FIG01531837 Tail fiber +FIG01531872 toxR-activated gene (tagE) +FIG01531875 FIG00361752: hypothetical protein +FIG01531893 FIG00847948: hypothetical protein +FIG01531913 hydrolase, alpha/beta hydrolase fold family protein +FIG01531921 probable nucleotide pyrophosphatase homolog +FIG01531928 FIG00747632: hypothetical protein +FIG01531954 putative transposase +FIG01531959 Cyanophycin synthetase +FIG01531972 FIG00733308: hypothetical protein +FIG01531979 FIG00643223: hypothetical protein +FIG01531984 FIG00351880: hypothetical protein +FIG01532004 FIG00352196: hypothetical protein +FIG01532036 mrp protein +FIG01532051 methylaspartate mutase, E subunit +FIG01532057 FIG00814514: hypothetical protein +FIG01532059 dehydrogenases and related proteins-like +FIG01532080 SUA5 protein +FIG01532087 Predicted transcriptional regulator of MarR-family +FIG01532109 Uncharacterized aromatic compound catabolism-like protein +FIG01532125 FIG00364209: hypothetical protein +FIG01532148 Hemin transport system ATP-binding protein hmuV +FIG01532149 MutT/nudix family protein +FIG01532159 FIG00355759: hypothetical protein +FIG01532169 hypothetical protein +FIG01532175 Glycosidase, PH1107-related +FIG01532181 Kinesin light chain +FIG01532206 Uncharacterized protein containing double-stranded beta helix domain +FIG01532216 tRNA (guanine-N(1)-)-methyltransferase( EC:2.1.1.31 ) +FIG01532284 Regulator of chromosome condensation RCC1 family protein +FIG01532306 similar to acyl carrier protein dehydratase +FIG01532316 FIG00835086: hypothetical protein +FIG01532326 FIG01532326: acyltransferase, putative +FIG01532387 lipoprotein BH0482 +FIG01532388 Possible peptidase S26 family protein +FIG01532395 nitrate/sulfonate/bicarbonate ABC transporter, ATPase component +FIG01532413 COG0666: FOG: Ankyrin repeat +FIG01532421 FIG00633402: hypothetical protein +FIG01532423 FIG00353604: hypothetical protein +FIG01532442 Plasmid stabilization system protein +FIG01532453 Conserved protein YvbF +FIG01532460 FIG00624636: hypothetical protein +FIG01532462 Protein-glutamate methylesterase FrzG (EC 3.1.1.61) +FIG01532468 COG1835: Predicted acyltransferases +FIG01532476 Merozoite surface protein 2 +FIG01532493 regulatory protein, MarR:regulatory protein, LysR +FIG01532502 maltose transacetylase +FIG01532527 Protein of unknown function DUF1211 +FIG01532552 Formate/nitrite transporter family +FIG01532587 TRANSPORT PROTEIN SGAT, LIPOPROTEIN +FIG01532627 FIG00782800: hypothetical protein +FIG01532641 Predicted glucose transporter in b-glucoside utilization gene cluster +FIG01532657 putative alcohol dehydrogenase +FIG01532658 FIG00807861: hypothetical protein +FIG01532677 FIG00411363: hypothetical protein +FIG01532683 nucleotidyl transferase family protein +FIG01532685 hypothetical protein +FIG01532717 FIG00895447: hypothetical protein +FIG01532730 FIG00388295: hypothetical protein +FIG01532782 FIG00363273: hypothetical protein +FIG01532800 5-methylcytosine-specific restriction enzyme B (EC 3.1.21.-) +FIG01532823 hydrogenase-4 transcriptional activator +FIG01532825 cell wall protein precursor, similar to choline binding protein, truncated +FIG01532835 Possible deazaflavin-dependent nitroreductase family protein +FIG01532859 FIG00774436: hypothetical protein +FIG01532873 Zn peptidase +FIG01532896 Phage dehydrogenase +FIG01532910 signal peptidase (type I) +FIG01532915 FIG00379901: hypothetical protein +FIG01532965 protein of unknown function DUF358 +FIG01532989 FIG01236840: hypothetical protein +FIG01532995 Hepatocellular carcinoma-associated antigen HCA557b +FIG01533003 ABC lipoprotein transporter, permease component +FIG01533006 ParB-like nuclease +FIG01533013 FIG00638662: hypothetical protein +FIG01533030 FIG00524218: hypothetical protein +FIG01533055 Putative SPBc2 prophage-derived 5'(3')-deoxyribonucleotidase (EC 3.1.3.-) +FIG01533065 Putative secreted glycosyl hydrolase +FIG01533073 CRISPR associated protein of unknown function +FIG01533078 FIG00517900: hypothetical protein +FIG01533140 PAS/PAC sensor hybrid histidine kinase precursor +FIG01533149 AWR family protein +FIG01533158 FIG01133315: hypothetical protein +FIG01533159 FIG00747754: hypothetical protein +FIG01533165 Glutamate-cysteine ligase family 2(GCS2) +FIG01533168 FIG00356573: hypothetical protein +FIG01533174 FIG00523203: hypothetical protein +FIG01533228 FIG00344010: hypothetical protein +FIG01533236 putative e6 protein +FIG01533264 protein of unknown function DUF111 +FIG01533282 COG1008: NADH:ubiquinone oxidoreductase subunit 4 (chain M) +FIG01533287 FIG00469019: hypothetical protein +FIG01533296 LysR-family transcriptional regulator PA4203 +FIG01533302 FIG021930: Phage-associated protein +FIG01533324 similar to protease ecfE( EC:3.4.24.- ) +FIG01533361 Cold-shock DNA-binding domain protein +FIG01533365 hypothetical proline hydroxylase +FIG01533385 putative ABC-type sugar transport systems, permease components +FIG01533389 large repetitive protein +FIG01533422 HTH-type transcriptional regulator prsX +FIG01533432 FIG00633104: hypothetical protein +FIG01533439 ORF23 +FIG01533456 no significant homology. Putative N-terminal signal sequence and 9 putative transmembrane regions were found by PSORT. +FIG01533465 putative aminopeptidase C +FIG01533468 FIG00388388: hypothetical protein +FIG01533502 FIG00408294: hypothetical protein +FIG01533517 Monooxygenase, FAD-binding +FIG01533527 FIG00409836: hypothetical protein +FIG01533532 FIG00349723: hypothetical protein +FIG01533536 FIG00849032: hypothetical protein +FIG01533541 FIG00380153: hypothetical protein +FIG01533552 virulence associated protein C +FIG01533554 ParB domain protein nuclease +FIG01533587 M. jannaschii predicted coding region MJ1615 +FIG01533642 Iron(III)-transport system permease protein SfuB +FIG01533665 Probable protease +FIG01533694 TonB-dependent siderophore receptor precursor +FIG01533697 Putative glycoportein or S-layer protein +FIG01533702 hypothetical protein +FIG01533712 Small, acid-soluble spore protein tlp +FIG01533727 FIG00816693: hypothetical protein +FIG01533732 FUPA32 P-type ATPase +FIG01533766 RfbJ protein +FIG01533788 Accessory colonization factor AcfC, contains ABC-type periplasmic domain +FIG01533811 FIG00837933: hypothetical protein +FIG01533831 FIG00344575: hypothetical protein +FIG01533847 ankyrin repeat protein +FIG01533853 merops peptidase family S24 +FIG01533857 FIG00388102: hypothetical protein +FIG01533896 FIG00733725: hypothetical protein +FIG01533949 Glycosaminoglycan attachment site +FIG01533973 Uncharacterized protein ydjB +FIG01534020 FIG00414217: hypothetical protein +FIG01534039 Cell Inhibiting Factor (Cif) +FIG01534130 Probable molybdenum cofactor biosynthesis protein C +FIG01534157 FIG00523041: hypothetical protein +FIG01534206 FIG00361834: hypothetical protein +FIG01534210 FIG01233227: hypothetical protein +FIG01534216 Chromosomal protein MC1 +FIG01534228 gamma-BHC dehydrochlorinase +FIG01534266 Gamma-butyrobetaine dioxygenase (EC 1.14.11.1) +FIG01534277 N-acyl-L-homoserine lactone synthetase TraI +FIG01534317 FIG00406408: hypothetical protein +FIG01534334 Conserved protein, with weak BamHI domain +FIG01534368 Macrolide-efflux transporter +FIG01534371 Hypothetical protein, CF-7 family +FIG01534397 FIG00528181: hypothetical protein +FIG01534415 FIG01181513: hypothetical protein +FIG01534425 GTP-binding protein AF1181 +FIG01534454 conserved hypothetical protein, related to putative virulence-associated proteins and nitrogen regulatory protein NtrP +FIG01534457 FIG00256662: hypothetical protein +FIG01534463 FIG00407212: hypothetical protein +FIG01534472 probable enoyl-CoA hydratase/isomerase +FIG01534490 Integrase/recombinase, core domain family +FIG01534496 FIG00820485: hypothetical protein +FIG01534528 Tir chaperone family protein +FIG01534576 Platelet-activating factor acetylhydrolase IB gamma subunit (EC 3.1.1.47) +FIG01534637 Uncharacterized protein MJ1404 +FIG01534664 baseplate assembly protein V, putative +FIG01534689 hypothetical phage associated protein +FIG01534712 conserved hypothetical protein TIGR00046 +FIG01534732 putative flippase +FIG01534743 FIG01231112: hypothetical protein +FIG01534761 Possible secreted peptidase +FIG01534773 FIG00937960: hypothetical protein +FIG01534786 Guanosine polyphosphate pyrophosphohydrolases/synthetases +FIG01534826 FIG00762710: hypothetical protein +FIG01534837 InterPro IPR001225 +FIG01534842 farnesyl cysteine carboxyl-methyltransferase +FIG01534844 FIG00766148: hypothetical protein +FIG01534849 Hypothetical protein, CF-28 family +FIG01534855 FIG01083888: hypothetical protein +FIG01534897 IS256-family transposase +FIG01534915 RNA-binding protein RbpD +FIG01534919 FIG00712400: hypothetical protein +FIG01534924 Leader peptidase (Prepilin peptidase) (EC 3.4.23.43) / N-methyltransferase (EC 2.1.1.-) +FIG01534950 FIG00362117: hypothetical protein +FIG01534983 FIG00388190: hypothetical protein +FIG01534986 FIG00744268: hypothetical protein +FIG01534990 Peptidyl-prolyl cis-trans isomerase, FKBP-type (EC 5.2.1.8) +FIG01535009 ISCps7, transposase +FIG01535011 FIG00412690: hypothetical protein +FIG01535021 FIG00388368: hypothetical protein +FIG01535035 FIG00353998: hypothetical protein +FIG01535038 Secreted protein containing uncharacterized conserved protein of ErfK family +FIG01535044 FIG00752359: hypothetical protein +FIG01535050 UPF0337 protein RB10934 +FIG01535056 Methyltransferase FkbM +FIG01535064 FIG01245312: hypothetical protein +FIG01535091 PmgB +FIG01535106 FIG00411656: hypothetical protein +FIG01535122 COG0463: Glycosyltransferases involved in cell wall biogenesis +FIG01535142 Beta-mannanase ManB, contains ChW-repeats +FIG01535158 hypothetical protein +FIG01535169 response regulator receiver and unknown domain protein +FIG01535173 similar to Uncharacterized low-complexity proteins +FIG01535177 FIG00405014: hypothetical protein +FIG01535217 FIG00413911: hypothetical protein +FIG01535219 FIG00385177: hypothetical protein +FIG01535265 C1.100 +FIG01535274 FIG01045202: hypothetical protein +FIG01535279 FIG00356745: hypothetical protein +FIG01535288 FIG00519472: hypothetical protein +FIG01535297 FIG01008087: hypothetical protein +FIG01535306 UDP-glucuronosyltransferase +FIG01535318 FIG00388133: hypothetical protein +FIG01535325 FIG00387995: hypothetical protein +FIG01535334 FIG00524747: hypothetical protein +FIG01535366 FIG00715857: hypothetical protein +FIG01535369 Short-chain dehydrogenase/reductase (SDR) superfamily +FIG01535393 FIG00450818: hypothetical protein +FIG01535419 Uncharacterized 9.4 kDa protein +FIG01535512 FIG00352368: hypothetical protein +FIG01535536 sugar permease of ABC transporter system +FIG01535556 Site-specific DNA-methyltransferase +FIG01535560 dihydrodipicolinate reductase +FIG01535571 putative regulator +FIG01535574 ORF_ID:alr7565 hypothetical protein +FIG01535580 FIG00962384: hypothetical protein +FIG01535603 UPF0049 protein MJ0046, possible RNA methyltransferase +FIG01535624 carbon monoxide dehydrogenase, medium subunit( EC:1.2.99.2 ) +FIG01535642 sulfate transporter family protein +FIG01535646 FIG028593: membrane protein +FIG01535679 Functional role page for Anaerobic nitric oxide reductase transcription regulator NorR +FIG01535703 FIG00624802: hypothetical protein +FIG01535710 Proto-chlorophyllide reductase 57 kD subunit +FIG01535752 ORF_ID:tlr0872 hypothetical protein +FIG01535785 esterase/lipase +FIG01535803 signal peptidase +FIG01535847 Transcriptional regulators, AcrR family +FIG01535862 hypothetical protein +FIG01535869 Putative hexosyltransferase +FIG01535871 FIG00352464: hypothetical protein +FIG01535881 hypothetical alpha-(13)-fucosyltransferase +FIG01535885 FIG00176575: hypothetical protein +FIG01535888 FIG00408846: hypothetical protein +FIG01535903 putative gamma-aminobutyrate permease +FIG01535904 Gll1024 protein +FIG01535907 FIG00894951: hypothetical protein +FIG01535912 FIG00403073: hypothetical protein +FIG01535921 FIG00425146: hypothetical protein +FIG01535923 FIG00832962: hypothetical protein +FIG01535926 FIG00513348: hypothetical protein +FIG01535973 FIG00258463: hypothetical protein +FIG01535995 Sialic acid transporter +FIG01536006 FIG00517190: hypothetical protein +FIG01536023 FIG01150240: hypothetical protein +FIG01536062 ABC transporter dipeptide binding protein +FIG01536069 Hydrogenase maturation factor +FIG01536071 FIG00624564: hypothetical protein +FIG01536078 Transcriptional regulator, TetR family protein +FIG01536099 hypothetical protein +FIG01536112 hypothetical protein +FIG01536122 possible Cytochrome c oxidase subunit Va +FIG01536151 FIG00859558: hypothetical protein +FIG01536168 FIG01227252: hypothetical protein +FIG01536175 glutathione-dependent formaldehyde-activating, GFA +FIG01536201 Permease protein of amino acid ABC transporter +FIG01536225 FIG00631353: hypothetical protein +FIG01536231 IncI1 plasmid pilus assembly protein PilP +FIG01536263 FIG00624338: hypothetical protein +FIG01536265 Outer membrane assembly protein +FIG01536275 FIG00384937: hypothetical protein +FIG01536293 transposase (22) +FIG01536310 putative type II restriction endonuclease +FIG01536320 4Fe-4S binding domain protein +FIG01536333 Na+/H+ antiporter family protein +FIG01536395 FIG00769466: hypothetical protein +FIG01536462 FIG00469392: hypothetical protein +FIG01536504 FIG00385432: hypothetical protein +FIG01536533 FIG00759175: hypothetical protein +FIG01536575 hemolysin expression modulating family protein +FIG01536618 AtrA transcriptional regulator +FIG01536642 copper resistance protein C +FIG01536655 protein of unknown function DUF1615 +FIG01536667 Intradiol ring-cleavage dioxygenase:Catechol dioxygenase, N-terminal +FIG01536681 Probable transglycosylase +FIG01536745 FIG00753453: hypothetical protein +FIG01536760 conserved hypothetical protein, putative protein kinase +FIG01536772 FIG00628532: hypothetical protein +FIG01536823 FIG00380261: hypothetical protein +FIG01536828 Prenyl group binding site +FIG01536870 integral membrane protein PlnU, membrane-bound protease CAAX family +FIG01536876 FIG00624493: hypothetical protein +FIG01536886 Predicted transcriptional regulator, lacI/xre family +FIG01536902 Molybdenum transport system permease protein ModB (TC 3.A.1.8.1) +FIG01537022 FIG00344865: hypothetical protein +FIG01537027 FIG01166399: hypothetical protein +FIG01537043 AcpK +FIG01537059 similar to ankyrin 2,3/unc44 +FIG01537093 polyhydroxyalkanoate synthesis protein PhaF +FIG01537126 FIG00350783: hypothetical protein +FIG01537142 putative membrane efflux protein +FIG01537145 ABC-type molybdate transport system, periplasmic component +FIG01537156 FeoA-like protein, involved in iron transport +FIG01537166 Tetratricopeptide TPR_4 +FIG01537206 putative blue copper protein +FIG01537207 Tn5520-like integrase +FIG01537253 ankyrin repeat-containing protein 05_01 +FIG01537262 FIG00344361: hypothetical protein +FIG01537274 Glycine betaine transporter +FIG01537302 FIG00519092: hypothetical protein +FIG01537345 Probable polyketide cyclase +FIG01537375 FIG01048830: hypothetical protein +FIG01537388 FIG01048207: hypothetical protein +FIG01537394 FIG00303701: hypothetical protein +FIG01537397 FIG00665684: hypothetical protein +FIG01537411 TPR repeat:Sel1-like repeat:Sel1-like repeat +FIG01537419 Transcriptional repressor of the arabinose operon +FIG01537435 PE-PGRS FAMILY PROTEIN +FIG01537452 FIG01232099: hypothetical protein +FIG01537458 ISxac3 transposase +FIG01537461 putative two component response regulator protein +FIG01537558 COG3410: Uncharacterized conserved protein +FIG01537598 FIG00839491: hypothetical protein +FIG01537607 Ig family protein +FIG01537614 Nodulation protein +FIG01537622 FIG00756871: hypothetical protein +FIG01537649 FIG00753812: hypothetical protein +FIG01537671 FIG00527906: hypothetical protein +FIG01537684 probable solute-binding periplasmic protein +FIG01537708 DnaJ protein +FIG01537730 FIG00641323: hypothetical protein +FIG01537769 Trypsin-like protease precursor (EC 3.4.21.-) +FIG01537801 N-ethylammeline chlorohydrolase +FIG01537827 Hypothetical proteins +FIG01537829 FIG01203071: hypothetical protein +FIG01537830 Mll7390 protein +FIG01537844 FIG00403226: hypothetical protein +FIG01537888 lantibiotic dehydratase +FIG01537915 possible signal peptide +FIG01537938 FIG00803783: hypothetical protein +FIG01537974 Gll1625 protein +FIG01537975 conserved hypothetical protein; possible acetyltransferase +FIG01537986 methyltransferase Atu0936 , putative +FIG01538020 colicin V secretion ABC transporter ATP-binding protein +FIG01538021 Lipopolysaccharide core biosynthesis mannosyltransferase lpcC +FIG01538029 IS30 family transposase +FIG01538042 putative AraC family transcriptional regulator +FIG01538045 FIG01246496: hypothetical protein +FIG01538080 Voltage-gated potassium channel beta-1 subunit +FIG01538087 competence protein GD +FIG01538093 serine alkaline protease (subtilisin E) +FIG01538098 FIG01069349: hypothetical protein +FIG01538112 hypothetical protein +FIG01538117 UDP-N-acetylmuramoylpentapeptide-lysine N(6)-alanyltransferase +FIG01538154 TlpA +FIG01538163 membrane carboxypeptidase +FIG01538166 FIG00775439: hypothetical protein +FIG01538178 FIG00351657: hypothetical protein +FIG01538190 FIG00839386: hypothetical protein +FIG01538191 FIG00424881: hypothetical protein +FIG01538196 FIG00907285: hypothetical protein +FIG01538199 Protein of unknown function DUF214 +FIG01538300 Type IV fimbrial assembly protein PilC +FIG01538310 Bsl0054 protein +FIG01538314 Domain of unknown function DUF1836 +FIG01538319 TagA-related protein +FIG01538335 sugar:cation symporter family protein +FIG01538351 FIG00733378: hypothetical protein +FIG01538373 syc2092_c +FIG01538380 FIG00361742: hypothetical protein +FIG01538384 Penicillin tolerance protein +FIG01538390 RESPONSE TWO-COMPONENT REGULATOR +FIG01538395 FIG00624456: hypothetical protein +FIG01538400 FIG00767707: hypothetical protein +FIG01538414 FIG00623493: hypothetical protein +FIG01538480 putative ABC transport ATP-binding subunit +FIG01538482 FIG00388508: hypothetical protein +FIG01538522 FIG00352475: hypothetical protein +FIG01538529 Possible processive endoglucanase family 48, secreted; CelF ortholog; dockerin domain +FIG01538551 FIG00418205: hypothetical protein +FIG01538599 FIG00348941: hypothetical protein +FIG01538617 Sll2007 protein +FIG01538619 Sugar binding lipoprotein precursor +FIG01538629 glycoprotein galactosyltransferase alpha 1, 3 +FIG01538661 FIG00768314: hypothetical protein +FIG01538726 FIG00412646: hypothetical protein +FIG01538727 protein folding and stabilization +FIG01538732 Phage transcriptional activator ArpU +FIG01538737 FIG00349171: hypothetical protein +FIG01538738 streptomycin 6-kinase( EC:2.7.1.72 ) +FIG01538797 pyridoxamine 5'-phosphate oxidase family protein +FIG01538798 hypothetical protein +FIG01538820 O-acetyltransferase +FIG01538825 Photoactive yellow protein +FIG01538833 metallo-beta-lactamase domain protein +FIG01538913 hypothetical protein +FIG01539003 FIG00815005: hypothetical protein +FIG01539020 FIG00849209: hypothetical protein +FIG01539057 transcriptional regulator (RpiR family) +FIG01539059 possible acetoacetate decarboxylase +FIG01539068 peptidase S9, prolyl oligopeptidase active site domain protein +FIG01539077 FIG00658293: hypothetical protein +FIG01539132 lysozyme M1 precursor( EC:3.2.1.17 ) +FIG01539160 major pilu subunit operon regulatory protein PapB +FIG01539220 FIG00348223: hypothetical protein +FIG01539246 Outer membrane protein 8 +FIG01539262 PknM +FIG01539289 FIG00364096: hypothetical protein +FIG01539309 FIG00343873: hypothetical protein +FIG01539330 Tyrosinase (EC 1.14.18.1) (Monophenol monooxygenase) +FIG01539363 FIG00528207: hypothetical protein +FIG01539390 Gll2474 protein +FIG01539391 Gll4023 protein +FIG01539434 secreted FAD-binding protein +FIG01539489 Choline binding protein PcpA +FIG01539496 FIG00571165: hypothetical protein +FIG01539523 phycocyanin alpha phycocyanobilin lyase-like +FIG01539540 FIG00640931: hypothetical protein +FIG01539562 InterPro IPR000063 COGs COG0526 +FIG01539586 FIG00672535: hypothetical protein +FIG01539609 Cwp84 +FIG01539611 FIG00623538: hypothetical protein +FIG01539617 histone H1-like protein Hc2 +FIG01539642 transposase +FIG01539660 FIG00527665: hypothetical protein +FIG01539672 NADH dehydrogenase 32K chain homolog +FIG01539679 Cytochrome C5 +FIG01539695 FIG00518801: hypothetical protein +FIG01539697 FIG00354019: hypothetical protein +FIG01539754 ISGsu2, transposase +FIG01539774 FIG01240928: hypothetical protein +FIG01539796 ortholog of Bordetella pertussis (BX470248) BP1585 +FIG01539805 FIG00711031: hypothetical protein +FIG01539819 putative sugar kinase +FIG01539821 FIG00743199: hypothetical protein +FIG01539835 FIG00531688: hypothetical protein +FIG01539853 FIG00344818: hypothetical protein +FIG01539857 Peptodoglycan-binding domain containing protein +FIG01539865 pilT protein, putative +FIG01539887 Peptidyl-prolyl cis-trans isomerase, cyclophilin-type (EC 5.2.1.8) +FIG01539892 FIG00520077: hypothetical protein +FIG01539919 Oligopeptide transport system, permease +FIG01539926 transcriptional regulator, AraC/XylS family +FIG01539930 Cytoplasmic peptidoglycan synthetase, N-terminal precursor +FIG01539957 Bile acid beta-glucosidase +FIG01539967 COG4584: Transposase and inactivated derivatives +FIG01540019 phenol hydroxylase, putative +FIG01540025 calcium-translocating P-type ATPase, PMCA-type +FIG01540058 Vitamin B12 ABC transporter, permease component BtuC +FIG01540067 FIG00698731: hypothetical protein +FIG01540073 conserved hypothetical protein-putative permease +FIG01540128 FIG00245438: hypothetical protein +FIG01540134 FIG01222998: hypothetical protein +FIG01540155 no significant homology. Putative N-terminal signal sequence and 1 putative transmembrane region were found by PSORT +FIG01540159 Abortive infection protein AbiGI +FIG01540167 PUTATIVE ATP /GTP BINDING PROTEIN +FIG01540168 HTH-type transcriptional regulator Rgg family +FIG01540169 FIG01127396: hypothetical protein +FIG01540241 Truncated hemoglobins-like protein +FIG01540264 Inositol monophosphatase +FIG01540278 iron(III)-binding periplasmic protein precursor +FIG01540294 probable ATP binding protein of ABC transporter +FIG01540298 putative cobalamin biosynthesis protein, CobT +FIG01540309 FIG00768739: hypothetical protein +FIG01540329 no significant homology. 2 putative transmembrane regions were found by PSORT. +FIG01540407 protein containing bacterial pre-peptidase C-terminal domain +FIG01540455 Photolyase protein family +FIG01540463 FIG01276199: hypothetical protein +FIG01540502 porin opacity type +FIG01540514 protein of unknown function UPF0102 +FIG01540545 putative anti-SigV factor +FIG01540568 FIG00623547: hypothetical protein +FIG01540583 FIG00675627: hypothetical protein +FIG01540595 FIG00404889: hypothetical protein +FIG01540642 hemolysin III +FIG01540661 FIG00733654: hypothetical protein +FIG01540698 protein phosphatase 2C domain protein +FIG01540702 Type II R-M system adenine specific methyltransferase (EC 2.1.1.72) +FIG01540740 ortholog of Bordetella pertussis (BX470248) BP3296 +FIG01540790 FIG00363080: hypothetical protein +FIG01540839 FIG00410745: hypothetical protein +FIG01540880 putative mobilization protein mobC +FIG01540881 glycosyl transferase domain, group 2 family protein +FIG01540890 FIG00379804: hypothetical protein +FIG01540904 ortholog to Borrelia burgdorferi BB0006 +FIG01540936 FIG00413962: hypothetical protein +FIG01540944 FIG00385568: hypothetical protein +FIG01540949 Na(+)/H(+) antiporter, homolog +FIG01540951 Hemagglutinin component HA-17 +FIG01540979 oligosaccharide translocase +FIG01541012 Uncharacterized protein aq_1953 +FIG01541044 phage-related lytic enzyme +FIG01541088 truncated transposase +FIG01541096 N-carbamoyl-L-amino acid amidohydrolase +FIG01541142 Predicted acyltransferases +FIG01541167 ABC-type tungstate transport system, ATP-binding protein +FIG01541177 FIG00763296: hypothetical protein +FIG01541217 hypothetical protein +FIG01541221 FIG01134245: hypothetical protein +FIG01541240 Protein of unknown function DUF1555 +FIG01541259 FIG00361269: hypothetical protein +FIG01541269 Site-specific DNA methylase-like +FIG01541285 FIG00898506: hypothetical protein +FIG01541292 FIG00954150: hypothetical protein +FIG01541297 FIG00640437: hypothetical protein +FIG01541325 FIG00638013: hypothetical protein +FIG01541364 F1 capsule antigen +FIG01541390 response regulator, rrf1 protein +FIG01541407 conserved hypothetical membrane spanning protein +FIG01541419 SoxR family transcriptional regulator fused to SAM-dependent methyltransferase +FIG01541474 Phage major tail protein, TP901-1, subfamily 1 +FIG01541524 Uncharacterized protein MJ1654 +FIG01541534 CRISPR-associated protein Cas2 +FIG01541542 dessication-associated protein +FIG01541593 Oxetanocin A resistance protein +FIG01541601 FIG00825751: hypothetical protein +FIG01541624 Helix-turn-helix type 3 +FIG01541634 Argininosuccinate lyase 2 (EC 4.3.2.1) +FIG01541638 phosphoenolpyruvate synthase/pyruvate phosphate dikinase +FIG01541656 adenine-specific DNA methyltransferase +FIG01541745 ABC transporter, ATP binding protein related protein +FIG01541750 deoxyribonuclease +FIG01541760 Protein of unknown function DUF331 +FIG01541789 FIG00412419: hypothetical protein +FIG01541867 FIG00606574: hypothetical protein +FIG01541900 microcystin dependent protein +FIG01541904 FIG00530852: hypothetical protein +FIG01541907 FIG00403715: hypothetical protein +FIG01541931 FIG00688335: hypothetical protein +FIG01541957 Transcriptional regulator, AraC family, homolog 5 +FIG01541964 putative transposase of unclassified IS +FIG01541968 FIG01247892: hypothetical protein +FIG01541974 ortholog of Bordetella pertussis (BX470248) BP2265 +FIG01541975 FIG00385690: hypothetical protein +FIG01541979 Membrane associated sensory transduction histidine kinase (with HAMP domain) +FIG01542004 PDZ domain protein +FIG01542008 FIG00385396: hypothetical protein +FIG01542009 FIG00762742: hypothetical protein +FIG01542015 ABC-type Co2+ transport system periplasmic component-like protein +FIG01542018 FIG00425549: hypothetical protein +FIG01542031 phosphoribosylglycinamide synthetase +FIG01542041 FIG00413299: hypothetical protein +FIG01542051 Protein of unknown function DUF955 +FIG01542100 FIG01247936: hypothetical protein +FIG01542122 P16 +FIG01542144 FIG00945998: hypothetical protein +FIG01542163 Tetratricopeptide repeat family +FIG01542174 Esterase/lipase/thioesterase, slr0421 homolog +FIG01542186 FIG00415090: hypothetical protein +FIG01542238 FIG01198175: hypothetical protein +FIG01542252 hypothetical protein, putative bacteriocin +FIG01542267 FIG00747386: hypothetical protein +FIG01542296 Protein essC +FIG01542314 FIG00412176: hypothetical protein +FIG01542316 DNA repair protein rad2, putative +FIG01542334 IS630-Spn1, transposase Orf2 +FIG01542348 Site-specific recombinase XerC +FIG01542417 intracellular proteinase inhibitor Ipi +FIG01542419 putative mobilization protein C +FIG01542436 pyridoxal-dependent decarboxylase, Orn/Lys/Arg family +FIG01542447 FIG00379902: hypothetical protein +FIG01542496 FIG00823315: hypothetical protein +FIG01542501 FIG00849060: hypothetical protein +FIG01542521 Phage integrase +FIG01542539 HTH-type transcriptional regulator yidZ domain protein +FIG01542557 Mobilizable transposon, tnpC protein +FIG01542558 hypothetical protein with helix turn helix motif +FIG01542562 Phage uncharacterised protein +FIG01542581 expression validated by proteogenomic mapping: 43 unique peptides covering 71.4% of sequence +FIG01542597 FIG00417257: hypothetical protein +FIG01542601 FIG00462603: hypothetical protein +FIG01542602 methyl-accepting chemotaxis protein (MCP) homologue +FIG01542613 hypothetical protein +FIG01542638 Uncharacterized conserved secreted or membrane protein +FIG01542649 peptidase U32 +FIG01542651 RhtB family transporter +FIG01542652 Xanthine dehydrogenase accessory factor, putative +FIG01542678 cytolysin B transport protein +FIG01542711 syc0807_c +FIG01542728 phage shock protein E (rhodanese-like domain protein) +FIG01542729 Heat shock protein G homolog +FIG01542735 probable transposase protein, Y4bF +FIG01542737 putative F420-dependent dehydrogenase +FIG01542781 aminotransferase class I and II +FIG01542782 Phage-related lysozyme +FIG01542789 HlyD family secretion protein +FIG01542793 Mlr6579 protein +FIG01542825 TetR family transcriptional regulator +FIG01542841 peptidase M16-like +FIG01542849 FIG00347594: hypothetical protein +FIG01542879 FIG00937377: hypothetical protein +FIG01542889 Putative polyamine transporter; +FIG01542896 Putative ABC transport system, ATP-binding subunit +FIG01542934 Iron(III) ABC transporter, ATP-binding protein +FIG01542950 Uncharacterized protein MJ0096 +FIG01542969 FIG01244371: hypothetical protein +FIG01542973 formate/nitrite transporter family protein, truncated +FIG01542979 Glycosyltransferase sugar-binding region containing DXD motif +FIG01543010 Site-specific DNA-methyltransferase (adenine- specific), dam +FIG01543060 Response regulator of citrate/malate metabolism +FIG01543070 putative mutT/nudix family protein +FIG01543081 osmotically inducible protein OsmC +FIG01543096 ISChy3, transposase +FIG01543106 FIG00353706: hypothetical protein +FIG01543110 acyl-homoserine-lactone synthase TraI +FIG01543115 hypothetical protein +FIG01543142 FIG00410753: hypothetical protein +FIG01543143 probable IolI protein +FIG01543168 FIG00347775: hypothetical protein +FIG01543203 FIG00762842: hypothetical protein +FIG01543228 FIG00641247: hypothetical protein +FIG01543264 putative signal transduction histidine kinase with PAS/PAC domain +FIG01543267 Bll7785 protein +FIG01543275 FIG00416167: hypothetical protein +FIG01543294 FIG01118938: hypothetical protein +FIG01543316 FIG00385101: hypothetical protein +FIG01543345 FIG00532305: hypothetical protein +FIG01543377 FIG00769002: hypothetical protein +FIG01543423 FIG00363376: hypothetical protein +FIG01543485 FIG00744075: hypothetical protein +FIG01543487 methyltransferase, UbiE-COQ5 family +FIG01543489 hypothetical protein +FIG01543497 trypsin domain lipoprotein +FIG01543520 Eukaryotic small stress protein PASS1 +FIG01543536 Aminoglycoside 3'-phosphotransferase (EC 2.7.1.95) +FIG01543539 FIG00754544: hypothetical protein +FIG01543551 FIG00415226: hypothetical protein +FIG01543553 FIG00624142: hypothetical protein +FIG01543558 putative lemA protein +FIG01543560 cystine-binding protein +FIG01543562 COGs COG2378 +FIG01543570 hypothetical protein +FIG01543582 NRFJ +FIG01543584 FIG00849082: hypothetical protein +FIG01543589 FIG048485: Phage protein +FIG01543611 FIG00641907: hypothetical protein +FIG01543628 phosphate acetyltransferase( EC:2.3.1.8 ) +FIG01543656 FIG00764639: hypothetical protein +FIG01543712 hypothetical protein; putative coiled-coil domain +FIG01543733 Phosphoribosyl transferase domain +FIG01543761 FIG00518512: hypothetical protein +FIG01543770 Putative sugar ABC transport syste, ATP-binding protein +FIG01543772 FIG01118045: hypothetical protein +FIG01543773 FIG01223629: hypothetical protein +FIG01543802 AroM +FIG01543805 FIG00347649: hypothetical protein +FIG01543810 FIG01118191: hypothetical protein +FIG01543836 FIG01080457: hypothetical protein +FIG01543846 FIG00643674: hypothetical protein +FIG01543858 Putative transposase (partial) +FIG01543914 Phage protein +FIG01543927 contains predicted Rossmann fold nucleotide-binding domain +FIG01543930 Site-specific recombinase, phage integrase family domain protein +FIG01543942 FIG00407497: hypothetical protein +FIG01543944 FIG01197713: hypothetical protein +FIG01543986 alkaline phosphatase, putative +FIG01543996 FIG00631791: hypothetical protein +FIG01544010 FIG00849200: hypothetical protein +FIG01544020 FIG00451110: hypothetical protein +FIG01544029 Trehalose and maltose hydrolases (possible phosphorylases) +FIG01544054 probable p-cresol methylhydroxylase subunit +FIG01544093 ATP-dependent protease peptidase subunit( EC:3.4.25.- ) +FIG01544133 FIG00769645: hypothetical protein +FIG01544136 Two-component system sensor protein [USSDB2B] +FIG01544154 type IV prepilin peptidase HopD +FIG01544158 FIG00407675: hypothetical protein +FIG01544174 FIG00624265: hypothetical protein +FIG01544179 Lin0455 protein +FIG01544182 215aa long hypothetical protein +FIG01544204 enoyl-CoA hydratase +FIG01544235 FIG00518252: hypothetical protein +FIG01544238 FIG00815558: hypothetical protein +FIG01544239 FIG00361911: hypothetical protein +FIG01544252 hypothetical periplasmic protein +FIG01544293 RDD domain protein +FIG01544297 putative terpene cyclase +FIG01544320 sodium- and chloride-dependent transporter, putative tyrosine transporter +FIG01544321 FIG00688113: hypothetical protein +FIG01544329 FIG00747879: hypothetical protein +FIG01544340 Protein of unknown function DUF952 +FIG01544384 FIG00734490: hypothetical protein +FIG01544393 Putative enzyme of poly-gamma-glutamate biosynthesis (capsule formation) +FIG01544412 FIG00794560: hypothetical protein +FIG01544423 probable carbohydrate-binding protein +FIG01544439 putative amino acid uptake ABC transporter periplasmic solute-binding protein precursor +FIG01544440 FIG00605404: hypothetical protein +FIG01544461 FIG00385059: hypothetical protein +FIG01544482 POSSIBLE INTEGRAL MEMBRANE PROTEIN +FIG01544483 FIG00633793: hypothetical protein +FIG01544490 RLX protein +FIG01544507 pseudouridine synthase +FIG01544520 UPF0336 protein SAV4901 +FIG01544524 conserved hypothetical protein SCL11.04c +FIG01544560 Plasmid replication protein +FIG01544579 FIG00384863: hypothetical protein +FIG01544599 ABC transporter, ATP-binding/permease +FIG01544601 Asr2958 protein +FIG01544617 FIG00876888: hypothetical protein +FIG01544639 Putative cation transport regulator +FIG01544646 InterPro IPR002197 +FIG01544672 conserved protein of unknown function; putative smp protein +FIG01544676 thiopurine S-methyltransferase +FIG01544729 Glycoside hydrolase, family 12 +FIG01544807 unknown protein encoded by prophage CP-933N +FIG01544817 possible acyl-CoA dehydrogenase +FIG01544836 hypothetical protein +FIG01544851 FIG00349687: hypothetical protein +FIG01544862 LamG-like jellyroll fold +FIG01544871 syc1814_d +FIG01544881 FIG00037758: hypothetical protein +FIG01544916 Nrp +FIG01544948 precorrin-3B C17-methyltransferase +FIG01544955 FIG00409790: hypothetical protein +FIG01544961 FIG00623927: hypothetical protein +FIG01544963 FIG00388025: hypothetical protein +FIG01544964 FIG00629496: hypothetical protein +FIG01544965 Hypothetical protein, CF-12 family +FIG01544997 FIG00404294: hypothetical protein +FIG01545009 Protein tyrosine phosphatase II superfamily protein +FIG01545010 FIG00416872: hypothetical protein +FIG01545023 DNA topoisomerase I( EC:5.99.1.2 ) +FIG01545030 Magnesium and cobalt transport protein corA +FIG01545064 FIG00407374: hypothetical protein +FIG01545077 identified by Glimmer2; putative +FIG01545079 lectin C-type domain protein +FIG01545088 hypothetical protein +FIG01545148 FIG00385277: hypothetical protein +FIG01545156 Glycosyltransferase involved in cell wall biogenesis (EC 2.4.-.-) +FIG01545204 CsoS1D +FIG01545210 putative chromate resistance protein +FIG01545216 tw-component sensor kinase +FIG01545223 conserved hypothetical protein; possible metalloprotease +FIG01545224 Putative ArsR family Transcriptional regulator +FIG01545246 Carboxypeptidase T precursor (EC 3.4.17.18) +FIG01545259 FIG00641967: hypothetical protein +FIG01545263 FIG00344354: hypothetical protein +FIG01545328 FIG01015831: hypothetical protein +FIG01545339 hypothetical protein +FIG01545344 FIG00385251: hypothetical protein +FIG01545351 Modification methylase BslI (EC 2.1.1.113) (N(4)- cytosine-specific methyltransferase BslI) (M.BslI) +FIG01545355 putative 3-demethylubiquinone-9 3-O-methyltransferase( EC:2.1.1.64 ) +FIG01545357 Regulatory protein afsR +FIG01545395 glycosyl transferase, group 1 +FIG01545402 FIG00352909: hypothetical protein +FIG01545436 ferric aerobactin receptor +FIG01545448 Phosphorylase, Pnp/Udp family, putative +FIG01545450 entry exclusion protein 1 +FIG01545461 FIG00675035: hypothetical protein +FIG01545463 FIG00521122: hypothetical protein +FIG01545470 Transposase +FIG01545478 bacteriocin transport accessory protein +FIG01545487 FIG00533228: hypothetical protein +FIG01545505 Endoglucanase 3 precursor (EC 3.2.1.4) +FIG01545525 UPF0169 lipoprotein CC1984 precursor +FIG01545526 FIG00350626: hypothetical protein +FIG01545552 putative insecticidal toxin +FIG01545573 FIG00354367: hypothetical protein +FIG01545589 FIG01199758: hypothetical protein +FIG01545645 Putative terminal quinol oxidase, subunit DoxD +FIG01545702 3-hydroxy-3isohexenylglutaryl-CoA:acetate lyase +FIG01545716 iron-sulfur flavoprotein (isf) +FIG01545740 FIG00522352: hypothetical protein +FIG01545748 FIG01114360: hypothetical protein +FIG01545769 COG0531: Amino acid transporters +FIG01545775 Bll3417 protein +FIG01545808 FIG00403559: hypothetical protein +FIG01545822 probable lipase/esterase( EC:3.1.1.3 ) +FIG01545845 FIG00711740: hypothetical protein +FIG01545849 BapA +FIG01545856 SICP +FIG01545867 Putative Lactamase B ( Metallo-beta-lactamase superfamily) +FIG01545873 PROBABLE CONSERVED MEMBRANE PROTEIN +FIG01545903 FIG00404011: hypothetical protein +FIG01545905 Tn554-related, transposase A +FIG01545926 Amino acid permease, +FIG01545930 Chaperone-like protein +FIG01546025 COG0412: Dienelactone hydrolase and related enzymes +FIG01546066 FIG00388580: hypothetical protein +FIG01546077 FIG00355794: hypothetical protein +FIG01546085 FIG00389569: hypothetical protein +FIG01546096 Heat shock protein, Hsp20 family +FIG01546103 hypothetical protein +FIG01546106 ATPases of the AAA+ class +FIG01546123 FIG00821018: hypothetical protein +FIG01546133 TraG family protein +FIG01546142 FIG00622771: hypothetical protein +FIG01546164 FIG00385362: hypothetical protein +FIG01546179 FIG00827288: hypothetical protein +FIG01546189 putative P-loop ATPase +FIG01546193 Serine-threonine kinase Stk1( EC:2.7.1.37 ) +FIG01546196 FIG00403771: hypothetical protein +FIG01546197 syc1765_c +FIG01546219 probable sigma-54 modulation protein +FIG01546224 Capsule biosynthesis protein +FIG01546257 FIG00515576: hypothetical protein +FIG01546265 Sulfide dehydrogenase flavocytochrome C +FIG01546287 COG2944: Predicted transcriptional regulator +FIG01546299 FIG01211521: hypothetical protein +FIG01546305 FIG01134364: hypothetical protein +FIG01546320 FIG00768257: hypothetical protein +FIG01546325 Transposase, IS605 family +FIG01546329 Pilx2 protein +FIG01546334 insertion element IS2 transposase InsD +FIG01546339 FIG00630042: hypothetical protein +FIG01546353 Acylneuraminate cytidylyltransferase:Aminotransferase class-III +FIG01546358 FIG00351435: hypothetical protein +FIG01546361 FIG00640424: hypothetical protein +FIG01546383 FIG00758895: hypothetical protein +FIG01546402 hypothetical LOC575554 +FIG01546427 Protein of unknown function DUF1332 +FIG01546442 Beta-amylase precursor (EC 3.2.1.2) +FIG01546462 FIG00533775: hypothetical protein +FIG01546497 RecJ like exonuclease +FIG01546518 FIG00388973: hypothetical protein +FIG01546521 FIG00470306: hypothetical protein +FIG01546529 COG2000: Predicted Fe-S protein +FIG01546546 lipopolysaccharide biosynthesis polymerase, putative +FIG01546568 phage structural protein, truncation +FIG01546578 Phosphoribosylformimino-5-aminoimidazole carboxamide ribotide isomerase related protein +FIG01546591 flavodoxin family protein +FIG01546598 Hypothetical protein Cj1433c +FIG01546615 colicin I receptor precursor +FIG01546659 integral membrane protein (DUF81) +FIG01546663 putative ABC transporter nitrate-binding protein +FIG01546668 ferredoxin (3Fe-4S) +FIG01546690 FIG00624659: hypothetical protein +FIG01546692 FIG00344268: hypothetical protein +FIG01546695 type I restriction-modification system restriction subunit, truncated +FIG01546696 Bll7882 protein +FIG01546704 syc2028_d +FIG01546708 TRAM domain-containing protein +FIG01546720 Metabolite transporter +FIG01546729 HrpX protein +FIG01546735 FIG01136609: hypothetical protein +FIG01546767 FIG00426028: hypothetical protein +FIG01546770 Uncharacterized protein y4mC precursor +FIG01546780 prophage antirepressor +FIG01546799 Probable conserved lipoprotein LppL +FIG01546817 FIG00351906: hypothetical protein +FIG01546819 TPP-requiring enzyme co-localized with putative O-antigen rfb gene cluster +FIG01546823 glycoside hydrolase, family 76 +FIG01546824 FIG00762595: hypothetical protein +FIG01546825 putative DNA exonuclease X +FIG01546836 nucleotidyltransferase substrate-binding protein, putative +FIG01546845 FIG00351938: hypothetical protein +FIG01546861 Hydrolase, alpha/beta fold family protein, At1g52510/AT4G12830 homolog, group3 +FIG01546869 FIG00768313: hypothetical protein +FIG01546931 FIG00689553: hypothetical protein +FIG01546946 FIG00946374: hypothetical protein +FIG01546991 Mlr3260 protein +FIG01547002 FIG00352411: hypothetical protein +FIG01547035 transposase for ISSha1 +FIG01547039 putative transposase TnA +FIG01547052 YdjC family protein +FIG01547055 Uncharacterized protein MJ0273 +FIG01547074 FIG00349707: hypothetical protein +FIG01547084 YkoY family integral membrane protein +FIG01547089 COG2186: Transcriptional regulators +FIG01547091 FIG00407657: hypothetical protein +FIG01547111 Phosphate-selective porin O and P +FIG01547112 Colicin lysis protein +FIG01547161 putative primase +FIG01547179 alkanonic acid methyltransferase +FIG01547188 hypothetical protein +FIG01547216 Glutamate receptor 1 precursor +FIG01547221 FIG00641557: hypothetical protein +FIG01547225 Endoglucanase 5A (EC 3.2.1.4) (Endo-1,4-beta-glucanase 5A) (Alkaline cellulase) +FIG01547232 putative oligosaccharide deacetylase +FIG01547247 probable dipeptidyl aminopeptidase +FIG01547250 type IV secretion system protein VirB8, putative +FIG01547276 Acyl-CoA dehydrogenase (EC 1.3.99.-) +FIG01547312 FIG01135772: hypothetical protein +FIG01547329 Predicted beta-glucoside-regulated ABC transport system, permease component 2 +FIG01547337 FIG00873943: hypothetical protein +FIG01547353 FIG00519614: hypothetical protein +FIG01547367 Bifidobacterial FemAB-like protein type 4 +FIG01547374 Putative transport protein +FIG01547380 FIG00450903: hypothetical protein +FIG01547394 ABC-type nitrate/sulfonate/bicarbonate transport system ATPase component +FIG01547404 FIG00551342: hypothetical protein +FIG01547415 putative dinitrogenase iron-molybdenum cofactor +FIG01547417 FIG00816561: hypothetical protein +FIG01547425 conserved hypothetical ATP-binding protein +FIG01547427 Membrane transport protein +FIG01547444 Sec7-domain containing protein transport protein +FIG01547445 universal stress protein (Usp) +FIG01547446 hypothetical protein +FIG01547456 FIG00418458: hypothetical protein +FIG01547475 COGs COG0183 +FIG01547492 methyltransferase type 12 +FIG01547506 FIG00769105: hypothetical protein +FIG01547538 FIG00938469: hypothetical protein +FIG01547561 Modification methylase HaeII (EC 2.1.1.37) +FIG01547586 hypotheteical protein +FIG01547646 putative creatinine amidohydrolase +FIG01547649 protein of unknown function DUF1452 +FIG01547652 symbiosis island integrase +FIG01547659 putative transporter (MFS family) +FIG01547666 FIG01115390: hypothetical protein +FIG01547675 serine protease (membrane protein) +FIG01547683 rieske [2Fe-2S] domain protein +FIG01547687 FIG01047491: hypothetical protein +FIG01547690 FIG00409085: hypothetical protein +FIG01547734 FIG00355887: hypothetical protein +FIG01547743 phage tail assembly-like protein +FIG01547757 FIG00514942: hypothetical protein +FIG01547781 FIG00350751: hypothetical protein +FIG01547786 FIG01046335: hypothetical protein +FIG01547805 Disease resistance domain-containing protein / Tetratricopeptide repeat-containing protein / Transcriptional regulator, LuxR family +FIG01547827 FIG00520230: hypothetical protein +FIG01547849 hypothetical protein +FIG01547865 FIG01243825: hypothetical protein +FIG01547993 FIG00644276: hypothetical protein +FIG01548009 strongly similar to N-acetylmuramoyl-L-alanine amidase (T7 lysozyme) +FIG01548074 TonB-dependent receptor, plug +FIG01548080 SdbB +FIG01548088 FIG01246143: hypothetical protein +FIG01548139 ORF_ID:alr7576 unknown protein +FIG01548147 FIG00865806: hypothetical protein +FIG01548153 FIG00830541: hypothetical protein +FIG01548161 Alr0614 protein +FIG01548186 glutamine transport protein glnQ +FIG01548187 MobC-like protein +FIG01548216 FIG00850448: hypothetical protein +FIG01548219 Lyase +FIG01548227 FIG00534214: hypothetical protein +FIG01548261 Uncharacterized protein MJ1634 +FIG01548290 FIG00900393: hypothetical protein +FIG01548291 tRNA 2-thiouridine synthesizing protein E (EC 2.8.1.-) +FIG01548303 hypothetical protein +FIG01548305 Che cluster related two-component response regulator +FIG01548307 FIG00555279: hypothetical protein +FIG01548309 Gamma-aminobutyrate permease and related permeases +FIG01548334 FIG00388819: hypothetical protein +FIG01548356 G-protein beta WD-40 repeat precursor +FIG01548392 Lin2582 protein +FIG01548401 ankyrin repeat domain protein +FIG01548432 Transcriptional regulator, XRE family +FIG01548503 putative beta-lactamase +FIG01548512 FIG00640538: hypothetical protein +FIG01548526 RloF, putative +FIG01548528 zinc finger, UBP-type +FIG01548546 FIG00623718: hypothetical protein +FIG01548587 hypothetical protein +FIG01548597 hypothetical protein +FIG01548598 Degenerate transposase (orf2) +FIG01548656 FIG00640842: hypothetical protein +FIG01548669 possible integral-membrane protein +FIG01548676 FIG00403686: hypothetical protein +FIG01548678 FIG00440276: hypothetical protein +FIG01548685 Mlr4813 protein +FIG01548694 FIG00713107: hypothetical protein +FIG01548701 Transcription regulator AbrB +FIG01548709 FIG00748538: hypothetical protein +FIG01548735 FIG00525910: hypothetical protein +FIG01548769 FIG00624600: hypothetical protein +FIG01548777 FIG01167265: hypothetical protein +FIG01548793 similar to DNA-binding protein +FIG01548795 hypothetical protein +FIG01548801 FIG00404871: hypothetical protein +FIG01548844 FIG00623250: hypothetical protein +FIG01548849 contains sodium/hydrogen exchanger family domain +FIG01548859 flavin-dependent oxidoreductase +FIG01548869 hypothetical protein +FIG01548874 FIG00411249: hypothetical protein +FIG01548900 Uncharacterized Zn-finger protein +FIG01548906 FIG00624536: hypothetical protein +FIG01548910 hypothetical protein NMA1226 +FIG01548911 FIG00710914: hypothetical protein +FIG01548931 Signal transduction response regulator / Transcriptional regulator, LuxR family +FIG01548952 Regulatory protein related to malT, positive regulator of mal regulon (ATPase and HTH-type DNA-binding domain) +FIG01548957 IS629 ORF2 +FIG01548974 Uncharacterized protein yxbA +FIG01548980 FIG00640752: hypothetical protein +FIG01549038 FIG01205727: hypothetical protein +FIG01549041 Probable resuscitation-promoting factor rpfB +FIG01549042 FIG00921500: hypothetical protein +FIG01549061 Uncharacterized protein MJ0481 +FIG01549062 FIG00344210: hypothetical protein +FIG01549077 FIG00344279: hypothetical protein +FIG01549082 All2314 protein +FIG01549094 TfoX N-terminal domain family protein +FIG01549143 Vng0814c +FIG01549148 FIG00769394: hypothetical protein +FIG01549160 FIG00347731: hypothetical protein +FIG01549177 COG5012: Predicted cobalamin binding protein +FIG01549235 FIG00389042: hypothetical protein +FIG01549248 Repeat organellar protein-related +FIG01549331 permease component of ABC transporter +FIG01549372 FIG00734481: hypothetical protein +FIG01549384 Polyprotein +FIG01549385 FIG00769949: hypothetical protein +FIG01549388 FIG01129912: hypothetical protein +FIG01549404 Putative xylulose kinase +FIG01549419 B-cell receptor associated protein-related protein +FIG01549451 putative membrane protein (DUF1211 family) +FIG01549453 FIG00343843: hypothetical protein +FIG01549458 putative exported protease/peptidase +FIG01549471 hypothetical protein Rrub02001449 +FIG01549473 FIG00352467: hypothetical protein +FIG01549525 Mll3930 protein +FIG01549534 FIG01212014: hypothetical protein +FIG01549549 ortholog of Bordetella pertussis (BX470248) BP2465 +FIG01549552 FIG01136631: hypothetical protein +FIG01549556 ABC-type transport system periplasmic substrate-binding protein +FIG01549575 FIG00244801: hypothetical protein +FIG01549604 heparin-binding hemagglutinin +FIG01549622 FIG01243548: hypothetical protein +FIG01549633 Predicted signal transduction protein containing Nacht domain +FIG01549673 FKBP-type peptidyl-prolyl cis-trans isomerase slyD (EC 5.2.1.8) +FIG01549691 FIG00558632: hypothetical protein +FIG01549696 Acetyltransferase, GNAT family family +FIG01549740 FIG00385366: hypothetical protein +FIG01549769 Protein of unknown function DUF1810 +FIG01549777 Glutamate carboxypeptidase II( EC:3.4.17.21 ) +FIG01549786 CopG-like DNA-binding protein +FIG01549797 FIG00411629: hypothetical protein +FIG01549843 COG4832: Uncharacterized conserved protein +FIG01549858 FIG00527363: hypothetical protein +FIG01549864 isoleucyl-tRNA synthetase( EC:6.1.1.5 ) +FIG01549869 FIG00404852: hypothetical protein +FIG01549901 OLIGOPEPTIDE TRANSPORT ATP-BINDING PROTEIN OPPD +FIG01549958 FIG00261907: hypothetical protein +FIG01549965 hypothetical protein +FIG01549983 Dihydroorotase and related cyclic amidohydrolases +FIG01550012 FIG00624768: hypothetical protein +FIG01550026 transcriptional regulator, DeoR family protein +FIG01550032 FIG00427083: hypothetical protein +FIG01550036 putative MarC family integral membrane protein +FIG01550061 Glycosyltransferases, probably involved in cell wall biogenesis +FIG01550089 FIG00423779: hypothetical protein +FIG01550112 Phage immunity repressor +FIG01550130 arabinogalactan endo-1,4-beta-galactosidase +FIG01550134 hypothetical protein +FIG01550157 FIG00687303: hypothetical protein +FIG01550187 Parathion hydrolase (EC 3.1.8.1) +FIG01550194 Gll1168 protein +FIG01550228 FIG00511238: hypothetical protein +FIG01550233 protein of unknown function DUF1025 +FIG01550240 Sterol-binding domain protein +FIG01550249 protein of unknown function DUF1009 +FIG01550261 RofA-like transcriptional regulator RALP3 +FIG01550315 FIG00363285: hypothetical protein +FIG01550317 FIG00639744: hypothetical protein +FIG01550318 Putative inner membrane protein +FIG01550357 hypothetical protein +FIG01550368 Uncharcterized conserved membrane protein, YXAI B.subtilis homolog +FIG01550383 COG0184: Ribosomal protein S15P/S13E +FIG01550435 probable vgr related protein +FIG01550485 FIG00520460: hypothetical protein +FIG01550523 FIG00624726: hypothetical protein +FIG01550539 FIG01028059: hypothetical protein +FIG01550540 FIG00733248: hypothetical protein +FIG01550562 FIG00467464: hypothetical protein +FIG01550593 3-alpha-(or 20-beta)-hydroxysteroid dehydrogenase (EC 1.1.1.53) +FIG01550643 FIG00700859: hypothetical protein +FIG01550648 Uncharacterized protein Rv2079/MT2140 +FIG01550662 phosphotransferase (aminonucleoside antibiotic resistance) +FIG01550677 Putative bacteriophage protein +FIG01550678 hypothetical protein +FIG01550685 ABC-type glycine betaine transport, permease protein +FIG01550692 Putative phage excisionase +FIG01550693 putative transcriptional regulator, putative two-component response regulator +FIG01550751 FIG01205671: hypothetical protein +FIG01550752 Autolytic lysozyme (EC 3.2.1.17) (1,4-beta-N-acetylmuramidase) (Autolysin) +FIG01550779 Acyl CoA:acetate/3-ketoacid CoA transferase, beta subunit +FIG01550790 FIG00413876: hypothetical protein +FIG01550830 Trypsin beta precursor (EC 3.4.21.4) +FIG01550883 Fusobacterium outer membrane protein family +FIG01550909 FIG00768436: hypothetical protein +FIG01550916 FIG00388131: hypothetical protein +FIG01550926 Transmembrane transport protein MmpL11 +FIG01550982 Ssr5117 protein +FIG01550988 FIG00847963: hypothetical protein +FIG01551008 Lin2395 protein +FIG01551049 hypothetical protein +FIG01551092 CONSERVED HYPOTHETICAL PROTEIN-PLASMID ENCODED +FIG01551128 FIG00407480: hypothetical protein +FIG01551142 Uncharacterized protein MJ0504 +FIG01551169 Acyl-CoA dehydrogenase, type 2-like +FIG01551185 Aldo/keto reductase:4Fe-4S ferredoxin, iron-sulfur binding +FIG01551196 FIG00413379: hypothetical protein +FIG01551211 branched amino acid transport system permease +FIG01551215 FIG00886068: hypothetical protein +FIG01551277 iron-containing alcohol dehydrogenase +FIG01551281 Bacterial ring hydroxylating dioxygenase alpha subunit +FIG01551287 hypothetical protein-putative metallopeptidase +FIG01551296 FIG00388244: hypothetical protein +FIG01551313 Bll5650 protein +FIG01551337 drug:proton antiporter +FIG01551351 UPF0272 protein Slr1411 +FIG01551356 response regulator receiver and SARP domain protein +FIG01551385 FIG00361726: hypothetical protein +FIG01551416 FIG00570466: hypothetical protein +FIG01551456 DSBA-like thioredoxin family protein +FIG01551469 Transposase +FIG01551559 Hydrogenase maturation factor hoxL +FIG01551578 FIG00495861: hypothetical protein +FIG01551591 Branched-chain amino acid ABC transporter, binding protein +FIG01551593 bacteriophage f237 ORF9 +FIG01551654 FIG00426623: hypothetical protein +FIG01551669 FIG00527230: hypothetical protein +FIG01551714 Osmotically inducible lipoprotein B precursor +FIG01551752 FIG00849371: hypothetical protein +FIG01551763 possible Alpha-2-macroglobulin family N-termin +FIG01551780 Sigma-54 dependent transcriptional activator +FIG01551783 FIG00414220: hypothetical protein +FIG01551792 Response regulator (CheY domain, HTH domain) +FIG01551805 COG4122: Predicted O-methyltransferase +FIG01551814 putative large multi-functional protein +FIG01551818 FIG00623706: hypothetical protein +FIG01551860 Replication protein +FIG01551863 nifU domain protein +FIG01551871 transporter, solute:sodium symporter (SSS) family +FIG01551876 FIG01167110: hypothetical protein +FIG01551942 protein up-regulated by thyroid hormone-putative PQQ-dependent glucose dehydrogenase +FIG01551980 FIG00816530: hypothetical protein +FIG01551982 Transcriptional activator adenine-specific DNA methyltransferase-like +FIG01552007 NisR +FIG01552045 transposase, IS204/IS1001/IS1096/IS1165 +FIG01552077 Sec-independent protein translocase protein +FIG01552120 FIG00839876: hypothetical protein +FIG01552126 FIG00764599: hypothetical protein +FIG01552137 FIG00403960: hypothetical protein +FIG01552140 FIG00353481: hypothetical protein +FIG01552188 FIG01166733: hypothetical protein +FIG01552222 FIG01241703: hypothetical protein +FIG01552266 FIG00410242: hypothetical protein +FIG01552287 ISRSO10-TRANSPOSASE ORFA PROTEIN +FIG01552299 FIG01029284: hypothetical protein +FIG01552302 FIG00411978: hypothetical protein +FIG01552325 flagellar assembly protein FliH, putative +FIG01552357 FIG00350696: hypothetical protein +FIG01552358 hypothetical protein +FIG01552399 Chorismate synthase (EC 4.2.3.5) +FIG01552415 FIG00513755: hypothetical protein +FIG01552423 GAF:ATP-binding region, ATPase-like:Histidine kinase A, N-terminal +FIG01552424 FIG00734419: hypothetical protein +FIG01552475 FIG00350488: hypothetical protein +FIG01552488 FIG00673744: hypothetical protein +FIG01552542 Sensory box protein, EAL domain, GGDEF domain, signal transduction protein +FIG01552578 S-layer homology region +FIG01552601 Von Willebrand factor, type A precursor +FIG01552733 Membrane-spanning protein +FIG01552765 putative protein secretion protein, HlyD family +FIG01552804 ABC transporter ATP-binding protein +FIG01552808 FIG01048275: hypothetical protein +FIG01552831 SpvD +FIG01552839 FIG00800983: hypothetical protein +FIG01552895 FIG00623108: hypothetical protein +FIG01552909 putative integrase +FIG01552913 P30 adhesin +FIG01552931 FIG01133203: hypothetical protein +FIG01552952 beta-lactamase regulatory protein 1 +FIG01552978 COG0748: Putative heme iron utilization protein +FIG01552981 FIG00528862: hypothetical protein +FIG01552990 FIG01244156: hypothetical protein +FIG01552995 PTS system, mannose-specific IIAB component( EC:2.7.1.69 ) +FIG01552997 FIG00528875: hypothetical protein +FIG01553003 FIG00361984: hypothetical protein +FIG01553004 Conserved Membrane Protein (Archaea) +FIG01553044 hypothetical protein +FIG01553050 fructosyl-amino acid oxidase, putative +FIG01553064 hypothetical protein +FIG01553105 FIG00433744: hypothetical protein +FIG01553139 FIG00361435: hypothetical protein +FIG01553173 FIG00380661: hypothetical protein +FIG01553210 FIG00527947: hypothetical protein +FIG01553215 Transcriptional regulator LysR family +FIG01553239 hypothetical protein +FIG01553240 FIG00513680: hypothetical protein +FIG01553255 FIG00361245: hypothetical protein +FIG01553263 Putative transmembrane acyltransferase +FIG01553286 Tfp pilus assembly protein FimV +FIG01553289 FIG00638624: hypothetical protein +FIG01553313 dithiol-disulfide isomerase involved in polyketide biosynthesis-like protein +FIG01553325 FIG01120691: hypothetical protein +FIG01553332 COG0667: Predicted oxidoreductases (related to aryl-alcohol dehydrogenases) +FIG01553351 region 2 capsular polysaccharide biosynthesis protein +FIG01553362 L-lysine dehydrogenase +FIG01553445 FIG01136066: hypothetical protein +FIG01553448 carotenoid biosynthetic protein CrtK +FIG01553489 transcriptional regulator Spx +FIG01553507 Anaerobic glycerol-3-phosphate dehydrogenase subunit C +FIG01553516 related to SanF from Streptomyces ansochromogenes +FIG01553532 carboxypeptidase G2 +FIG01553540 biosynthesis of stilbenes, flavonoids +FIG01553582 FIG01115876: hypothetical protein +FIG01553594 SdhB protein, substrate of the Dot/Icm system +FIG01553599 FIG00354222: hypothetical protein +FIG01553610 IS, phage, Tn; Transposon-related functions +FIG01553631 hypothetical protein +FIG01553636 Transposase, mutator type +FIG01553660 outer membrane organization +FIG01553687 Ribosomal RNA adenine dimethylase +FIG01553701 Protein Mom +FIG01553713 putative cro protein +FIG01553746 FIG00756144: hypothetical protein +FIG01553750 plasmid replication and transfer +FIG01553791 possible DnaJ central domain (4 repeats) +FIG01553797 FIG00746374: hypothetical protein +FIG01553828 FIG00262686: hypothetical protein +FIG01553867 PTS system, nitrogen regulatory IIA component +FIG01553902 FIG00413070: hypothetical protein +FIG01553923 response regulator receiver (CheY-like) and ANTAR domain protein +FIG01553982 syc0482_c +FIG01554007 protein of unknown function DUF29 +FIG01554025 FIG00624831: hypothetical protein +FIG01554041 Na/Pi cotransporter II-related +FIG01554089 PROTEIN YBIS PRECURSOR +FIG01554105 plasmid replication initiator protein +FIG01554148 L-fuco-beta-pyranose dehydrogenase (EC 1.1.1.122) +FIG01554172 protein of unknown function DUF1063 +FIG01554178 Predicted L-lactate dehydrogenase, Fe-S oxidoreductase subunit YkgE +FIG01554210 internalin A-like protein/putative S-layer protein +FIG01554219 protein of unknown function UPF0175 +FIG01554264 FIG00348011: hypothetical protein +FIG01554277 molybdenum transport domain protein +FIG01554291 Oxidoreductase (EC 1.-.-.-) +FIG01554301 putative modulator of drug activity +FIG01554381 Dextranase precursor (EC 3.2.1.11) +FIG01554404 molybdopterin-converting factor subunit 1 +FIG01554405 FIG00351336: hypothetical protein +FIG01554426 FIG00402773: hypothetical protein +FIG01554448 Integral membrane protein +FIG01554449 hypothetical protein +FIG01554464 FIG01135370: hypothetical protein +FIG01554487 probable ATP-dependent DNA helicase +FIG01554489 FIG00351916: hypothetical protein +FIG01554492 FIG00733635: hypothetical protein +FIG01554535 sensor histidine kinase +FIG01554565 peptidase M6, immune inhibitor A +FIG01554575 Possible cell surface protein +FIG01554605 FIG01092143: hypothetical protein +FIG01554607 FIG00624238: hypothetical protein +FIG01554624 FIG00452114: hypothetical protein +FIG01554645 K+-transporting ATPase, F subunit +FIG01554699 Thioredoxin domain protein +FIG01554766 FIG00551500: hypothetical protein +FIG01554781 FIG01110531: hypothetical protein +FIG01554783 ABC-type sugar transport system, permease component UgpE +FIG01554798 FIG00385455: hypothetical protein +FIG01554810 ParA protein +FIG01554823 FIG00564192: hypothetical protein +FIG01554903 FIG00766476: hypothetical protein +FIG01554939 putative O-acetyltransferase +FIG01554968 Excinuclease ABC C subunit domain protein +FIG01554988 Chymotrypsinogen B precursor (EC 3.4.21.1) +FIG01555027 FIG00434865: hypothetical protein +FIG01555033 Uncharacterized protein ywdI +FIG01555042 sterol desaturase family protein, putative +FIG01555051 FIG00623468: hypothetical protein +FIG01555058 hypothetical protein +FIG01555069 FIG00816740: hypothetical protein +FIG01555079 (Uracil-5)-methyltransferase +FIG01555091 Possible rhamnose ABC transporter, permease component 2 +FIG01555094 A2-5a orf8; hypothetical protein +FIG01555132 bacteriophage transposase A protein, putative +FIG01555133 FIG00469621: hypothetical protein +FIG01555168 lipoprotein OprI, putative +FIG01555172 FIG00387990: hypothetical protein +FIG01555183 Lantibiotic biosynthesis protein +FIG01555210 FIG00756813: hypothetical protein +FIG01555228 putative ABC transporter, permease +FIG01555263 Lipoprotein A family protein +FIG01555278 ATPas +FIG01555287 FIG01166358: hypothetical protein +FIG01555291 FIG00531208: hypothetical protein +FIG01555331 Azurin precursor +FIG01555344 FIG00385523: hypothetical protein +FIG01555349 Prophage Lp2 protein 16 +FIG01555377 COG0568: DNA-directed RNA polymerase, sigma subunit (sigma70/sigma32) +FIG01555378 FIG00936210: hypothetical protein +FIG01555439 Petrobactin ABC transporter, permease protein II +FIG01555470 FIG00895149: hypothetical protein +FIG01555528 FIG00350529: hypothetical protein +FIG01555540 Mll5052 protein +FIG01555588 FIG00623261: hypothetical protein +FIG01555616 biotin carboxyl carrier protein (BCCP) +FIG01555635 FIG00356740: hypothetical protein +FIG01555637 Alcohol dehydrogenase, zinc-binding +FIG01555646 FIG01166887: hypothetical protein +FIG01555676 FIG00966261: hypothetical protein +FIG01555679 FIG00748597: hypothetical protein +FIG01555706 UDP-glucose-beta-D-glucan glucosyltransferase +FIG01555707 FIG00408892: hypothetical protein +FIG01555717 probable transcriptional regulatory, LuxR family +FIG01555744 FIG00580956: hypothetical protein +FIG01555758 FIG00520231: hypothetical protein +FIG01555760 FIG00347584: hypothetical protein +FIG01555775 FIG01169746: hypothetical protein +FIG01555785 ABC transporter ATP-binding protein +FIG01555851 glutamate binding periplasmic protein +FIG01555856 FIG00733268: hypothetical protein +FIG01555921 Probable sugar kinase +FIG01555951 TldD/PmbA family protein +FIG01555962 FIG00352057: hypothetical protein +FIG01556015 YedB +FIG01556074 N-terminal fragment of SPy0560 +FIG01556082 FIG00413619: hypothetical protein +FIG01556083 ABC nitrate/sulfonate/bicarbonate transporter, inner membrane subunit +FIG01556116 Bll4535 protein +FIG01556122 Bacterial sugar transferase +FIG01556124 Protein ybiS precursor +FIG01556142 FIG00750179: hypothetical protein +FIG01556146 FIG00411991: hypothetical protein +FIG01556149 Uncharacterized protein aq_2144 +FIG01556162 FIG01077591: hypothetical protein +FIG01556164 FIG00687705: hypothetical protein +FIG01556191 FIG00753853: hypothetical protein +FIG01556238 Poly granule associated +FIG01556259 FIG00344637: hypothetical protein +FIG01556266 Carboxymuconolactone decarboxylase domain protein +FIG01556274 FIG00417110: hypothetical protein +FIG01556286 FIG00775124: hypothetical protein +FIG01556315 FIG00755049: hypothetical protein +FIG01556325 FIG00361653: hypothetical protein +FIG01556342 Outer membrane protein Lom +FIG01556353 FIG00647252: hypothetical protein +FIG01556355 Transcription initiation factor IIIA +FIG01556416 ORF_ID:alr5182 +FIG01556432 Uncharacterized protein MJ0327 +FIG01556433 FIG00815102: hypothetical protein +FIG01556449 FIG00765506: hypothetical protein +FIG01556455 DNA polymerase III, alpha subunit( EC:2.7.7.7 ) +FIG01556458 ATP-dependent Clp protease adaptor protein ClpS, putative +FIG01556464 FIG01248758: hypothetical protein +FIG01556488 FIG00523901: hypothetical protein +FIG01556493 Possible esterase +FIG01556504 Tn5252, relaxase +FIG01556516 FIG00348804: hypothetical protein +FIG01556522 FIG00352502: hypothetical protein +FIG01556531 Racemase, Asp/Glu/Hydantoin family +FIG01556561 Glycosyltransferase (group I) +FIG01556565 polysaccharide polymerase +FIG01556626 Domain of unknown function domain protein +FIG01556628 dipeptide ABC transporter permease +FIG01556658 Cold-shock protein, DNA-binding +FIG01556665 Major acid phosphatase Map +FIG01556679 Rhs-family protein +FIG01556694 Helix-turn-helix type 11 domain protein +FIG01556775 Asr4321 protein +FIG01556784 Tn7-like transposition protein A +FIG01556808 Uncharacterized protein Rv1258c/MT1297 +FIG01556823 hypothetical protein +FIG01556824 FIG00766009: hypothetical protein +FIG01556832 Nodulin 21-related protein +FIG01556836 syc1384_d +FIG01556842 FIG00622818: hypothetical protein +FIG01556843 Putative Rieske (2Fe-2S) family oxidoreductase, large subunit +FIG01556949 FIG00522614: hypothetical protein +FIG01556950 Amino acid (probably glutamine) ABC transporter, periplasmic binding protein component +FIG01556953 endo-1,4-beta glucanase +FIG01556992 FIG00426572: hypothetical protein +FIG01557002 ABC transporter, family 2 +FIG01557061 Diaminopimelate epimerase homolog +FIG01557075 FIG01134552: hypothetical protein +FIG01557079 gp5 +FIG01557088 transcriptional regulatory protein-like +FIG01557101 hypothetical protein +FIG01557151 FIG00817514: hypothetical protein +FIG01557153 FIG00356229: hypothetical protein +FIG01557185 Hypothetical conjugal transfer protein, TrbC +FIG01557186 poly (3-hydroxybutyrate) depolymerase +FIG01557195 FIG00349705: hypothetical protein +FIG01557247 FIG00344841: hypothetical protein +FIG01557289 lacX protein +FIG01557291 Lyzozyme M1 (1,4-beta-N-acetylmuramidase) (EC 3.2.1.17) +FIG01557309 probable membrane protein YPO2316 +FIG01557318 SH3 type 3 domain protein +FIG01557413 Endoglucanase D precursor (EC 3.2.1.4) +FIG01557414 ORF055 +FIG01557435 transcription factor nitR +FIG01557484 Bifunctional ABC transporter +FIG01557487 Probable Haloacid dehalogenase, type II +FIG01557501 ORF_ID:alr7553 unknown protein +FIG01557520 Possible regulator pra-like protein +FIG01557522 hypothetical protein +FIG01557548 4-aminobutyrate aminotransferase +FIG01557582 Coenzyme A pyrophosphatase, nudix hydrolase family +FIG01557587 Gp30 protein +FIG01557616 FIG00733169: hypothetical protein +FIG01557619 Heme exporter protein D (CcmD) +FIG01557630 FIG00624400: hypothetical protein +FIG01557632 FIG00344421: hypothetical protein +FIG01557645 FIG00350031: hypothetical protein +FIG01557697 FIG00517350: hypothetical protein +FIG01557716 FIG00458345: hypothetical protein +FIG01557732 FIG01048941: hypothetical protein +FIG01557740 FIG00251280: hypothetical protein +FIG01557762 Diadenosine tetraphosphate hydrolase +FIG01557827 FIG00344364: hypothetical protein +FIG01557843 Aspartate dehydrogenase homolog +FIG01557857 FIG01116963: hypothetical protein +FIG01557863 MxiN +FIG01557882 Dolichyl phosphate glucosyltransferase +FIG01557884 FIG01239554: hypothetical protein +FIG01557894 MmcQ-like protein +FIG01557903 FIG00624402: hypothetical protein +FIG01557919 FIG00365005: hypothetical protein +FIG01557925 FIG00415494: hypothetical protein +FIG01557946 M. jannaschii predicted coding region MJ0978 +FIG01557950 FIG00406293: hypothetical protein +FIG01557959 Possible xylan degradation enzyme (glycosyl hydrolase family 30-like domain and Ricin B-like domain) +FIG01557988 unknown; predicted coding region +FIG01557994 Dentin sialophosphoprotein precursor +FIG01557997 FIG00522543: hypothetical protein +FIG01558003 Putative transposase y4qJ +FIG01558018 FIG00406984: hypothetical protein +FIG01558022 hypothetical protein +FIG01558023 FIG01110068: hypothetical protein +FIG01558038 Repeat motif gene A protein +FIG01558039 FIG00363181: hypothetical protein +FIG01558047 Alpha/beta hydrolase fold precursor +FIG01558062 EBNA-1 +FIG01558087 FIG00361440: hypothetical protein +FIG01558125 FIG00849104: hypothetical protein +FIG01558167 FIG00253762: hypothetical protein +FIG01558182 FIG00525068: hypothetical protein +FIG01558231 ABC transporter-related protein +FIG01558265 FIG00838163: hypothetical protein +FIG01558278 maoC protein (maoC) +FIG01558289 hypothetical protein( EC:3.4.21.10 ) +FIG01558301 FIG00405040: hypothetical protein +FIG01558303 glycosyltransferase( EC:2.4.1.- ) +FIG01558306 putative regulatory protein,conserved in anaerobic benzoate degadation gene clusters +FIG01558316 conserved hypothetical protein; putative conserved domain +FIG01558321 FIG00623365: hypothetical protein +FIG01558348 Choline-glycine betaine transporter +FIG01558365 FIG00733178: hypothetical protein +FIG01558371 FIG00871072: hypothetical protein +FIG01558384 FIG00411828: hypothetical protein +FIG01558386 2x Universal stress protein A (2UspA) +FIG01558396 FIG00353618: hypothetical protein +FIG01558433 cell wall-associated protein +FIG01558477 FIG00424815: hypothetical protein +FIG01558520 NLP/P60 family protein +FIG01558525 FIG00766161: hypothetical protein +FIG01558532 TVG0696003 protein +FIG01558634 ISDet4, transposase +FIG01558643 Nodulation protein U (EC 2.1.3.-) +FIG01558676 similar to puromycin N-acetyltransferase +FIG01558700 BH0953 unknown conserved protein in B. subtilis +FIG01558733 dtdp-glucose-46-dehydratase +FIG01558737 protein kinase domain protein +FIG01558745 hypothetical protein +FIG01558749 phage transcriptional regulator, ArpU family subfamily +FIG01558789 FIG01199081: hypothetical protein +FIG01558791 transcriptional pleiotropic regulator of transition state genes +FIG01558802 FIG00352264: hypothetical protein +FIG01558805 syc0187_c +FIG01558816 FAD linked oxidase-like protein +FIG01558838 Ais protein, putative +FIG01558850 cell divisionFtsK/SpoIIIE +FIG01558854 transposase IS1296EH (ORFA), putative +FIG01558856 FIG01236397: hypothetical protein +FIG01558894 ubiquinol cytochrome c cyanide insensitive terminal oxidase +FIG01558965 Gifsy-2 prophage lysozyme( EC:3.2.1.17 ) +FIG01558982 FIG00349534: hypothetical protein +FIG01559027 putative periplasmic substrate-binding protein +FIG01559054 FIG00416614: hypothetical protein +FIG01559069 FIG00361956: hypothetical protein +FIG01559076 FIG00537023: hypothetical protein +FIG01559108 FIG00515799: hypothetical protein +FIG01559124 FIG00687897: hypothetical protein +FIG01559144 FIG00828509: hypothetical protein +FIG01559145 IcmT +FIG01559183 FIG01015690: hypothetical protein +FIG01559231 outer membrane protein (porin) +FIG01559258 non-ribosomal peptide synthetase/polyketide synthase +FIG01559278 Phage replication initiation +FIG01559295 Bacterial/Archaeal Transporter family protein +FIG01559300 Diphthine synthase (EC 2.1.1.98) +FIG01559311 histone H1-like protein +FIG01559316 FIG00624253: hypothetical protein +FIG01559328 hypothetical protein +FIG01559331 sensory box/GGDEF family protein +FIG01559342 FIG00354277: hypothetical protein +FIG01559392 POSSIBLE TRANSMEMBRANE PROTEIN +FIG01559395 CDS_ID OB0639 +FIG01559399 nudix/MutT family protein, putative +FIG01559427 Thiosulfate sulfurtransferase, rhodanase (EC 2.8.1.1) +FIG01559433 FIG00389000: hypothetical protein +FIG01559439 FIG00432056: hypothetical protein +FIG01559442 FIG00644916: hypothetical protein +FIG01559445 Gll4225 protein +FIG01559491 FIG00514981: hypothetical protein +FIG01559506 protein of unknown function DUF1552 +FIG01559526 FIG00623453: hypothetical protein +FIG01559584 FIG00385206: hypothetical protein +FIG01559612 FIG00622986: hypothetical protein +FIG01559629 Uncharacterized protein TP_0126 +FIG01559640 COGs COG2854 +FIG01559644 putative restriction endonuclease +FIG01559661 FIG00622955: hypothetical protein +FIG01559676 Pli0075 protein +FIG01559682 putative secreted glycosyl hydrolase +FIG01559683 FIG00537971: hypothetical protein +FIG01559692 FIG00456489: hypothetical protein +FIG01559734 ybiA +FIG01559762 FIG00352577: hypothetical protein +FIG01559769 FIG00412289: hypothetical protein +FIG01559772 Predicted succinate dehydrogenase, flavoprotein subunit +FIG01559786 extracellular solute-binding protein +FIG01559790 Capsule polysaccharide export protein +FIG01559800 probable DNA-directed RNA polymerase, beta' subunit/160 kD subunit; COG0086 +FIG01559808 putative chemotaxis sensory protein +FIG01559833 Prefoldin beta subunit (GimC beta subunit) +FIG01559846 Glr2153 protein +FIG01559892 FIG00344756: hypothetical protein +FIG01559911 Linoleoyl-CoA desaturase (EC 1.14.19.3) (Delta(6)-desaturase) +FIG01559920 FIG01108371: hypothetical protein +FIG01559926 ISXo5 transposase +FIG01559927 FIG00624113: hypothetical protein +FIG01559951 FIG01109839: hypothetical protein +FIG01559983 signal transduction protein +FIG01559991 FIG00525581: hypothetical protein +FIG01559998 putative cytochrome c oxidase, subunit I +FIG01560010 FIG00408604: hypothetical protein +FIG01560036 FIG01116890: hypothetical protein +FIG01560052 FIG00633028: hypothetical protein +FIG01560076 Glycosyl transferase, group 1 +FIG01560081 O-actetyl transferase related protein +FIG01560086 ATP-dependent DNA helicase pcrA +FIG01560088 putative lysis protein +FIG01560115 tRNA dihydrouridine synthase B like +FIG01560125 FIG01244008: hypothetical protein +FIG01560129 Probable dipeptidase A (EC 3.4.-.-) +FIG01560153 MSHA pilin protein MshA BUT NOT +FIG01560182 FIG01049718: hypothetical protein +FIG01560188 FIG00904992: hypothetical protein +FIG01560207 Prophage ps2 protein 16 +FIG01560257 Transcriptional regulator, AraC family, homolog 1 +FIG01560281 OLIGOPEPTIDE TRANSPORT ATP-BINDING PROTEIN OPPD +FIG01560283 FIG00388182: hypothetical protein +FIG01560309 FIG00769688: hypothetical protein +FIG01560310 Uvs066 +FIG01560336 FIG01002416: hypothetical protein +FIG01560356 FIG00815113: hypothetical protein +FIG01560362 FIG00349555: hypothetical protein +FIG01560374 hypothetical protein +FIG01560381 Probable racemase +FIG01560382 site-specific DNA recombinase +FIG01560390 DNA-binding protein HU, putative +FIG01560391 FIG01252781: hypothetical protein +FIG01560428 aqualysin-1( EC:3.4.21.- ) +FIG01560482 Protein translocase subunit SecE +FIG01560503 Exonuclease +FIG01560506 core protein +FIG01560512 opine ABC transporter, ATP-binding protein, putative +FIG01560525 Metalloprotease +FIG01560533 FIG00361411: hypothetical protein +FIG01560559 Uncharacterized conserved protein (some members contain a von Willebrand factor type A (vWA) domain) +FIG01560624 bacteriophage integrase +FIG01560647 hypothetical O-linked GlcNAc transferase +FIG01560662 Yersiniabactin synthetase, thiazolinyl reductase component Irp3 +FIG01560691 FIG00388699: hypothetical protein +FIG01560718 Serine O-acetyltransferase( EC:2.3.1.30 ) +FIG01560789 chemotaxis response regulator +FIG01560819 NADH-dependent flavin oxidoreductase, Oye family +FIG01560873 FIG00349182: hypothetical protein +FIG01560913 Mlr3257 protein +FIG01560924 FIG00765030: hypothetical protein +FIG01560931 Integral membrane protein (Rhomboid family) +FIG01560938 FIG01198050: hypothetical protein +FIG01560950 hypothetical protein +FIG01560957 hypothetical protein +FIG01560966 putative RebB like protein +FIG01560988 tetracyclin repressor, C- all-alpha domain protein +FIG01561015 FIG00673842: hypothetical protein +FIG01561017 FIG00384909: hypothetical protein +FIG01561033 carboxy-terminal peptidase +FIG01561048 ATPase, AAA family, putative +FIG01561056 FIG01260812: hypothetical protein +FIG01561065 FIG00530220: hypothetical protein +FIG01561068 short-chain alcohol dehydrogenase family +FIG01561079 Prophage LambdaBa03, transcriptional regulator domain protein +FIG01561092 FIG00355954: hypothetical protein +FIG01561097 FIG00537043: hypothetical protein +FIG01561103 probable peptide synthetase protein +FIG01561105 hypothetical protein +FIG01561116 FIG00911518: hypothetical protein +FIG01561153 FIG00415983: hypothetical protein +FIG01561169 FIG00273054: hypothetical protein +FIG01561181 FIG00406301: hypothetical protein +FIG01561192 Hydrolase of alpha/beta superfamily, possible membrane associated lipase +FIG01561195 membrane protein containing CBS domain +FIG01561218 prophage ps3 protein 15 +FIG01561219 FIG00513215: hypothetical protein +FIG01561221 conserved hypothetical protein +FIG01561229 FIG01238247: hypothetical protein +FIG01561258 possible high light inducible polypeptide HliC +FIG01561267 Glycogen-binding regulatory subunit of S/T protein phosphatase I +FIG01561306 LPS biosynthesis +FIG01561355 Transcriptional regulator, XRE family +FIG01561359 hypothetical protein +FIG01561366 putative colicin immunity protein +FIG01561367 Lin0983 protein +FIG01561389 FIG00831494: hypothetical protein +FIG01561391 FIG00930816: hypothetical protein +FIG01561446 contains permease domain +FIG01561476 FIG00344476: hypothetical protein +FIG01561492 aminotransferase NifS +FIG01561494 FIG00352429: hypothetical protein +FIG01561504 P-type conjugative transfer protein TrbL +FIG01561509 Endo-1,4-beta-xylanase D precursor +FIG01561513 COG2962: Predicted permeases +FIG01561528 COG0466: ATP-dependent Lon protease, bacterial type +FIG01561602 Prophage pi3 protein 59 +FIG01561634 putative iron-sulfur flavoprotein +FIG01561649 Cytolysin precursor +FIG01561656 Signalling protein containing EAL domain +FIG01561657 probable bacteriophage regulatory protein +FIG01561683 FIG00733311: hypothetical protein +FIG01561686 HTH-type transcriptional regulator tnrA +FIG01561695 FIG00816897: hypothetical protein +FIG01561750 FIG00623079: hypothetical protein +FIG01561762 FIG00361333: hypothetical protein +FIG01561849 Chloride peroxidase (EC 1.11.1.10) +FIG01561854 membrane-associated oxidoreductase +FIG01561892 FIG00230945: hypothetical protein +FIG01561903 ResB-like +FIG01561905 FIG00825830: hypothetical protein +FIG01561923 FIG00674791: hypothetical protein +FIG01561925 Collagen triple helix repeat +FIG01561934 Enhancing lycopene biosynthesis protein 2 +FIG01561936 3D domain protein +FIG01561938 nitrate ABC transporter, permease protein +FIG01561996 Type II secretion cytoplasmic ATP binding protein (PulE, ATPase) +FIG01562018 syc1293_d +FIG01562029 Prophage ps3 protein 07 +FIG01562040 Uncharacterized protein aq_935 +FIG01562050 FIG00513902: hypothetical protein +FIG01562082 HicA-like protein +FIG01562084 hypothetical protein +FIG01562087 Para-nitrobenzyl esterase (EC 3.1.1.-) +FIG01562093 Putative integral-membrane protein +FIG01562121 FIG00877277: hypothetical protein +FIG01562136 FIG00804492: hypothetical protein +FIG01562216 ResB-like protein +FIG01562242 peptidase family protein U32 +FIG01562248 Na(+):H(+) antiporter +FIG01562294 hypothetical protein, contains weak similarity to NADH dehydrogenase I +FIG01562310 putative RNA polymerase sigma factor protein +FIG01562342 Glucan 1,4-alpha-glucosidase( EC:3.2.1.3 ) +FIG01562355 FIG00916938: hypothetical protein +FIG01562383 RNA polymerase ECF-type (group 3) sigma factor +FIG01562407 FIG00623208: hypothetical protein +FIG01562416 FIG00685171: hypothetical protein +FIG01562426 protein of unknown function DUF461 +FIG01562439 Hypothetical protein yrhA +FIG01562475 Fe-S protein, radical SAM family +FIG01562496 solute-binding protein (secreted protein) +FIG01562499 Mlr3177 protein +FIG01562500 25 KDA OUTER-MEMBRANE IMMUNOGENIC PROTEIN PRECURSOR +FIG01562503 FIG01021662: hypothetical protein +FIG01562508 molybdenum-binding protein, HTH domain +FIG01562509 FIG00987500: hypothetical protein +FIG01562523 FIG00385500: hypothetical protein +FIG01562566 Possible sugar ABC transporter, substrate-binding component +FIG01562585 FIG00643650: hypothetical protein +FIG01562612 FIG00389896: hypothetical protein +FIG01562624 FIG00384917: hypothetical protein +FIG01562650 Ring hydroxylating dioxygenase, alpha subunit +FIG01562661 FIG01117056: hypothetical protein +FIG01562694 galactosyl transferase CpsD +FIG01562701 FIG00351794: hypothetical protein +FIG01562743 FIG00424884: hypothetical protein +FIG01562760 putative glycosyltransferase HI1698 +FIG01562782 FIG01118803: hypothetical protein +FIG01562791 putative phage related transcriptional regulator +FIG01562814 xylose isomerase domain protein TIM barrel +FIG01562886 Aerobic respiration control protein arcA +FIG01562900 Transposase for insertion sequence element IS1106 (ORF 1) +FIG01562905 Probable cis-diol dehydratase large subunit (similar to propanediol and glycerol dehydratases) / Probable cis-diol dehydratase medium subunit (similar to propanediol and glycerol dehydratases) +FIG01562914 Aminopeptidase (EC 3.4.11.-) +FIG01562915 Transport ATP-binding protein cydCD +FIG01562916 FIG00562617: hypothetical protein +FIG01562924 FIG01049142: hypothetical protein +FIG01562956 Molybdenum-pterin binding +FIG01562990 FIG00526304: hypothetical protein +FIG01563016 Bile acid 7-alpha-dehydratase +FIG01563044 FIG00791828: hypothetical protein +FIG01563097 Subtilisin-like serine protease-like +FIG01563132 Aryl carrier domain +FIG01563166 FIG00409880: hypothetical protein +FIG01563193 arylsulfate sulfotransferase +FIG01563195 FIG00939935: hypothetical protein +FIG01563210 RumR protein +FIG01563261 FIG00547420: hypothetical protein +FIG01563306 pilin domain protein +FIG01563315 putative lipopolysaccharide modification acyltransferase +FIG01563317 hypothetical protein +FIG01563343 FIG00363783: hypothetical protein +FIG01563366 FIG00904440: hypothetical protein +FIG01563378 Predicted protein family PM-13 +FIG01563392 FIG00344232: hypothetical protein +FIG01563403 TWO COMPONENT SENSOR KINASE +FIG01563472 calcium binding hemolysin protein, putative +FIG01563489 FIG00672709: hypothetical protein +FIG01563505 cytochrome p460, putative +FIG01563518 FIG00513096: hypothetical protein +FIG01563522 Methyl-accepting chemotaxis protein McpI +FIG01563555 FIG00530598: hypothetical protein +FIG01563609 IS1272-like transposase, degenerate +FIG01563617 Translation elongation factors (GTPases) +FIG01563625 biopolymer transport protein ExbD/TolR family +FIG01563632 FIG00468893: hypothetical protein +FIG01563651 Alkanal monooxygenase (FMN-linked)( EC:1.14.14.3 ) +FIG01563672 FIG00855313: hypothetical protein +FIG01563709 putative lactoylglutathione lyase +FIG01563742 Soluble aldose sugar dehydrogenase, PQQ-dependent (EC 1.1.5.-) +FIG01563785 sensor protein AtoS, putative +FIG01563792 Major ampullate spidroin +FIG01563815 FIG00380173: hypothetical protein +FIG01563869 FIG00696702: hypothetical protein +FIG01563892 FIG00520191: hypothetical protein +FIG01563907 Predicted protein family PM-14 +FIG01563931 secreted protein containing DUF1501 +FIG01563965 FIG00385273: hypothetical protein +FIG01563985 cytochrome c, class III +FIG01564009 FIG01124105: hypothetical protein +FIG01564068 FIG01032239: hypothetical protein +FIG01564095 hypothetical protein, putative phage associated protein +FIG01564129 peptidase M29, aminopeptidase II +FIG01564145 putative lantibiotic ABC transporter,ATP-binding protein +FIG01564147 ribonuclease Z( EC:3.1.26.11 ) +FIG01564205 lipase (secreted protein) +FIG01564232 acyl-CoA oxidase homolog +FIG01564242 FIG00407310: hypothetical protein +FIG01564277 FIG00425666: hypothetical protein +FIG01564282 FIG00341616: hypothetical protein +FIG01564298 FIG00767864: hypothetical protein +FIG01564300 FIG00425533: hypothetical protein +FIG01564314 putative ferredoxin 2Fe-2S protein +FIG01564347 transcriptional regulator YbbE +FIG01564374 FIG00624674: hypothetical protein +FIG01564383 hypothetical protein +FIG01564392 protein of unknown function DUF1064 +FIG01564418 transposase Tn3 family protein +FIG01564433 Uncharacterized protein MJ0011 +FIG01564442 CheC domain protein +FIG01564447 FIG00362354: hypothetical protein +FIG01564488 CHRD domain containing protein +FIG01564512 Putative anti-sigma factor kinase +FIG01564517 Bis(5'-nucleosyl)-tetraphosphatase [Asymmetrical] (EC 3.6.1.17) +FIG01564603 FIG00902157: hypothetical protein +FIG01564609 DNA-binding domain of LuxR-like proteins +FIG01564641 FIG00407067: hypothetical protein +FIG01564670 DNA modification methylase (EC 2.1.1.72) +FIG01564691 HsdM +FIG01564766 PUTATIVE HEMAGGLUTININ-RELATED PROTEIN +FIG01564806 possible Uncharacterized protein family UPF003 +FIG01564840 Enoyl-CoA hydratase/carnithine racemase +FIG01564850 ABC transporter for amino acids, substrate binding protein precursor +FIG01564871 FIG00361194: hypothetical protein +FIG01564889 salivaricin A modification enzyme +FIG01564946 prophage MuMc02, virion morphogenesis protein +FIG01564963 Hypothetical prolipoprotein +FIG01565049 PROBABLE OXIDOREDUCTASE [SECOND PART]( EC:1.- ) +FIG01565109 Putative capsid protein of prophage +FIG01565122 cold-shock DNA-binding domain protein +FIG01565129 FIG01253025: hypothetical protein +FIG01565146 Puative intergenic transcriptional regulator +FIG01565150 putative Lysophospholipase +FIG01565164 core protein +FIG01565173 FIG00622781: hypothetical protein +FIG01565186 FIG00624165: hypothetical protein +FIG01565197 epoxide hydrolase-like protein +FIG01565204 Protein-L-isoaspartate-O-methyltransferase (EC 2.1.1.77) +FIG01565207 putative metal ion transport protein +FIG01565226 COG0262: Dihydrofolate reductase +FIG01565244 SCD49.01c, hypothetical protein (fragment), len: >115 aa; N-terminal part of TR:CAB77354 (EMBL:AL160331) Streptomyces coelicolor hypothetical 24.5 kD protein (fragment) SCD8A.33c, 224 aa and similar to TR:P96262 (EMBL:Z84724) Mycobacterium tuberculosis hypothetical 7.4 kD protein MTCY22G10.13, 68 aa; fasta scores: opt: 71 z-score: 131.0 E(): 8; 41.0% identity in 39 aa overlap SCD8A.33c, unknown (fragment), len: >224 aa +FIG01565259 Transport system permease protein +FIG01565272 Ig-like, group 2 +FIG01565276 conserved hypothetical protein TIGR00268 +FIG01565293 FIG00346639: hypothetical protein +FIG01565298 Rhoptry protein +FIG01565367 Protease secretion protein +FIG01565373 adventurous gliding motility protein S +FIG01565382 PTS system fructose-specific II component +FIG01565389 Monomeric sarcosine oxidase (EC 1.5.3.1) +FIG01565391 possible permease +FIG01565521 FIG00666884: hypothetical protein +FIG01565557 putative polyketide biosynthesis acyl carrier protein +FIG01565648 FIG00451392: hypothetical protein +FIG01565682 outer membrane protein W +FIG01565689 Multidrug transporter homolog +FIG01565702 FIG00673165: hypothetical protein +FIG01565706 melibiose operon regulatory protein +FIG01565740 FIG01117823: hypothetical protein +FIG01565786 Riorf50 protein +FIG01565797 FIG00356420: hypothetical protein +FIG01565806 hypothetical protein +FIG01565820 hypothetical protein +FIG01565823 FIG00623348: hypothetical protein +FIG01565824 FIG00679284: hypothetical protein +FIG01565828 Putative LysR-family transcriptional regulator YbdO +FIG01565847 Glutamate dehydrogenase( EC:1.4.1.2 ) +FIG01565921 Protein of unknown function DUF1486 +FIG01565922 ParB-like nuclease domain protein +FIG01565923 hypothetical protein +FIG01565954 putative general stress protein +FIG01565957 hypothetical protein +FIG01565968 Putative general stress protein +FIG01565993 narrowly conserved hypothetical protein with possible glycosyltransferase domain +FIG01566004 FIG00986747: hypothetical protein +FIG01566034 PTS system, N-acetylgalactosamine-specific IIC component (EC 2.7.1.69) +FIG01566082 FIG00354856: hypothetical protein +FIG01566093 NolG efflux transporter +FIG01566097 FIG00733933: hypothetical protein +FIG01566111 NADH oxidase of the flavin-dependent disulfide reductase family, MJ0649 +FIG01566134 FIG00356270: hypothetical protein +FIG01566176 hypothetical protein Rv1877 +FIG01566190 FIG00388146: hypothetical protein +FIG01566219 putative multiple inositol polyphosphate histidine phosphatase 1 +FIG01566233 FIG00353835: hypothetical protein +FIG01566279 FIG00385217: hypothetical protein +FIG01566281 COGs COG2020 +FIG01566311 Two-component response regulator colocalized with HrtAB transporter +FIG01566324 putative Zn-dependent hydrolase (beta-lactamase superfamily) +FIG01566350 putative metalloprotease, family M23B +FIG01566352 Slr0967 protein +FIG01566388 putative bacterocin transport accessory protein, Bta +FIG01566396 syc0810_d +FIG01566400 FIG00850187: hypothetical protein +FIG01566427 D-tagatose 3-epimerase +FIG01566437 cytochrome c class I +FIG01566467 FIG00469303: hypothetical protein +FIG01566480 hypothetical protein +FIG01566530 FIG00815289: hypothetical protein +FIG01566549 Zinc-binding dehydrogenase +FIG01566554 acyl-CoA dehydrogenase type 2 domain protein +FIG01566566 hypothetical protein +FIG01566574 Transcriptional regulator, contains sigma factor-related N-terminal domain +FIG01566575 FIG00838602: hypothetical protein +FIG01566576 glucosyltransferase-S +FIG01566581 nitrate reductase subunit +FIG01566597 FIG00522603: hypothetical protein +FIG01566608 FIG01092542: hypothetical protein +FIG01566613 possible MCE family protein +FIG01566648 FIG00631899: hypothetical protein +FIG01566705 FIG00410285: hypothetical protein +FIG01566729 FIG00561109: hypothetical protein +FIG01566745 possible TraG-related protein +FIG01566756 FIG00410124: hypothetical protein +FIG01566764 FIG00410251: hypothetical protein +FIG01566765 Protein of unknown function DUF683 +FIG01566772 FIG00898720: hypothetical protein +FIG01566773 Processing protease +FIG01566784 FIG00629749: hypothetical protein +FIG01566803 VlhA.4.01 +FIG01566805 cell wall hydrolase, SleB +FIG01566807 succinoglycan biosynthesis protein exoM( EC:2.- ) +FIG01566854 FIG00896454: hypothetical protein +FIG01566870 Aldo/keto reductase family enzyme +FIG01566909 RNA polymerase ECF sigma factor +FIG01566924 Mll6637 protein +FIG01566932 amino acid-binding ACT +FIG01566942 FIG00847344: hypothetical protein +FIG01566965 b-glycosyltransferase, glycosyltransferase family 2 protein +FIG01566982 FIG00385087: hypothetical protein +FIG01566983 FIG00632937: hypothetical protein +FIG01566993 possible nitrogenase molybdenum-iron protein alpha chain (nitrogenase component I) (dinitrogenase) +FIG01567003 Macrolide-efflux protein +FIG01567030 putative transport ATP-binding protein +FIG01567035 Similar to Glutathione synthetase (EC 6.3.2.3) +FIG01567043 Suppressor of fused +FIG01567052 ABC transporter ATP-binding protein +FIG01567065 FIG01126790: hypothetical protein +FIG01567087 hemolysin-type calcium-binding toxin +FIG01567146 Protein yfbU +FIG01567205 FIG00815292: hypothetical protein +FIG01567223 predicted nucleic acid-binding protein,contains PIN domain +FIG01567234 FIG00468303: hypothetical protein +FIG01567244 glutaredoxin-like domain protein +FIG01567256 Modification methylase BbvI (EC 2.1.1.37) +FIG01567273 ISCps2, transposase orfB +FIG01567276 Transcriptional regulator, RpiR family (phosphosugar-binding), putative +FIG01567278 FIG00640938: hypothetical protein +FIG01567279 transcriptional regulator, LacI family protein +FIG01567324 Predicted flavodoxin +FIG01567325 FIG01167116: hypothetical protein +FIG01567341 vitamin K epoxide reductase +FIG01567385 FIG00831360: hypothetical protein +FIG01567388 FIG00412349: hypothetical protein +FIG01567392 Ubiquinone biosynthesis protein COQ9 +FIG01567396 DNA invertase +FIG01567406 FIG00472032: hypothetical protein +FIG01567407 Glutenin, high molecular weight subunit PW212 precursor +FIG01567419 Cyclic di-GMP-binding protein precursor (Cellulose synthase regulatory subunit) (Cellulose synthase protein B) (CDGBP) +FIG01567434 Hydrogenase maturation protease delta subunit, HyaD-like +FIG01567467 Adenylate cyclase hemolysin (Fragment) +FIG01567524 chromosome replication initiation inhibitor protein +FIG01567526 FIG00939883: hypothetical protein +FIG01567593 FIG01118217: hypothetical protein +FIG01567595 FIG00735862: hypothetical protein +FIG01567599 FIG00353712: hypothetical protein +FIG01567651 FIG00404527: hypothetical protein +FIG01567664 response regulator of two-component system +FIG01567676 protein of unknown function DUF1028 +FIG01567684 FIG00469211: hypothetical protein +FIG01567718 FIG00623434: hypothetical protein +FIG01567757 Gsl3751 protein +FIG01567760 FIG00564398: hypothetical protein +FIG01567786 Spore germination protein, GRKC +FIG01567790 FIG01240913: hypothetical protein +FIG01567817 Gll1752 protein +FIG01567884 FIG00525029: hypothetical protein +FIG01567885 FIG01038558: hypothetical protein +FIG01567901 probable lipase/esterase +FIG01567916 Long-chain fatty acid transport protein precursor +FIG01567917 hypothetical protein +FIG01567929 E-cinnamoyl-CoA:R-phenyllactate CoA transferase large subunit +FIG01567945 lipoprotein, ComL family +FIG01567966 conserved hypothetical protein; Glycine-rich protein +FIG01567970 FIG00922120: hypothetical protein +FIG01567985 anti-sigm factor, ChrR +FIG01568002 Competence protein PilW +FIG01568006 DNA-entry nuclease (EC 3.-.-.-) +FIG01568041 FIG00696117: hypothetical protein +FIG01568054 PUTATIVE HEMOLYSIN-TYPE PROTEIN +FIG01568057 COG1359: Uncharacterized conserved protein +FIG01568059 FIG01017518: hypothetical protein +FIG01568074 FIG00841481: hypothetical protein +FIG01568103 FIG00781682: hypothetical protein +FIG01568116 FIG01136476: hypothetical protein +FIG01568126 FIG00624282: hypothetical protein +FIG01568138 syc2387_c +FIG01568148 Transposase +FIG01568155 nitrogen regulatory protein P-II +FIG01568164 FIG00525550: hypothetical protein +FIG01568211 FIG00733190: hypothetical protein +FIG01568239 FIG00834338: hypothetical protein +FIG01568299 Putative phytoene dehydrogenase +FIG01568335 hypothetical protein +FIG01568348 FIG00355914: hypothetical protein +FIG01568398 FIG01118560: hypothetical protein +FIG01568409 FIG00623409: hypothetical protein +FIG01568415 FIG00514674: hypothetical protein +FIG01568427 FIG00966137: hypothetical protein +FIG01568435 Selenium binding protein +FIG01568511 ABC-type polar amino acid transport system protein, ATP-binding protein +FIG01568562 Putative oxidoreductase component of anaerobic dehydrogenases; Chaperone protein torD +FIG01568588 metal-dependent membrane protease +FIG01568599 zinc metalloprotease ZmpB, truncated +FIG01568611 FIG00951764: hypothetical protein +FIG01568632 FIG00822718: hypothetical protein +FIG01568654 FIG00764650: hypothetical protein +FIG01568696 FIG00674521: hypothetical protein +FIG01568707 FIG236019: hypothetical protein +FIG01568718 RloG protein, putative +FIG01568723 sporulation initiation inhibitor protein Soj +FIG01568727 FIG00624250: hypothetical protein +FIG01568742 FIG00946318: hypothetical protein +FIG01568743 FIG00388480: hypothetical protein +FIG01568748 probable tetratricopeptide repeat family protein +FIG01568818 Competence damage inducible protein CinA +FIG01568822 Small acid-soluble spore protein, beta-type SASP +FIG01568847 Magnesium and cobalt transport protein CorA +FIG01568849 PTP-like phytase +FIG01568855 putative sigma-54 dependent transcriptional regulator +FIG01568866 SpoIID/LytB domain protein +FIG01568891 FIG00469626: hypothetical protein +FIG01568905 nifU protein (nifU-3) +FIG01568943 FIG01248843: hypothetical protein +FIG01568993 putative iron ABC transporter, ATP-binding protein +FIG01568994 actinorhodin transporter +FIG01569010 FIG01119851: hypothetical protein +FIG01569012 FIG01083614: hypothetical protein +FIG01569033 hypothetical protein +FIG01569041 outer-membrane lipoprotein carrier protein precursor +FIG01569042 FIG00414163: hypothetical protein +FIG01569045 putative chromosome segregation ATPase +FIG01569049 FIG00688467: hypothetical protein +FIG01569062 FIG00520761: hypothetical protein +FIG01569066 FIG00849266: hypothetical protein +FIG01569092 2-hydroxy-3-keto-5-methylthiopentenyl-1-phosphate phosphatase / Methylthioribulose-1-phosphate dehydratase (EC 4.2.1.109) +FIG01569097 bile acid transporter family protein +FIG01569099 lipoprotein releasing system transmembrane protein +FIG01569115 OsmC/Ohr family protein +FIG01569140 protein of unknown function DUF1549 +FIG01569153 FIG00424942: hypothetical protein +FIG01569157 FIG00388943: hypothetical protein +FIG01569163 FIG01118723: hypothetical protein +FIG01569186 FIG00693501: hypothetical protein +FIG01569227 probable ethanolamine utilization protein EutM +FIG01569261 UPF0309 protein SCO4393 +FIG01569273 Phosphatidylethanolamine N-methyltransferase, putative( EC:2.1.1.- ) +FIG01569288 B-lactamase regulatory protein +FIG01569294 InterPro IPR000087 +FIG01569299 ABC-type multidrug transport system +FIG01569322 FIG00750066: hypothetical protein +FIG01569332 HEPN domain-containing protein +FIG01569373 uracil phosphoribosyltransferase( EC:2.4.2.9 ) +FIG01569408 Uncharacterized protein involved in cytokinesis, contains TGc (transglutaminase/protease-like) domain +FIG01569416 FIG00348422: hypothetical protein +FIG01569419 outer membrane protein with alpha integrin like repeat domains +FIG01569427 Six-cysteine peptide SCIFF +FIG01569429 213aa long conserved hypothetical protein +FIG01569433 Tetratricopeptide repeat protein +FIG01569451 ATP-binding cassette, sub-family A (ABC1), member 4 +FIG01569458 acetyltransferase, GNAT family +FIG01569489 FIG00638866: hypothetical protein +FIG01569499 transposase for insertion sequence element +FIG01569504 possible Helper component proteinase +FIG01569522 N-terminal acetyltransferase complex subunit +FIG01569523 hypothetical protein +FIG01569545 Putative transcriptional regulator MarT +FIG01569564 FIG00388571: hypothetical protein +FIG01569573 Endoglucanase 1 precursor (EC 3.2.1.4) (Endoglucanase I) (EGI) (Endo-1,4-beta-glucanase) (Cellulase I) +FIG01569580 Citrate lyase beta subunit +FIG01569588 UPF0187 protein alr2987 +FIG01569611 EpsK +FIG01569660 Capsular polysaccharide synthesis protein +FIG01569665 FIG00635367: hypothetical protein +FIG01569674 FIG00633636: hypothetical protein +FIG01569681 FIG00365089: hypothetical protein +FIG01569712 Major ring-forming surface antigen precursor +FIG01569713 FIG00622867: hypothetical protein +FIG01569761 FIG00825760: hypothetical protein +FIG01569776 putative hydrolase, NUDIX family +FIG01569779 FIG00415504: hypothetical protein +FIG01569798 syc0808_d +FIG01569800 FIG00343805: hypothetical protein +FIG01569805 FIG01093541: hypothetical protein +FIG01569862 hypothetical protein +FIG01569893 FIG00468450: hypothetical protein +FIG01569913 CAB/ELIP/HLIP superfamily protein +FIG01569918 hypothetical protein +FIG01569936 helicase related protein +FIG01569937 MIP family channel protein +FIG01569946 FIG00622743: hypothetical protein +FIG01570012 FIG00403624: hypothetical protein +FIG01570028 mandelate racemase/muconate lactonizing enzyme +FIG01570050 FIG00526571: hypothetical protein +FIG01570053 FIG00991444: hypothetical protein +FIG01570059 FIG00388357: hypothetical protein +FIG01570061 SoxA sarcosine oxidase, subunit alpha +FIG01570088 putative CheW protein +FIG01570091 Glr3318 protein +FIG01570123 FIG01109953: hypothetical protein +FIG01570222 Cellodextrinase A (EC 3.2.1.-) +FIG01570232 hypothetical protein; putative peptide signal +FIG01570240 protein-tyrosine phosphatase-related protein +FIG01570246 probable cytochrome b561 +FIG01570262 FIG00749008: hypothetical protein +FIG01570298 COG4319: Ketosteroid isomerase homolog +FIG01570316 FIG00362082: hypothetical protein +FIG01570321 FIG00528388: hypothetical protein +FIG01570324 3-oxoadipate enol-lactonase +FIG01570351 2,4-dienoyl-CoA reductase [NADPH] (EC 1.3.1.34) +FIG01570358 FIG00633303: hypothetical protein +FIG01570390 Blue (type 1) copper domain +FIG01570493 PsiF repeat-containing protein +FIG01570521 Phage antitermination protein Q +FIG01570534 FIG00745219: hypothetical protein +FIG01570557 conserved hyperthetical protein +FIG01570596 FIG00462565: hypothetical protein +FIG01570600 FIG00465263: hypothetical protein +FIG01570601 FIG00945946: hypothetical protein +FIG01570619 FIG00733619: hypothetical protein +FIG01570665 Homospermidine synthase-like protein +FIG01570681 FIG00348957: hypothetical protein +FIG01570683 FIG00571570: hypothetical protein +FIG01570710 FIG00945928: hypothetical protein +FIG01570712 FIG00384913: hypothetical protein +FIG01570714 FIG00461516: hypothetical protein +FIG01570733 FIG00814846: hypothetical protein +FIG01570760 FIG00521767: hypothetical protein +FIG01570780 Predicted dehydrogenase and related protein +FIG01570787 naphthoate synthase( EC:4.1.3.36 ) +FIG01570808 FIG00624509: hypothetical protein +FIG01570825 solute binding protein of ABC transporter systemy for peptides +FIG01570847 hypothetical protein +FIG01570850 Negative regulator of sigma E activity +FIG01570857 FIG00361730: hypothetical protein +FIG01570912 acylaminoacyl-peptidase +FIG01570915 FIG00675452: hypothetical protein +FIG01570936 probable endonuclease +FIG01570948 FIG00809194: hypothetical protein +FIG01570997 transposase, IS4 family +FIG01571009 LtrG* +FIG01571034 Colicin V secretion ABC transporter ATP-binding protein +FIG01571081 FIG00515392: hypothetical protein +FIG01571095 ABC transporter solute-bing protein +FIG01571102 peptidase M7, snapalysin +FIG01571133 FIG00349085: hypothetical protein +FIG01571168 putative DNA methyltransferase +FIG01571176 Acetyltransferase (GNAT) family protein +FIG01571177 FIG00622808: hypothetical protein +FIG01571218 Pli0011 protein +FIG01571264 Outer membrane autotransporter barrel +FIG01571269 putative Phosphoglycerate/bisphosphoglycerate mutase +FIG01571274 putative prophage antirepressor +FIG01571282 FIG00414340: hypothetical protein +FIG01571310 Protein of unknown function DUF1576 +FIG01571323 Slr1262 protein +FIG01571329 Large exoproteins involved in heme utilization or adhesion +FIG01571348 Protein kinase-like protein +FIG01571369 4-amino-4-deoxy-L-arabinose transferase +FIG01571395 FIG00379702: hypothetical protein +FIG01571411 hypothetical protein +FIG01571430 TWO-COMPONENT RESPONSE REGULATOR +FIG01571437 putative histidine kinase protein +FIG01571443 NDP-hexose 3-C-methyltransferase TylCIII +FIG01571450 FIG01165618: hypothetical protein +FIG01571455 syc0771_d +FIG01571467 NTP pyrophosphohydrolase +FIG01571495 Bll2791 protein +FIG01571507 Cointegrate resolution protein S +FIG01571621 50S ribosomal protein L20 +FIG01571639 FIG00753138: hypothetical protein +FIG01571642 FIG00832330: hypothetical protein +FIG01571658 FIG00380498: hypothetical protein +FIG01571659 protein of unknown function DUF710 +FIG01571681 Transposase KP1_0766 +FIG01571685 Ornithine transporter +FIG01571689 transposase +FIG01571695 Putative amino acid ABC transport system, substrate-binding protein +FIG01571706 FIG00849595: hypothetical protein +FIG01571728 FIG00388128: hypothetical protein +FIG01571774 PatB and ORF2 genes +FIG01571781 probable aminopeptidase +FIG01571782 hypothetical protein +FIG01571797 AlbB +FIG01571803 ROK family Glucokinase with ambiguous substrate specificity +FIG01571833 DIGUANYLATE CYCLASE (FRAGMENT) +FIG01571842 Vinylacetyl-CoA Delta-isomerase( EC:5.3.3.3 ) +FIG01571884 FIG00873176: hypothetical protein +FIG01571906 FIG00919308: hypothetical protein +FIG01571917 molybdenum cofactor biosynthesis protein +FIG01571957 Small multidrug resistance protein +FIG01571959 Ribosomal RNA adenine dimethylase (EC 2.1.1.-) +FIG01571965 FIG00533725: hypothetical protein +FIG01571981 FIG00839642: hypothetical protein +FIG01572007 FIG01015901: hypothetical protein +FIG01572010 collagen-like protein +FIG01572013 hydrolase, alpha/beta fold family protein +FIG01572014 lysine-N-methylase, homolog +FIG01572016 antibiotic hydrolase +FIG01572020 FIG00913685: hypothetical protein +FIG01572022 glycosyl transferase family 51 +FIG01572042 putative glycosyl hydrolase( EC:3.2.1.86 ) +FIG01572064 Glutothione ABC transporter ATP-binding protein +FIG01572068 two component response regulator( EC:2.7.3.- ) +FIG01572110 FIG00385247: hypothetical protein +FIG01572134 2,3-dihydroxybiphenyl dioxygenase +FIG01572147 hypothetical protein +FIG01572152 FIG01134599: hypothetical protein +FIG01572191 FIG00424465: hypothetical protein +FIG01572269 FIG00350649: hypothetical protein +FIG01572294 acyl carrier domain protein +FIG01572318 FIG00764319: hypothetical protein +FIG01572334 UDP-sulfoquinovose synthase (EC 3.13.1.1) +FIG01572335 Keratin associated protein 18-4 +FIG01572411 FIG00384858: hypothetical protein +FIG01572428 FIG00847747: hypothetical protein +FIG01572437 Serine/Threonine protein kinase +FIG01572458 hypothetical protein +FIG01572474 FIG00352648: hypothetical protein +FIG01572486 FIG00410313: hypothetical protein +FIG01572491 FIG00642000: hypothetical protein +FIG01572506 identified by similarity to GB:AAM06297.1 +FIG01572539 FIG00417039: hypothetical protein +FIG01572575 FIG01166409: hypothetical protein +FIG01572581 FIG01131372: hypothetical protein +FIG01572590 FIG01249208: hypothetical protein +FIG01572609 FIG00965957: hypothetical protein +FIG01572613 Transcriptional regulator of fucose utilization, DeoR family +FIG01572648 Transcriptional regulator, MarR family +FIG01572661 Cell surface antigen Sca2 +FIG01572662 FIG00531134: hypothetical protein +FIG01572665 FIG00344496: hypothetical protein +FIG01572670 death-on-curing protein +FIG01572692 syc1807_c +FIG01572698 hypothetical protein +FIG01572707 protein-tyrosine phosphatase +FIG01572709 ABC transporter ATP-binding protein +FIG01572723 FIG00638840: hypothetical protein +FIG01572728 VlhA.3.04 +FIG01572739 FIG00408736: hypothetical protein +FIG01572741 FIG00347960: hypothetical protein +FIG01572748 FIG00658822: hypothetical protein +FIG01572776 uncharacterized domain 1 +FIG01572790 Probable lipase (EC 3.1.1.3) +FIG01572799 PHP-like +FIG01572805 FIG00628023: hypothetical protein +FIG01572807 Sphingosine-1-phosphate lyase 1 (EC 4.1.2.27) +FIG01572812 FIG00817478: hypothetical protein +FIG01572840 FIG01206405: hypothetical protein +FIG01572869 sulfite oxidase, putative +FIG01572902 FIG00425799: hypothetical protein +FIG01572964 FIG00822657: hypothetical protein +FIG01573002 hypothetical protein +FIG01573010 possible hydroxylase +FIG01573022 Ssr8013 protein +FIG01573027 FIG01114416: hypothetical protein +FIG01573033 FIG00385644: hypothetical protein +FIG01573045 FIG00570463: hypothetical protein +FIG01573067 predicted AAA family ATPase +FIG01573083 transposase IS66 +FIG01573144 FIG00768664: hypothetical protein +FIG01573185 FIG01234274: hypothetical protein +FIG01573220 ABC transporter ATP-binding protein YvcR +FIG01573237 putative transposition-related protein +FIG01573243 protein of unknown function UPF0131 +FIG01573260 putative cytochrome c-type biogenesis protein; putative membrane protein +FIG01573267 FIG00515116: hypothetical protein +FIG01573301 putative solute transport protein +FIG01573303 Cytochrome c peroxidase +FIG01573322 hypothetical protein +FIG01573337 transcriptional regulator, AsnC family +FIG01573385 osmC-like family protein +FIG01573396 Outer membrane porin precursor +FIG01573428 putative teicoplanin resistance protein +FIG01573432 secreted alpha-amylase. +FIG01573458 FIG00352113: hypothetical protein +FIG01573465 FIG00389439: hypothetical protein +FIG01573471 FIG00666811: hypothetical protein +FIG01573497 conserved hypothetical protein +FIG01573507 possible two-component sensor histidine kinase +FIG01573567 FIG00531872: hypothetical protein +FIG01573585 FIG00350917: hypothetical protein +FIG01573596 FIG00631964: hypothetical protein +FIG01573601 FIG00390571: hypothetical protein +FIG01573628 osmotically inducible protein +FIG01573632 anaerobic C4-dicarboxylate transport +FIG01573638 Endo alpha-1,4 polygalactosaminidase precusor precursor +FIG01573672 replication initiation factor +FIG01573693 putative ankyrin-like protein +FIG01573728 UPF0285 protein MA_3856 +FIG01573762 Myo-inositol 2-dehydrogenase +FIG01573774 FIG01242277: hypothetical protein +FIG01573776 FIG00642554: hypothetical protein +FIG01573790 FIG00815897: hypothetical protein +FIG01573791 probable glucosyl transferase +FIG01573811 FIG00848603: hypothetical protein +FIG01573841 probable reticuline oxidase +FIG01573897 LUCIFERASE-ALPHA SUBUNIT +FIG01573900 pyrimidine regulatory protein PyrR +FIG01573901 FIG00528463: hypothetical protein +FIG01573957 Phosphoenolpyruvate-dependent sugar phosphotransferase system, EIIA 2:PRD +FIG01573964 Gll3467 protein +FIG01573980 RND efflux system, outer membrane protein +FIG01574009 FIG00407990: hypothetical protein +FIG01574026 Retroviral aspartyl protease domain protein +FIG01574051 Type IV pilus biogenesis protein PilM +FIG01574060 FIG00451030: hypothetical protein +FIG01574067 possible collagen-like protein +FIG01574084 FIG00344806: hypothetical protein +FIG01574090 Thioredoxin +FIG01574102 AviX3 +FIG01574122 Transcription antitermination protein NusG-related protein +FIG01574126 putative NDP-3-keto-6-deoxyhexose 3-ketoreductase +FIG01574139 First ORF in transposon ISC1904 +FIG01574141 probable copper resistance protein +FIG01574210 glucose-6-phosphate 1-dehydrogenase +FIG01574240 Phage terminase, small subunit +FIG01574245 Putative NADH-flavin reductase +FIG01574254 Histidinol-phosphatase [alternative form] (EC 3.1.3.15) +FIG01574276 FIG00526208: hypothetical protein +FIG01574368 putative TonB-dependent receptor protein with OmpA-like transmembrane domain +FIG01574433 COG1649 predicted glycoside hydrolase +FIG01574467 FIG01241261: hypothetical protein +FIG01574477 Aldo/keto reductase:Bacterial regulatory protein, TetR +FIG01574485 FIG00849720: hypothetical protein +FIG01574487 unknown protein encoded in prophage CP-933I +FIG01574507 FIG01133427: hypothetical protein +FIG01574509 FIG01231443: hypothetical protein +FIG01574558 Peptidase M30, hyicolysin +FIG01574590 FIG00364975: hypothetical protein +FIG01574621 Terminase large subunit +FIG01574647 FIG00919866: hypothetical protein +FIG01574671 Uncharacterized protein yxcE +FIG01574691 FIG01235532: hypothetical protein +FIG01574706 TraB family protein +FIG01574711 FIG00623822: hypothetical protein +FIG01574773 GcrA cell cycle regulator +FIG01574816 possible MerR-type transcriptional regulator +FIG01574834 probable polysaccharide transport protein +FIG01574842 FIG01118643: hypothetical protein +FIG01574848 ADP-ribose pyrophosphatase( EC:3.6.1.13 ) +FIG01574849 ORF063 +FIG01574862 hypothetical protein +FIG01574871 FIG00817583: hypothetical protein +FIG01574877 hypothetical protein, fusion +FIG01574886 hypothetical protein +FIG01574899 CDS_ID OB0724 +FIG01574906 Zeta toxin family protein +FIG01574917 Cell surface lipoprotein MPT83 precursor +FIG01574924 FIG00850351: hypothetical protein +FIG01574945 putative cell filamentation protein +FIG01575008 Accessory protein +FIG01575015 FIG00834892: hypothetical protein +FIG01575053 IncP-type DNA transfer protein TraO +FIG01575063 FIG00356160: hypothetical protein +FIG01575098 CelB protein +FIG01575156 FIG00624503: hypothetical protein +FIG01575202 FIG00756236: hypothetical protein +FIG01575203 Multiple sugar transport system +FIG01575223 Conjugal transfer protein TraD +FIG01575251 FIG00468959: hypothetical protein +FIG01575254 FIG01204547: hypothetical protein +FIG01575262 Probable type IV pilus assembly FimV-related transmembrane protein +FIG01575263 Protein lacX, plasmid +FIG01575272 FIG00388320: hypothetical protein +FIG01575280 putative bifunctional hydroxylase/oxidoreductase +FIG01575307 possible serine peptidase +FIG01575327 putative secreted pectinesterase +FIG01575343 FIG00622774: hypothetical protein +FIG01575377 hypothetical protein +FIG01575380 putative outer membrane protein +FIG01575386 FIG00824073: hypothetical protein +FIG01575435 peptidoglycan-binding LysM +FIG01575436 FIG00624637: hypothetical protein +FIG01575442 transporter, hydrophobe/amphiphile efflux-1 (HAE1) family +FIG01575453 D12 class N6 adenine-specific DNA methyltransferase family +FIG01575559 FIG00609505: hypothetical protein +FIG01575576 FIG00849126: hypothetical protein +FIG01575615 FIG00352060: hypothetical protein +FIG01575659 FIG00624468: hypothetical protein +FIG01575682 FIG00966480: hypothetical protein +FIG01575704 FIG00623862: hypothetical protein +FIG01575711 FIG00532246: hypothetical protein +FIG01575757 cytochrome c oxidase, subunit CcoQ +FIG01575783 possible heme oxygenase +FIG01575851 phage-like element pbsx protein xkdP +FIG01575870 Uncharacterized protein y4hQ +FIG01576000 FIG00696059: hypothetical protein +FIG01576007 FIG00762987: hypothetical protein +FIG01576047 Type IV pilus biogenesis protein PilN +FIG01576048 ABC Fe(3+) transporter, substrate binding component +FIG01576092 TonB family protein +FIG01576111 FIG00349923: hypothetical protein +FIG01576126 surface repeat protein, putative +FIG01576142 putative conserved DNA-binding protein +FIG01576153 Glucose oligosaccharide ABC transport system, permease protein 2 +FIG01576202 calcium/proton exchanger +FIG01576216 FIG00351760: hypothetical protein +FIG01576228 hypothetical protein +FIG01576233 putative RTX toxin hemolysin-type calcium-binding protein +FIG01576265 FIG00468418: hypothetical protein +FIG01576270 FIG00251454: hypothetical protein +FIG01576279 Putative pathogenicity island protein +FIG01576335 Mammalian cell entry related +FIG01576345 Iron ABC transporter, ATP-binding protein +FIG01576357 FIG00804025: hypothetical protein +FIG01576373 hypothetical protein +FIG01576382 hypothetical protein +FIG01576429 Uncharacterized protein MJ1620 +FIG01576453 FIG00863414: hypothetical protein +FIG01576519 conserved protein of unknown function (similar to E. coli YacL) +FIG01576580 Glutathione S-transferase N-terminal domain +FIG01576599 ATPases and helicase subunits involved in DNA replication +FIG01576620 FIG00352625: hypothetical protein +FIG01576648 FIG00532725: hypothetical protein +FIG01576683 FIG00364582: hypothetical protein +FIG01576699 Uncharacterized protein MJ0489 +FIG01576757 Isochorismatase family protein +FIG01576775 FIG00361489: hypothetical protein +FIG01576777 FIG00355764: hypothetical protein +FIG01576778 Transcriptional regulator, TetR family +FIG01576804 probable oxidoreductase, Zn-binding +FIG01576822 FIG00762933: hypothetical protein +FIG01576825 peptidase, M23B family +FIG01576862 putative ABC-transporter integral membrane protein +FIG01576867 molecular chaperone DnaK +FIG01576871 putative amino acid efflux protein +FIG01576874 hypothetical protein +FIG01576892 peptidase, M16 family +FIG01576894 FIG00630016: hypothetical protein +FIG01576923 phage-related exonuclease +FIG01576931 FIG00815403: hypothetical protein +FIG01577004 FIG00627642: hypothetical protein +FIG01577026 probable ECF-like sigma factor SigE +FIG01577032 FIG00351238: hypothetical protein +FIG01577081 FIG00820985: hypothetical protein +FIG01577104 renal dipeptidase family protein +FIG01577110 CELL SURFACE ANTIGEN +FIG01577183 putative thiol-disulfide isomerase and thioredoxin +FIG01577190 FIG00769930: hypothetical protein +FIG01577214 Methyltransferase type 11 (EC 2.1.1.51) +FIG01577221 FIG00344749: hypothetical protein +FIG01577262 Phage restriction alleviation ral +FIG01577320 FIG00525305: hypothetical protein +FIG01577322 Kappa-fimbriae regulatory protein +FIG01577336 molybdopterin oxidoreductase, iron-sulfur binding subunit +FIG01577346 FIG00793291: hypothetical protein +FIG01577348 FIG00498239: hypothetical protein +FIG01577393 Protein of unknown function DUF1016 +FIG01577398 Uncharacterized transporter yybO +FIG01577405 UPF0028 protein YchK +FIG01577407 3-hydroxyisobutyrate dehydrogenase, NAD-binding protein +FIG01577425 globin family protein +FIG01577449 FIG00388560: hypothetical protein +FIG01577458 regulatory protein AlgP +FIG01577461 resolvase, N-terminal:Resolvase helix-turn-helix region +FIG01577485 LytTr DNA-binding response regulator +FIG01577493 COG0572: Uridine kinase +FIG01577516 probable cytochrome c-552 precursor +FIG01577536 FIG01018073: hypothetical protein +FIG01577546 FIG00361615: hypothetical protein +FIG01577562 Possible replication protein A +FIG01577584 Conserved protein YngD +FIG01577594 Glycosyl transferase, family 28 +FIG01577648 Probable secretion protein +FIG01577704 sulfate transporter +FIG01577719 Vanillate monooxygenase( EC:1.14.13.82 ) +FIG01577732 split soret cytochrome c precursor +FIG01577745 capsular polysaccharide biosynthesis protein Cap5D +FIG01577775 hypothetical protein +FIG01577793 prophage LambdaSa2, protease, putative +FIG01577794 conserved domain protein +FIG01577809 hypothetical LysR-like regular protein +FIG01577861 FIG00418133: hypothetical protein +FIG01577882 FIG00640227: hypothetical protein +FIG01577927 (S)-2-haloacid dehalogenase (EC 3.8.1.2) (2-haloalkanoic acid dehalogenase) (L-2-haloacid dehalogenase) (Halocarboxylic acid halidohydrolase) (L-DEX) +FIG01578029 FIG00641140: hypothetical protein +FIG01578047 KilA +FIG01578055 FIG00711691: hypothetical protein +FIG01578059 Polyketide synthase Pks2 +FIG01578063 FIG00348319: hypothetical protein +FIG01578099 Uncharacterized protein ymzD +FIG01578123 FIG00348593: hypothetical protein +FIG01578147 FIG01242809: hypothetical protein +FIG01578165 hypothetical protein +FIG01578184 Nitrogenase molybdenum-iron protein alpha chain (EC 1.18.6.1) +FIG01578193 Predicted transcriptional regulator, YDCN B.subtilis ortholog +FIG01578198 Uncharacterized protein MJ0583 +FIG01578214 FIG01277518: hypothetical protein +FIG01578227 biosynthesis of ubiquinone +FIG01578231 Peptidase U7 +FIG01578239 FIG00624697: hypothetical protein +FIG01578253 probable MutT-family protein +FIG01578260 Hypothetical protein Cj0569 +FIG01578264 FIG00404493: hypothetical protein +FIG01578271 NirP, putative +FIG01578276 FIG01016189: hypothetical protein +FIG01578296 Carbonic anhydrase I (EC 4.2.1.1) +FIG01578301 FIG00821224: hypothetical protein +FIG01578305 FIG01067525: hypothetical protein +FIG01578307 FIG00624780: hypothetical protein +FIG01578308 collagen adhesin protein +FIG01578349 FIG00767744: hypothetical protein +FIG01578359 FIG00380286: hypothetical protein +FIG01578361 transcriptional regulators, TraR/DksA family +FIG01578368 e14 prophage; 5-methylcytosine-specific restriction endonuclease B +FIG01578399 FIG00733750: hypothetical protein +FIG01578400 possible phage-related protein +FIG01578420 Putative lipoprotein +FIG01578433 enterobacterial exodeoxyribonuclease VIII family protein +FIG01578452 anti-sigmaB factor antagonist +FIG01578455 protein disulfide isomerase +FIG01578538 sugar-non-specific nuclease inhibitor NuiA homolog +FIG01578540 Putative glycoprotein-receptor +FIG01578551 major facilitator superfamily +FIG01578574 thiamine-phosphate pyrophosphorylase, putative +FIG01578610 iron-binding periplasmic protein +FIG01578613 FIG235764: hypothetical protein +FIG01578636 putative nodulation protein NoeI-putative methyltransferase +FIG01578651 FIG01120077: hypothetical protein +FIG01578672 Serine/threonine-protein kinase PknE (EC 2.7.11.1) +FIG01578673 phosphatase-like protein( EC:3.1.3.18 ) +FIG01578686 FIG00404360: hypothetical protein +FIG01578718 FIG00479213: hypothetical protein +FIG01578790 family transcriptional regulator +FIG01578813 FIG01045275: hypothetical protein +FIG01578817 hypothetical protein +FIG01578903 Putative short chain dehydrogenase( EC:1.1.1.- ) +FIG01578912 FIG00465769: hypothetical protein +FIG01578946 FIG01240718: hypothetical protein +FIG01578967 FIG01120426: hypothetical protein +FIG01578984 FIG00405553: hypothetical protein +FIG01578994 Probable low molecular weight protein-tyrosine-phosphatase epsP (EC 3.1.3.48) +FIG01579009 FIG00425694: hypothetical protein +FIG01579030 FIG01166597: hypothetical protein +FIG01579074 FIG00749367: hypothetical protein +FIG01579080 FIG00734310: hypothetical protein +FIG01579103 FIG00389195: hypothetical protein +FIG01579109 Exonuclease, possibly dna polymerase III epsilon subunit (EC 2.7.7.7) +FIG01579111 FIG00842418: hypothetical protein +FIG01579159 FIG00348553: hypothetical protein +FIG01579162 Phage-like element PBSX protein xkdM +FIG01579215 hypothetical protein bll5443 +FIG01579226 DNA topology modulation protein FLAR-related protein +FIG01579233 rifampin ADP-ribosyl transferase +FIG01579287 Membrane-associated methyl-accepting chemotaxis protein with HAMP domain +FIG01579347 mu DNA-binding domain protein +FIG01579353 FIG01233531: hypothetical protein +FIG01579391 FIG00817690: hypothetical protein +FIG01579407 PchX protein +FIG01579423 FIG00642449: hypothetical protein +FIG01579424 putative MTA/SAH nucleosidase +FIG01579431 ferric siderophore ABC transporter, periplasmic siderophore-binding protein +FIG01579440 Transglutaminase-like superfamily domain protein +FIG01579500 FIG00815557: hypothetical protein +FIG01579501 Viral protein TPX +FIG01579516 putative pullulanase precursor +FIG01579517 FIG00425873: hypothetical protein +FIG01579550 FIG01117854: hypothetical protein +FIG01579573 Uncharacterized protein HI0592 +FIG01579627 Sphingosine kinase 2 (EC 2.7.1.-) +FIG01579630 hypothetical protein +FIG01579664 protein of unknown function DUF1332 +FIG01579683 FIG00348979: hypothetical protein +FIG01579712 FIG001454: Transglutaminase-like enzymes, putative cysteine proteases +FIG01579733 novel N-acetylglucosamine kinase of eukaryotic type (EC 2.7.1.59) +FIG01579744 Hemolysin-type calcium binding protein +FIG01579771 transcriptional regulator/antitoxin, MazE +FIG01579811 FIG00513646: hypothetical protein +FIG01579829 syc2363_c +FIG01579952 FIG00344440: hypothetical protein +FIG01579956 3-hydroxy-3-methylglutaryl CoA synthase +FIG01579989 DNA mismatch repair protein +FIG01579994 NADH-ubiquinone oxidoreductase, putative +FIG01580013 FIG00630608: hypothetical protein +FIG01580043 possible tautomerase +FIG01580056 hypothetical protein +FIG01580082 FIG00994805: hypothetical protein +FIG01580088 FIG00824589: hypothetical protein +FIG01580109 type IV secretion system protein VirB5 precursor; 17-kDa antigen precursor +FIG01580123 FIG01114910: hypothetical protein +FIG01580165 Protein of unknown function DUF450 +FIG01580181 putative iron uptake protein +FIG01580183 FIG00922675: hypothetical protein +FIG01580197 Transcriptional (co)regulator CytR +FIG01580206 FIG00849575: hypothetical protein +FIG01580212 FIG00569791: hypothetical protein +FIG01580221 FIG00986889: hypothetical protein +FIG01580249 GGDEF/GAF domain protein +FIG01580250 COG4989: Predicted oxidoreductase +FIG01580251 FIG00675376: hypothetical protein +FIG01580265 prophage pi2 protein 02 +FIG01580277 FIG00545175: hypothetical protein +FIG01580283 Sea24 +FIG01580334 Type I secretion membrane fusion protein, HlyD +FIG01580344 galactoside transport system permease protein mglC +FIG01580348 Amidohydrolase family superfamily +FIG01580375 FIG00660544: hypothetical protein +FIG01580385 Domain of unknown function (DUF386) superfamily +FIG01580390 Polyglutamate synthase CapA +FIG01580395 FIG00818401: hypothetical protein +FIG01580428 3-isopropylmalate dehydratase large subunit +FIG01580431 (Acyl-carrier-protein) phosphodiesterase( EC:3.1.4.14 ) +FIG01580435 type IV secretion system protein VirB7, 15 kDa Antigen +FIG01580438 conserved putative exported protein +FIG01580461 FIG00624533: hypothetical protein +FIG01580473 Putative RTX family exoprotein A gene +FIG01580480 FIG00424381: hypothetical protein +FIG01580513 FIG00388515: hypothetical protein +FIG01580530 hypothetical protein +FIG01580556 C-compound and carbohydrate utilization +FIG01580583 Uncharacterized low-complexity proteins +FIG01580604 DNA translocase +FIG01580626 Xylose isomerase-like TIM barrel +FIG01580657 Lmo2272 protein +FIG01580661 transcriptional regulator, AraC family +FIG01580670 FIG00385208: hypothetical protein +FIG01580676 Ferredoxin oxidoreductase +FIG01580715 Uncharacterized protein MJ0971 +FIG01580738 FIG00388886: hypothetical protein +FIG01580745 hypothetical protein +FIG01580746 FIG00389048: hypothetical protein +FIG01580749 FIG00404491: hypothetical protein +FIG01580764 Acetamidase/formamidase family protein +FIG01580765 putative outer membrane receptor +FIG01580784 putative inner membrane transport protein +FIG01580791 adenine-specific DNA-methyltransferase +FIG01580804 Mll5255 protein +FIG01580849 FIG00766340: hypothetical protein +FIG01580855 putative ATP/GTP-binding protein remnant +FIG01580899 lmbT protein +FIG01580901 CRISPR-associated SAG0897 family protein +FIG01580924 FIG235896: hypothetical protein +FIG01580940 LysR-type transcriptional regulator +FIG01580975 Carbohydrate-binding family V/XII +FIG01580987 glycoside hydrolase, family 18 +FIG01580988 FIG00755025: hypothetical protein +FIG01580996 putative transcriptional regulator, TetR family +FIG01581025 cytolytic delta-endotoxin (insecticidal protein) +FIG01581055 FIG00344580: hypothetical protein +FIG01581083 ankyrin containing protein +FIG01581128 CHLPS 43 kDa protein homolog_3 +FIG01581135 extradiol dioxygenase, type I +FIG01581139 ISSpo3, transposase +FIG01581175 FIG00566142: hypothetical protein +FIG01581203 leucine-, isoleucine-, valine-, threonine-, and alanine-binding protein +FIG01581220 ASPIC/UnbV domain protein +FIG01581227 putative lipopolysaccharide core biosynthesis mannosyltransferaseprotein +FIG01581240 FIG01115743: hypothetical protein +FIG01581253 FIG00764524: hypothetical protein +FIG01581275 GGDEF domain/HD domain protein +FIG01581281 COG0845: Membrane-fusion protein +FIG01581324 FIG00818577: hypothetical protein +FIG01581330 FIG00404570: hypothetical protein +FIG01581334 Bll4656 protein +FIG01581368 syc1477_c +FIG01581372 FIG00624034: hypothetical protein +FIG01581389 Membrane protein, Bmp family +FIG01581445 Abort lactococcal phage infection AbiTii +FIG01581476 FIG00711957: hypothetical protein +FIG01581514 LPXTG anchored putative adhesin +FIG01581547 FIG00385358: hypothetical protein +FIG01581548 FIG01240554: hypothetical protein +FIG01581550 FIG00571613: hypothetical protein +FIG01581582 dihydrolipoamide dehydrogenase +FIG01581633 CBS domain protein/ACT domain protein +FIG01581637 FIG00344766: hypothetical protein +FIG01581655 similar to ECF-family RNA polymerase sigma factor +FIG01581659 FIG00682303: hypothetical protein +FIG01581701 FIG01228486: hypothetical protein +FIG01581712 FIG00768305: hypothetical protein +FIG01581759 ORF_ID:all7665 hypothetical protein +FIG01581762 YVGZ protein +FIG01581773 N-methyl-transferase +FIG01581777 FIG01202273: hypothetical protein +FIG01581789 FIG00631656: hypothetical protein +FIG01581806 TraW +FIG01581831 Rhomboid-like protein +FIG01581841 Two Component Transcriptional Regulator, LuxR family (EC 3.1.1.61) +FIG01581846 Dehydrogenase, E1 component +FIG01581859 putative exporter +FIG01581896 hypothetical protein +FIG01581911 Uncharacterized secreted protein +FIG01581941 VirA +FIG01581951 Similar to 5-oxoprolinase (EC 3.5.2.9) and Methylhydantoinases A, B (EC 3.5.2.14), N-terminal domain +FIG01581967 FIG00733708: hypothetical protein +FIG01581985 Mesaconyl-CoA C1-C4 CoA transferase +FIG01581990 diguanylate cyclase/phosphodiesterase with GAF sensor +FIG01581996 conserved hypothetical protein ; putative menbrane protein +FIG01582001 DTW domain containing protein +FIG01582048 FIG00388605: hypothetical protein +FIG01582059 RNA-binding proteins (RRM domain) +FIG01582060 FIG00828045: hypothetical protein +FIG01582065 Protein of unknown function DUF497 +FIG01582096 YdfS +FIG01582098 FIG00639997: hypothetical protein +FIG01582104 conserved hypothetical protein-putative transglutaminase-like enzyme +FIG01582108 FIG00846775: hypothetical protein +FIG01582119 FIG00408819: hypothetical protein +FIG01582134 FIG01229214: hypothetical protein +FIG01582141 FIG00965772: hypothetical protein +FIG01582180 putative cell division-related protein +FIG01582186 UPF0126 membrane protein SCO4104 +FIG01582194 FIG00911228: hypothetical protein +FIG01582200 FIG01116836: hypothetical protein +FIG01582212 FIG00692143: hypothetical protein +FIG01582246 FIG00519914: hypothetical protein +FIG01582259 CofG +FIG01582317 ABC-type histidine/lysine/arginine/ornithine transporter, permease component +FIG01582371 FIG00379722: hypothetical protein +FIG01582386 hypothetical protein +FIG01582410 FIG00765009: hypothetical protein +FIG01582440 FIG00388247: hypothetical protein +FIG01582447 FIG00527229: hypothetical protein +FIG01582449 FIG00352741: hypothetical protein +FIG01582486 Streptomycin 6-kinase +FIG01582495 transcription regulator, LacI family [imported], putative +FIG01582522 FIG115872: hypothetical protein +FIG01582554 molybdopterin-guanine dinucleotide biosynthesis MobB region +FIG01582556 Intracellular protease/amidase related enzyme (ThiJ family) +FIG01582569 FIG01084422: hypothetical protein +FIG01582616 FIG00524539: hypothetical protein +FIG01582631 FIG00901969: hypothetical protein +FIG01582641 LysR-family regulatory protein. +FIG01582654 Putative two component system response regulator +FIG01582674 transcriptional antiterminator, Rof +FIG01582711 Mov34/MPN/PAD-1 family protein +FIG01582735 FIG00356766: hypothetical protein +FIG01582740 IS3 family element, transposase orfB +FIG01582743 Putative transcriptional regulator +FIG01582760 FIG00344098: hypothetical protein +FIG01582768 Resembles eukaryotic-type potassium channels +FIG01582801 FIG01117292: hypothetical protein +FIG01582824 choline transporter +FIG01582861 Phage antitermination protein +FIG01582896 putative metal-dependent hydrolase, membrane-bound +FIG01582936 PROBABLE PORIN SIGNAL PEPTIDE PROTEIN +FIG01582947 FIG00256218: hypothetical protein +FIG01583003 sensor histidine kinase PhoR +FIG01583039 exopolysaccharide biosynthesis domain protein +FIG01583048 FIG00623762: hypothetical protein +FIG01583056 amino acid transporter, putative +FIG01583058 PE-PGRS FAMILY PROTEIN +FIG01583071 FIG00353110: hypothetical protein +FIG01583080 ABC-type amino acid transport system, secreted component +FIG01583097 subtilase family protein +FIG01583101 FIG00352376: hypothetical protein +FIG01583106 Tn5045 resolvase +FIG01583112 Protease subunit of ATP-dependent Clp proteases +FIG01583125 Specialized sigma subunit of RNA polymerase +FIG01583146 alpha/beta fold hydrolase +FIG01583149 hypothetical protein +FIG01583164 Oxidoreductase, short-chain dehydrogenase/reductase (EC 1.1.1.-) +FIG01583221 FIG00734134: hypothetical protein +FIG01583239 FrrI +FIG01583258 FIG00640445: hypothetical protein +FIG01583261 FIG00222257: hypothetical protein +FIG01583289 Myo-inositol 2-dehydrogenase (EC 1.1.1.18) +FIG01583321 FIG01067224: hypothetical protein +FIG01583322 FIG00385329: hypothetical protein +FIG01583353 FIG01046304: hypothetical protein +FIG01583359 regulators of stationary/sporulation gene expression +FIG01583396 FIG01077590: hypothetical protein +FIG01583399 FIG00388725: hypothetical protein +FIG01583412 Sugar transporter family protein +FIG01583447 LytTr DNA-binding domain protein +FIG01583509 FIG00767216: hypothetical protein +FIG01583517 FIG00385267: hypothetical protein +FIG01583522 FIG01049225: hypothetical protein +FIG01583576 FIG00408146: hypothetical protein +FIG01583594 mucin-like glycoprotein 900 +FIG01583637 All0746 protein +FIG01583641 Putative hemolysin activation/secretion protein +FIG01583642 Sodium/sulphate symporter +FIG01583686 DNA for TA region of Ti plasmid +FIG01583706 FIG00529363: hypothetical protein +FIG01583759 conserved hypothetical protein-putative a transcriptional regulator +FIG01583762 FIG00623828: hypothetical protein +FIG01583764 FIG00871400: hypothetical protein +FIG01583808 FIG01027704: hypothetical protein +FIG01583809 FIG01175600: hypothetical protein +FIG01583816 FIG00390391: hypothetical protein +FIG01583829 Transcriptional regulator ArsR family +FIG01583832 peptidase, zinc-dependent +FIG01583854 conserved hypothetical protein, putative nucleotidyltransferase +FIG01583876 phage Terminase +FIG01583881 FIG00568540: hypothetical protein +FIG01583887 ATPase / Transcriptional regulator, LuxR family +FIG01583888 FIG00388794: hypothetical protein +FIG01583923 Conserved membrane protein YfiD +FIG01583930 possible pirin-like protein +FIG01583958 SenC +FIG01583968 FIG00623257: hypothetical protein +FIG01583988 protein of unknown function DUF896 +FIG01584034 regulatory components of sensory transduction system +FIG01584083 FIG00556632: hypothetical protein +FIG01584089 Mll7338 protein +FIG01584092 Ribonuclease precursor (barnase), secreted. +FIG01584123 Nickel and cobalt efflux transporter rcnA +FIG01584125 FIG00451210: hypothetical protein +FIG01584160 type II DNA modification methyltransferase, putative +FIG01584170 Permease protein of polyamine ABC transporter +FIG01584174 FIG00290938: hypothetical protein +FIG01584236 phage transcriptional regulator, RinA family +FIG01584261 FIG00470112: hypothetical protein +FIG01584267 lytic murein transglycosylase +FIG01584278 Cytochrome P450 136 +FIG01584305 Cell divisionFtsK/SpoIIIE protein +FIG01584314 BH0010 unknown +FIG01584362 FIG00362155: hypothetical protein +FIG01584363 Predicted hydrolase of the HAD family +FIG01584401 Serine beta-lactamase-like protein LACTB +FIG01584411 Suppressor protein SRP40 +FIG01584424 FIG00412745: hypothetical protein +FIG01584441 ATP-dependent RNA helicase homolog eIF-4A +FIG01584462 FIG00733285: hypothetical protein +FIG01584467 Truncated transposase +FIG01584515 BAT1-like +FIG01584516 FIG00733309: hypothetical protein +FIG01584544 Cobalamin-independent methionine synthase II +FIG01584551 FIG00674973: hypothetical protein +FIG01584602 glycosyltransferase (group 1) +FIG01584608 probable diverged CheY-domain +FIG01584645 PEP phosphonomutase +FIG01584676 BFD-like iron-sulfur cluster-binding protein +FIG01584684 protein of unknown function DUF512 +FIG01584795 putative component D of type II secretion pathway +FIG01584852 Bacteriophage N4 adsorption protein A precursor +FIG01584883 FIG00808938: hypothetical protein +FIG01584902 FIG01021702: hypothetical protein +FIG01584953 Chain A, Crystal Structure Of The A-Subunit Of The Ab5 Toxin From E. Coli +FIG01584975 alpha-1,2-mannosidase +FIG01585023 COG2319: FOG: WD40 repeat +FIG01585035 possible indole oxygenase +FIG01585095 FIG00385203: hypothetical protein +FIG01585114 Integrase, catalytic region +FIG01585126 FIG00425572: hypothetical protein +FIG01585152 Diguanylate cyclase/phosphodiesterase domain (GGDEF) containing protein +FIG01585176 Protein of unknown function DUF742 +FIG01585215 deacylase-like protein +FIG01585233 FIG00624230: hypothetical protein +FIG01585235 FIG00526124: hypothetical protein +FIG01585259 Cytochrome c precursor +FIG01585303 FIG00820237: hypothetical protein +FIG01585310 KapB +FIG01585317 FIG01165560: hypothetical protein +FIG01585333 Colicin E2 tolerance protein CbrC +FIG01585334 uncharacterized protein, possibly involved in aromatic compounds catabolism +FIG01585356 peptidase, family M23/M37 domain protein +FIG01585367 BigB +FIG01585387 FIG00526372: hypothetical protein +FIG01585415 FIG00426202: hypothetical protein +FIG01585428 FIG00768397: hypothetical protein +FIG01585460 FIG00768458: hypothetical protein +FIG01585492 TonB-dependent receptor domain protein +FIG01585498 HAD phosphatase superfamily protein +FIG01585525 CopG-like DNA-binding +FIG01585545 FIG00623170: hypothetical protein +FIG01585567 FIG00385061: hypothetical protein +FIG01585642 FIG00526796: hypothetical protein +FIG01585653 PBS lyase HEAT repeat-like domain protein +FIG01585692 InterPro IPR000104:IPR000727:IPR003660:IPR004089 COGs COG0840 +FIG01585757 FIG00767758: hypothetical protein +FIG01585765 Epoxide hydrolase-like +FIG01585770 Putative dipeptidase +FIG01585800 Histone-like nucleoid-structuring protein H-NS +FIG01585803 FIG00768004: hypothetical protein +FIG01585804 hydrolase, NUDIX family, putative +FIG01585805 Peptidase S8 family domain in Subtilisin-like protein +FIG01585822 Siderophore biosynthesis non-ribosomal peptide synthetase modules +FIG01585834 FIG00767076: hypothetical protein +FIG01585835 transport protein HasD, putative +FIG01585847 putative glycosyl transferases +FIG01585874 putative aminotransferase( EC:2.6.1.- ) +FIG01585900 FIG01233582: hypothetical protein +FIG01585912 iron aquisition yersiniabactin synthesis enzyme (Irp2) +FIG01585956 possible secreted hydrolase +FIG01585981 Bem46 protein +FIG01585989 FIG00624836: hypothetical protein +FIG01585999 FIG00353774: hypothetical protein +FIG01586027 FIG01032523: hypothetical protein +FIG01586118 putative membrane protein-putative a lipopolysaccharide biosynthesis acyltransferase +FIG01586160 FIG00388440: hypothetical protein +FIG01586204 FIG00380950: hypothetical protein +FIG01586217 S-layer related protein precursor, sialic acid-specific 9-O-acetylesterase +FIG01586265 hypothetical protein +FIG01586275 FIG00664543: hypothetical protein +FIG01586280 Glutamate Aspartate transport system permease protein GltJ (TC 3.A.1.3.4) +FIG01586288 FIG00794299: hypothetical protein +FIG01586321 FIG00624004: hypothetical protein +FIG01586335 conserved hypothetical protein, DoxX +FIG01586342 FIG01047766: hypothetical protein +FIG01586348 Fatty acid hydroxylase +FIG01586352 InterPro IPR000683:IPR004104 COGs COG0673 +FIG01586391 Tripartite ATP-independent periplasmic transporter, DctQ component +FIG01586426 FIG00387844: hypothetical protein +FIG01586433 Glycoside hydrolase, family 13-like +FIG01586440 FIG00385772: hypothetical protein +FIG01586505 PLA depolymerase +FIG01586508 COG0028: Thiamine pyrophosphate-requiring enzymes [acetolactate synthase, pyruvate dehydrogenase (cytochrome), glyoxylate carboligase, phosphonopyruvate decarboxylase] +FIG01586515 Mobilization protein MobM +FIG01586548 FIG00674790: hypothetical protein +FIG01586550 putative cystine-binding periplasmic protein +FIG01586559 FeoA +FIG01586582 conserved hypothetical protein-putative related to competence-damage inducible protein +FIG01586587 condensation domain protein +FIG01586588 FIG00528113: hypothetical protein +FIG01586617 Uncharacterized protein y4fB +FIG01586640 oxidoreductase (membrane protein) +FIG01586672 Predicted DNA-binding protein containing a Zn-ribbon domain +FIG01586673 Putative intracellular protease/amidase (ThiJ family) +FIG01586677 hybrid sensory kinase +FIG01586682 AbiQ-like protein +FIG01586707 Subtilisin Carlsberg precursor (EC 3.4.21.62) +FIG01586715 FIG00434251: hypothetical protein +FIG01586723 FIG00356325: hypothetical protein +FIG01586724 possible protein-tyrosine-phosphatase( EC:3.1.3.48 ) +FIG01586743 FIG00347877: hypothetical protein +FIG01586746 hypothetical protein +FIG01586784 FIG01232273: hypothetical protein +FIG01586807 FIG00734078: hypothetical protein +FIG01586836 FIG00349837: hypothetical protein +FIG01586842 Cell division protein DivIC (FtsB), stabilizes FtsL against RasP cleavage +FIG01586880 hypothetical protein +FIG01586911 InterPro IPR000379 COGs COG2945 +FIG01586912 tRNA and rRNA cytosine-C5-methylases +FIG01586923 FIG01114143: hypothetical protein +FIG01586946 Asl2194 protein +FIG01586955 putative ATPase involved in DNA repair +FIG01587014 FIG00494112: hypothetical protein +FIG01587024 FIG00514876: hypothetical protein +FIG01587041 FIG00624825: hypothetical protein +FIG01587047 similarity to competence protein F +FIG01587089 Restriction enzyme BgcI alpha subunit (EC 3.1.21.-) [Includes: Adenine-specific methyltransferase activity (EC 2.1.1.72)] +FIG01587094 FIG00350057: hypothetical protein +FIG01587107 FIG00389190: hypothetical protein +FIG01587142 FIG01234698: hypothetical protein +FIG01587151 Iron siderophore receptor protein +FIG01587163 hypothetical protein +FIG01587180 putative transport integral membrane protein +FIG01587204 syc1505_d +FIG01587236 FIG071147: hypothetical protein +FIG01587237 FIG00350030: hypothetical protein +FIG01587275 Putative WD-40 repeat protein +FIG01587299 FIG00425903: hypothetical protein +FIG01587301 FIG00389789: hypothetical protein +FIG01587304 Jag protein +FIG01587306 proteinase +FIG01587309 RND-type multidrug efflux pump, outer membrane protein +FIG01587325 glutamine ABC transporter glutamine-binding protein +FIG01587341 Phage terminase, ATPase subunit +FIG01587386 1-aminocyclopropane-1-carboxylate deaminase (EC 3.5.99.7) +FIG01587408 4-hydroxybenzoate octaprenyltransferase +FIG01587435 extracellular solute-binding proteins, family 3/GGDEF domain protein +FIG01587437 FIG01239073: hypothetical protein +FIG01587454 exopolysaccharide biosynthesis protein, sugar transferase +FIG01587493 H. pylori predicted coding region HP1283 +FIG01587513 Phage envelope protein +FIG01587531 FIG01204119: hypothetical protein +FIG01587618 putative isomerase +FIG01587647 hypothetical protein; putative cupin domain. +FIG01587679 TPR domain protein, truncation +FIG01587682 probably aromatic ring hydroxylating enzyme, evidenced by COGnitor +FIG01587683 FIG00347713: hypothetical protein +FIG01587701 FIG00413110: hypothetical protein +FIG01587740 protein of unknown function DUF34 +FIG01587776 FIG00414320: hypothetical protein +FIG01587778 FIG00769471: hypothetical protein +FIG01587785 Pli0065 protein +FIG01587812 transposase IS116/IS110/IS902 family protein +FIG01587818 FIG028593: membrane protein +FIG01587819 probable chemotaxis transducer +FIG01587828 Pyruvoyl-dependent arginine decarboxylase (EC 4.1.1.19) +FIG01587839 FIG01131184: hypothetical protein +FIG01587843 TPR repeat:Peptidase S41:RDD:Tetratricopeptide TPR_3 +FIG01587892 Outer membrane protein I precursor +FIG01587903 FIG01135463: hypothetical protein +FIG01587916 Xaa-Pro aminopeptidase family enzyme +FIG01587927 Putative efflux membrane protein (partial match) +FIG01587948 FIG00388645: hypothetical protein +FIG01587950 FIG00860105: hypothetical protein +FIG01587982 putative transport system ATP-binding protein +FIG01588023 FIG00347514: hypothetical protein +FIG01588028 putative AraC transcriptional regulatory protein +FIG01588048 FIG00358116: hypothetical protein +FIG01588052 Ortholog putative anti-SigV factor [Bacillus subtilis] +FIG01588080 probable transposase, IS605 family +FIG01588098 nitrilase 1 +FIG01588103 proton antiporter efflux pump +FIG01588117 FIG00471975: hypothetical protein +FIG01588123 FIG00361875: hypothetical protein +FIG01588135 FIG00529946: hypothetical protein +FIG01588162 Biofilm-associated protein +FIG01588176 Mercury resistance probable Hg transport protein +FIG01588188 FIG00385758: hypothetical protein +FIG01588198 putative secreted sugar-binding protein +FIG01588203 adenine DNA methyltransferase +FIG01588214 transcriptional regulator araC family protein +FIG01588218 Alkyl sulfatase or beta-lactamase (EC 3.1.6.-) +FIG01588223 FIG00819464: hypothetical protein +FIG01588243 protein containing QXW lectin repeats +FIG01588248 FIG01017538: hypothetical protein +FIG01588261 FIG00897336: hypothetical protein +FIG01588267 FIG01249401: hypothetical protein +FIG01588280 porin O precursor +FIG01588282 Transcriptional regulator, TetR family +FIG01588302 FIG00751098: hypothetical protein +FIG01588308 Putative porin B precursor outer transmembrane protein +FIG01588314 PREDICTED: similar to beta-1,3-galactosyltransferase-6 +FIG01588316 conserved hypothetical protein-putative exnuclease related to the exonuclease domain of PolB +FIG01588335 3,4-dihydroxyphthalate decarboxylase +FIG01588349 Neutral endopeptidase (EC 3.4.-.-) +FIG01588386 Ferrichrome ABC transporter ATP-binding protein +FIG01588397 predicted amino-acid transport protein +FIG01588399 FIG01055428: hypothetical protein +FIG01588411 possible GatB/Yqey domain +FIG01588417 FIG00816456: hypothetical protein +FIG01588429 FIG00750683: hypothetical protein +FIG01588442 probable competence protein +FIG01588455 FIG00341670: hypothetical protein +FIG01588467 FIG00356744: hypothetical protein +FIG01588485 Uncharacterized protein Rv1501/MT1550 +FIG01588494 Uncharacterized conserved small protein-like +FIG01588496 FIG00528435: hypothetical protein +FIG01588521 possible sodium dependent transporter +FIG01588565 Pherophorin-dz1 protein precursor +FIG01588582 FIG00896343: hypothetical protein +FIG01588602 putative depolymerase +FIG01588616 O-antigen conversion: translocase +FIG01588618 TETRATRICOPEPTIDE REPEAT FAMILY PROTEIN +FIG01588658 FIG00633171: hypothetical protein +FIG01588680 Secreted guanine-specific ribonuclease +FIG01588682 Amino acid ABC transporter, periplasmic amino acid-binding protein +FIG01588711 FIG01236073: hypothetical protein +FIG01588752 poly granule associated +FIG01588757 FIG01084097: hypothetical protein +FIG01588822 immunogenic protein P37, putative +FIG01588871 ISAfe7, transposase OrfA +FIG01588882 Serine/threonine sodium symporter +FIG01588938 FIG00388178: hypothetical protein +FIG01588945 FIG00767242: hypothetical protein +FIG01588951 FIG01236266: hypothetical protein +FIG01588962 FIG01210695: hypothetical protein +FIG01589027 FIG00733427: hypothetical protein +FIG01589028 FIG00349859: hypothetical protein +FIG01589073 Probable transcription regulator protein +FIG01589089 aldehyde dehydrogenase( EC:1.2.1.65 ) +FIG01589136 Putative N-acetylglucosamine kinase( EC:2.7.1.59 ) +FIG01589137 Phenylacetate-coenzyme A ligase +FIG01589158 FIG00834059: hypothetical protein +FIG01589185 FIG00624406: hypothetical protein +FIG01589218 predicted inner membrane protein +FIG01589241 hypothetical protein +FIG01589250 FIG047884 (not subsystem-based): Universal stress protein +FIG01589260 Outer membrane protein H1 +FIG01589278 Transglutaminase-like predicted protease domain fused ChW-repeats and cell-adhesion domain +FIG01589305 FIG00344154: hypothetical protein +FIG01589316 FIG00751810: hypothetical protein +FIG01589319 UbiD paralog +FIG01589329 Autoinducer synthesis protein +FIG01589336 FIG00816417: hypothetical protein +FIG01589359 hypothetical protein +FIG01589375 FIG01210809: hypothetical protein +FIG01589385 FIG01047745: hypothetical protein +FIG01589413 FIG01047120: hypothetical protein +FIG01589430 COG2364: Predicted membrane protein +FIG01589435 FIG00407658: hypothetical protein +FIG01589446 succinoglycan biosynthesis ketolase +FIG01589470 FIG00468196: hypothetical protein +FIG01589554 FIG00350582: hypothetical protein +FIG01589585 hypothetical protein +FIG01589664 SNase-like nuclease +FIG01589678 protein of unknown function DUF124 +FIG01589736 FIG00753461: hypothetical protein +FIG01589820 FIG01166670: hypothetical protein +FIG01589825 ABC transporter ATP-binding-Pr2-like +FIG01589834 FIG00355873: hypothetical protein +FIG01589893 Erythrocyte membrane-associated antigen +FIG01589906 Arginyl-tRNA synthetase +FIG01589978 Conserved protein YqkD +FIG01590023 araC-family transcriptional regulator +FIG01590033 DivIVA family protein +FIG01590035 FIG01244449: hypothetical protein +FIG01590047 FIG00775432: hypothetical protein +FIG01590067 response regulator (homolog to ciaR Spn), truncated +FIG01590077 Na+/Ca2+-exchanging protein +FIG01590095 Alanyl-tRNA synthetase family 2 protein +FIG01590099 FIG00388931: hypothetical protein +FIG01590118 FIG00487125: hypothetical protein +FIG01590136 CYTOCHROME B561 +FIG01590146 unknown protein, phage associated +FIG01590148 nudix (MutT) family hydrolase +FIG01590169 probable solute-binding protein +FIG01590175 Hypothetical methyl-accepting chemotaxis protein +FIG01590185 FIG01237242: hypothetical protein +FIG01590194 Permease, major facilitator superfamily +FIG01590205 FIG00672660: hypothetical protein +FIG01590218 FIG01206993: hypothetical protein +FIG01590243 FIG00766142: hypothetical protein +FIG01590318 conserved protein YwiB +FIG01590325 phenylpyruvate tautomerase, putative +FIG01590360 FIG00816410: hypothetical protein +FIG01590375 FIG00425012: hypothetical protein +FIG01590456 Spore protease GPR related protein, YYAC B.subtilis ortholog +FIG01590464 Hypothetical protein, CF-21 family +FIG01590482 FIG00363253: hypothetical protein +FIG01590534 FIG00528171: hypothetical protein +FIG01590545 FIG00417241: hypothetical protein +FIG01590547 HAD-superfamily hydrolase, subfamily IIA +FIG01590549 Transcriptional regulatory protein, ros/mucR family +FIG01590570 FIG00631626: hypothetical protein +FIG01590587 Ig domain-containing protein +FIG01590617 N5,N10-methylenetetrahydromethanopterin reductase-related protein, SAV7403 family +FIG01590627 hypothetical protein +FIG01590628 Nicotinamidase (EC 3.5.1.19), homolog +FIG01590634 terminase, large subunit, putative +FIG01590683 FIG01221384: hypothetical protein +FIG01590686 FIG00624786: hypothetical protein +FIG01590728 Flagellar protein FlaG protein +FIG01590806 Phage protein +FIG01590810 FIG00957896: hypothetical protein +FIG01590813 Transcription elongation factor GreA-related protein +FIG01590861 FIG01117335: hypothetical protein +FIG01590873 FIG00385498: hypothetical protein +FIG01590879 Invasin +FIG01590915 FIG00531052: hypothetical protein +FIG01590954 FIG00487304: hypothetical protein +FIG01590986 Oxygen-insensitive NADPH nitroreductase +FIG01591021 uncharacterized conserved protein containing predicted Zn-ribbon like domain +FIG01591039 Mlc, transcriptional repressor of MalT (the transcriptional activator of maltose regulon) and manXYZ operon +FIG01591044 FIG00364192: hypothetical protein +FIG01591057 Transposon Tn21 modulator protein +FIG01591063 Uncharacterized relative of glutathione S-transferase +FIG01591112 probable DNA-binding protein YPO0196 +FIG01591133 putative glyxalase +FIG01591174 lipoprotein UxpA +FIG01591208 PUTATIVE PERIPLASMIC BINDING PROTEIN +FIG01591214 COG1940: Transcriptional regulator/sugar kinase +FIG01591270 PTS system, fructose-specific IIA component +FIG01591275 Zinc carboxypeptidase superfamily +FIG01591299 Streptococcal histidine triad +FIG01591307 FIG00711515: hypothetical protein +FIG01591308 FIG00838208: hypothetical protein +FIG01591388 TonB-like protein +FIG01591391 FIG00623231: hypothetical protein +FIG01591393 Trypsin-1 precursor (EC 3.4.21.4) +FIG01591401 Multidrug resistance efflux protein +FIG01591406 flagellar FlbD family protein +FIG01591413 prophage ps2 protein 03 +FIG01591443 Outer membrane receptor protein, mostly Fe transport +FIG01591448 glucoamylase, (GLUCAN 1,4-ALPHA-GLUCOSIDASE) +FIG01591519 FIG00523611: hypothetical protein +FIG01591520 FIG00523557: hypothetical protein +FIG01591523 FIG00492661: hypothetical protein +FIG01591529 FIG00417535: hypothetical protein +FIG01591538 FIG00534832: hypothetical protein +FIG01591539 putative spore-coat protein +FIG01591547 di- and tripeptidases +FIG01591549 NLP/P60 family protein +FIG01591596 ORF_ID:alr8060 unknown protein +FIG01591598 FIG01166642: hypothetical protein +FIG01591642 FIG01043249: hypothetical protein +FIG01591678 FIG01115491: hypothetical protein +FIG01591684 putative surface-anchored protein +FIG01591687 N-acetylmuramoyl-L-alanine amidase cwlL precursor (EC 3.5.1.28) +FIG01591714 All3792 protein +FIG01591735 putative multidrag resistance protein +FIG01591806 related to NADH oxidase +FIG01591809 FIG00673064: hypothetical protein +FIG01591813 ORF C +FIG01591850 putative gluconate dehydrogenase +FIG01591855 FIG00958110: hypothetical protein +FIG01591878 diverges from R100 at 3' end +FIG01591932 similar to Putative stress-responsive transcriptional regulator +FIG01591982 FIG00361452: hypothetical protein +FIG01591984 alpha-ketoglutarate decarboxylase( EC:1.2.4.2 ) +FIG01591998 putative polygalacturonase (pectinase) +FIG01592016 Hypothetical protein, CF-41 family +FIG01592028 FIG00959305: hypothetical protein +FIG01592077 FIG00657157: hypothetical protein +FIG01592085 FIG00748619: hypothetical protein +FIG01592088 Membrane protein, MgtC/SapB family +FIG01592115 putative short chain alcohol dehydrogenase +FIG01592169 hypothetical protein +FIG01592182 probable sialidase +FIG01592253 related to dihydroorotate dehydrogenase +FIG01592264 Conserved hypothetical protein 374 +FIG01592293 probable decarboxylase +FIG01592300 phosphate regulon sensor protein phoR( EC:2.7.3.- ) +FIG01592330 FIG00416107: hypothetical protein +FIG01592341 FIG00766074: hypothetical protein +FIG01592343 syc0452_c +FIG01592354 MutL protein +FIG01592363 FIG01238806: hypothetical protein +FIG01592371 FIG01188200: hypothetical protein +FIG01592381 FIG00451206: hypothetical protein +FIG01592390 FIG00388230: hypothetical protein +FIG01592445 Iron oxidase precursor (EC 1.16.3.-) (Fe(II) oxidase) +FIG01592483 chromosome initiation inhibitor +FIG01592511 4-oxalocrotonate tautomerase family enzyme +FIG01592518 hypothetical bacteriophage protein +FIG01592564 FIG00344695: hypothetical protein +FIG01592565 putative transcriptional regulator, XRE family protein +FIG01592580 FIG00414726: hypothetical protein +FIG01592590 dCMP deaminase( EC:3.5.4.3 ) +FIG01592591 hypothetical protein +FIG01592608 General substrate transporter:Major facilitator superfamily MFS_1 +FIG01592623 Capsule biosynthesis protein capA +FIG01592635 FIG00835565: hypothetical protein +FIG01592637 FIG01080999: hypothetical protein +FIG01592648 transcriptional regulatory protein (probably TetR-family) +FIG01592655 renal dipeptidase +FIG01592689 HTH-type transcriptional regulator Ptr2 +FIG01592696 FIG00850348: hypothetical protein +FIG01592715 FIG00538558: hypothetical protein +FIG01592722 membrane lipoprotein +FIG01592724 methanogen enzyme similar to murein synthesis amino acid ligase +FIG01592733 FIG00520185: hypothetical protein +FIG01592808 Protein yciF +FIG01592809 transposase, IS200 family +FIG01592820 KlaA protein +FIG01592840 putative pleiotropic regulatory protein +FIG01592884 FIG00349265: hypothetical protein +FIG01592887 FIG00768837: hypothetical protein +FIG01592888 FIG00347527: hypothetical protein +FIG01592894 FIG00355960: hypothetical protein +FIG01592919 ADP-ribosylglycohydrolase( EC:3.2.- ) +FIG01592921 Predicted ATPase of HSP70 class +FIG01592973 FIG01062932: hypothetical protein +FIG01592981 FIG00424261: hypothetical protein +FIG01592997 multidrug resistance transporter, Bcr/CflA family, putative +FIG01593002 FIG00412021: hypothetical protein +FIG01593022 IS3 family transposase +FIG01593030 similar to biotin apo-protein ligase-related protein +FIG01593036 hypothetical DNA binding protein +FIG01593059 FIG00855827: hypothetical protein +FIG01593098 competence-stimulating peptide; CSP +FIG01593145 Transposase +FIG01593163 FIG00763652: hypothetical protein +FIG01593166 FIG00816148: hypothetical protein +FIG01593174 contains gram positive anchor domain +FIG01593183 Major facilitator family transporter +FIG01593199 Protein of unknown function DUF1085 +FIG01593238 FIG00624730: hypothetical protein +FIG01593279 FIG00533513: hypothetical protein +FIG01593282 UPF0398 protein ABC2016 +FIG01593296 FIG00623727: hypothetical protein +FIG01593297 FIG00417685: hypothetical protein +FIG01593316 FIG00351958: hypothetical protein +FIG01593335 Mannosylfructose-phosphate phosphatase mfppA +FIG01593366 PTS system, EIIA component +FIG01593378 FIG00416879: hypothetical protein +FIG01593382 FIG01235059: hypothetical protein +FIG01593394 MccC-like protein +FIG01593470 predicted transglutaminase/protease, putative +FIG01593523 FIG00410929: hypothetical protein +FIG01593544 Putative esterase protein (EC 3.1.1.-) +FIG01593545 FIG00767141: hypothetical protein +FIG01593553 Nuclease inhibitor +FIG01593585 Tyrosine-protein kinase wzc (EC 2.7.1.112) +FIG01593595 putative permease, chloride channel +FIG01593603 FIG01122473: hypothetical protein +FIG01593613 FIG00746618: hypothetical protein +FIG01593635 Probable sugar-binding periplasmic protein precursor +FIG01593702 FIG00388369: hypothetical protein +FIG01593704 small hydrophobic hypothetical protein +FIG01593737 Uncharacterized protein MJ0009 +FIG01593753 hypothetical protein +FIG01593799 Site-specific DNA recombinase +FIG01593809 FIG01239789: hypothetical protein +FIG01593817 arsenical resistance operon repressor +FIG01593836 syc1990_d +FIG01593856 P. aerophilum family 1964 protein +FIG01593863 FIG00525607: hypothetical protein +FIG01593872 FIG01206058: hypothetical protein +FIG01593884 FIG00532437: hypothetical protein +FIG01593887 putative nodulin-related protein +FIG01593929 hypothetical protein +FIG01593946 FIG00349520: hypothetical protein +FIG01593957 putative cAMP-binding protein +FIG01593966 Probable microcin H47 secretion/processing ATP-binding protein mchF (EC 3.4.22.-) +FIG01593979 FIG00529953: hypothetical protein +FIG01593995 COG0729: Outer membrane protein +FIG01593997 FIG00406286: hypothetical protein +FIG01594025 FIG00403161: hypothetical protein +FIG01594026 phosphoesterase, PA-phosphatase-related protein +FIG01594033 FIG00527147: hypothetical protein +FIG01594048 FIG00418196: hypothetical protein +FIG01594072 ATP-dependent DNA helicase RecG +FIG01594081 hypothetical protein +FIG01594085 FIG00348251: hypothetical protein +FIG01594120 FIG00623876: hypothetical protein +FIG01594121 Extracellular neutral metalloprotease, NPRE +FIG01594147 FIG00750255: hypothetical protein +FIG01594150 FIG00380000: hypothetical protein +FIG01594169 FIG00623319: hypothetical protein +FIG01594172 Protein of unknown function DUF307 +FIG01594181 hypothetical protein +FIG01594201 FIG00353728: hypothetical protein +FIG01594202 transformation system protein +FIG01594237 FIG00405589: hypothetical protein +FIG01594245 FIG00769549: hypothetical protein +FIG01594267 FIG00627914: hypothetical protein +FIG01594276 Vng1086c +FIG01594296 FIG01234033: hypothetical protein +FIG01594300 putative membrane CBS domain protein +FIG01594367 FIG00389330: hypothetical protein +FIG01594436 glutamate--cysteine ligase GCS2 +FIG01594501 N-formylglutamate amidohydrolase +FIG01594557 molybdopterin converting factor subunit 1 +FIG01594573 FIG00353438: hypothetical protein +FIG01594590 Conserved hypothetical protein 1655 +FIG01594604 FIG00623732: hypothetical protein +FIG01594631 hypothetical protein +FIG01594634 FIG00403428: hypothetical protein +FIG01594639 putative membrane transport protein +FIG01594645 probable P23 protein +FIG01594647 ORFID:MW0047 +FIG01594651 conserved hypothetical protein with endonuclease/exonuclease/phosphatase family domain +FIG01594657 FIG00353116: hypothetical protein +FIG01594667 Acetyl-hydrolase (EC 3.1.1.-) +FIG01594689 putative circadian clock protein, KaiC +FIG01594735 drug resistance MFS transporter, drug:H+ antiporter-2 (DHA2) family protein +FIG01594748 Uncharacterized protein MJ1199 +FIG01594768 Putative outer membrane lipoprotein +FIG01594813 chaperone protein hchA domain protein +FIG01594827 FIG00640380: hypothetical protein +FIG01594838 putative transcriptional regulator of the AsnC-family +FIG01594840 hypothetical protein, phage associated protein +FIG01594846 FIG00362006: hypothetical protein +FIG01594884 Spore-associated protein A precursor +FIG01594893 FIG00749190: hypothetical protein +FIG01594902 FIG00532250: hypothetical protein +FIG01594956 peptidase M56, BlaR1 +FIG01594960 putative KfrA protein +FIG01594967 FIG00644919: hypothetical protein +FIG01594982 FIG00633760: hypothetical protein +FIG01594991 FIG00875724: hypothetical protein +FIG01595019 Proteophosphoglycan 5 +FIG01595066 rhs protein +FIG01595074 BRO-like +FIG01595076 Heparin-binding hemagglutinin +FIG01595115 FIG01049755: hypothetical protein +FIG01595147 Possible non-processive endoglucanase family 9, secreted; CelG ortholog; dockerin and cellulose-binding domain +FIG01595156 FIG00765098: hypothetical protein +FIG01595230 FIG00450655: hypothetical protein +FIG01595233 nicotinate phosphoribosyltransferase +FIG01595235 FIG01160152: hypothetical protein +FIG01595237 FIG00424368: hypothetical protein +FIG01595254 outer membrane protein V +FIG01595284 Zn-finger domain associated with topoisomerase type I +FIG01595306 FIG00640251: hypothetical protein +FIG01595335 Transposase +FIG01595338 FIG00389003: hypothetical protein +FIG01595349 putative extracellular serine protease +FIG01595356 FIG00643010: hypothetical protein +FIG01595362 phosphatase YidA( EC:3.1.3.- ) +FIG01595483 FIG01240920: hypothetical protein +FIG01595489 FIG00380447: hypothetical protein +FIG01595495 Lead, cadmium, zinc and mercury transporting ATPase (EC 3.6.3.3) (EC 3.6.3.5); Copper-translocating P-type ATPase (EC 3.6.3.4) +FIG01595538 Nudix/MutT family protein +FIG01595542 Probable periplasmic protein precursor +FIG01595547 Aconitase A +FIG01595552 hypothetical protein +FIG01595554 FIG00388672: hypothetical protein +FIG01595610 COG0640: Predicted transcriptional regulators +FIG01595612 FIG00471749: hypothetical protein +FIG01595640 transmembrane sensor, putative +FIG01595653 FIG00353455: hypothetical protein +FIG01595664 FIG01113954: hypothetical protein +FIG01595682 Aggregation promoting factrelated surface protein +FIG01595707 FIG00755808: hypothetical protein +FIG01595724 FIG00743214: hypothetical protein +FIG01595741 FIG01251443: hypothetical protein +FIG01595745 COG1100: GTPase SAR1 and related small G proteins +FIG01595752 Putative translocase transmembrane protein +FIG01595759 tryptophan rich sensory protein +FIG01595765 PAP2 family protein/DedA family protein +FIG01595772 FIG00674746: hypothetical protein +FIG01595783 conjugal transfer protein precursor +FIG01595809 preprotein translocase, SecG subunit (secG) +FIG01595841 phytanoyl-CoA dioxygenase PhyH family protein +FIG01595882 transcriptional regulator, xre family +FIG01595885 FIG00712801: hypothetical protein +FIG01595916 FIG00441995: hypothetical protein +FIG01595946 Putative phosphohydrolases, Icc family +FIG01595954 transposase and inactivated derivative +FIG01595959 conserved protein of unknown function; putative FtsZ-associated protein +FIG01596003 COG0679: Predicted permeases +FIG01596007 FIG00876556: hypothetical protein +FIG01596022 putative transcriptional regulator, Nlp +FIG01596049 Putative peptidoglycan binding domain 1:ErfK/YbiS/YcfS/YnhG +FIG01596087 Dimethylsulfide methyltransferase corrinoid protein / Dimethylsulfide:corrinoid methyltransferase +FIG01596112 Bile acid 7-alpha dehydratase (EC 4.2.1.106) (BA7 alpha dehydratase) (Bile acid-inducible operon protein E) +FIG01596150 FIG01204139: hypothetical protein +FIG01596178 FIG00379978: hypothetical protein +FIG01596182 FIG00409957: hypothetical protein +FIG01596197 Hxr +FIG01596233 Small acid-soluble spore protein, alpha/beta family, SASP_4 +FIG01596260 RNA polymerase sigma factor sigW +FIG01596298 biotin protein +FIG01596310 FIG00355849: hypothetical protein +FIG01596317 COG2206: HD-GYP domain +FIG01596376 Amidase +FIG01596381 lysis S family protein +FIG01596445 Invertase/recombinase protein +FIG01596446 Probable transmembrane heme sensor +FIG01596491 RidA/YER057c/UK114 superfamily, group 7, YjgH-like protein +FIG01596499 Endoglucanase F precursor (EC 3.2.1.4) (EGF) (Endo-1,4-beta-glucanase) (Cellulase F) +FIG01596529 phage-related portal protein +FIG01596552 possible DNA gyrase/topoisomerase IV, subunit +FIG01596593 type II restriction-modification enzyme +FIG01596599 acetyltransferase (GNAT) family +FIG01596650 protein yceI +FIG01596674 Spermidine export protein MdtI +FIG01596700 Polypeptide-transport-associated domain protein, ShlB-type +FIG01596743 FIG01166316: hypothetical protein +FIG01596746 Viomycin phosphotransferase (EC 2.7.1.103) (Viomycin kinase) +FIG01596752 Two-component, sensor histidine kinase +FIG01596785 FIG00353143: hypothetical protein +FIG01596799 FIG00767992: hypothetical protein +FIG01596810 FIG00638862: hypothetical protein +FIG01596814 Rod binding-like protein +FIG01596825 Putative diguanylate cyclase/phosphodiesterase domain 1 +FIG01596828 FIG00525094: hypothetical protein +FIG01596879 Choline transporter, permease protein +FIG01596894 FIG00898502: hypothetical protein +FIG01596938 FIG00528518: hypothetical protein +FIG01596948 FIG00661840: hypothetical protein +FIG01596973 FIG00960458: hypothetical protein +FIG01596980 conserved hypothetical protein; putative DGPF domain +FIG01596982 Possible exosporium protein H +FIG01596990 Phenazine biosynthesis PhzC/PhzF protein +FIG01597016 FIG00974627: hypothetical protein +FIG01597105 FIG00522412: hypothetical protein +FIG01597110 monovalent cation/proton antiporter, MnhG/PhaG subunit +FIG01597166 FIG00826446: hypothetical protein +FIG01597195 NADH oxidase (EC 1.-.-.-) +FIG01597214 Cytochrome c3 +FIG01597228 probable exported protein YPO4040 +FIG01597315 FIG00688834: hypothetical protein +FIG01597334 FIG00873427: hypothetical protein +FIG01597339 conseved hypothetical protein +FIG01597389 FIG00519963: hypothetical protein +FIG01597396 Lipopolysaccharide heptosyltransferase I +FIG01597464 possible Sensor with GAF domain +FIG01597502 Protein of unknown function DUF888 +FIG01597529 uncharacterized protein UPF0065 +FIG01597565 putative transcriptional regulator, Crp/Fnr family +FIG01597618 FIG00515950: hypothetical protein +FIG01597675 DotH +FIG01597695 FIG01132868: hypothetical protein +FIG01597819 FIG00624198: hypothetical protein +FIG01597848 hypothetical protein +FIG01597893 FIG00711960: hypothetical protein +FIG01597901 phage integrase family domain protein +FIG01597930 Mu-like prophage major head subunit +FIG01597974 Na+/H+ antiporter NhaP +FIG01597977 FIG00406779: hypothetical protein +FIG01597980 FIG00745142: hypothetical protein +FIG01598018 FIG00814731: hypothetical protein +FIG01598055 probable imidazolonepropionase +FIG01598085 Undecaprenyl-phosphate galactose phosphotransferase (EC 2.7.8.6) +FIG01598087 Zonular occludens toxin +FIG01598097 putative dioxygenase subunit +FIG01598099 probable response regulatory protein (atoC) +FIG01598121 FIG00578586: hypothetical protein +FIG01598127 Probable abc-type multidrug transport system, permease component abc transporter protein +FIG01598140 UDP-N-acetylmuramyl pentapeptide phosphotransferase/UDP-N-acetylglucosamine-1-phosphate transferase +FIG01598142 FIG01128621: hypothetical protein +FIG01598167 FIG00645980: hypothetical protein +FIG01598253 Methyltransferase Sare_0198 +FIG01598255 FIG01242516: hypothetical protein +FIG01598275 conserved protein (PRC-barrel domain) +FIG01598292 FIG00745912: hypothetical protein +FIG01598293 FIG00363671: hypothetical protein +FIG01598323 syc1909_d +FIG01598329 molybdopterin converting factor, subunit 2 +FIG01598339 sensory histidine protein kinase +FIG01598369 FIG01242751: hypothetical protein +FIG01598375 Sodium/calcium exchanger family protein +FIG01598377 FIG00518488: hypothetical protein +FIG01598390 probable transcription regulatory protein YPO1927 +FIG01598417 FIG00407210: hypothetical protein +FIG01598427 TriL protein +FIG01598534 putative xylanase +FIG01598574 DUF1440 domain-containing membrane protein +FIG01598595 hypothetical conserved protein +FIG01598599 NhaC, Na+/H+ antiporter +FIG01598634 FIG00208745: hypothetical protein +FIG01598674 possible replication initiation protein +FIG01598681 molybdopterin biosynthesis enzyme, MoaB +FIG01598688 Ketopantoate reductase +FIG01598689 putative 4Fe-4S binding protein +FIG01598696 FIG01037878: hypothetical protein +FIG01598779 FIG00837807: hypothetical protein +FIG01598788 prophage Lp2 protein 24 +FIG01598822 putative plasmid partitioning protein +FIG01598824 Msl1750 protein +FIG01598827 FIG00361916: hypothetical protein +FIG01598834 contains uncharacterized ACR domain +FIG01598846 FIG00351524: hypothetical protein +FIG01598864 Possible flavodoxin oxidoreductase precursor +FIG01598875 Putative (AJ250469) putative SinR-like protein [Clostri +FIG01598902 TM2 +FIG01598930 FIG00642929: hypothetical protein +FIG01598936 Similar to C-terminal domain of competence/damage-inducible protein CinA +FIG01598970 Putative surface-anchored fimbrial associated protein +FIG01598982 FIG00384965: hypothetical protein +FIG01599056 FIG00343954: hypothetical protein +FIG01599059 SEC-C motif domain protein +FIG01599097 FIG00939884: hypothetical protein +FIG01599113 FIG00765933: hypothetical protein +FIG01599119 Alr3529 protein +FIG01599131 FIG00520749: hypothetical protein +FIG01599141 Peptidase A1, pepsin +FIG01599150 transcriptional regulator, TetR/AcrR-family +FIG01599168 HAD-superfamily hydrolase, putative +FIG01599216 Immunoglobulin-binding protein EIBE +FIG01599218 InterPro IPR001230 COGs COG1343 +FIG01599228 FIG00388838: hypothetical protein +FIG01599238 phage portal protein, lambda family +FIG01599240 NLP/P60 +FIG01599258 FIG00722096: hypothetical protein +FIG01599266 glucarate transporter +FIG01599278 FIG01123561: hypothetical protein +FIG01599291 NADPH:quinone reductase related Zn-dependent oxidoreductase +FIG01599336 FIG01119696: hypothetical protein +FIG01599348 FIG00417169: hypothetical protein +FIG01599415 FIG00814968: hypothetical protein +FIG01599523 FIG00410465: hypothetical protein +FIG01599528 Pyridoxal-dependent decarboxylase family protein (EC 4.1.1.-) +FIG01599536 FIG00565196: hypothetical protein +FIG01599555 Gll0907 protein +FIG01599562 Ig domain protein group 2 domain protein +FIG01599566 Carboxylate-amine ligase +FIG01599577 FIG00385176: hypothetical protein +FIG01599583 IS2 orf1, +FIG01599616 1-phosphofructokinase( EC:2.7.1.56 ) +FIG01599622 hypothetical protein +FIG01599674 Probable terminase, endonuclease subunit +FIG01599706 FIG00388541: hypothetical protein +FIG01599737 putative glycosyl transferase (WbnE) +FIG01599742 FIG00581864: hypothetical protein +FIG01599749 FIG00622874: hypothetical protein +FIG01599788 FIG00526784: hypothetical protein +FIG01599805 similar to acetyltransferase involved in intracellular survival and related acetyltransferases +FIG01599869 Secreted protein contains fibronectin type III domains +FIG01599889 Uncharacterized protein, homolog YvqG B.subtilis +FIG01599901 FIG00522516: hypothetical protein +FIG01599949 trypsinogen precursor +FIG01599985 FIG00405481: hypothetical protein +FIG01600014 putative transporter permease +FIG01600018 possible Hepatitis C virus envelope glycoprote +FIG01600066 FIG00733423: hypothetical protein +FIG01600068 oxidoreductase alr2142 [imported] +FIG01600102 Mll9311 protein +FIG01600166 phage / plasmid primase, P4 family +FIG01600196 FIG00623103: hypothetical protein +FIG01600211 GDSL lipase family protein +FIG01600240 FIG00624345: hypothetical protein +FIG01600244 conserved hypothetical 1 TMS, 30-80aa Actinobacteria protein +FIG01600265 Alr4810 protein +FIG01600266 Peptidase/PDZ domain protein +FIG01600298 conserved hypothetical protein-putative membrane protein +FIG01600306 predicted ORF +FIG01600323 GMP synthase - Glutamine amidotransferase domain-like protein +FIG01600331 FIG01167240: hypothetical protein +FIG01600342 Methylcobamide:CoM methyltransferase mtbA (EC 2.1.1.-) +FIG01600343 FIG00632055: hypothetical protein +FIG01600363 FIG00816566: hypothetical protein +FIG01600439 IS4 family transposase +FIG01600463 FIG00519742: hypothetical protein +FIG01600466 Cytochrome P450-pinF2, plant-inducible (EC 1.14.-.-) +FIG01600494 FIG00523847: hypothetical protein +FIG01600538 ISBma1, transposase +FIG01600540 FMN-dependent dehydrogenase +FIG01600558 putative cystathionine gamma-synthase protein +FIG01600595 FIG00827380: hypothetical protein +FIG01600629 cell wall-associated protein precursor WapA +FIG01600657 hypothetical protein +FIG01600683 FIG00385058: hypothetical protein +FIG01600694 peptidase C26 +FIG01600712 Protein of unknown function DUF466 +FIG01600718 hypothetical protein +FIG01600803 protein of unknown function DUF526 +FIG01600804 protein of unknown function DUF892 +FIG01600819 FIG00559292: hypothetical protein +FIG01600823 FIG00387827: hypothetical protein +FIG01600836 FIG00632940: hypothetical protein +FIG01600855 FIG00351602: hypothetical protein +FIG01600866 FIG00623411: hypothetical protein +FIG01600876 FIG00624147: hypothetical protein +FIG01600946 N-glycosylase/DNA lyase [Includes: 8-oxoguanine DNA glycosylase (EC 3.2.2.-); DNA-(apurinic or apyrimidinic site) lyase (EC 4.2.99.18) (AP lyase)] +FIG01600953 FIG00426379: hypothetical protein +FIG01600957 SagB-type dehydrogenase domain protein +FIG01600977 putative exported avidin family protein +FIG01600988 Sai integrase +FIG01601026 FIG01021385: hypothetical protein +FIG01601027 FIG00672797: hypothetical protein +FIG01601065 FIG00816958: hypothetical protein +FIG01601101 FIG00355992: hypothetical protein +FIG01601108 hypothetical protein +FIG01601109 FIG00941272: hypothetical protein +FIG01601179 Response regulator, LuxR family (CheY-HTH) +FIG01601197 FIG01219255: hypothetical protein +FIG01601230 possible lignostilbene-alpha,beta-dioxygenase +FIG01601273 putative peptidase precursor +FIG01601275 Outer membrane receptor for lactoferrin or transferrin, lipoprotein B +FIG01601280 predicted secreted or membrane protein +FIG01601284 syc1095_c +FIG01601292 FIG00361887: hypothetical protein +FIG01601309 FIG00690006: hypothetical protein +FIG01601380 FIG00385212: hypothetical protein +FIG01601423 unknown +FIG01601428 FIG00355896: hypothetical protein +FIG01601475 FIG00733170: hypothetical protein +FIG01601483 hypothetical protein +FIG01601510 putative phophoslipid binding protein +FIG01601559 Possible 3-oxo-(Acyl) acyl carrier protein reductase +FIG01601566 FIG00385424: hypothetical protein +FIG01601579 probable Peptidase +FIG01601624 Probable response regulator +FIG01601733 FIG00362224: hypothetical protein +FIG01601735 FIG00413734: hypothetical protein +FIG01601781 FHA-domain-containing proteins +FIG01601836 FIG01166243: hypothetical protein +FIG01601874 putative hydrolytic protein +FIG01601906 Asl2848 protein +FIG01601915 FIG00674146: hypothetical protein +FIG01601946 Possible haloacid dehalogenase (EC 3.8.1.-) +FIG01601962 FIG00487463: hypothetical protein +FIG01601971 DNA-binding protein Roi +FIG01601972 HTH-type transcriptional regulator hexR +FIG01601984 Membrane protein, YKJA_BACSU homolog +FIG01601985 Transposase +FIG01601994 Prophage MuSo1, transcriptional regulator, Cro/CI family +FIG01602037 Transcriptional regulatory protein +FIG01602051 FIG00693449: hypothetical protein +FIG01602052 FIG01181167: hypothetical protein +FIG01602054 FIG01118824: hypothetical protein +FIG01602102 N5-glutamine methyltransferase, HemK family +FIG01602103 FIG00556526: hypothetical protein +FIG01602105 COG1327: Predicted transcriptional regulator, consists of a Zn-ribbon and ATP-cone domains +FIG01602115 FIG00755648: hypothetical protein +FIG01602120 FIG00390548: hypothetical protein +FIG01602128 6-phosphofructo-2- kinase (EC 2.7.1.105) / Fructose-2,6-bisphosphatase (EC 3.1.3.46) +FIG01602129 MoaA/NirJ family Fe-S oxidoreductase +FIG01602188 hypothetical protein +FIG01602200 ribosomal protein L29 +FIG01602207 FIG00388924: hypothetical protein +FIG01602237 methylamine utilization protein precursor +FIG01602266 HTH-type transcriptional regulator DegA +FIG01602275 hydrolase, alpha-beta fold family, putative +FIG01602296 FIG01048608: hypothetical protein +FIG01602323 putative tail length tape measure protein +FIG01602359 FIG01238359: hypothetical protein +FIG01602371 Sarcosine oxidase( EC:1.5.3.1 ) +FIG01602438 Mlr0163 protein +FIG01602444 FIG00624805: hypothetical protein +FIG01602453 thioesterase( EC:3.1.2.- ) +FIG01602454 Bll7046 protein +FIG01602466 O-methyltransferase( EC:2.1.1.- ) +FIG01602470 FIG01069630: hypothetical protein +FIG01602473 probable large ATP-binding protein +FIG01602475 TspO and MBR like protein +FIG01602508 Phage prohead protease, HK97 family +FIG01602535 conserved hypothetical protein Cj1330 +FIG01602575 FIG00623199: hypothetical protein +FIG01602600 FIG00849526: hypothetical protein +FIG01602662 Endoglucanase B precursor (EC 3.2.1.4) (Endo-1,4-beta-glucanase B) (Cellulase B) +FIG01602681 Integral membrane protein +FIG01602687 FIG00623206: hypothetical protein +FIG01602762 DUF370 and DUF2179 domains-containing proteins +FIG01602765 myo-inositol 1-monophosphatase +FIG01602777 hypothetical protein +FIG01602792 FIG00405652: hypothetical protein +FIG01602795 FIG00414760: hypothetical protein +FIG01602799 hypothetical protein +FIG01602812 ATPase, ParA family protein +FIG01602814 prophage pi3 protein 37 +FIG01602824 FIG00945486: hypothetical protein +FIG01602841 carboxyl-terminal proteinase +FIG01602849 NADH:flavin oxidoreductase/NADH oxidase +FIG01602916 FIG01048214: hypothetical protein +FIG01602956 Uncharacterized protein aq_1581 +FIG01602973 FIG00520418: hypothetical protein +FIG01602976 Peptidyl-tRNA hydrolase domain protein +FIG01602988 ORF62 +FIG01603001 Conjugative transposon protein TraC +FIG01603035 possible Photosystem II reaction centre N prot +FIG01603036 COG1209: dTDP-glucose pyrophosphorylase +FIG01603039 GAF domain/sensory box/EAL domain protein +FIG01603040 fumarate reductase/succinate dehydrogenase flavoprotein-like +FIG01603054 FIG00763352: hypothetical protein +FIG01603064 putative suppressor protein DnaK +FIG01603123 FIG00519707: hypothetical protein +FIG01603136 phosphoribosyl transferase domain protein +FIG01603149 FIG00361592: hypothetical protein +FIG01603163 FIG00848842: hypothetical protein +FIG01603171 Possible membrane protein +FIG01603205 branched-chain amino acid export protein small subunit +FIG01603249 FIG01067823: hypothetical protein +FIG01603276 Uncharacterized protein y4eO +FIG01603298 Probable coat protein A precursor +FIG01603305 DNA repair protein RadA domain protein +FIG01603325 syc0019_c +FIG01603343 FIG00632743: hypothetical protein +FIG01603368 FIG00388618: hypothetical protein +FIG01603376 rarD protein (rarD) +FIG01603408 putative oxidoreductase( EC:1.- ) +FIG01603473 FIG00361744: hypothetical protein +FIG01603476 FIG00365119: hypothetical protein +FIG01603481 GtrA-like family protein +FIG01603518 FIG01166449: hypothetical protein +FIG01603519 FIG00425349: hypothetical protein +FIG01603550 hypothetical protein, probable transposase, partial +FIG01603551 GTP-binding protein YqeH, possibly involved in replication initiation +FIG01603554 Modification methylase AgeI (EC 2.1.1.37) +FIG01603570 dehydrogenase( EC:1.1.1.- ) +FIG01603580 FIG00407290: hypothetical protein +FIG01603584 Invasion protein B precursor +FIG01603597 Uncharacterized protein MJ0014 +FIG01603625 FIG00860108: hypothetical protein +FIG01603659 FIG00632540: hypothetical protein +FIG01603680 FIG00528262: hypothetical protein +FIG01603713 putative ABC transporter ATP-binding protein( EC:3.6.3.25 ) +FIG01603730 FIG00364075: hypothetical protein +FIG01603738 FIG00388731: hypothetical protein +FIG01603746 FIG00624219: hypothetical protein +FIG01603773 FIG01132009: hypothetical protein +FIG01603803 FIG00348192: hypothetical protein +FIG01603845 peptidase S1 and S6 chymotrypsin/Hap +FIG01603851 ABC transporter, ATP binding-protein +FIG01603854 Phosphoglucomutase (EC 5.4.2.2) +FIG01603882 FIG00814425: hypothetical protein +FIG01603976 FIG00849218: hypothetical protein +FIG01603980 peptidase M56 BlaR1 +FIG01603997 P pilus assembly protein, porin PapC +FIG01604008 CpsVH, putative +FIG01604034 probable surface-anchored fimbrial subunit +FIG01604046 FIG00349604: hypothetical protein +FIG01604055 Bacteriocin class II, amylovorin-like +FIG01604071 FIG01232837: hypothetical protein +FIG01604078 possible MarR-type transcriptional regulator +FIG01604087 FIG00675157: hypothetical protein +FIG01604093 post-segregation killing protein +FIG01604099 Predicted regulator of maltodextrin utilization, ROK family +FIG01604119 FIG00411138: hypothetical protein +FIG01604145 FIG00344233: hypothetical protein +FIG01604190 YOZE protein +FIG01604201 Cold shock protein +FIG01604239 FIG00411511: hypothetical protein +FIG01604246 integrase catalytic region +FIG01604294 Putative pectin degradation protein +FIG01604318 hypothetical protein +FIG01604329 putative galactose oxidase precursor +FIG01604336 Lipoprotein NlpC +FIG01604341 FIG00435306: hypothetical protein +FIG01604372 hypothetical RP691 +FIG01604405 Prepilin peptidase( EC:3.4.23.43 ) +FIG01604419 Resolvase/Integrase TinR protein +FIG01604428 FIG00414677: hypothetical protein +FIG01604432 COG family: Na+-dependent transporters of the Snf family +FIG01604445 hypothetical protein +FIG01604468 FIG01064937: hypothetical protein +FIG01604471 FIG00518656: hypothetical protein +FIG01604476 FIG00352850: hypothetical protein +FIG01604483 DnaJ domain-containing protein +FIG01604496 conserved hypothetical protein, C-terminal fragment +FIG01604510 Outer memberane protein Sca16 +FIG01604517 YciL +FIG01604539 Bona fide RidA/YjgF/TdcF/RutC subgroup +FIG01604545 FIG01166383: hypothetical protein +FIG01604578 FIG00356042: hypothetical protein +FIG01604589 Triosephosphate isomerase +FIG01604590 FIG00344893: hypothetical protein +FIG01604596 probable secreted protein-putative xanthan lyase related +FIG01604604 FIG01070993: hypothetical protein +FIG01604626 FIG00693269: hypothetical protein +FIG01604675 FIG00872624: hypothetical protein +FIG01604725 FIG00633823: hypothetical protein +FIG01604727 FIG00828173: hypothetical protein +FIG01604728 FIG01245816: hypothetical protein +FIG01604731 FIG00403622: hypothetical protein +FIG01604742 FIG00387819: hypothetical protein +FIG01604801 TniA putative transposase +FIG01604803 Spore germination protein A3 precursor +FIG01604824 maf protein +FIG01604827 transposase-like protein, PS3IS +FIG01604851 tautomerase +FIG01604866 Collagen-like protein SclA +FIG01604873 FIG00606900: hypothetical protein +FIG01604945 Smr protein/MutS2-like +FIG01604947 Amino acid ABC transporter, ATP-binding protein yhdZ +FIG01604966 FIG00514891: hypothetical protein +FIG01604981 bll2563; hypothetical protein +FIG01605007 FIG00753351: hypothetical protein +FIG01605018 FIG00513025: hypothetical protein +FIG01605024 isopentenyl pyrophosphate isomerase +FIG01605033 FIG00384922: hypothetical protein +FIG01605074 Oxidoreductase aldo/keto reductase +FIG01605079 FIG01131889: hypothetical protein +FIG01605092 Gll4044 protein +FIG01605124 FIG00870291: hypothetical protein +FIG01605137 FIG00624602: hypothetical protein +FIG01605158 N-carbamyl-L-amino acid amidohydrolase +FIG01605171 Perosamine synthetase WbkB / Mannosyltransferase WboA +FIG01605183 transporter, sodium/bile acid symporter family +FIG01605188 probable efflux transporter protein +FIG01605209 FIG00403504: hypothetical protein +FIG01605227 putative lipase lipH( EC:3.1.- ) +FIG01605231 FIG01093844: hypothetical protein +FIG01605239 Protein containing LysM motif repeat +FIG01605267 FIG00424683: hypothetical protein +FIG01605305 FIG00390293: hypothetical protein +FIG01605310 prophage ps1 protein 14 +FIG01605334 Probable lipase/esterase (EC 3.1.1.3) +FIG01605352 Polyketide synthase hetM +FIG01605385 putative hydratase +FIG01605398 FIG00847938: hypothetical protein +FIG01605434 FIG00342468: hypothetical protein +FIG01605459 FIG00520295: hypothetical protein +FIG01605469 Integral membrane protein possibly involved in chromosome condensation +FIG01605492 Mannosylfructose-phosphate synthase mfpsA +FIG01605501 regulatory protein GntR, HTH:UbiC transcription regulator-associated +FIG01605530 FIG00623692: hypothetical protein +FIG01605540 probable phosphatase +FIG01605543 Spermidine Putrescine transport ATP-binding protein potA +FIG01605556 FIG00848006: hypothetical protein +FIG01605560 putative toxic cation resistance protein +FIG01605579 ATP-dependent DNA helicase-like +FIG01605580 MaoC like domain, putative +FIG01605594 Amino acid ABC-type transporter, permease component +FIG01605676 FIG00344423: hypothetical protein +FIG01605679 FIG00954022: hypothetical protein +FIG01605702 FIG00623933: hypothetical protein +FIG01605715 FIG00425675: hypothetical protein +FIG01605718 ABC transporter ATP-binding protein fragment +FIG01605724 FIG00407622: hypothetical protein +FIG01605733 10 TMS putative drug/metabolite transporter (DMT) superfamily permease +FIG01605779 FIG00815555: hypothetical protein +FIG01605787 FIG01123562: hypothetical protein +FIG01605792 FIG01131599: hypothetical protein +FIG01605796 FIG01165372: hypothetical protein +FIG01605805 Predicted ATP-dependent endonuclease of the OLD family +FIG01605825 FIG01151655: hypothetical protein +FIG01605828 YHS domain protein +FIG01605853 citrate lyase acyl carrier protein +FIG01605917 PilT protein-like +FIG01605954 tributyrin esterase, putative +FIG01605964 Pyruvate synthase alpha chain (EC 1.2.7.1) +FIG01605972 FIG01135254: hypothetical protein +FIG01605978 FIG00966239: hypothetical protein +FIG01606014 FIG00524515: hypothetical protein +FIG01606035 FIG00564016: hypothetical protein +FIG01606047 Manganese ABC transporter, ATP-binding protein +FIG01606058 FIG01223801: hypothetical protein +FIG01606109 FIG00663259: hypothetical protein +FIG01606125 FIG00531621: hypothetical protein +FIG01606155 transmembrane-transport protein +FIG01606161 putative flavoprotein/ferredoxin +FIG01606203 FIG00353022: hypothetical protein +FIG01606215 Membrane protein, TerC homolog +FIG01606219 Modification methylase HgaIA (EC 2.1.1.37) (Cytosine-specific methyltransferase HgaIA) (M.HgaIA) (M.HgaI-1) +FIG01606289 lipopolysaccharide heptosyltransferase-1, putative +FIG01606295 FIG00815633: hypothetical protein +FIG01606314 Putative ribose/galactose/methyl galactoside import ATP-binding protein 1 (EC 3.6.3.17) +FIG01606325 FIG00522495: hypothetical protein +FIG01606362 FIG00408745: hypothetical protein +FIG01606408 FIG00385801: hypothetical protein +FIG01606415 hypothetical cell surface antigen +FIG01606421 FIG00782644: hypothetical protein +FIG01606433 hypothetical protein with possible RecF domain +FIG01606434 FIG00424555: hypothetical protein +FIG01606437 HtrA family serine protease +FIG01606447 FIG00417077: hypothetical protein +FIG01606459 Sphingomyelinase C precursor (EC 3.1.4.12) +FIG01606471 xylosidase/arabinosidase +FIG01606486 organophosphate acid anhydrase +FIG01606508 FIG00897594: hypothetical protein +FIG01606511 possible filamentous phage CTX RstR-like repressor +FIG01606517 Outer membrane autotransporter barrel domain protein +FIG01606534 Cell wall-associated hydrolases (invasion-associated proteins)-like +FIG01606554 Endo-1,4-beta-xylanase B precursor +FIG01606649 peptidase M48, Ste24p +FIG01606653 Glycosyl transferase, group 1( EC:2.4.1.21 ) +FIG01606654 hypothetical protein +FIG01606662 ATP-dependent helicase HrpA, putative +FIG01606677 Uncharacterized protein Rv2008c/MT2064 +FIG01606689 zinc-containing alcohol dehydrogenase +FIG01606697 sugar transporter, putative +FIG01606714 FIG00424501: hypothetical protein +FIG01606720 F17G adhesin subunit +FIG01606730 FIG00935504: hypothetical protein +FIG01606735 Probable protein phosphatase +FIG01606739 putative DNA-binding protein. +FIG01606797 AAA+ superfamily protein +FIG01606813 FIG00639858: hypothetical protein +FIG01606851 FIG00733241: hypothetical protein +FIG01606860 hypothetical protein +FIG01606876 Transposon Tn917 resolvase +FIG01606886 probable Mip +FIG01606889 FIG00364087: hypothetical protein +FIG01606906 putative ABC transport proteins, ATP-binding component +FIG01606923 CbbY family protein, putative +FIG01606985 FIG01207166: hypothetical protein +FIG01606993 predicted Endodeoxyribonuclease RusA +FIG01606995 putative endonuclease protein +FIG01606997 YcbN +FIG01607001 FIG00384918: hypothetical protein +FIG01607002 Putative transcriptional regulator, MarR family +FIG01607033 hypothetical protein +FIG01607056 DNA-damage repair protein +FIG01607057 FIG00520342: hypothetical protein +FIG01607065 splicing coactivator subunit-like protein +FIG01607124 FIG00403024: hypothetical protein +FIG01607135 possible regulator of polyketide synthase expression +FIG01607194 FIG00632131: hypothetical protein +FIG01607204 FIG00405611: hypothetical protein +FIG01607206 transcriptional Regulator, TetR family protein +FIG01607222 FIG00509959: hypothetical protein +FIG01607237 Mll4416 protein +FIG01607291 Cold shock protein cspB (Fragment) +FIG01607323 cytochrome P450, putative +FIG01607338 iron compound ABC transporter, iron compound-binding protein, putative +FIG01607343 FIG00408333: hypothetical protein +FIG01607370 transcriptional regulator for RecA +FIG01607427 FIG00389957: hypothetical protein +FIG01607475 Predicted ABC transporter for tryptophane, permease protein TrpY +FIG01607512 FIG00389147: hypothetical protein +FIG01607534 ISPsy22, transposase truncated +FIG01607556 FIG00494480: hypothetical protein +FIG01607563 Periplasmic solute binding protein +FIG01607590 FIG00353055: hypothetical protein +FIG01607607 6-phospho-beta-galactosidase (EC 3.2.1.85) +FIG01607617 FIG01078197: hypothetical protein +FIG01607621 Salicylaldehyde dehydrogenase (EC 1.2.1.65) +FIG01607630 outermembrane transporter +FIG01607775 twin-arginine translocation signal domain protein +FIG01607834 Uncharacterized protein ydcF +FIG01607841 FIG00412626: hypothetical protein +FIG01607863 Protein rlx +FIG01607921 FIG00353246: hypothetical protein +FIG01607928 HTH-type transcriptional activator ampR +FIG01607938 WD-repeat protein +FIG01607961 FIG00897066: hypothetical protein +FIG01608007 putative TraA-like conjugal transfer protein +FIG01608036 FIG00753964: hypothetical protein +FIG01608057 FIG00961498: hypothetical protein +FIG01608068 FIG00409945: hypothetical protein +FIG01608079 FIG00872763: hypothetical protein +FIG01608084 FIG00388066: hypothetical protein +FIG01608103 Toxin of toxin-antitoxin (TA) system +FIG01608114 protein of unknown function DUF323 +FIG01608133 Uncharacterized conserved secreted protein +FIG01608138 Uncharacterized protein y4oB +FIG01608150 Metal-dependent hydrolases of the beta-lactamase superfamily I; PhnP protein +FIG01608156 flagellar hook-length control protein +FIG01608158 COG1192: ATPases involved in chromosome partitioning +FIG01608188 phage-related terminase large subunit +FIG01608207 FIG00425752: hypothetical protein +FIG01608221 FIG00402868: hypothetical protein +FIG01608242 FIG00388765: hypothetical protein +FIG01608260 suggest reductase homologue +FIG01608280 FIG00815978: hypothetical protein +FIG01608303 FIG00413031: hypothetical protein +FIG01608307 hypothetical protein +FIG01608352 putative TetR/AcrR-family transcriptional regulator +FIG01608357 FIG00417691: hypothetical protein +FIG01608358 probable oxidoreductase( EC:1.- ) +FIG01608367 FIG00623093: hypothetical protein +FIG01608372 FIG00344539: hypothetical protein +FIG01608401 probable RNA polymerase sigma factor cnrH +FIG01608430 hypothetical protein +FIG01608455 FIG00344834: hypothetical protein +FIG01608485 similar to TPR repeat proteins +FIG01608504 FIG00380282: hypothetical protein +FIG01608528 FIG00406005: hypothetical protein +FIG01608529 similarity to RP534 +FIG01608535 Myosin heavy chain, skeletal muscle, juvenile +FIG01608555 FIG00839825: hypothetical protein +FIG01608559 FIG00353532: hypothetical protein +FIG01608652 37 kDa nucleoid-associated protein +FIG01608660 Probable transposase +FIG01608665 FIG01054838: hypothetical protein +FIG01608684 FIG00747889: hypothetical protein +FIG01608704 similar to Coenzyme F390 synthetase +FIG01608763 Probable microcin H47 secretion ATP-binding protein +FIG01608771 DUF192 precursor +FIG01608786 sigma-70 region 2 domain protein +FIG01608794 FIG00763648: hypothetical protein +FIG01608893 FIG00411902: hypothetical protein +FIG01608974 FIG00363946: hypothetical protein +FIG01609043 FIG00884884: hypothetical protein +FIG01609054 FIG00827270: hypothetical protein +FIG01609070 FIG00627878: hypothetical protein +FIG01609085 FIG00415876: hypothetical protein +FIG01609095 FIG01206054: hypothetical protein +FIG01609105 conserved hypothetical protein-putative glyoxalase +FIG01609121 NAD binding oxidoreductase +FIG01609141 kinase, PfkB family +FIG01609145 serine phosphatase( EC:3.1.3.16 ) +FIG01609149 FIG00816994: hypothetical protein +FIG01609191 FIG01208001: hypothetical protein +FIG01609241 NifU family iron binding protein, [Fe-S] cluster formation/repair protein IscU, HesB +FIG01609263 putative transcriptional regulator AraC/XylS family protein +FIG01609299 FIG00348278: hypothetical protein +FIG01609303 FIG00523433: hypothetical protein +FIG01609304 FIG00624782: hypothetical protein +FIG01609319 phosphoribosylglycinamide formyltransferase protein +FIG01609329 membrane spanning protein +FIG01609346 acylneuraminate cytidylyltransferase +FIG01609411 FIG00633413: hypothetical protein +FIG01609445 FIG00530175: hypothetical protein +FIG01609447 FIG00764429: hypothetical protein +FIG01609458 FIG00734001: hypothetical protein +FIG01609459 conserved hypothetical protein, possible hemolysis inducing protein +FIG01609468 FIG00998953: hypothetical protein +FIG01609476 V-type ATPase, subunit E, putative +FIG01609492 probable chromosome partitioning protein, ParA family +FIG01609515 phage-related terminase +FIG01609563 hypothetical protein +FIG01609576 FIG00533317: hypothetical protein +FIG01609638 alpha-1,2-fucosyltransferase, putative +FIG01609642 Acetylacetone-cleaving enzyme (EC 1.13.11.50) +FIG01609700 FIG00626825: hypothetical protein +FIG01609716 FIG00364010: hypothetical protein +FIG01609736 NERD domain protein +FIG01609738 multi-sensor signal transduction histidine kinase( EC:2.7.13.3 ) +FIG01609766 Membrane protein FdrA +FIG01609770 phage-related repressor protein +FIG01609791 conserved hypothetical multidrug-efflux transporter +FIG01609800 FIG00529446: hypothetical protein +FIG01609872 FIG01048195: hypothetical protein +FIG01609881 Ribonuclease III( EC:3.1.26.3 ) +FIG01609883 FIG01049503: hypothetical protein +FIG01609886 FIG00675245: hypothetical protein +FIG01609953 Prolyl-tRNA synthetase (EC 6.1.1.15), bacterial type +FIG01609954 FIG00788518: hypothetical protein +FIG01609962 FIG01238808: hypothetical protein +FIG01609974 acetoacetate metabolism regulatory protein atoC +FIG01610016 lipase chaperone +FIG01610053 hypothetical protein +FIG01610071 Phage prohead protease, HK97 family +FIG01610077 CMP/dCMP deaminase, zinc-binding +FIG01610110 phage protein +FIG01610176 FHA/GGDEF domain protein +FIG01610181 arylsulfatase +FIG01610197 FIG00769119: hypothetical protein +FIG01610206 Putative amidase amiB2 (EC 3.5.1.4) +FIG01610245 FIG00827389: hypothetical protein +FIG01610305 Hypothetical protein, CF-46 family +FIG01610317 sensory box/response regulator +FIG01610411 alkylhydroperoxidase-like protein +FIG01610456 Probable dipeptidase pepE (EC 3.4.13.-) +FIG01610492 Putative haloacid dehalogenase-like hydrolase +FIG01610495 FIG01024965: hypothetical protein +FIG01610505 FIG00387895: hypothetical protein +FIG01610514 ATP synthase protein I [KO:K02116] +FIG01610539 putative flagellin +FIG01610565 Short-chain dehydrodenase, dltE +FIG01610583 Transposase (class II) +FIG01610603 Stress induced protein +FIG01610604 Haloalkane dehalogenase +FIG01610610 UPF0332 protein TM1000 +FIG01610613 FIG01038536: hypothetical protein +FIG01610631 FIG00403845: hypothetical protein +FIG01610634 transport associated protein +FIG01610651 protein of unknown function DUF498 +FIG01610655 cell envelope-related function transcriptional attenuator, LytR/CpsA family +FIG01610680 DNA polymerase III alpha subunit (EC 2.7.7.7) @ intein-containing +FIG01610700 FIG00733777: hypothetical protein +FIG01610741 Protein related to penicillin acylase +FIG01610750 prim-VSK +FIG01610758 Chitinase, putative +FIG01610768 FIG00356678: hypothetical protein +FIG01610782 protein of unknown function DUF867 +FIG01610811 FIG00643001: hypothetical protein +FIG01610859 FIG00673386: hypothetical protein +FIG01610876 Tungsten-containing ferredoxin oxidoreductase WOR5 +FIG01610893 hypothetical protein @ intein-containing +FIG01610896 FIG00938929: hypothetical protein +FIG01610899 Uncharacterized protein yxiJ +FIG01610904 FIG00425312: hypothetical protein +FIG01610931 Fmu (Sun) domain protein +FIG01610945 PE-PGRS homolog MAG24-1 +FIG01610980 CoA enzyme activase +FIG01610989 Hypothetical protein probably related to hydantoin metabolism +FIG01610993 MALTODEXTRIN ABC TRANSPORTER PERMEASE PROTEIN MALD +FIG01610996 protein of unknown function DUF306 Meta and HslJ +FIG01611035 hoxX-like protein +FIG01611102 POSSIBLE HYDROLASE MUTT1 +FIG01611246 FIG00410216: hypothetical protein +FIG01611279 FIG00405976: hypothetical protein +FIG01611287 peptidase, M48 family( EC:3.4.- ) +FIG01611291 FIG01248438: hypothetical protein +FIG01611325 FIG00770047: hypothetical protein +FIG01611348 PTS system, mannitol-specific IIA component( EC:2.7.1.69 ) +FIG01611379 TPR +FIG01611396 putative periplasmic ligand-binding sensor protein +FIG01611402 putative streptogramin lyase, gluconolactonase family +FIG01611421 Transposase +FIG01611423 FIG00410851: hypothetical protein +FIG01611428 FIG01118047: hypothetical protein +FIG01611434 DNA repair helicase Rad3 +FIG01611474 two-component hybrid sensor and regulator +FIG01611475 preprotein translocase, YajC subunit +FIG01611507 Molecular chaperone, HSP90 family +FIG01611554 hypothetical protein, putative phage associated protein +FIG01611595 Lj965 prophage replication protein +FIG01611625 Microcompartments protein +FIG01611629 pentapeptide repeat +FIG01611669 Pterin-4-alpha-carbinolamine dehydratase (EC 4.2.1.96) +FIG01611685 FIG00412827: hypothetical protein +FIG01611686 putative NADPH-flavin oxidoreductase +FIG01611719 peptidase S26B, signal peptidase +FIG01611721 FIG00623669: hypothetical protein +FIG01611734 citrate transporter +FIG01611757 ORF_ID:alr7573 unknown protein +FIG01611777 Putative lipoprotein SCO4651 precursor +FIG01611800 FIG00767428: hypothetical protein +FIG01611833 Phenazine biosynthesis protein phzF +FIG01611867 FIG00841811: hypothetical protein +FIG01611883 possible acyl dehydratase +FIG01611894 general secretory pathway protein E +FIG01611923 FIG00425385: hypothetical protein +FIG01611947 FIG00998840: hypothetical protein +FIG01611959 FIG00902730: hypothetical protein +FIG01611988 FIG00622930: hypothetical protein +FIG01612015 FmtA protein involved in methicillin resistance / affects cell wall cross-linking and amidation +FIG01612037 glutathione-dependent formaldehyde-activating GFA +FIG01612045 FIG00537905: hypothetical protein +FIG01612046 FIG00469494: hypothetical protein +FIG01612060 FIG00675290: hypothetical protein +FIG01612069 PKA regulatory subunit-like protein +FIG01612103 sigma-24 +FIG01612105 Fibrinogen binding protein +FIG01612159 putative dehydrogenase related to short-chain alcohol dehydrogenases +FIG01612199 inosine monophosphate dehydrogenase (guaB-2) +FIG01612239 C-terminal modulator protein +FIG01612243 FIG00353603: hypothetical protein +FIG01612281 18 kDa antigen +FIG01612283 conserved hypothetical protein, similar to glycosyltransferases +FIG01612288 FIG00383857: hypothetical protein +FIG01612371 cell division protein FtsZ +FIG01612378 FIG00417823: hypothetical protein +FIG01612392 Response regulator receiver:ANTAR +FIG01612399 Aryl sulfotransferase +FIG01612406 Uncharacterized protein MJ0645 +FIG01612447 Positive transcriptional regulator MutR family +FIG01612477 sugar transport system (sugar-binding protein) +FIG01612534 transporter, permease +FIG01612538 virulence sensor protein +FIG01612589 protein serine/threonine phosphatase +FIG01612634 FIG00468831: hypothetical protein +FIG01612667 possible Poly A polymerase regulatory subunit +FIG01612678 hypothetical protein +FIG01612707 FERREDOXIN DOMAIN INTEGRAL MEMBRANE +FIG01612734 FIG00672604: hypothetical protein +FIG01612755 sulfatase-domain-containing protein +FIG01612775 methyltransferase, putative 3-demethylubiquinone-9 3-methyltransferase +FIG01612809 6-aminohexanoate-dimer hydrolase +FIG01612874 Methyltransferase TTHA0482 +FIG01612877 FIG00353819: hypothetical protein +FIG01612879 Cyclic nucleotide-binding domain protein +FIG01612880 hypothetical protein +FIG01612884 Possible acetoin transport system substrate binding protein YtrF +FIG01612886 FIG00754632: hypothetical protein +FIG01612939 NhaP +FIG01612948 FIG00734491: hypothetical protein +FIG01612955 Protein of unknown function DUF2149 +FIG01612960 Predicted glycogen debranching enzyme +FIG01613005 FIG00976694: hypothetical protein +FIG01613034 L,L-diaminopimelate aminotransferase (EC 2.6.1.83), methanococcal +FIG01613047 FIG00825540: hypothetical protein +FIG01613052 Transporter, major facilitator family +FIG01613091 Vacuolating cytotoxin +FIG01613107 Melittin resistance protein PqaB +FIG01613139 CMP/dCMP deaminase, zinc-binding protein +FIG01613170 FIG01170024: hypothetical protein +FIG01613196 Related to protein-tyrosine phosphatase +FIG01613216 FIG00631469: hypothetical protein +FIG01613226 N-acetylmuramoyl-L-alanine amidase +FIG01613236 Spore germination protein, gerKB +FIG01613264 putative cytochrome C-type biogenesis protein +FIG01613270 FIG00361313: hypothetical protein +FIG01613274 FIG00669076: hypothetical protein +FIG01613275 ABC efflux transporter, ATP-binding protein +FIG01613305 Huntingtin interacting protein HYPE homolog +FIG01613306 protein-tyrosine-phosphatase +FIG01613316 doubtful CDS +FIG01613351 FIG00830907: hypothetical protein +FIG01613358 COG4679: Phage-related protein +FIG01613363 putative bacteriocin secretion protein +FIG01613371 FIG00351047: hypothetical protein +FIG01613376 Tellurite resistance protein tehA +FIG01613402 DsrC family protein +FIG01613523 FIG00404037: hypothetical protein +FIG01613524 FIG00897781: hypothetical protein +FIG01613528 Polysulphide reductase NrfD +FIG01613561 uncharacterized enzyme +FIG01613583 AsnC-family transcriptional regulator +FIG01613592 probable ABC transporter, periplasmic substrate-binding +FIG01613606 putative periplasmic phosphate-binding protein +FIG01613628 KDP operon transcriptional regulatory protein kdpE +FIG01613659 FIG00822610: hypothetical protein +FIG01613660 helix-hairpin-helix motif +FIG01613699 Cell wall surface anchor family protein, LPXTG motif +FIG01613711 FIG01003589: hypothetical protein +FIG01613715 transposase-like p;rotein +FIG01613730 Thiamine pyrophosphate-requiring protein Saci_2281 +FIG01613758 COG1902: NADH:flavin oxidoreductases, Old Yellow Enzyme family +FIG01613883 FIG00765616: hypothetical protein +FIG01613886 HAD-superfamily hydrolase, subfamily IA +FIG01613906 putative efflux transporter protein +FIG01613937 FIG00431586: hypothetical protein +FIG01613987 FIG00347480: hypothetical protein +FIG01614048 FIG00900875: hypothetical protein +FIG01614058 FIG00732098: hypothetical protein +FIG01614061 FIG00946189: hypothetical protein +FIG01614071 FIG00642108: hypothetical protein +FIG01614163 FIG00468678: hypothetical protein +FIG01614165 predicted cytoskeletal protein +FIG01614176 FAD linked oxidase-like +FIG01614188 Ssr2194 protein +FIG01614198 Phage replication protein, putative +FIG01614226 FIG01242474: hypothetical protein +FIG01614338 Map1-related protein +FIG01614357 Solute carrier family 13, member 2 +FIG01614369 protein of unknown function DUF891 +FIG01614375 FIG00362312: hypothetical protein +FIG01614378 tRNA (guanine-N(7)-)-methyltransferase (EC 2.1.1.33) (tRNA(m7G46)-methyltransferase) +FIG01614415 Lipase/acylhydrolase +FIG01614433 blr2742; hypothetical protein +FIG01614482 FIG00408453: hypothetical protein +FIG01614484 FIG00388372: hypothetical protein +FIG01614521 Beta-glucosidase family protein +FIG01614538 FIG00623289: hypothetical protein +FIG01614546 FIG00252199: hypothetical protein +FIG01614567 Pseudouridine synthase, Rsu +FIG01614574 NAD(P)H oxidoreductase +FIG01614576 putative exopolysaccharide biosynthesis-related protein +FIG01614577 FIG00402880: hypothetical protein +FIG01614628 drug/proton antiporter +FIG01614632 low molecular weight heat stress protein +FIG01614634 FIG00684844: hypothetical protein +FIG01614658 FIG00406763: hypothetical protein +FIG01614668 negative regulation of the azlBCD operon +FIG01614714 transcriptional regulatory protein, lysR family +FIG01614791 FIG00855934: hypothetical protein +FIG01614819 FIG00734510: hypothetical protein +FIG01614849 FIG00776273: hypothetical protein +FIG01614854 FIG01116256: hypothetical protein +FIG01614882 FIG01165424: hypothetical protein +FIG01614894 NAd-glycohydrolase, hvnA +FIG01614957 FIG00405246: hypothetical protein +FIG01614966 carboxylesterase (lipT) +FIG01614973 Putative MFS-type transporter +FIG01614974 ABC-type amino acid transport/signal transduction systems periplasmic component/domain-like protein +FIG01614990 FIG00816218: hypothetical protein +FIG01615003 FIG00838079: hypothetical protein +FIG01615014 FIG01180482: hypothetical protein +FIG01615017 FIG00959072: hypothetical protein +FIG01615025 Protein containing HNH endonuclease domain +FIG01615031 Ribosome-associated heat shock protein; Heat shock protein 15 +FIG01615041 protein of unknown function DUF1429 +FIG01615099 Probable proteinase +FIG01615192 Uncharacterized conserved protein of probably eukaryotic origin +FIG01615201 FIG00817912: hypothetical protein +FIG01615209 FIG01085635: hypothetical protein +FIG01615254 FIG00984683: hypothetical protein +FIG01615284 FIG00521520: hypothetical protein +FIG01615338 UPF0337 protein msl9551 +FIG01615385 NurA domain-containing protein +FIG01615433 FIG01047593: hypothetical protein +FIG01615452 FIG00269092: hypothetical protein +FIG01615467 FIG00632553: hypothetical protein +FIG01615496 putative outer membrane protein OmpA +FIG01615532 UDP-sulfoquinovose synthase (EC 3.13.1.1) +FIG01615535 Type IV fimbrial biogenesis protein PilW +FIG01615544 FIG00348437: hypothetical protein +FIG01615551 COG3878: Uncharacterized protein conserved in bacteria +FIG01615553 Sigma cross-reacting protein 27A +FIG01615561 Mn2+ and Fe2+ transporters of the NRAMP family-like protein +FIG01615564 FIG01249277: hypothetical protein +FIG01615566 hypothetical protein +FIG01615584 InterPro IPR003807 COGs COG2149 +FIG01615599 FIG00404025: hypothetical protein +FIG01615660 FIG00687947: hypothetical protein +FIG01615673 FIG00407172: hypothetical protein +FIG01615724 Spermidine/putrescine ABC transporter, permease protein +FIG01615726 FIG00988273: hypothetical protein +FIG01615733 hypothetical protein +FIG01615748 FIG00349395: hypothetical protein +FIG01615759 putative pectinesterase precursor +FIG01615809 Dna2 helicase involved in Okazaki fragment processing +FIG01615813 FIG01205951: hypothetical protein +FIG01615819 repeat motif-containing protein +FIG01615827 Zinc ABC transporter, periplasmic-binding protein ZnuA +FIG01615853 deca-heme C-type cytochrome-like protein +FIG01615875 FIG00353341: hypothetical protein +FIG01615911 Putative thiolase +FIG01615912 SN-glycerol-3-phosphate transport system permease protein ugpA (TC 3.A.1.1.3) +FIG01615920 hypothetical protein +FIG01615954 FIG01054815: hypothetical protein +FIG01615960 FIG00951969: hypothetical protein +FIG01615988 FIG01166099: hypothetical protein +FIG01615995 protein of unknown function (DUF1555) +FIG01616081 conserved putative phosphatase +FIG01616090 FIG00424250: hypothetical protein +FIG01616110 Cellulase CelE ortholog; dockerin domain +FIG01616135 protein of unknown function DUF306, MetA and HslJ +FIG01616209 probable inner membrane protein NMA0456 +FIG01616269 FIG00388367: hypothetical protein +FIG01616293 putative integrase of prophage +FIG01616294 ATP synthase F0 sector subunit c (EC 3.6.3.14) +FIG01616356 FIG00365166: hypothetical protein +FIG01616388 FIG00352988: hypothetical protein +FIG01616410 FIG01126584: hypothetical protein +FIG01616444 FIG01164202: hypothetical protein +FIG01616473 CheY subfamily protein +FIG01616479 FIG00352252: hypothetical protein +FIG01616481 InterPro IPR001993:IPR004843:IPR006311 +FIG01616513 PqqE +FIG01616517 FIG00688449: hypothetical protein +FIG01616524 FIG00362179: hypothetical protein +FIG01616550 N-acyl-L-amino acid amidohydrolase (L-aminoacylase)( EC:3.5.1.14 ) +FIG01616566 Osmotically inducible protein Y +FIG01616603 FIG00425658: hypothetical protein +FIG01616689 cyclic nucleotide phosphodiesterase, putative +FIG01616716 N-acetylmuramoyl-L-alanine amidase cwlM (EC 3.5.1.28) (Cell wall hydrolase) (Autolysin) +FIG01616756 FIG00513763: hypothetical protein +FIG01616782 MFS type sugar transporter +FIG01616787 FIG00688665: hypothetical protein +FIG01616801 LSU ribosomal protein L33p +FIG01616804 FIG01128302: hypothetical protein +FIG01616840 hypothetical protein +FIG01616853 FIG00641253: hypothetical protein +FIG01616868 FIG01093617: hypothetical protein +FIG01616871 hypothetical protein +FIG01616956 Alkaline serine protease, subtilase family (EC 3.4.21.-) +FIG01616971 FIG00417660: hypothetical protein +FIG01616972 trehalose 6-phosphate phosphorylase( EC:2.4.1.216 ) +FIG01616973 FIG00769821: hypothetical protein +FIG01616992 COG2342: Predicted extracellular endo alpha-1,4 polygalactosaminidase or related polysaccharide hydrolase +FIG01616998 FIG00839357: hypothetical protein +FIG01617017 Glucosyl-isoprenylphosphate transferase +FIG01617062 hypothetical protein +FIG01617064 putative serine/threonine-protein kinase pknB +FIG01617106 putative alkaline shock protein +FIG01617118 Possible S-layer protein +FIG01617136 FIG00388043: hypothetical protein +FIG01617142 predicted ribokinase +FIG01617147 5-Nitroimidazole antibiotic resistance protein +FIG01617151 Immunity/modification protein +FIG01617162 FIG00407079: hypothetical protein +FIG01617174 Cold shock protein CspG +FIG01617179 FIG01119137: hypothetical protein +FIG01617188 putative acyl-CoA transferases/carnitine dehydratase +FIG01617212 FIG00361250: hypothetical protein +FIG01617220 Possible restriction endonuclease +FIG01617232 transcriptional activator ampR family +FIG01617246 putative bumetanide-sensitive Na-K-Cl +FIG01617322 similar to phosphatidylserine decarboxylase, proenzyme +FIG01617326 FIG00467665: hypothetical protein +FIG01617342 peptidyl-prolyl cis-trans isomerse D +FIG01617349 ABC transporter, transmembrane region:ABC transporter related +FIG01617365 FIG01020250: hypothetical protein +FIG01617439 Plasmid related protein +FIG01617452 Repressor (cro-like) [Bacteriophage A118] +FIG01617469 conserved hypothetical protein, partial length +FIG01617473 FIG00648939: hypothetical protein +FIG01617481 type-1 fimbrial protein, A subunit +FIG01617559 conserved membrane protein YfiD +FIG01617573 FIG00526224: hypothetical protein +FIG01617595 FIG00515940: hypothetical protein +FIG01617605 FIG00633520: hypothetical protein +FIG01617683 FIG00521247: hypothetical protein +FIG01617705 RNA-binding protein, RRM domain +FIG01617721 FIG00348289: hypothetical protein +FIG01617739 FIG00641616: hypothetical protein +FIG01617744 FIG00623264: hypothetical protein +FIG01617859 hypothetical, predicted membrane protein (TMS6) +FIG01617886 FIG00638558: hypothetical protein +FIG01617900 TAP domain protein +FIG01617917 FIG01021773: hypothetical protein +FIG01617926 FIG00362022: hypothetical protein +FIG01617993 putative FtsK/SpoIIIE family protein +FIG01618004 FIG00388169: hypothetical protein +FIG01618027 succinoglycan biosynthesis protein +FIG01618041 secreted transglycosylase +FIG01618053 glycosyltransferase, group 1 family +FIG01618059 Response regulator CitB of citrate metabolism +FIG01618111 putative transposase, IS891/IS1136/IS1341 +FIG01618131 orf6 +FIG01618137 FIG00624625: hypothetical protein +FIG01618147 syc1933_c +FIG01618252 putative sugar-proton symporter +FIG01618260 Integrase, catalytic domain +FIG01618289 Sulfate transporter family protein in cluster with carbonic anhydrase +FIG01618321 FIG00387805: hypothetical protein +FIG01618327 phage-related tail protein +FIG01618341 FIG01222246: hypothetical protein +FIG01618384 FIG01203617: hypothetical protein +FIG01618408 putative sensory protein +FIG01618419 FIG00408187: hypothetical protein +FIG01618447 glycosyltransferase involved in cell wall biogenesis +FIG01618472 PUTATIVE NA+/H+ ANTIPORTER +FIG01618516 FIG00361326: hypothetical protein +FIG01618541 Predicted dehydrogenase; short-chain alcohol dehydrogenase family protein +FIG01618607 Cobalt transport protein +FIG01618616 FIG00380523: hypothetical protein +FIG01618643 Mor transcription activator domain protein +FIG01618659 Uncharacterized protein SCO3165 +FIG01618716 possible gas vesicle synthesis protein +FIG01618720 sodium-glucose/galactose cotransporter +FIG01618755 Transcriptional factor-related protein +FIG01618756 FIG00767470: hypothetical protein +FIG01618819 FIG00823203: hypothetical protein +FIG01618846 transposase IS204/IS1001/IS1096/IS1165 family protein +FIG01618865 FIG00838142: hypothetical protein +FIG01618868 Histidine decarboxylase proenzyme (EC 4.1.1.22) (Pi chain) [Contains: Histidine decarboxylase beta chain; Histidine decarboxylase alpha chain] +FIG01618948 probable phage-related lysozyme( EC:3.2.1.17 ) +FIG01618950 hypothetical protein +FIG01618960 FIG00623731: hypothetical protein +FIG01618961 Sensory box/GGDEF family +FIG01619016 transposase, OrfB +FIG01619035 FIG00388808: hypothetical protein +FIG01619073 DinB family superfamily +FIG01619080 FIG00513562: hypothetical protein +FIG01619125 Conserved protein YuxK +FIG01619196 COG3795: Uncharacterized protein conserved in bacteria +FIG01619197 Transcriptional regulator MgrA (Regulator of autolytic activity) +FIG01619232 L-Proline/Glycine betaine transporter ProP +FIG01619287 Uncharacterized 23.9 kDa protein in xynA 3'region (ORF5) +FIG01619292 Glycine-rich cell wall structural protein 1.0 precursor +FIG01619299 probable cAMP-regulatory protein +FIG01619315 FIG00352618: hypothetical protein +FIG01619317 Probable calcium binding hemolysin +FIG01619331 FIG00351809: hypothetical protein +FIG01619339 conserved hypothetical protein TIGR00052 +FIG01619395 FIG00528886: hypothetical protein +FIG01619396 ABC-type glycine betaine transport system protein +FIG01619427 FIG01226360: hypothetical protein +FIG01619444 Arginine repressor +FIG01619463 predicted phosphatases +FIG01619498 FIG00767562: hypothetical protein +FIG01619508 daunorubicin resistance ABC transporter ATP-binding subunit +FIG01619563 FIG00624398: hypothetical protein +FIG01619601 predicted redox protein +FIG01619613 Uncharacterized conserved protein, predicted metal-binding +FIG01619642 LacX protein +FIG01619651 Probable amino acid permease +FIG01619697 FIG00385151: hypothetical protein +FIG01619800 protein of unknown function DUF486 +FIG01619823 Chemotaxis protein cheW +FIG01619910 acid phosphatase (Class B) +FIG01619917 Uncharacterized protein yesE +FIG01619926 FIG00860998: hypothetical protein +FIG01619949 transcriptional regulator AcrR family +FIG01620004 FIG00426294: hypothetical protein +FIG01620015 putative phytochrome sensor protein +FIG01620065 FIG00526381: hypothetical protein +FIG01620067 Putative secreted protein +FIG01620072 sugar ABC transporter, sugar-binding protein, putative +FIG01620074 Uncharacterized protein yebD +FIG01620091 permease protein of ABC transporter +FIG01620130 Bll3777 protein +FIG01620131 antirestriction protein, putative +FIG01620143 FIG00898442: hypothetical protein +FIG01620183 prophage ps3 protein 01, putative +FIG01620200 conserved hypothetical protein; putative branched-chain amino acid permease (azaleucine resistance) +FIG01620206 InsA protein (Fragment) +FIG01620213 putative 4-amino-4-deoxy-L-arabinose transferase +FIG01620225 conserved hypothetical protein +FIG01620261 FIG00688223: hypothetical protein +FIG01620308 Phage related protein, YorF B.subtilis homolog +FIG01620315 FIG00958267: hypothetical protein +FIG01620327 Serine protease 3 precursor +FIG01620333 Uncharacterized protein HI0762 +FIG01620348 MCP-DOMAIN SIGNAL TRANSDUCTION PROTEIN +FIG01620354 Anti-sigma F factor antagonist (spoIIAA-2); Anti-sigma B factor antagonist RsbV +FIG01620365 Probable sugar ABC transporter, sugar-binding protein +FIG01620397 FIG00355800: hypothetical protein +FIG01620398 DeoR-type transcriptional regulator, putative +FIG01620427 FIG01117710: hypothetical protein +FIG01620432 FIG00624773: hypothetical protein +FIG01620442 probable terminase large subunit +FIG01620487 FIG00733494: hypothetical protein +FIG01620504 putative O-antigen polymerase +FIG01620521 FIG00388212: hypothetical protein +FIG01620534 DRTGG domain protein +FIG01620537 FIG01229313: hypothetical protein +FIG01620550 Bacteriophage N4 adsorption protein A precursor +FIG01620578 FIG00344813: hypothetical protein +FIG01620597 ISRm2011-2 transposase protein +FIG01620617 putative periplasmic dipeptidase +FIG01620640 InterPro IPR000014:IPR001633 COGs COG2200 +FIG01620657 ABC-type transporter, permease components +FIG01620662 Peptidase M16-like +FIG01620670 Regulatory function on capsule expression +FIG01620712 COG1487: Predicted nucleic acid-binding protein, contains PIN domain +FIG01620721 Zinc transporter ZIP +FIG01620731 hypothetical protein +FIG01620769 ORF19 +FIG01620818 FIG00344023: hypothetical protein +FIG01620838 FIG00468184: hypothetical protein +FIG01620922 FIG00623760: hypothetical protein +FIG01620956 FIG00468839: hypothetical protein +FIG01620970 FIG00821181: hypothetical protein +FIG01620976 FIG00950713: hypothetical protein +FIG01620989 Vesicle-fusing ATPase (EC 3.6.4.6) +FIG01621008 ABC transporter, substrate binding protein, possibly Mn +FIG01621032 small subunit of N,N-dimethylformamidase +FIG01621056 syc0022_d +FIG01621146 FIG00528190: hypothetical protein +FIG01621155 FIG00677422: hypothetical protein +FIG01621173 Blr2286 protein +FIG01621178 lactose ABC transporter substrate-binding protein +FIG01621185 FIG00416635: hypothetical protein +FIG01621199 FIG00344181: hypothetical protein +FIG01621233 FIG00632240: hypothetical protein +FIG01621238 Respiratory-chain NADH dehydrogenase domain, 51 kDa subunit +FIG01621274 Head-TO-tail joining protein +FIG01621285 cobaltochelatase( EC:6.6.1.2 ) +FIG01621299 mCG1039259, isoform CRA_a +FIG01621332 FIG00388529: hypothetical protein +FIG01621338 FIG00388543: hypothetical protein +FIG01621363 Cell surface SD repeat protein precursor +FIG01621429 FIG00764591: hypothetical protein +FIG01621481 FIG00628855: hypothetical protein +FIG01621515 FIG00629835: hypothetical protein +FIG01621523 FIG00516007: hypothetical protein +FIG01621528 FIG00743299: hypothetical protein +FIG01621573 FIG00545058: hypothetical protein +FIG01621601 FIG00519538: hypothetical protein +FIG01621616 FIG00734408: hypothetical protein +FIG01621619 Fibronectin, type III +FIG01621659 ORF_ID:tll0286 hypothetical protein +FIG01621666 diguanylate cyclase with GAF sensor +FIG01621691 FIG00848704: hypothetical protein +FIG01621697 FIG01115068: hypothetical protein +FIG01621731 FIG01167053: hypothetical protein +FIG01621746 preprotein translocase, SecE subunit +FIG01621752 predicted acyltransferase +FIG01621757 3-oxoacyl-[acyl-carrier-protein] reductase (EC 1.1.1.100) +FIG01621776 hypothetical protein +FIG01621798 127aa long conserved hypothetical protein +FIG01621834 FIG00417184: hypothetical protein +FIG01621838 FIG00664315: hypothetical protein +FIG01621843 ABC transporter membrane-spanning permease - glutamine transport +FIG01621853 Putative DNA packaging protein of prophage CP-933U +FIG01621901 FIG00624259: hypothetical protein +FIG01621903 signal peptide peptidase SppA, 67K type( EC:3.4.- ) +FIG01621929 FIG00412154: hypothetical protein +FIG01621974 hypothetical protein +FIG01621981 hypothetical protein +FIG01621984 Bll1540 protein +FIG01621999 FIG00406459: hypothetical protein +FIG01622017 TRANSPOSASE +FIG01622028 FIG00624561: hypothetical protein +FIG01622030 phospholipid N-methyltransferase +FIG01622031 COG0349: Ribonuclease D +FIG01622032 quinoprotein dehydrogenase +FIG01622050 FIG01166511: hypothetical protein +FIG01622053 AatD +FIG01622066 amino acid ABC transporter, periplasmic amino acid-binding protein +FIG01622068 beta 1,4 glucosyltransferase +FIG01622099 FIG01228771: hypothetical protein +FIG01622101 oxidoreductase, short-chain dehydrogenase/reductase family protein +FIG01622166 Uncharacterized conserved membrane protein, VanZ family +FIG01622195 probable substrate-binding protein +FIG01622219 FIG00624085: hypothetical protein +FIG01622226 FIG00817491: hypothetical protein +FIG01622292 Phage-related portal protein +FIG01622296 DNA distortion protein 3 +FIG01622314 FIG00962979: hypothetical protein +FIG01622336 ILL6; metallopeptidase +FIG01622371 MerR family transcriptional regulator +FIG01622418 sugars +FIG01622467 Transthyretin-like protein precursor +FIG01622468 ATP-dependent DNA ligase +FIG01622471 unknown protein +FIG01622514 EXTENSIN-LIKE PROTEIN +FIG01622555 capsular exopolysaccharide family protein +FIG01622581 ORF37-1 +FIG01622618 Transposase and inactivated derivative +FIG01622638 hypothetical protein +FIG01622646 putative 37-kDa protein +FIG01622661 FIG00939775: hypothetical protein +FIG01622670 FIG00407991: hypothetical protein +FIG01622716 FIG00387979: hypothetical protein +FIG01622739 FIG01077378: hypothetical protein +FIG01622755 FIG00966893: hypothetical protein +FIG01622762 FIG00385530: hypothetical protein +FIG01622771 FIG00623871: hypothetical protein +FIG01622805 FIG00387810: hypothetical protein +FIG01622813 FIG00348002: hypothetical protein +FIG01622815 FIG00351390: hypothetical protein +FIG01622817 Uncharacterized protein aq_1120 +FIG01622827 probable dicarboxylic acid transport integral membrane protein kgtp (dicarboxylate +FIG01622856 hypothetical protein +FIG01622869 FIG01055965: hypothetical protein +FIG01622874 sel1-like repeat protein +FIG01622888 FIG01076674: hypothetical protein +FIG01622908 FIG00733724: hypothetical protein +FIG01622919 HD-GYP domain containing protein +FIG01622938 Cytochrome b558/566 subunit B +FIG01622939 Cell Processes; Protection responses; drug/analog sensitivity and resistance +FIG01622983 FIG01167236: hypothetical protein +FIG01622988 probable methyl transferase( EC:2.1.1.- ) +FIG01623006 FIG00633846: hypothetical protein +FIG01623011 Fibrinogen-binding protein +FIG01623019 prophage pi3 protein 32 +FIG01623039 FIG01120280: hypothetical protein +FIG01623048 Alkaline phosphatase +FIG01623086 putative glyoxalase/bleomycin resistance protein/dioxygenase +FIG01623186 FIG00896977: hypothetical protein +FIG01623214 FIG00816947: hypothetical protein +FIG01623220 Yme +FIG01623243 Sperm-specific protein Don juan +FIG01623247 FIG00939384: hypothetical protein +FIG01623282 MaoC-like dehydratase precursor +FIG01623332 ATP-binding protein of polyamine ABC transporter +FIG01623334 mobilizable transposon, int protein +FIG01623344 FIG00752465: hypothetical protein +FIG01623364 Major facilitator family transporter +FIG01623382 FIG00344803: hypothetical protein +FIG01623425 Sll0436 protein +FIG01623438 FIG00839599: hypothetical protein +FIG01623448 DNA-cytosine methyltransferase (EC 2.1.1.37) +FIG01623450 integral membrane protein PlnT, membrane-bound protease CAAX family +FIG01623475 L-carnitine dehydratase +FIG01623484 Predicted dinucleotide-binding enzymes +FIG01623495 Sulfate transporter 4.1, chloroplast precursor +FIG01623505 DNA-methyltransferase +FIG01623509 Possible glucoamylase (diverged), 15 family +FIG01623537 FIG00673437: hypothetical protein +FIG01623585 hypothetical protein +FIG01623600 FIG00755996: hypothetical protein +FIG01623602 putative amino group acetyl transferase +FIG01623609 long-chain fatty acid transport protein +FIG01623613 Mll2946 protein +FIG01623619 FIG00631119: hypothetical protein +FIG01623636 putative DNA polymerase III subunit +FIG01623669 CylD protein +FIG01623693 FIG00768946: hypothetical protein +FIG01623718 fructosamine kinase +FIG01623735 cytochrome c oxidase, subunit III +FIG01623752 hypothetical protein +FIG01623769 FIG00841052: hypothetical protein +FIG01623787 preprotein translocase SecG subunit +FIG01623811 tgtA5 cluster protein 2 +FIG01623838 FIG00632905: hypothetical protein +FIG01623844 Small protein A, tmRNA-binding +FIG01623845 putative growth inhibitor +FIG01623850 Glucose oligosaccharide ABC transport system, ATP-binding protein 2 +FIG01623852 phage Gp37Gp68 family protein +FIG01623876 ATP-binding region, ATPase-like:Histidine kinase A-like +FIG01623879 FIG00353809: hypothetical protein +FIG01623884 Adhesin yadA precursor +FIG01623918 micrococcal nuclease (SNase-like) +FIG01623927 HAD superfamily hydrolase, YKRA B.subtilis ortholog +FIG01623941 Transposase, IS204/IS1001/IS1096/IS1165 +FIG01624005 FIG00624816: hypothetical protein +FIG01624021 FIG00837109: hypothetical protein +FIG01624046 FIG00434035: hypothetical protein +FIG01624109 FIG00820024: hypothetical protein +FIG01624148 FIG00353751: hypothetical protein +FIG01624153 identified by similarity to SP:Q9CKX3 +FIG01624197 ortholog of Bordetella pertussis (BX470248) BP0934 +FIG01624230 Phosphoglycerate dehydrogenase related enzyme +FIG01624234 Uncharacterized protein Rv2577/MT2654 +FIG01624259 hypothetical protein +FIG01624273 ferrous ion uptake +FIG01624288 FIG00734297: hypothetical protein +FIG01624301 All2509 protein +FIG01624364 Transcribed sequence with weak similarity to protein ref:NP_079373.1 (H.sapiens) hypothetical protein FLJ21106 [Homo sapiens] [Source:UniGene;Acc:Ame.4051] +FIG01624385 endo-1,3-beta-glucanase +FIG01624426 nodulation protein( EC:2.3.1.79 ) +FIG01624451 FIG00762659: hypothetical protein +FIG01624460 Site-specific recombinase, resolvase family, putative +FIG01624464 FIG00624285: hypothetical protein +FIG01624475 Response regulator receiver domain protein (CheY) +FIG01624500 putative flavoprotein subunit of a reductase +FIG01624527 collagen triple helix repeat +FIG01624539 Possible aminoglycoside phosphotransferase (protein kinase related), diverged +FIG01624544 FIG01226001: hypothetical protein +FIG01624605 FIG01245557: hypothetical protein +FIG01624640 COG3933: Transcriptional antiterminator +FIG01624648 FIG00353762: hypothetical protein +FIG01624707 Conjugal transfer protein TrbC +FIG01624779 FIG00408291: hypothetical protein +FIG01624801 FIG00532546: hypothetical protein +FIG01624852 Permease, multidrug efflux +FIG01624865 FIG00977094: hypothetical protein +FIG01624909 Putative esterase/lipase YbfF +FIG01624918 putative cell filamentation protein Fic +FIG01624919 tellurite resistance protein TehB +FIG01624928 FIG00668100: hypothetical protein +FIG01624977 FIG00642913: hypothetical protein +FIG01624984 FIG00425130: hypothetical protein +FIG01624990 FIG00624698: hypothetical protein +FIG01625022 AidA-I adhesin-like protein +FIG01625040 FIG00356396: hypothetical protein +FIG01625063 Tyrosine protein kinase:Serine/threonine protein kinase:Sel1-like repeat +FIG01625072 Aminotransferase, class II (EC 2.3.1.-) +FIG01625075 FIG01198927: hypothetical protein +FIG01625100 NrtR-regulated hypothetical OrfY +FIG01625101 probable phage prohead protease, HK97 family +FIG01625194 Amino acid ABC transporter, amino acid-binding/permease protein +FIG01625195 devC-like ABC transporter permease protein +FIG01625210 hypothetical protein +FIG01625214 FIG01208389: hypothetical protein +FIG01625228 ORF_ID:tlr1760 probable prohibitin +FIG01625245 FIG00898051: hypothetical protein +FIG01625272 FIG00501965: hypothetical protein +FIG01625279 FIG00352963: hypothetical protein +FIG01625312 hypothetical protein +FIG01625336 FIG01027761: hypothetical protein +FIG01625346 FIG01038202: hypothetical protein +FIG01625351 peroxiredoxin-like protein +FIG01625365 Membrane-bound lytic murein transglycosylase +FIG01625368 FIG00528418: hypothetical protein +FIG01625374 serine/threonine protein kinase PpkA +FIG01625416 Serine/Threonine protein kinase (EC 2.7.1.123) +FIG01625428 Mov34/MPN/PAD-1 family +FIG01625437 FIG00733894: hypothetical protein +FIG01625446 Exoproteins involved in heme utilization or adhesion +FIG01625514 COG1136: ABC-type antimicrobial peptide transport system, ATPase component +FIG01625578 probable acetyl xylan esterase +FIG01625583 Mlr3122 protein +FIG01625627 N-Acetyl-D-glucosamine-related ABC transport system, permease protein 2 +FIG01625637 FIG00642909: hypothetical protein +FIG01625654 FIG00794787: hypothetical protein +FIG01625676 FIG00767162: hypothetical protein +FIG01625776 subtilisin carlsberg precursor, putative( EC:3.4.21.62 ) +FIG01625780 FIG01167179: hypothetical protein +FIG01625792 probable short chain dehydrogenase +FIG01625816 HesB/YadR/YfhF-family protein +FIG01625853 cell volume regulation protein CvrA +FIG01625891 FIG00786943: hypothetical protein +FIG01625937 oxidoreductase, short-chain dehydrogenase-reductase family +FIG01625939 FIG00766922: hypothetical protein +FIG01626035 RelB/StbD replicon stabilization protein (antitoxin to RelE/StbE) +FIG01626051 iron-sulphur-binding reductase +FIG01626073 YcfA-like protein +FIG01626162 FIG00835029: hypothetical protein +FIG01626164 cytoplasmic domain of flagellar protein FhlB-like protein +FIG01626242 putative methyltransferase family +FIG01626244 laminin G, sub domain 2 +FIG01626265 FIG00388729: hypothetical protein +FIG01626267 Endoglucanase B precursor (EC 3.2.1.4) (Endo-1,4-beta-glucanase B) (Cellulase B) (EG-B) +FIG01626280 FIG00351807: hypothetical protein +FIG01626314 alkyl hydroperoxide reductase +FIG01626344 FIG00388308: hypothetical protein +FIG01626378 ABC transport system, ATPase component +FIG01626392 Multifunctional nonribosomal peptide synthetase +FIG01626397 FIG00555540: hypothetical protein +FIG01626421 FIG00388551: hypothetical protein +FIG01626428 FIG00356404: hypothetical protein +FIG01626469 phage protein homolog lin2602 +FIG01626501 FIG01150558: hypothetical protein +FIG01626515 Maltose transport system permease protein malF +FIG01626556 FIG00624377: hypothetical protein +FIG01626588 FIG00527313: hypothetical protein +FIG01626590 acyl-CoA dehydrogenase, medium-chain specific( EC:1.3.99.3 ) +FIG01626593 FIG00408612: hypothetical protein +FIG01626613 Cytochrome P450 51 (EC 1.14.13.70) +FIG01626654 Proteinase inhibitor I42, chagasin +FIG01626674 Mlr1300 protein +FIG01626681 probable membrane protein STY0992 +FIG01626687 FIG00755731: hypothetical protein +FIG01626700 FIG00666957: hypothetical protein +FIG01626739 molybdopterin biosynthesis protein, D chain +FIG01626811 integrase family protein +FIG01626819 hypothetical protein +FIG01626823 FIG00411514: hypothetical protein +FIG01626824 FIG01238884: hypothetical protein +FIG01626856 Probable ABC transporter, permease protein +FIG01626869 FIG00348260: hypothetical protein +FIG01626883 probable haloalkane dehalogenase( EC:3.8.1.5 ) +FIG01626888 Cell wall-associated protein +FIG01626903 N-ethylmaleimide reductase (EC 1.-.-.-) +FIG01626924 PAS/PAC Sensor Hybrid Histidine Kinase +FIG01626962 Myosin heavy chain, nonmuscle type B +FIG01626977 Cell surface antigen Sca9 +FIG01627000 FIG00469286: hypothetical protein +FIG01627004 Phage associated-antirepressor +FIG01627011 superfamily I DNA helicase +FIG01627017 FIG00387890: hypothetical protein +FIG01627028 IncH1 plasmid conjugative transfer protein HtdV +FIG01627078 FIG00629076: hypothetical protein +FIG01627085 possible BRCA1 C Terminus (BRCT) domain +FIG01627095 FIG00407931: hypothetical protein +FIG01627114 Hypothetical protein, CF-17 family +FIG01627128 2-dehydro-3-deoxygalactonokinase, putative +FIG01627139 FIG00336677: hypothetical protein +FIG01627157 FIG00348858: hypothetical protein +FIG01627163 FIG01032145: hypothetical protein +FIG01627250 hypothetical protein +FIG01627262 truncated integrase +FIG01627289 putative lipopolysaccharide glycosyltransferase +FIG01627329 FIG00581959: hypothetical protein +FIG01627348 Glycosyl transferase family 1 protein-like +FIG01627378 FIG00361364: hypothetical protein +FIG01627380 L-fuculose-phosphate aldolase( EC:4.1.2.17 ) +FIG01627406 hypothetical protein +FIG01627409 FIG00623126: hypothetical protein +FIG01627412 probable DNA-binding protein HU +FIG01627445 Uncharacterized protein MJ0105 +FIG01627494 Transcriptional regulatory protein, conjectural +FIG01627496 NAD(P)H dehydrogenase (quinone)( EC:3.1.4.14 ) +FIG01627518 FIG00817481: hypothetical protein +FIG01627529 FIG00847918: hypothetical protein +FIG01627575 putative WD-repeat containing protein +FIG01627591 Antioxidant, putative +FIG01627595 FIG00349400: hypothetical protein +FIG01627597 FIG00642058: hypothetical protein +FIG01627605 FIG00752846: hypothetical protein +FIG01627618 FIG00874333: hypothetical protein +FIG01627634 thioesterase domain protein +FIG01627654 Uncharacterized protein MJ0670 +FIG01627676 Amino acid ABC transporter, permease protein +FIG01627677 FIG00361446: hypothetical protein +FIG01627698 ATP-binding region, ATPase-like protein +FIG01627720 Possible sugar ABC transporter, permease component 1 +FIG01627730 bacterial histone like protein +FIG01627763 Glyoxalase/bleomycin resistance protein/dioxygenase +FIG01627776 FIG00754854: hypothetical protein +FIG01627820 FIG00414132: hypothetical protein +FIG01627824 FIG00361789: hypothetical protein +FIG01627826 FIG00824961: hypothetical protein +FIG01627860 FIG01167104: hypothetical protein +FIG01627953 Acetyltransf, Acetyltransferase (GNAT) family +FIG01627978 FIG00450081: hypothetical protein +FIG01627982 FIG00344976: hypothetical protein +FIG01627999 TIORF34 protein +FIG01628062 ISXo2 transposase +FIG01628086 peptidase E +FIG01628125 conserved hypothetical protein; putative membrane protein; putative exported protein +FIG01628127 FIG00403342: hypothetical protein +FIG01628136 FIG00711119: hypothetical protein +FIG01628174 hypothetical protein; putative ''Winged helix'' DNA-binding domain +FIG01628189 FIG01159000: hypothetical protein +FIG01628196 16 kD immunogenic protein +FIG01628201 GGDEF/EAL domain protein +FIG01628233 Lactose phosphotransferase system repressor lacR +FIG01628241 FIG00356665: hypothetical protein +FIG01628270 probable sodium extrusion protein NatB +FIG01628272 Toluene tolerance protein +FIG01628282 NDP-hexose 4-ketoreductase UrdR +FIG01628292 probable thiamine pyrophosphate dependent enzyme +FIG01628304 FIG00520480: hypothetical protein +FIG01628305 UDP-sulfoquinovose synthase (EC 3.13.1.1) +FIG01628313 Uncharacterized protein MJ0856 +FIG01628330 TIM-barrel enzyme, nifR3 family +FIG01628344 Tub +FIG01628356 Ribosomal small subunit Rsm22 +FIG01628374 FIG00361918: hypothetical protein +FIG01628395 annexin VII +FIG01628401 FIG01092353: hypothetical protein +FIG01628418 cytochrome b6-f complex subunit PetM +FIG01628436 conserved hypothetical prolipoprotein (abc transporter?) +FIG01628441 universal stress family protein +FIG01628450 VirB6-like protein of the type IV secretion system +FIG01628492 FIG00638692: hypothetical protein +FIG01628564 hypothetical protein +FIG01628573 atp-binding transport protein +FIG01628663 Uncharacterized protein, YYAC B.subtilis homolog (fragment) +FIG01628674 FIG00468182: hypothetical protein +FIG01628677 Bifunctional endo-1,4-beta-xylanase XYLA precursor (EC 3.2.1.8) +FIG01628698 ZINC PROTEASE +FIG01628708 MFS family transporter +FIG01628736 Mll3904 protein +FIG01628868 Hxdroxypyruvate reductase( EC:1.1.1.81 ) +FIG01628874 Sll1507 protein +FIG01628875 FIG00346670: hypothetical protein +FIG01628930 adhA upstream ORF +FIG01628996 Transposase +FIG01629007 FIG00385271: hypothetical protein +FIG01629080 transposase N-terminus +FIG01629094 glycine cleavage system, H protein +FIG01629108 FIG00362058: hypothetical protein +FIG01629118 hypothetical protein +FIG01629125 FIG00405916: hypothetical protein +FIG01629132 FIG01154220: hypothetical protein +FIG01629149 D-glutamyl-L-m-Dpm peptidase P45; Peptidoglycan lytic protein P45 +FIG01629150 Zinc transporter, ZIP family +FIG01629152 D-aspartate ligase (EC 6.3.1.12) +FIG01629214 hydrolase, alpha/beta superfamily +FIG01629217 FIG00711765: hypothetical protein +FIG01629228 FIG01120010: hypothetical protein +FIG01629235 Retinol dehydrogenase 14 (EC 1.1.1.-) +FIG01629237 oxidoreductase, aldo reductase +FIG01629242 FIG00348076: hypothetical protein +FIG01629267 putative thiol-disulphide oxidoreductase DCC +FIG01629282 hypothetical protein +FIG01629286 FIG01206385: hypothetical protein +FIG01629328 C3: similar to Vanillate O-demethylase oxygenase +FIG01629341 FIG00390549: hypothetical protein +FIG01629372 Slr0431 protein +FIG01629380 FIG00834632: hypothetical protein +FIG01629383 FIG01252972: hypothetical protein +FIG01629391 FIG00268753: hypothetical protein +FIG01629409 ORF +FIG01629414 ISSod6, transposase +FIG01629419 ribose-phosphate pyrophosphokinase( EC:2.7.6.1 ) +FIG01629440 FIG00814841: hypothetical protein +FIG01629481 FIG00816166: hypothetical protein +FIG01629493 Polysaccharide deacetylase-like protein +FIG01629527 FIG00840579: hypothetical protein +FIG01629530 FIG00405049: hypothetical protein +FIG01629545 FIG00564009: hypothetical protein +FIG01629558 FIG00653930: hypothetical protein +FIG01629563 putative membrane protein; triplicated sequence +FIG01629599 carboxylesterase NA +FIG01629602 FIG00850849: hypothetical protein +FIG01629660 Putative enzyme of poly-gamma-glutamate biosynthesis +FIG01629726 NanA gene +FIG01629748 putative acyltransferase, group 3 +FIG01629755 Rickettsia 17 kDa surface antigen +FIG01629808 regulatory protein for cyclic-di-GMP, EAL domain +FIG01629817 FIG00640109: hypothetical protein +FIG01629819 FIG00408038: hypothetical protein +FIG01629828 jumonji domain containing 5 +FIG01629876 FIG01246574: hypothetical protein +FIG01629878 cold-active alkaline serine protease +FIG01629903 2-amino-3-carboxymuconate-6- semialdehydedecarboxylase +FIG01629918 FIG01119959: hypothetical protein +FIG01629930 FIG01093783: hypothetical protein +FIG01629979 Phage Mu Mom-like protein +FIG01629984 FIG01234056: hypothetical protein +FIG01630060 phage P2 baseplate assembly protein gpV +FIG01630073 Protein of unknown function, Porph ging +FIG01630079 FIG00631705: hypothetical protein +FIG01630103 Outer memberane protein Sca15 +FIG01630119 FIG00408873: hypothetical protein +FIG01630120 Tn5045 transposase +FIG01630132 FIG00361612: hypothetical protein +FIG01630198 FIG01126256: hypothetical protein +FIG01630205 FIG00631025: hypothetical protein +FIG01630231 FIG00533459: hypothetical protein +FIG01630247 FIG00814138: hypothetical protein +FIG01630249 Phage shock domain protein +FIG01630307 FIG00426410: hypothetical protein +FIG01630310 putative quinone oxidoreductase +FIG01630313 Putative marR-family transcriptional regulator +FIG01630332 FIG00686423: hypothetical protein +FIG01630336 hypothetical protein +FIG01630342 Putative prophage repressor protein +FIG01630361 FIG00823948: hypothetical protein +FIG01630366 FIG00385084: hypothetical protein +FIG01630368 short-chain alcohol dehydrogenase-like protein +FIG01630420 haloalkane dehalogenase( EC:3.8.1.5 ) +FIG01630424 FIG00347767: hypothetical protein +FIG01630434 FIG00624436: hypothetical protein +FIG01630467 Glutamate carboxypeptidase II precursor (EC 3.4.17.21) +FIG01630511 COG2124: Cytochrome P450 +FIG01630522 FIG01114110: hypothetical protein +FIG01630531 FIG01134650: hypothetical protein +FIG01630568 DnaG primase-like protein +FIG01630571 Aldo/keto reductase( EC:1.1.1.274 ) +FIG01630642 possible extracellular exo-xylanase +FIG01630643 putative protein with helicase domain +FIG01630650 Type IV pilus biogenesis protein PilQ; Competence protein E +FIG01630662 FIG00624694: hypothetical protein +FIG01630681 FIG00353346: hypothetical protein +FIG01630693 FIG00356743: hypothetical protein +FIG01630694 putative peptide ABC transporter, permease component +FIG01630712 FIG00749349: hypothetical protein +FIG01630789 7,8-dihydro-8-oxoguanine triphosphatase (EC 3.1.6.-) +FIG01630795 FIG00418002: hypothetical protein +FIG01630808 lipase like family member (4M534) +FIG01630827 FIG00251480: hypothetical protein +FIG01630832 FIG00622825: hypothetical protein +FIG01630837 FIG00518271: hypothetical protein +FIG01630844 pyoverdine efflux carrier and ATP binding protein +FIG01630847 INTEGRAL MEMBRANE PROTEIN (Rhomboid family) +FIG01630853 putative alpha-1,6-galactosidase +FIG01630865 FIG00688029: hypothetical protein +FIG01630870 FIG00849874: hypothetical protein +FIG01630885 ortholog of Bordetella pertussis (BX470248) BP1829 +FIG01630915 FIG00361608: hypothetical protein +FIG01630934 GGDEF family protein +FIG01630965 Ancient conserved domain protein 4 +FIG01630979 FIG00352619: hypothetical protein +FIG01631004 MGC80593 protein +FIG01631015 heterodisulfide reductase +FIG01631021 FIG01118528: hypothetical protein +FIG01631037 LpfD protein precursor +FIG01631050 dihydrolipoamide acetyltransferase, putative +FIG01631054 Mll2956 protein +FIG01631059 C-factor +FIG01631077 probable pyruvate kinase +FIG01631080 Drug resistance transporter Bcr/CflA subfamily +FIG01631141 FIG00748685: hypothetical protein +FIG01631189 FIG00836682: hypothetical protein +FIG01631211 COG3001: Fructosamine-3-kinase +FIG01631223 Glycosyltransferase involved in cell wall biogenesis( EC:2.4.- ) +FIG01631238 Archaeal heat shock regulator, ArsR family +FIG01631243 FIG00522732: hypothetical protein +FIG01631259 Bem46 protein (EC 3.4.-.-) +FIG01631292 FIG00354332: hypothetical protein +FIG01631341 protein of unknown function DUF1365 +FIG01631350 FIG00761568: hypothetical protein +FIG01631369 possible Galanin +FIG01631378 FIG00623776: hypothetical protein +FIG01631389 FIG00527455: hypothetical protein +FIG01631391 Alpha-lytic protease precursor (EC 3.4.21.12) (Alpha-lytic endopeptidase) +FIG01631397 FIG01046546: hypothetical protein +FIG01631413 FIG00411617: hypothetical protein +FIG01631418 hypothetical protein +FIG01631436 Chey-like receiver domain containing protein, YCBB B.subtilis ortholog +FIG01631440 COG3772: Phage-related lysozyme (muraminidase) +FIG01631448 TraD +FIG01631470 FIG00764857: hypothetical protein +FIG01631484 Glycoprotein/polysaccharide metabolism +FIG01631491 replication initiation protein +FIG01631502 FIG00850327: hypothetical protein +FIG01631520 transcriptional regulator BkdR +FIG01631558 FIG00711867: hypothetical protein +FIG01631601 KAP P-loop domain protein +FIG01631618 conservedhypothetical protein +FIG01631626 conserved hypothetical protein TIGR00305 +FIG01631631 CorD2 protein +FIG01631669 Weakly similar to Thermoplasma acidophilum hypothetical protein TA0352 SWALL:Q9HL78 (EMBL:AL445064) (164 aa) fasta scores: E(): 0.00039, 27.13% id in 129 aa, and to Archaeoglobus fulgidus hypothetical protein AF0203 SWALL:O30036 (EMBL:AE001092) (149 aa) fasta scores: E(): 0.00091, 31.53% id in 130 aa +FIG01631681 putative outer membrane receptor protein +FIG01631687 carbohydrate binding protein +FIG01631696 FIG00412068: hypothetical protein +FIG01631701 FIG00412074: hypothetical protein +FIG01631709 putative dihydropteroate synthase +FIG01631710 UPF0353 protein Rv1481/MT1528 +FIG01631729 FIG00450678: hypothetical protein +FIG01631735 Probable nucleoside-diphosphate kinase N-terminal domain +FIG01631741 hydrolase (metallo-beta-lactamase superfamily) +FIG01631750 FIG00622937: hypothetical protein +FIG01631755 DegV +FIG01631775 Surface protein pspA precursor +FIG01631795 FIG00672479: hypothetical protein +FIG01631801 probable anti-anti-sigma regulatory factor (antagonist of anti-sigma factor) +FIG01631811 COG3469: Chitinase +FIG01631820 FIG00364884: hypothetical protein +FIG01631871 ABC transporter ATP-binding protein (taurine) +FIG01631896 Phage uncharacterized protein-like +FIG01631913 FIG00643892: hypothetical protein +FIG01631931 Ribosomal protein L7/L12 +FIG01631932 FIG00624108: hypothetical protein +FIG01631938 FIG01237759: hypothetical protein +FIG01631998 probable NADH-dependent dehydrogenase( EC:1.- ) +FIG01632052 Methyltransferase TK2241 +FIG01632064 FIG00349418: hypothetical protein +FIG01632068 possible phage integrase family +FIG01632074 FIG00524550: hypothetical protein +FIG01632085 FIG00351961: hypothetical protein +FIG01632105 Putative HTH-type transcriptional regulator ypdC +FIG01632134 FIG01066692: hypothetical protein +FIG01632153 Redoxin domain protein +FIG01632167 Gll2047 protein +FIG01632189 FIG01166186: hypothetical protein +FIG01632203 FIG00632264: hypothetical protein +FIG01632234 protein of unknown function DUF107 +FIG01632305 FIG01094697: hypothetical protein +FIG01632308 CDP-diglyceride synthetase +FIG01632309 N-acetylglucosamine-6-phosphate deacetylase +FIG01632328 Response regulator receiver +FIG01632333 FIG00816691: hypothetical protein +FIG01632357 FIG00762572: hypothetical protein +FIG01632444 tRNA methylase YGL050w homolog Wyeosine biosynthesis +FIG01632450 bacteriophage transposase A protein +FIG01632457 BplB +FIG01632459 dTDP-glucose 4,6-dehydratase (EC 4.2.1.46) +FIG01632466 transposase, Mutator family +FIG01632556 Protein of unknown function UPF0102 +FIG01632604 hypothetical protein +FIG01632627 sterol desaturase protein +FIG01632666 anti-ECFsigma factor, ChrR +FIG01632690 FIG00688016: hypothetical protein +FIG01632736 Propanediol utilization polyhedral body protein PduB +FIG01632737 glycosyl transferase family 8 protein( EC:2.4.1.- ) +FIG01632742 FIG00361280: hypothetical protein +FIG01632793 FIG00388443: hypothetical protein +FIG01632800 FIG00624632: hypothetical protein +FIG01632806 Serine protease HtrA (DegP protein) +FIG01632848 RelE/StbE replicon stabilization toxin +FIG01632928 FIG00413783: hypothetical protein +FIG01632983 Tn554-related, transposase B +FIG01633045 FIG00412123: hypothetical protein +FIG01633057 FIG00624763: hypothetical protein +FIG01633061 ORF_ID:all7676 unknown protein +FIG01633066 peptidase, S24 family +FIG01633127 FIG00379970: hypothetical protein +FIG01633146 FIG00527613: hypothetical protein +FIG01633167 RESPONSE REGULATOR PROTEIN-CheY-like nd an HD-GYP domain +FIG01633177 UPF0178 protein BR1979 +FIG01633180 conserved protein YdbB +FIG01633182 FIG00344009: hypothetical protein +FIG01633187 FIG00746330: hypothetical protein +FIG01633201 Putative secreted protease +FIG01633202 probable RNA polymerase ECF-type sigma factor +FIG01633223 Parallel beta-helix repeat +FIG01633246 FIG00409540: hypothetical protein +FIG01633248 putative peptide monooxygenase( EC:1.13.12.- ) +FIG01633254 FIG00849285: hypothetical protein +FIG01633293 Transcriptional regulators-like +FIG01633298 FIG00664649: hypothetical protein +FIG01633356 Secreted protein containing C-terminal beta-propeller domain distantly related to WD-40 repeats +FIG01633377 Putative Fe-S cluster +FIG01633391 FIG01233741: hypothetical protein +FIG01633393 Probable MDR-type ABC transporter, ATP-binding protein +FIG01633398 FIG00623450: hypothetical protein +FIG01633415 HEPN domain-containing nucleotidyltransferase +FIG01633492 leucine rich repeat variant +FIG01633497 FIG00771309: hypothetical protein +FIG01633500 FIG00959164: hypothetical protein +FIG01633553 Cell surface protein, ErfK family +FIG01633573 FIG00347669: hypothetical protein +FIG01633598 FIG00416028: hypothetical protein +FIG01633608 putative solute:Na symporter +FIG01633614 FIG00406234: hypothetical protein +FIG01633621 HEAT domain containing protein +FIG01633625 protein of unknown function DUF164 +FIG01633626 NADH dehydrogenase subunit I( EC:1.6.5.3 ) +FIG01633627 ABC transporter, ATP binding component, possibly for oligopeptides +FIG01633650 avermectin gene cluster +FIG01633654 Positive regulator of phenol-degradative genes +FIG01633669 YvqG +FIG01633685 FIG00388309: hypothetical protein +FIG01633708 phage portal protein, putative, A118 family +FIG01633744 Stress-induced protein OsmC +FIG01633745 FIG00848468: hypothetical protein +FIG01633756 hypothetical protein +FIG01633763 FIG00407628: hypothetical protein +FIG01633805 FIG00733186: hypothetical protein +FIG01633829 FIG01226895: hypothetical protein +FIG01633842 FIG00766909: hypothetical protein +FIG01633846 FIG00388917: hypothetical protein +FIG01633864 COG0842: ABC-type multidrug transport system, permease component +FIG01633908 FIG00423825: hypothetical protein +FIG01633955 Cellulose-binding, family II +FIG01634029 Phosphoprotein phosphatase( EC:3.1.3.16 ) +FIG01634060 similar to Beta-glucosidase-related glycosidases +FIG01634073 Transcribed locus [Source:UniGene;Acc:Cin.16458] +FIG01634077 FIG00688286: hypothetical protein +FIG01634078 Rieske (2Fe-2S) domain protein +FIG01634114 bile acid 7-alpha-dehydratase +FIG01634115 FIG00426440: hypothetical protein +FIG01634134 alkylhydroperoxidase AhpD domain protein +FIG01634145 FIG00412681: hypothetical protein +FIG01634153 FIG00752057: hypothetical protein +FIG01634228 GDP-mannose 4,6-dehydratase +FIG01634247 FIG00348004: hypothetical protein +FIG01634286 inner membrane protein AmpE +FIG01634304 FIG01200855: hypothetical protein +FIG01634310 Putative lysogenic conversion protein +FIG01634323 hypothetical protein Acry_0114 +FIG01634332 FIG00361944: hypothetical protein +FIG01634345 microtubule binding protein +FIG01634364 putative sugar transport integral membrane protein +FIG01634367 Macrolide-efflux protein +FIG01634384 Fe uptake system permease +FIG01634385 putative cytochrome d ubiquinol oxidase subunit II +FIG01634423 O-methyltransferase, family 3( EC:2.1.1.104 ) +FIG01634446 elements of external origin; transposon-related functions +FIG01634473 FIG01115107: hypothetical protein +FIG01634579 FIG00349693: hypothetical protein +FIG01634620 FIG00514302: hypothetical protein +FIG01634639 choline transport system permease protein +FIG01634648 FIG00840065: hypothetical protein +FIG01634656 Protein of unknown function DUF208 +FIG01634685 possible lactate/malate dehydrogenase, alpha/b +FIG01634704 Uncharacterized protein Rv1261c/MT1299 +FIG01634709 Ej97D protein +FIG01634717 DNA-damage-inducible protein J, putative +FIG01634725 truncated glycosyltransferase +FIG01634735 UnbV +FIG01634745 Flagellar hook-length control protein FliK +FIG01634790 hypothetical protein +FIG01634821 replication-associated protein RepA1 +FIG01634826 FIG00752663: hypothetical protein +FIG01634841 integral membrane protein DUF6 +FIG01634857 Phosphoesterase, PA-phosphatase related protein +FIG01634860 FIG00623695: hypothetical protein +FIG01634875 ortholog of Bordetella pertussis (BX470248) BP2236 +FIG01634896 FIG00776120: hypothetical protein +FIG01634899 FIG00349391: hypothetical protein +FIG01634914 iron ABC transporter, solute-binding protein +FIG01634923 Type II restriction enzyme BsuFI (EC 3.1.21.4) +FIG01634956 Rubrerythrin subfamily +FIG01634997 FIG00685478: hypothetical protein +FIG01635072 Phage protein +FIG01635099 FIG00524330: hypothetical protein +FIG01635108 ORF_ID:alr7529 hypothetical protein +FIG01635121 Cof-like hydrolase( EC:3.8.1.- ) +FIG01635146 General substrate transporter +FIG01635189 Monooxygenase, FAD-binding protein +FIG01635199 SENSOR/RESPONSE REGULATOR HYBRID +FIG01635226 CI repressor of phage 186 and others +FIG01635287 FIG00624676: hypothetical protein +FIG01635362 Transposase, IS630 family +FIG01635422 N-methyltransferase, putative +FIG01635444 Tellurite-resistance/Dicarboxylate Transporter (TDT) family +FIG01635448 FIG01175640: hypothetical protein +FIG01635458 sec-C metal-binding protein +FIG01635467 conserved hypothetical protein containing the kelch-motif +FIG01635490 putative glucokinase, ROK family +FIG01635555 daunorubicin C-13 ketoreductase XF1741 +FIG01635597 probable ECF sigma factor (sigma-70 family) +FIG01635646 Ketoacyl reductase hetN (EC 1.3.1.-) +FIG01635655 putative plasmid replication protein repA +FIG01635676 ATPase (AAA+ superfamily)-like +FIG01635694 FIG00415907: hypothetical protein +FIG01635704 Benzylsuccinate synthase beta subunit (EC 4.1.99.11) +FIG01635732 FIG00649460: hypothetical protein +FIG01635770 TonB-dependent siderophore receptor, putative +FIG01635820 hypothetical protein +FIG01635826 Tsl1837 protein +FIG01635839 CofC, F420 2-Phospho-l-lactate Guanylyltransferase +FIG01635882 starvation induced DNA binding protein +FIG01635897 FIG00754575: hypothetical protein +FIG01635908 FIG00733453: hypothetical protein +FIG01635943 ISCco1, transposase orfA +FIG01635958 FIG00966855: hypothetical protein +FIG01635981 FIG00344231: hypothetical protein +FIG01636017 Flagellar hook capping protein +FIG01636041 FIG00623318: hypothetical protein +FIG01636044 Pre-mRNA splicing helicase +FIG01636078 FIG00877439: hypothetical protein +FIG01636086 FIG00379895: hypothetical protein +FIG01636091 C4-dicarboxylate-transport transmembrane protein DctA +FIG01636129 Putative metal ion ABC transporter, substrate-binding lipoprotein precursor +FIG01636132 FIG00641534: hypothetical protein +FIG01636152 Kumamolisin-As +FIG01636160 putative ATP-dependent DNA helicase( EC:3.6.1.- ) +FIG01636168 ISMsm3, transposase +FIG01636176 FIG01006602: hypothetical protein +FIG01636237 FIG00624846: hypothetical protein +FIG01636253 protein of unknown function DUF1499 +FIG01636263 TPR-repeat lipoprotein +FIG01636265 Acetyltransferase or hydrolase +FIG01636284 competence protein ComEA-related protein +FIG01636302 Sensory box protein, GGDEF family protein, LssE +FIG01636328 Sulfotransferase domain protein +FIG01636347 FIG00752138: hypothetical protein +FIG01636380 protein YgiW precursor +FIG01636392 Asr2172 protein +FIG01636399 Transcriptional regulator-like +FIG01636401 FIG01119085: hypothetical protein +FIG01636406 FIG00744152: hypothetical protein +FIG01636411 conserved hypothetical protein-putative cycloisomerase +FIG01636438 Aldo/keto reductase( EC:1.1.1.91 ) +FIG01636485 FIG00629973: hypothetical protein +FIG01636495 Fe-hydrogenase, gamma subunit +FIG01636534 probable sulfite reductase +FIG01636541 Probable glycosyl hydrolase +FIG01636610 Mob protein +FIG01636638 Uncharacterized protein y4vH +FIG01636642 FIG00847916: hypothetical protein +FIG01636661 FIG202268: hypothetical protein +FIG01636732 extracellular solute-binding protein family 5 +FIG01636781 iron sulphur protein (secreted protein) +FIG01636810 tetrathionate reductase complex response regulator +FIG01636815 FIG00350290: hypothetical protein +FIG01636856 FIG01177692: hypothetical protein +FIG01636866 periplasmic serine protease, HtrA/DegQ/DegS family +FIG01636897 protein racC domain protein +FIG01636952 DNA topology modulation kinase FlaR, putative +FIG01636978 FIG00410869: hypothetical protein +FIG01636989 FIG00633730: hypothetical protein +FIG01636990 FIG00624197: hypothetical protein +FIG01637017 FIG00754208: hypothetical protein +FIG01637092 CRISPR-associated helicase Cas3, protein +FIG01637105 hypothetical protein +FIG01637120 predicted Zn-dependent protease +FIG01637206 FIG00833849: hypothetical protein +FIG01637212 FIG00734302: hypothetical protein +FIG01637216 conserved protein of unknown function; putative thioesterase domain +FIG01637228 FIG00425706: hypothetical protein +FIG01637240 FIG01007265: hypothetical protein +FIG01637302 Xylanase regulatory protein +FIG01637309 Ankyrin-repeat protein A +FIG01637321 putative chromosome partitioning protein +FIG01637327 FIG00413877: hypothetical protein +FIG01637367 BETA-TIP (BETA-TONOPLAST INTRINSIC PROTEIN); water channel +FIG01637390 related to transcription regulator +FIG01637410 hypothetical protein +FIG01637479 xanthomonapepsin related protein +FIG01637554 FIG00631824: hypothetical protein +FIG01637560 FIG00451552: hypothetical protein +FIG01637575 FIG01166825: hypothetical protein +FIG01637589 Hyalin +FIG01637592 transcriptional antiterminator +FIG01637627 FIG00364658: hypothetical protein +FIG01637644 VWA containing CoxE-like +FIG01637653 FIG00523284: hypothetical protein +FIG01637690 Putative ski2-type helicase MJ1124 +FIG01637702 ATP-binding protein of an ABC transporter complex +FIG01637704 putative serine protease (putative secreted protein) +FIG01637715 Bipolar DNA helicase HerA +FIG01637742 Gll1509 protein +FIG01637755 adenine-specific DNA methyltransferase( EC:2.1.1.72 ) +FIG01637756 FIG00350928: hypothetical protein +FIG01637774 Receptor-like protein kinase +FIG01637792 ABC transporter, ATP binding component, possibly iron transporter +FIG01637806 FIG00351682: hypothetical protein +FIG01637811 FIG00623336: hypothetical protein +FIG01637831 protein disulfide-isomerase +FIG01637833 Complete genome; segment 8/17 +FIG01637841 COG3673: Uncharacterized conserved protein +FIG01637892 FIG00471987: hypothetical protein +FIG01637934 conserved protein YqjF +FIG01638001 FIG00734124: hypothetical protein +FIG01638017 FIG00673412: hypothetical protein +FIG01638032 FIG01203931: hypothetical protein +FIG01638045 putative universal stress family domain protein +FIG01638059 Phosphotransacetylase +FIG01638073 Male sterility C-terminal domain +FIG01638074 NADPH-dependent FMN reductase family protein +FIG01638087 protein of unknown function DUF1468 +FIG01638090 COG0456: Acetyltransferases +FIG01638099 FIG00835163: hypothetical protein +FIG01638187 BBG30-like protein +FIG01638206 IrpP +FIG01638214 TrpBA operon transcriptional activator +FIG01638269 similar to Antirepressor regulating drug resistance predicted signal transduction N-terminal membrane component +FIG01638290 probable capsid portal protein +FIG01638306 putative stage IV sporulation YqfD +FIG01638330 Phospholipid and glycerol acyltransferase (EC 2.3.1.51) +FIG01638331 FIG01215019: hypothetical protein +FIG01638333 Serine/threonine-protein kinase B (EC 2.7.11.1) +FIG01638343 FIG00409125: hypothetical protein +FIG01638346 PaREP9, associated with SRSRs +FIG01638378 ABC transporter ATPase +FIG01638384 fimbrial subunit +FIG01638419 Co/Zn/Cd cation transporter +FIG01638428 Dimethylmenaquinone methyltransferase family protein +FIG01638480 YbbR family protein +FIG01638484 Probable cytochrome-c peroxidase (EC 1.11.1.5) +FIG01638510 hypothetical protein +FIG01638545 Transcriptional regulator RegR, rpressor of hyaluronate and KDG utilization +FIG01638566 FIG00623052: hypothetical protein +FIG01638577 orf; hypothetical protein +FIG01638578 FIG00672996: hypothetical protein +FIG01638582 putative DNA replication protein +FIG01638626 ATP/GTP-binding protein, doubtful CDS +FIG01638635 FIG00343878: hypothetical protein +FIG01638652 FIG01213901: hypothetical protein +FIG01638755 Demethylmenaquinone methyltransferase-like protein +FIG01638756 Putative dicarboxylic acid hydrolase +FIG01638759 endoglucanase +FIG01638798 Mll3243 protein +FIG01638810 CDS_ID OB0153 +FIG01638824 Coenzyme F420-dependent N5 N10-methylene tetrahydromethanopterin reductase and related flavin-dependent oxidoreductase-like protein +FIG01638836 FIG00426557: hypothetical protein +FIG01638844 DNA ligase (ATP) (EC 6.5.1.1) +FIG01638873 putative short-chain dehydrogenase/reductase +FIG01638893 Cysteine sulfinate desulfinase/cysteine desulfurase and related enzymes-like +FIG01638912 FIG00623935: hypothetical protein +FIG01638973 Hypothetical protein Cj0261c +FIG01638981 GNAT family acetyltransferase BA2069 +FIG01638984 FIG00468569: hypothetical protein +FIG01638991 Heterocyst specific ABC transporter permease protein +FIG01638992 FIG00624538: hypothetical protein +FIG01639006 Flagellar biosynthetic protein flhB +FIG01639012 putative suagr ABC transporter permease protein +FIG01639017 WavE lipopolysaccharide synthesis +FIG01639028 peptidoglycan-associated outer membrane lipoprotein precursor +FIG01639059 FIG00574812: hypothetical protein +FIG01639076 methyl-accepting chemotaxis protein (tlpB), putative +FIG01639114 V4R domain protein +FIG01639143 FIG01119051: hypothetical protein +FIG01639189 VacJ lipoprotein +FIG01639194 A. fulgidus predicted coding region AF1548 +FIG01639255 diacylglycerol kinase catalytic region +FIG01639260 FIG00633131: hypothetical protein +FIG01639266 FIG00388410: hypothetical protein +FIG01639280 Putative secreted protein +FIG01639286 FIG00349659: hypothetical protein +FIG01639297 Posttranslational flagellin modification protein A +FIG01639311 Sensory transduction protein with GGDEF and EAL domains +FIG01639324 FIG00353354: hypothetical protein +FIG01639370 cis-3-chloroacrylic acid dehalogenase +FIG01639371 putative acetyltransferase, (GNAT) family +FIG01639420 FIG01165475: hypothetical protein +FIG01639422 PE-PGRS FAMILY-RELATED PROTEIN +FIG01639440 FIG00719351: hypothetical protein +FIG01639488 UPF0146 protein MJ0688 +FIG01639491 Na+/H+ antiporter cdu2 +FIG01639502 sodium:sulfate symporter transmembrane domain protein +FIG01639506 transcriptional regulator protein +FIG01639507 FIG00803913: hypothetical protein +FIG01639538 c-type lectin precursor family member (2D393) / c-type lectin precursor family member (2D393) +FIG01639570 FIG00417121: hypothetical protein +FIG01639599 copper binding protein, plastocyanin/azurin family +FIG01639602 Glutamate decarboxylase (EC 4.1.1.15) +FIG01639644 Mu-like prophage FluMu protein GP27 +FIG01639664 FIG00820246: hypothetical protein +FIG01639691 Uncharacterized Fe-S protein (fragment) +FIG01639727 hypothetical protein +FIG01639730 probable arylsulfatase( EC:3.1.6.- ) +FIG01639755 hypothetical protein +FIG01639757 FIG00424763: hypothetical protein +FIG01639800 FIG00631917: hypothetical protein +FIG01639841 FIG00380361: hypothetical protein +FIG01639874 FIG00518239: hypothetical protein +FIG01639904 FIG00259221: hypothetical protein +FIG01639905 INTEGRASE/RECOMBINASE (XERCD FAMILY) +FIG01639965 FIG00193372: hypothetical protein +FIG01639968 FIG00783131: hypothetical protein +FIG01639977 FIG00643397: hypothetical protein +FIG01639991 ubiE/COQ5 methyltransferase familiy protein +FIG01640044 FIG01251401: hypothetical protein +FIG01640051 FIG00962970: hypothetical protein +FIG01640053 C_GCAxxG_C_C family protein +FIG01640091 FIG00898277: hypothetical protein +FIG01640144 FIG00417994: hypothetical protein +FIG01640157 FIG00499079: hypothetical protein +FIG01640167 Capsular polysaccharide biosynthesis protein-like +FIG01640181 FIG00361806: hypothetical protein +FIG01640185 FIG00425697: hypothetical protein +FIG01640243 Probable zinc metalloendopeptidase, leishmanolysin family (EC 3.4.24.36) +FIG01640249 FIG00640731: hypothetical protein +FIG01640259 DEAD/H associated domain protein +FIG01640307 endo-arabinase +FIG01640310 syc1618_c +FIG01640312 FIG00814888: hypothetical protein +FIG01640320 FIG00711479: hypothetical protein +FIG01640335 Prolyl oligopeptidase( EC:3.4.21.26 ) +FIG01640357 HD superfamily hydrolase +FIG01640362 PROBABLE L-ORNITHINE 5-MONOOXYGENASE OXIDOREDUCTASE PROTEIN( EC:1.13.12.- ) +FIG01640454 FIG00409931: hypothetical protein +FIG01640459 FIG00622838: hypothetical protein +FIG01640463 integral membrane protein; transport and binding protein; multidrug resistance; there is no connection with the lmrA gene +FIG01640505 transposase for IS1630-like insertion sequence element, putative +FIG01640513 Phosphocarrier protein, nitrogen regulation associated +FIG01640524 DNA topology modulation protein FlaR-related protein +FIG01640530 transcriptional regulator, ArsR +FIG01640543 Putative Sensor histidine kinase with PAS and Response regulator receiver domains +FIG01640568 FIG00711907: hypothetical protein +FIG01640575 DEOXYCYTIDYLATE DEAMINASE (DCMP DEAMINASE)( EC:3.5.4.12 ) +FIG01640666 regulatory protein Pchr, putative +FIG01640673 TetR family transcriptional regulator-like protein +FIG01640689 Orf, hypothetical +FIG01640696 FIG00675276: hypothetical protein +FIG01640704 Plasmid pO157 DNA, complete sequence +FIG01640718 FIG00733604: hypothetical protein +FIG01640758 hypothetical protein +FIG01640780 2-polyprenyl-6-methoxyphenol hydroxylase and related FAD-dependent oxidoreductases +FIG01640811 FIG01119637: hypothetical protein +FIG01640820 Neurotensin receptor R8 +FIG01640829 FIG00553240: hypothetical protein +FIG01640832 Transporter, TrkA family +FIG01640852 380aa long conserved hypothetical protein +FIG01640860 DNA polymerase III, epsilon subunit and related 3'-5' exonucleases +FIG01640877 replication protein RepA +FIG01640887 putative small membrane hydrophobic protein +FIG01640889 Phosphatidylcholine-hydrolyzing phospholipase C (EC 3.1.4.3) +FIG01640893 XkdE +FIG01640909 FIG00624391: hypothetical protein +FIG01641003 FIG00361441: hypothetical protein +FIG01641030 FIG00768654: hypothetical protein +FIG01641037 FIG00639112: hypothetical protein +FIG01641078 lipopolysaccaride biosynthesis protein wbpB +FIG01641091 17K common-antigen +FIG01641104 desulforedoxin, putative +FIG01641108 conserved protein YuxK +FIG01641131 hypothetical protein +FIG01641138 truncated phage T7 exclusion protein +FIG01641139 Putative virulence protein +FIG01641144 FIG00675028: hypothetical protein +FIG01641176 hypothetical protein +FIG01641209 Choline monooxygenase-like protein with aromatic-ring-hydroxylating dioxygenase domain +FIG01641210 Uncharacterized conserved membrane protein, possible permease +FIG01641230 FIG00385597: hypothetical protein +FIG01641232 Conjugal transfer protein +FIG01641249 FIG00522145: hypothetical protein +FIG01641304 anthranilate synthase component II( EC:4.1.3.27 ) +FIG01641386 NADH-dependent butanol dehydrogenase a (EC 1.1.99.8) +FIG01641410 probable HspC2 heat shock protein +FIG01641437 putative endonuclease precursor +FIG01641558 sodium-dependent transporter family protein +FIG01641589 possible tRNA/rRNA methyltransferase +FIG01641609 FIG01082414: hypothetical protein +FIG01641611 Sll0549 protein +FIG01641623 hypothetical protein +FIG01641636 FIG01115670: hypothetical protein +FIG01641639 L-shaped tail fiber protein +FIG01641661 FIG00361388: hypothetical protein +FIG01641669 Succinoglycan biosynthesis protein exoM (EC 2.-.-.-) +FIG01641701 hypothetical protein +FIG01641703 stress response; osmosensing +FIG01641737 FIG01129253: hypothetical protein +FIG01641752 SOS-response cell division inhibitor +FIG01641780 F-box DNA helicase 1 +FIG01641786 FIG00348481: hypothetical protein +FIG01641825 FIG01093387: hypothetical protein +FIG01641841 FIG01044116: hypothetical protein +FIG01641859 possible transcriptional regulator YdgC +FIG01641918 gluconate permease gntP +FIG01641920 FRNE +FIG01641936 Cysteinyl-tRNA synthetase-like +FIG01641946 predicted phage-related membrane protein +FIG01641969 protein of unknown function DUF820 +FIG01642006 ribonuclease HI +FIG01642016 FIG01243676: hypothetical protein +FIG01642044 FIG00424838: hypothetical protein +FIG01642046 Putative tellurite resistance protein +FIG01642122 FIG00517141: hypothetical protein +FIG01642144 PseT polynucleotide 5'-kinase and 3'-phosphatase +FIG01642153 (S)-2-haloacid dehalogenase (EC 3.8.1.2) (2-haloalkanoic acid dehalogenase) (L-2-haloacid dehalogenase) (Halocarboxylic acid halidohydrolase) +FIG01642175 macromolecule metabolism; macromolecule synthesis, modification; rna synthesis, modification , dna transcription +FIG01642176 xanthomonadin biosynthesis related protein 2 +FIG01642205 FIG00356504: hypothetical protein +FIG01642225 FIG00475765: hypothetical protein +FIG01642226 FIG00468335: hypothetical protein +FIG01642242 FIG00364387: hypothetical protein +FIG01642248 FIG00839567: hypothetical protein +FIG01642306 Hydroxymethylglutaryl-CoA reductase (NADPH) +FIG01642336 Sterol desaturase-like protein +FIG01642357 Archaeal/vacuolar-type H+-ATPase subunit A +FIG01642366 FIG00712738: hypothetical protein +FIG01642380 FIG01198930: hypothetical protein +FIG01642398 putative branched-chain amino acid transport ATP-binding protein +FIG01642468 probable BatD +FIG01642495 membrane protein DedA family +FIG01642512 FIG00633863: hypothetical protein +FIG01642560 Histidine-rich glycoprotein precursor +FIG01642565 Putative membrane protein MmpL12 +FIG01642573 FIG00946196: hypothetical protein +FIG01642602 FIG00448179: hypothetical protein +FIG01642612 IS298, transposase OrfA +FIG01642622 FIG00622881: hypothetical protein +FIG01642666 DNA for ribosomal protein S14, OppC-like protein, complete cds +FIG01642699 FIG00910497: hypothetical protein +FIG01642716 Strictosidine synthase family protein +FIG01642720 FIG01115881: hypothetical protein +FIG01642776 Aldehyde dehydrogenase family protein +FIG01642785 Thiamine biosynthesis protein ThiS +FIG01642841 FIG00253067: hypothetical protein +FIG01642857 TraA-like protein +FIG01642870 FIG00388057: hypothetical protein +FIG01642975 Membrane protein, related to Actinobacillus protein (1944168) +FIG01642990 FIG00623023: hypothetical protein +FIG01642995 BILE ACID BETA-GLUCOSIDASE +FIG01642999 FIG01049278: hypothetical protein +FIG01643006 multicopper oxidase type 2 +FIG01643015 pseudogene (IS1655 transposase) NMA0236 +FIG01643040 RNA polymerase sigma factor SigX +FIG01643053 Type II secretion pathway protein XcpZ +FIG01643058 hypothetical protein +FIG01643076 FIG00347759: hypothetical protein +FIG01643104 putative integral membrane sensor protein +FIG01643131 Acyl-coenzyme A:6-aminopenicillanic-acid-acyltransferase precursor (EC 2.3.1.-) +FIG01643147 OutS lipoprotein precursor +FIG01643150 regulatory protein LacI +FIG01643154 putative cytochrome C-like protein +FIG01643188 FIG00791576: hypothetical protein +FIG01643205 spore coat peptide assembly protein CotJC +FIG01643234 putative GAF sensor protein +FIG01643281 PROBABLE CONSERVED TRANSMEMBRANE PROTEIN +FIG01643330 FIG00742480: hypothetical protein +FIG01643350 5-nitroimidazole antibiotic resistance protein +FIG01643381 Pentapeptide repeat protein; possible oxetanocin A resistance protein +FIG01643392 regulator of chromosome condensation RCC1 +FIG01643561 FIG00848814: hypothetical protein +FIG01643573 histone family protein DNA-binding protein +FIG01643609 polysialic acid transport ATP-binding protein; KpsT +FIG01643620 FIG00388879: hypothetical protein +FIG01643674 Hypothetical protein, CF-1 family +FIG01643681 Primosomal replication protein C +FIG01643708 FIG00697513: hypothetical protein +FIG01643715 FIG00850597: hypothetical protein +FIG01643800 peptidodoglycan-binding membrane protein +FIG01643839 FIG00793260: hypothetical protein +FIG01643848 Phosphatidylserine/phosphatidylglycerophosphate/ cardiolipin synthases and related enzymes-like +FIG01643854 FIG00767396: hypothetical protein +FIG01643885 ASPIC/UnbV domain-containing protein +FIG01643887 FIG00629033: hypothetical protein +FIG01643923 FIG00379878: hypothetical protein +FIG01643926 FIG01233232: hypothetical protein +FIG01643931 FIG00425782: hypothetical protein +FIG01643962 MJ0042 family finger-like domain/tetratricopeptide repeat protein +FIG01643966 NAD-dependent epimerase/dehydratase( EC:5.1.3.12 ) +FIG01643980 integrase (partial) +FIG01643985 Predicted pyridoxine biosynthesis protein (probably from glycolaldehide) +FIG01644003 Bll0406 protein +FIG01644037 hypothetical protein +FIG01644049 FIG00848660: hypothetical protein +FIG01644080 Protein of unknown function DUF309 +FIG01644088 putative molybdopterin cofactor synthesis protein moaD +FIG01644160 247aa long hypothetical protein +FIG01644161 FIG00406186: hypothetical protein +FIG01644251 FIG00380348: hypothetical protein +FIG01644266 ferrous ion transport protein A +FIG01644269 Putative auxin-binding protein +FIG01644280 Feruloyl esterase B precursor (EC 3.1.1.73) +FIG01644297 probable acrA1 protein +FIG01644311 ABC transporter ATP-binding protein +FIG01644317 Uncharacterized protein MJ1355 +FIG01644329 FIG00407265: hypothetical protein +FIG01644364 hypothetical protein, (pXO1-65) +FIG01644394 phasin family protein +FIG01644400 FIG00745763: hypothetical protein +FIG01644416 protein phosphatase 1, regulatory subunit 10 +FIG01644427 hypothetical protein +FIG01644439 Intein-containing protein +FIG01644512 Putative hemolysin secretion ATP-binding protein +FIG01644514 FIG01116650: hypothetical protein +FIG01644557 conserved hypothetical phage-related protein +FIG01644571 Acyl-[acyl-carrier protein] desaturase DesA2 (EC 1.14.19.2) +FIG01644579 FIG00746206: hypothetical protein +FIG01644583 FIG00403029: hypothetical protein +FIG01644591 Stage II sporulation protein AA +FIG01644604 FIG00749872: hypothetical protein +FIG01644628 Heparosan synthase A +FIG01644634 Bll5582 protein +FIG01644688 FIG01282554: hypothetical protein +FIG01644789 FIG00769973: hypothetical protein +FIG01644805 FIG00963798: hypothetical protein +FIG01644806 Sucraseferredoxin family protein +FIG01644844 FIG00829247: hypothetical protein +FIG01644860 FIG00519656: hypothetical protein +FIG01644909 Portal protein +FIG01644937 FIG00519892: hypothetical protein +FIG01644940 conserved hypothetical protein; putative kinase +FIG01644985 mannosyltransferase OCH1-related enzyme +FIG01644999 FIG00560029: hypothetical protein +FIG01645013 lysin rich protein +FIG01645027 possible ATP-dependent RNA helicase +FIG01645030 FIG01233048: hypothetical protein +FIG01645035 FIG01201678: hypothetical protein +FIG01645104 FIG00520465: hypothetical protein +FIG01645127 Putative type IIS restriction /modification enzyme, C-terminal half +FIG01645132 FIG00763513: hypothetical protein +FIG01645136 PUTATIVE THIOREDOXIN-LIKE PROTEIN +FIG01645152 FIG01056252: hypothetical protein +FIG01645176 FIG00388243: hypothetical protein +FIG01645187 blr3473; probable sulfate transporter +FIG01645193 syc1084_c +FIG01645205 FIG00829024: hypothetical protein +FIG01645236 FIG01126987: hypothetical protein +FIG01645262 Possible stage V sporulation protein T, transcriptional regulator AbrB homolog +FIG01645277 Two-component sensor histidine kinase precursor +FIG01645280 putative extracellular sugar-binding protein +FIG01645293 FIG00517577: hypothetical protein +FIG01645300 FIG01116704: hypothetical protein +FIG01645314 PTS system fructose IIA component superfamily +FIG01645319 Uncharacterized protein yurS +FIG01645375 Uncharacterized protein MJ1471 +FIG01645424 FIG00892225: hypothetical protein +FIG01645427 hypothetical protein +FIG01645440 FIG00623405: hypothetical protein +FIG01645447 FIG00624815: hypothetical protein +FIG01645475 hypothetical protein +FIG01645521 ORF_ID:alr7531 unknown protein +FIG01645523 trimethylamine methyltransferase MttB-like protein +FIG01645559 FIG01212877: hypothetical protein +FIG01645568 FIG00848747: hypothetical protein +FIG01645569 FIG00963364: hypothetical protein +FIG01645602 diacylglycerol kinase-related protein +FIG01645611 putative multidrug resistance pump +FIG01645625 FIG00355745: hypothetical protein +FIG01645690 FIG00406697: hypothetical protein +FIG01645706 FIG00426782: hypothetical protein +FIG01645786 Bactoprenol glucosyl transferase GtrB (EC 2.4.1.-) +FIG01645803 FIG00688162: hypothetical protein +FIG01645827 FIG00624241: hypothetical protein +FIG01645833 Excl1 protein +FIG01645864 FIG00639687: hypothetical protein +FIG01645872 Transcription regulator protein, DeoR family +FIG01645876 Uncharacterized protein Mb1573 +FIG01645882 FIG00873511: hypothetical protein +FIG01645913 protein of unknown function DUF876 +FIG01645928 YafQ toxin protein +FIG01645951 universal stress protein family protein +FIG01645960 NMT1/THI5 like domain protein +FIG01645961 Type IV pilus biogenesis protein PilQ / Competence protein PilQ +FIG01645976 FIG00666701: hypothetical protein +FIG01645982 NADH dehydrogenase-like protein +FIG01646015 Penicillin G acylase precursor (EC 3.5.1.11) +FIG01646040 peroxiredoxin +FIG01646052 F36H12.3 +FIG01646066 UPF0189 protein SSO2899 +FIG01646068 P2 phage tail completion R +FIG01646090 FIG00405659: hypothetical protein +FIG01646108 FIG01022335: hypothetical protein +FIG01646109 Agrobacteirum virulence homologue virD4 +FIG01646145 hypothetical protein +FIG01646169 FIG01117651: hypothetical protein +FIG01646271 probable transcriptional regulator, CopG family +FIG01646274 Tetracycline efflux pump TetA(P) +FIG01646291 regulatory protein, AsnC/Lrp +FIG01646312 riboflavin synthase subunit alpha( EC:2.5.1.9 ) +FIG01646352 ABC transporter, substrate binding protein [sugar] +FIG01646391 narrowly conserved protein with unknown function +FIG01646393 Rhodanese-like +FIG01646419 FIG00409332: hypothetical protein +FIG01646425 FIG01118067: hypothetical protein +FIG01646433 FIG00363480: hypothetical protein +FIG01646486 Adrenodoxin reductase +FIG01646505 FIG00687892: hypothetical protein +FIG01646582 Tgh102 +FIG01646588 FIG00734345: hypothetical protein +FIG01646590 FIG01231828: hypothetical protein +FIG01646625 FIG00827769: hypothetical protein +FIG01646650 Phosphoesterase PHP, N-terminal precursor +FIG01646700 hypothetical protein +FIG01646713 FIG00343998: hypothetical protein +FIG01646730 FIG00412263: hypothetical protein +FIG01646731 probable Na+/H+ antiporter, CPA1 family +FIG01646740 FIG00848684: hypothetical protein +FIG01646781 Possible tail length tape measure protein +FIG01646912 FIG01253900: hypothetical protein +FIG01646936 ferrichrome-iron receptor +FIG01646939 nucleic acid-binding protein contains PIN domain-like protein +FIG01646963 outer membrane autotransporter barrel +FIG01646976 CPG DNA methylase (EC 2.1.1.37) +FIG01646985 Kf-pending protein +FIG01646990 hypothetical protein +FIG01646994 Conjugal transfer protein TraA +FIG01647018 C-5 sterol desaturase( EC:1.3.- ) +FIG01647060 probable S-adenosylmethionine-dependent methyltransferase +FIG01647068 FIG00623519: hypothetical protein +FIG01647096 Regulatory protein, LysR-family +FIG01647123 putative ArsR-family transcriptional regulator +FIG01647129 Prepilin-type cleavage/methylation-like +FIG01647189 hypothetical protein; putative acetyltransferase, GNAT family +FIG01647201 lipase( EC:3.1.1.- ) +FIG01647212 FIG00343840: hypothetical protein +FIG01647218 FIG00413460: hypothetical protein +FIG01647236 FIG00388614: hypothetical protein +FIG01647249 outer membrane porin protein OmpQ +FIG01647254 putative O-acyltransferase +FIG01647274 FIG01077095: hypothetical protein +FIG01647277 FIG00384987: hypothetical protein +FIG01647323 FIG00407668: hypothetical protein +FIG01647397 hypothetical protein +FIG01647398 Homologous to secreted protein sopD +FIG01647459 NAD/NADP transhydrogenase beta subunit +FIG01647478 pleD gene product +FIG01647504 putative crcB-like protein +FIG01647510 N-acetylmuramoyl-L-alanine amidase blyA (EC 3.5.1.28) +FIG01647543 FIG00387989: hypothetical protein +FIG01647567 Probable aggregation factor core protein MAFp3, isoform C +FIG01647609 probable sugar transferase +FIG01647636 FIG00269499: hypothetical protein +FIG01647640 molecular chaperones (DnaJ family) +FIG01647643 FIG00947519: hypothetical protein +FIG01647653 FIG00815480: hypothetical protein +FIG01647690 cytidine/deoxycytidylate deaminase domain protein +FIG01647693 putative tyrosine recombinase XerC +FIG01647717 FIG00968041: hypothetical protein +FIG01647728 FIG00525980: hypothetical protein +FIG01647737 DifB protein +FIG01647740 FIG00632598: hypothetical protein +FIG01647745 chondroitinase AC precursor +FIG01647767 FIG00349159: hypothetical protein +FIG01647769 voltage-gated sodium channel +FIG01647799 FIG00712933: hypothetical protein +FIG01647820 Putative aldose 1-epimerase +FIG01647827 putative MarR-family transcriptional regulatory protein +FIG01647834 FIG00344962: hypothetical protein +FIG01647839 FIG00688488: hypothetical protein +FIG01647841 FIG00414200: hypothetical protein +FIG01647862 All0937 protein +FIG01647873 FIG01233420: hypothetical protein +FIG01647894 OrfG1 +FIG01647905 probable polyvinylalcohol dehydrogenase +FIG01647927 putative HlyD-like secretion protein +FIG01647936 FIG01165711: hypothetical protein +FIG01647952 Function Code:14.00 - Unknown +FIG01647965 FIG00623427: hypothetical protein +FIG01648014 NADPH-cytochrome P450 reductase +FIG01648032 FIG00763771: hypothetical protein +FIG01648076 FIG00733682: hypothetical protein +FIG01648106 blr7934; hypothetical protein +FIG01648113 probable fimbrial assembly protein PilM +FIG01648129 FIG00361413: hypothetical protein +FIG01648146 cytosine methyltransferase +FIG01648158 FIG01166536: hypothetical protein +FIG01648163 FIG00361718: hypothetical protein +FIG01648191 hypothetical protein +FIG01648203 FIG00629525: hypothetical protein +FIG01648230 FIG00412116: hypothetical protein +FIG01648235 type I restriction-modification system, S subunit, putative +FIG01648253 Periplasmic Sensor Hybrid Histidine Kinase +FIG01648319 FIG00353179: hypothetical protein +FIG01648325 Protein of unknown function DUF883, ElaB +FIG01648340 FIG00624555: hypothetical protein +FIG01648342 haloalkane dehalogenase +FIG01648404 Altronate dehydratase (EC 4.2.1.7) +FIG01648411 FIG00623347: hypothetical protein +FIG01648457 Ciliary adhesin protein P97 +FIG01648464 FIG00734042: hypothetical protein +FIG01648494 Endoglucanase Z precursor (EC 3.2.1.4) (Endo-1,4-beta-glucanase) (Thermoactive cellulase) (Avicelase I) +FIG01648511 glycosyl transferase CpsG(V) +FIG01648560 GumB +FIG01648594 syc1349_d +FIG01648597 FIG00816890: hypothetical protein +FIG01648609 FIG00564833: hypothetical protein +FIG01648662 FIG00830027: hypothetical protein +FIG01648712 FIG00348417: hypothetical protein +FIG01648736 Unsaturated glucuronyl hydrolase +FIG01648748 probable cell division protein FtsH( EC:3.4.24.- ) +FIG01648769 FIG00353317: hypothetical protein +FIG01648770 TetR family transcriptional regulatory protein +FIG01648773 FIG00734061: hypothetical protein +FIG01648775 Replicative DNA helicase-like protein +FIG01648789 FIG00409776: hypothetical protein +FIG01648796 conserved hypothetical acetyltransferase +FIG01648809 FIG01048836: hypothetical protein +FIG01648817 FIG00356141: hypothetical protein +FIG01648840 Plant-inducible protein PinF2, cytochrome P450-like, contributes to virulence +FIG01648859 RNP-1 like RNA-binding protein +FIG01648924 seryl-tRNA synthetase( EC:6.1.1.11 ) +FIG01648932 FIG01234550: hypothetical protein +FIG01648940 Two-component sensor +FIG01648949 Sll1737 protein +FIG01648962 FIG00624118: hypothetical protein +FIG01648966 FIG01048890: hypothetical protein +FIG01648991 Error-prone repair protein UmuC +FIG01648993 Twin-arginine translocation protein TatA/E +FIG01649011 FIG01118818: hypothetical protein +FIG01649022 FIG00348182: hypothetical protein +FIG01649046 ORF_ID:all7673 unknown protein +FIG01649059 conserced hypothetical protein +FIG01649079 Protein of unknown function DUF1021 +FIG01649097 COG3022: Uncharacterized protein conserved in bacteria +FIG01649099 FIG00581833: hypothetical protein +FIG01649121 UPF0178 protein Daro_2879 +FIG01649132 major capsid protein gpP +FIG01649137 carbon-nitrogen hydrolase +FIG01649162 Bacteriophage capsid protein +FIG01649176 Uncharacterized protein MJ1535 +FIG01649241 hypothetical protein +FIG01649254 FIG00409457: hypothetical protein +FIG01649305 putative FecR protein +FIG01649335 putative VirD2, a T-DNA border endonuclease +FIG01649365 FIG00652136: hypothetical protein +FIG01649368 TfoX, C-terminal +FIG01649385 FIG00385504: hypothetical protein +FIG01649409 FIG00503188: hypothetical protein +FIG01649464 Predicted D-mannonate epimerase +FIG01649473 Pli0005 protein +FIG01649519 Streptococcal extracellular nuclease 2 +FIG01649525 Ycf21 protein +FIG01649586 putative DNA primerase +FIG01649604 All1239 protein +FIG01649609 hypothetical protein +FIG01649619 FIG00632203: hypothetical protein +FIG01649621 Transcriptional accessory protein +FIG01649676 possible transposase B +FIG01649684 periplasmic protein-like protein +FIG01649695 DNA repair photolyase +FIG01649734 outer membrane adhesin like proteiin +FIG01649746 putative pyridoxamine 5 '-phosphate-related protein +FIG01649760 FIG00752975: hypothetical protein +FIG01649761 Morrisoni EG2158 transposon Tn5401 site-specific recombinase (tnpI) and transposase (tpnA) genes +FIG01649786 FIG01235456: hypothetical protein +FIG01649804 Transposase +FIG01649810 FIG00353097: hypothetical protein +FIG01649817 FIG01170683: hypothetical protein +FIG01649836 Putative iron compound ABC transporter, ATP-binding protein +FIG01649851 (2R)-phospho-3-sulfolactate synthase, comA family +FIG01649855 O-methyltransferase involved in polyketide biosynthesis +FIG01649878 cytotoxic translational repressor +FIG01649897 ATPase, BadF/BadG/BcrA/BcrD type +FIG01649907 FIG00470422: hypothetical protein +FIG01649941 Thiol methyltransferase 1 +FIG01649974 FIG01231485: hypothetical protein +FIG01649992 heat shock protein DnaJ domain protein +FIG01649998 A-factor receptor, putative +FIG01650012 Sphingomyelinase C precursor +FIG01650077 RCC1 repeat domain protein +FIG01650104 FIG00961816: hypothetical protein +FIG01650109 P450 heme-thiolate protein +FIG01650212 FIG00385113: hypothetical protein +FIG01650218 FIG00677516: hypothetical protein +FIG01650243 glycosyl transferase, group 2 family +FIG01650255 Response regulator (CheY-like receiver domain and HTH DNA-binding domain) +FIG01650262 hypothetical protein +FIG01650274 Bacterial Ig-like domain protein +FIG01650296 FIG00390582: hypothetical protein +FIG01650383 hypothetical exported protein +FIG01650395 type I restriction-modification system, S subunit +FIG01650401 FIG01231929: hypothetical protein +FIG01650429 POSSIBLE METHYLTRANSFERASE/METHYLASE +FIG01650446 hypothetical protein( EC:2.4.1.- ) +FIG01650450 spore coat protein (inner) +FIG01650512 FIG00810074: hypothetical protein +FIG01650515 probable aminoglycoside N(6prime)-acetyltransferase( EC:2.3.1.82 ) +FIG01650584 YvaZ +FIG01650617 Related to F420H2-dehydrogenase, beta subunit +FIG01650631 ABC transporter, ATP-binding protein, HlyB family +FIG01650640 L-ornithine N5-oxygenase +FIG01650667 FIG00364422: hypothetical protein +FIG01650669 putative IS605 family transposase +FIG01650672 hypothetical protein +FIG01650699 FIG00623659: hypothetical protein +FIG01650725 FIG00410152: hypothetical protein +FIG01650764 FIG00624781: hypothetical protein +FIG01650778 domain of unknown function DUF1745 +FIG01650784 protein of short-chain alcohol dehydrogenase family +FIG01650862 FIG01244143: hypothetical protein +FIG01650868 FIG00817635: hypothetical protein +FIG01650869 peptidylarginine deiminase +FIG01650917 UDP-hexose transferase +FIG01650941 VlmA +FIG01650942 FIG00517671: hypothetical protein +FIG01650945 FIG01068803: hypothetical protein +FIG01650961 Predicted glucose transporter in maltodextrin utilization gene cluster +FIG01651011 FIG01133666: hypothetical protein +FIG01651015 FIG00388565: hypothetical protein +FIG01651024 FIG01077186: hypothetical protein +FIG01651057 Phosphatase kdsC +FIG01651067 putative flagellar protein +FIG01651080 FIG00768085: hypothetical protein +FIG01651082 Histidine protein kinase AsgD +FIG01651091 major facilitator superfamily protein +FIG01651115 site-specific recombinase, phage integrase family protein +FIG01651117 FIG00952617: hypothetical protein +FIG01651129 Possible general stress protein 26 +FIG01651150 FIG00528349: hypothetical protein +FIG01651181 FIG00351736: hypothetical protein +FIG01651240 FIG00487266: hypothetical protein +FIG01651244 FIG00402922: hypothetical protein +FIG01651246 possible penicillin-binding protein +FIG01651258 DNA Pol III Epsilon Chain +FIG01651298 transcriptional activator protein +FIG01651391 FtsK/SpoIIIE family protein, putative EssC component of Type VII secretion system +FIG01651411 FIG00896833: hypothetical protein +FIG01651457 probable large multifunctional protein-putative glycosyl hydrolase +FIG01651458 FIG00347596: hypothetical protein +FIG01651468 ortholog of Bordetella pertussis (BX470248) BP1189 +FIG01651471 Predicted mannose-6-phosphate isomerase +FIG01651512 FIG00729507: hypothetical protein +FIG01651547 Uncharacterized protein MJ1480 +FIG01651553 FIG00385254: hypothetical protein +FIG01651607 ORF5 +FIG01651639 FIG00408671: hypothetical protein +FIG01651654 Membrane GTPase LepA +FIG01651700 PTPS-VI +FIG01651713 FIG00522082: hypothetical protein +FIG01651723 protein of unknown function DUF362 +FIG01651742 possible HAMP domain +FIG01651747 FIG00520132: hypothetical protein +FIG01651823 putative RNA methyltransferase( EC:2.1.1.- ) +FIG01651827 ORF035 +FIG01651896 FIG00689409: hypothetical protein +FIG01651906 Possible D-alanyl carrier protein, acyl carrier protein family +FIG01651921 3-ketosteroid 1-dehydrogenase +FIG01651922 carboxylesterase/phospholipase family protein +FIG01651934 FIG00763105: hypothetical protein +FIG01651974 FIG01053024: hypothetical protein +FIG01651976 best DB hits: PFAM: PF01909; Nucleotidyltransferase domain; E=0.00053 +FIG01652085 Myxococcales GC_trans_RRR domain protein +FIG01652131 Uracil phosphoribosyltransferase (EC 2.4.2.9) / Pyrimidine operon regulatory protein PyrR +FIG01652133 SNARE associated Golgi protein +FIG01652136 HigA protein (antitoxin to HigB) +FIG01652140 Copper/Zinc superoxide dismutase +FIG01652185 Bll0177 protein +FIG01652191 FIG00486859: hypothetical protein +FIG01652209 FIG01086896: hypothetical protein +FIG01652218 aquaporin Z +FIG01652259 putative bacteriophage lysozyme +FIG01652273 FIG00388698: hypothetical protein +FIG01652281 FIG01186987: hypothetical protein +FIG01652290 Deoxycytidylate deaminase +FIG01652301 FIG00531673: hypothetical protein +FIG01652319 putative transcriptional regulator, TetR-family +FIG01652349 FIG00517316: hypothetical protein +FIG01652351 FIG00769897: hypothetical protein +FIG01652499 FIG00468846: hypothetical protein +FIG01652500 probable methylamine utilization protein mauD +FIG01652587 FIG01022511: hypothetical protein +FIG01652591 AatA outermembrane protein +FIG01652600 Asr0516 protein +FIG01652691 bacteriophage integrase family protein +FIG01652703 FIG00524021: hypothetical protein +FIG01652763 FIG00754244: hypothetical protein +FIG01652764 FIG00814131: hypothetical protein +FIG01652771 FIG00388027: hypothetical protein +FIG01652800 iron dependent repressor +FIG01652816 FIG01120389: hypothetical protein +FIG01652824 phosphodiesterase, MJ0936 family subfamily( EC:3.1.- ) +FIG01652853 FIG00623258: hypothetical protein +FIG01652880 FIG00388596: hypothetical protein +FIG01652893 FIG00688222: hypothetical protein +FIG01652900 FIG00631228: hypothetical protein +FIG01652927 sugar ABC transporter (permease) +FIG01652932 Uncharacterized protein Rv1526c/MT1577 +FIG01652938 FIG00519794: hypothetical protein +FIG01652961 ferripyochelin binding protein +FIG01652962 FIG01118108: hypothetical protein +FIG01652970 FIG00390550: hypothetical protein +FIG01652977 FIG00545850: hypothetical protein +FIG01652990 Predicted integrase of XerC/XerD family, diverged +FIG01653032 PE-PGRS FAMILY PROTEIN +FIG01653043 putative methyltransferase SAM dependent +FIG01653089 orf; Unknown function +FIG01653112 flotillin-like protein +FIG01653137 Type IV pilus biogenesis protein PilO +FIG01653138 Trehalose-6-phosphate synthase +FIG01653141 FIG00527728: hypothetical protein +FIG01653143 FIG00353131: hypothetical protein +FIG01653149 ABC transporter ATP-binding protein yliA +FIG01653193 FIG00362435: hypothetical protein +FIG01653243 Predicted protein family PM-21 +FIG01653244 3'-nucleotidase/nuclease +FIG01653254 amidohydrolase family protein( EC:4.1.1.- ) +FIG01653284 COG3176: Putative hemolysin +FIG01653309 pseudouridylate synthase +FIG01653315 amino acid permease, putative +FIG01653326 DNA-directed RNA polymerase sigma subunit (RpoE,sigma24)( EC:2.7.7.6 ) +FIG01653346 FIG01117400: hypothetical protein +FIG01653433 FIG00521137: hypothetical protein +FIG01653443 FIG00821345: hypothetical protein +FIG01653448 FIG00622850: hypothetical protein +FIG01653451 FIG00355777: hypothetical protein +FIG01653458 Beta-glucosidase +FIG01653462 Phosphatidylserine decarboxylase +FIG01653470 putative L-arabinose ABC transporter, substrate binding protein +FIG01653476 FIG00471503: hypothetical protein +FIG01653523 syc1903_d +FIG01653531 COG2141: Coenzyme F420-dependent N5,N10-methylene tetrahydromethanopterin reductase and related flavin-dependent oxidoreductases +FIG01653533 hypothetical protein +FIG01653601 methyltransferase FkbM +FIG01653614 dTDP-4-dehydrorhamnose reductase( EC:1.1.1.133 ) +FIG01653642 5-NITROIMIDAZOLE ANTIBIOTIC RESISTANCE PROTEIN +FIG01653658 related to acetoin utilization protein (AcuB) +FIG01653668 Carboxyethylarginine synthase +FIG01653672 phage transcriptional regulator, ArpU family +FIG01653702 FIG00675678: hypothetical protein +FIG01653713 hypothetical protein; Some similarities with methyltransferase and with fatty acid synthase +FIG01653721 FIG00349188: hypothetical protein +FIG01653749 FIG00955356: hypothetical protein +FIG01653814 Uncharacterized protein ynzH +FIG01653832 FIG00364083: hypothetical protein +FIG01653885 FIG00405310: hypothetical protein +FIG01653946 putative DNA modification methylase +FIG01653972 ferritin A +FIG01653986 FIG00413378: hypothetical protein +FIG01654054 FIG00744637: hypothetical protein +FIG01654078 FIG00403110: hypothetical protein +FIG01654134 Monooxygenase, DszA family +FIG01654136 probable permease +FIG01654150 FIG01203495: hypothetical protein +FIG01654165 FIG00356378: hypothetical protein +FIG01654171 probable metal-dependent regulatory protein +FIG01654180 HigA protein (antitoxin to HigB) +FIG01654208 FIG00623389: hypothetical protein +FIG01654235 putative segregation and condensation protein B +FIG01654241 fragment of Orfc273-4 from Vibrio metschnikovii +FIG01654276 Site-specific recombinase, DNA invertase Pin homolog +FIG01654280 FIG00416394: hypothetical protein +FIG01654295 magnesium and cobalt transport protein CorA, putative +FIG01654302 HTH-type transcriptional regulator xre +FIG01654361 FIG00533268: hypothetical protein +FIG01654387 Int +FIG01654389 FIG01152794: hypothetical protein +FIG01654411 FIG00733447: hypothetical protein +FIG01654424 heat shock protein DnaJ-like +FIG01654472 FIG00389470: hypothetical protein +FIG01654473 Multicopper oxidase, type 2 +FIG01654513 iduronate 2-sulfatase precursor +FIG01654515 plasmid stabilization system protein +FIG01654541 FIG01095610: hypothetical protein +FIG01654542 FIG00716889: hypothetical protein +FIG01654595 dead/deah box helicase domain protein, putative +FIG01654597 Protease transmembrane heat shock protein HtpX +FIG01654611 Putative regulator of cell autolysis +FIG01654613 Twin-arginine translocation pathway signal( EC:3.1.1.45 ) +FIG01654639 Tricorn protease homolog 1 (EC 3.4.21.-) +FIG01654650 FIG214331: conserved cobalamin operon protein +FIG01654695 FIG00521987: hypothetical protein +FIG01654699 Flavodoxin-like protein +FIG01654701 FIG00409859: hypothetical protein +FIG01654724 PfkB +FIG01654804 ENOYL-[ACYL-CARRIER-PROTEIN] REDUCTASE (fabL) (NADPH) (EC 1.3.1.9) +FIG01654814 Predicted hydrolase (HD superfamily) +FIG01654838 peptidase, M16 family protein +FIG01654865 protein of unknown function DUF47 +FIG01654894 putative YceI-like family protein +FIG01654946 COG1063: Threonine dehydrogenase and related Zn-dependent dehydrogenases +FIG01654949 FIG00361696: hypothetical protein +FIG01654966 invertase/recombinase like protein +FIG01654979 FIG00752748: hypothetical protein +FIG01655027 Conjugative transposon protein TraG +FIG01655045 FIG00762996: hypothetical protein +FIG01655047 FIG00751852: hypothetical protein +FIG01655049 FIG00349083: hypothetical protein +FIG01655135 Haloacid dehalogenase domain protein hydrolase +FIG01655198 FIG00344344: hypothetical protein +FIG01655214 FIG00425664: hypothetical protein +FIG01655238 Possible glycosyl transferase +FIG01655249 FIG00622815: hypothetical protein +FIG01655287 Gll3595 protein +FIG01655337 Transposon Tn1546 resolvase +FIG01655339 UPF0354 protein BH3252 +FIG01655344 Non-heme chloroperoxidase (EC 1.11.1.10) +FIG01655345 putative methyltransferase, S-Adenosyl-L-methionine (SAM)-MTase protein +FIG01655353 FIG00353189: hypothetical protein +FIG01655393 FIG00481487: hypothetical protein +FIG01655414 Anion-binding protein +FIG01655451 Alpha/beta hydrolase fold-1 +FIG01655470 FIG00389096: hypothetical protein +FIG01655533 FIG00380671: hypothetical protein +FIG01655541 amine oxidase-like protein family member (3F906) +FIG01655552 FIG00407890: hypothetical protein +FIG01655562 FIG00624392: hypothetical protein +FIG01655568 Putative Transposase +FIG01655590 FIG00623109: hypothetical protein +FIG01655595 putative LmbE-like protein +FIG01655603 Arsenical pump membrane protein +FIG01655622 FIG00833377: hypothetical protein +FIG01655637 putative ABC-2 type transport system permease protein +FIG01655639 ankyrin domain protein +FIG01655641 FIG01048170: hypothetical protein +FIG01655687 Serine-protein kinase RsbW (EC 2.7.11.1) / Anti-sigma regulatory factor (Ser/Thr protein kinase), essential for photomixotrophic growth, PmgA +FIG01655710 FIG00534204: hypothetical protein +FIG01655724 FIG00533603: hypothetical protein +FIG01655742 similarity to lipopolysaccharide 1,2-glucosyltransferase (rfaJ) +FIG01655749 cold shock domain protein +FIG01655762 Steroid delta-isomerase domain protein +FIG01655768 FIG00556793: hypothetical protein +FIG01655796 FIG00818541: hypothetical protein +FIG01655804 Integrins alpha chain precursor +FIG01655872 FIG01107848: hypothetical protein +FIG01655891 FIG00624472: hypothetical protein +FIG01655905 FIG00344606: hypothetical protein +FIG01655940 putative copper resistance protein +FIG01655996 FIG00353401: hypothetical protein +FIG01655998 FIG01166125: hypothetical protein +FIG01656002 FIG00633791: hypothetical protein +FIG01656005 acetate-CoA ligase, truncation +FIG01656015 FIG00344867: hypothetical protein +FIG01656040 phycobilisome degradation protein; NblA +FIG01656050 putative DNA-binding protein (Roi) +FIG01656210 FIG00666438: hypothetical protein +FIG01656221 FIG00525708: hypothetical protein +FIG01656243 possible aromatic ring hydroxylase +FIG01656254 putative azaleucine resistance protein AzlC +FIG01656277 putative secretion protein +FIG01656299 integration host factor beta-subunit +FIG01656332 FIG00623990: hypothetical protein +FIG01656381 FIG00788550: hypothetical protein +FIG01656554 Putative metal-dependent hydrolase BLi00869/BLi00870/BL03027 (EC 3.-.-.-) +FIG01656564 ATP-binding protein of ribose ABC transporter +FIG01656591 FIG00772978: hypothetical protein +FIG01656606 hypothetical protein +FIG01656609 200 kDa antigen p200, putative +FIG01656620 FIG00622951: hypothetical protein +FIG01656642 FIG00388579: hypothetical protein +FIG01656719 transcription regulatory protein YtlI +FIG01656739 cytochrome c oxidase subunit I +FIG01656770 Modification methylase BepI (EC 2.1.1.37) +FIG01656782 FIG01049799: hypothetical protein +FIG01656831 hypothetical protein +FIG01656857 transcriptional regulator marR family +FIG01656894 Peptidase, membrane zinc metallopeptidase, putative +FIG01656920 Beta-glucanase precursor (EC 3.2.1.73) (Endo-beta-1,3-1,4 glucanase) (1,3-1,4-beta-D-glucan 4-glucanohydrolase) (Lichenase) +FIG01656978 probable phosphatase of HAD hydrolase superfamily +FIG01656983 quinolene resistance protein; NorA +FIG01656986 hypothetical protein +FIG01657000 FIG00362240: hypothetical protein +FIG01657020 heat shock protein, putative +FIG01657024 FIG00641242: hypothetical protein +FIG01657027 FIG01036708: hypothetical protein +FIG01657033 Transposase for insertion sequence element IS4351 (Transposon TN4551) +FIG01657055 type II restriction endonuclease TdeIII +FIG01657064 FIG00351245: hypothetical protein +FIG01657067 InterPro IPR000408 +FIG01657087 Outer membrane protein p28 +FIG01657130 RNA polymerase ECF-type sigma factor +FIG01657131 DEAD-box helicase-related protein +FIG01657133 FIG01020712: hypothetical protein +FIG01657134 organization of plasma membrane +FIG01657166 FIG00425949: hypothetical protein +FIG01657176 putative thiamin S protein +FIG01657222 extracellular ligand-binding receptor +FIG01657225 HYDROLASE-RELATED PROTEIN +FIG01657227 Possible conserved integral membrane protein +FIG01657235 Uncharacterized protein MJECL43 +FIG01657243 Predicted alpha/beta superfamily hydrolase +FIG01657278 putative RepA protein +FIG01657397 Sugar ABC transporter permease protein +FIG01657453 ThiJ/PfpI family (EC 3.4.-.-) +FIG01657481 Putative ribose phosphate pyrophosphokinase +FIG01657490 hypothetical protein +FIG01657542 FIG00351612: hypothetical protein +FIG01657547 Alpha-1,3-mannosyltransferase ALG2 (EC 2.4.1.-) +FIG01657624 FIG00403363: hypothetical protein +FIG01657652 MFS transporter, DHA1 family +FIG01657682 FIG00385134: hypothetical protein +FIG01657735 FIG00403991: hypothetical protein +FIG01657744 glycoside hydrolase family 1 +FIG01657816 hypothetical protein +FIG01657833 FIG01126350: hypothetical protein +FIG01657880 FIG01054761: hypothetical protein +FIG01657918 FIG00512199: hypothetical protein +FIG01657921 FIG00950338: hypothetical protein +FIG01657961 Sugar transport ATP-binding protein +FIG01657972 Transcriptional activator NprR +FIG01657976 NrtR-regulated hypothetical OrfX +FIG01658022 Probable dioxygenase +FIG01658029 conserved hypothetical protein-putative peroxiredoxin +FIG01658031 FIG01032197: hypothetical protein +FIG01658046 ADP-ribosylglycohydrolase, putative +FIG01658068 FIG01140766: hypothetical protein +FIG01658081 peptide ABC transporter ATP binding protein, putative, truncated +FIG01658109 ORF_ID:alr7539 unknown protein +FIG01658157 Asl1664 protein +FIG01658193 molybdopterin binding domain protein +FIG01658196 ORF_ID:tll2333 hypothetical protein +FIG01658205 putative polysaccharide-degrading enzyme +FIG01658207 YBTQ PROTEIN +FIG01658223 FIG00406133: hypothetical protein +FIG01658244 sulfur transferase, putative, selenocysteine-containing +FIG01658320 Protein oar precursor +FIG01658362 integron integrase +FIG01658366 FIG00426132: hypothetical protein +FIG01658395 Possible transglycosylase SLT domain precursor +FIG01658448 2-methylthioadenine synthetase +FIG01658450 FIG00832862: hypothetical protein +FIG01658453 Carboxypeptidase B (EC 3.4.17.2) +FIG01658469 beta-hexosaminidase( EC:3.2.1.52 ) +FIG01658482 FIG01046844: hypothetical protein +FIG01658512 Bona fide RidA/YjgF/TdcF/RutC subgroup +FIG01658514 Integrase, phage associated +FIG01658547 FIG00415761: hypothetical protein +FIG01658571 Putative Transporter, LysE family +FIG01658580 FIG00774492: hypothetical protein +FIG01658586 CRISPR-associated helicase Cas3, Yersinia-type +FIG01658609 FIG00364061: hypothetical protein +FIG01658669 FIG00734295: hypothetical protein +FIG01658678 Possible Transcriptional Regulator, TetR family +FIG01658695 FIG00344456: hypothetical protein +FIG01658715 FIG00765766: hypothetical protein +FIG01658733 FIG00389037: hypothetical protein +FIG01658734 Nitrogen regulatory protein PII +FIG01658788 COG3652: Predicted outer membrane protein +FIG01658795 Taurine-binding periplasmic protein tauA +FIG01658829 nitrate transport protein +FIG01658841 FIG00875144: hypothetical protein +FIG01658854 superantigen precursor +FIG01658862 ISPg4, transposase +FIG01658883 probable membrane efflux protein +FIG01658888 FIG00352340: hypothetical protein +FIG01658896 FIG00518916: hypothetical protein +FIG01658952 serine/threonine-protein kinase +FIG01658959 FIG00674948: hypothetical protein +FIG01658991 FIG00632421: hypothetical protein +FIG01659034 PUTATIVE DNA-INVERTASE PROTEIN +FIG01659060 cold-shock DNA-binding protein +FIG01659063 hypothetical protein +FIG01659081 Cell wall surface anchor family protein, putative +FIG01659102 putative METHYLTRANSFERASE PROTEIN +FIG01659118 FIG00634801: hypothetical protein +FIG01659121 FIG00348539: hypothetical protein +FIG01659128 hypothetical protein +FIG01659152 hypothetical protein; putative signal peptide; putative lectin/glucanase domains +FIG01659165 FIG00643474: hypothetical protein +FIG01659181 Putative membrane anchored protein +FIG01659182 FIG00521699: hypothetical protein +FIG01659186 FIG01240792: hypothetical protein +FIG01659191 Putative anaerobic C4-dicarboxylate transporter +FIG01659198 FIG01018532: hypothetical protein +FIG01659220 Prolyl aminopeptidase( EC:3.4.11.5 ) +FIG01659275 hypothetical protein +FIG01659308 Probable tautomerase yrdN (EC 5.3.2.-) +FIG01659342 Nucleoside permease nupG +FIG01659346 DedA family protein +FIG01659374 XcbB +FIG01659434 Conserved hypothetical protein Tiny_TM_bacill +FIG01659526 pyruvate formate-lyase activating enzyme (act-1) +FIG01659555 FIG00520891: hypothetical protein +FIG01659563 nitrogenase iron protein( EC:1.18.6.1 ) +FIG01659615 Phage transcriptional regulator, Cro/CI family +FIG01659628 FIG00623690: hypothetical protein +FIG01659629 transposase, IS116/IS110/IS902 family +FIG01659652 HISTIDINE KINASE SENSOR PROTEIN +FIG01659654 Putative mitochondrial protein, with 2 coiled coil-4 domains, of bilaterial origin, Nuclear Pore complex Protein NPP-11 (77.2 kD) (npp-11) [Source:;Acc:Cel.17399] +FIG01659689 8-amino-7-oxononanoate synthase( EC:2.3.1.47 ) +FIG01659720 phosphate-binding protein +FIG01659732 FIG00389072: hypothetical protein +FIG01659739 Cell division protein DivIC (FtsB), stabilizes FtsL against RasP cleavage +FIG01659744 FIG00521476: hypothetical protein +FIG01659760 FIG00410370: hypothetical protein +FIG01659762 Hvp45 +FIG01659772 FIG01123579: Glyoxalase/bleomycin resistance protein/dioxygenase +FIG01659782 HecB-like protein +FIG01659795 FIG00817105: hypothetical protein +FIG01659799 FIG00932923: hypothetical protein +FIG01659839 2-hydroxyhepta-2,4-diene-1,7-dioate isomerase (EC 5.3.3.-) +FIG01659888 putative pirin-like protein +FIG01659898 FIG00733726: hypothetical protein +FIG01659916 ISXoo15 transposase +FIG01659945 aminoglycoside N3`-acetyltransferase, type IV +FIG01659970 Glyoxalase/dioxygenase superfamily protein +FIG01660035 Kelch repeat-containing protein +FIG01660038 Polyprenyltransferase (cytochrome oxidase assembly factor) +FIG01660080 recombination protein +FIG01660128 Protease I (EC 3.4.-.-) +FIG01660165 FIG01008728: hypothetical protein +FIG01660175 FIG01120488: hypothetical protein +FIG01660198 FIG00388238: hypothetical protein +FIG01660203 3-oxoacyl-(acyl-carrier-protein) reductase +FIG01660204 Histidine triad (HIT) protein +FIG01660217 UPF0192 protein all5100 precursor +FIG01660266 FIG00768833: hypothetical protein +FIG01660287 FIG00522924: hypothetical protein +FIG01660293 Predicted permease, DMT superfamily +FIG01660340 Transglutaminase-like protein Sll1049 +FIG01660342 response regulator receiver sensor signal transduction histidine kinase +FIG01660349 Acetyl-CoA C-acyltransferase +FIG01660362 Cis,cis-muconate transport protein +FIG01660373 RDD protein +FIG01660381 homoserine dehydrogenase +FIG01660387 FIG00632750: hypothetical protein +FIG01660445 putative DNA-damage-inducible protein +FIG01660450 Putative oligoketide cyclase/lipid transport protein, similarity with yeast ubiquinone-binding protein YOL008W +FIG01660466 tRNA (5-methylaminomethyl-2-thiouridylate)-methyltransferase (EC 2.1.1.61) +FIG01660545 Germination protein +FIG01660583 Transcription initiation factor IID 150 kD subunit +FIG01660654 phosphate regulon transcriptional regulatory protein PhoB +FIG01660732 chloride channel protein +FIG01660755 serine/threonine-protein kinase-related protein +FIG01660778 Accessory gene regulator A (response regulator) +FIG01660814 ORF278 +FIG01660834 FIG00841528: hypothetical protein +FIG01660875 ATP-binding protein of ABC transporter +FIG01660891 FIG01115664: hypothetical protein +FIG01660912 biogenesis of outer membrane +FIG01660919 siroheme synthase-like protein +FIG01660987 amino acid permeases +FIG01661009 prophage ps1 protein 23 +FIG01661011 FIG01204715: hypothetical protein +FIG01661036 FIG00790032: hypothetical protein +FIG01661040 FIG00631832: hypothetical protein +FIG01661048 FIG01083343: hypothetical protein +FIG01661078 FIG01076924: hypothetical protein +FIG01661080 FIG00524744: hypothetical protein +FIG01661104 FIG01049609: hypothetical protein +FIG01661134 UDP-N-acetylglucosamine 1-carboxyvinyltransferase protein +FIG01661136 FIG01251111: hypothetical protein +FIG01661182 FIG00524949: hypothetical protein +FIG01661185 FIG00562481: hypothetical protein +FIG01661200 FIG00763397: hypothetical protein +FIG01661216 Uncharacterized protein MJ1537 +FIG01661222 Heat shock protein 70 +FIG01661317 diguanylate phosphodiesterase (EAL domain) +FIG01661339 FIG00405879: hypothetical protein +FIG01661365 cytidine/deoxycytidylate deaminase/nudix/methyltransferase domains protein +FIG01661382 major outer membrane protein precursor +FIG01661404 MmcM +FIG01661415 outer membrane protein 1E +FIG01661422 FIG00347851: hypothetical protein +FIG01661426 AclQ +FIG01661444 Rhodanese domain protein / Ankyrin +FIG01661447 Tfp pilus assembly protein PilV +FIG01661481 hypothetical protein +FIG01661490 immunity-specific protein Beta371 +FIG01661491 FIG00937492: hypothetical protein +FIG01661492 Transposase +FIG01661547 putative short-chain dehydrogenase/reductase family protein +FIG01661578 ENSANGP00000016745 +FIG01661607 peptidyl-tRNA hydrolase( EC:3.1.1.29 ) +FIG01661625 FIG00673802: hypothetical protein +FIG01661656 probable MucD-putative a secreted serine proteinase +FIG01661660 putative phosphatidylethanolamine N-methyltransferase +FIG01661718 Flagellar protein fliO +FIG01661769 ORF031 +FIG01661795 hypothetical protein +FIG01661830 Gln/Arg/Lys/His-binding protein and permease protein +FIG01661901 glycosyltransferase GtfE +FIG01661912 outer membrane protein expression inhibitor +FIG01661982 toxin-antitoxin systems (TAS) HicB +FIG01661998 Endoglucanase 1 precursor (EC 3.2.1.4) (Endoglucanase I) (Endo-1,4-beta-glucanase) (Cellulase) (EG-I) +FIG01662005 small integral membrane protein +FIG01662182 Cytochrome P450 102 (EC 1.14.14.1) / NADPH--cytochrome P450 reductase (EC 1.6.2.4) +FIG01662223 FIG01202671: hypothetical protein +FIG01662239 FOG: PKD repeat +FIG01662262 FIG00356175: hypothetical protein +FIG01662291 Crotonobetainyl-CoA dehydrogenase (EC 1.3.99.-) +FIG01662327 CylB protein +FIG01662352 FIG00527215: hypothetical protein +FIG01662404 AcrA/AcrE family multidrug resistance protein +FIG01662476 Tn552 transposase +FIG01662542 Amino acid adenylation +FIG01662598 Slr0479 protein +FIG01662608 FIG01043807: hypothetical protein +FIG01662627 FIG00348340: hypothetical protein +FIG01662630 FIG00365040: hypothetical protein +FIG01662660 Modification methylase XamI (EC 2.1.1.72) (Adenine-specific methyltransferase XamI) (M.XamI) +FIG01662724 Putative amidase( EC:3.5.1.4 ) +FIG01662784 CAT RNA binding domain protein +FIG01662790 FIG01202759: hypothetical protein +FIG01662801 GDSL-like lipase/acylhydrolase domain protein +FIG01662808 protein of unknown function DUF1178 +FIG01662820 FIG00388998: hypothetical protein +FIG01662828 75aa long conserved hypothetical protein +FIG01662843 protein of unknown function DUF924 +FIG01662879 Hypothetical outer membrane usher protein yraJ precursor +FIG01662885 FIG00815022: hypothetical protein +FIG01662886 Recombinational DNA repair protein +FIG01662892 FIG00412932: hypothetical protein +FIG01662897 FIG00257846: hypothetical protein +FIG01663115 bacteriophage tail sheath protein +FIG01663152 Fucolectin-related protein +FIG01663213 putative inner membrane protein +FIG01663231 hypothetical protein +FIG01663249 Serine protease( EC:3.4.21.- ) +FIG01663314 hypothetical protein; putative Peptidoglycan-binding domain ErfK/YbiS/YcfS/YnhG +FIG01663320 Methyltransferase MJ0906 +FIG01663373 Histidine kinase, HAMP region:chemotaxis sensory transducer +FIG01663384 FIG01238583: hypothetical protein +FIG01663391 FIG00526925: hypothetical protein +FIG01663392 Zinc-regulated zinc transporting ATPase ZntA +FIG01663427 CalS11 +FIG01663448 PE-PGRS FAMILY PROTEIN +FIG01663471 ATP-binding protein syrD +FIG01663490 FIG00523974: hypothetical protein +FIG01663502 Class II aldolase/adducin domain protein +FIG01663523 Palmitoyl-CoA hydrolase( EC:3.1.2.2 ) +FIG01663549 FIG00426971: hypothetical protein +FIG01663575 FIG00651258: hypothetical protein +FIG01663629 FIG00346629: hypothetical protein +FIG01663676 PROBABLE CONSERVED LIPOPROTEIN LPPF +FIG01663678 shufflon-specific recombinase +FIG01663702 MerP +FIG01663726 FIG01214542: hypothetical protein +FIG01663769 BseRI methylase fusion protein +FIG01663830 hypothetical protein +FIG01663867 FIG00517100: hypothetical protein +FIG01663916 FIG00662105: hypothetical protein +FIG01663925 FIG00389315: hypothetical protein +FIG01663963 Putative ABC transporter (substrate binding protein) +FIG01663994 FIG00623080: hypothetical protein +FIG01664077 EhpG +FIG01664084 Serine/Threonine protein kinase and Signal Transduction Histidine Kinase (EC 2.7.1.112) +FIG01664124 fimbriae associated protein +FIG01664182 FIG00425884: hypothetical protein +FIG01664247 probable serine/threonine-protein kinase pknB +FIG01664260 FIG00883088: hypothetical protein +FIG01664268 FIG00348456: hypothetical protein +FIG01664319 3-deoxy-D-manno-octulosonic-acid kinase +FIG01664398 similar to Uncharacterized protein conserved in bacteria +FIG01664399 FIG00870296: hypothetical protein +FIG01664407 DINB PROTEIN +FIG01664427 HAD-superfamily subfamily IIA hydrolase, hypothetical 3 +FIG01664430 NADPH quinone oxidoreductase, putative +FIG01664465 fructose-bisphosphate aldolase, class-II, putative +FIG01664484 hypothetical protein +FIG01664486 Pirin-like protein Mb0187c +FIG01664494 FIG00411201: hypothetical protein +FIG01664496 Uncharacterized protein yesK +FIG01664534 Ferredoxin--nitrite reductase( EC:1.7.7.1 ) +FIG01664558 Function Code: 16.0 Unknown +FIG01664581 POSSIBLE METHYLTRANSFERASE (METHYLASE) (EC 2.1.1.-) +FIG01664589 putative aminotransferase protein +FIG01664602 FIG00694576: hypothetical protein +FIG01664611 FIG00411591: hypothetical protein +FIG01664619 probable L-proline 4-hydroxylase +FIG01664643 prepilin peptidase CpaA +FIG01664650 FIG00525343: hypothetical protein +FIG01664675 FIG01245958: hypothetical protein +FIG01664695 C4-dicarboxylate transporter DcuC (TC 2.A.61.1.1) +FIG01664773 Tll0948 protein +FIG01664812 Sll1926 protein +FIG01664838 Gll4149 protein +FIG01664868 putative mitomycin resistance protein +FIG01664925 FIG01239289: hypothetical protein +FIG01664933 FIG01047736: hypothetical protein +FIG01664949 putative membrane/secreted protein +FIG01664951 FIG00835348: hypothetical protein +FIG01664964 porin; major outer membrane protein +FIG01664975 Unknown, probable RTX toxin +FIG01664978 possible GTPase +FIG01665048 protein of unknown function DUF72 +FIG01665064 FIG00633803: hypothetical protein +FIG01665123 Aspartyl/asparaginyl beta-hydroxylase +FIG01665162 173aa long hypothetical protein +FIG01665199 excinuclease ABC subunit C +FIG01665208 FIG01118774: hypothetical protein +FIG01665241 3-oxoacyl-[acyl-carrier-protein] reductase +FIG01665279 outer membrane serine protease +FIG01665328 possible methyl-accepting chemotaxis protein [Bacillus ... +FIG01665369 FIG00838968: hypothetical protein +FIG01665371 FIG00380605: hypothetical protein +FIG01665535 Sugar ABC transporter, permease protein +FIG01665576 Abi-like protein +FIG01665581 PIN domain containing protein +FIG01665586 probable quinohemoprotein ethanol dehydrogenase +FIG01665588 predicted Zn-dependent hydrolases of the beta-lactamase fold +FIG01665645 FIG00766597: hypothetical protein +FIG01665656 Hypohetical protein, phage associated +FIG01665665 Transposase +FIG01665667 hypothetical protein Psyc022217 +FIG01665669 FIG01032304: hypothetical protein +FIG01665746 FIG00385564: hypothetical protein +FIG01665755 FIG01093835: hypothetical protein +FIG01665766 FIG00514224: hypothetical protein +FIG01665796 putative Fe-S containing oxidoreductase( EC:1.- ) +FIG01665799 FIG00694912: hypothetical protein +FIG01665801 FIG00346632: hypothetical protein +FIG01665829 Enzyme from phospholipase D family, possible endonuclease nuc +FIG01665849 RESPONSE REGULATOR OMPR +FIG01665884 FIG01066046: hypothetical protein +FIG01665888 predicted gene, EG665748 +FIG01665897 Hypothetical protein, CF-8 family +FIG01665912 hypothetical transposase +FIG01665950 Transposase +FIG01665958 FIG00870311: hypothetical protein +FIG01665962 FIG01092763: hypothetical protein +FIG01666003 Homocysteine S-methyltransferase domain protein +FIG01666004 FIG00690025: hypothetical protein +FIG01666009 FIG01177819: hypothetical protein +FIG01666046 5-amino-6-(5-phosphoribosylamino)uracil reductase( EC:1.1.1.193 ) +FIG01666083 Gifsy-2 prophage protein +FIG01666100 possible resolvase, N-terminal +FIG01666116 predicted acylneuraminate cytidylyltransferase, NeuS +FIG01666154 FIG01203504: hypothetical protein +FIG01666218 alpha-L-arabinofuranosidase B +FIG01666233 FIG00644396: hypothetical protein +FIG01666242 putative bacteriophage integrase +FIG01666281 FIG00519304: hypothetical protein +FIG01666323 Serine protease 2 (SFase-2) +FIG01666332 FIG00424709: hypothetical protein +FIG01666336 FIG00389405: hypothetical protein +FIG01666363 Sugar phosphate permease of the Major Facilitator Superfamily +FIG01666391 type III secretion chaperone, CesT family +FIG01666397 FIG00404357: hypothetical protein +FIG01666424 FIG01055106: hypothetical protein +FIG01666425 cytochrome oxidase assembly +FIG01666460 Mobile element protein +FIG01666502 Sulfatase-domain-containing protein +FIG01666503 FIG00875025: hypothetical protein +FIG01666512 FIG01108719: hypothetical protein +FIG01666531 FIG01118869: hypothetical protein +FIG01666546 steroid delta-5-3-ketosteroid isomerase +FIG01666575 probable D-tagatose 3-epimerase +FIG01666589 Uncharacterized protein TP_0148 +FIG01666591 FIG00828812: hypothetical protein +FIG01666665 FIG00350756: hypothetical protein +FIG01666677 FIG00412341: hypothetical protein +FIG01666725 FIG00848052: hypothetical protein +FIG01666795 FIG00624858: hypothetical protein +FIG01666819 FIG00632434: hypothetical protein +FIG01666825 protein of unknown function DUF1192 +FIG01666837 Uncharacterized protein TP_0665 +FIG01666864 glycosyl transferase, family 8 +FIG01666940 putative para-nitrobenzyl esterase +FIG01667029 Predicted Zn peptidase +FIG01667034 Acyl-CoA dehydrogenase, C-terminal:Acyl-CoA dehydrogenase, central region:Acyl-CoA dehydrogenase, N-terminal +FIG01667128 COG3566: Uncharacterized protein conserved in bacteria +FIG01667154 FIG00425246: hypothetical protein +FIG01667175 putative glycan acetyltransferase +FIG01667176 FIG00762908: hypothetical protein +FIG01667178 FIG00850005: hypothetical protein +FIG01667185 unnamed protein product +FIG01667186 urease domain protein +FIG01667191 conserved hypothetical HI0974 +FIG01667193 hypothetical protein +FIG01667273 FIG00713348: hypothetical protein +FIG01667306 HlyD-family secretion protein +FIG01667322 FIG00838611: hypothetical protein +FIG01667323 FIG00469146: hypothetical protein +FIG01667328 probable ISRm5 transposase protein +FIG01667335 NAD dependent epimerase/dehydratase family protein +FIG01667397 FIG00643797: hypothetical protein +FIG01667425 FIG00349375: hypothetical protein +FIG01667428 manganese-containing catalase +FIG01667491 Tn5044 transposase +FIG01667494 Tannase and feruloyl esterase +FIG01667500 response regulator with a HTH DNA-binding domain +FIG01667525 monooxygenase +FIG01667532 hypothetical protein +FIG01667540 FIG00514947: hypothetical protein +FIG01667565 hypothetical protein +FIG01667584 FIG01227714: hypothetical protein +FIG01667609 Sll0779 protein +FIG01667610 FIG00923744: hypothetical protein +FIG01667752 hypothetical protein +FIG01667755 COG1414: Transcriptional regulator +FIG01667803 Probable phosphoglycerate mutase 2( EC:5.4.2.1 ) +FIG01667811 bacteriocin uviA +FIG01667837 aldo-keto reductase, putative +FIG01667888 FIG01118312: hypothetical protein +FIG01667923 putative response regulator receiver (CheY-like protein) +FIG01667951 FIG00350286: hypothetical protein +FIG01667957 similar to ABC-type multidrug transport system ATPase component +FIG01667985 peptidase domain protein +FIG01668011 Conjugal transfer protein TraC +FIG01668023 FIG00342122: hypothetical protein +FIG01668096 FIG01046402: hypothetical protein +FIG01668109 Adult brain protein 239-like protein +FIG01668119 FIG00769413: hypothetical protein +FIG01668157 FIG00767430: hypothetical protein +FIG01668160 aromatic amino acid transporter +FIG01668174 transposase (25) +FIG01668219 RNA polymerase sigma-70 domain protein +FIG01668257 FIG00344789: hypothetical protein +FIG01668260 FIG01060732: hypothetical protein +FIG01668296 Asparagine synthase +FIG01668314 FIG01182900: hypothetical protein +FIG01668342 Endoglycoceramidase II (EC 3.2.1.123) +FIG01668370 FIG00734192: hypothetical protein +FIG01668383 COG1651: Protein-disulfide isomerase +FIG01668415 Fe-S-cluster protein +FIG01668426 ATP-dependent clp protease ATP-binding subunit clpA +FIG01668504 DNA invertase from prophage CP-933H +FIG01668516 FIG00362035: hypothetical protein +FIG01668553 FIG00753977: hypothetical protein +FIG01668565 Expressed protein precursor +FIG01668576 Gas vesicle protein GvpH, heat shock protein Hsp20 +FIG01668599 Two-component sensor kinase precursor +FIG01668628 similar to GTPase subunit of restriction endonuclease +FIG01668642 FIG00945872: hypothetical protein +FIG01668653 FIG00385393: hypothetical protein +FIG01668674 InterPro IPR000014:IPR001789:IPR002106:IPR002570:IPR003594:IPR00366 0 :IPR003661:IPR004358:IPR005467 COGs COG0642 +FIG01668699 hypothetical protein NMA0604 +FIG01668749 FIG00390107: hypothetical protein +FIG01668751 Methanol utilization control sensor protein MoxY (EC 2.7.3.-) +FIG01668757 possible Hemagglutinin-neuraminidase +FIG01668773 Phage baseplate assembly protein W +FIG01668794 Probable serine/threonine-protein kinase Sps1 (EC 2.7.11.1) +FIG01668799 LysE family efflux protein +FIG01668807 FIG00407386: hypothetical protein +FIG01668814 predicted heat shock protein +FIG01668863 SyrP protein, putative +FIG01668864 FIG00409466: hypothetical protein +FIG01668903 FIG00349294: hypothetical protein +FIG01668938 putative acetyltransferase, gnat family +FIG01668981 hypothetical protein +FIG01668994 YeeT +FIG01669002 Similar to Agmatine deiminase +FIG01669049 FIG00410172: hypothetical protein +FIG01669051 FIG01242806: hypothetical protein +FIG01669068 FIG01206154: hypothetical protein +FIG01669086 ABC-type spermidine/putrescine transport systems ATPase components-like +FIG01669108 probable methyl-accepting chemotaxis protein +FIG01669111 Putative acetyltransferase (Antibiotic resistance ) protein +FIG01669134 FIG00641641: hypothetical protein +FIG01669149 potassium-efflux system protein +FIG01669169 VCBS repeat domain protein +FIG01669233 FIG00687945: hypothetical protein +FIG01669248 FIG00828173: hypothetical protein +FIG01669259 FIG00343969: hypothetical protein +FIG01669307 FIG01001968: hypothetical protein +FIG01669332 FIG01054649: hypothetical protein +FIG01669344 FIG00642743: hypothetical protein +FIG01669350 Capsular polysaccharide biosynthesis protein capA +FIG01669368 COG3534: Alpha-L-arabinofuranosidase +FIG01669374 glycerophosphoryl diester phosphodiesterase +FIG01669401 FIG00410994: hypothetical protein +FIG01669421 predicted nucleotidyltransferase +FIG01669479 FIG00815056: hypothetical protein +FIG01669507 Esterase/lipase, sll0644 homolog +FIG01669593 possible integral membrane sulfate transportor +FIG01669603 Pectate lyase related protein, secreted +FIG01669631 hypothetical protein +FIG01669640 Uncharacterized protein yjiA precursor +FIG01669673 transcriptional activator MltR +FIG01669680 FIG01166582: hypothetical protein +FIG01669755 FIG00624029: hypothetical protein +FIG01669793 FIG00466861: hypothetical protein +FIG01669826 Lipase chaperone-like protein +FIG01669845 prophage LambdaMc01, DNA methyltransferase +FIG01669849 FIG00764281: hypothetical protein +FIG01669934 FIG00623160: hypothetical protein +FIG01669937 hydrolase family protein +FIG01669958 Translation initiation factor 2B alpha/beta/delta-type subunit +FIG01669974 FIG00644913: hypothetical protein +FIG01670010 phage-associated protein +FIG01670024 50S ribosomal protein L19 +FIG01670072 FIG00762985: hypothetical protein +FIG01670089 VirK family protein +FIG01670136 FIG00764690: hypothetical protein +FIG01670137 FIG00362276: hypothetical protein +FIG01670149 hypothetical protein +FIG01670170 Possible transcriptional regulator from YAEG/LRPR family +FIG01670193 surface antigen BspA, putative +FIG01670202 hypothetical protein +FIG01670279 FIG01207411: hypothetical protein +FIG01670294 COG0539: Ribosomal protein S1 +FIG01670298 FIG00352459: hypothetical protein +FIG01670306 isochorismatase hydrolase +FIG01670331 Gll2461 protein +FIG01670333 FIG00768784: hypothetical protein +FIG01670367 hypothetical protein +FIG01670374 FIG00733281: hypothetical protein +FIG01670395 Uncharacterized conserved protein, YTFJ B.subtilis ortholog +FIG01670416 FIG00733466: hypothetical protein +FIG01670421 FIG01059427: hypothetical protein +FIG01670432 Glutamine ABC transporter (ATP-binding protein) +FIG01670440 FIG00850500: hypothetical protein +FIG01670450 Periplasmic protein TonB +FIG01670504 FIG00385168: hypothetical protein +FIG01670546 FIG00364207: hypothetical protein +FIG01670577 FIG00387926: hypothetical protein +FIG01670601 FIG00385491: hypothetical protein +FIG01670688 COG0110: Acetyltransferase (isoleucine patch superfamily) +FIG01670693 FIG00959242: hypothetical protein +FIG01670718 Uncharacterized protein Synpcc7942_2318 (ORF 2) +FIG01670746 7TM domain sensor diguanylate cyclase +FIG01670804 sodium ABC transporter ATP-binding protein +FIG01670826 amino acid ABC transporter, permease protein, putative +FIG01670851 conserved hypothetical protein; leucine-rich repeat (LRR) protein +FIG01670898 NLP/P60 family protein +FIG01670923 FIG00623308: hypothetical protein +FIG01670961 FIG00464505: hypothetical protein +FIG01670973 FIG00850680: hypothetical protein +FIG01670976 FIG00763849: hypothetical protein +FIG01671008 FIG00385559: hypothetical protein +FIG01671040 predicted intracellular protease +FIG01671071 FIG01151905: hypothetical protein +FIG01671083 Cholesterol oxidase precursor (EC 1.1.3.6) (CHOD) +FIG01671125 Glucose/galactose transporter +FIG01671126 cag pathogenicity island protein (cag7) +FIG01671174 FIG00402717: hypothetical protein +FIG01671199 Sll1352 protein +FIG01671203 FIG00920967: hypothetical protein +FIG01671229 no significant homology. 1 putative transmembrane region was found by PSORT +FIG01671244 2-hydroxyglutaryl-CoA dehydratase, D-component +FIG01671252 putative transscriptional regulator HTH type +FIG01671272 FIG01157618: hypothetical protein +FIG01671274 putative; ORF located using Glimmer/Genemark +FIG01671285 Metal dependent phosphohydrolase +FIG01671323 Soluble guanylyl cyclase beta 1 subunit +FIG01671327 UPF0272 protein MTH_1109 +FIG01671340 Macrolide export ATP-binding/permease protein macB 1 (EC 3.6.3.-) +FIG01671382 conserved hypothetical protein-putative NAD-dependent oxidoreductase of the GFO/IDH/MOCA family +FIG01671404 bacteriocin transport permease +FIG01671410 MFS-type transporter +FIG01671421 FIG00751819: hypothetical protein +FIG01671454 phosphate binding protein +FIG01671455 FIG00624205: hypothetical protein +FIG01671477 FIG00451978: hypothetical protein +FIG01671489 similar to ADP-ribosylation factor-directed GTPase activating protein isoform b +FIG01671490 FIG01002808: hypothetical protein +FIG01671514 ATP-dependent Clp protease regulatory subunit +FIG01671544 protein of unknown function DUF882 +FIG01671600 FIG01165502: hypothetical protein +FIG01671603 DNA-BINDING PROTEIN HU +FIG01671620 FIG01020639: hypothetical protein +FIG01671625 FIG00362210: hypothetical protein +FIG01671692 hypothetical protein +FIG01671715 UDP-N-acetylglucosamine acyltransferase( EC:2.3.1.129 ) +FIG01671745 2-hydroxymuconic semialdehyde hydrolase (EC 3.1.1.-) +FIG01671760 FIG00423977: hypothetical protein +FIG01671781 FIG00402961: hypothetical protein +FIG01671792 FIG00468103: hypothetical protein +FIG01671814 FIG00557183: hypothetical protein +FIG01671827 Glycosyl hydrolase, family 18 +FIG01671857 FIG01238556: hypothetical protein +FIG01671869 COG1694: Predicted pyrophosphatase +FIG01671871 FIG00623911: hypothetical protein +FIG01671898 FIG00353163: hypothetical protein +FIG01671902 possible symporter +FIG01671921 FIG00263586: hypothetical protein +FIG01671941 hypothetical protein +FIG01671968 FIG00823248: hypothetical protein +FIG01671996 Probable cis-diol dehydratase small subunit (similar to propanediol and glycerol dehydratases) +FIG01672000 BNR repeat +FIG01672058 Gll1194 protein +FIG01672066 IS861, transposase (orf2), IS3 family, truncated +FIG01672137 FIG00403032: hypothetical protein +FIG01672163 FIG00638035: hypothetical protein +FIG01672167 Phage endonuclease VII +FIG01672187 phosphatase +FIG01672196 Polysaccharide biosynthesis protein CapD type +FIG01672200 Lipoprotein, VirB7-like +FIG01672205 HigA protein (antitoxin to HigB) +FIG01672208 metal-binding protein-like +FIG01672247 putative low calcium response protein H +FIG01672251 sarcosine oxidase, putative +FIG01672276 lipase (esterase) +FIG01672289 prolyl oligopeptidase family protein, putative +FIG01672293 tuberculin related peptide +FIG01672346 FIG00764553: hypothetical protein +FIG01672360 Uncharacterized protein MJ1239 +FIG01672398 aminoglycoside N6'-acetyltransferase +FIG01672442 Major tail tube protein +FIG01672460 FIG00624675: hypothetical protein +FIG01672477 probable amino acid transporter +FIG01672577 FIG00390237: hypothetical protein +FIG01672580 Bile-acid 7-alpha dehydratase (EC 4.2.1.106) +FIG01672639 superinfection exclusion +FIG01672689 FIG00407030: hypothetical protein +FIG01672694 FIG00347550: hypothetical protein +FIG01672755 acyl-protein synthetase, LuxE +FIG01672760 FIG00513716: hypothetical protein +FIG01672806 COG0589: Universal stress protein UspA and related nucleotide-binding proteins +FIG01672807 FIG01165702: hypothetical protein +FIG01672830 FIG00745759: hypothetical protein +FIG01672853 MMPL domain protein +FIG01672898 Cupin region +FIG01672904 FIG01218272: hypothetical protein +FIG01672908 competence ComEA family protein +FIG01672957 putative murein endopeptidase +FIG01672972 FIG00470449: hypothetical protein +FIG01672997 FIG01017271: hypothetical protein +FIG01673002 FIG00389022: hypothetical protein +FIG01673005 ORF_ID:tll1971 hypothetical protein +FIG01673008 FIG01249275: hypothetical protein +FIG01673028 Hypothetical outer membrane usher protein yraJ precursor +FIG01673037 FIG01247143: hypothetical protein +FIG01673142 FIG01181231: hypothetical protein +FIG01673171 FIG01119385: hypothetical protein +FIG01673172 FIG00743916: hypothetical protein +FIG01673184 FIG00352192: hypothetical protein +FIG01673186 FIG00946004: hypothetical protein +FIG01673188 FIG00343777: hypothetical protein +FIG01673219 HemX protein, negative effector of steady-state concentration of glutamyl-tRNA reductase +FIG01673221 putative ComG operon protein 3 +FIG01673243 FIG00415657: hypothetical protein +FIG01673245 FIG00390545: hypothetical protein +FIG01673269 Glutaconate CoA-transferase subunit A (EC 2.8.3.12) +FIG01673302 FIG00408936: hypothetical protein +FIG01673344 FIG00622779: hypothetical protein +FIG01673352 2-dehydro-3-deoxyglucarate aldolase( EC:4.1.2.20 ) +FIG01673376 Msl9076 protein +FIG01673392 FIG01082492: hypothetical protein +FIG01673398 FIG00424511: hypothetical protein +FIG01673436 Integral membrane protein, YccS/YhfK +FIG01673441 hypothetical protein +FIG01673456 FIG00623424: hypothetical protein +FIG01673464 conjugative transposon conserved hypothetical protein +FIG01673465 mutlidrug resistance protein, putative +FIG01673473 Milk-clotting protease +FIG01673504 FIG00403453: hypothetical protein +FIG01673544 FIG00385228: hypothetical protein +FIG01673562 FIG00675248: hypothetical protein +FIG01673637 COG2826: Transposase and inactivated derivatives, IS30 family +FIG01673659 Probable dipeptidyl anminopeptidase +FIG01673681 PUTATIVE TRANSMEMBRANE SENSOR +FIG01673741 CrcB protein +FIG01673865 FIG01074521: hypothetical protein +FIG01673867 Atu, putative +FIG01673870 FIG00873743: hypothetical protein +FIG01673958 FIG00652834: hypothetical protein +FIG01673976 FIG01249792: hypothetical protein +FIG01674002 CBS domain +FIG01674011 FIG00971754: hypothetical protein +FIG01674023 FIG00348987: hypothetical protein +FIG01674060 hypothetical protein +FIG01674131 FIG00712848: hypothetical protein +FIG01674136 avirulence protein +FIG01674161 sulfite reductase +FIG01674168 COG3498: Phage tail tube protein FII +FIG01674175 FIG00623176: hypothetical protein +FIG01674205 COG0730: Predicted permeases +FIG01674257 Uncharacterized protein ydiR +FIG01674259 Multi-sensor signal transduction histidine kinase +FIG01674273 FIG00344992: hypothetical protein +FIG01674314 Addiction module toxin, Txe/YoeB +FIG01674320 Predicted membrane protein, containing FHA domain +FIG01674324 FIG00008269: hypothetical protein +FIG01674337 ORF_ID:all3630 +FIG01674397 FIG00388667: hypothetical protein +FIG01674483 major paralogous domain protein +FIG01674492 Dipeptide-binding protein +FIG01674499 transporter, Drug/metabolite exporter family +FIG01674571 FIG00404752: hypothetical protein +FIG01674613 FIG00470188: hypothetical protein +FIG01674626 Putative surface-anchored membrane protein +FIG01674661 FIG00351460: hypothetical protein +FIG01674666 FIG00853673: hypothetical protein +FIG01674708 Probable cytochrome P450 110 (EC 1.14.-.-) +FIG01674783 glyoxalase/bleomycin resistance protein/dioxygenase superfamily +FIG01674799 FIG01135576: hypothetical protein +FIG01674806 FIG00765255: hypothetical protein +FIG01674810 FIG00152082: hypothetical protein +FIG01674852 ABC transporter integral membrane subunit +FIG01674880 hypothetical protein +FIG01674887 hypothetical protein +FIG01674906 multidrug-efflux transporter, putative +FIG01674928 DNA helicase related protein +FIG01674982 FIG01207028: hypothetical protein +FIG01675002 magnesium transport protein +FIG01675026 Ig-like domain/kelch domain protein +FIG01675115 Proline-rich region precursor +FIG01675122 Putative cysteine transferase +FIG01675123 guanosine-3,5-bis(diphosphate) 3-pyrophosphohydrolase SpoTb +FIG01675149 FIG00353665: hypothetical protein +FIG01675240 FIG00763678: hypothetical protein +FIG01675261 phage-related conserved hypothetical protein +FIG01675297 FIG00624110: hypothetical protein +FIG01675305 COGs COG0715 +FIG01675348 FIG00680299: hypothetical protein +FIG01675363 putative Lipase/esterase protein +FIG01675378 FIG00624447: hypothetical protein +FIG01675385 FIG00816569: hypothetical protein +FIG01675412 FIG00524268: hypothetical protein +FIG01675423 FIG00533092: hypothetical protein +FIG01675424 FIG00388097: hypothetical protein +FIG01675450 lysine biosynthesis protein LysW +FIG01675480 FIG00341283: hypothetical protein +FIG01675487 glucosaminyltransferase +FIG01675498 hypothetical protein +FIG01675511 FIG00348159: hypothetical protein +FIG01675551 Nucleotide sugar transaminase +FIG01675714 Predicted Phage-related amidase +FIG01675719 FIG00711986: hypothetical protein +FIG01675738 FIG00753378: hypothetical protein +FIG01675767 Predicted Na+-dependent transporter +FIG01675814 relA/spoT family protein +FIG01675820 IS630-Spn1, transposase Orf1, putative +FIG01675828 FIG00415875: hypothetical protein +FIG01675831 Polysaccharide deacetylase, Carbohydrate Esterase Family 4 +FIG01675864 putative phage head-tail adaptor +FIG01675873 virulence protein, putative +FIG01675901 FIG00388391: hypothetical protein +FIG01675921 FIG00410352: hypothetical protein +FIG01675935 hypothetical protein SCD39.27c +FIG01675943 CheY-like receiver domain of response regulator +FIG01675953 ADP-ribosyltransferase toxin aexT (EC 2.4.2.-) (Exoenzyme T) +FIG01675995 FIG00750822: hypothetical protein +FIG01676014 possible antibiotic efflux protein +FIG01676033 COG0525: Valyl-tRNA synthetase +FIG01676046 Modification methylase Phi3TI +FIG01676072 FIG00347979: hypothetical protein +FIG01676082 FIG00524549: hypothetical protein +FIG01676108 FIG00406964: hypothetical protein +FIG01676187 putative ABC transporter (permease protein) +FIG01676201 FIG01025417: hypothetical protein +FIG01676239 FIG01118945: hypothetical protein +FIG01676251 FIG00469431: hypothetical protein +FIG01676254 Gll2346 protein +FIG01676255 FIG00959032: hypothetical protein +FIG01676282 Serine/threonine-protein kinase D (EC 2.7.11.1) +FIG01676353 probable ceramide glucosyltransferase +FIG01676354 FIG00816780: hypothetical protein +FIG01676372 FIG00816884: hypothetical protein +FIG01676392 FIG00747028: hypothetical protein +FIG01676407 Lipoprotein LppO +FIG01676423 glutaminase A +FIG01676428 oxidoreductase molybdopterin binding +FIG01676433 putative phosphoglycerate dehydrogenase( EC:1.1.1.95 ) +FIG01676477 Msm operon regulatory protein +FIG01676525 Histidine kinase-like protein +FIG01676530 FIG01077230: hypothetical protein +FIG01676597 Ssl2069 protein +FIG01676620 HNS-like transcription regulator protein +FIG01676639 FIG00414762: hypothetical protein +FIG01676656 Branched-chain amino acid ABC tranpsorter, permease/ATP-binding protein +FIG01676691 Uncharacterized protein MJ1340 +FIG01676713 Magnesium transport P-type atpase +FIG01676731 Phage repressor +FIG01676775 syc2295_c +FIG01676784 ortholog of Bordetella pertussis (BX470248) BP2627 +FIG01676790 bsr5763; unknown protein +FIG01676816 FIG00533381: hypothetical protein +FIG01676865 FIG00387963: hypothetical protein +FIG01676869 Putative general secretion pathway protein L +FIG01676898 Tetrahydromethanopterin S-methyltransferase subunit H (EC 2.1.1.86) homolog +FIG01676913 FIG00632935: hypothetical protein +FIG01676918 Putative iron transport permease +FIG01676922 conserved hypothetical transposase +FIG01676924 probable serine/threonine protein kinase, putative( EC:2.7.11.1 ) +FIG01676925 FIG01053019: hypothetical protein +FIG01676926 3-dehydroquinate synthase( EC:4.2.3.4 ) +FIG01676997 sensory box/GGDEF domain protein +FIG01677037 putative type II secretion system protein +FIG01677042 Uncharacterized protein TP_0222 precursor +FIG01677046 FIG00623062: hypothetical protein +FIG01677065 Spore maturation protein +FIG01677122 Phenolpthiocerol synthesis type-I polyketide synthase PpsA (EC 2.3.1.41) +FIG01677166 FIG00935838: hypothetical protein +FIG01677216 Protein of unknown function DUF1234 +FIG01677218 nitrogen-fixing NifU-like +FIG01677219 Conserved hypothetical protein 481 +FIG01677259 FIG00835980: hypothetical protein +FIG01677263 FIG00362284: hypothetical protein +FIG01677338 probable enoyl-CoA hydratase +FIG01677382 Inorganic phosphate transporter +FIG01677395 Serine phosphatase +FIG01677418 putative amino-acid ABC transporter, periplasmic amino acid-binding protein +FIG01677420 FIG00756922: hypothetical protein +FIG01677440 calcium binding and coiled-coil domain 2 +FIG01677479 FIG00531751: hypothetical protein +FIG01677523 YpkF +FIG01677529 unknown, predicted membrane protein (TMS4) +FIG01677541 Lipoprotein LpqB, GerMN domain protein +FIG01677548 FIG00529177: hypothetical protein +FIG01677586 Tsl1516 protein +FIG01677614 putative porin +FIG01677627 FIG00413964: hypothetical protein +FIG01677666 Siroheme synthase-like +FIG01677702 FIG01021661: hypothetical protein +FIG01677730 FIG00860645: hypothetical protein +FIG01677766 FIG01020362: hypothetical protein +FIG01677776 Transposase +FIG01677860 similar to adenylate cyclase( EC:4.6.1.1 ) +FIG01677903 FIG00764734: hypothetical protein +FIG01677906 FIG00595558: hypothetical protein +FIG01677916 FIG00424803: hypothetical protein +FIG01677958 putative phage capsid protein (partial) +FIG01677988 gliding motility protein GldC +FIG01678019 Leucine-rich repeat +FIG01678034 FunZ family protein, +FIG01678038 putative nodulin 21-related protein +FIG01678049 Xylose ABC transporter permease protein +FIG01678079 FIG00416034: hypothetical protein +FIG01678080 hypothetical protein +FIG01678114 glycoside hydrolase, family 13-like +FIG01678115 Nucleotidyltransferase domain, putative +FIG01678133 FIG00756792: hypothetical protein +FIG01678145 FIG00711189: hypothetical protein +FIG01678146 ISEf1, transposase +FIG01678155 FIG00351653: hypothetical protein +FIG01678215 FIG00416158: hypothetical protein +FIG01678224 probable cytosine deaminase +FIG01678235 Fimbrial protein pilin +FIG01678249 FIG00623124: hypothetical protein +FIG01678320 flagellar biosynthetic protein FliR +FIG01678349 HAD superfamily (Subfamily IG) hydrolase, 5'-nucleotidase +FIG01678416 oligopeptide transport system permease protein +FIG01678444 FIG01180916: hypothetical protein +FIG01678455 Propanediol utilization protein PduV, truncated fragment +FIG01678484 probable GnaT-family acetyltransferase +FIG01678582 Uncharacterized protein MJ0582 +FIG01678586 FIG00756773: hypothetical protein +FIG01678680 putative transposase_11 DDE family protein +FIG01678736 FIG00416514: hypothetical protein +FIG01678738 Protein of unknown function DUF262 +FIG01678767 ISPpu14, transposase Orf3 +FIG01678780 Silver-binding protein +FIG01678795 FIG00948809: hypothetical protein +FIG01678814 Iron dependent repressor +FIG01678874 Histone H1-like protein +FIG01678888 hypothetical protein +FIG01678944 FIG01132358: hypothetical protein +FIG01678946 FIG00413008: hypothetical protein +FIG01678952 FIG00412057: hypothetical protein +FIG01678953 trehalose-6-phosphate hydrolase, truncated +FIG01678955 Exoenzymes regulatory protein AepA precursor +FIG01678970 FIG00388124: hypothetical protein +FIG01679012 FIG00768070: hypothetical protein +FIG01679027 FIG00753566: hypothetical protein +FIG01679059 FIG00986109: hypothetical protein +FIG01679071 hypothetical mobile element-associated protein +FIG01679073 YpzD +FIG01679077 FIG00642913: hypothetical protein +FIG01679116 FraH-related protein +FIG01679119 Staphylococcal nuclease family protein +FIG01679131 FIG01126341: hypothetical protein +FIG01679139 thrombospondin type 3 repeat family protein/Calx-beta domain protein +FIG01679157 probable n-terminal acetyltransferase +FIG01679173 FIG00418597: hypothetical protein +FIG01679300 FIG00886196: hypothetical protein +FIG01679318 haloacid dehalogenase-like hydrolase, putative +FIG01679359 FIG00836007: hypothetical protein +FIG01679395 FIG00527033: hypothetical protein +FIG01679423 FIG00814599: hypothetical protein +FIG01679447 FIG01047310: hypothetical protein +FIG01679448 FIG00623436: hypothetical protein +FIG01679454 FIG01122019: hypothetical protein +FIG01679600 FIG01022152: hypothetical protein +FIG01679626 Protein of unknown function DUF2262 +FIG01679636 L-lysine exporter, putative +FIG01679649 Conjugal transfer protein TraA +FIG01679654 ribosomal protein L7Ae/L30e/S12e/Gadd45 +FIG01679665 caa(3)-type oxidase, subunit IV +FIG01679667 Flp pilus assembly protein TadD +FIG01679712 FIG00528522: hypothetical protein +FIG01679714 Relaxase/mobilization nuclease family protein +FIG01679723 two component system histidine kinase +FIG01679754 putative RNA-polymerase +FIG01679780 UPF0254 protein MTH_1148 +FIG01679949 FIG01038590: hypothetical protein +FIG01679981 Acid shock +FIG01679997 FIG00347627: hypothetical protein +FIG01680023 hypothetical protein +FIG01680029 hypothetical protein +FIG01680072 Dicarboxylate/amino acid:cation (Na+ or H+) symporter +FIG01680084 FIG00838437: hypothetical protein +FIG01680095 ISSoc3, orfB transposase +FIG01680105 integrase/recombinase, phage integrase family +FIG01680119 possible predicted diverged CheY-domain +FIG01680135 FIG01003856: hypothetical protein +FIG01680171 prophage Lp1 protein 23 +FIG01680173 hypothetical protein +FIG01680198 Protein of phosphatidic acid phosphatase family, YNBD E.coli ortholog +FIG01680230 FIG00733373: hypothetical protein +FIG01680243 FIG00526259: hypothetical protein +FIG01680271 nitrate/nitrite regulatory protein narP +FIG01680320 Phosphatase YidA +FIG01680331 AAA family ATPase, possible cell division control protein cdc48 +FIG01680337 Lytic transglycosylase +FIG01680371 FIG00641564: hypothetical protein +FIG01680399 ion transport family protein +FIG01680416 probable transcriptional regulator YfiF +FIG01680439 FIG01116816: hypothetical protein +FIG01680464 putative RND family multidrug efflux transporter +FIG01680479 Modification methylase DsaV (EC 2.1.1.37) +FIG01680528 protein of unknown function DUF1622 +FIG01680582 Nucleotidyltransferase PLUS glutamate rich protein GrpB PLUS ribosomal protein alanine acetyltransferase +FIG01680595 FIG00766317: hypothetical protein +FIG01680625 carboxyphosphonoenolpyruvate phosphonomutase, putative +FIG01680653 FIG00344129: hypothetical protein +FIG01680695 Transposase +FIG01680708 hypothetical protein +FIG01680715 enterochelin esterase and related enzyme +FIG01680724 FIG01137703: hypothetical protein +FIG01680726 FIG00733901: hypothetical protein +FIG01680749 FIG00817443: hypothetical protein +FIG01680785 conserved domain protein +FIG01680788 COG0296: 1,4-alpha-glucan branching enzyme +FIG01680819 FIG00344712: hypothetical protein +FIG01680825 hypothetical protein 2SCG4.11 +FIG01680846 FIG00665103: hypothetical protein +FIG01680871 Cytochrome P450 alkane hydroxylase 1 CYP153A7 (EC 1.14.15.3) +FIG01680893 COG3425: 3-hydroxy-3-methylglutaryl CoA synthase +FIG01680903 FIG00389424: hypothetical protein +FIG01680948 Mg2+ transport protein +FIG01680976 signaling protein without kinase domain +FIG01680982 FIG01119045: hypothetical protein +FIG01680996 ferredoxin-type protein, NapH/MauN family +FIG01681000 Major tail sheath protein +FIG01681047 FIG00753066: hypothetical protein +FIG01681055 FIG00570979: hypothetical protein +FIG01681069 Protein of unknown function UPF0187 +FIG01681071 sialidase +FIG01681103 putative osmC-like protein +FIG01681111 FIG00513666: hypothetical protein +FIG01681116 FIG00524028: hypothetical protein +FIG01681117 Proteophosphoglycan +FIG01681139 FIG00528441: hypothetical protein +FIG01681150 FIG00754489: hypothetical protein +FIG01681159 FIG00604290: hypothetical protein +FIG01681176 acyl-coA-binding protein, ACBP +FIG01681237 GGDEF/HAMP domain protein +FIG01681248 FIG00385699: hypothetical protein +FIG01681257 protein of unknown function DUF748 +FIG01681265 FIG00742919: hypothetical protein +FIG01681318 Diverged Metallo-dependent hydrolase(Zn) of DD-Peptidase family; peptodoglycan-binding domain +FIG01681319 FIG00789993: hypothetical protein +FIG01681404 V8-like Glu-specific endopeptidase-like protein +FIG01681459 flagellin hook IN motif family +FIG01681463 Putative transport protein +FIG01681471 FIG00389090: hypothetical protein +FIG01681488 FIG00387934: hypothetical protein +FIG01681492 Transposase +FIG01681494 mannanase +FIG01681525 FIG00465314: hypothetical protein +FIG01681540 FIG00623378: hypothetical protein +FIG01681585 protein of unknown function DUF861 cupin_3 +FIG01681700 hypothetical protein GFO_1395 +FIG01681706 conserved hypothetical sex pilus assembly and synthesis protein +FIG01681709 probable replication protein Rep +FIG01681713 FIG01115485: hypothetical protein +FIG01681766 FIG00389039: hypothetical protein +FIG01681827 endo-1,4-beta-xylanase +FIG01681839 hypothetical protein +FIG01681841 FIG00827355: hypothetical protein +FIG01681851 conserved domain protein +FIG01681857 Probable hemagglutinin/hemolysin-related protein +FIG01681902 beta2 toxin +FIG01681908 peptidyl-prolyl cis-trans isomerase Mip( EC:5.2.1.8 ) +FIG01681919 hypothetical protein +FIG01681922 FIG00527121: hypothetical protein +FIG01682017 FIG00356507: hypothetical protein +FIG01682034 syc0126_d +FIG01682044 FIG00576996: hypothetical protein +FIG01682075 type IIs restriction endonuclease +FIG01682085 Mannosyltransferase A +FIG01682086 alpha-L-fucosidase family protein +FIG01682140 conserved protein, with a weak D-galactarate dehydratase/altronate hydrolase domain +FIG01682156 FIG00690651: hypothetical protein +FIG01682211 putative collagen-like protein +FIG01682224 regulatory protein for 2-phenylethylamine catabolism +FIG01682292 FIG00487766: hypothetical protein +FIG01682376 FIG01227761: hypothetical protein +FIG01682387 Reverse transcriptase (EC 2.7.7.49) +FIG01682392 ORF-6 +FIG01682415 FIG00532611: hypothetical protein +FIG01682492 ribonuclease inhibitor +FIG01682509 Cellulose synthase operon protein D +FIG01682587 FIG00860897: hypothetical protein +FIG01682631 competence factor comEC +FIG01682683 FIG00638738: hypothetical protein +FIG01682690 FIG01092846: hypothetical protein +FIG01682695 FIG00351587: hypothetical protein +FIG01682723 FIG00451905: hypothetical protein +FIG01682787 FIG01128247: hypothetical protein +FIG01682840 related to glyceraldehyde-3-phosphate dehydrogenase +FIG01682864 FIG00465291: hypothetical protein +FIG01682898 FIG00905633: hypothetical protein +FIG01682938 PspC domain family +FIG01682981 LppO +FIG01683009 plasmid maintenance system killer +FIG01683024 FIG01220318: hypothetical protein +FIG01683066 FIG00751255: hypothetical protein +FIG01683082 probable membrane-fusion protein +FIG01683092 conserved hypothetical protein containing TPR repeat +FIG01683106 FIG01128583: hypothetical protein +FIG01683131 PEBP family protein +FIG01683140 FIG00516771: hypothetical protein +FIG01683212 serine protease A +FIG01683217 FIG00733796: hypothetical protein +FIG01683234 Membrane permease, predicted cation efflux pumps +FIG01683374 Monooxygenase, FAD-binding:FAD dependent oxidoreductase( EC:1.14.13.20 ) +FIG01683379 hypothetical protein +FIG01683382 50S ribosomal protein L32 +FIG01683388 Bacteriophage T4 late gene expression blocking protein +FIG01683401 phosphatase family protein +FIG01683412 Chain A, Crystal Structure Of Protein Of Unknown Function (Duf1255) (Afe_2634) From Acidithiobacillus Ferrooxidans Ncib8455 At 0.97 A Resolution +FIG01683485 FIG00363518: hypothetical protein +FIG01683498 FIG01114999: hypothetical protein +FIG01683522 FIG00520522: hypothetical protein +FIG01683553 FIG00515097: hypothetical protein +FIG01683610 tetracycline repressor protein +FIG01683627 Type IV fimbrial biogenesis protein PilW +FIG01683631 FIG00389899: hypothetical protein +FIG01683645 FIG01046993: hypothetical protein +FIG01683711 pH adaptation potassium efflux system protein G; sodium-potassium/hydrogen antiporter subunit G +FIG01683722 probable metalloprotease/ CBS domain protein( EC:3.4.24.- ) +FIG01683765 FIG00630568: hypothetical protein +FIG01683766 secretion activator protein, putative +FIG01683796 Negative regulator of flagellin synthesis (anti-sigma28 factor) +FIG01683842 FIG00416961: hypothetical protein +FIG01683854 FIG00532708: hypothetical protein +FIG01683885 Uncharacterized ABC transporter ATP-binding protein MJ0412 +FIG01683907 Predicted diverged CheY-domain +FIG01683929 FIG00792695: hypothetical protein +FIG01683932 POSSIBLE MEMBRANE ACYLTRANSFERASE (EC 2.3.1.-) +FIG01683934 Cell wall degradation protein +FIG01683987 FIG00402644: hypothetical protein +FIG01684031 FIG00643353: hypothetical protein +FIG01684129 syc1427_c +FIG01684151 transposase +FIG01684164 putative hemolysin secretion ATP-binding protein +FIG01684167 2Fe-2S iron-sulfur cluster binding domain protein +FIG01684192 IcsA (Fragment) +FIG01684218 oligopeptide permease integral membrane protein +FIG01684238 amino acid adenylation domain-containing protein +FIG01684251 putative transmembrane acyltransferase +FIG01684262 Tiorf138 protein +FIG01684287 FIG00765869: hypothetical protein +FIG01684324 FIG01120726: hypothetical protein +FIG01684347 HetP protein +FIG01684375 protein of unknown function DUF964 +FIG01684412 YxeL +FIG01684439 conserved hypothetical fusion protein +FIG01684445 FIG00498055: hypothetical protein +FIG01684455 Appr-1-p processing +FIG01684456 FIG00379969: hypothetical protein +FIG01684492 transcriptional regulator, TetR/AcrR family +FIG01684499 FIG00350216: hypothetical protein +FIG01684515 COG0518: GMP synthase - Glutamine amidotransferase domain +FIG01684519 FIG00623612: hypothetical protein +FIG01684551 FIG00922001: hypothetical protein +FIG01684566 FIG00343944: hypothetical protein +FIG01684599 Polysaccharide deacetylase precursor +FIG01684621 hypothetical protein +FIG01684647 RepE replication protein +FIG01684667 YbaA +FIG01684677 Zinc ABC transporter, ATP-binding protein ZnuC; Manganese ABC transporter, ATP-binding protein SitB +FIG01684743 FIG00623923: hypothetical protein +FIG01684780 Rieske [2Fe-2S] domain containing oxidoreductase +FIG01684799 taurine ABC transporter, permease protein +FIG01684834 FIG00486994: hypothetical protein +FIG01684843 acetoacetate metabolism regulatory protein ATOC +FIG01684849 DNA helicase II UvrD +FIG01684852 Styrene monooxygenase subunit A +FIG01684892 FIG00633847: hypothetical protein +FIG01684909 methyl-accepting chemotaxis protein III (MCP-III) +FIG01684924 FIG00763200: hypothetical protein +FIG01684986 FIG00388408: hypothetical protein +FIG01685029 FIG00624102: hypothetical protein +FIG01685038 FIG00388196: hypothetical protein +FIG01685058 hypothetical protein; Hypothetical protein +FIG01685083 hypothetical protein +FIG01685115 transposase, TnsB-related protein +FIG01685119 Exoribonuclease II( EC:3.1.13.1 ) +FIG01685193 gluconolactonase +FIG01685200 Predicted nucleotide kinase +FIG01685228 Sugar-proton symporter +FIG01685242 probable phosphotransbutyrylase +FIG01685280 Integral membrane protein +FIG01685287 Possible TPR-repeat contaning protein +FIG01685305 possible phosphoglycerate mutase +FIG01685311 Phosphonate-binding periplasmic protein +FIG01685329 Staphylococcus nuclease (SNase) homologues precursor +FIG01685333 Putative enzyme of poly-gamma-glutamate biosynthesis (capsule formation)-like +FIG01685365 CFA synthetase, thioesterase component +FIG01685367 signal transduction histidine kinase with PAS/PAC sensor domain +FIG01685369 similar to c-type cytochrome +FIG01685403 putative cytochrome c4 +FIG01685410 FIG00403256: hypothetical protein +FIG01685426 FIG00768096: hypothetical protein +FIG01685451 Multidrug resistance-like ATP-binding protein mdlB +FIG01685471 Putative periplasmic binding protein +FIG01685477 FIG00628472: hypothetical protein +FIG01685502 FIG01133761: hypothetical protein +FIG01685552 Transposase, IS605 OrfB +FIG01685587 putative comEA-related protein +FIG01685590 FIG00348345: hypothetical protein +FIG01685591 FIG00350858: hypothetical protein +FIG01685598 Cytochrome b subunit of the bc complex +FIG01685624 coagulation factor 5/8 type-like protein +FIG01685651 Polyheme membrane-associated cytochrome c +FIG01685674 FIG00404599: hypothetical protein +FIG01685695 sugar-binding transport ATP-binding protein +FIG01685722 putative regulator (fragment). +FIG01685740 protein of unknown function DUF533 +FIG01685794 phage integrase family site specific recombinase +FIG01685819 Esterase/hydrolase +FIG01685822 FIG00356174: hypothetical protein +FIG01685841 FIG01115360: hypothetical protein +FIG01685843 Tellurium resistance protein terD +FIG01685854 Spore germination protein GerKA +FIG01685857 hypothetical protein +FIG01685860 FIG00955951: hypothetical protein +FIG01685882 FIG00515844: hypothetical protein +FIG01685925 putative RNA-binding protein +FIG01685964 hypothetical protein +FIG01685970 Endoglucanase C precursor (EC 3.2.1.4) (Endo-1,4-beta-glucanase C) (Cellulase C) +FIG01685989 FIG00388327: hypothetical protein +FIG01685999 FIG00363810: hypothetical protein +FIG01686036 FIG01208172: hypothetical protein +FIG01686065 conserved hypothetical fusion protein +FIG01686075 phage protein, HK97 GP10 family +FIG01686089 FIG00641784: hypothetical protein +FIG01686149 FIG00405618: hypothetical protein +FIG01686184 FIG00470439: hypothetical protein +FIG01686217 putative chloride-channel protein +FIG01686242 GALACTOFURANOSYL TRANSFERASE +FIG01686280 Stimulator of FtsZ polymerization and component of cell-division Z-ring +FIG01686281 FIG00672339: hypothetical protein +FIG01686308 FIG00344514: hypothetical protein +FIG01686333 Intradiol ring-cleavage dioxygenase precursor (EC 1.13.11.1) +FIG01686359 leucine rich repeat protein +FIG01686444 FIG00363551: hypothetical protein +FIG01686445 Dipeptidase-related protein +FIG01686455 NTNH protein +FIG01686459 FIG00516946: hypothetical protein +FIG01686464 FIG00877881: hypothetical protein +FIG01686468 putative O antigen polymerase +FIG01686486 FIG00390559: hypothetical protein +FIG01686519 LeoA +FIG01686552 predicted phosphoesterase +FIG01686567 Subtilisin-like secreted protease +FIG01686583 hypothetical protein +FIG01686586 FIG00347606: hypothetical protein +FIG01686651 FIG00361271: hypothetical protein +FIG01686677 hypothetical protein +FIG01686726 SCI7.27c, unknown, len: 235aa +FIG01686737 putative protein of unknown function +FIG01686751 FIG00939681: hypothetical protein +FIG01686788 IS1381, transposase OrfB +FIG01686808 Predicted nucleotide-binding protein +FIG01686866 Lsr2 protein +FIG01686900 traI protein, putative +FIG01686910 probable sugar ABC transporter, ATP-binding protein +FIG01686941 Bsr7110 protein +FIG01686947 FIG00407002: hypothetical protein +FIG01687013 FIG00351502: hypothetical protein +FIG01687147 L. lactis predicted coding region ORF00025 +FIG01687148 hemolysin A +FIG01687174 PUTATIVE INTEGRASE DNA PROTEIN +FIG01687176 COGs COG1018 +FIG01687187 FIG00767518: hypothetical protein +FIG01687192 probable small heat shock protein +FIG01687283 Lysophospholipase +FIG01687329 FIG00517816: hypothetical protein +FIG01687339 conserved hypothetical protein-putative integraal membrane protein +FIG01687358 PEP motif putative anchor-like +FIG01687378 FIG00344288: hypothetical protein +FIG01687440 spectinomycin phosphotransferase +FIG01687477 Gll0387 protein +FIG01687508 prophage LambdaSo, lysozyme, putative +FIG01687583 probable acyl-CoA-binding protein +FIG01687584 FIG01220650: hypothetical protein +FIG01687588 toxin-antitoxin system, antitoxin component, Xre domain protein +FIG01687628 Protein related to MIFH/DOPD protein family, function in bacteria is unknown +FIG01687631 FIG01250230: hypothetical protein +FIG01687632 FIG00343826: hypothetical protein +FIG01687646 FIG00875916: hypothetical protein +FIG01687650 FIG00850101: hypothetical protein +FIG01687678 Transcriptional regulator, AraC family +FIG01687705 Tlr2088 protein +FIG01687729 rickettsial conserved hypothetical protein +FIG01687735 helicase/SNF2 family domain protein +FIG01687736 FIG01334132: Putative conserved alanine, valine and leucine rich integral membrane protein +FIG01687739 Citrate transporter, citM family +FIG01687782 ABC-type transport system involved in resistance to organic solvents +FIG01687788 FIG01242241: hypothetical protein +FIG01687855 Glycosyltransferase-like 1 +FIG01687870 FIG00642280: hypothetical protein +FIG01687898 hypothetical protein +FIG01687908 Bacteriophage minor capsid protein C +FIG01687965 Beta-lactamase( EC:3.5.2.6 ) +FIG01687992 FIG01115820: hypothetical protein +FIG01688024 FIG00523340: hypothetical protein +FIG01688043 predicted Transcriptional regulator +FIG01688048 FIG00523394: hypothetical protein +FIG01688056 probable immediate early protein +FIG01688096 FIG00941138: hypothetical protein +FIG01688105 putative endoglucanase( EC:3.2.1.- ) +FIG01688154 FIG00403194: hypothetical protein +FIG01688159 hypothetical protein +FIG01688214 FIG00551444: hypothetical protein +FIG01688261 Predicted protein family PM-15 +FIG01688292 FIG01056709: hypothetical protein +FIG01688307 Nucleoside:H+ symporter:Major facilitator superfamily MFS_1 +FIG01688348 FIG00414607: hypothetical protein +FIG01688371 uncharacterized membrane-associated protein +FIG01688403 Phage related anti-repressor protein +FIG01688445 plasmid replication/partition related protein +FIG01688447 FIG00743287: hypothetical protein +FIG01688466 possible Gonadotropin-releasing hormone +FIG01688523 putative arabinofuranosidase +FIG01688548 acetyltransferase homolog +FIG01688557 Sensor protein rstB (EC 2.7.3.-) +FIG01688588 FIG00350204: hypothetical protein +FIG01688658 inner membrane protein YjdF +FIG01688697 Endoglucanase S precursor (EC 3.2.1.4) +FIG01688702 Serine protease, subtilase family (EC 3.4.21.-) +FIG01688706 Amidophosphoribosyl transferase +FIG01688707 FIG01217850: hypothetical protein +FIG01688740 Putative ADP-ribosylglycohydrolase +FIG01688745 potassium-dependent ATPase chain G +FIG01688754 FIG00581063: hypothetical protein +FIG01688776 ortholog of Bordetella pertussis (BX470248) BP3468 +FIG01688793 High molecular weight glutenin subunit x precursor +FIG01688800 hypothetical protein +FIG01688834 Slr0302 protein +FIG01688870 FIG00356455: hypothetical protein +FIG01688893 FIG00242751: hypothetical protein +FIG01688900 Competence protein-like +FIG01688914 FIG00638745: hypothetical protein +FIG01688926 50S ribosomal protein L1 +FIG01689009 FIG00987904: hypothetical protein +FIG01689014 FIG00525737: hypothetical protein +FIG01689114 cationic outer membrane protein OmpH +FIG01689117 hypothetical protein +FIG01689118 FIG00840526: hypothetical protein +FIG01689120 putative ribosylglycohydrolase +FIG01689146 hypothetical protein +FIG01689178 FIG00764979: hypothetical protein +FIG01689194 FIG00898178: hypothetical protein +FIG01689199 putative peptidase, S37 family +FIG01689296 FIG00365051: hypothetical protein +FIG01689338 FIG00537935: hypothetical protein +FIG01689377 NADH:flavin oxidoreductase, Old Yellow Enzyme family +FIG01689392 FIG00562904: hypothetical protein +FIG01689449 FIG00348977: hypothetical protein +FIG01689458 FIG00416859: hypothetical protein +FIG01689473 putative glutamate--cysteine ligase +FIG01689485 Putative RNA polymerase ECF-subfamily sigma factor +FIG01689516 FIG00409153: hypothetical protein +FIG01689518 tetracenomycin C synthesis protein +FIG01689563 FIG01047694: hypothetical protein +FIG01689600 phospholipase D +FIG01689621 PROBABLE ACYL-COA THIOESTER HYDROLASE-RELATED PROTEIN +FIG01689632 Thioredoxin( EC:5.3.4.1 ) +FIG01689675 bacterial Ig-like domain protein +FIG01689686 FIG00429613: hypothetical protein +FIG01689704 FIG00643794: hypothetical protein +FIG01689732 FIG00451996: hypothetical protein +FIG01689748 COG1872 +FIG01689757 essential for degradative enzyme (sacB and degQ) expression and competence regulation (positive regulation of comK expression) +FIG01689762 carbon storage regulator related protein +FIG01689771 CDP-6-deoxy-delta-3,4-glucoseen reductase-like +FIG01689789 Adenylosuccinate synthase +FIG01689792 FIG00960019: hypothetical protein +FIG01689795 Tgh088 +FIG01689814 InterPro IPR004183 COGs COG3384 +FIG01689827 conserved lipoprotein DsbF +FIG01689828 FIG00745466: hypothetical protein +FIG01689842 protein of unknown function Mtu_121 +FIG01689844 DNA-directed DNA polymerase +FIG01689910 FIG00886549: hypothetical protein +FIG01689937 FIG01125116: hypothetical protein +FIG01690015 hypothetical protein +FIG01690040 toxR-activated gene (tagE) +FIG01690053 Protein of unknown function DUF343 +FIG01690058 FIG00870050: hypothetical protein +FIG01690066 Transcriptional regulator, TrmB family / Transcriptional regulator, LuxR family +FIG01690067 putative zinc protease protein +FIG01690081 Predicted L-arabinose isomerase (EC 5.3.1.4) +FIG01690121 F420-dependent NADP reductase +FIG01690141 FIG00413880: hypothetical protein +FIG01690220 IS630-Spn1, transposase Orf2 +FIG01690257 FIG00623645: hypothetical protein +FIG01690278 FIG00989936: hypothetical protein +FIG01690295 oxidoreductase family, NAD-binding Rossmann fold domain protein +FIG01690328 thioredoxin H1 +FIG01690352 serine/threonine kinase family protein +FIG01690359 FIG00528321: hypothetical protein +FIG01690363 Mll9648 protein +FIG01690378 possible conserved lipoprotein +FIG01690422 UL36 very large tegument protein +FIG01690508 Outer membrane lipoprotein carrier protein +FIG01690517 FIG00641792: hypothetical protein +FIG01690524 Putative heat shock protein +FIG01690529 Protein of unknown function DUF192 +FIG01690651 FIG00513125: hypothetical protein +FIG01690652 DNA polymerase III domain protein +FIG01690661 FIG00388593: hypothetical protein +FIG01690701 FIG00767686: hypothetical protein +FIG01690711 Pyrimidine deaminase archaeal predicted (EC 3.5.4.26) type 2 +FIG01690722 FIG00364033: hypothetical protein +FIG01690751 TRANSCRIPTIONAL ACTIVATOR PROTEIN COPR +FIG01690752 FIG01119444: hypothetical protein +FIG01690782 FIG00427302: hypothetical protein +FIG01690785 hypothetical exported peptide protein +FIG01690837 FIG00979822: hypothetical protein +FIG01690842 Putative iron sulphur protein +FIG01690878 FIG00472303: hypothetical protein +FIG01690923 Mll5767 protein +FIG01690924 L-aspartate oxidase( EC:1.4.3.16 ) +FIG01690945 A2-5a orf9; hypothetical protein +FIG01690968 branched-chain amino acid transport system permease protein livM/branched-chain amino acid transport ATP-binding protein livG +FIG01690983 FIG00688431: hypothetical protein +FIG01690997 FIG00624633: hypothetical protein +FIG01691005 alanyl-tRNA synthetase( EC:6.1.1.7 ) +FIG01691008 FIG00490081: hypothetical protein +FIG01691054 ABC transporter, putative ATP binding protein, truncated +FIG01691075 FIG00623509: hypothetical protein +FIG01691079 Putative bacteriophage protein +FIG01691157 putative transposable insertion element +FIG01691204 dipeptidyl peptidase VI +FIG01691269 NADH dehydogenase +FIG01691271 Pectate lyase H (FS) +FIG01691278 RNA polymerase sigma factor-related protein +FIG01691342 FIG00884377: hypothetical protein +FIG01691363 FIG00623532: hypothetical protein +FIG01691367 FIG00524651: hypothetical protein +FIG01691374 Arachidonate 15-lipoxygenase precursor (EC 1.13.11.33) +FIG01691389 putative phage integrase. +FIG01691399 diadenosine tetraphosphatase +FIG01691412 protein of unknown function (DUF433) +FIG01691418 FIG00526104: hypothetical protein +FIG01691458 FIG00630695: hypothetical protein +FIG01691461 DIGUANYLATE CYCLASE +FIG01691515 iron(III)-transport ATP-binding protein sfuC +FIG01691520 Phosphoryl transfer system, HPr +FIG01691528 multi-sensor hybrid histidine kinase( EC:2.7.13.3 ) +FIG01691553 tail tape measure protein, putative +FIG01691561 FIG00947995: hypothetical protein +FIG01691566 protein of unknown function DUF1113 +FIG01691616 FIG00344188: hypothetical protein +FIG01691626 hypothetical protein +FIG01691634 probable glycosyltransferase WbpH +FIG01691666 FIG00405347: hypothetical protein +FIG01691690 Negative regulator of genetic competence sporulation and motility-like +FIG01691717 essential recombination function protein +FIG01691732 FIG00405130: hypothetical protein +FIG01691748 hypothetical protein +FIG01691758 FIG00384968: hypothetical protein +FIG01691804 FIG00527537: hypothetical protein +FIG01691822 TnpA transposase +FIG01691938 FIG00414118: hypothetical protein +FIG01692050 FIG00873517: hypothetical protein +FIG01692053 small acid soluble protein +FIG01692059 Potential acid phosphatase (EC 3.1.3.2) +FIG01692060 FIG00849474: hypothetical protein +FIG01692085 amine oxidase, putative +FIG01692124 2(4Fe-4S) ferredoxin in Nif regulon, iron-sulfur compound bisynthesis +FIG01692128 probable glutaredoxin +FIG01692146 protein of unknown function DUF1010 +FIG01692179 Predicted N-acetyltransferase +FIG01692224 FIG01107201: hypothetical protein +FIG01692245 ABC transport protein, solute binding component +FIG01692249 Low molecular weight protein-tyrosine-phosphatase (EC 3.1.3.48) +FIG01692264 chaperone FimC +FIG01692345 similar to ATP adenylyltransferase (5' 5'''-P-1 P-4-tetraphosphate phosphorylase II) +FIG01692351 PAS sensor protein +FIG01692385 phosphatidylinositol glycan, class B +FIG01692442 DNA polymerase, beta domain protein region +FIG01692449 FIG00817171: hypothetical protein +FIG01692492 FIG00388439: hypothetical protein +FIG01692586 FIG01068916: hypothetical protein +FIG01692591 FIG00733973: hypothetical protein +FIG01692594 F420H2:quinone oxidoreductase +FIG01692595 ABC transporter, sugar-binding protein of unknown specificity +FIG01692608 CheC, inhibitor of MCP methylation +FIG01692692 FIG00407595: hypothetical protein +FIG01692693 predicted micrococcal nuclease-like protein +FIG01692753 FIG01135110: hypothetical protein +FIG01692775 UDP-sulfoquinovose synthase (EC 3.13.1.1) +FIG01692782 spore cortex formation (peptidoglycan biosynthesis) +FIG01692790 putative sugar transporter, permease protein +FIG01692877 possible large adhesin +FIG01692932 glycoside hydrolase, family 6 +FIG01692934 predicted outer membrane protein +FIG01692961 reverse transcriptase (RNA-dependent)-like +FIG01692995 FIG094192: hypothetical protein +FIG01693050 putative extracellular nuclease +FIG01693062 Site specific DNA-methyltransferase +FIG01693073 CRISPR-associated protein, Cas2 +FIG01693143 agrocinopine utilization periplasmic binding protein precursor +FIG01693147 C-compound, carbohydrate catabolism +FIG01693256 FIG00468548: hypothetical protein +FIG01693294 FIG00424378: hypothetical protein +FIG01693297 FIG01046550: hypothetical protein +FIG01693300 putative phage-encoded membrane protein +FIG01693338 chromosome partitioning protein, ParA family ATPase +FIG01693347 FIG00426194: hypothetical protein +FIG01693351 UBA/THIF-type NAD/FAD binding fold:MoeZ/MoeB +FIG01693369 possible ATP-binding protease, Clp family +FIG01693386 Cytochrome c oxidase subunit I +FIG01693408 FIG00352590: hypothetical protein +FIG01693412 Lanthionine synthetase C-like +FIG01693451 Transmembrane efflux protein +FIG01693468 Lin2382 protein +FIG01693470 FIG00342209: hypothetical protein +FIG01693472 Capsular polysaccharide phosphotransferase wcwK (EC 2.7.-.-) (Stealth protein wcwK) +FIG01693549 Uncharacterized protein PM1083 precursor +FIG01693566 cotJB protein +FIG01693577 FIG00264004: hypothetical protein +FIG01693604 FIG00623188: hypothetical protein +FIG01693780 FIG00361883: hypothetical protein +FIG01693795 predicted acyl dehydratase +FIG01693806 glutathione S-transferase-like +FIG01693817 non-essential pilus assembly protein +FIG01693835 signal recognition particle +FIG01693896 FIG00876555: hypothetical protein +FIG01693903 Stress responsive alpha-beta barrel domain protein +FIG01693966 Rieske domain protein +FIG01693983 FIG01129484: hypothetical protein +FIG01693997 Asl2713 protein +FIG01694024 FIG00767172: hypothetical protein +FIG01694047 Phosphatidylserine/phosphatidylglycerophosphate/ cardiolipin synthases and related enzymes-like protein precursor +FIG01694056 Cell surface antigen Sca8 +FIG01694064 MRNA-binding protein +FIG01694084 transcriptional regulator, LysR-family +FIG01694088 FIG00351812: hypothetical protein +FIG01694113 FIG00499509: hypothetical protein +FIG01694125 Transcriptional repressor pagR +FIG01694143 POSSIBLE CONSERVED LIPOPROTEIN LPPE +FIG01694160 Lipopolysaccharide core biosynthesis glycosyl transferase kdtX (EC 2.-.-.-) +FIG01694175 EXTRACYTOPLASMIC FUNCTION ALTERNATIVE SIGMA FACTOR +FIG01694192 FIG00675540: hypothetical protein +FIG01694201 FIG00350730: hypothetical protein +FIG01694238 Related to spore coat protein F +FIG01694239 Malonyl CoA-acyl carrier protein transacylase (EC 2.3.1.39) +FIG01694244 FIG00639281: hypothetical protein +FIG01694246 FIG00734403: hypothetical protein +FIG01694313 FIG00859362: hypothetical protein +FIG01694369 Hypothetical protein, CF-42 family +FIG01694390 Mu-like prophage major head subunit gpT +FIG01694406 Asr4910 protein +FIG01694410 putative ABC transporter membrane-spanning subunit +FIG01694434 FIG00363475: hypothetical protein +FIG01694449 FERRICHROME-IRON RECEPTOR +FIG01694450 FIG00766290: hypothetical protein +FIG01694490 FIG00660989: hypothetical protein +FIG01694511 Uncharacterized protein MJ0939 +FIG01694546 WavE lipopolysaccharide synthesis superfamily +FIG01694598 FIG00356774: hypothetical protein +FIG01694608 protein kinase C-like protein +FIG01694646 FIG00849914: hypothetical protein +FIG01694657 FIG01253735: hypothetical protein +FIG01694671 FIG00837632: hypothetical protein +FIG01694697 rhomboid family protein +FIG01694707 iron/ascorbate oxidoreductase family protein, putative +FIG01694727 FIG00753964: hypothetical protein +FIG01694747 5-enolpyruvylshikimate-3-phosphate synthase +FIG01694771 oligopeptide ABC transporter, periplasmic oligopeptide-binding protein +FIG01694778 FIG00438814: hypothetical protein +FIG01694789 Predicted zinc-dependent repressor ZntR, DtxR superfamily +FIG01694818 Possible membrane protein +FIG01694828 Phosphoglycerol transferase MdoB related protein, alkaline phosphatase superfamily +FIG01694844 DNA polymerase III, gamma/tau subunits +FIG01694858 FIG01204015: hypothetical protein +FIG01694863 FIG00426382: hypothetical protein +FIG01694947 FIG01208302: hypothetical protein +FIG01695065 Sulfate transporter/antisigma-factor antagonist STAS +FIG01695066 FIG00672671: hypothetical protein +FIG01695078 FIG00686327: hypothetical protein +FIG01695089 FIG00389025: hypothetical protein +FIG01695156 CsbD-like protein +FIG01695223 FIG00424274: hypothetical protein +FIG01695245 FIG00388201: hypothetical protein +FIG01695247 syc1929_d +FIG01695254 NADH-quinone oxidoreductase, E subunit +FIG01695273 GGDEF/FHA domain protein +FIG01695285 Phage transcriptional activator RinA +FIG01695293 multidrug ABC transporter +FIG01695304 esterase/lipase/thioesterase family active site +FIG01695322 probable pyridine nucleotide-disulphide oxidoreductase +FIG01695337 Methane monooxygenase component A gamma chain (EC 1.14.13.25) +FIG01695418 ORF_ID:alr7505 unknown protein +FIG01695442 FIG00697634: hypothetical protein +FIG01695453 Type ii site-specific deoxyribonuclease (EC 3.1.21.4) +FIG01695481 FIG00380279: hypothetical protein +FIG01695485 Pirin-related protein +FIG01695567 ORF012 +FIG01695603 membrane-associated acyltransferase +FIG01695638 FIG00712616: hypothetical protein +FIG01695646 Probable NAD-dependent malic enzyme 1 (EC 1.1.1.38) (NAD-ME 1) +FIG01695691 uncharacterized MobA-related protein-like protein +FIG01695697 FIG01093685: hypothetical protein +FIG01695701 FIG00767680: hypothetical protein +FIG01695741 Hypothetical Rhodanese sulfurtransferase protein +FIG01695757 ORF_ID:asr7548 unknown protein +FIG01695764 FIG00554062: hypothetical protein +FIG01695767 FIG00920351: hypothetical protein +FIG01695775 FIG00817030: hypothetical protein +FIG01695790 Competence protein F homolog, phosphoribosyltransferase domain; protein YhgH required for utilization of DNA as sole source of carbon and energy +FIG01695791 CBS domain protein( EC:1.1.1.205 ) +FIG01695850 N-acetyltransferase NrgA homolog +FIG01695869 FIG00623071: hypothetical protein +FIG01695876 FIG00385817: hypothetical protein +FIG01695878 Dihydroorotate dehydrogenase (EC 1.3.3.1) (Dihydroorotate oxidase) (DHOdehase) (DHODase) (DHOD) +FIG01695890 HTH-type transcriptional regulator rgg +FIG01695922 hypothetical protein +FIG01695931 FIG00355801: hypothetical protein +FIG01695943 FIG00967929: hypothetical protein +FIG01695952 FIG00578909: hypothetical protein +FIG01695988 sodium/glucose cotransporter 2 +FIG01695996 FIG00965471: hypothetical protein +FIG01695998 FIG01245794: hypothetical protein +FIG01696013 FIG00589513: hypothetical protein +FIG01696023 FIG01166242: hypothetical protein +FIG01696046 FIG00425650: hypothetical protein +FIG01696081 FIG01198748: hypothetical protein +FIG01696082 Aminobenzoyl-glutamate utilization protein B +FIG01696093 FIG00743519: hypothetical protein +FIG01696119 putative outer membrane porin +FIG01696123 Sialidase precursor (EC 3.2.1.18) (Neuraminidase) +FIG01696201 FIG00418096: hypothetical protein +FIG01696205 ABC transporter, ATP-binding protein +FIG01696206 Nucleotidyltransferase associated with HEPN-containing protein +FIG01696252 unknown protein, truncated +FIG01696305 Opioid growth factor receptor +FIG01696315 Putative pilus assembly protein +FIG01696323 endolysin, putative +FIG01696344 Replication terminator protein +FIG01696362 FIG00961874: hypothetical protein +FIG01696428 Possible ATLS1-like light-inducible protein +FIG01696430 protein of unknown function DUF1470 +FIG01696448 FIG00353373: hypothetical protein +FIG01696462 putative DnaJ-class molecular chaperone +FIG01696473 HPP family protein+B94 +FIG01696474 fimbrial subunit CS5 +FIG01696495 probable CDP-tyvelose epimerase +FIG01696538 COG0277: FAD/FMN-containing dehydrogenases +FIG01696548 hypothetical protein +FIG01696551 FIG01129233: hypothetical protein +FIG01696561 lactate 2-monooxygenase( EC:1.13.12.4 ) +FIG01696596 hyaluronidase( EC:3.2.1.35 ) +FIG01696617 Protein of unknown function DUF1121 +FIG01696720 FIG01120711: hypothetical protein +FIG01696825 FIG01229675: hypothetical protein +FIG01696843 FIG01241050: hypothetical protein +FIG01696847 FIG00530929: hypothetical protein +FIG01696855 Endo-1,4-beta-xylanase B (EC 3.2.1.8) (Xylanase B) (1,4-beta-D-xylan xylanohydrolase B) +FIG01696884 FIG00388051: hypothetical protein +FIG01696906 secreted protein antigen +FIG01696938 osmolarity response regulator +FIG01697011 FIG00820052: hypothetical protein +FIG01697016 FIG00753082: hypothetical protein +FIG01697087 UDP-N-acetyl-D-mannosaminuronic acid transferase +FIG01697108 Uncharacterized protein AF_1786 +FIG01697112 FMN-binding domain protein +FIG01697125 Biotin biosynthesis protein BioI of cytochrome P450 family, pimeloyl-ACP producing +FIG01697130 Hypothetical protein, CF-2 family +FIG01697173 Prophage, holin, SPP1 family +FIG01697181 FIG00895456: hypothetical protein +FIG01697190 FIG00850588: hypothetical protein +FIG01697193 FIG00756894: hypothetical protein +FIG01697200 Phage TAIL SHEATH PROTEIN +FIG01697204 uridine kinase( EC:2.7.1.48 ) +FIG01697214 FIG00385280: hypothetical protein +FIG01697249 FIG00388595: hypothetical protein +FIG01697257 protein of unknown function DUF420 +FIG01697283 FIG01054959: hypothetical protein +FIG01697383 COG1463: ABC-type transport system involved in resistance to organic solvents, periplasmic component +FIG01697409 putative lipoprotein precursor lplA +FIG01697445 FIG01136520: hypothetical protein +FIG01697501 antirepressor, putative +FIG01697534 tetratricopeptide repeat family +FIG01697548 Tsr1131 protein +FIG01697557 haemagglutination domain protein +FIG01697578 FIG00559800: hypothetical protein +FIG01697599 HSP20 type chaperone +FIG01697617 FIG00751800: hypothetical protein +FIG01697619 arsenical pump membrane protein +FIG01697648 Hypothetical protein, CF-44 family +FIG01697656 FIG00833912: hypothetical protein +FIG01697657 FIG01016319: hypothetical protein +FIG01697661 Probable endoglucanase (EC 3.2.1.4) +FIG01697687 FIG01156875: hypothetical protein +FIG01697768 FIG00623408: hypothetical protein +FIG01697796 FIG01121370: hypothetical protein +FIG01697799 FIG00811200: hypothetical protein +FIG01697803 Relaxase/Mobilisation nuclease domain +FIG01697854 ABC transporter membrane-spanning permease, Pep export, Vex1 +FIG01697897 FIG00001892: hypothetical protein +FIG01697903 FIG00749747: hypothetical protein +FIG01697916 FIG00923948: hypothetical protein +FIG01697926 nifU protein, homolog +FIG01697938 ATP binding histidine kinase +FIG01697972 glycoside hydrolase, family 10 +FIG01698003 conserved hypothetical protein; putative cell wall-associated hydrolase (invasion-associated proteins) +FIG01698017 FIG00529747: hypothetical protein +FIG01698035 FIG00344563: hypothetical protein +FIG01698055 probable ECF sigma factor AdsA +FIG01698121 complete genome; segment 4/17 +FIG01698130 FIG00644296: hypothetical protein +FIG01698138 FIG00751874: hypothetical protein +FIG01698162 COG1548 family protein +FIG01698201 FIG00412323: hypothetical protein +FIG01698238 FIG00930839: hypothetical protein +FIG01698273 Biotin synthetase +FIG01698280 Probable S-layer protein +FIG01698290 Cytochrome c551 peroxidase precursor (EC 1.11.1.5) +FIG01698297 taurine ABC transporter, ATP-binding protein +FIG01698335 probable mobilization protein MobA +FIG01698346 FIG00403031: hypothetical protein +FIG01698349 FIG00846964: hypothetical protein +FIG01698378 universal stress protein UspA and related nucleotide-binding proteins +FIG01698394 FIG01237875: hypothetical protein +FIG01698413 amine oxidase family, flavin-containing protein +FIG01698467 Archaeal ATPase family +FIG01698507 Putative ATP-binding component of a transport system +FIG01698557 Wax synthase-like protein +FIG01698607 FIG01095233: hypothetical protein +FIG01698669 pore-forming peptide, putative bacteriocin +FIG01698680 probable sigma factor, includes region 2 +FIG01698706 holin-like protein similar to orf of bacteriophage BK5-T +FIG01698748 FIG145533: hypothetical protein +FIG01698752 SecE subunit of protein translocation complex +FIG01698774 hypothetical protein +FIG01698778 FIG00469498: hypothetical protein +FIG01698783 exporter of the RND superfamily +FIG01698786 FIG01068771: hypothetical protein +FIG01698803 Cytochrome P450-terp (EC 1.14.-.-) +FIG01698854 FIG00356432: hypothetical protein +FIG01698861 Secreted esterase +FIG01698870 FIG01120276: hypothetical protein +FIG01698883 FIG00715091: hypothetical protein +FIG01698926 Lipase family protein +FIG01698969 Uncharacterized protein R02378 +FIG01699009 putative cyanamide hydratase +FIG01699012 FIG00829615: hypothetical protein +FIG01699014 FIG00518024: hypothetical protein +FIG01699038 FIG00517048: hypothetical protein +FIG01699044 FIG00733176: hypothetical protein +FIG01699109 FIG00907965: hypothetical protein +FIG01699111 FIG00733564: hypothetical protein +FIG01699134 FIG00344420: hypothetical protein +FIG01699137 Helicase-like:DEAD/DEAH box helicase-like +FIG01699142 endo-arabinase-like protein +FIG01699146 metal-dependent phosphohydrolase, HD sub domain +FIG01699176 FIG01049227: hypothetical protein +FIG01699184 FIG00763020: hypothetical protein +FIG01699187 FIG00524107: hypothetical protein +FIG01699257 protein of unknown function DUF404 +FIG01699267 FIG00623337: hypothetical protein +FIG01699275 hypothetical protein +FIG01699300 Alcohol dehydrogenase zinc-binding domain protein +FIG01699455 lactose transport system (lactose-binding protein) +FIG01699497 peptidoglycan-binding protein, putative +FIG01699538 Putative flippase +FIG01699542 colicin V production family protein +FIG01699545 cation translocating P-type ATPase +FIG01699571 FIG01201398: hypothetical protein +FIG01699579 oxidoreductase FAD/NAD(P)-binding domain protein +FIG01699593 Protein of unknown function DUF472 +FIG01699604 Fosfomycin resistance protein fosX +FIG01699639 Excalibur domain protein +FIG01699661 FIG00352615: hypothetical protein +FIG01699662 FIG00734207: hypothetical protein +FIG01699685 putative glutamate transporter permease +FIG01699691 some similarities to plasmid-related proteins +FIG01699733 Iron (III) dicitrate ABC transporter substrate-binding protein +FIG01699812 FIG00352217: hypothetical protein +FIG01699844 Amylo-alpha-16-glucosidase +FIG01699894 FIG00414479: hypothetical protein +FIG01699903 FIG00747291: hypothetical protein +FIG01699904 putative homoserine/homoserine lactone efflux protein +FIG01699926 Phosphohistidine phosphatase +FIG01699941 ORF_ID:all7654 unknown protein +FIG01700031 PROBABLE CONSERVED TRANSMEMBRANE PROTEIN +FIG01700059 YcfA-like +FIG01700070 hypothetical protein +FIG01700141 FIG00712352: hypothetical protein +FIG01700161 FIG00912369: hypothetical protein +FIG01700187 hypothetical protein +FIG01700206 antenna complex alpha/beta subunit +FIG01700223 FIG00389052: hypothetical protein +FIG01700232 Uncharacterized protein YeaK +FIG01700305 Glucan endo-1,6-beta-glucosidase( EC:3.2.1.75 ) +FIG01700312 fosmidmycin resistance protein +FIG01700334 putative butyryltransferase +FIG01700339 FIG00410527: hypothetical protein +FIG01700388 Endoproteinase Arg-C +FIG01700392 small heat shock protein (hsp20-1) +FIG01700412 Predicted ATPase involved in replication control, Cdc46/Mcm family +FIG01700418 FIG00388286: hypothetical protein +FIG01700427 FIG01082877: hypothetical protein +FIG01700443 putative transcriptional regulator protein, Cro/CI family +FIG01700461 FIG00410852: hypothetical protein +FIG01700511 FIG01132873: hypothetical protein +FIG01700517 ABC transport system permease protein +FIG01700541 Hyaluronan synthase (EC 2.4.1.212) +FIG01700543 FIG00364965: hypothetical protein +FIG01700561 Fibril-like structure subunit FibA, putative +FIG01700601 FIG01117398: hypothetical protein +FIG01700614 3-oxoacyl-(Acyl-carrier-protein) reductase +FIG01700688 predicted Rossmann fold nucleotide-binding protein +FIG01700700 FIG00985533: hypothetical protein +FIG01700753 FIG00627394: hypothetical protein +FIG01700798 NERD domain-containing family protein +FIG01700818 Protein of unknown function DUF45 +FIG01700821 FIG00911432: hypothetical protein +FIG01700832 probable exported protein YPO3699 +FIG01700838 hypothetical protein +FIG01700865 FIG00416450: hypothetical protein +FIG01700919 FIG01047927: hypothetical protein +FIG01700931 protein of unknown function DUF975 +FIG01700946 chromosome segregation protein +FIG01700965 sialidase precursor, exo-alpha-sialidase +FIG01701038 FIG00736698: hypothetical protein +FIG01701073 FIG00733295: hypothetical protein +FIG01701101 Tripeptidyl-peptidase 2 (EC 3.4.14.10) +FIG01701107 Serine proteinase +FIG01701227 FIG00766142: hypothetical protein +FIG01701247 phenylacetate-CoA ligase( EC:6.2.1.30 ) +FIG01701259 Cystine ABC transporter, periplasmic cystine-binding protein FliY +FIG01701268 FIG00901576: hypothetical protein +FIG01701294 FIG00858674: hypothetical protein +FIG01701329 AatP permease +FIG01701354 Membrane proteins, metalloendopeptidase-like +FIG01701373 protein of unknown function DUF413 +FIG01701416 chitosanase-glucanase +FIG01701470 FIG00630947: hypothetical protein +FIG01701480 ABC transporter, ATP-binding protein +FIG01701484 FIG00411696: hypothetical protein +FIG01701501 Re face-specific citrate synthase (EC 2.3.3.3) +FIG01701502 SIGNAL-TRANSDUCTION SENSOR PROTEIN-PAS/PAC domain +FIG01701516 LacI-family transcriptional regulatory protein +FIG01701519 FIG00561913: hypothetical protein +FIG01701523 hypothetical protein +FIG01701563 lipoprotein, putative +FIG01701595 FIG00388477: hypothetical protein +FIG01701634 FIG00347610: hypothetical protein +FIG01701677 FIG01114936: hypothetical protein +FIG01701742 FIG00348236: hypothetical protein +FIG01701757 hypothetical protein +FIG01701764 transporter, MMPL family +FIG01701805 Uncharcterized protein, shares conserved domain among different RHS family proteins and WAPA of B.subtilis +FIG01701871 Transcriptional regulator, Cro/CI family +FIG01701882 putative CcdB-like protein +FIG01701891 FIG01055243: hypothetical protein +FIG01701908 FIG01062475: hypothetical protein +FIG01701909 zinc metalloproteinase Mpr protein +FIG01701936 FIG00387906: hypothetical protein +FIG01701939 Conjugal transfer TrbH family protein +FIG01701973 ABC-2 type transport system ATP-binding protein +FIG01702011 Serine/Threonine protein kinase with WD40 repeats +FIG01702015 FIG00410161: hypothetical protein +FIG01702017 FIG00384868: hypothetical protein +FIG01702061 FIG00850469: hypothetical protein +FIG01702097 RNA polymerase sigma factor RpoD +FIG01702107 Asparagine-rich protein +FIG01702118 FIG00390090: hypothetical protein +FIG01702140 235 kDa rhoptry protein +FIG01702177 Cellulose biosynthesis protein +FIG01702185 FIG01045275: hypothetical protein +FIG01702221 conserved hypothetical ABC transporter periplasmic solute-binding protein +FIG01702244 FIG01137708: hypothetical protein +FIG01702284 FIG00469302: hypothetical protein +FIG01702303 adenylate kinase and related kinases +FIG01702337 putative regulatory protein +FIG01702420 phage phi-C31 gp35-like protein +FIG01702453 hypothetical protein +FIG01702483 5-methylcytosine-specific restriction enzyme A (EC 3.1.21.-) +FIG01702484 Early endosome antigen 1 +FIG01702499 Outer membrane lipoprotein A precursor +FIG01702588 COG2703: Hemerythrin +FIG01702597 Cro-like protein, phage associated +FIG01702600 predicted response regulator +FIG01702651 HMG-I and HMG-Y, DNA-binding +FIG01702719 FIG00352142: hypothetical protein +FIG01702744 transcriptional regulator (ArsR family) protein +FIG01702745 fatty acid biosynthesis +FIG01702751 Sensor protein comP (EC 2.7.1.-) +FIG01702772 similar to ADP-ribosylglycohydrolase +FIG01702782 Helix-turn-helix protein +FIG01702789 hypothetical protein +FIG01702790 FIG00667368: hypothetical protein +FIG01702809 Archaeal-type Fe-S oxidoreductase +FIG01702867 Putative pirin-like protein +FIG01702899 type III effector HopAU1 +FIG01702907 type II secretion system F domain protein +FIG01702920 putative AraC family transcriptional regulatory protein +FIG01702923 holliday junction DNA helicase +FIG01703018 aryldialkylphosphatase +FIG01703038 Acetyl-coenzyme A carboxyl transferase alpha chain (EC 6.4.1.2) +FIG01703089 FIG00416911: hypothetical protein +FIG01703122 LmbE-related protein +FIG01703148 blr7651; hypothetical protein +FIG01703181 Cytidine and deoxycytidylate deaminase family protein +FIG01703237 FIG00623714: hypothetical protein +FIG01703242 putative purple acid phosphatase precursor +FIG01703282 FIG00343838: hypothetical protein +FIG01703340 Glutaredoxin 2-like protein +FIG01703354 hypothetical protein +FIG01703399 FIG00765516: hypothetical protein +FIG01703409 putative competence protein ComGD +FIG01703452 FIG00642186: hypothetical protein +FIG01703477 Transcriptional regulator, TetR family +FIG01703480 probable glyoxalase/bleomycin resistance protein, dioxygenase superfamily +FIG01703547 two-component response regulator ResD +FIG01703589 bll4819; hypothetical protein +FIG01703598 Uncharacterized flavoprotein +FIG01703655 Arabinogalactan endo-1,4-beta-galactosidase( EC:3.2.1.89 ) +FIG01703696 FIG01119903: hypothetical protein +FIG01703771 Carboxyl esterase family II protein +FIG01703778 FIG01118153: hypothetical protein +FIG01703796 Generic methyltransferase +FIG01703843 ABC TRANSPORTER, ATP-BINDING PROTEIN +FIG01703876 FIG00522465: hypothetical protein +FIG01703882 B. burgdorferi predicted coding region BBB27 +FIG01703883 conserved protein, permease-related +FIG01703896 Smu13B +FIG01703897 hypothetical protein +FIG01703936 FIG00389097: hypothetical protein +FIG01704006 UpfB +FIG01704016 FIG00749960: hypothetical protein +FIG01704035 FIG00519154: hypothetical protein +FIG01704057 Aryldialkylphosphatase related protein +FIG01704081 FIG01019982: hypothetical protein +FIG01704092 DNA polymerase III, delta subunit (EC 2.7.7.7) +FIG01704103 pectate lyase L precursor +FIG01704112 DNA helicase II related protein +FIG01704146 Bacteriophage N4 adsorption protein B +FIG01704158 FIG00413032: hypothetical protein +FIG01704217 Opine oxidase subunit A (EC 1.-.-.-) +FIG01704223 YokH +FIG01704225 FIG00529792: hypothetical protein +FIG01704227 FIG00515516: hypothetical protein +FIG01704285 FIG00362222: hypothetical protein +FIG01704332 syc1928_d +FIG01704360 putative diguanylate cyclase +FIG01704423 FIG00767806: hypothetical protein +FIG01704450 Mlr0120 protein +FIG01704471 probable 3-oxoacyl-(acyl carrier protein) reductase +FIG01704575 FIG00760467: hypothetical protein +FIG01704586 FIG00642515: hypothetical protein +FIG01704593 N-6 DNA Methylase family +FIG01704595 Sodium/bile acid cotransporter family +FIG01704596 FIG00471403: hypothetical protein +FIG01704615 FIG00388303: hypothetical protein +FIG01704616 Glycosyltransferase +FIG01704622 putative endo-1,4-beta-xylanase +FIG01704632 possible ketosteroid isomerase-related protein +FIG01704635 sugar ABC transporter ATP-binding protein (UGPC) +FIG01704636 Possible signal peptide protein +FIG01704644 Predicted protein family PM-20 +FIG01704723 secretory protein YscJ/FliF family protein +FIG01704749 orf25 +FIG01704753 iron-sulphur protein +FIG01704757 FIG00762524: hypothetical protein +FIG01704793 Methylated-DNA--protein-cysteine methyltransferase +FIG01704794 TRm24 transposase +FIG01704796 hypothetical protein +FIG01704806 FIG01094268: hypothetical protein +FIG01704807 NADH oxidase (putative) +FIG01704859 FIG00623758: hypothetical protein +FIG01704901 processing protease +FIG01704910 probable adenylate kinase( EC:2.7.4.3 ) +FIG01704928 FIG01005414: hypothetical protein +FIG01704954 COG2391: Predicted transporter component +FIG01704996 COG0406: Fructose-2,6-bisphosphatase +FIG01705018 AgrC, putative +FIG01705019 phytoene dehydrogenase family +FIG01705035 hypothetical protein +FIG01705053 probable two-component system response regulator +FIG01705073 Type B carboxylesterase (EC 3.1.1.1) +FIG01705089 FIG01236055: hypothetical protein +FIG01705118 plantaricin biosynthesis protein PlnO +FIG01705161 FIG01057880: hypothetical protein +FIG01705210 Putative RNA methylase:THUMP +FIG01705214 Beta-lactamase class C +FIG01705308 phage replication protein O, putative +FIG01705309 FIG00675011: hypothetical protein +FIG01705317 syc1260_d +FIG01705345 succinate dehydrogenase, membrane subunit, putative +FIG01705358 transporter, membrane fusion protein (MFP) family +FIG01705519 FIG00521766: hypothetical protein +FIG01705555 putative branched-chain amino acid permease +FIG01705557 FIG00482109: hypothetical protein +FIG01705577 Putative ABC transport system, ATP-bidning protein +FIG01705590 predicted surface-layer protein +FIG01705676 sarcosine oxidase, subunit beta +FIG01705691 FIG01119885: hypothetical protein +FIG01705759 FIG00643296: hypothetical protein +FIG01705768 FIG01166067: hypothetical protein +FIG01705781 FIG00388940: hypothetical protein +FIG01705787 Putative integrase protein +FIG01705788 FIG00631216: hypothetical protein +FIG01705792 prophage ps3 protein 08 +FIG01705812 FIG00356155: hypothetical protein +FIG01705819 hypothetical protein +FIG01705834 FIG00388506: hypothetical protein +FIG01705839 FIG01045871: hypothetical protein +FIG01705853 FIG00624294: hypothetical protein +FIG01705895 FIG00424430: hypothetical protein +FIG01705915 FIG00734518: hypothetical protein +FIG01705938 Putative D-tagaturonate epimerase +FIG01705949 FIG01237263: hypothetical protein +FIG01705981 FIG00380133: hypothetical protein +FIG01706044 Oxidoreductase, C-terminal +FIG01706051 Small cold-shock protein +FIG01706056 Hsp33 disulfide bond chaperone +FIG01706069 FIG00745602: hypothetical protein +FIG01706110 Related to UspA stress proteins +FIG01706129 Sugar transferase +FIG01706130 probable aldehyde dehydrogenase( EC:1.2.1.- ) +FIG01706140 FIG01114617: hypothetical protein +FIG01706149 FIG00352555: hypothetical protein +FIG01706153 predicted porin protein +FIG01706192 FIG003955: protein of unknown function +FIG01706214 transcriptional regulator Hpr +FIG01706255 FIG00344839: hypothetical protein +FIG01706306 FIG00426986: hypothetical protein +FIG01706307 Restriction alleviation and modification enhancement protein +FIG01706316 putative phytoene dehydrogenase +FIG01706343 FIG00387904: hypothetical protein +FIG01706371 FIG00497967: hypothetical protein +FIG01706399 hypothetical permease +FIG01706423 Uncharacterized protein yxlC +FIG01706430 hypothetical protein +FIG01706444 FIG00848679: hypothetical protein +FIG01706460 FIG01203208: hypothetical protein +FIG01706487 Virulence factor mviN protein +FIG01706491 acetyl-coenzyme A synthetase +FIG01706562 FIG00412371: hypothetical protein +FIG01706598 FIG00820356: hypothetical protein +FIG01706603 Endoglucanase E precursor (EC 3.2.1.4) (EgE) (Endo-1,4-beta-glucanase E) (Cellulase E) +FIG01706628 rod shape-determining-related protein +FIG01706635 Sensor histidine kinase CiaH +FIG01706665 FIG00388855: hypothetical protein +FIG01706674 SN-glycerol-3-phosphate transport system permease protein UgpA (TC 3.A.1.1.3) +FIG01706714 FIG00513739: hypothetical protein +FIG01706729 NodF acyl carrier protein +FIG01706739 FIG00414346: hypothetical protein +FIG01706758 beta-glucanase precursor +FIG01706768 FIG01089567: hypothetical protein +FIG01706780 FIG00733631: hypothetical protein +FIG01706800 FIG00352685: hypothetical protein +FIG01706815 FIG01116920: hypothetical protein +FIG01706837 histone protein +FIG01706851 FIG01217146: hypothetical protein +FIG01706853 FIG00951473: hypothetical protein +FIG01706903 redoxin domain protein +FIG01706906 FIG00416734: hypothetical protein +FIG01706943 Possible membrane protein +FIG01706959 ABC transport protein, Solute-binding component +FIG01706972 FIG00521966: hypothetical protein +FIG01706993 putative 3-oxoacyl-ACP synthase III +FIG01706997 Mlr6185 protein +FIG01706998 transcriptional regulator, tetR family, putative +FIG01707124 Sll0563 protein +FIG01707153 hypothetical protein Sden_1896 +FIG01707169 FIG00982629: hypothetical protein +FIG01707200 protein of unknown function DUF1684 +FIG01707280 protein of unknown function UPF0089 +FIG01707301 Sll1532 protein +FIG01707308 Xanthosine triphosphate pyrophosphatase +FIG01707347 FIG00623835: hypothetical protein +FIG01707369 Endoglucanase 4 (EC 3.2.1.4) (Endoglucanase IV) (Endo-1,4-beta-glucanase 4) (Cellulase 4) (EG-IV) +FIG01707373 FIG00524149: hypothetical protein +FIG01707390 deoxycytidylate deaminase +FIG01707397 transposase in ISPg1 +FIG01707409 PROBABLE LIPOPROTEIN LPQA +FIG01707411 probable PTS system, fructose-specific IIABC component +FIG01707413 IS110 family transposase +FIG01707448 FIG00624103: hypothetical protein +FIG01707460 M50 metallopeptidase +FIG01707490 FIG01205040: hypothetical protein +FIG01707495 FIG00450495: hypothetical protein +FIG01707511 FIG00402804: hypothetical protein +FIG01707526 surface proteins containing Ig-like domains-like +FIG01707531 Transcriptional regulator MerR +FIG01707613 autotransporter +FIG01707628 conserved hypothetical protein-putative membrane associated protein +FIG01707658 FIG00733328: hypothetical protein +FIG01707697 FIG00530007: hypothetical protein +FIG01707710 FIG00675428: hypothetical protein +FIG01707712 Platelet-activating factor acetylhydrolase, plasma/intracellular isoform II +FIG01707717 stage II sporulation protein AA +FIG01707722 hypothetical protein +FIG01707767 FIG00353281: hypothetical protein +FIG01707788 FIG00642687: hypothetical protein +FIG01707828 platelet activating factor, putative +FIG01707838 FIG00850888: hypothetical protein +FIG01707850 hypothetical protein +FIG01707859 FIG00687588: hypothetical protein +FIG01708016 FIG00754679: hypothetical protein +FIG01708021 nitrogen metabolism transcriptional regulator, NtrC, Fis Family +FIG01708024 FIG01226570: hypothetical protein +FIG01708066 FIG01116220: hypothetical protein +FIG01708098 FIG00408368: hypothetical protein +FIG01708116 FIG00388919: hypothetical protein +FIG01708149 MxaK protein, putative +FIG01708166 COG0483: Archaeal fructose-1,6-bisphosphatase and related enzymes of inositol monophosphatase family +FIG01708170 COG1783: Phage terminase large subunit +FIG01708266 TetR-family protein transcriptional regulator +FIG01708280 ABC transporter, periplasmic oligopeptide-binding protein +FIG01708305 Acyl-CoA dehydrogenase (EC 1.3.8.1), Mycobacterial subgroup FadE26 +FIG01708339 GumJ protein +FIG01708347 FIG00951303: hypothetical protein +FIG01708353 FIG00641158: hypothetical protein +FIG01708401 Putative GTPases (G3E family)-like +FIG01708416 FIG01234929: hypothetical protein +FIG01708487 FIG01214635: hypothetical protein +FIG01708524 acylglycerophosphoethanolamine acyltransferase( EC:6.2.1.20 ) +FIG01708679 FIG00768486: hypothetical protein +FIG01708686 hypothetical type I restriction enzyme restriction subunit +FIG01708695 FIG00734430: hypothetical protein +FIG01708739 FIG00624430: hypothetical protein +FIG01708779 Phosphomannomutase (EC 5.4.2.8) (PMM) +FIG01708782 Predicted extracellular nuclease +FIG01708806 FIG00527102: hypothetical protein +FIG01708807 Putative transmembrane oxidoreductase +FIG01708851 hypothetical protein +FIG01708923 Multicopper oxidase type 1 +FIG01708969 putative transformylase +FIG01709010 hydrolase, isochorismatase family +FIG01709033 Threonyl-tRNA synthetase (EC 6.1.1.3) +FIG01709055 FIG01240183: hypothetical protein +FIG01709122 FIG01040514: hypothetical protein +FIG01709179 phage tail tape measure protein, family +FIG01709215 Alkaline protease precursor (EC 3.4.21.-) +FIG01709220 YfaZ family protein +FIG01709228 Magnesium chelatase subunit I +FIG01709232 FIG00675007: hypothetical protein +FIG01709247 L-malyl-CoA/beta-methylmalyl-CoA lyase (EC 4.1.3.-), actinobacterial type +FIG01709248 FIG00818201: hypothetical protein +FIG01709266 FIG00454828: hypothetical protein +FIG01709267 FIG00385654: hypothetical protein +FIG01709443 FIG00520831: hypothetical protein +FIG01709460 FIG00624470: hypothetical protein +FIG01709485 Glutamine amidotransferase class-I( EC:6.3.5.2 ) +FIG01709565 FIG00443271: hypothetical protein +FIG01709575 FIG00349061: hypothetical protein +FIG01709581 CylX +FIG01709600 FIG00623905: hypothetical protein +FIG01709625 transcriptional regulator, TetR family domain protein +FIG01709636 FIG00687567: hypothetical protein +FIG01709650 Amidases related to nicotinamidase +FIG01709652 FIG01116537: hypothetical protein +FIG01709696 Hypothetical protein, CF-31 family +FIG01709709 FIG00624473: hypothetical protein +FIG01709713 putative flavoredoxin +FIG01709733 FIG00526082: hypothetical protein +FIG01709750 secreted chitin binding protein +FIG01709775 putative dienelactone hydrolase family protein +FIG01709796 FIG01240679: hypothetical protein +FIG01709821 similar to Uncharacterized protein potentially involved in peptidoglycan biosynthesis +FIG01709852 transport-associated protein +FIG01709964 FIG00516387: hypothetical protein +FIG01709972 syc0403_d +FIG01710105 FIG00836718: hypothetical protein +FIG01710134 SCP1.204c, unknown, len: 553aa +FIG01710138 FIG00712483: hypothetical protein +FIG01710151 Possible NADH-Ubiquinone/plastoquinone +FIG01710163 putative protein-tyrosine-phosphatase +FIG01710201 Uncharacterized secreted protein, containing cell adhesion domain +FIG01710220 Membrane associated GGDEF domain containing protein +FIG01710242 molybdopterin-guanine dinucleotide biosynthesis protein +FIG01710272 FIG01026577: hypothetical protein +FIG01710313 FIG00437354: hypothetical protein +FIG01710356 Putative cytochrome P450 172A1 +FIG01710403 FIG00363731: hypothetical protein +FIG01710433 Smp-like protein +FIG01710452 FIG01289895: hypothetical protein +FIG01710472 hypothetical protein +FIG01710481 possible amino terminal protease +FIG01710509 photosystem II reaction center protein PsbI +FIG01710581 FIG00633399: hypothetical protein +FIG01710583 intracellular protease, PfpI family +FIG01710592 putative lytic transglycosylase +FIG01710640 transposase IS2020, hypothetical +FIG01710675 ISPg6, transposase +FIG01710679 Bll4432 protein +FIG01710730 FIG01204242: hypothetical protein +FIG01710832 MMPL +FIG01710838 Alpha 1 type I collagen +FIG01711034 Outer membrane fimbrial usher porin precursor +FIG01711106 hypothetical lysozyme +FIG01711165 aminopeptidase N( EC:3.4.11.2 ) +FIG01711187 FIG00861229: hypothetical protein +FIG01711226 Tetrahydromethanopterin S-methyltransferase subunit A (EC 2.1.1.86) homolog +FIG01711254 sarcosine oxidase subunit beta +FIG01711288 FIG00389069: hypothetical protein +FIG01711368 phospholipase/carboxylesterase +FIG01711394 FIG00643154: hypothetical protein +FIG01711415 hypothetical protein +FIG01711417 probable secretion system protein +FIG01711425 Uncharacterized protein aq_113 precursor +FIG01711455 Putative DNA-binding response regulator +FIG01711470 possible phage integrase +FIG01711504 FIG00563571: hypothetical protein +FIG01711512 FIG00415292: hypothetical protein +FIG01711535 Nif-specific regulatory protein +FIG01711546 WbbB +FIG01711549 Probable ECF-like sigma factor SigE +FIG01711557 Bile acid 7-alpha dehydratase (EC 4.2.1.106) +FIG01711567 RelE/StbE replicon stabilization toxin +FIG01711569 primase, putative +FIG01711613 FIG00933601: hypothetical protein +FIG01711624 FIG00344658: hypothetical protein +FIG01711657 FIG016425: Soluble lytic murein transglycosylase and related regulatory proteins (some contain LysM/invasin domains) +FIG01711664 FIG00559154: hypothetical protein +FIG01711711 FIG00362816: hypothetical protein +FIG01711723 prostaglandin-endoperoxide synthase 2 +FIG01711731 FIG00343847: hypothetical protein +FIG01711755 hypothetical protein +FIG01711761 dnaJ/dnaK assembly factor dafA +FIG01711797 FIG00624429: hypothetical protein +FIG01711883 FIG01116040: hypothetical protein +FIG01711935 Lipopolysaccharide biosynthesis proteins, LPS:glycosyltransferases +FIG01711953 FIG00388693: hypothetical protein +FIG01711970 PUTATIVE TRIMETHYLAMINE METHYLTRANSFERASE PROTEIN +FIG01712008 dihydroxyacetone kinase family protein +FIG01712013 uncharacterized iron-regulated protein +FIG01712040 FIG00630368: hypothetical protein +FIG01712059 putative dioxygenase component +FIG01712074 probable lipoprotein NlpC +FIG01712112 acyl-CoA dehydrogenase protein +FIG01712197 FIG01187668: hypothetical protein +FIG01712274 FIG00360287: hypothetical protein +FIG01712283 uncharacterized conserved protein, YitT family +FIG01712345 FIG00826134: hypothetical protein +FIG01712361 Forkhead-associated protein +FIG01712441 FIG00344827: hypothetical protein +FIG01712446 Surface array protein +FIG01712483 FIG00627450: hypothetical protein +FIG01712503 putative HTH-type transcriptional regulator YezE +FIG01712579 putative signal transduction protein with Nacht domain +FIG01712600 GLP_28_74910_75575 +FIG01712622 FIG00833958: hypothetical protein +FIG01712664 FIG00363360: hypothetical protein +FIG01712665 Phosphomannomutase( EC:5.4.2.8 ) +FIG01712711 DNA-binding response regulator AgmR +FIG01712719 putative membrane bound metalloprotease +FIG01712788 secreted peptidase +FIG01712793 possible anti-sigma factor +FIG01712805 FIG00467857: hypothetical protein +FIG01712812 FIG00556772: hypothetical protein +FIG01712826 hypothetical protein +FIG01712842 FIG01020056: hypothetical protein +FIG01712846 hypothetical protein +FIG01712865 FIG00414833: hypothetical protein +FIG01712873 Peptide synthetase +FIG01712886 type IV secretory pathway VirB3 +FIG01712888 putative threonine efflux protein +FIG01712909 FIG00641908: hypothetical protein +FIG01712922 FIG01047293: hypothetical protein +FIG01712985 FIG00380485: hypothetical protein +FIG01712987 IncF plasmid conjugative transfer pilus assembly protein TraU +FIG01713023 FIG00351751: hypothetical protein +FIG01713033 type IIS restriction enzyme M2 protein (mod) +FIG01713058 putative lipoprotein L +FIG01713086 putative drug transport transmembrane protein +FIG01713125 syc0821_c +FIG01713141 FIG00711365: hypothetical protein +FIG01713158 possible sensor with HAMP domain +FIG01713203 FIG00417103: hypothetical protein +FIG01713207 FIG01203726: hypothetical protein +FIG01713255 FIG00765241: hypothetical protein +FIG01713285 FIG00363348: hypothetical protein +FIG01713312 FIG00451485: hypothetical protein +FIG01713432 FIG00388072: hypothetical protein +FIG01713481 FIG00543892: hypothetical protein +FIG01713513 FIG00623841: hypothetical protein +FIG01713583 FIG00752117: hypothetical protein +FIG01713606 putative regulatory protein, FmdB family +FIG01713608 FG-GAP repeat-containing protein +FIG01713637 FIG00950030: hypothetical protein +FIG01713689 XkdM protein +FIG01713716 FIG00763217: hypothetical protein +FIG01713746 Protein of unknown function DUF1626 +FIG01713797 FIG00463731: hypothetical protein +FIG01713841 FIG01243739: hypothetical protein +FIG01713856 putative FMNH2-utilizing oxygenase +FIG01713873 syc0742_d +FIG01713876 Hypothetical protein ycgF +FIG01713903 Flagellar protein flgJ [peptidoglycan hydrolase] (EC 3.2.1.-) +FIG01713904 iron-sulfur flavoprotein, putative +FIG01713933 RIBONUCLEASE PRECURSOR +FIG01713942 FIG00272123: hypothetical protein +FIG01713961 probable benzoylformate decarboxylase (EC 4.1.1.7) +FIG01713967 Collagen alpha-2(I) chain precursor (Alpha-2 type I collagen) +FIG01713973 protein of unknown function DUF899,thioredoxin-like +FIG01714006 FIG01119624: hypothetical protein +FIG01714042 Phi Mu50B-like protein +FIG01714047 FIG039786: hypothetical protein +FIG01714069 basic protein +FIG01714073 Transglutaminase-like precursor +FIG01714120 TprB +FIG01714125 Putative siderophore biosynthesis protein, HpcH/HpaI aldolase family +FIG01714140 FIG00755510: hypothetical protein +FIG01714202 spore germination B3 GerAC like +FIG01714270 hypothetical protein +FIG01714302 FIG00407277: hypothetical protein +FIG01714342 FIG00747971: hypothetical protein +FIG01714371 Ferric iron-binding periplasmic protein HitA +FIG01714401 hypothetical protein +FIG01714452 FIG00693375: hypothetical protein +FIG01714482 FIG00999730: hypothetical protein +FIG01714530 FIG00388902: hypothetical protein +FIG01714578 probable dolichyl-phosphate mannose synthase( EC:2.4.1.83 ) +FIG01714610 Phage protein gp18 +FIG01714614 Integrase core domain +FIG01714628 FIG00193234: hypothetical protein +FIG01714642 Nickel-transporting ATPase +FIG01714656 hypothetical protein +FIG01714658 hypothetical protein +FIG01714673 ABC transporter, periplasmic binding-protein +FIG01714681 FIG00348963: hypothetical protein +FIG01714727 Phage protein gp19 +FIG01714760 FIG01199131: hypothetical protein +FIG01714794 permease, possibly an amine +FIG01714796 FIG00344661: hypothetical protein +FIG01714799 FIG00827442: hypothetical protein +FIG01714852 Integrase, catalytic region (EC 2.7.7.49) +FIG01714862 Protein of unknown function DUF523 +FIG01714887 FIG00526415: hypothetical protein +FIG01714888 permease protein of sugar ABC transporter +FIG01714907 FIG01249332: hypothetical protein +FIG01714962 FIG00363022: hypothetical protein +FIG01715028 Hemin binding protein a +FIG01715049 Alkaline serine protease II +FIG01715103 FIG00518344: hypothetical protein +FIG01715106 Probable O-antigen polymerase +FIG01715132 MazG nucleotide pyrophosphohydrolase domain protein +FIG01715136 FIG00414257: hypothetical protein +FIG01715180 COG0234: Co-chaperonin GroES (HSP10) +FIG01715206 dienelactone hydrolase domain protein +FIG01715243 EbsC protein +FIG01715249 FIG01244405: hypothetical protein +FIG01715288 putative transposase for insertion sequence NGRIS-12c +FIG01715369 FIG00631239: hypothetical protein +FIG01715380 FIG01118971: hypothetical protein +FIG01715416 FIG01024482: hypothetical protein +FIG01715441 FIG00527578: hypothetical protein +FIG01715471 transcriptional regulator MerR family +FIG01715483 possible CapK protein +FIG01715489 S-adenosylmethionine decarboxylase proenzyme (EC 4.1.1.50) +FIG01715507 Putative glycosyltransferase involved in O-methyl phosphoramidate capsule modification +FIG01715524 FIG01128527: hypothetical protein +FIG01715534 protease IV (signal peptide peptidase)( EC:3.4.21.- ) +FIG01715587 Probable 3-demethylubiquinone-9 3-methyltransferase (EC 2.1.1.64) +FIG01715636 endopeptidase Clp ATP-binding chain +FIG01715638 FIG00961133: hypothetical protein +FIG01715678 beta lactamase precursor +FIG01715710 DNA topoisomerase I +FIG01715713 Alternative oxidase 2, mitochondrial precursor (EC 1.-.-.-) +FIG01715739 lipid, fatty-acid and isoprenoid metabolism +FIG01715754 FIG00624453: hypothetical protein +FIG01715766 putative type I restriction-modification system methylase +FIG01715774 putative sporulation protein YtaF +FIG01715827 Serine/threonine kinase PKN8 +FIG01715837 FIG00415081: hypothetical protein +FIG01715912 FIG00816027: hypothetical protein +FIG01715938 FIG00838595: hypothetical protein +FIG01715955 Predicted mannuronate transporter +FIG01715969 putative Rz1 lytic protein +FIG01715982 FIG00623333: hypothetical protein +FIG01716012 hypothetical protein +FIG01716086 putative guanylate kinase +FIG01716105 Vitamin K epoxide reductase family +FIG01716142 Uncharacterized protein aq_1029 +FIG01716152 FIG01191081: hypothetical protein +FIG01716157 FIG00351137: hypothetical protein +FIG01716178 FIG00600940: hypothetical protein +FIG01716260 Sodium ABC transporter ATP-binding protein +FIG01716350 HSCARG +FIG01716401 Hypothetical protein MW1780 +FIG01716411 ortholog of Bordetella pertussis (BX470248) BP2243 +FIG01716442 bacterial pre-peptidase C-terminal domain protein +FIG01716470 molybdenum-binding protein +FIG01716478 hypothetical protein +FIG01716505 FIG01166554: hypothetical protein +FIG01716524 FIG00530660: hypothetical protein +FIG01716545 ABC transporter, substrate binding protein [amino acid] +FIG01716550 Helix-turn-helix, AraC type:AraC protein, arabinose-binding/dimerisation:Cupin region +FIG01716557 FIG00364741: hypothetical protein +FIG01716562 Phage antirepressor +FIG01716581 ABC-2 transporter, permease protein +FIG01716590 FIG00409872: hypothetical protein +FIG01716613 succinate-semialdehyde dehydrogenase +FIG01716629 protein C +FIG01716656 FIG00259293: hypothetical protein +FIG01716674 protein of unknown function DUF456 +FIG01716709 FIG01062327: hypothetical protein +FIG01716763 prophage ps2 protein 02 +FIG01716804 carotenogenesis protein CarR +FIG01716855 FIG00578782: hypothetical protein +FIG01716860 putative sulfatase membrane protein +FIG01716869 FIG01245737: hypothetical protein +FIG01716870 potassium channel TrkA variant +FIG01716896 Putative RNA-binding protein rbpF +FIG01716908 FIG00389766: hypothetical protein +FIG01716945 FIG00643232: hypothetical protein +FIG01716947 outer membrane protein, OMP85 family +FIG01717003 FIG00344457: hypothetical protein +FIG01717046 hypothetical protein +FIG01717057 bacterial surface protein +FIG01717067 putative 4-oxalocrotonate tautomerase( EC:5.3.2.- ) +FIG01717102 FIG00417592: hypothetical protein +FIG01717163 homolog to dolichol kinase +FIG01717187 putative small heat shock protein +FIG01717217 All4644 protein +FIG01717227 Serine-Carboxyl Peptidase( EC:3.4.21.- ) +FIG01717341 FIG01127943: hypothetical protein +FIG01717345 FIG00530784: hypothetical protein +FIG01717369 FIG00742765: hypothetical protein +FIG01717422 hydrolase, alpha/beta hydrolase fold family, putative +FIG01717424 RodA protein homolog +FIG01717484 Adhesin aidA-I precursor +FIG01717520 Predicted soluble lytic transglycosylase fused to an ABC-type amino acid-binding protein +FIG01717523 possible glutamine amidotransferase +FIG01717549 related to F420H2-dehydrogenase, beta subunit +FIG01717573 abortive infection protein AbiGI +FIG01717600 SIMILARITY TO mviN PROTEIN +FIG01717618 putative Streptomyces subtilisin inhibitor-like protein +FIG01717631 FIG01240025: hypothetical protein +FIG01717635 FIG00815547: hypothetical protein +FIG01717666 Gll0561 protein +FIG01717755 IS1381, transposase OrfA +FIG01717801 putative two-component regulator with metal-dependent phosphohydrolase, HD region +FIG01717816 FIG01093382: hypothetical protein +FIG01717854 helix-turn-helix- domain containing protein, AraC type +FIG01717859 AtsB +FIG01717863 FIG00531061: hypothetical protein +FIG01717869 Uncharacterized Zn-dependent hydrolase MJ0888 +FIG01717905 FIG00385056: hypothetical protein +FIG01717924 N-ethylammeline chlorohydrolase +FIG01717971 A. fulgidus predicted coding region AF1182 +FIG01718077 FIG01128447: hypothetical protein +FIG01718113 Peptidyl-prolyl cis-trans isomerase( EC:5.2.1.8 ) +FIG01718146 FIG00520107: hypothetical protein +FIG01718185 FIG00623974: hypothetical protein +FIG01718203 FIG01232926: hypothetical protein +FIG01718207 FIG00405472: hypothetical protein +FIG01718310 FIG00385635: hypothetical protein +FIG01718313 FIG00415953: hypothetical protein +FIG01718317 FIG01081909: hypothetical protein +FIG01718332 Uncharacterized protein MJ0213 +FIG01718395 Uncharacterized protein yoeB precursor +FIG01718421 substrate-binding protein, putative +FIG01718461 ABC transporter binding protein component +FIG01718470 FIG01083120: hypothetical protein +FIG01718473 FIG00517606: hypothetical protein +FIG01718485 FIG00349139: hypothetical protein +FIG01718548 FIG00733185: hypothetical protein +FIG01718568 Inorganic pyrophosphatase/exopolyphosphatase +FIG01718591 FIG00814468: hypothetical protein +FIG01718630 SpnM +FIG01718638 Periplasmic amino acid-binding protein of amino acid ABC transporter +FIG01718651 FIG00361869: hypothetical protein +FIG01718683 FIG00698279: hypothetical protein +FIG01718686 FIG00363715: hypothetical protein +FIG01718688 FIG00675102: hypothetical protein +FIG01718748 thermostable beta-glucosidase B +FIG01718753 sporulation protein SpoIID +FIG01718761 VirG-like two component response regulator +FIG01718778 FIG01202594: hypothetical protein +FIG01718808 TrwC protein +FIG01718809 tetratricopeptide domain protein +FIG01718820 Regulatory protein betI +FIG01718901 FIG00388728: hypothetical protein +FIG01718909 FIG00525662: hypothetical protein +FIG01718913 putative signal transduction protein with CBS domains +FIG01718922 hypothetical acetyltransferase +FIG01718935 response regulator BlpR , putative +FIG01718936 FIG01117137: hypothetical protein +FIG01718938 small acid-soluble spore protein Tlp +FIG01718946 FIG01135143: hypothetical protein +FIG01719012 FIG01060708: hypothetical protein +FIG01719068 MANNOSYLTRANSFERASE (EC 2.4.1.-) +FIG01719072 AsmA family superfamily +FIG01719087 FIG00353913: hypothetical protein +FIG01719106 FIG00388106: hypothetical protein +FIG01719136 H-NS histone family protein +FIG01719182 FIG00352017: hypothetical protein +FIG01719185 flavocytochrome C sulfide dehydrogenase +FIG01719186 FIG00272463: hypothetical protein +FIG01719190 FIG00352331: hypothetical protein +FIG01719204 UPF0331 protein MA_1296 +FIG01719232 FIG00344465: hypothetical protein +FIG01719296 Uncharacterized protein MJ1021 +FIG01719356 Peptidylprolyl isomerase +FIG01719363 ABC-type transporter, permease component: POPT family +FIG01719385 UPF0236 protein TTE2489 +FIG01719420 glucose-6-phosphate isomerase( EC:5.3.1.9 ) +FIG01719430 FIG00414796: hypothetical protein +FIG01719481 FIG00763220: hypothetical protein +FIG01719498 NrfF +FIG01719520 site-specific recombinases +FIG01719550 glutamate--cysteine ligase, putative, truncated +FIG01719604 Inorganic pyrophosphatase/exopolyphosphatase +FIG01719667 Acetyltransferase( EC:2.3.1.79 ) +FIG01719682 FIG00411473: hypothetical protein +FIG01719710 ccdc protein +FIG01719716 Pseudogene of Conserved hypothetical protein(C-terminal part) +FIG01719767 FIG00364037: hypothetical protein +FIG01719794 putative ribosomal-protein-serine acetyltransferase +FIG01719796 FIG00631609: hypothetical protein +FIG01719803 Type 4 pilus biogenesis operon protein +FIG01719813 homocysteine S-methyltransferase domain protein +FIG01719864 Transposase and inactivated derivatives +FIG01719920 Secreted metal-dependent hydrolase, amidohydrolase family +FIG01719954 No significant database matches. Doubtful CDS +FIG01719971 FIG00876210: hypothetical protein +FIG01720084 FIG00581870: hypothetical protein +FIG01720101 FIG00816980: hypothetical protein +FIG01720166 FIG01093419: hypothetical protein +FIG01720190 FIG00632201: hypothetical protein +FIG01720209 Glutaredoxin-like protein, YruB +FIG01720214 transcription regulator (AraC/XylS family) +FIG01720354 COG1376: Uncharacterized protein conserved in bacteria +FIG01720361 Modification methylase HgaIB (EC 2.1.1.37) (Cytosine-specific methyltransferase HgaIB) (M.HgaIB) (M.HgaI-2) +FIG01720423 FIG00623523: hypothetical protein +FIG01720425 Mn-dependent transcriptional regulator MntR; Zn-dependent transcriptional regulator TroR +FIG01720440 FIG01119530: hypothetical protein +FIG01720445 probable nucleotide pyrophosphatase-like protein +FIG01720462 FIG00622880: hypothetical protein +FIG01720465 FIG00764077: hypothetical protein +FIG01720473 putative N-oxidase +FIG01720475 FIG00688289: hypothetical protein +FIG01720512 Amidase, related to GSP of E.coli +FIG01720513 putative dopa decarboxylase protein remnant +FIG01720523 FIG01117338: hypothetical protein +FIG01720557 Nedd4 binding protein 2 +FIG01720571 FIG00873794: hypothetical protein +FIG01720606 FIG01181470: hypothetical protein +FIG01720622 Virulence-associated protein C +FIG01720628 FIG00515926: hypothetical protein +FIG01720676 putative HIT family hydrolase +FIG01720678 FIG00624840: hypothetical protein +FIG01720685 Capsular polysaccharide synthesis enzyme CpsF, glycosyltransferase +FIG01720689 CaiB/BaiF family protein +FIG01720721 FIG00349902: hypothetical protein +FIG01720789 FIG00835566: hypothetical protein +FIG01720814 FIG00451821: hypothetical protein +FIG01720867 Transcriptional Regulator, TetR family +FIG01720903 Uncharacterized protein TP_0007 +FIG01720923 TsaC protein (YrdC domain) required for threonylcarbamoyladenosine t(6)A37 modification in tRNA / Low molecular weight protein tyrosine phosphatase (EC 3.1.3.48) +FIG01720937 LGFP +FIG01720965 Tll0889 protein +FIG01720984 nitroreductase-like +FIG01721001 FIG00423906: hypothetical protein +FIG01721060 predicted secreted protein +FIG01721063 FIG00472107: hypothetical protein +FIG01721101 TfoX domain protein, putative +FIG01721104 FIG00644188: hypothetical protein +FIG01721106 YmcC +FIG01721188 nickel-dependent hydrogenases B-type cytochrome subunit family +FIG01721235 Protein fanF precursor +FIG01721290 FIG00519217: hypothetical protein +FIG01721305 conserved domain protein +FIG01721323 FIG00623497: hypothetical protein +FIG01721413 FIG00356146: hypothetical protein +FIG01721444 Kinesin-related protein K4 +FIG01721448 transposition helper protein +FIG01721481 FIG01117716: hypothetical protein +FIG01721489 FIG00426753: hypothetical protein +FIG01721506 FIG00347619: hypothetical protein +FIG01721528 FIG01228619: hypothetical protein +FIG01721585 Nikkomycin biosynthesis protein, carboxylase +FIG01721597 Mlr6561 protein +FIG01721629 FIG01029278: hypothetical protein +FIG01721640 FIG00510943: hypothetical protein +FIG01721685 Immunogenic protein +FIG01721692 Acetamidase/Formamidase +FIG01721762 hypothetical protein +FIG01721781 FIG00733229: hypothetical protein +FIG01721788 FIG00532141: hypothetical protein +FIG01721845 FIG00624301: hypothetical protein +FIG01721861 Bll0405 protein +FIG01721864 Upf93.6 +FIG01721892 FIG00404209: hypothetical protein +FIG01721899 IS911 transposase orfB +FIG01721908 FIG00468881: hypothetical protein +FIG01721978 4-coumarate--CoA ligase (EC 6.2.1.12) +FIG01722078 FIG01099978: hypothetical protein +FIG01722166 lysophospholipases-like protein +FIG01722178 FIG00523474: hypothetical protein +FIG01722185 FIG01189781: hypothetical protein +FIG01722196 deoxyribose-phosphate aldolase/phospho-2-dehydro-3-deoxyheptonate aldolase +FIG01722201 Possible epoxide hydrolase +FIG01722245 FIG00385447: hypothetical protein +FIG01722264 Antibiotic efflux protein +FIG01722297 phosphotriesterase-family protein +FIG01722300 Uncharacterized conserved membrane protein +FIG01722301 H+/citrate symporter +FIG01722377 WbuO +FIG01722441 putative transcriptional regulator, AraC family +FIG01722472 FIG00385782: hypothetical protein +FIG01722508 FIG00754265: hypothetical protein +FIG01722542 probable arabinosyltransferase B( EC:2.4.2.- ) +FIG01722602 hypothetical protein +FIG01722695 FIG01253599: hypothetical protein +FIG01722710 Integral membrane protein for chromosome condensation +FIG01722783 FIG00589690: hypothetical protein +FIG01722788 hypothetical protein +FIG01723037 FIG01239964: hypothetical protein +FIG01723043 FIG00346599: hypothetical protein +FIG01723107 regulatory protein LuxR +FIG01723150 Calcium binding protein +FIG01723194 AT hook motif domain protein +FIG01723220 serine/threonine kinase PKN11 +FIG01723226 FIG00961232: hypothetical protein +FIG01723282 FIG00347438: hypothetical protein +FIG01723302 PUTATIVE TETR-FAMILY TRANSCRIPTIONAL REGULATOR +FIG01723340 FIG00242367: hypothetical protein +FIG01723400 FIG01124592: hypothetical protein +FIG01723459 FIG00766086: hypothetical protein +FIG01723476 FIG00742905: hypothetical protein +FIG01723477 Type IIA topoisomerase, A subunit +FIG01723496 FIG00580138: hypothetical protein +FIG01723544 FIG01115666: hypothetical protein +FIG01723553 ATPase related to the helicase subunit of the Holliday junction resolvase +FIG01723556 protein of unknown function DUF1540 +FIG01723565 FIG00514450: hypothetical protein +FIG01723570 carbohydrate binding family 25 +FIG01723572 FIG00387923: hypothetical protein +FIG01723573 Probable L-amino-acid oxidase (EC 1.4.3.2) +FIG01723673 Export protein +FIG01723760 hypothetical membrane protein, conserved +FIG01723775 Succinate dehydrogenase( EC:1.3.99.1 ) +FIG01723790 FIG01220095: hypothetical protein +FIG01723798 FIG00673988: hypothetical protein +FIG01723867 mannose-1-phosphate guanylyltransferase/mannose-6-phosphate isomerase( EC:2.7.7.22 ) +FIG01723897 Bacteriocin uviB precursor +FIG01723987 Protein EspG3, component of Type VII secretion system ESX-3 +FIG01724000 FIG00406340: hypothetical protein +FIG01724004 toxin protein +FIG01724035 Cl- channel, voltage gated +FIG01724102 FIG00406747: hypothetical protein +FIG01724140 Uncharacterized protein MJ0067 +FIG01724180 FIG01122737: hypothetical protein +FIG01724185 FIG00350897: hypothetical protein +FIG01724239 FIG00356320: hypothetical protein +FIG01724306 Prolidase (Xaa-Pro dipeptidase) (PepQ-like3) (EC 3.4.13.9) +FIG01724333 Dyp-type peroxidase +FIG01724334 Sugar transport related protein +FIG01724341 FIG00361940: hypothetical protein +FIG01724377 Cellobiose phosphotransferase system YdjC-like protein +FIG01724411 DNA/RNA helicase of DEAD/DEAH box family +FIG01724446 Protein of unknown function DUF486 +FIG01724449 Probable nicotianamine synthase 3 (EC 2.5.1.43) (S-adenosyl-L-methionine:S-adenosyl-L-methionine:S-adenosyl-methionine 3-amino-3-carboxypropyltransferase 3) (HvNAS3) +FIG01724453 20-beta-hydroxysteroid dehydrogenase +FIG01724459 FIG01240914: hypothetical protein +FIG01724469 FIG00389204: hypothetical protein +FIG01724487 Inosine-5-monophosphate dehydrogenase +FIG01724490 COGs COG1502 +FIG01724495 FIG00347986: hypothetical protein +FIG01724506 FIG00952192: hypothetical protein +FIG01724567 Type IV pilin PilA +FIG01724594 FIG00648790: hypothetical protein +FIG01724602 transcriptional regulator, ArsR family protein +FIG01724669 Mll4364 protein +FIG01724695 Glycosyl transferase, family 2, YwdF +FIG01724699 FIG01128089: hypothetical protein +FIG01724702 FIG00408976: hypothetical protein +FIG01724707 3-ketosteroid-delta1-dehydrogenase +FIG01724801 FIG00762974: hypothetical protein +FIG01724807 FIG01047270: hypothetical protein +FIG01724820 FIG00623491: hypothetical protein +FIG01724821 FIG00764301: hypothetical protein +FIG01724838 FIG00389032: hypothetical protein +FIG01724857 bll6811; hypothetical protein +FIG01724878 Regulatory protein dnrI +FIG01724896 Stress-responsive transcription regulator +FIG01724911 hypothetical protei +FIG01724975 2,5-dichlorohydroquinone reductive dechlorinase (EC 2.5.1.-) +FIG01724977 protein containing DUF1559 +FIG01724988 (MTCY24G1.02), len: 496 aa, Probable polyketide synthase, almost identical to G560508 PKS002B (495 aa), fasta scores, opt: 3270, E(): 0, (99.6% identity in 496 aa overlap); contains PS00606 Beta-ketoacyl synthases active site; similar to MTCY338.20 (49.9% identity in 465 aa overlap) and MTCY24G1.09 (50.2% identity in 454 aa overlap) and MTCY22H8.03 (47.6% identity in 437 aa overlap) +FIG01725023 FIG00873658: hypothetical protein +FIG01725033 COGs COG0439 +FIG01725057 Zn-dependent hydrolases, glyoxylase family +FIG01725102 FIG00498943: hypothetical protein +FIG01725106 FIG00747900: hypothetical protein +FIG01725169 FIG00672539: hypothetical protein +FIG01725188 FIG01032221: hypothetical protein +FIG01725204 FIG00352920: hypothetical protein +FIG01725206 Cytolysin secretion protein +FIG01725217 probable thioesterase( EC:3.1.2.23 ) +FIG01725237 FIG00817022: hypothetical protein +FIG01725314 hypothetical protein +FIG01725328 4-hydroxybenzoate octaprenyltransferase, putative +FIG01725329 kilA protein, putative phage-related DNA binding protein +FIG01725339 putative ABC transporter ATP-binding protein( EC:3.6.3.- ) +FIG01725361 mucin-associated surface protein (MASP), putative +FIG01725378 FIG00495706: hypothetical protein +FIG01725393 Flagelliform silk protein (Fragment) +FIG01725486 putative transporter component +FIG01725521 FIG01032494: hypothetical protein +FIG01725524 3-oxoacyl-[acyl-carrier-protein] reductase( EC:1.1.1.100 ) +FIG01725650 Major type 1 subunit fimbrin +FIG01725666 FIG00953174: hypothetical protein +FIG01725667 FIG00712326: hypothetical protein +FIG01725693 FIG00897769: hypothetical protein +FIG01725706 erythromycin esterase +FIG01725788 hypothetical protein +FIG01725799 FIG152265: Sodium:solute symporter associated protein +FIG01725840 FIG00733576: hypothetical protein +FIG01725895 RIKEN cDNA 2610510H03 gene +FIG01725916 FIG00424595: hypothetical protein +FIG01725926 nucleoside-diphosphate-sugar epimerases-like protein +FIG01725928 putative multimer resolution protein +FIG01725929 CELL PROCESSES; Adaptation; adaptations, atypical conditions +FIG01725934 phage transcriptional repressor +FIG01725964 FIG00523851: hypothetical protein +FIG01725981 FIG00518321: hypothetical protein +FIG01726019 Linoleoyl-CoA desaturase( EC:1.14.19.3 ) +FIG01726052 Hemolysin related protein +FIG01726058 eukaryotic protein kinase +FIG01726068 FIG00749724: hypothetical protein +FIG01726090 FIG01116517: hypothetical protein +FIG01726115 FIG01166630: hypothetical protein +FIG01726146 FIG00572301: hypothetical protein +FIG01726182 Thrombospondin type 3 repeat:Cna B-type +FIG01726201 FIG00522007: hypothetical protein +FIG01726202 hypothetical phage protein, putative +FIG01726207 CheA like protein +FIG01726232 similar to metal-dependent enzyme of the double-stranded beta helix superfamily +FIG01726234 FIG00646998: hypothetical protein +FIG01726240 similarity to lysozyme +FIG01726300 competence-damage inducible protein +FIG01726301 AEL327Wp +FIG01726382 glutathione-regulated potassium-efflux system protein +FIG01726384 GTP-binding protein LepA +FIG01726393 Transposase and inactivated derivatives +FIG01726401 integrase/recombinase-related protein +FIG01726406 Acyl-CoA thioester hydrolase( EC:3.1.2.- ) +FIG01726440 Pectate lyase +FIG01726441 lysine:N6-hydroxylase +FIG01726534 Dienelactone hydrolase domain protein +FIG01726570 C-5 cytosine-specific DNA methylase +FIG01726582 chaperonin GroEL +FIG01726604 FIG00361320: hypothetical protein +FIG01726621 TRASH +FIG01726638 FIG00364313: hypothetical protein +FIG01726661 putative phosphonate metabolism protein +FIG01726675 FIG00976902: hypothetical protein +FIG01726681 syc1283_d +FIG01726695 Uncharacterized membrane-anchored protein-like +FIG01726713 F pilin acetylation protein TraX +FIG01726751 FIG00755551: hypothetical protein +FIG01726795 Galactose-1-phosphate uridylyltransferase (EC 2.7.7.12) +FIG01726806 FIG00958889: hypothetical protein +FIG01726809 FIG00526070: hypothetical protein +FIG01726812 putative soluble lytic murein transglycosylase +FIG01726819 FIG00836583: hypothetical protein +FIG01726821 proteinase, putative +FIG01726827 FIG01208877: hypothetical protein +FIG01726889 haloacid dehalogenase-like hydrolase family protein +FIG01726896 UPF0262 protein BR0251 +FIG01726903 FIG00623147: hypothetical protein +FIG01726906 putative sulfite oxidase +FIG01726933 PEGA domain-containing protein +FIG01726940 glucose-inhibited division protein B( EC:2.1.- ) +FIG01726942 FIG00414598: hypothetical protein +FIG01726945 putative phosphoribosyltransferase +FIG01726957 Ribose ABC transport system, permease protein RbsC (TC 3.A.1.2.1) +FIG01726962 FIG00521160: hypothetical protein +FIG01727008 Mobile element protein +FIG01727035 FIG00639473: hypothetical protein +FIG01727081 Lj928 prophage major head protein +FIG01727110 TM2 domain family protein +FIG01727131 Secreted protein containing cell-adhesion domains +FIG01727166 FIG00815523: hypothetical protein +FIG01727176 Uncharacterized protein aq_919 +FIG01727205 FIG00411519: hypothetical protein +FIG01727249 FIG00343871: hypothetical protein +FIG01727303 Hsp15-like protein +FIG01727309 FIG00361393: hypothetical protein +FIG01727323 FIG00745427: hypothetical protein +FIG01727444 Ribosomal-protein-alanine acetyltransferase (EC 2.3.1.128) +FIG01727456 FIG00527472: hypothetical protein +FIG01727495 peptidase U34, dipeptidase +FIG01727566 FIG00957083: hypothetical protein +FIG01727674 hydrolase/phosphatase +FIG01727685 FIG00923803: hypothetical protein +FIG01727731 two-component response regulator homolog +FIG01727849 hypothetical protein +FIG01727851 conserved hypothetical protein in cyt c oxidase gene clusters +FIG01727925 glycosyl transferase family 8 +FIG01727944 FIG00417940: hypothetical protein +FIG01727967 Multidrug ABC exporter (DrugE2) family, ATP binding/membrane-spanning protein +FIG01727974 FIG00639093: hypothetical protein +FIG01727989 FIG00670769: hypothetical protein +FIG01728084 FIG00685032: hypothetical protein +FIG01728126 FIG00675427: hypothetical protein +FIG01728139 FOG: Ankyrin repeat-like +FIG01728147 FIG00623970: hypothetical protein +FIG01728160 FIG00642152: hypothetical protein +FIG01728186 FIG00406210: hypothetical protein +FIG01728190 FIG00513745: hypothetical protein +FIG01728198 Nodulation protein J +FIG01728208 FIG00405231: hypothetical protein +FIG01728212 gas vesicle synthesis protein GvpA +FIG01728217 Streptomyces venezuelae ISP5230 chloramphenicol resistance protein (cmlv) and chloramphenicol phosphotransferase genes, complete cds +FIG01728226 Mosaic protein LGN +FIG01728234 protein of unknown function DUF438 +FIG01728259 FIG00907547: hypothetical protein +FIG01728261 ABC-type antimicrobial peptide transport system, permease component +FIG01728313 FIG00623480: hypothetical protein +FIG01728373 hypothetical protein( EC:2.7.3.- ) +FIG01728453 FIG00622786: hypothetical protein +FIG01728482 lipase/acylhydrolase, GDSL family +FIG01728495 plasmid mobilization protein +FIG01728571 transcriptional factor +FIG01728583 FIG00921617: hypothetical protein +FIG01728608 Hopanoid-associated RND transporter, HpnN +FIG01728615 Possible Transcriptional Regulator, Crp/Fnr family +FIG01728625 NodS +FIG01728633 FIG01133567: hypothetical protein +FIG01728678 hypothetical protein +FIG01728699 FIG00858679: hypothetical protein +FIG01728730 putative phage minor capsid protein +FIG01728767 bll3714; unknown protein +FIG01728771 1,4-butanediol diacrylate esterase +FIG01728777 Prophage CP4-57 regulatory +FIG01728784 FIG01048104: hypothetical protein +FIG01728787 FIG01250193: hypothetical protein +FIG01728806 Endo-1,4-beta-xylanase A precursor (EC 3.2.1.8) (1,4-beta-D-xylan xylanohydrolase) (Xylanase A) (XYLA) +FIG01728823 putative bacteriocin leucocin-A +FIG01728855 FIG00410341: hypothetical protein +FIG01728870 FIG00877206: hypothetical protein +FIG01728896 FIG00519455: hypothetical protein +FIG01728909 Pilin, type IV, putative +FIG01728922 Beta-lactamase precursor +FIG01728952 methyltransferase domain family +FIG01729083 FIG01136769: hypothetical protein +FIG01729127 FIG01243411: hypothetical protein +FIG01729176 FIG01207222: hypothetical protein +FIG01729364 Taurine catabolism dioxygenase TauD/TfdA +FIG01729381 Magnesium and cobalt transport protein CorA +FIG01729444 Outer membrane protein, porin family +FIG01729480 MCP domain signal transducer, putative +FIG01729537 Phosphatidylglycerophosphatase A +FIG01729546 FIG01248112: hypothetical protein +FIG01729547 FIG01019012: hypothetical protein +FIG01729559 hypothetical protein +FIG01729562 putative galactosyltransferase +FIG01729578 oxygenase +FIG01729582 FIG00757027: hypothetical protein +FIG01729634 FIG00388487: hypothetical protein +FIG01729665 Uncharacterized membrane-associated protein-like +FIG01729666 Heat-labile enterotoxin IIB, A chain precursor +FIG01729676 cellulose binding protein +FIG01729697 FIG00407325: hypothetical protein +FIG01729714 FIG00644009: hypothetical protein +FIG01729740 Phage protein +FIG01729745 FIG01130430: hypothetical protein +FIG01729759 General secretion family related protein +FIG01729787 two-component sensor histidine kinase( EC:2.7.3.- ) +FIG01729816 hypothetical protein ECs1262 +FIG01729846 FIG00749714: hypothetical protein +FIG01729895 FOG: GGDEF domain-like +FIG01729989 FIG00675463: hypothetical protein +FIG01729994 IS1004 transposase +FIG01729996 Cobyrinic acid A,C-diamide synthase +FIG01730002 macrolide-efflux transporter +FIG01730004 FIG00550139: hypothetical protein +FIG01730011 FIG00766744: hypothetical protein +FIG01730035 PIN (PilT N terminus) domain +FIG01730036 fumarate reductase/succinate dehydrogenase flavoprotein +FIG01730037 FIG01250527: hypothetical protein +FIG01730059 Chondroitinase-AC precursor (EC 4.2.2.5) (Chondroitin-AC lyase) (Chondroitin sulfate AC lyase) (Chondroitin-AC eliminase) +FIG01730120 FIG00417011: hypothetical protein +FIG01730122 Oxidoreductase, NIFE-related +FIG01730179 FIG00734382: hypothetical protein +FIG01730213 Zonadhesin precursor +FIG01730250 FIG00417078: hypothetical protein +FIG01730270 aminoglycoside nucleotidyltransferase, putative +FIG01730301 putative phage prohead protease +FIG01730334 FIG00542312: hypothetical protein +FIG01730342 Type 1 fimbriae regulatory protein fimB +FIG01730361 peptidase A24A-like protein +FIG01730385 ortholog of Bordetella pertussis (BX470248) BP2871 +FIG01730401 Heme/hemopexin utilization protein B precursor +FIG01730496 predicted membrane protein, COG2259 +FIG01730548 probable permease component of branched-chain amino acid transporter +FIG01730597 Mannosyl-glycoprotein endo-beta-N-acetylglucosamidase( EC:3.2.1.96 ) +FIG01730634 FIG00413640: hypothetical protein +FIG01730691 Putative acetyltransferase, GnaT family +FIG01730719 protein of unknown function DUF752 +FIG01730741 Putative transcriptional regulator MarT (Putative transcriptional regulatory protein) +FIG01730749 FIG00645218: hypothetical protein +FIG01730777 RNA polymerase sigma factor cnrH +FIG01730832 ATPases of the AAA+ class-like +FIG01730855 iron compound ABC transporter, permease +FIG01730867 Rifampin ADP-ribosyl transferase +FIG01730911 leucyl-tRNA synthetase( EC:6.1.1.4 ) +FIG01730977 Haem oxygenase +FIG01731078 putative integrase (partial) +FIG01731105 DNA polymerase, phage-associated +FIG01731108 transcriptional repressor DeoR +FIG01731124 COG1876: D-alanyl-D-alanine carboxypeptidase +FIG01731169 FIG00642092: hypothetical protein +FIG01731198 FIG00417513: hypothetical protein +FIG01731205 FIG00410438: hypothetical protein +FIG01731209 Uncharacterized protein CPE0188 +FIG01731228 FIG01032041: hypothetical protein +FIG01731251 Positive transcriptional regulator, MutR family +FIG01731286 putative glycosyltransferase( EC:2.4.1.- ) +FIG01731310 zgc:112315 +FIG01731315 putative biopolymer transport protein +FIG01731341 FIG00380213: hypothetical protein +FIG01731351 Protein-L-isoaspartate(D-aspartate) O-methyltransferase (EC 2.1.1.77) +FIG01731371 regulator of the activity of phosphatase RapE +FIG01731378 FIG00560843: hypothetical protein +FIG01731398 Toxin of toxin-antitoxin (TA) system ParE +FIG01731404 DsrE family protein +FIG01731442 tnpA +FIG01731459 UPF0225 protein YchJ +FIG01731489 flavoprotein reductase +FIG01731495 FIG00524070: hypothetical protein +FIG01731529 probable DNA recombinase recG( EC:3.6.1.- ) +FIG01731542 P65 lipoprotein-like protein +FIG01731558 FIG00380876: hypothetical protein +FIG01731600 Possible acyl carrier protein +FIG01731604 transposase, IS5 family, truncation +FIG01731690 Gamma-glutamylcysteine synthetase (EC 6.3.2.2) +FIG01731696 putative amino-acid ABC transporter (ATP-binding protein) +FIG01731768 FIG00387884: hypothetical protein +FIG01731793 VrlI homologue +FIG01731800 Spore germination protein KB +FIG01731805 FIG00388211: hypothetical protein +FIG01731836 Glutamate-binding protein of ABC transporter system +FIG01731849 COG0366: Glycosidases +FIG01731851 Lipopolysaccharide biosynthesis protein RffA +FIG01731876 FIG00630758: hypothetical protein +FIG01731999 FIG00385388: hypothetical protein +FIG01732048 FIG00417980: hypothetical protein +FIG01732069 possible Adenosine-deaminase (editase) domain +FIG01732079 FIG00696152: hypothetical protein +FIG01732080 FIG00568660: hypothetical protein +FIG01732096 putative integral membrane protein containing HD domain +FIG01732097 Uncharacterized protein MJ1070 precursor +FIG01732098 putative terminal protein +FIG01732103 Cold shock-like protein cspD +FIG01732145 putative beta-lactamase/hydrolase +FIG01732167 probable sulfate transporter +FIG01732174 FIG00939868: hypothetical protein +FIG01732193 membrane or secreted protein +FIG01732199 FIG00406430: hypothetical protein +FIG01732204 Tyrosine-protein kinase wzc +FIG01732234 cell surface antigen Sca3 +FIG01732258 permease (major facilitator superfamily) +FIG01732261 hypothetical protein +FIG01732334 COG4680: Uncharacterized protein conserved in bacteria +FIG01732344 protease degQ precursor( EC:3.4.21.- ) +FIG01732348 transposase of IS653-like element +FIG01732356 YjeF C-terminal-like +FIG01732396 conserved cobalamine operon protein +FIG01732472 ABC-type multidrug transport system permease component +FIG01732505 FIG00958634: hypothetical protein +FIG01732513 putative transcription regulator, LacI family +FIG01732517 ceramide glucosyltransferase, putative +FIG01732553 FIG01108266: hypothetical protein +FIG01732561 Copper resistance D +FIG01732571 FIG01166019: hypothetical protein +FIG01732592 Msr1301 protein +FIG01732694 FIG00447186: hypothetical protein +FIG01732697 ATP-dependent DNA helicase rep +FIG01732704 FIG00388840: hypothetical protein +FIG01732706 similar to Arabinose efflux permease +FIG01732707 Glyoxalase family protein +FIG01732759 FIG00424014: hypothetical protein +FIG01732791 FIG00733156: hypothetical protein +FIG01732813 Hexosyltransferase +FIG01732816 FIG00816397: hypothetical protein +FIG01732867 ABC transporter transmembrane region +FIG01732876 probable Na/H+ antiporter +FIG01732934 POSSIBLE HYDROLASE (EC 3.-.-.-) +FIG01732939 FIG00567600: hypothetical protein +FIG01732959 COG1432: Uncharacterized conserved protein +FIG01733033 Initiation-control protein yabA +FIG01733043 transcriptional regulator of the bltD operon +FIG01733147 FIG00937587: hypothetical protein +FIG01733198 syc1061_c +FIG01733238 mcbG protein, putative +FIG01733289 Aspartokinase 2 (EC 2.7.2.4) (Aspartokinase II) (Aspartate kinase 2) [Contains: Aspartokinase II subunit alpha; Aspartokinase II subunit beta] +FIG01733290 cobalt ABC transporter, ATPase subunit +FIG01733352 Polysaccharidase +FIG01733359 Putative RHS-family protein +FIG01733495 FIG00388424: hypothetical protein +FIG01733518 FIG00672369: hypothetical protein +FIG01733552 Uncharacterized protein MJ0362 +FIG01733553 putative spermidine synthase( EC:2.5.1.16 ) +FIG01733569 FIG00343766: hypothetical protein +FIG01733570 FIG00817339: hypothetical protein +FIG01733607 Acetoacetyl-CoA synthase +FIG01733627 FIG00816964: hypothetical protein +FIG01733632 ATPase, AFG1 type +FIG01733693 FIG00733801: hypothetical protein +FIG01733704 mitogen-activated protein kinase 1 +FIG01733708 Probable transposase protein +FIG01733719 hypothetical protein +FIG01733784 Cystathionine beta-lyase family protein involved in aluminum resistance +FIG01733901 Gsr3654 protein +FIG01733959 Transcriptional regulator (TetR/AcrR family) +FIG01733963 Predicted protein family PM-10 +FIG01733972 FIG00520588: hypothetical protein +FIG01733976 hypothetical protein +FIG01733997 FIG01116110: hypothetical protein +FIG01733998 LysM domain-containing membrane protein +FIG01734031 steroid delta-isomerase +FIG01734046 Branched-chain amino acid transport system permease protein livM (TC 3.A.1.4.1) +FIG01734121 FIG00518788: hypothetical protein +FIG01734134 nodulation protein N +FIG01734152 small heat shock protein HspC2 +FIG01734184 [Ni/Fe] hydrogenase, group 1, large subunit +FIG01734206 COG1741: Pirin-related protein +FIG01734207 FIG01116847: hypothetical protein +FIG01734214 Thrombospondin 4 precursor +FIG01734219 Acylaminoacyl-peptidase +FIG01734250 drug resistance transporter, Bcr/CflA subfamily +FIG01734269 NADH oxidase( EC:1.- ) +FIG01734310 FIG00889672: hypothetical protein +FIG01734375 FIG00776475: hypothetical protein +FIG01734431 probable anti-repressor protein +FIG01734477 PROBABLE EPOXIDE HYDROLASE EPHC (EPOXIDE HYDRATASE) (EC 3.3.2.9) +FIG01734492 glutathione S-transferase family protein +FIG01734499 glyoxalase I +FIG01734527 FIG00403868: hypothetical protein +FIG01734532 FIG00624341: hypothetical protein +FIG01734563 FIG01245983: hypothetical protein +FIG01734593 FIG00792170: hypothetical protein +FIG01734619 FIG00644104: hypothetical protein +FIG01734626 FIG00416846: hypothetical protein +FIG01734630 TrfA-related protein +FIG01734643 conjugal transfer protein TrbG/VirB9/CagX +FIG01734655 MoaD family protein +FIG01734774 WD40 domain protein beta Propeller +FIG01734787 FIG00623223: hypothetical protein +FIG01734806 syc1954_c +FIG01734810 Pirin-like protein +FIG01734841 FIG00867019: hypothetical protein +FIG01734845 extracellular protein, membrane-anchored (putative) +FIG01734858 putative zinc-binding oxidoreductase +FIG01734871 cytochrome C5 +FIG01734917 FIG01124720: hypothetical protein +FIG01734929 FIG00533288: hypothetical protein +FIG01734983 COG0179: 2-keto-4-pentenoate hydratase/2-oxohepta-3-ene-1,7-dioic acid hydratase (catechol pathway) +FIG01735029 FIG00733655: hypothetical protein +FIG01735095 FIG01181587: hypothetical protein +FIG01735117 Discoidin domain protein +FIG01735139 Methyltransferase, FkbM family subfamily +FIG01735153 mycodextranase +FIG01735176 PNAS-9 +FIG01735181 Aminobenzoyl-glutamate utilization protein A homolog +FIG01735195 FIG01172378: hypothetical protein +FIG01735221 permease protein of ribose ABC transporter +FIG01735244 Chaperone protein dnaJ +FIG01735265 N-acetylneuraminic acid synthase-like protein +FIG01735279 Protein of unknown function DUF322 +FIG01735311 Mlr5215 protein +FIG01735314 FIG00351955: hypothetical protein +FIG01735315 MutT/nudix family phosphohydrolase +FIG01735320 fuculose-1-phosphate aldolase +FIG01735332 FIG00897619: hypothetical protein +FIG01735346 FIG00361720: hypothetical protein +FIG01735373 [Genomic island nu Sa alpha2] +FIG01735374 Prophage MuSo2, transcriptional regulator, Cro/CI family +FIG01735376 phytoene dehydrogenase( EC:1.3.- ) +FIG01735441 phage/plasmid replication protein +FIG01735452 FIG00733860: hypothetical protein +FIG01735481 Serine/threonine protein phosphatase 1 +FIG01735570 Ketohexokinase( EC:2.7.1.3 ) +FIG01735648 FIG00365007: hypothetical protein +FIG01735659 transcriptional regulator, XRE family with cupin sensor domain +FIG01735728 putative Outer membrane porin +FIG01735734 TRSE-LIKE PROTEIN +FIG01735781 Integrase +FIG01735888 FIG00693699: hypothetical protein +FIG01735908 CDP-Glycerol:Poly(glycerophosphate) glycerophosphotransferase family protein +FIG01735924 FIG01181053: hypothetical protein +FIG01735927 Conserved hypothetical protein 1784 +FIG01735944 TraL family protein +FIG01735947 Kinase +FIG01735969 geranylgeranyl pyrophosphate synthase +FIG01735989 FIG00800590: hypothetical protein +FIG01735993 hypothetical protein +FIG01736002 Putative D-mannonate oxidoreductase (EC 1.1.1.57) +FIG01736006 putative acyl-CoA dehyrdogenase +FIG01736027 FIG00407359: hypothetical protein +FIG01736096 FIG00408941: hypothetical protein +FIG01736122 hypothetical protein +FIG01736130 FIG00424448: hypothetical protein +FIG01736177 glucan binding protein +FIG01736182 FIG00674800: hypothetical protein +FIG01736196 iron(III) dicitrate-binding periplasmic protein +FIG01736237 FIG00746364: hypothetical protein +FIG01736249 laminarinase +FIG01736311 FIG00733468: hypothetical protein +FIG01736320 SERINE PROTEASE( EC:3.4.21.- ) +FIG01736334 oligopeptide ABC transporter (permease) +FIG01736381 Complete genome; segment 1/17 +FIG01736471 hypothetical protein +FIG01736474 hypothetical protein +FIG01736499 FIG00742057: hypothetical protein +FIG01736504 FIG00385326: hypothetical protein +FIG01736537 HTH-type transcriptional regulator HdiR +FIG01736553 FIG00385605: hypothetical protein +FIG01736587 probable endo-1,4-beta-xylanase 1 precursor +FIG01736623 FIG00938921: hypothetical protein +FIG01736654 Acetyl-CoA hydrolase/transferase +FIG01736678 Salivary glue protein Sgs-3 precursor +FIG01736717 exporters of the RND superfamily-like +FIG01736754 18 : Unknown function +FIG01736757 FIG00344815: hypothetical protein +FIG01736783 HTH transcriptional regulator TetR family +FIG01736791 probable sulfatase atsG +FIG01736833 FIG00555104: hypothetical protein +FIG01736852 FIG01166156: hypothetical protein +FIG01736871 putative alkylhydroperoxidase AhpD family core domain protein +FIG01736912 FIG00521561: hypothetical protein +FIG01736923 glucose/galactose transporter family protein +FIG01737035 Sensory transduction histidine kinase (HAMP, HisKA, HATPase domains) +FIG01737054 Regulatory sensor-transducer, BlaR1/MecR1 family / Leucine-rich repeat containing protein +FIG01737056 Uncharacterized protein y4jQ +FIG01737176 FIG00815639: hypothetical protein +FIG01737240 PE-PGRS FAMILY PROTEIN +FIG01737253 FIG00349420: hypothetical protein +FIG01737258 FIG00364395: hypothetical protein +FIG01737385 FIG00908879: hypothetical protein +FIG01737391 Hypothetical Integral membrane protein +FIG01737394 FIG01130558: hypothetical protein +FIG01737401 Metallo-beta-lactamase precursor +FIG01737444 FIG00348827: hypothetical protein +FIG01737449 blr3682; hypothetical protein +FIG01737458 putative N-acetylglucosaminyltransferase +FIG01737491 hypothetical protein( EC:4.1.1.2 ) +FIG01737552 integrase, catalytic domain, putative +FIG01737554 flagellar biosynthetic protein (FlhB)-like +FIG01737572 FIG00522183: hypothetical protein +FIG01737588 nucleotide sugar dehydrogenase +FIG01737590 FIG00388865: hypothetical protein +FIG01737609 FIG00517181: hypothetical protein +FIG01737631 FIG01115691: hypothetical protein +FIG01737644 lipase/esterase( EC:3.1.1.- ) +FIG01737679 conserved hypothetical protein-putative outer membrane protein +FIG01737725 ABC-type multidrug transport system, ATP-ase compoment +FIG01737756 FIG00747710: hypothetical protein +FIG01737832 FIG00533277: hypothetical protein +FIG01737861 FIG00815610: hypothetical protein +FIG01737920 Sphingomyelinase C precursor +FIG01737956 PUTATIVE DNA-3-METHYLADENINE GLYCOSIDASE II PROTEIN( EC:3.2.2.21 ) +FIG01737960 FIG00346601: hypothetical protein +FIG01737991 membrane protein, putative +FIG01738036 FIG00762925: hypothetical protein +FIG01738052 FIG01253323: hypothetical protein +FIG01738057 hypothetical protein; RBL05322 +FIG01738064 Endoglucanase E precursor (EC 3.2.1.4) +FIG01738073 FIG01198409: hypothetical protein +FIG01738099 Predicted alginate utilization operon transcriptional repressor AlgR +FIG01738101 (Acyl-carrier protein) phosphodiesterase( EC:3.1.4.14 ) +FIG01738212 biotin/lipoic acid binding domain protein +FIG01738217 Protein of unknown function precursor +FIG01738353 FkbH like protein +FIG01738417 Alpha/beta hydrolase fold-1:PGAP1-like +FIG01738420 possible Signal peptidase I +FIG01738424 FIG00624678: hypothetical protein +FIG01738433 YxeD +FIG01738434 protein disulfide-isomerase-like protein +FIG01738491 SCE2.16, unknown, len: 706aa +FIG01738534 putative AraC-type regulator +FIG01738552 X-Pro dipeptidyl-peptidase-like +FIG01738590 FIG00623918: hypothetical protein +FIG01738609 Dehydrogenase protein DltE +FIG01738626 FIG01118924: hypothetical protein +FIG01738659 putative membrane protein with Tetratricopeptide repeat domain +FIG01738741 glutamine synthetase repressor +FIG01738816 similar to zinc protease +FIG01738825 Glutamate carboxypeptidase II (EC 3.4.17.21) +FIG01738850 All3669 protein +FIG01738872 cold-shock DNA-binding domain protein +FIG01738918 High-affinity Fe2+/Pb2+ permease +FIG01738936 FIG00756013: hypothetical protein +FIG01738981 Archaea-specific Superfamily II helicase MJ1401 +FIG01739024 transposase InsA +FIG01739058 Diguanylate cyclase (GGDEF domain) precursor +FIG01739127 putative lipoprotein signal peptidase +FIG01739145 SSU ribosomal protein S6p / hypothetical protein +FIG01739354 Anion transporter family protein +FIG01739377 Similarities with tr|Q12218 Saccharomyces cerevisiae YOR009w +FIG01739411 alpha-clostripain-like protein +FIG01739455 Ssr1558 protein +FIG01739478 COG2865: Predicted transcriptional regulator containing an HTH domain and an uncharacterized domain shared with the mammalian protein Schlafen +FIG01739483 Uncharacterized protein PM1543 precursor +FIG01739525 peptidase M14, carboxypeptidase A +FIG01739535 Methyltransferase MA1251 +FIG01739554 Integral membrane efflux protein +FIG01739570 POSSIBLE PROTEASE IV SPPA (ENDOPEPTIDASE IV) (SIGNAL PEPTIDE PEPTIDASE) (EC 3.4.21.-) +FIG01739589 FIG00564193: hypothetical protein +FIG01739591 FIG00624111: hypothetical protein +FIG01739680 FIG00565356: hypothetical protein +FIG01739705 putative pectinesterase/pectate lyase protein +FIG01739773 FIG00632225: hypothetical protein +FIG01739783 hypothetical protein +FIG01739794 COGs COG1989 +FIG01739830 pilus assembly protein PilC +FIG01739863 probable TonB protein +FIG01739871 N-acyl-D-amino-acid deacylase precursor (EC 3.5.1.81) +FIG01739966 FIG01044694: hypothetical protein +FIG01739979 acyl-CoA thioesterase 1 +FIG01739994 Protein of unknown function DUF86 +FIG01740015 FIG00351176: hypothetical protein +FIG01740028 Conserved protein YyaK +FIG01740050 Uncharacterized HTH-type transcriptional regulator yusT +FIG01740052 FIG01160486: hypothetical protein +FIG01740055 predicted xylanase/chitin deacetylase +FIG01740094 FMN-dependent NADH-azoreductase (EC 1.7.-.-) (FMN-dependent NADH-azo compound oxidoreductase) (Azo-dye reductase) +FIG01740141 FIG01248417: hypothetical protein +FIG01740153 ada regulatory protein, putative +FIG01740215 FIG00522182: hypothetical protein +FIG01740218 FIG00467295: hypothetical protein +FIG01740231 thioredoxin-like +FIG01740237 predicted Fe-S oxidoreductase +FIG01740271 Chloramphenicol acetyltransferase (EC 2.3.1.28) +FIG01740369 mobilization protein MocB +FIG01740470 hypothetical protein +FIG01740492 COG3617: Prophage antirepressor +FIG01740520 FIG01253646: hypothetical protein +FIG01740588 FIG00468393: hypothetical protein +FIG01740595 FIG00769646: hypothetical protein +FIG01740610 FIG01212147: hypothetical protein +FIG01740641 FIG01125548: hypothetical protein +FIG01740711 FIG00886340: hypothetical protein +FIG01740723 Flagellar hook-length control protein FliK +FIG01740725 FIG00558662: hypothetical protein +FIG01740726 FIG00530316: hypothetical protein +FIG01740744 FIG00528936: hypothetical protein +FIG01740759 MurB family protein +FIG01740765 Small terminase subunit +FIG01740809 probable penicillin amidase +FIG01740834 glycosyltransferase, GT1 family +FIG01740854 FIG00363416: hypothetical protein +FIG01740880 FIG00530533: hypothetical protein +FIG01740894 protein of unknown function DUF1465 +FIG01740916 FIG00622924: hypothetical protein +FIG01740932 GAF sensor hybrid histidine kinase( EC:2.7.13.3 ) +FIG01740938 Mannose-1-phosphate guanylyltransferase (GDP) (EC 2.7.7.22) / Mannose-6-phosphate isomerase (EC 5.3.1.8) +FIG01741002 unspecified kinase or ATP dependent regulatory protein +FIG01741010 FIG01165722: hypothetical protein +FIG01741012 protein of unknown function DUF1659 +FIG01741026 Methyltransferase type 11 +FIG01741028 protein of unknown function UPF0047 +FIG01741046 amino acid ABC transporter periplasmic component +FIG01741055 hypothetical protein +FIG01741142 putative FAD/FMN-containing dehydrogenase +FIG01741158 FIG00348841: hypothetical protein +FIG01741241 MaoC-related acyl dehydratase +FIG01741266 alpha amylase( EC:3.2.1.10 ) +FIG01741283 YkuI +FIG01741285 FIG00817688: hypothetical protein +FIG01741298 L-lysine 6-monooxygenase (Lysine N(6)-hydroxylase) protein +FIG01741299 Probable calcium-binding signal peptide protein +FIG01741314 FIG00338558: hypothetical protein +FIG01741352 Decaheme cytochrome c related protein +FIG01741375 rmoA +FIG01741400 probable riboflavin-specific deaminase +FIG01741432 RNA methyltransferase [EC:2.1.1.-] +FIG01741445 FIG00538369: hypothetical protein +FIG01741476 putative amino acid ABC transporter, integral membrane protein +FIG01741499 ISSod6 transposase, IS1301 +FIG01741506 probable conserved transmembrane protein +FIG01741557 GntR family regulatory proteins +FIG01741561 FIG01126749: hypothetical protein +FIG01741594 putative protease B +FIG01741618 hypothetical protein +FIG01741623 Mut/nudix family protein +FIG01741651 Staphylococcus nuclease (SNase) domain +FIG01741704 unspecific monooxygenase (cytochrome P450)( EC:1.14.14.1 ) +FIG01741779 NAD/NADP octopine/nopaline dehydrogenas +FIG01741828 structural elements; cell envelope +FIG01741829 FIG00411741: hypothetical protein +FIG01741851 FIG00463869: hypothetical protein +FIG01741932 CfcF, putative +FIG01741944 FIG00405132: hypothetical protein +FIG01741960 Listeria/Bacterioides repeat protein +FIG01741998 COG0662: Mannose-6-phosphate isomerase +FIG01742051 Probable UDP-galactose-lipid carrier transferase +FIG01742072 FIG00388089: hypothetical protein +FIG01742141 hypothetical protein +FIG01742142 FIG00418327: hypothetical protein +FIG01742260 hypothetical protein +FIG01742285 Hypothetical protein: possibly conserved +FIG01742332 hypothetical protein +FIG01742359 COG3636: Predicted transcriptional regulator +FIG01742368 FIG00531700: hypothetical protein +FIG01742389 protein-disulfide reductase +FIG01742390 hypothetical protein +FIG01742412 recombination protein F +FIG01742424 FIG00629389: hypothetical protein +FIG01742426 FIG00529428: hypothetical protein +FIG01742440 hypothetical protein +FIG01742443 Putative phosphoesterase, PA-phosphatase related +FIG01742498 Sodium/calcium antiporter +FIG01742539 teichoic acid glycosylation protein +FIG01742603 FIG00623368: hypothetical protein +FIG01742618 polyguluronate lyase precursor +FIG01742621 X-Pro dipeptidyl-peptidase +FIG01742638 L-arabinose-binding periplasmic protein precursor AraF (TC 3.A.1.2.2) +FIG01742641 domain of unknown function DUF1738 +FIG01742655 Lipase/esterase.( EC:3.1.1.- ) +FIG01742679 similar to N,N-dimethyltransferase +FIG01742700 Dihydroxy-acid dehydratase( EC:4.2.1.9 ) +FIG01742735 sucrose operon repressor +FIG01742801 transcription factor +FIG01742826 TRANSPORTER +FIG01742842 periplasmic sensor signal transduction histidine kinase +FIG01742851 Plasmid partitioning protein +FIG01742891 IS426 transposase +FIG01742914 FIG00673916: hypothetical protein +FIG01742941 ATPase involved in DNA replication initiation +FIG01742949 putative tetracenomycin polyketide synthesis O-methyltransferase +FIG01742955 conserved domain protein +FIG01742978 FIG00527394: hypothetical protein +FIG01742999 protein of unknown function DUF718 +FIG01743012 possible Methanol dehydrogenase beta subunit +FIG01743055 Alpha-amylase precursor (EC 3.2.1.1) (1,4-alpha-D-glucan glucanohydrolase) +FIG01743057 FIG01041539: hypothetical protein +FIG01743075 FIG00425345: hypothetical protein +FIG01743099 IS1167, transposase (ORF2) +FIG01743105 Probable ABC transporter ATP-binding protein in ycf23-apcF intergenic region +FIG01743177 probable insertion sequence transposase protein +FIG01743181 flagella-associated protein +FIG01743202 Membrane associated chemotaxis sensory transducer protein (MSP domain and HAMP domain) +FIG01743211 putative phage repressor protein +FIG01743220 unknown protein encoded in prophage CP-933I +FIG01743260 Mo-dependent nitrogenase-like +FIG01743264 PTS system, maltose and glucose-specific IIC component (EC 2.7.1.69) / PTS system, maltose and glucose-specific IIB component (EC 2.7.1.69) / PTS system, maltose and glucose-specific IIA component (EC 2.7.1.69) +FIG01743272 FIG00623489: hypothetical protein +FIG01743296 FIG00363396: hypothetical protein +FIG01743321 putative pyridoxine 5'-phosphate oxidase +FIG01743342 FIG00514331: hypothetical protein +FIG01743392 endoglucanase, putative +FIG01743394 FIG00417723: hypothetical protein +FIG01743454 COG4928: Predicted P-loop ATPase +FIG01743465 conserved hypothetical protein-putative inosine monophosphate dehydrogenase-related protein +FIG01743469 FIG00533117: hypothetical protein +FIG01743482 putative arginine-binding periplasmic protein +FIG01743547 FIG01236709: hypothetical protein +FIG01743559 COG3293: Transposase and inactivated derivatives +FIG01743573 FIG00623931: hypothetical protein +FIG01743599 FIG00455117: hypothetical protein +FIG01743600 SWIB/MDM2 domain protein +FIG01743610 PAS/PAC sensor hybrid histidine kinase +FIG01743614 FIG00808623: hypothetical protein +FIG01743623 cell filamentation-like protein +FIG01743648 FIG00689946: hypothetical protein +FIG01743678 natural resistance-associated macrophage protein +FIG01743680 FIG00517086: hypothetical protein +FIG01743689 FIG00389006: hypothetical protein +FIG01743726 enhanced entry protein EnhB +FIG01743730 FIG00517486: hypothetical protein +FIG01743753 Cupin 4 family protein +FIG01743760 Uncharacterized protein PM1772 +FIG01743782 glycerol ABC transporter, ATP-binding protein +FIG01743802 bifunctional aconitate hydratase 2/2-methylisocitrate dehydratase +FIG01743823 PROBABLE CONSERVED INTEGRAL MEMBRANE PROTEIN +FIG01743847 FIG01114391: hypothetical protein +FIG01743927 probable iron ABC transporter, ATP-binding protein( EC:3.6.3.34 ) +FIG01743960 GH3 auxin-responsive promoter superfamily +FIG01743970 Thiosulfate reductase cytochrome B subunit (membrane anchoring protein)-like protein +FIG01743971 FIG00827964: hypothetical protein +FIG01743973 FIG00807778: hypothetical protein +FIG01743993 ACT domain-containing protein +FIG01743998 FIG00764897: hypothetical protein +FIG01744056 Protein capK +FIG01744076 FIG01189663: hypothetical protein +FIG01744084 Bsl6731 protein +FIG01744198 All1616 protein +FIG01744263 FIG00624565: hypothetical protein +FIG01744266 FIG01128805: hypothetical protein +FIG01744315 190-KDa cell surface antigen +FIG01744339 O-antigen modification protein +FIG01744365 FIG01177657: hypothetical protein +FIG01744384 FIG00666443: hypothetical protein +FIG01744390 integrase domain protein +FIG01744407 FIG00647107: hypothetical protein +FIG01744408 FIG00468343: hypothetical protein +FIG01744409 LipO +FIG01744468 Protein of unknown function DUF1526 +FIG01744522 FIG01211990: hypothetical protein +FIG01744564 FIG00985168: hypothetical protein +FIG01744578 FIG01235068: hypothetical protein +FIG01744589 Possible heat shock protein DnaJ +FIG01744593 FIG00361496: hypothetical protein +FIG01744620 CONJUGAL TRANSFER PROTEIN TRAF +FIG01744642 FIG137478: Hypothetical protein YbgI +FIG01744678 FIG00411451: hypothetical protein +FIG01744738 hypothetical protein predicted by Glimmer/Critica +FIG01744782 FIG01224365: hypothetical protein +FIG01744786 FIG00344682: hypothetical protein +FIG01744803 Dihydrokaempferol 4-reductase +FIG01744808 probable acetyltransferase YybD +FIG01744860 bifunctional autolysin precursor +FIG01744936 SENSOR KINASE OF TWO-COMPONENT REGULATORY SYSTEM +FIG01744955 Slr0755 protein +FIG01745029 glutamate transport system permease protein GluC +FIG01745064 putative tetracycline-efflux transporter +FIG01745081 predicted electron-transferring-flavoprotein dehydrogenase / geranylgeranyl hydrogenase homolog( EC:1.5.5.1 ) +FIG01745091 putative cytochrome P450 hydroxylase +FIG01745103 FIG01253137: hypothetical protein +FIG01745122 FIG00354122: hypothetical protein +FIG01745152 membrane protein containing DUF1558 +FIG01745262 nitrate reductase component, ferredoxin-type protein +FIG01745336 Alkylmercury lyase (EC 4.99.1.2) (Organomercurial lyase) +FIG01745346 DNA polymerase III, alpha subunit, Gram-positive type( EC:2.7.7.7 ) +FIG01745361 putative prophage transcriptional repressor +FIG01745386 FIG00847878: hypothetical protein +FIG01745442 Gll0027 protein +FIG01745451 Twin-arginine translocation protein TatB +FIG01745458 Protein-glutamate methylesterase +FIG01745462 Fe-S metabolism associated domain subfamily protein +FIG01745502 erythromycin esterase, putative +FIG01745524 Uncharacterized protein 4 in cox locus +FIG01745537 M38 (beta-aspartyl dipeptidase) family protein +FIG01745547 Lipoprotein NlpD +FIG01745550 glutaredoxin and related proteins +FIG01745555 FIG00344905: hypothetical protein +FIG01745615 Alr3919 protein +FIG01745649 Retinol dehydrogenase 13 +FIG01745657 FIG00388361: hypothetical protein +FIG01745677 FIG00348367: hypothetical protein +FIG01745682 COG4004 family +FIG01745699 FIG01117042: hypothetical protein +FIG01745713 xenobiotic compound monooxygenase, DszA family +FIG01745714 FIG00875870: hypothetical protein +FIG01745755 transposase IS1193D +FIG01745780 FIG00361103: hypothetical protein +FIG01745797 trehalose synthase( EC:5.4.99.16 ) +FIG01745803 Aliphatic amidase AmiE (EC 3.5.1.4) +FIG01745804 hypothetical protein +FIG01745849 probable flippase +FIG01745861 pyoverdine chromophore precursor synthetase +FIG01745975 Proton glutamate symport protein +FIG01745997 replication protein A +FIG01746006 outer membrane protein TolC +FIG01746042 Thiosulfate sulfurtransferase (EC 2.8.1.1) +FIG01746072 Predicted S-adenosylmethionine-dependent methyltransferase +FIG01746115 FIG00521522: hypothetical protein +FIG01746118 FIG00745607: hypothetical protein +FIG01746128 NIPSNAP +FIG01746146 putative replication protein A +FIG01746181 hypothetical proteins-like +FIG01746204 redox family protein +FIG01746240 Acyl-CoA dehydrogenase (EC 1.3.8.1), Mycobacterial subgroup FadE27 +FIG01746285 FIG00674964: hypothetical protein +FIG01746299 FIG01069489: hypothetical protein +FIG01746306 FIG00673820: hypothetical protein +FIG01746321 FIG00344888: hypothetical protein +FIG01746349 FIG00390054: hypothetical protein +FIG01746365 GDP-D-mannose dehydratase gmdA (GDP-mannose 4,6 dehydratase) (GMD) (EC 4.2.1.47) +FIG01746422 COG0741: Soluble lytic murein transglycosylase and related regulatory proteins (some contain LysM/invasin domains) +FIG01746443 transcriptional regulator AbrB +FIG01746449 FIG00832514: hypothetical protein +FIG01746459 Pirin, N-terminal +FIG01746465 FIG01111792: hypothetical protein +FIG01746505 hypothetical protein +FIG01746519 glcG protein +FIG01746538 FIG00794134: hypothetical protein +FIG01746540 FIG01232969: hypothetical protein +FIG01746548 FIG00536445: hypothetical protein +FIG01746592 IS, phage, Tn; Transposon-related functions +FIG01746604 ATP-dependent DNA helicase recQ( EC:3.6.1.- ) +FIG01746613 Lin0338 protein +FIG01746637 aconitate hydrase 1( EC:4.2.1.3 ) +FIG01746659 FIG00938663: hypothetical protein +FIG01746660 FIG01122678: hypothetical protein +FIG01746678 Epoxide hydrolase domain protein +FIG01746686 hypothetical protein +FIG01746713 FIG00385261: hypothetical protein +FIG01746731 probable glucanotransferase (endo alpha-1,4 polygalactosaminidase related protein) +FIG01746807 NAD-dependent formate dehydrogenase (EC 1.2.1.2) +FIG01746926 Transglutaminase-like predicted protease domain fused to ChW-repeats and cell-adhesion domain +FIG01746956 3,4-dihydroxyphenylacetate 2,3-dioxygenase HpaD (EC 1.13.11.2) +FIG01746960 FIG01126998: hypothetical protein +FIG01746975 TphA protein +FIG01746984 FIG00515176: hypothetical protein +FIG01746996 hypothetical protein +FIG01747074 UPP-Galactopyranose Isomerase (EC 5.4.99.9) +FIG01747085 dicarboxylate sensor protein +FIG01747106 FIG00522151: hypothetical protein +FIG01747121 Methyltransferase Mboo_1663 +FIG01747187 Putative short-chain dehydrogenase/reductase (EC 1.1.1.100) +FIG01747190 FIG00348470: hypothetical protein +FIG01747270 FIG00892439: hypothetical protein +FIG01747287 FIG00836130: hypothetical protein +FIG01747304 FIG00406576: hypothetical protein +FIG01747318 hypothetical protein +FIG01747331 FIG00406684: hypothetical protein +FIG01747353 TWO-COMPONENT HYBRID PROTEIN +FIG01747369 hypothetical protein +FIG01747420 All0385 protein +FIG01747459 BH2068 unknown conserved protein +FIG01747463 COG2801: Transposase and inactivated derivatives +FIG01747490 FIG00921374: hypothetical protein +FIG01747491 topology modulation protein +FIG01747512 ThiamineS +FIG01747552 FIG00568003: hypothetical protein +FIG01747600 dynein heavy chain, putative +FIG01747639 FIG00872944: hypothetical protein +FIG01747667 Putative fimbrial chaperone +FIG01747672 Putative protein-tyrosine sulfotransferase +FIG01747726 FIG01228815: hypothetical protein +FIG01747735 putative exopolyphosphatase +FIG01747799 Putative ligase +FIG01747800 FIG00727695: hypothetical protein +FIG01747835 general secretion pathway protein J +FIG01747935 FIG00349428: hypothetical protein +FIG01747944 response regulator receiver modulated serine phosphatase +FIG01747954 Signal peptidase I +FIG01748039 FIG00348718: hypothetical protein +FIG01748045 transcriptional regulator, RpiR family protein +FIG01748060 probable cytosol aminopeptidase( EC:3.4.11.1 ) +FIG01748067 Oxidoreductase-like +FIG01748106 FIG00409518: hypothetical protein +FIG01748114 FIG00747394: hypothetical protein +FIG01748115 ORF9 +FIG01748117 Probable cation efflux pump (multidrug resistance protein) +FIG01748185 Probable serine/threonine-protein kinase +FIG01748204 GTP cyclohydrolase II/3,4-dihydroxy-2-butanone-4-phosphate synthase +FIG01748211 RapD +FIG01748230 hypothetical protein +FIG01748244 negative regulator of flagellin synthesis FlgM +FIG01748257 FIG00816682: hypothetical protein +FIG01748279 FIG01047435: hypothetical protein +FIG01748306 FIG00351975: hypothetical protein +FIG01748325 ATPase of the AAA+ family protein associated with FIG137771 hypothetical protein +FIG01748361 FIG00356401: hypothetical protein +FIG01748513 CDS_ID OB0968 +FIG01748592 FIG00348194: hypothetical protein +FIG01748600 FlaA +FIG01748636 FIG00674925: hypothetical protein +FIG01748662 FIG00349263: hypothetical protein +FIG01748692 FIG00812613: hypothetical protein +FIG01748696 FIG01135797: hypothetical protein +FIG01748697 FIG01117631: hypothetical protein +FIG01748727 membrane protein , putative +FIG01748767 FIG00513588: hypothetical protein +FIG01748803 FIG00462320: hypothetical protein +FIG01748875 Protein of unknown function DUF204 +FIG01748886 FIG00348257: hypothetical protein +FIG01748936 Metal-dependent hydrolase of the beta-lactamase superfamily II +FIG01748942 prophage Lp2 protein 13 +FIG01748971 FIG00344737: hypothetical protein +FIG01748993 FIG00361636: hypothetical protein +FIG01748998 Na+/H+ antiporter precursor +FIG01749003 FIG01019437: hypothetical protein +FIG01749008 FIG00910578: hypothetical protein +FIG01749037 Cystine ABC transporter, ATP-binding protein +FIG01749116 syc0634_c +FIG01749137 FIG00405312: hypothetical protein +FIG01749309 Type IV secretory pathway, VirB6 components +FIG01749351 glucosamine-6-phosphate isomerase( EC:3.5.99.6 ) +FIG01749408 Uncharacterized protein aq_1842 +FIG01749411 Butyryl-CoA transferase +FIG01749519 putative sulfate transporter +FIG01749533 FIG00251188: hypothetical protein +FIG01749548 FIG00961968: hypothetical protein +FIG01749557 FIG00388214: hypothetical protein +FIG01749599 FIG00347857: hypothetical protein +FIG01749608 Na(+)/H(+) antiporter (TC 2.A.37.2.4) +FIG01749610 Sll0359 protein +FIG01749632 HAD hydrolase-like protein/gas vesicle protein K +FIG01749646 gp2, terminase +FIG01749651 PROBABLE CONSERVED INTEGRAL MEMBRANE PROTEIN +FIG01749711 FIG00381060: hypothetical protein +FIG01749735 hypothetical protein +FIG01749755 Periplasmic nitrate reductase component NapK +FIG01749780 organic anion transporter family protein +FIG01749787 Trehalose-6-phosphate hydrolase( EC:3.2.1.70 ) +FIG01749870 FIG00817141: hypothetical protein +FIG01749874 FIG00840401: hypothetical protein +FIG01749897 carbon monoxide dehydrogenase subunit CooF +FIG01749945 D-aminopeptidase dipeptide-binding protein DppA (EC 3.4.11.-) +FIG01749985 hypothetical protein +FIG01750030 Dimethylaniline monooxygenase [N-oxide-forming] 2 (EC 1.14.13.8) +FIG01750031 putative peptidase, M28 family protein +FIG01750062 transposase-like protein TnpA3 +FIG01750066 FIG01252895: hypothetical protein +FIG01750088 hypothetical protein +FIG01750094 FIG00624329: hypothetical protein +FIG01750103 perosamine synthetase-related protein +FIG01750104 FIG00962859: hypothetical protein +FIG01750107 Asr4076 protein +FIG01750115 FIG00667858: hypothetical protein +FIG01750170 Chromosome (plasmid) partitioning protein ParA / Sporulation initiation inhibitor protein Soj +FIG01750247 FIG00350237: hypothetical protein +FIG01750261 Transposon resolvase +FIG01750345 FIG00414149: hypothetical protein +FIG01750351 FIG01045024: hypothetical protein +FIG01750405 FIG00350403: hypothetical protein +FIG01750425 hypothetical protein +FIG01750433 Sll0168 protein +FIG01750453 FIG00618450: hypothetical protein +FIG01750487 CutC +FIG01750505 FIG00527176: hypothetical protein +FIG01750516 FIG00876315: hypothetical protein +FIG01750534 FIG00876941: hypothetical protein +FIG01750541 probable sugar transporter sugar binding lipoprotein +FIG01750546 Phage antirepressor protein +FIG01750551 FIG00385665: hypothetical protein +FIG01750611 Uncharacterized component of anaerobic dehydrogenases-like +FIG01750640 Osmosensitive K+ channel histidine kinase +FIG01750657 Uncharacterized conserved protein +FIG01750669 FIG01233855: hypothetical protein +FIG01750672 putative formate/nitrite transporter +FIG01750675 Flagellar hook-associated protein 3 +FIG01750716 FIG00828812: hypothetical protein +FIG01750727 blr2203; putative RNA polymerase sigma factor +FIG01750761 immunogenic protein (bcsp31-2) +FIG01750771 emm-like protein +FIG01750775 FIG00643881: hypothetical protein +FIG01750893 membrane associated protein +FIG01750898 putative dTDP-glucose 4,6-dehydratase +FIG01750942 FIG01046988: hypothetical protein +FIG01750948 YyaO +FIG01750965 BtrN protein +FIG01751035 FIG00431892: hypothetical protein +FIG01751038 FIG00468323: hypothetical protein +FIG01751088 ABC transporter, ATP-binding transmembrane protein +FIG01751154 conserved hypothetical protein 698 +FIG01751166 putative virulence associated protein +FIG01751169 VrrB +FIG01751189 probable maoC-like dehydratase +FIG01751239 FIG00675109: hypothetical protein +FIG01751265 putative ABC transporter sugar permease +FIG01751282 N-acyl-L-amino acid amidohydrolase (EC 3.5.1.14) +FIG01751283 FIG00354225: hypothetical protein +FIG01751289 FIG00687991: hypothetical protein +FIG01751301 tcdA-E operon negative regulator +FIG01751323 ferrichrome ABC transporter, substrate-binding protein, truncated +FIG01751345 dipeptidyl aminopeptidase/acylaminoacyl-peptidase +FIG01751455 hemin receptor +FIG01751477 putative treponemal membrane protein B precursor-like protein +FIG01751478 Glyoxalase/bleomycin resistance protein/dioxygenase +FIG01751518 putative Cro protein +FIG01751556 FIG01008637: hypothetical protein +FIG01751572 FIG00848179: hypothetical protein +FIG01751617 Streptococcal histidine triad protein +FIG01751652 FIG00641916: hypothetical protein +FIG01751722 FIG00209575: hypothetical protein +FIG01751733 Imp4 family protein +FIG01751734 probable protein kinase yloP-putative serine/threonine protein kinase +FIG01751736 long chain fatty acid transport protein +FIG01751754 sodium extrusion protein NatB +FIG01751783 two-component sensor histidine kinase/response regulator +FIG01751828 nutrient-stress induced DNA binding protein homolog +FIG01751842 peptidoglycan associated lipoprotein +FIG01751843 FIG01215064: hypothetical protein +FIG01751857 FIG00849143: hypothetical protein +FIG01751888 FIG01170872: hypothetical protein +FIG01751929 Serine acetyltransferase +FIG01751973 probable outer membrane protein STY1784 +FIG01751976 FIG01120752: hypothetical protein +FIG01751990 serine acetyltransferase +FIG01751992 FIG01048943: hypothetical protein +FIG01752014 hypothetical protein +FIG01752021 putative enzymatic protein +FIG01752055 ABC transporter permease protein +FIG01752076 FIG00733789: hypothetical protein +FIG01752114 ABC transporter (lipoprotein) +FIG01752169 COG4868: Uncharacterized protein conserved in bacteria +FIG01752230 FIG01235870: hypothetical protein +FIG01752265 polyketide biosynthesis enoyl-CoA hydratase +FIG01752277 putative acyl coenzyme A thioester hydrolase +FIG01752314 possible Virion host shutoff protein +FIG01752337 possible NAGC-like transcriptional regulator +FIG01752348 FIG00407771: hypothetical protein +FIG01752398 PTS system, mannose/fructose/sorbose family, IID component +FIG01752409 Transmembrane protein, ortholog TM1408 +FIG01752441 Cytoplasmic membrane protein LemA +FIG01752445 Uncharacterized protein family (UPF0175) +FIG01752452 FIG01068124: hypothetical protein +FIG01752475 probable lipoprotein Cj0375 +FIG01752487 FIG00687832: hypothetical protein +FIG01752534 transcriptional regulator, LytR family +FIG01752542 FIG00410219: hypothetical protein +FIG01752567 carboxyl-terminal protease, putative +FIG01752568 Uncharacterized low-complexity protein, related to YISX/YYBG B.subtilis +FIG01752594 transposase IS200-like protein +FIG01752637 Arginyl-tRNA synthetase-related protein +FIG01752645 hypothetical protein +FIG01752670 Peptidyl-prolyl cis-trans isomerase, FkbP-type +FIG01752679 heparan N-sulfatase +FIG01752700 dipeptide transport system permease protein +FIG01752703 heterodisulfide reductase, subunit A +FIG01752705 FIG00622814: hypothetical protein +FIG01752727 oligosaccharide repeat unit polymerase Wzy +FIG01752730 FIG00767618: hypothetical protein +FIG01752739 FIG00351342: hypothetical protein +FIG01752807 Gll2990 protein +FIG01752816 2,4-diketo-3-deoxy-L-fuconate hydrolase +FIG01752970 FIG00767855: hypothetical protein +FIG01752979 FIG00414882: hypothetical protein +FIG01752982 FIG00347478: hypothetical protein +FIG01752996 FIG00432987: hypothetical protein +FIG01753043 Putative RNA polymerase sigma-E factor (sigma-24) protein 1 +FIG01753111 Diguanylate cyclase/phosphodiesterase with GAF sensor +FIG01753112 putative Alkanal monooxygenase( EC:1.14.14.3 ) +FIG01753116 Protein gp61 [Bacteriophage A118], similar to Listeria protein LmaD +FIG01753209 Putitive HlyD family secretion protein +FIG01753220 Phage structural protein +FIG01753267 putative NAD(P)H oxidoreductase +FIG01753327 FIG00623636: hypothetical protein +FIG01753361 Transcriptional regulator, TetR family, putative +FIG01753383 FIG00518292: hypothetical protein +FIG01753400 hypothetical protein +FIG01753410 alpha/beta family hydrolase +FIG01753415 FIG00389774: hypothetical protein +FIG01753482 transport facilitation +FIG01753483 FIG00987372: hypothetical protein +FIG01753508 Putative DNA recombination protein +FIG01753522 FIG00642860: hypothetical protein +FIG01753594 Transcriptional regulator, MarR family +FIG01753611 Acetylglutamate kinase (EC 2.7.2.8) / Acetylaminoadipate kinase (EC 2.7.2.-) +FIG01753625 similar to ring-infested erythrocyte surface antigen, putative +FIG01753631 ATP-dependent RNA helicase, EIF-4A family +FIG01753645 FIG00345014: hypothetical protein +FIG01753663 Flavin reductase-like, FMN-binding domain protein +FIG01753726 FIG00363345: hypothetical protein +FIG01753748 Mb2678c, -, len: 73 aa. Equivalent to Rv2660c, len: 75 aa, from Mycobacterium tuberculosis strain H37Rv, (100.0% identity in 73 aa overlap). (questionable orf). Hypothetical unknown protein. REMARK-M.bovis-M.tuberculosis: In Mycobacterium bovis, a large 10982 bp deletion leads to deletion of genes between Mb2677c and Mb2678c compared to Mycobacterium tuberculosis strain H37Rv. +FIG01753751 Fibronectin, type III domain protein +FIG01753760 UPF0311 protein RPA1785 +FIG01753838 APHP +FIG01753917 FIG00344732: hypothetical protein +FIG01753964 FIG00849791: hypothetical protein +FIG01753972 ABC transporter-like protein +FIG01754031 FIG01042464: hypothetical protein +FIG01754087 glutamyl-tRNA synthetase( EC:6.1.1.17 ) +FIG01754141 sodium-solute symporter putative +FIG01754176 Helix-turn-helix, AraC domain +FIG01754224 324aa long hypothetical immunogenic protein +FIG01754275 COG3237: Uncharacterized protein conserved in bacteria +FIG01754298 tail component protein +FIG01754311 FIG00411719: hypothetical protein +FIG01754350 predicted sulfurtransferase +FIG01754408 Regulatory protein, ArsR +FIG01754418 FIG00564922: hypothetical protein +FIG01754442 PE_PGRS family protein +FIG01754455 dnaJ family protein +FIG01754512 putative modification methylase +FIG01754513 hypothetical protein +FIG01754535 Coenzyme A-dependent NAD(P)H sulfur oxidoreductase +FIG01754588 2OG-Fe(II) oxygenase +FIG01754617 5-oxopent-3-ene-1,2,5-tricarboxylate decarboxylase (EC 4.1.1.68) +FIG01754620 putative quinone oxidoreductase( EC:1.6.5.5 ) +FIG01754634 FIG00362141: hypothetical protein +FIG01754649 Adenine-specific methyltransferase activity Eco57IA (EC 2.1.1.72) +FIG01754675 FIG01089058: hypothetical protein +FIG01754688 FIG00344974: hypothetical protein +FIG01754691 FIG00390427: hypothetical protein +FIG01754700 Transcriptional Regulator, XRE family protein +FIG01754711 FIG00643341: hypothetical protein +FIG01754714 LacI family transcription regulator +FIG01754718 hypothetical protein +FIG01754742 FIG00752997: hypothetical protein +FIG01754754 FIG00525642: hypothetical protein +FIG01754759 FIG00623104: hypothetical protein +FIG01754793 membrane protein WxcE +FIG01754818 conserved protein, putative permease +FIG01754866 hypothetical protein +FIG01754869 FIG00642613: hypothetical protein +FIG01754884 FIG00938398: hypothetical protein +FIG01754950 FIG00472484: hypothetical protein +FIG01754958 FIG00769818: hypothetical protein +FIG01754987 PE_PGRS family protein +FIG01754989 FIG00389333: hypothetical protein +FIG01755028 ORF_ID:alr7003 +FIG01755039 ortholog of Bordetella pertussis (BX470248) BP3499 +FIG01755073 PTS system, beta-glucoside-specific IIBCA component (EC 2.7.1.69) +FIG01755080 FIG00605242: hypothetical protein +FIG01755119 Cuticle collagen 19 precursor +FIG01755122 FIG00388041: hypothetical protein +FIG01755147 tetracycline-efflux transporter +FIG01755183 FIG00623802: hypothetical protein +FIG01755245 Probable efflux protein Cj0035c +FIG01755321 endo/excinuclease domain protein +FIG01755335 Ferredoxin-type protein +FIG01755392 cd06127 DEDDh DNA polymerase III 3'-5' exonuclease domain +FIG01755403 Conjugal transfer coupling protein TraG +FIG01755429 related to spore coat protein F +FIG01755456 FIG00815886: hypothetical protein +FIG01755497 Putatative secreted serine protease +FIG01755506 FIG00688020: hypothetical protein +FIG01755512 dolichol-p-glucose synthetase, (glycosyltransferase) +FIG01755518 FIG00623649: hypothetical protein +FIG01755535 FIG00756900: hypothetical protein +FIG01755586 Response regulator (CheY-like receiver domain and HTH-type DNA-binding) +FIG01755715 FIG00642986: hypothetical protein +FIG01755755 FIG00388739: hypothetical protein +FIG01755795 GDP-mannose 4,6-dehydratase( EC:4.2.1.47 ) +FIG01755809 probable NADH-dependent dehydrogenase homolog +FIG01755826 FIG00674487: hypothetical protein +FIG01755891 ABC TRANSPORTER (ATP-BINDING PROTEIN) +FIG01755902 Sulfate transport system protein cysZ +FIG01755948 polysaccharide biosynthesis protein (putative) +FIG01755954 Hydrolase of MutT (Nudix) family +FIG01755978 mobilization protein A +FIG01756003 FIG00534016: hypothetical protein +FIG01756032 FIG00380732: hypothetical protein +FIG01756033 FIG00624592: hypothetical protein +FIG01756174 Chromate resistance protein +FIG01756191 Retinal degeneration B protein +FIG01756205 probable integrase +FIG01756211 Lmo0466 protein +FIG01756249 Rok family protein +FIG01756280 Nucleolar protein,Nop52 containing protein +FIG01756310 FIG00344609: hypothetical protein +FIG01756314 FIG01119828: hypothetical protein +FIG01756338 lipoprotein releasing system ATP-binding protein lolD +FIG01756369 Protein of unknown function DUF1778 +FIG01756391 FIG00413571: hypothetical protein +FIG01756392 Mck protein +FIG01756400 sulfur oxygenase reductase +FIG01756407 DNA-binding helix-turn-helix protein +FIG01756476 NapA-2 Na+/H+ antiporter +FIG01756533 FIG00687299: hypothetical protein +FIG01756561 FIG00675263: hypothetical protein +FIG01756582 FIG00752803: hypothetical protein +FIG01756587 LysR family transcriptional regulator YdcI +FIG01756628 Pseudogene of RecU (C-terminal part) +FIG01756637 FIG00405963: hypothetical protein +FIG01756720 FIG00388927: hypothetical protein +FIG01756735 FIG00623721: hypothetical protein +FIG01756800 FIG01041171: hypothetical protein +FIG01756835 D-aminoacylase( EC:3.5.1.81 ) +FIG01756840 eight transmembrane protein EpsH +FIG01756854 FIG00836469: hypothetical protein +FIG01756874 Membrane protein of YDFR family +FIG01756901 FIG00353761: hypothetical protein +FIG01756933 TM2 domain protein +FIG01756969 cysteine synthase A +FIG01756985 aconitate hydratase( EC:4.2.1.3 ) +FIG01757046 FIG00525458: hypothetical protein +FIG01757058 peptidase M20D, amidohydrolase +FIG01757123 Putative gas vesicle synthesis protein +FIG01757150 FIG01119306: hypothetical protein +FIG01757163 Integrin-like repeats domain fused to lysozyme, LYCV glycosyl hydrolase +FIG01757190 Putative inner membrane protein +FIG01757197 sensor histidine kinase( EC:2.7.3.- ) +FIG01757222 Protease( EC:3.4.- ) +FIG01757283 FIG00920303: hypothetical protein +FIG01757301 Alpha/beta hydrolase superfamily enzyme +FIG01757383 STAS domain +FIG01757405 pathogenesis related protein +FIG01757432 FIG00817591: hypothetical protein +FIG01757447 FIG00711636: hypothetical protein +FIG01757470 PASTA +FIG01757482 ATP synthase subunit D( EC:3.6.3.14 ) +FIG01757499 FIG00387829: hypothetical protein +FIG01757518 Two-component system, sensor protein +FIG01757556 Phage terminase small subunit-like protein +FIG01757566 peptidase M19, renal dipeptidase +FIG01757584 POSSIBLE DIOXYGENASE( EC:1.- ) +FIG01757632 FIG005274: hypothetical protein +FIG01757650 iron permease FTR1 +FIG01757677 FIG00388703: hypothetical protein +FIG01757718 argininosuccinate lyase( EC:4.3.2.1 ) +FIG01757746 NanA gene +FIG01757759 hypothetical protein +FIG01757794 FIG00752955: hypothetical protein +FIG01757805 FIG00957184: hypothetical protein +FIG01757868 probable acyltransferase +FIG01757895 response regulator of the LytR/AlgR family +FIG01757916 Outer membrane protein Lom +FIG01757981 alpha/beta superfamily hydrolase +FIG01758008 FIG00623157: hypothetical protein +FIG01758075 SpdB homolog +FIG01758080 FIG01241992: hypothetical protein +FIG01758115 N-acetylglucosaminyltransferase, MurG +FIG01758122 FIG00954961: hypothetical protein +FIG01758125 Uncharacterized protein AF_1109 +FIG01758154 FIG01002319: hypothetical protein +FIG01758186 phenylacetic acid degradation protein PaaI +FIG01758199 COG1626: Neutral trehalase( EC:3.2.1.28 ) +FIG01758212 conserved domain protein +FIG01758236 FIG00550776: hypothetical protein +FIG01758245 FIG01032599: hypothetical protein +FIG01758294 pullanase-associated protein +FIG01758341 protein containing glyoxalase/bleomycin resistance protein/dioxygenase superfamily domain +FIG01758346 FIG00352642: hypothetical protein +FIG01758372 FIG00516401: hypothetical protein +FIG01758432 FIG00922350: hypothetical protein +FIG01758465 DSBA thioredoxin domain protein +FIG01758503 FIG01167027: hypothetical protein +FIG01758522 Voltage-gated potassium channel subunit beta-1 (K(+) channel subunit beta-1) (Kv-beta-1) +FIG01758577 FIG01115363: hypothetical protein +FIG01758588 similar to repressor protein CI +FIG01758596 FIG00962931: hypothetical protein +FIG01758623 ribose operon repressor +FIG01758624 mediator of plasmid stability +FIG01758839 Putative cytochrome B561 +FIG01758994 FIG00654450: hypothetical protein +FIG01759003 FIG00508541: hypothetical protein +FIG01759017 pullulanase +FIG01759040 FIG00267170: hypothetical protein +FIG01759079 FIG01116849: hypothetical protein +FIG01759155 flagellar basal-body rod protein FlgB +FIG01759191 FIG01135803: hypothetical protein +FIG01759194 Arylamine N-acetyltransferase( EC:2.3.1.5 ) +FIG01759214 FIG00347597: hypothetical protein +FIG01759219 ATP-dependent protease Clp, ATPase subunit +FIG01759221 Beta-lactamase class C and other penicillin binding proteins +FIG01759233 Accessory secretory protein Asp5 +FIG01759267 FIG00710813: hypothetical protein +FIG01759283 Fe-S oxidoreductase-like protein +FIG01759301 FIG00746789: hypothetical protein +FIG01759304 hypothetical protein +FIG01759341 FIG00410859: hypothetical protein +FIG01759346 putative minor silk ampullate protein +FIG01759347 Pyrimidine reductase, riboflavin biosynthesis +FIG01759364 FIG01040094: hypothetical protein +FIG01759373 phage-like element pbsx protein xkdg +FIG01759462 FIG00352361: hypothetical protein +FIG01759501 Phosphate butyryltransferase (EC 2.3.1.19) +FIG01759534 FIG00404445: hypothetical protein +FIG01759576 FIG00733249: hypothetical protein +FIG01759617 FIG00426713: hypothetical protein +FIG01759664 Acyl-CoA dehydrogenase (EC 1.3.8.7) +FIG01759685 UPF0045 protein Mb1933 +FIG01759709 Protease inhibitor, SSI family (subtilisin inhibitor) +FIG01759744 glyoxalase +FIG01759745 electron transport protein/SenC +FIG01759762 FIG00748645: hypothetical protein +FIG01759771 FIG00624665: hypothetical protein +FIG01759791 COG4421: Capsular polysaccharide biosynthesis protein +FIG01759793 Mlr6157 protein +FIG01759828 FIG00487164: hypothetical protein +FIG01759846 endodeoxyribonuclease RusA +FIG01759886 FIG01243441: hypothetical protein +FIG01759911 fragment of transposase +FIG01759913 FIG00388194: hypothetical protein +FIG01759962 Unknown, transcriptional activator +FIG01759978 FIG00514873: hypothetical protein +FIG01760010 FIG00416545: hypothetical protein +FIG01760018 Putative adhesion and penetration protein +FIG01760019 Transposase +FIG01760021 FIG00388727: hypothetical protein +FIG01760089 FIG00411794: hypothetical protein +FIG01760160 hemerythrin-like metal-binding domain protein +FIG01760230 FIG00632154: hypothetical protein +FIG01760264 putative methanol oxidation protein +FIG01760266 NifU-like nitrogen fixation protein +FIG01760268 valine start +FIG01760269 hypothetical protein SC2H4.10 +FIG01760332 hemolysin/hemagglutinin-like protein HecA precursor +FIG01760354 exodeoxyribonuclease III +FIG01760377 DNA-binding response regulator +FIG01760380 isochorismatase( EC:3.3.2.1 ) +FIG01760393 FIG00412465: hypothetical protein +FIG01760406 transcriptional regulator (Xre family) +FIG01760468 Putative decarboxylase +FIG01760495 protein of unknown function DUF1428 +FIG01760497 FIG01166694: hypothetical protein +FIG01760505 FIG00523795: hypothetical protein +FIG01760536 Integrase-recombinase +FIG01760671 Basic membrane lipoprotein +FIG01760695 Tripeptidylaminopeptidase precursor +FIG01760702 Plasmid associated TOPRIM domain protein +FIG01760704 type IV prepilin peptidase PilD / late competence protein ComC processing protease +FIG01760711 GGDEF domain containing protein +FIG01760716 Sphingosine-1-phosphate lyase (EC 4.1.2.27) (SP-lyase) (SPL) (Sphingosine-1-phosphate aldolase) +FIG01760718 transposase of IS200 family +FIG01760722 aldehyde reductase +FIG01760796 Phenylacetyl-CoA:acceptor oxidoreductase +FIG01760799 FIG00962291: hypothetical protein +FIG01760861 Uncharacterized protein aq_1287 +FIG01760862 TnpA, transposase (5' segment) +FIG01760884 FIG00623362: hypothetical protein +FIG01760895 hypothetical protein +FIG01760915 jmjC domain protein +FIG01760974 FIG00643057: hypothetical protein +FIG01760975 FIG00640055: hypothetical protein +FIG01760985 FIG00348850: hypothetical protein +FIG01760988 FIG00424956: hypothetical protein +FIG01760999 InterPro IPR002142 COGs COG0616 +FIG01761007 putative bacteriocin +FIG01761037 Galactoside 2-alpha-L-fucosyltransferase 1 (EC 2.4.1.69) (GDP-L-fucose:beta-D-galactoside 2-alpha-L-fucosyltransferase 1) (Alpha(1,2)FT 1) (Fucosyltransferase 1) +FIG01761058 lysyl tRNA synthetase-like protein +FIG01761089 Histone-like protein of HNS family +FIG01761123 syc0475_d +FIG01761193 bacterioferritin comigratory protein homolog +FIG01761263 hypothetical protein +FIG01761301 HemU +FIG01761339 FIG00526816: hypothetical protein +FIG01761358 Bll5166 protein +FIG01761359 Transcriptional regulator, TetR +FIG01761407 FIG00578305: hypothetical protein +FIG01761410 cell well associated RhsD protein +FIG01761424 electron transport complex, RnfABCDGE type, B subunit +FIG01761512 caa(3)-type oxidase, subunit IV subfamily, putative +FIG01761540 Integral membrane glycosyltransferase +FIG01761564 Phospholipid scramblase 1 +FIG01761576 Cytochrome c mono- and diheme variants +FIG01761581 FIG00847606: hypothetical protein +FIG01761589 10.1 kDa protein (ORF 90) +FIG01761603 Metal-dependent hydrolase of the beta-lactamase superfamily III +FIG01761626 COG1922: Teichoic acid biosynthesis proteins +FIG01761686 YqaS +FIG01761761 luciferase-like protein +FIG01761785 protein of unknown function DUF1440 +FIG01761793 Mll2220 protein +FIG01761835 FIG00471843: hypothetical protein +FIG01761848 FIG00711127: hypothetical protein +FIG01761937 FIG01048823: hypothetical protein +FIG01761943 NHL repeat precursor +FIG01761999 FIG044987: protein with 4 CBS domains +FIG01762002 FIG01055219: hypothetical protein +FIG01762116 putative membrane protein, YibE/F-like family +FIG01762139 FIG00623328: hypothetical protein +FIG01762178 putative permease (major facilitator superfamily) +FIG01762189 FIG00878785: hypothetical protein +FIG01762191 hicA protein +FIG01762212 Sugar ABC transporter (permease) +FIG01762259 Chitooligosaccharide deacetylase +FIG01762324 FIG00816517: hypothetical protein +FIG01762409 polynucleotide kinase 3-phosphatase-like +FIG01762426 Small, acid-soluble spore protein tlp +FIG01762506 putative formyl transferase +FIG01762529 Hypothetical oxidoreductase ydbC (EC 1.-.-.-) +FIG01762531 FIG00712919: hypothetical protein +FIG01762548 FIG01116042: hypothetical protein +FIG01762558 putative recombination protein +FIG01762565 FIG00839154: hypothetical protein +FIG01762615 FIG01167042: hypothetical protein +FIG01762617 FIG00847553: hypothetical protein +FIG01762618 Acyl-CoA thioester-like hydrolase +FIG01762627 hypothetical protein-putative conserved hypothetical protein +FIG01762632 FIG00347630: hypothetical protein +FIG01762641 FIG00751500: hypothetical protein +FIG01762654 FIG00977738: hypothetical protein +FIG01762661 FIG00404839: hypothetical protein +FIG01762729 triacylglycerol lipase +FIG01762739 Oligopeptide transporter putative ATPase domain +FIG01762770 COG0433: Predicted ATPase +FIG01762809 Mrr restriction system protein-like protein +FIG01762842 cell wall-binding endopeptidase-related protein +FIG01762861 D-glucuronyl C5-epimerase +FIG01762917 FIG00526697: hypothetical protein +FIG01762945 FIG01233561: hypothetical protein +FIG01762994 FIG00418044: hypothetical protein +FIG01762999 FIG00412885: hypothetical protein +FIG01763012 putative prophage repressor +FIG01763015 FIG00631844: hypothetical protein +FIG01763016 Thioredoxin-like proteins and domains-like +FIG01763028 Transposase ISLasa4o, ISL3 family +FIG01763039 FIG00678339: hypothetical protein +FIG01763072 extracellular protease domain protein +FIG01763075 Protein of unknown function DUF488 +FIG01763091 Tetratricopeptide repeat +FIG01763165 FIG00571777: hypothetical protein +FIG01763191 FIG00524280: hypothetical protein +FIG01763205 putative ATP /GTP-binding protein +FIG01763229 Outer membrane lipoprotein blc precursor +FIG01763273 FIG00573914: hypothetical protein +FIG01763306 FIG00597853: hypothetical protein +FIG01763312 sensor protein, putative +FIG01763355 Transposase for insertion sequences IS1326/IS1353 +FIG01763479 Amino acid ABC transporter binding protein and permease protein +FIG01763503 Probable DNA methylase +FIG01763513 FIG00445004: hypothetical protein +FIG01763537 FIG00623376: hypothetical protein +FIG01763549 InterPro IPR001327 COGs COG2072 +FIG01763571 FIG00514352: hypothetical protein +FIG01763579 FIG00401914: hypothetical protein +FIG01763616 Helix-turn-helix motif protein +FIG01763684 Ketosteroid isomerase-like protein +FIG01763724 putative Rieske-like ferredoxin MocE +FIG01763792 FIG00921815: hypothetical protein +FIG01763793 Excinuclease ABC, C subunit domain protein +FIG01763798 Slr1770 protein +FIG01763808 peptidase A2A, retrovirus, catalytic +FIG01763815 COG1278: Cold shock proteins +FIG01763819 FIG01117577: hypothetical protein +FIG01763892 hypothetical protein +FIG01763909 putative cation transport protein +FIG01763949 Cadmium resistance transporter +FIG01763980 lipoprotein, NLP/P60 family protein +FIG01763988 FIG01029344: hypothetical protein +FIG01763999 membrane protein containing DoxX domain +FIG01764008 FIG00353832: hypothetical protein +FIG01764027 putative alkaline phosphatase D (APaseD) +FIG01764100 FIG01166388: hypothetical protein +FIG01764163 COGs COG1397 +FIG01764210 FIG00342445: hypothetical protein +FIG01764229 ABC transporter related precursor +FIG01764239 gluconate 5-dehydrogenase +FIG01764255 probable sugar transport inner membrane protein +FIG01764348 FIG00623837: hypothetical protein +FIG01764371 putative carbon-nitrogen hydrolase +FIG01764379 amino acid ABC transporter, ATP-binding protein +FIG01764385 FIG00775345: hypothetical protein +FIG01764415 FIG00517907: hypothetical protein +FIG01764472 putative IS630 family transposase +FIG01764529 FIG01086053: hypothetical protein +FIG01764537 FIG00638466: hypothetical protein +FIG01764595 putative GNAT-family acetyltransferase +FIG01764604 endonuclease of the HNH family +FIG01764638 Putative membrane protein precursor +FIG01764700 PhaK-like protein +FIG01764767 COG3239: Fatty acid desaturase +FIG01764771 FIG01251701: hypothetical protein +FIG01764823 FIG00688349: hypothetical protein +FIG01764922 Nitrogen assimilation regulatory protein nac +FIG01764928 cation efflux system (czcB-like) +FIG01764934 prophage Lp2 protein 52 +FIG01764997 Possible nodulin-related protein +FIG01765049 ORF_ID:all7653 unknown protein +FIG01765050 FIG00526546: hypothetical protein +FIG01765090 FIG00348486: hypothetical protein +FIG01765142 Putative oxidoreductase; (Related to short-chain alcohol dehydrogenases) +FIG01765150 Integral membrane protein precursor +FIG01765218 prolyl endopeptidase( EC:3.4.21.26 ) +FIG01765247 extracellular serine protease( EC:3.4.21.- ) +FIG01765310 transcriptional regulatory protein TcpP +FIG01765327 siderophore biosynthesis protein, putative +FIG01765388 FIG00361611: hypothetical protein +FIG01765398 Zn-dependent metalloprotease, insulinase family +FIG01765413 bll8024; hypothetical protein +FIG01765433 FIG00895326: hypothetical protein +FIG01765440 hypothetical protein +FIG01765454 similar to Glycine/D-amino acid oxidases (deaminating) +FIG01765506 Probable serine/threonine protein kinase (EC 2.7.1.-) +FIG01765559 FIG00352080: hypothetical protein +FIG01765562 FIG01191312: hypothetical protein +FIG01765571 FIG00897876: hypothetical protein +FIG01765618 Transcription activator gutR +FIG01765630 FIG00388245: hypothetical protein +FIG01765666 Prefoldin alpha subunit (GimC alpha subunit) +FIG01765702 Alpha-amylase (EC 3.2.1.1) (1,4-alpha-D-glucan glucanohydrolase) (GLYCOGENASE) +FIG01765725 hypothetical protein +FIG01765749 FIG00753621: hypothetical protein +FIG01765782 Esterase/lipase-like +FIG01765825 Two-component response regulator virR +FIG01765836 IS, phage, Tn; Transposon-related functions +FIG01765861 sigma factor +FIG01765872 pilin, type IV, putative +FIG01765884 FIG00365171: hypothetical protein +FIG01765935 FIG00278285: hypothetical protein +FIG01765958 ApbE family protein, putative +FIG01766070 FIG00410920: hypothetical protein +FIG01766131 amino acid transporter, periplasmic amino acid-binding protein +FIG01766215 probable protein kinase yloP +FIG01766238 maltose phosphorylase (EC 2.4.1.8) +FIG01766240 FIG00451926: hypothetical protein +FIG01766303 hypothetical protein +FIG01766315 TRAP-type mannitol/chloroaromatic compound transport system, large permease component +FIG01766347 carbohydrate-selective porin +FIG01766362 Alr1215 protein +FIG01766410 FIG01272578: hypothetical protein +FIG01766420 FIG00364912: hypothetical protein +FIG01766430 RWP-RK domain-containing protein +FIG01766511 FIG00755281: hypothetical protein +FIG01766530 Hpt +FIG01766550 Possible membrane-spanning protein +FIG01766553 Putative MarR-family transcriptional regulator +FIG01766572 FIG00623941: hypothetical protein +FIG01766609 PUTATIVE PROLIN-RICH TRANSMEMBRANE PROTEIN +FIG01766618 probable multidrug efflux transport protein +FIG01766623 3-oxoacyl-ACP reductase +FIG01766643 Orf59 +FIG01766653 phosphate regulatory protein-like +FIG01766683 UDP-galactopyranose mutase (EC 5.4.99.9) +FIG01766735 FIG00909075: hypothetical protein +FIG01766763 Conserved oxidoreductase (EC 1.3.1.26) +FIG01766846 UPF0145 protein MA_3383 +FIG01766867 putative secreted serine protease [EC:3.4.21.-] +FIG01766888 Acetyltransferase +FIG01766892 FIG01120505: hypothetical protein +FIG01766958 FIG00816971: hypothetical protein +FIG01766991 FIG00348290: hypothetical protein +FIG01767024 acyl carrier protein ACP +FIG01767036 Thioredoxin domain-containing protein +FIG01767054 phosphopantetheinyltransferase component of enterobactin synthase multienzyme complex +FIG01767074 probable multiple antibiotic resistance protein MarC +FIG01767080 FIG01166330: hypothetical protein +FIG01767102 hypothetical protein +FIG01767165 putative glutamate transporter glutamate-binding protein +FIG01767202 protein of unknown function DUF1212 +FIG01767211 phosphoenolpyruvate-dependent sugar phosphotransferase system EIIABC, glucose specific +FIG01767239 FIG01232866: hypothetical protein +FIG01767319 hypothetical protein +FIG01767334 YceI-like family protein +FIG01767339 FIG00854213: hypothetical protein +FIG01767346 Glucose-6-phosphate isomerase-like protein (EC 5.3.1.9) +FIG01767347 similar to two-component sensor histidine kinase +FIG01767363 FIG00874608: hypothetical protein +FIG01767369 putative deaminase +FIG01767378 Sulfatase domain protein +FIG01767406 FIG01023769: hypothetical protein +FIG01767408 Molybdopterin biosynthesis MoeB protein +FIG01767499 Epoxide hydrolase, N-terminal +FIG01767524 FIG00415328: hypothetical protein +FIG01767533 FIG00352171: hypothetical protein +FIG01767546 transcriptional regulator +FIG01767615 FIG00344550: hypothetical protein +FIG01767621 Sodium pump decarboxylase, gamma subunit +FIG01767628 Foldase protein prsA precursor (EC 5.2.1.8) +FIG01767647 Putative mutase +FIG01767674 COG1167: Transcriptional regulators containing a DNA-binding HTH domain and an aminotransferase domain (MocR family) and their eukaryotic orthologs +FIG01767679 Glycosyl transferase, group 2 family +FIG01767761 prophage transcriptional regulator +FIG01767773 lipoprotein NlpC +FIG01767835 phage lysozyme( EC:3.2.1.17 ) +FIG01767867 Tsr0373 protein +FIG01767872 FIG00867206: hypothetical protein +FIG01767955 FIG00344680: hypothetical protein +FIG01768012 FIG00850175: hypothetical protein +FIG01768126 FIG01126813: hypothetical protein +FIG01768129 FIG01218798: hypothetical protein +FIG01768170 FIG01248797: hypothetical protein +FIG01768188 Serine-threonine protein kinase (EC 2.7.11.1) +FIG01768255 FIG01134604: hypothetical protein +FIG01768341 Taurine transport ATP-binding protein tauB +FIG01768408 FIG01250421: hypothetical protein +FIG01768412 FIG00519694: hypothetical protein +FIG01768432 FIG01002288: hypothetical protein +FIG01768451 FIG00623459: hypothetical protein +FIG01768487 hypothetical protein +FIG01768523 FIG00468730: hypothetical protein +FIG01768535 RbsC-4, ribose ABC transporter, permease protein +FIG01768538 amino acid-binding ACT domain protein +FIG01768550 FIG00768027: hypothetical protein +FIG01768551 BINDING COMPONENT OF ABC TRANSPORTER +FIG01768587 FIG00418058: hypothetical protein +FIG01768629 FIG01166359: hypothetical protein +FIG01768643 Xanthine/uracil/vitamin C permease +FIG01768658 FIG00742143: hypothetical protein +FIG01768661 Elements of external origin; Transposon-related functions +FIG01768683 UDP-glucose 6-dehydrogenase (EC 1.1.1.22) +FIG01768697 FIG00388175: hypothetical protein +FIG01768700 META domain protein +FIG01768735 ANHYDRO-N-ACETYLMURAMYL-TRIPEPTIDE AMIDASE +FIG01768739 lipopolysaccharide N-acetylglucosaminyltransferase +FIG01768748 conserved membrane protein YoaK +FIG01768763 N-terminal methylation +FIG01768823 FIG00388137: hypothetical protein +FIG01768858 Conjugal transfer protein, TraD +FIG01768932 conserved hypothetical protein containing a ferredoxin domain +FIG01768973 ORF_ID:alr7543 unknown protein +FIG01768996 FIG00759726: hypothetical protein +FIG01769003 Uracil-DNA glycosylase +FIG01769023 FIG00515673: hypothetical protein +FIG01769060 Probable tail fiber assembly protein +FIG01769072 AAA ATPase, central domain protein +FIG01769075 putative repressor C1 +FIG01769082 Hypothetical SecA-related protein +FIG01769083 RalF protein, translocated into host cells by the Dot/Icm system +FIG01769088 FIG00516041: hypothetical protein +FIG01769097 putative lipooligosaccharide cholinephosphotransferase +FIG01769098 FIG00744371: hypothetical protein +FIG01769151 primase +FIG01769191 hypothetical protein +FIG01769280 FIG00997866: hypothetical protein +FIG01769288 conserved hypothetical protein +FIG01769302 molybdopterin converting factor +FIG01769315 IclR family transcriptional regulator +FIG01769319 amino acid ABC transporter, amino acid-binding/permease protein +FIG01769363 outer membrane usher protein +FIG01769396 Phage-related protein HI1409 +FIG01769425 FIG00760530: hypothetical protein +FIG01769442 proteinase like protein +FIG01769502 FIG00644472: hypothetical protein +FIG01769534 FIG00711465: hypothetical protein +FIG01769554 membrane-associated sensory histidine kinase-like ATPase +FIG01769561 coronafacic acid synthetase, acyl carrier protein component +FIG01769625 enzyme with TIM-barrel fold +FIG01769759 COG2353: Uncharacterized conserved protein +FIG01769763 Spo0E like sporulation regulatory protein +FIG01769781 molybdopterin converting factor, subunit 1 +FIG01769785 putative NADH oxidase +FIG01769831 FIG01063310: hypothetical protein +FIG01769839 hypothetical protein +FIG01769850 FIG00344546: hypothetical protein +FIG01769880 FIG00775637: hypothetical protein +FIG01770053 FIG00352766: hypothetical protein +FIG01770092 possible oxoacyl carrier protein reductase( EC:1.1.1.100 ) +FIG01770162 corresponds to STY4647 from Accession AL513382: Salmonella typhi CT18 +FIG01770199 FIG00521143: hypothetical protein +FIG01770276 Putative glutathione s-transferase transmembrane protein (EC 2.5.1.18) +FIG01770278 Dipeptidyl aminopeptidase/acylaminoacyl-peptidase-like protein +FIG01770283 P pilus assembly protein FimD +FIG01770327 FIG00348635: hypothetical protein +FIG01770329 O-antigen transporter permease +FIG01770348 FIG01074383: hypothetical protein +FIG01770353 FIG00344314: hypothetical protein +FIG01770413 FIG00840499: hypothetical protein +FIG01770468 putative antigen 34 kDa family +FIG01770477 FIG00860898: hypothetical protein +FIG01770545 FIG00349257: hypothetical protein +FIG01770554 hypothetical protein +FIG01770568 FIG00674367: hypothetical protein +FIG01770612 FIG01124630: hypothetical protein +FIG01770644 Predicted endonuclease, URI domain +FIG01770675 glycosyl hydrolase, family 16 +FIG01770697 ABC transporter membrane-spanning permease - macrolide efflux +FIG01770829 Oxygen-independent coproporphyrinogen III oxidase( EC:1.- ) +FIG01770855 putative flagellar protein FliS +FIG01770899 probable membrane protein YPO2574 +FIG01770928 Chromosome segregation ATPases-like protein +FIG01770933 FIG00749452: hypothetical protein +FIG01770942 helix-turn-helix DNA binding protein +FIG01770995 serine-threonine protein kinase +FIG01771072 2-iminoacetate synthase (ThiH) (EC 4.1.99.19) +FIG01771099 putative Acetyltransferase +FIG01771107 FIG00447263: hypothetical protein +FIG01771154 FIG00352259: hypothetical protein +FIG01771263 TPP-requiring enzyme co-localized with fatty acid metabolic genes +FIG01771280 probable periplasmic protein Cj1004 +FIG01771389 FIG00623771: hypothetical protein +FIG01771445 3-oxoacyl-(acyl-carrier protein) reductase( EC:1.1.1.100 ) +FIG01771455 Re face-specific citrate synthase (EC 2.3.3.3) / extracellular cache domain +FIG01771462 FIG00685476: hypothetical protein +FIG01771490 FIG00412456: hypothetical protein +FIG01771527 FIG01108633: hypothetical protein +FIG01771640 FIG00673719: hypothetical protein +FIG01771691 cytochrome c-553 +FIG01771748 hypothetical protein +FIG01771807 putative ATPase and membrane protein +FIG01771826 FIG014387: Transcriptional regulator, PadR family +FIG01771860 probable bacteriophage tail fibre protein +FIG01771875 FIG00413839: hypothetical protein +FIG01771904 FIG00786363: hypothetical protein +FIG01771941 sodium dependent amino acid transporter +FIG01771968 FIG00918533: hypothetical protein +FIG01771982 syc0753_c +FIG01771986 biogenesis of cell wall (cell envelope) +FIG01771987 cytosine specific DNA methyltransferase (DDEM) +FIG01771994 conserved hypothetical protein, putative +FIG01772096 putative fiber protein +FIG01772127 FIG00829339: hypothetical protein +FIG01772135 Pup ligase PafA +FIG01772262 phage recombinase, putative +FIG01772283 Fermentation/respiration switch protein +FIG01772370 FIG00424199: hypothetical protein +FIG01772460 universally conserved protein +FIG01772478 FIG00523765: hypothetical protein +FIG01772484 Myb domain-containing protein +FIG01772519 type I site-specific deoxyribonuclease, HsdR family +FIG01772528 cytochrome b5 +FIG01772563 Putative transport system permease (iron) +FIG01772571 FIG00518023: hypothetical protein +FIG01772574 Probable phage hk97 tail length tape measure-related protein +FIG01772591 DpgB +FIG01772598 Appr-1-p processing enzyme family +FIG01772627 FIG00964012: hypothetical protein +FIG01772630 Dsg protein involved in extracellular polysaccharide synthesis and transport +FIG01772641 RNA lariat debranching enzyme +FIG01772644 FIG00622817: hypothetical protein +FIG01772651 FIG00356500: hypothetical protein +FIG01772652 protein of unknown function DUF1573 +FIG01772754 FIG00348036: hypothetical protein +FIG01772799 Transmembrane component of energizing module of predicted B12-regulated ECF transporter for dimethylbenzimidazole +FIG01772884 FIG00520199: hypothetical protein +FIG01772926 Protein kilB +FIG01772928 Mlr7830 protein +FIG01772931 FIG00388315: hypothetical protein +FIG01772955 aculeacin A acylase( EC:3.5.1.- ) +FIG01772990 protein of unknown function DUF1400 +FIG01773044 hypothetical protein +FIG01773137 Lysyltransferase (EC 2.3.2.3) +FIG01773167 two-component response regulator PilR +FIG01773235 Conserved OsmC-like protein +FIG01773254 FIG00385590: hypothetical protein +FIG01773303 putative hydrolase( EC:3.8.1.3 ) +FIG01773345 60 kDa outer membrane protein +FIG01773390 sodium/proton antiporter +FIG01773416 FIG00764652: hypothetical protein +FIG01773479 FIG00412305: hypothetical protein +FIG01773520 FIG00529816: hypothetical protein +FIG01773534 FIG01214113: hypothetical protein +FIG01773547 putative protein GP15 +FIG01773593 Sll0678 protein +FIG01773618 negative regulation of sporulation and degradative enzyme genes +FIG01773637 FIG00624488: hypothetical protein +FIG01773669 FIG00745243: hypothetical protein +FIG01773691 FIG00344293: hypothetical protein +FIG01773743 FIG00633230: hypothetical protein +FIG01773824 FIG00405311: hypothetical protein +FIG01773847 Probable ATP-dependent helicase Lhr +FIG01773870 Asr3080 protein +FIG01773922 latex allergen from Hevea brasiliensis +FIG01774016 FIG01165637: hypothetical protein +FIG01774064 FIG01181182: hypothetical protein +FIG01774090 FIG00799662: hypothetical protein +FIG01774130 FIG00256215: hypothetical protein +FIG01774133 FIG01191494: hypothetical protein +FIG01774153 FIG00416554: hypothetical protein +FIG01774173 porin, Gram-negative type +FIG01774184 Chemotaxis protein CheYIV +FIG01774274 heat shock protein-related protein +FIG01774313 Predicted GTPase, probable translation factor +FIG01774385 FIG00752733: hypothetical protein +FIG01774460 ABC sugar transporter, fused ATP-binding subunits +FIG01774480 FIG00596268: hypothetical protein +FIG01774502 barstar-like protein ribonuclease (barnase) inhibitor +FIG01774634 Predicted amidohydrolases +FIG01774647 probable sodium/alanine symporter +FIG01774657 Probably membrane protein +FIG01774690 MATE efflux family protein +FIG01774703 protein of unknown function UPF0270 +FIG01774758 large integral membrane protein +FIG01774804 FIG00642371: hypothetical protein +FIG01774807 FIG00815682: hypothetical protein +FIG01774826 Secreted protein, containing thioredoxin-like domain +FIG01774851 inner membrane ABC transporter ATP-binding protein yddA domain protein +FIG01774871 malate synthase( EC:2.3.3.9 ) +FIG01774873 Transcriptional Regulator, ArsR family +FIG01774916 Fimbrial subunit protein +FIG01774942 3-chlorobenzoate-3,4-dioxygenase dyhydrogenase related protein +FIG01774983 FIG00769358: hypothetical protein +FIG01774987 FIG01101286: hypothetical protein +FIG01775004 FIG00353047: hypothetical protein +FIG01775036 Ycf83 protein +FIG01775058 FIG00815183: hypothetical protein +FIG01775091 Aspergillopepsin-2 precursor (EC 3.4.23.19) +FIG01775132 FIG00527833: hypothetical protein +FIG01775133 CheE protein +FIG01775278 probable yciF protein +FIG01775280 FIG00468744: hypothetical protein +FIG01775368 FIG00347697: hypothetical protein +FIG01775376 FIG00380826: hypothetical protein +FIG01775471 Protein of unknown function DUF47 +FIG01775483 serine/threonine kinase related protein +FIG01775499 FIG00876980: hypothetical protein +FIG01775505 FIG01118840: hypothetical protein +FIG01775529 FIG00624822: hypothetical protein +FIG01775544 UPF0331 protein MJ0434 +FIG01775573 COGs COG0726 +FIG01775586 FIG00721579: hypothetical protein +FIG01775593 FIG00794344: hypothetical protein +FIG01775647 transposase IS1533 +FIG01775683 FIG00425827: hypothetical protein +FIG01775721 Tail length tape measure protein +FIG01775736 Monomeric sarcosine oxidase (EC 1.5.3.1) (MSOX) +FIG01775744 hypothetical protein Ajs_0007 +FIG01775769 FIG00361184: hypothetical protein +FIG01775773 FIG01043392: hypothetical protein +FIG01775790 regulator of melibiose operon +FIG01775847 FIG01180438: hypothetical protein +FIG01775864 FIG01127175: hypothetical protein +FIG01775903 FIG00468694: hypothetical protein +FIG01775914 Signal Transduction Histidine Kinase (STHK), LytS +FIG01775919 heat shock protein G homolog +FIG01775929 FIG00352507: hypothetical protein +FIG01775946 FIG00752523: hypothetical protein +FIG01775971 putative trypsin-like proteinase +FIG01776008 FIG00344583: hypothetical protein +FIG01776118 hypothetical protein +FIG01776122 FIG00752859: hypothetical protein +FIG01776140 adenine-specific DNA modification methyltransferase +FIG01776147 Bacterioferritin (cytochrome b1) +FIG01776227 Thioredoxin-related protein +FIG01776257 FIG01069656: hypothetical protein +FIG01776267 glutamate--cysteine ligase, putative, truncated +FIG01776286 Asp-tRNAAsn/Glu-tRNAGln amidotransferase C subunit +FIG01776316 manganese transporter +FIG01776317 Ric1 protein +FIG01776333 polyketide synthesis 8-O-methyltransferase( EC:2.1.1.- ) +FIG01776341 putative diacylglycerol kinase +FIG01776371 FIG00642913: hypothetical protein +FIG01776394 hydrolase, CbbY/CbbZ/GpH/YieH family +FIG01776470 FIG00870967: hypothetical protein +FIG01776537 Heat shock protein DnaJ-like +FIG01776548 Putative ski2-type helicase (EC 3.6.1.-) +FIG01776620 probable cytochrome c' +FIG01776638 FIG00344620: hypothetical protein +FIG01776677 PE-PGRS FAMILY PROTEIN [SECOND PART] +FIG01776694 FIG00549989: hypothetical protein +FIG01776706 FIG01125613: hypothetical protein +FIG01776740 cytochrome P-450 hydroxylase +FIG01776744 TRK potassium uptake system protein +FIG01776764 SAM-dependent methyltransferase, UbiE/CobQ family +FIG01776779 Long-chain fatty acid transporter +FIG01776840 hypothetical protein +FIG01776889 DNA, complete genome +FIG01776899 FIG00389064: hypothetical protein +FIG01776912 COG0645: Predicted kinase +FIG01776931 prophage LambdaSa2, transcriptional regulator, Cro/CI family +FIG01776952 Ig domain protein, group 2 domain protein +FIG01777008 toxin-antitoxin protein, putative +FIG01777011 phage-related terminase small chain homolog yqaS +FIG01777050 Ethanolamine utilization protein EutA +FIG01777076 Probable carboxy-terminal processing proteinase ctpA +FIG01777083 FIG00385144: hypothetical protein +FIG01777095 Chain A, Solution Nmr Structure Of The Yjcq Protein From Bacillus Subtilis. Northeast Structural Genomics Target Sr346 +FIG01777104 FIG00698173: hypothetical protein +FIG01777108 phosphoribosylformylglycinamidine synthase subunit II( EC:6.3.5.3 ) +FIG01777118 phage-related putative DNA binding protein +FIG01777119 conserved hypothetical protein; possible permease +FIG01777122 protein of unknown function DUF99 +FIG01777192 putative transporter ATPase +FIG01777196 FIG00388360: hypothetical protein +FIG01777203 4-methyl-5(beta-hydroxyethyl)-thiazole monophosphate synthesis protein +FIG01777217 ATP-dependent carboxylate-amine ligase domain protein, ATP-grasp +FIG01777256 FIG00922654: hypothetical protein +FIG01777260 FIG00264013: hypothetical protein +FIG01777265 sugar transporter sugar binding protein +FIG01777301 FIG00472589: hypothetical protein +FIG01777305 FIG00518284: hypothetical protein +FIG01777339 TonB-dependent receptor precursor +FIG01777382 sugar ABC transporter, permease +FIG01777386 Baseplate J-like protein +FIG01777424 Polyprenyl synthetase +FIG01777449 FIG00516058: hypothetical protein +FIG01777478 Hydrogenase maturation factor HoxQ domain-containing protein +FIG01777540 FIG00817518: hypothetical protein +FIG01777610 FIG00388767: hypothetical protein +FIG01777655 FIG00817608: hypothetical protein +FIG01777667 GTP-binding domain protein +FIG01777676 FIG00389009: hypothetical protein +FIG01777686 FIG00624257: hypothetical protein +FIG01777733 Beta-1,4-mannanase +FIG01777757 FIG00751812: hypothetical protein +FIG01777774 similar to ATPase involved in chromosome partitioning +FIG01777864 Bona fide RidA/YjgF/TdcF/RutC subgroup +FIG01777888 FIG00363220: hypothetical protein +FIG01777893 traI protein (DNA helicase I)( EC:3.6.1.- ) +FIG01777922 FIG01030462: hypothetical protein +FIG01777977 tRNA uridine 5-carboxymethylaminomethyl modification enzyme GidA +FIG01777985 ATPase component BL0693 of energizing module of predicted ECF transporter +FIG01777998 DNA invertase from prophage CP-933H +FIG01778037 site specific recombinase +FIG01778082 FIG00775799: hypothetical protein +FIG01778087 opacity protein and related surface antigens +FIG01778088 hypothetical protein +FIG01778138 RNA methyltransferase, TrmH family, group 3 +FIG01778153 FIG00620252: hypothetical protein +FIG01778201 FIG00531489: hypothetical protein +FIG01778278 ferritin like protein (RsgA) +FIG01778314 FIG01085379: hypothetical protein +FIG01778341 similarity to ATP-dependent protease subunit C (ClpC) +FIG01778358 UPF0102 protein TTE1452 +FIG01778398 Branched-chain amino acid transport system permease protein LivM (TC 3.A.1.4.1) +FIG01778450 FIG00427413: hypothetical protein +FIG01778458 putative outer-membrane protein precursor +FIG01778518 FIG00826238: hypothetical protein +FIG01778522 FIG00417587: hypothetical protein +FIG01778539 FIG01117676: hypothetical protein +FIG01778541 putative propanediol utilization protein +FIG01778562 Substrate-specific component BioY of biotin ECF transporter +FIG01778563 UPF0310 protein PYRAB08750 +FIG01778594 FIG01246902: hypothetical protein +FIG01778600 N-acetyl-glucosamine transferase +FIG01778623 Alkaline phosphatase precursor (EC 3.1.3.1) (APASE) +FIG01778695 hypothetical protein TRANSMEMBRANE +FIG01778704 FIG00968549: hypothetical protein +FIG01778737 FIG00977325: hypothetical protein +FIG01778790 Histone acetyltransferase HPA2/related acetyltransferase +FIG01778806 FIG00411025: hypothetical protein +FIG01778810 flavoredoxin, putative +FIG01778873 Phosphopantetheine-binding +FIG01778906 FIG00643520: hypothetical protein +FIG01778924 histidine protein kinase +FIG01778947 Galactophilic lectin PA-I +FIG01778968 FIG00361445: hypothetical protein +FIG01779003 FIG00746856: hypothetical protein +FIG01779024 capsid protein E +FIG01779040 FIG01124310: hypothetical protein +FIG01779054 putative repressor protein - phage associated +FIG01779072 InterPro IPR002931 COGs COG1305 +FIG01779136 FIG005189: putative transferase clustered with tellurite resistance proteins TehA/TehB +FIG01779170 Type IV fimbrial biogenesis protein FimT +FIG01779172 probable Zn-dependent protease +FIG01779192 FIG00363789: hypothetical protein +FIG01779212 Methylisocitrate lyase (EC 4.1.3.30) +FIG01779234 Predicted Fe-S oxidoreductases +FIG01779237 hypothetical protein +FIG01779308 FIG00388526: hypothetical protein +FIG01779314 Sll1359 protein +FIG01779336 similar to protein BmrU +FIG01779355 heavy metal efflux pump, CzcB family +FIG01779412 Unknown, putative LysR-type transcriptional regulator +FIG01779422 InterPro IPR003423 COGs COG1538 +FIG01779435 Mat +FIG01779467 FIG00836071: hypothetical protein +FIG01779504 Ribonuclease (EC 3.1.27.-) +FIG01779533 FIG00380174: hypothetical protein +FIG01779559 Ferredoxin 1 +FIG01779571 FIG00962583: hypothetical protein +FIG01779663 FIG00344942: hypothetical protein +FIG01779702 FIG00516896: hypothetical protein +FIG01779742 transposase, fragment +FIG01779777 FIG00245279: hypothetical protein +FIG01779788 csfB protein, putative +FIG01779821 FIG00344411: hypothetical protein +FIG01779840 FIG01044525: hypothetical protein +FIG01779901 conserved hypothetical protein-possibly contains sugar binding site +FIG01779905 minor structural protein 3 +FIG01779906 Transcriptional activator of the alkB cluster +FIG01779922 PPE family protein +FIG01779944 R body protein, putative +FIG01779963 ThiJ/pfpI family protein +FIG01780026 FIG00406036: hypothetical protein +FIG01780073 Metal-dependent hydrolases of the beta-lactamase superfamily I; PhnP protein +FIG01780166 FIG00883824: hypothetical protein +FIG01780170 Methyltransferase (EC 2.1.1.-) +FIG01780181 FIG00639972: hypothetical protein +FIG01780187 FIG00766366: hypothetical protein +FIG01780188 Organophosphate pesticide hydrolase +FIG01780192 conserved hypothetical protein - phage 370.2 protein +FIG01780241 FIG00818158: hypothetical protein +FIG01780242 putative ABC transporter ATPase component +FIG01780248 FIG00352612: hypothetical protein +FIG01780361 possible Ribosomal protein S14p/S29e +FIG01780423 Gene D protein +FIG01780424 putative beta-agarase precursor +FIG01780434 chitin-binding protein CbpD +FIG01780466 FIG00644795: hypothetical protein +FIG01780477 recombination and DNA repair +FIG01780528 Penicillinase repressor +FIG01780579 FIG00624809: hypothetical protein +FIG01780640 pyridoxamine 5'-phosphate oxidase-related FMN-binding +FIG01780689 putative copper resistance (CopC-like) +FIG01780797 phosphate transport system substrate-binding protein +FIG01780800 Possible membrane protein +FIG01780872 Uncharacterized protein, YJDF B.subtilis ortholog +FIG01780887 peptidase M15D vanX D-ala-D-ala dipeptidase +FIG01780902 resolvase domain-containing protein +FIG01780946 TraY protein +FIG01780987 Periplasmic aromatic aldehyde oxidoreductase, molybdenum binding subunit YagR +FIG01780997 FIG01008871: hypothetical protein +FIG01781017 signal transduction histidine kinase with CheB and CheR activity +FIG01781057 epoxide hydrolase( EC:3.3.2.3 ) +FIG01781070 FIG01068745: hypothetical protein +FIG01781087 Ankyrin repeat +FIG01781096 protein ydhR precursor +FIG01781119 FIG00523410: hypothetical protein +FIG01781126 Subtilisin inhibitor precursor +FIG01781237 FIG00349066: hypothetical protein +FIG01781251 Pirin-like protein YhhW, possibly qercetin 2,3-dioxygenase activity +FIG01781254 FIG00923595: hypothetical protein +FIG01781272 FIG00344054: hypothetical protein +FIG01781290 truncated transposase +FIG01781298 FIG00417891: hypothetical protein +FIG01781308 putative CbbY homolog +FIG01781323 HD-hydrolase domain +FIG01781359 possible bacteriophage Mu G-like protein +FIG01781366 FIG00768960: hypothetical protein +FIG01781404 metal-dependent membrane protease +FIG01781448 NifU protein, putative +FIG01781487 FIG00948920: hypothetical protein +FIG01781532 type IV fimbrial assembly protein PilB +FIG01781534 FIG00733900: hypothetical protein +FIG01781538 FIG00389079: hypothetical protein +FIG01781623 DNA topoisomerase (ATP-hydrolyzing), subunit B +FIG01781651 FIG00623046: hypothetical protein +FIG01781681 FIG00827143: hypothetical protein +FIG01781691 Gas vesicle protein GvpK +FIG01781714 FIG00348117: hypothetical protein +FIG01781715 FIG00356622: hypothetical protein +FIG01781729 FIG00734234: hypothetical protein +FIG01781748 Uncharacterized protein HI0073 +FIG01781825 TPR repeat-containing protein 03 +FIG01781826 FIG00526249: hypothetical protein +FIG01781837 putative autoaggregation protein +FIG01781865 PROBABLE PEPTIDE SYNTHETASE PROTEIN +FIG01782001 FIG00733298: hypothetical protein +FIG01782054 FIG01094098: hypothetical protein +FIG01782059 FIG00687166: hypothetical protein +FIG01782118 FIG01093180: hypothetical protein +FIG01782132 FIG00411111: hypothetical protein +FIG01782163 predicted MutT-like hydrolases +FIG01782240 conserved hypothetical protein, MbtH family +FIG01782267 FIG00639686: hypothetical protein +FIG01782318 Putative Nudix hydrolase +FIG01782341 FIG01278058: hypothetical protein +FIG01782363 probable serine proteinase, subtilase family protein +FIG01782396 FIG00533518: hypothetical protein +FIG01782425 Ankyrin repeat-containing protein +FIG01782452 FIG00623254: hypothetical protein +FIG01782460 transcription; transcriptional control +FIG01782491 FIG01225228: hypothetical protein +FIG01782494 FIG00642459: hypothetical protein +FIG01782549 putative penicillin amidase +FIG01782739 TPR repeat:Tetratricopeptide TPR_3 +FIG01782778 Putative polyphosphate-selective porin O +FIG01782807 FIG00388851: hypothetical protein +FIG01782876 CAIB-BAIF family protein +FIG01782942 PUTATIVE PERIPLASMIC PROTEIN-TRXB +FIG01782944 Mll4938 protein +FIG01783018 3-oxoadipate enol-lactonase (EC 3.1.1.24) +FIG01783044 peptidase C39, bacteriocin processing +FIG01783046 FIG00760545: hypothetical protein +FIG01783050 putative conjugative transfer protein TraF +FIG01783075 hypothetical protein; putative phosphatase +FIG01783100 FIG00523060: hypothetical protein +FIG01783147 sulfur oxidation protein SoxY +FIG01783219 3'-phosphoadenosine 5'-phosphosulfate sulfotransferase +FIG01783350 restriction endonuclease family +FIG01783352 syc0249_d +FIG01783466 L-fucose isomerase related protein +FIG01783581 FIG01234397: hypothetical protein +FIG01783596 FIG00348864: hypothetical protein +FIG01783622 nucleoside permease NupC +FIG01783642 hypothetical protein +FIG01783644 molybdenum-pterin binding domain protein/site-specific recombinase, phage integrase family +FIG01783730 3-isopropylmalate dehydrogenase( EC:1.1.1.85 ) +FIG01783759 PUTATIVE MFS TRANSPORTER +FIG01783780 ferredoxin-related protein +FIG01783840 glycosyl hydrolase-like +FIG01783862 Fatty acid hydroxylase FAH1P +FIG01783882 DNA segregation ATPase +FIG01783902 MCBG protein-like (microcin resistance protein) +FIG01783933 FIG01016881: hypothetical protein +FIG01783961 hypothetical protein +FIG01783993 Penicillin amidase( EC:3.5.1.11 ) +FIG01784033 zinc metallohydrolase +FIG01784039 RNA polymerase sigma factor, group 3 +FIG01784055 probable cysteinyl-tRNA synthetase( EC:6.1.1.16 ) +FIG01784059 FIG00748714: hypothetical protein +FIG01784141 M protein, putative +FIG01784157 hypothetical protein +FIG01784223 FIG00387969: hypothetical protein +FIG01784260 Gb|AAD14522.1 +FIG01784323 putative protein-L-isoaspartate(D-aspartate) O-methyltransferase( EC:2.1.1.77 ) +FIG01784341 FmhB protein of FemAB family involved in peptidoglycan interpeptide biosynthesis +FIG01784342 Unknown, putative fimbrial chaperone +FIG01784375 FIG01116292: hypothetical protein +FIG01784400 LAO/AO transport system ATPase +FIG01784420 Resolvase, N-terminal:Resolvase helix-turn-helix region +FIG01784432 prolyl oligopeptidase +FIG01784449 FIG00351385: hypothetical protein +FIG01784458 zinc finger, SWIM domain protein +FIG01784467 transcriptional repressor protein +FIG01784509 PROBABLE CHOLESTEROL OXIDASE CHOD (CHOLESTEROL-O2 OXIDOREDUCTASE) (EC 1.1.3.6) +FIG01784511 membrane protein; CF-9 family +FIG01784517 FIG00353818: hypothetical protein +FIG01784520 thiosulfate sulfurtransferase( EC:2.8.1.1 ) +FIG01784552 Response regulator FasA or ComE or BlpR +FIG01784562 sulfur oxidation protein SoxZ +FIG01784583 phosphosugar-binding transcriptional regulator, RpiR family +FIG01784610 Sterol desaturase-like +FIG01784657 Uncharacterized protein MJ0021 +FIG01784738 carbohydrate kinase, FGGY +FIG01784766 FIG00528770: hypothetical protein +FIG01784772 FIG00768983: hypothetical protein +FIG01784800 HPr protein serine kinase +FIG01784809 similar to metalloprotease +FIG01784810 SMR/MUTS family protein +FIG01784856 FIG00385701: hypothetical protein +FIG01784925 FIG01202762: hypothetical protein +FIG01785000 transposase Tn3 family +FIG01785042 FIG00529881: hypothetical protein +FIG01785090 hypothetical protein +FIG01785094 putative branched-chain amino acid transport system permease +FIG01785099 Putative methyl oligogalcturonate esterase +FIG01785138 FIG00645194: hypothetical protein +FIG01785142 Sensory transduction regulatory protein +FIG01785153 Myosin heavy chain kinase B (EC 2.7.11.7) (MHCK B) +FIG01785164 FIG00344561: hypothetical protein +FIG01785184 FIG00347599: hypothetical protein +FIG01785186 restriction-modification system regulatory protein, putative +FIG01785187 Purine catabolism PurC-like +FIG01785190 Tn554 transposase C +FIG01785200 FIG00922316: hypothetical protein +FIG01785232 FIG00468707: hypothetical protein +FIG01785293 gamma-butyrobetaine hydroxylase +FIG01785319 FIG00390077: hypothetical protein +FIG01785388 ORF6 +FIG01785418 putative phage excisionase +FIG01785435 FIG00906055: hypothetical protein +FIG01785463 FIG00529820: hypothetical protein +FIG01785485 Uncharacterised protein family UPF0157 (COG2320) +FIG01785544 FIG00875255: hypothetical protein +FIG01785548 Sporulation control protein Spo0M +FIG01785579 FIG01206097: hypothetical protein +FIG01785664 probable transcriptional regulatory protein zraR +FIG01785673 FIG00362012: hypothetical protein +FIG01785684 probable thioredoxin-like protein +FIG01785732 glycosyltransferase, MGT family +FIG01785846 Small uncharacterized protein Bpro_4170 +FIG01785890 possible ABC antibiotics transporter +FIG01785932 Chemotaxis sensory transducer +FIG01786016 Non-specific protein-tyrosine kinase( EC:2.7.10.2 ) +FIG01786079 FIG00528927: hypothetical protein +FIG01786092 archaeal histone A1 +FIG01786095 FIG01093517: hypothetical protein +FIG01786121 site-specific recombinase IntIA +FIG01786152 Heparinase II/III family protein +FIG01786193 FIG00768601: hypothetical protein +FIG01786239 UDP-galactose-lipid carrier transferase (EC 2.-.-.-) +FIG01786254 FIG00352201: hypothetical protein +FIG01786350 FIG00892475: hypothetical protein +FIG01786418 Phosphoesterase, putative +FIG01786455 hypothetical protein Pisl_1113 +FIG01786502 FIG01001963: hypothetical protein +FIG01786523 FIG01129353: hypothetical protein +FIG01786544 beta-glucanase +FIG01786566 putative phage tail tape meausure protein +FIG01786721 FIG00353249: hypothetical protein +FIG01786768 FIG00344461: hypothetical protein +FIG01786773 Retinitis pigmentosa GTPase regulator +FIG01786776 CRISPR-associated RAMP protein, Csm4 family +FIG01786792 FIG00708217: hypothetical protein +FIG01786835 FIG00624277: hypothetical protein +FIG01786847 FIG01166121: hypothetical protein +FIG01786863 similar to carbon monoxide dehydrogenase nickel insertion protein +FIG01786871 cobE protein +FIG01786874 oxalate/formate antiporter, putative +FIG01786952 FIG00838516: hypothetical protein +FIG01786970 SCO1/SenC family protein/cytochrome c +FIG01786974 Lipase-esterase related protein +FIG01787029 FIG01136269: hypothetical protein +FIG01787090 FIG00473107: hypothetical protein +FIG01787127 Heavy metal binding protein +FIG01787144 OmpA/MotB domain protein precursor +FIG01787218 FIG00532852: hypothetical protein +FIG01787246 Staphylococcus nuclease (SNase-like) :Thermonuclease precursor (EC 3.1.31.1) +FIG01787259 transaldolase( EC:2.2.1.2 ) +FIG01787264 ISPsy5, Orf1 +FIG01787278 Putative sugar ABC transport system, permease protein +FIG01787314 amidase( EC:3.5.1.4 ) +FIG01787332 FIG00768801: hypothetical protein +FIG01787355 putative IS1106 transposase +FIG01787401 FIG00388293: hypothetical protein +FIG01787473 Positive regulator for lys +FIG01787476 accumulation-associated protein +FIG01787550 FIG01084017: hypothetical protein +FIG01787566 oxygen-insensitive NADPH nitroreductase +FIG01787568 FIG01236358: hypothetical protein +FIG01787598 FIG00418119: hypothetical protein +FIG01787650 FIG00850667: hypothetical protein +FIG01787662 Uncharacterized protein, 4-oxalocrotonate tautomerase homolog +FIG01787755 flavin dependant oxidoreductase +FIG01787757 FIG00834437: hypothetical protein +FIG01787768 Ortholog ycnD B.subtilis, nitroreductase +FIG01787783 mobilization protein MobB +FIG01787793 Undecaprenyl-phosphate N-acetylglucosaminyl 1-phosphate transferase (EC 2.7.8.-) +FIG01787830 FIG00644952: hypothetical protein +FIG01787855 Lysozyme( EC:3.2.1.17 ) +FIG01787859 FIG00404367: hypothetical protein +FIG01787865 transposase for IS2606 +FIG01787867 FIG00468930: hypothetical protein +FIG01787909 FIG00341940: hypothetical protein +FIG01787937 InterPro IPR000345 +FIG01787950 nrfC protein +FIG01787976 FIG00675216: hypothetical protein +FIG01788106 FIG00534244: hypothetical protein +FIG01788115 Cell division protein DivIC (FtsB), stabilizes FtsL against RasP cleavage +FIG01788124 probable transporter, permease protein +FIG01788162 thiamine pyrophosphate enzyme, TPP binding domain protein +FIG01788169 AraC family transcriptional regulatory protein +FIG01788173 Histone acetyltransferase HPA2, putative +FIG01788263 FIG00388149: hypothetical protein +FIG01788285 putative TonB-dependent outer membrane receptor protein +FIG01788353 FIG00681360: hypothetical protein +FIG01788405 FIG00641795: hypothetical protein +FIG01788423 OpcA, an allosteric effector of glucose-6-phosphate dehydrogenase, actinobacterial +FIG01788450 Putative diguanylate cyclase/phosphodiesterase(GGDEF & EAL domains) with PAS/PAC sensor(s) +FIG01788485 FIG00616200: hypothetical protein +FIG01788529 Protein kinase:G-protein beta WD-40 repeat +FIG01788580 FIG00447210: hypothetical protein +FIG01788609 blue (type 1) copper domain +FIG01788610 FIG01082400: hypothetical protein +FIG01788633 FIG00838886: hypothetical protein +FIG01788736 putative 3-methyladenine DNA glycosylase +FIG01788758 FIG01110472: hypothetical protein +FIG01788843 Bile acid:sodium symporter +FIG01788917 N-acetylmuramyl-L-alanine amidase, negative regulator of AmpC, AmpD +FIG01788935 alpha/beta hydrolase domain protein +FIG01789158 FIG00349213: hypothetical protein +FIG01789166 Sulfatase modifying factor 2 precursor +FIG01789209 Predicted phosphoglycerate mutase +FIG01789262 Response regulator (CheY-like receiver domain containing) +FIG01789274 FIG00847062: hypothetical protein +FIG01789304 peptidylprolyl cis-trans isomerase( EC:5.2.1.8 ) +FIG01789305 FIG00640080: hypothetical protein +FIG01789369 Flagellar protein flbB +FIG01789428 protein of unknown function DUF1109 +FIG01789447 FIG01117679: hypothetical protein +FIG01789476 FIG00404684: hypothetical protein +FIG01789530 putative aminotransferase B +FIG01789535 FIG00343926: hypothetical protein +FIG01789592 FIG00624107: hypothetical protein +FIG01789694 ortholog of Bordetella pertussis (BX470248) BP2556 +FIG01789722 ABC-type transporter, permease protein +FIG01789769 Membrane protein, predicted transporter of cations and cationic drugs +FIG01789772 FIG00674305: hypothetical protein +FIG01789775 hypothetical protein SC3D9.10c +FIG01789819 Nitrous oxide reductase maturation transmembrane protein NosY +FIG01789821 FIG00624112: hypothetical protein +FIG01789885 teichoic acid biosynthesis related protein +FIG01789999 plasmid partition protein A +FIG01790037 FIG00938210: hypothetical protein +FIG01790079 transcriptional regulator with cyclic nucleotide-binding domain +FIG01790140 FIG00079005: hypothetical protein +FIG01790149 FIG00631460: hypothetical protein +FIG01790161 Alr1370 protein +FIG01790178 3-oxoacyl-(acyl-carrier-protein)-like +FIG01790201 TraD, putative +FIG01790207 Chloroperoxidase +FIG01790215 aldo-keto reductase +FIG01790221 HTH-type transcriptional activator tipA +FIG01790291 PnuC-like transporter linked to Choline/ethanolamine kinase and OMR +FIG01790388 phosphonate metabolism protein +FIG01790435 Dopamine beta-hydroxylase +FIG01790439 amino acid ABC transporter, amino acid-binding protein/permease protein +FIG01790452 COG4301: Uncharacterized conserved protein +FIG01790539 FIG01134316: hypothetical protein +FIG01790540 FIG00767727: hypothetical protein +FIG01790611 FIG00427342: hypothetical protein +FIG01790648 lactoylglutathione lyase( EC:4.4.1.5 ) +FIG01790680 hydrogenase expression/formation protein +FIG01790687 COG5635: Predicted NTPase (NACHT family) +FIG01790690 Probable dipeptidyl aminopeptidase +FIG01790781 FIG00410604: hypothetical protein +FIG01790783 FIG00632511: hypothetical protein +FIG01790830 DNA methylase (ParB family) +FIG01790835 PUTATIVE TRANSPORT PROTEIN +FIG01790867 BofC protein +FIG01790869 FIG00355852: hypothetical protein +FIG01790895 glycosyltransferase family 47 +FIG01790902 FIG00858705: hypothetical protein +FIG01790943 conserved unknownl protein +FIG01790995 peptidase A24A, prepilin type IV +FIG01790998 fdxN element excision controlling factor XisI homolog +FIG01791059 sodA +FIG01791088 regulatory protein GntR, HTH:GntR-like +FIG01791109 FIG01141345: hypothetical protein +FIG01791177 putative prohead protease +FIG01791272 hypothetical alkaline phosphatase synthesis sensor protein (phoR) +FIG01791273 FIG00828071: hypothetical protein +FIG01791315 FIG00412083: hypothetical protein +FIG01791348 thioesterase family protein +FIG01791385 Putative terminase large subunit +FIG01791446 metal dependent hydrolase( EC:3.- ) +FIG01791470 FIG00343849: hypothetical protein +FIG01791474 (S)-2-(hydroxymethyl)glutarate dehydratase +FIG01791531 FIG00630951: hypothetical protein +FIG01791560 PBS lyase HEAT domain protein repeat-containing protein +FIG01791564 Transcriptional regulator PaiA +FIG01791571 glycosyltransferase involved in cell wall biogenesis +FIG01791573 FIG00521112: hypothetical protein +FIG01791578 FIG00464497: hypothetical protein +FIG01791590 putative peptidylarginine deiminase +FIG01791593 SecY protein +FIG01791600 possible conserved membrane protein +FIG01791655 FIG00363055: hypothetical protein +FIG01791676 Acyl-CoA thioesterase family protein +FIG01791677 Gpr1/Fun34/YaaH family protein +FIG01791693 Phasin 2 protein +FIG01791695 probable outer membrane lipoprotein IbeB +FIG01791786 intracellular protease, ThiJ/PfpI family +FIG01791834 FIG00661132: hypothetical protein +FIG01791892 Putative IS element transposase +FIG01791916 FIG00467088: hypothetical protein +FIG01791930 FIG00410177: hypothetical protein +FIG01791940 xylose operon regulator +FIG01791949 protein kinase/ LuxR family transcriptional regulator +FIG01791956 FIG00472365: hypothetical protein +FIG01792035 rtn protein +FIG01792053 FIG01241407: hypothetical protein +FIG01792088 HdeD protein +FIG01792109 Prefoldin, chaperonin cofactor +FIG01792155 putative adhesin MAA1 +FIG01792195 FIG01134179: hypothetical protein +FIG01792198 FIG00518463: hypothetical protein +FIG01792274 putative RNA polymerase, sigma-24 subunit, ECF subfamily +FIG01792402 UPF0337 protein asr4653 +FIG01792420 FIG01203735: hypothetical protein +FIG01792433 COG5295: Autotransporter adhesin +FIG01792461 FIG01128857: hypothetical protein +FIG01792518 FIG01271967: hypothetical protein +FIG01792708 hypothetical protein +FIG01792739 Chitosanase-glucanase +FIG01792759 FIG00349243: hypothetical protein +FIG01792782 Hypothetical protein pVir0012 +FIG01792872 Low-CO2 inducible protein LCIB +FIG01792878 FIG01084825: hypothetical protein +FIG01792906 FIG00518476: hypothetical protein +FIG01792959 FIG00850224: hypothetical protein +FIG01793002 FIG00518724: hypothetical protein +FIG01793033 purine phosphoribosyltransferase, putative +FIG01793054 Uncharacterized protein MJ0754 +FIG01793072 putative carotenoid biosynthesis protein +FIG01793075 hypothetical protein Rrub02002024 +FIG01793105 Endo-1,4-beta-xylanase A precursor (EC 3.2.1.8) (Xylanase A) (1,4-beta-D-xylan xylanohydrolase A) +FIG01793134 FIG00574910: hypothetical protein +FIG01793159 magnesium and cobalt transport protein +FIG01793160 FIG00756314: hypothetical protein +FIG01793190 COG3803: Uncharacterized protein conserved in bacteria +FIG01793193 putative esterase/lipase +FIG01793354 Phytoene dehydrogenase and related proteins-like +FIG01793355 Fibroin heavy chain precursor (Fib-H) (H-fibroin) +FIG01793372 Oligosaccharide repeat unit transporter +FIG01793392 hypothetical membrane permease protein +FIG01793418 FIG00561770: hypothetical protein +FIG01793435 FIG00624656: hypothetical protein +FIG01793452 FIG00519738: hypothetical protein +FIG01793513 putative phage regluatory protein +FIG01793543 FIG00406950: hypothetical protein +FIG01793551 transposase for IS3525 +FIG01793601 Peptidase M20:Peptidase dimerisation +FIG01793652 putative monooxygenase. +FIG01793701 widely conserved hypothetical protein with duf51 +FIG01793738 FIG00817060: hypothetical protein +FIG01793766 FIG00530036: hypothetical protein +FIG01793810 Alr5340 protein +FIG01793866 FIG01235722: hypothetical protein +FIG01793879 Family S53 non-peptidase homologue +FIG01793899 Glutamate permease +FIG01793931 FIG00574579: hypothetical protein +FIG01793956 Virulence plasmid protein +FIG01793989 FIG01135925: hypothetical protein +FIG01794005 possible PH domain +FIG01794015 Lactoylglutathione lyase, YQJC B.subtilis ortholog +FIG01794025 ATP synthase C chain (EC 3.6.3.14) (Lipid-binding protein) +FIG01794054 FIG01233684: hypothetical protein +FIG01794136 putative sporulation-related protein +FIG01794161 FIG00361586: hypothetical protein +FIG01794188 ortholog of Bordetella pertussis (BX470248) BP2263 +FIG01794248 hypothetical protein +FIG01794286 Transposase and inactivated derivatives-like +FIG01794487 pyridoxine kinase( EC:2.7.1.35 ) +FIG01794500 FIG01008325: hypothetical protein +FIG01794502 FIG01171137: hypothetical protein +FIG01794512 FIG00623050: hypothetical protein +FIG01794536 ORFB +FIG01794660 putative alanine-rich protein +FIG01794707 FIG01286518: hypothetical protein +FIG01794743 UPF0223 protein BCE_4008 +FIG01794887 FIG00406579: hypothetical protein +FIG01794889 protein of unknown function DUF847 +FIG01794916 Trypsin-2 precursor (EC 3.4.21.4) +FIG01794950 Possible Transcriptional Regulator +FIG01794958 FIG00537048: hypothetical protein +FIG01794983 Deoxyribodipyrimidine photolyase +FIG01794984 FIG00768942: hypothetical protein +FIG01795029 protein of unknown function DUF1320 +FIG01795054 FIG00633595: hypothetical protein +FIG01795064 FIG00477807: hypothetical protein +FIG01795128 FIG00408424: hypothetical protein +FIG01795162 GMP synthase, PP-ATPase domain/subunit +FIG01795175 FIG01064504: hypothetical protein +FIG01795182 probable hemagglutinin-related protein +FIG01795188 transposase (class IV) +FIG01795192 Pro +FIG01795250 FIG00633843: hypothetical protein +FIG01795295 thymidylate synthase( EC:2.1.1.45 ) +FIG01795324 FIG00406419: hypothetical protein +FIG01795345 FIG01189938: hypothetical protein +FIG01795359 Peptidase M20 +FIG01795397 FIG00755748: hypothetical protein +FIG01795401 Outer-membrane protein yhbX precursor +FIG01795419 response regulator like protein +FIG01795447 acyl carrier protein synthase +FIG01795456 hypothetical protein +FIG01795477 ISSpo8, transposase +FIG01795525 HTR-like protein +FIG01795566 hypothetical aminotransferase, class-II +FIG01795579 FIG01222927: hypothetical protein +FIG01795594 aminoglycoside/hydroxyurea antibiotic resistance kinase +FIG01795595 FIG00528851: hypothetical protein +FIG01795675 group II decarboxylase family protein +FIG01795732 putative bacitracin synthetase +FIG01795765 FIG00356355: hypothetical protein +FIG01795794 transcription regulator protein +FIG01795800 putative non-specific DNA-binding protein +FIG01795848 Agrobacterium chromosomal virulence protein B +FIG01795850 FIG00379831: hypothetical protein +FIG01795854 FIG00858579: hypothetical protein +FIG01795920 FIG00389945: hypothetical protein +FIG01795945 FIG00624117: hypothetical protein +FIG01795953 FIG00533008: hypothetical protein +FIG01796000 hypothetical protein( EC:2.1.1.103 ) +FIG01796026 cell wall endopeptidase, family M23/M37 +FIG01796035 FIG00405867: hypothetical protein +FIG01796084 Possible membrane-associated methyl-accepting chemotaxis protein fused to HAMP domain +FIG01796106 Cytochrome P450 135B1 +FIG01796163 FIG01123381: hypothetical protein +FIG01796206 FIG01204362: hypothetical protein +FIG01796207 FIG00364615: hypothetical protein +FIG01796214 Special sigma factor (sigF/sigE/sigG family) +FIG01796268 FIG00775937: hypothetical protein +FIG01796272 FIG00361208: hypothetical protein +FIG01796307 protein secretion systems +FIG01796335 FIG01115135: hypothetical protein +FIG01796354 Transposase KPN_02818 +FIG01796454 colicin E1 immunity protein +FIG01796469 FIG00641685: hypothetical protein +FIG01796490 glyoxylase +FIG01796497 FIG01236714: hypothetical protein +FIG01796562 FIG00532747: hypothetical protein +FIG01796571 hemolysin/hemagglutin accessory protein +FIG01796603 FIG01236228: hypothetical protein +FIG01796606 FIG01022559: hypothetical protein +FIG01796724 FabG3_1( EC:1.1.1.53 ) +FIG01796725 FIG00343950: hypothetical protein +FIG01796732 probable xanthan lyase +FIG01796750 protein of unknown function DUF763 +FIG01796752 FIG00424913: hypothetical protein +FIG01796763 Branched-chain amino acid aminotransferase I +FIG01796779 transposase-like protein +FIG01796829 Lanthionine biosynthesis protein +FIG01796846 Vinylacetyl-CoA delta-isomerase( EC:5.3.3.3 ) +FIG01796850 protein of unknown function DUF450 +FIG01796870 malonamidase E2 +FIG01796882 Reverse gyrase +FIG01796889 FIG01119954: hypothetical protein +FIG01796937 Probable transmembrane drug efflux protein +FIG01796942 Type I restriction-modification system DNA methylase +FIG01797022 Interferon induced protein 2 +FIG01797029 methyltransferase type 11, putative +FIG01797030 unknown protein +FIG01797031 FIG00380120: hypothetical protein +FIG01797049 FIG00905779: hypothetical protein +FIG01797081 Hypothetical MFS-type transporter protein ycaD +FIG01797113 PDZ domain (Also known as DHR or GLGF) +FIG01797283 COG0573: ABC-type phosphate transport system, permease component +FIG01797285 FIG00591098: hypothetical protein +FIG01797329 FIG00998353: hypothetical protein +FIG01797352 hypothetical protein +FIG01797394 FIG01205586: hypothetical protein +FIG01797409 virulence factor mce family protein +FIG01797431 transmembrane transport protein +FIG01797446 UDP-glycosyltransferase, MGT +FIG01797531 FIG00841121: hypothetical protein +FIG01797586 FIG01205961: hypothetical protein +FIG01797592 FIG00363053: hypothetical protein +FIG01797622 IS511, transposase OrfB +FIG01797684 Predicted membrane protein, possible permease +FIG01797715 major ampullate spidroin 1 +FIG01797750 TonB-dependent copper receptor +FIG01797772 protein of unknown function DUF817 +FIG01797796 Lysozyme +FIG01797800 FIG00841182: hypothetical protein +FIG01797808 FIG00343980: hypothetical protein +FIG01797813 Type II restriction enzyme PaeR7I (EC 3.1.21.4) +FIG01797829 Aspartyl aminopeptidase( EC:3.4.11.21 ) +FIG01797837 BadF/BadG/BcrA/BcrD ATPase family superfamily +FIG01797852 Lin0308 protein +FIG01797860 zinc-binding oxidoreductase +FIG01797930 Uncharacterized protein MJ0455 +FIG01797943 Carboxylic ester hydrolase (EC 3.1.1.-) +FIG01797997 hypothetical protein +FIG01798007 Phage-related integrase +FIG01798084 FIG00389819: hypothetical protein +FIG01798127 FIG00362404: hypothetical protein +FIG01798141 transporter, solute:sodium symporter (SSS) family protein +FIG01798150 FIG00404713: hypothetical protein +FIG01798157 glutamine amidotransferase, class-II +FIG01798200 Sll1949 protein +FIG01798295 ComE-like protein +FIG01798307 FIG00348988: hypothetical protein +FIG01798324 FIG00873008: hypothetical protein +FIG01798354 FIG00678596: hypothetical protein +FIG01798356 FIG00963489: hypothetical protein +FIG01798417 FIG00353371: hypothetical protein +FIG01798476 possible endonuclease/exonuclease/phosphatase family protein +FIG01798525 Hemolytic protein hlpA +FIG01798565 FIG01240332: hypothetical protein +FIG01798586 FIG00576024: hypothetical protein +FIG01798684 cell division protein ZipA +FIG01798710 Periplasmic molybdate-binding protein +FIG01798723 putative TonB protein +FIG01798727 caffeoyl-CoA O-methyltransferase +FIG01798839 COG3602: Uncharacterized protein conserved in bacteria +FIG01798873 Glucan endo-1,3-beta-glucosidase precursor (EC 3.2.1.39) ((1->3)-beta-glucan endohydrolase) ((1->3)-beta-glucanase) +FIG01798875 GvpW +FIG01798923 transposase, mutator family +FIG01798929 bll5323; unknown protein +FIG01798986 two component transcriptional regulator, Fis family +FIG01798989 unknown protein encoded within prophage CP-933U +FIG01799021 FIG01043674: hypothetical protein +FIG01799022 TPR-repeat containing protein +FIG01799051 Multi-sensor Signal Transduction Histidine Kinase +FIG01799057 FIG00624326: hypothetical protein +FIG01799089 FIG00404177: hypothetical protein +FIG01799107 Gll1862 protein +FIG01799114 phenylacetic acid degradation protein PaaI( EC:3.1.2.23 ) +FIG01799136 FIG00712599: hypothetical protein +FIG01799151 histidine kinase A domain protein +FIG01799158 FIG00344202: hypothetical protein +FIG01799184 FIG00516994: hypothetical protein +FIG01799185 CARDB domain-containing protein +FIG01799261 FIG00766641: hypothetical protein +FIG01799316 putative ScnA-like protein +FIG01799337 IS1557 family transposase +FIG01799415 DarA +FIG01799420 glucan synthase 1-related protein +FIG01799422 Glycoside hydrolase, family 57 +FIG01799486 putative Beta-(1-3)-glucosyl transferase +FIG01799536 FIG00623354: hypothetical protein +FIG01799547 FIG00343940: hypothetical protein +FIG01799663 Retron-type reverse transcriptase +FIG01799674 pXO1-25 +FIG01799677 Surface layer protein precursor +FIG01799700 COG1950: Predicted membrane protein +FIG01799730 Spore germination protein B1 +FIG01799734 cold shock protein +FIG01799779 putative orphan protein; putative transposase (IS66 family element,Orf2-like) +FIG01799782 FIG00259264: hypothetical protein +FIG01799877 FIG01049046: hypothetical protein +FIG01799940 GUN4-like +FIG01799981 320aa long hypothetical protein +FIG01800000 FIG00631870: hypothetical protein +FIG01800025 ABC-type Na+ efflux pump permease component-like protein +FIG01800092 FIG01236588: hypothetical protein +FIG01800138 FIG01092111: hypothetical protein +FIG01800139 1-phosphofructokinase, putative +FIG01800161 SSU ribosomal protein S14p (S29e) +FIG01800176 nucleoside 2-deoxyribosyltransferase +FIG01800324 putative amino acid ABC transporter, periplasmic amino acid-binding protein +FIG01800351 phage encoded transcriptional regulator, ArpU family +FIG01800393 permease protein, putative +FIG01800427 transposase protein +FIG01800430 FIG01165995: hypothetical protein +FIG01800467 transport protein of the major facilitator +FIG01800493 FIG00832406: hypothetical protein +FIG01800570 COGs COG3514 +FIG01800628 Cysteine proteinase +FIG01800645 TRANSMEMBRANE TRANSPORT PROTEIN +FIG01800672 Outer membrane protein C precursor +FIG01800695 HD-GYP domain-like protein +FIG01800700 FIG00661738: hypothetical protein +FIG01800791 FIG00344337: hypothetical protein +FIG01800812 Protein involved in cell division +FIG01800829 FIG00834268: hypothetical protein +FIG01800879 Metallopeptidase, zinc binding +FIG01800883 Small-conductance mechanosensitive channel-like +FIG01800887 FIG00389916: hypothetical protein +FIG01800905 FIG00412108: hypothetical protein +FIG01800944 FIG00939110: hypothetical protein +FIG01800946 DNA primase/helicase (EC 2.7.7.-) +FIG01800947 Mlr0003 protein +FIG01800956 Uncharacterized protein sll0400 (EC 3.1.3.-) +FIG01800970 FIG00388345: hypothetical protein +FIG01800971 FIG00623555: hypothetical protein +FIG01800991 histidine-binding protein precursor +FIG01800992 ATP-binding protein of amino acid ABC transporter +FIG01801045 O-Antigen Polymerase +FIG01801055 Cell wall protein Awa1p +FIG01801070 Glutathione-S-transferase homolog +FIG01801074 Xyloside transporter XynT +FIG01801129 similar to two-component system sensory/regulatory protein (Ntr family) +FIG01801143 FIG00361539: hypothetical protein +FIG01801235 putative spore-cortex-lytic enzyme +FIG01801255 Glycosyl transferase, group 1( EC:2.4.1.57 ) +FIG01801304 NmrA-like +FIG01801307 probable DnaK suppressor protein +FIG01801312 Mu-like prophage protein +FIG01801345 K30 capsule biosynthesis cluster, partial sequence +FIG01801358 Gll3707 protein +FIG01801380 FIG01008886: hypothetical protein +FIG01801388 FIG00624139: hypothetical protein +FIG01801389 FIG00525463: hypothetical protein +FIG01801408 FIG00734453: hypothetical protein +FIG01801440 NADH dehydrogenase subunit +FIG01801455 FIG00385305: hypothetical protein +FIG01801524 FIG00440057: hypothetical protein +FIG01801527 Resolvase-like protein +FIG01801558 240aa long hypothetical protein +FIG01801579 Surface layer protein +FIG01801592 two component heavy metal response transcriptional regulator, winged helix family +FIG01801593 FIG00694210: hypothetical protein +FIG01801619 alanine racemase domain protein +FIG01801635 Bll5864 protein +FIG01801698 putative transposon integrase; Tn916 ORF3-like +FIG01801726 FIG00640213: hypothetical protein +FIG01801732 FIG00712583: hypothetical protein +FIG01801744 L-fuculose phosphate aldolase +FIG01801766 ATPase component ABC-type transport system +FIG01801820 ISSod5, transposase +FIG01801826 Opacity protein or related surface antigen +FIG01801845 general stress protein 26, putative +FIG01801866 serine/threonine kinase, putative regulatory protein +FIG01801914 transcriptional regulator, BadM/Rrf2 family +FIG01801929 Similar to phosphoglycolate phosphatase, clustered with acetylglutamate kinase +FIG01801933 putative RTX family exoprotein +FIG01802029 hypothetical protein +FIG01802039 FIG00978204: hypothetical protein +FIG01802066 lipid A-myristate beta-hydroxylase( EC:1.14.11.- ) +FIG01802105 FIG00388039: hypothetical protein +FIG01802124 FIG00462193: hypothetical protein +FIG01802206 FIG01126662: hypothetical protein +FIG01802225 Cps7C +FIG01802270 hypothetical protein +FIG01802279 FIG00945296: hypothetical protein +FIG01802286 possible Small, acid-soluble spore proteins, a +FIG01802313 FIG00850482: hypothetical protein +FIG01802336 LPS biosynthesis protein , RfbU family +FIG01802363 Possible Transcriptional Regulator, Crp/Fnr family protein +FIG01802440 YvaN +FIG01802545 putative colanic acid biosynthesis glycosyl transferase +FIG01802623 phage-related putative exported protein +FIG01802628 SIR2 family protein +FIG01802662 FIG00426000: hypothetical protein +FIG01802696 Restriction enzyme alpha subunit +FIG01802701 phage Terminase small subunit +FIG01802743 Ethylbenzene dehydrogenase delta subunit (EC 1.17.99.2) +FIG01802760 3-dehydroquinate dehydratase( EC:4.2.1.10 ) +FIG01802767 FIG01240834: hypothetical protein +FIG01802807 serine proteinase inhibitor +FIG01802817 similar to dienelactone hydrolase +FIG01802822 glutamate-binding protein precursor +FIG01802835 FIG00589686: hypothetical protein +FIG01802837 FIG00410279: hypothetical protein +FIG01802907 FIG01230389: hypothetical protein +FIG01802990 FIG00933687: hypothetical protein +FIG01803016 FIG00349130: hypothetical protein +FIG01803066 repeat organellar protein, putative +FIG01803097 Chemotaxis response regulator protein-glutamate methylesterase (EC 3.1.1.61) +FIG01803111 Regulatory protein SptAIC +FIG01803228 Gas vesicle protein C +FIG01803230 FIG01083867: hypothetical protein +FIG01803231 glutamine amidotransferase class-II +FIG01803248 transcriptional regulator, TraR/DksA family +FIG01803251 FIG00572074: hypothetical protein +FIG01803261 FIG01183406: hypothetical protein +FIG01803280 Uncharacterized protein ywcH +FIG01803324 putative general stress protein 26 +FIG01803348 FIG00530250: hypothetical protein +FIG01803358 ATP synthase, I subunit( EC:3.6.3.14 ) +FIG01803383 FIG00388694: hypothetical protein +FIG01803402 DNA-directed RNA polymerase, omega subunit, putative +FIG01803420 protein-tyrosine phosphatase 2 +FIG01803438 FIG00624705: hypothetical protein +FIG01803453 transposase, IS91 family, putative +FIG01803479 plasmid partitioning protein +FIG01803549 Putative ABC transporter (ATP binding protein) +FIG01803562 Probable arginyl-tRNA--protein transferase (EC 2.3.2.8) +FIG01803569 cell separation protein +FIG01803582 Putative sterol carrier protein +FIG01803586 choloylglycine hydrolase( EC:3.5.1.24 ) +FIG01803603 FIG01218393: hypothetical protein +FIG01803656 FIG00406942: hypothetical protein +FIG01803705 YiaAB two helix domain protein +FIG01803767 FIG01004676: hypothetical protein +FIG01803768 protein of unknown function DUF893, YccS/YhfK +FIG01803785 gp1 +FIG01803828 sensor protein atoS +FIG01803845 Putative cytochrome c protein +FIG01803917 FIG01190124: hypothetical protein +FIG01803935 Lea protein - soybean +FIG01803942 secreted lipase +FIG01803964 peptidase propeptide/YPEB domain protein +FIG01804076 Hypothetical alternative hydroxymethylpyrimidine phosphate kinase ThiD (EC 2.7.4.7) +FIG01804121 SAM-dependent methyltransferases related to tRNA (uracil-5-)-methyltransferase +FIG01804147 UpfA +FIG01804164 FIG01126609: hypothetical protein +FIG01804181 FIG00838820: hypothetical protein +FIG01804195 Translation initiation factor IF-2 +FIG01804215 MrfJ protein +FIG01804227 major facilitator superfamily MFS_1 transporter +FIG01804231 FIG00821342: hypothetical protein +FIG01804255 PCZA361.29 +FIG01804267 FIG01068492: hypothetical protein +FIG01804297 FIG00631059: hypothetical protein +FIG01804318 two component transcriptional regulator, AraC /protein_id= +FIG01804332 putative membrane protein, YjgP/YjgQ family +FIG01804353 DNA ligase (ATP) (EC 6.5.1.1) +FIG01804382 FIG01130752: hypothetical protein +FIG01804409 Biotin synthesis protein BioC +FIG01804421 sensory box histidine kinase PhoR +FIG01804431 FIG00458943: hypothetical protein +FIG01804444 FIG00417097: hypothetical protein +FIG01804477 FIG01212031: hypothetical protein +FIG01804491 FIG00342288: hypothetical protein +FIG01804496 FIG00755117: hypothetical protein +FIG01804501 3-oxoacyl-(acyl-carrier protein) reductase +FIG01804520 putative granule-associated protein +FIG01804615 Uncharacterized protein conserved in archaea (DUF531) +FIG01804626 transcriptional regulator, luxR family +FIG01804684 pyochelin synthetase F +FIG01804728 Haemagluttinin domain protein +FIG01804793 Possible exported protein +FIG01804852 Cytochrome P450( EC:1.14.14.1 ) +FIG01804865 iron(III) ABC transporter, ATP-binding protein +FIG01804934 Alanylphosphatidylglycerol synthase (EC 2.3.2.11) +FIG01804955 Molybdenum cofactor sulfurase +FIG01805007 Cis,cis-muconate transport protein +FIG01805051 FIG00362288: hypothetical protein +FIG01805080 Trimethylamine methyltransferase mttB (EC 2.1.1.-) (TMA methyltransferase) +FIG01805122 FIG01119967: hypothetical protein +FIG01805205 putative repressor protein +FIG01805224 FIG00413543: hypothetical protein +FIG01805258 FIG00624408: hypothetical protein +FIG01805266 FIG00344403: hypothetical protein +FIG01805282 putative membrane-anchored racemase protein +FIG01805309 phage conserved hypothetical protein, phiE125 gp8 +FIG01805315 glycosyltransferase-like protein( EC:2.4.1.- ) +FIG01805332 FIG00632794: hypothetical protein +FIG01805340 FIG00743963: hypothetical protein +FIG01805374 FIG00361573: hypothetical protein +FIG01805390 General stress protein A +FIG01805402 L-2-haloalkanoic acid dehalogenase +FIG01805463 Probable RND efflux transporter +FIG01805489 serine/threonine protein kinase related protein-like +FIG01805512 ABC-type transporter, periplasmic binding protein +FIG01805569 hypothetical protein +FIG01805664 putative methylase +FIG01805681 SoxR family transcriptional regulator +FIG01805729 FIG00415643: hypothetical protein +FIG01805732 Hypothetical protein, contains HAS barrel docking domain and DUF87 domain +FIG01805747 FIG00641397: hypothetical protein +FIG01805852 FIG01205866: hypothetical protein +FIG01805907 DsrK-like protein +FIG01805932 Helicase, SNF2 family +FIG01805953 putative alpha-mannosidase +FIG01806011 putative regulator of transfer genes ArtA +FIG01806159 Anti-sigma regulatory factor +FIG01806205 FIG00808259: hypothetical protein +FIG01806233 Putative ferredoxin (partial) +FIG01806254 FIG01091131: hypothetical protein +FIG01806274 FIG01020815: hypothetical protein +FIG01806296 nickel-cobalt-cadmium resistance protein +FIG01806306 FIG01166487: hypothetical protein +FIG01806318 FIG00671990: hypothetical protein +FIG01806366 sugE protein +FIG01806371 Gene Transfer Agent terminase protein +FIG01806386 ATP synthase subunit A +FIG01806395 FIG00365080: hypothetical protein +FIG01806414 possible tyrosine protein phosphatase +FIG01806423 FIG01239589: hypothetical protein +FIG01806491 Cytochrome c, class II +FIG01806494 Possible 3-oxoacyl-[acyl-carrier-protein] synthase III +FIG01806524 Rhs core protein with extension +FIG01806530 FIG00413844: hypothetical protein +FIG01806553 COG family: uncharacterized Acr +FIG01806576 FIG00388364: hypothetical protein +FIG01806581 FIG00387972: hypothetical protein +FIG01806595 FIG00344507: hypothetical protein +FIG01806682 FIG01020451: hypothetical protein +FIG01806683 FIG00450390: hypothetical protein +FIG01806684 glucose-resistance amylase regulator +FIG01806705 flavocytochrome c +FIG01806709 Peptidylprolyl isomerase( EC:5.2.1.8 ) +FIG01806714 Uncharacterized lipoprotein aq_615 precursor +FIG01806787 Sensory box sigma-54 dependent DNA-binding response regulator +FIG01806888 FIG00624832: hypothetical protein +FIG01806970 prophage ps2 protein 12 +FIG01807002 demethylmenaquinone methyltransferase +FIG01807024 peptidase M6 immune inhibitor A +FIG01807051 sanA protein, putative +FIG01807070 FIG00414691: hypothetical protein +FIG01807092 COG1032: Fe-S oxidoreductase +FIG01807140 FIG00414464: hypothetical protein +FIG01807179 FIG00433035: hypothetical protein +FIG01807202 chromosome partitioning protein, ParB family +FIG01807376 FIG00412280: hypothetical protein +FIG01807460 ABC-type bacteriocin transporter family protein +FIG01807507 dioxygenase (secreted protein) +FIG01807581 putative secreted calmodulin-like protein +FIG01807589 FIG00752401: hypothetical protein +FIG01807657 FIG01200708: hypothetical protein +FIG01807785 FIG00385487: hypothetical protein +FIG01807840 FIG00342559: hypothetical protein +FIG01807863 Sulfur deprivation response regulator +FIG01807926 UPF0059 membrane protein BF1149 +FIG01808004 glycine-rich RNA-binding protein +FIG01808039 ATPase involved in chromosome partitioning-like protein +FIG01808066 FIG00939931: hypothetical protein +FIG01808081 FIG00521351: hypothetical protein +FIG01808089 FIG00347520: hypothetical protein +FIG01808135 FIG00688169: hypothetical protein +FIG01808167 FIG00254089: hypothetical protein +FIG01808169 outer membrane protein homolog +FIG01808180 FIG01242618: hypothetical protein +FIG01808217 FIG00524296: hypothetical protein +FIG01808226 FIG00623280: hypothetical protein +FIG01808262 Glutamine cyclotransferase +FIG01808289 Putative polyketide synthase (Fragment) +FIG01808321 beta-N-acetylhexosaminidase( EC:3.2.1.52 ) +FIG01808324 FIG00469718: hypothetical protein +FIG01808327 Sigma factor, ECF subfamily +FIG01808328 Endoflagellar motor switch protein +FIG01808374 possible sigma factor +FIG01808379 glutamine-binding periplasmic protein fused to glutamine permease +FIG01808426 Putative P-loop ATPase +FIG01808434 FIG01122839: hypothetical protein +FIG01808461 Two component response regulator precursor +FIG01808517 Aha1 domain superfamily +FIG01808531 FIG01249237: hypothetical protein +FIG01808549 FIG01099037: hypothetical protein +FIG01808580 FIG00580450: hypothetical protein +FIG01808582 Mll3244 protein +FIG01808589 FIG00529003: hypothetical protein +FIG01808603 lemA protein, putative +FIG01808611 small heat shock protein (HSP20) family protein +FIG01808617 hypothetical protein, INTERPRO-suggestion: probable Apolipoprotein A/E/C3 +FIG01808717 TraL protein +FIG01808742 FIG00814882: hypothetical protein +FIG01808743 outer membrane protein, OmpA family +FIG01808770 Coat F +FIG01808775 Type I restriction-modification system methyltransferase subunit +FIG01808805 prabable sialidase +FIG01808837 FIG00874188: hypothetical protein +FIG01808864 FIG00518133: hypothetical protein +FIG01808963 protein-disulfide isomerase( EC:5.3.4.1 ) +FIG01809010 FIG00388023: hypothetical protein +FIG01809021 Wall associated protein +FIG01809022 FIG01244915: hypothetical protein +FIG01809029 alpha-rhamnosidase-like protein +FIG01809067 Two-component system sensor histidine kinase/response +FIG01809098 MCP methyltransferase, CheR-type +FIG01809151 protein of unknown function DUF1476 +FIG01809179 FIG00733250: hypothetical protein +FIG01809184 putative MFS-type efflux protein +FIG01809215 FIG00385022: hypothetical protein +FIG01809231 Nucleotidyltransferase substrate binding protein, HI0074 +FIG01809263 dCMP deaminase, putative +FIG01809366 FIG00415479: hypothetical protein +FIG01809385 hypothetical protein +FIG01809386 possible transporter, MFS superfamily +FIG01809405 FIG00361931: hypothetical protein +FIG01809487 FIG00351892: hypothetical protein +FIG01809527 FIG01233889: hypothetical protein +FIG01809561 FIG01093604: hypothetical protein +FIG01809571 Deoxyinosine 3'endonuclease (endonuclease V) +FIG01809580 FIG00524325: hypothetical protein +FIG01809609 Tn5520-like integrase (transfer factor) +FIG01809686 nuclease (thermonuclease)-like protein +FIG01809735 LysM repeats domain containing membrane protein +FIG01809736 FIG00344901: hypothetical protein +FIG01809766 Recombination inhibitory protein MutS2 +FIG01809783 FIG00734122: hypothetical protein +FIG01809788 FIG00814519: hypothetical protein +FIG01809851 FIG00773794: hypothetical protein +FIG01809917 Type IV pilin PilA +FIG01809929 FIG00534611: hypothetical protein +FIG01809949 FIG01117878: hypothetical protein +FIG01809972 FIG00356489: hypothetical protein +FIG01809982 FIG00385440: hypothetical protein +FIG01810035 Homospermidine synthase( EC:2.5.1.44 ) +FIG01810042 FIG00834686: hypothetical protein +FIG01810061 FIG00920704: hypothetical protein +FIG01810065 FIG01189626: hypothetical protein +FIG01810080 site-specific recombinase, phage integrase family, putative +FIG01810081 FIG00413071: hypothetical protein +FIG01810089 DUF81 precursor +FIG01810093 type II protein secretion system +FIG01810102 sensor histidine kinase, putative virS +FIG01810147 Outer-membrane protein yhbX precursor +FIG01810149 FIG00831056: hypothetical protein +FIG01810180 FIG00524154: hypothetical protein +FIG01810219 morphogenesis protein +FIG01810234 FIG00352063: hypothetical protein +FIG01810236 FIG00623766: hypothetical protein +FIG01810250 FIG00623980: hypothetical protein +FIG01810303 Permease, MDR related +FIG01810358 FIG00427381: hypothetical protein +FIG01810363 FIG00632852: hypothetical protein +FIG01810388 RNA polymerase sigma factor Y +FIG01810399 luxR family two-component response regulator +FIG01810431 nucleotidyltransferase, putative +FIG01810445 FIG00388370: hypothetical protein +FIG01810455 FIG01233916: hypothetical protein +FIG01810461 Hsp18_2 +FIG01810473 FIG01218066: hypothetical protein +FIG01810523 Adhesin AIDA-I precursor +FIG01810570 FIG01126090: hypothetical protein +FIG01810578 FIG00525491: hypothetical protein +FIG01810586 FIG01118474: hypothetical protein +FIG01810622 phosphoribosylformimino-5-aminoimidazole carboxamide ribotide isomerase related protein +FIG01810647 GGDEF/HD domain protein +FIG01810832 FIG00630669: hypothetical protein +FIG01810853 conserved protein of unknown function ; putative secreted protein +FIG01810877 peptidase, M48 family( EC:3.4.24.- ) +FIG01810880 minor tail family protein +FIG01810886 OrfA +FIG01810892 sulfotransferase family protein +FIG01810937 FIG00388261: hypothetical protein +FIG01810940 FIG01039847: hypothetical protein +FIG01810965 probable beta-galactosidase +FIG01810973 putative iron transport protein +FIG01811026 PmgC +FIG01811029 FIG00267895: hypothetical protein +FIG01811056 Predicted ABC-type transport system, permease component +FIG01811057 cation/multidrug efflux pump +FIG01811112 short chain dehydrogenase( EC:1.- ) +FIG01811135 amino-acid transporters +FIG01811161 cytochrome b561, putative +FIG01811181 putative Lysozyme (Lysis protein) (Muramidase) (Endolysin) +FIG01811187 Band 7 protein:Flotillin +FIG01811220 GlcNAc transferase( EC:2.4.1.198 ) +FIG01811235 transcriptional regulator, NifA subfamily, Fis Family +FIG01811257 protein export membrane protein +FIG01811289 possible glycosyltransferase family 1 +FIG01811304 FIG00414651: hypothetical protein +FIG01811310 FIG00528577: hypothetical protein +FIG01811317 COG3868: Uncharacterized conserved protein +FIG01811344 FIG00674771: hypothetical protein +FIG01811354 Bll3089 protein +FIG01811372 ORF_ID:all7659 unknown protein +FIG01811487 FIG00352256: hypothetical protein +FIG01811488 GNAT family acetyltransferase YiiD potentially involved in tRNA processing +FIG01811520 conserved hypothetical protein, putative membrane-associated protein +FIG01811525 Allophanate hydrolase 2 subunit 1 (EC 3.5.1.54) / Allophanate hydrolase 2 subunit 2 (EC 3.5.1.54) +FIG01811526 FIG00974958: hypothetical protein +FIG01811592 Uncharacterized protein COG3236 +FIG01811603 FIG00630535: hypothetical protein +FIG01811630 Uncharacterized protein, MazG family +FIG01811645 FIG00414000: hypothetical protein +FIG01811652 mandelate racemase related protein +FIG01811689 HTH-type transcriptional regulator LysM +FIG01811724 aminopeptidase Y +FIG01811742 Spore germination protein LC +FIG01811749 serine protease, trypsin family +FIG01811759 COG0835: Chemotaxis signal transduction protein +FIG01811768 FIG00528651: hypothetical protein +FIG01811797 FIG00525806: hypothetical protein +FIG01811848 CII phage-related protein +FIG01811855 FIG01000816: hypothetical protein +FIG01811890 Bacterial surface protein +FIG01811908 R3H domain protein +FIG01811924 FIG00405616: hypothetical protein +FIG01812046 RNA polymerase sigma factor sigM +FIG01812071 transcriptional regulator, ModE family +FIG01812147 amino acid ABC transporter substrate-binding protein +FIG01812171 FIG00938198: hypothetical protein +FIG01812225 pilin polypeptide PilA homolog +FIG01812230 FIG00389050: hypothetical protein +FIG01812290 FIG01223424: hypothetical protein +FIG01812317 L-asparagine permease +FIG01812341 secreted substrate binding protein +FIG01812342 putative unsaturated glucuronyl hydrolase +FIG01812378 similar to monoamine oxidase regulatory protein +FIG01812384 transferase hexapeptide repeat containing protein +FIG01812403 ABC-type ATPase +FIG01812414 Cyanovirin-N domain protein +FIG01812416 FIG00688124: hypothetical protein +FIG01812434 Xre family DNA-binding domain and TPR-repeat containing protein +FIG01812440 FIG00675311: hypothetical protein +FIG01812450 FIG01117976: hypothetical protein +FIG01812606 protein of unknown function DUF1348 +FIG01812616 transposase subunit B +FIG01812624 Putative membrane-spanning protein +FIG01812643 Hemagglutinin/hemolysin-related protein +FIG01812667 FIG00344311: hypothetical protein +FIG01812703 InterPro IPR002781 COGs COG0730 +FIG01812731 FIG00363419: hypothetical protein +FIG01812787 FIG00538057: hypothetical protein +FIG01812803 FIG01235259: hypothetical protein +FIG01812832 putative sulfate transport protein +FIG01812881 regulatory protein MerR +FIG01813011 Protein of unknown function (DUF1550) family +FIG01813016 FIG00524955: hypothetical protein +FIG01813043 protein containing oxidoreductase domain +FIG01813046 FIG00409024: hypothetical protein +FIG01813124 Acyl-CoA dehydrogenase, C-terminal +FIG01813233 FIG00520444: hypothetical protein +FIG01813244 FIG00343979: hypothetical protein +FIG01813261 ABC branched chain amino acid transporter, inner membrane subunit +FIG01813275 putative mercury resistance operon regulator MerR +FIG01813321 MISCELLANEOUS +FIG01813337 McrBC 5-methylcytosine restriction system component-like +FIG01813383 PE_PGRS family protein +FIG01813393 3-hydroxybutyryl-CoA dehydrogenase +FIG01813451 FIG00952809: hypothetical protein +FIG01813469 Legionella vir homologue protein +FIG01813517 FIG00255829: hypothetical protein +FIG01813570 FIG00524326: hypothetical protein +FIG01813581 chitin-binding, domain 3 protein +FIG01813590 putative IS1648 transposase +FIG01813647 branched-chain amino acid ABC transporter, ATP-binding protein +FIG01813700 FIG00404010: hypothetical protein +FIG01813705 FIG00388903: hypothetical protein +FIG01813707 Mannosyltransferase +FIG01813727 FIG00674872: hypothetical protein +FIG01813899 COG3093: Plasmid maintenance system antidote protein +FIG01813984 FIG01119156: hypothetical protein +FIG01813985 FIG00661880: hypothetical protein +FIG01813996 truncated transposase +FIG01814003 serine threonine rich antigen +FIG01814011 Amino acid transport system permease protein +FIG01814037 Conserved protein +FIG01814092 GAF domain-containing protein +FIG01814199 Modification methylase HgiCII (EC 2.1.1.37) +FIG01814288 RRNA methylase, YSGA B.subtilis ortholog +FIG01814294 FIG00474861: hypothetical protein +FIG01814302 ribose ABC transporter, periplasmic ribose-binding protein +FIG01814315 FIG00575888: hypothetical protein +FIG01814332 FIG00343988: hypothetical protein +FIG01814368 FIG00356323: hypothetical protein +FIG01814373 FIG01204285: hypothetical protein +FIG01814423 TonB-dependent receptor plug +FIG01814436 C-DI-GMP PHOSPHODIESTERASE A +FIG01814473 transcriptional regulator, LacI family, putative +FIG01814514 FIG00523216: hypothetical protein +FIG01814532 putative endo-1,4-beta-xylanase B +FIG01814536 holo-acyl-carrier protein synthase( EC:2.7.8.7 ) +FIG01814551 FIG00274452: hypothetical protein +FIG01814558 FIG00417713: hypothetical protein +FIG01814566 marC family integral membrane protein +FIG01814603 possible DNA repair helicase +FIG01814799 protein of unknown function DUF1643 +FIG01814854 FIG00733509: hypothetical protein +FIG01814880 FIG01080898: hypothetical protein +FIG01814881 putative type II DNA modification enzyme +FIG01814884 Cyclopropane-fatty-acyl-phospholipid synthase( EC:2.1.1.144 ) +FIG01814889 FIG00529460: hypothetical protein +FIG01814920 FIG00623421: hypothetical protein +FIG01814925 Regulatory sensor-transducer, BlaR1/MecR1 family / Peptidase S41 +FIG01814926 chorismate mutase( EC:5.4.99.5 ) +FIG01814938 Putative cytochrome c family protein +FIG01814945 Phospholipase D precursor (EC 3.1.4.4) (PLD) (Choline phosphatase) +FIG01814974 D-glucuronyl C5-epimerase (EC 5.1.3.-) +FIG01815051 FIG00832896: hypothetical protein +FIG01815069 outer membrane protein SusF +FIG01815072 FIG00575335: hypothetical protein +FIG01815131 phosphonate ABC transporter, inner membrane subunit +FIG01815149 hypothetical protein +FIG01815211 FIG00532121: hypothetical protein +FIG01815222 Diverged AAA-family ATPase containing protein +FIG01815233 Tlr1468 protein +FIG01815259 FIG00461093: hypothetical protein +FIG01815279 ethanolamine utilization protein eutS +FIG01815286 blr7068; hypothetical protein +FIG01815292 homoserine O-succinyltransferase( EC:2.3.1.46 ) +FIG01815354 hypothetical protein +FIG01815380 FIG00767338: hypothetical protein +FIG01815474 hypothetical protein +FIG01815498 Uncharacterized conserved protein, phnB family +FIG01815525 Periplasmic Sensor Signal Transduction Histidine Kinase +FIG01815534 protein of unknown function DUF114 +FIG01815595 chromosome partitioning protein ParA +FIG01815613 RHS repeat-associated core domain protein +FIG01815618 response regulator HsfA +FIG01815717 Iron-dependent repressor ideR +FIG01815733 Mlr4046 protein +FIG01815750 ZK84.1 +FIG01815816 Transposase, undefined +FIG01815817 acetyl-CoA carboxylase +FIG01815848 FIG01205968: hypothetical protein +FIG01815866 FIG00964468: hypothetical protein +FIG01815955 FIG01065827: hypothetical protein +FIG01815981 Molybdenum ABC transporter ATP-binding protein +FIG01815994 hypothetical protein +FIG01816019 possible restriction endonuclease +FIG01816036 hypothetical protein +FIG01816075 Uncharacterized protein MJ0988 +FIG01816088 Thiopurine S-methyltransferase +FIG01816128 syc0578_c +FIG01816177 DotG +FIG01816217 pentapeptide repeats domain protein +FIG01816222 possible phosphoadenosine phosphosulfate reductase +FIG01816261 FIG01131871: hypothetical protein +FIG01816269 putative capsule biosynthesis protein +FIG01816277 FIG00352320: hypothetical protein +FIG01816336 DNA resolvase +FIG01816419 probable trans-acting regulatory HvrA protein +FIG01816440 FIG00380609: hypothetical protein +FIG01816447 colicin +FIG01816519 Na+-driven multidrug efflux protein +FIG01816630 alpha-ketoglutarate permease +FIG01816655 two-component system response regulator (Ntr family) +FIG01816664 FIG01225206: hypothetical protein +FIG01816667 putative acyl-CoA oxidase +FIG01816683 toxin secretion, membrane fusion protein +FIG01816749 FIG00968158: hypothetical protein +FIG01816759 Domain of unknown function DUF1918 +FIG01816762 FIG00816223: hypothetical protein +FIG01816768 Transcription initiation factor IIE, alpha subunit +FIG01816771 cell wall lytic activity +FIG01816822 Serine/threonine protein kinase (EC 2.7.11.1) +FIG01816836 FIG00343952: hypothetical protein +FIG01816875 restriction endonuclease homolog R.XphI +FIG01816906 FIG00532588: hypothetical protein +FIG01816960 possible carboxylesterase or lipase +FIG01816979 TPR repeat:HAT (Half-A-TPR) repeat +FIG01817078 FIG01046678: hypothetical protein +FIG01817079 putative outer membrane usher protein +FIG01817107 FIG00934872: hypothetical protein +FIG01817163 predicted RNA binding protein +FIG01817173 putative multidomain membrane protein +FIG01817182 Endolysin (EC 3.2.1.-) +FIG01817193 bacterioferritin family protein +FIG01817253 diguanylate cyclase/phosphodiesterase (GGDEF & EAL domains) with PAS/PAC sensor(s) +FIG01817283 Sigma-K factor processing regulatory protein BOFA +FIG01817443 heparinase III protein +FIG01817533 FIG01088015: hypothetical protein +FIG01817574 DinB protein +FIG01817587 C4-dicarboxylate transport system permease small protein +FIG01817598 probable GntR-family transcriptional regulator +FIG01817617 transposase IS200-family protein +FIG01817631 WsaB +FIG01817715 conserved DNA-binding protein +FIG01817847 Surface layer-associated protease +FIG01817850 Putative L-2,4-diaminobutyrate decarboxylase +FIG01817868 Replication protein, repA +FIG01818016 FIG00815472: hypothetical protein +FIG01818022 acetyltransferase, GNAT family +FIG01818046 bll5452; unknown protein +FIG01818054 FIG00987236: hypothetical protein +FIG01818098 Leader peptidase (Prepilin peptidase) (EC 3.4.23.43) / unknown domain / N-methyltransferase (EC 2.1.1.-) +FIG01818204 FIG01040075: hypothetical protein +FIG01818273 FIG00733256: hypothetical protein +FIG01818276 FIG01165402: hypothetical protein +FIG01818329 FIG00854122: hypothetical protein +FIG01818333 FIG00567663: hypothetical protein +FIG01818497 FIG00634769: hypothetical protein +FIG01818510 copper-binding protein, plastocyanin/azurin family +FIG01818516 FIG00996798: hypothetical protein +FIG01818533 FIG00921498: hypothetical protein +FIG01818553 Nickel ABC transporter periplasmic component NikK +FIG01818582 Endoglucanase E-4 precursor (EC 3.2.1.4) (Endo-1,4-beta-glucanase E-4) (Cellulase E-4) (Cellulase E4) +FIG01818589 FIG00364555: hypothetical protein +FIG01818610 AhpC/TSA-family protein +FIG01818625 FIG00380781: hypothetical protein +FIG01818670 hypothetical protein +FIG01818755 FIG00814703: hypothetical protein +FIG01818764 FlgN +FIG01818780 cGMP-dependent protein kinase 2 (EC 2.7.11.1) +FIG01818783 FIG00935936: hypothetical protein +FIG01818802 Acyl-ACP thioesterase-like +FIG01818824 nucleic acid-binding protein,contains PIN domain +FIG01818843 CAB/ELIP/HLIP superfamily of proteins +FIG01818954 Bacteriochlorophyll c-binding protein precursor (BChl c-binding) (Chlorosome protein A) (Light-harvesting protein B-740) (5.7 kDa chlorosomal protein) +FIG01818958 FIG00380308: hypothetical protein +FIG01818977 FIG00362046: hypothetical protein +FIG01819023 putative ATP synthase F0, A subunit +FIG01819089 FIG00347535: hypothetical protein +FIG01819147 antibiotic acyltransferase +FIG01819160 Putative reductoisomerase in siderophore biosynthesis gene cluster +FIG01819180 FIG01055019: hypothetical protein +FIG01819223 FIG00632123: hypothetical protein +FIG01819273 Nickel insertion protein +FIG01819342 Conserved hypothetical Archael protein +FIG01819387 5-carboxymethyl-2-hydroxymuconate isomerase +FIG01819441 FIG00344553: hypothetical protein +FIG01819518 FIG00761517: hypothetical protein +FIG01819570 FIG00623020: hypothetical protein +FIG01819605 Cbb3-type cytochrome oxidase, subunit 1 +FIG01819620 FIG00834982: hypothetical protein +FIG01819657 Uncharacterized protein aq_460 +FIG01819714 probable oxidoreductase yajO1 +FIG01819745 Lkanal monooxygenase homolog yvbT (EC 1.14.14.3) +FIG01819769 hypothetical protein +FIG01819788 polyhydroxybutyrate depolymerase +FIG01819947 Phosphoribosylamine--glycine ligase (EC 6.3.4.13) +FIG01819963 siroheme synthase, N-terminal domain +FIG01820028 Putative DNA-binding protein, XRE family +FIG01820072 FIG00548778: hypothetical protein +FIG01820129 FIG00746170: hypothetical protein +FIG01820141 FIG00633665: hypothetical protein +FIG01820210 Histidinol-phosphatase [alternative form] (EC 3.1.3.15) +FIG01820216 FIG00848833: hypothetical protein +FIG01820238 putative ABC branched-chain amino transporter, periplasmic binding protein +FIG01820324 hypothetical protein +FIG01820351 FIG01232768: hypothetical protein +FIG01820361 FIG01239455: hypothetical protein +FIG01820373 Cobalamin B12-binding:Radical SAM +FIG01820386 Dipeptidyl aminopeptidases/acylaminoacyl-peptidases-like +FIG01820412 FIG00623087: hypothetical protein +FIG01820423 FIG00996400: hypothetical protein +FIG01820508 RpiR family regulatory protein +FIG01820556 outer membrane autotransporter barrel domain +FIG01820557 putative Secreted protein +FIG01820565 OmpW family protein +FIG01820575 Alpha/beta hydrolase( EC:1.11.1.10 ) +FIG01820582 FIG00644059: hypothetical protein +FIG01820585 zinc-containing alcohol dehydrogenase superfamily protein +FIG01820596 TraB +FIG01820698 PRC-barrel domain posible photosystem reaction centre subunit H +FIG01820731 Ribose import ATP-binding protein rbsA 1 (EC 3.6.3.17) +FIG01820840 agropine synthesis reductase +FIG01820854 ribosomal protein S7 homolog +FIG01820877 FIG00525263: hypothetical protein +FIG01820880 protein containing PDZ domain +FIG01820882 FIG00639650: hypothetical protein +FIG01820903 FIG00522069: hypothetical protein +FIG01821000 FIG00892470: hypothetical protein +FIG01821015 FIG01066994: hypothetical protein +FIG01821040 probable two-component system +FIG01821057 FIG00537335: hypothetical protein +FIG01821104 outer membrane protein (omp27) +FIG01821129 FIG00975577: hypothetical protein +FIG01821135 doubled CXXCH domain protein +FIG01821138 Phage Terminase Small Subunit +FIG01821142 cation-transporting P-type ATPase +FIG01821148 FIG00389137: hypothetical protein +FIG01821238 Putative integrin-like protein +FIG01821260 FIG01245337: hypothetical protein +FIG01821383 similar to c-type cytochrome precursor +FIG01821402 outer membrane protein precursor CzcC +FIG01821419 FIG00738711: hypothetical protein +FIG01821438 FIG00385561: hypothetical protein +FIG01821492 conserved hypothetical protein-putative secreted protein +FIG01821647 plasmid related protein +FIG01821650 probable hydrolase( EC:3.- ) +FIG01821720 putative exported (partial) +FIG01821726 valyl-tRNA synthetase( EC:6.1.1.9 ) +FIG01821755 probable RND efflux transporter +FIG01821846 membrane protein, putative( EC:5.1.1.- ) +FIG01821864 FIG01128535: hypothetical protein +FIG01821914 phosphoglycerate mutase family protein, putative +FIG01821941 CRISPR-associated protein, Cas5e family +FIG01822020 FIG00351855: hypothetical protein +FIG01822025 Probable serine/threonine protein kinase afsK (EC 2.7.1.-) +FIG01822031 cold shock domain family protein +FIG01822053 filamentous haemagglutinin +FIG01822127 epoxide hydrolase( EC:3.3.2.9 ) +FIG01822185 COG3344: Retron-type reverse transcriptase +FIG01822302 small conserved hypothetical protein +FIG01822342 FIG00551477: hypothetical protein +FIG01822363 FIG00687478: hypothetical protein +FIG01822393 Thymidylate synthase thyX (EC 2.1.1.-) @ intein-containing +FIG01822405 Msr6406 protein +FIG01822446 hypothetical protein +FIG01822452 small, acid-soluble spore proteins, alpha/be +FIG01822514 Hypothetical protein YggS, proline synthase co-transcribed bacterial homolog PROSC +FIG01822545 FIG00835292: hypothetical protein +FIG01822765 FIG00861118: hypothetical protein +FIG01822773 FIG00532616: hypothetical protein +FIG01822776 Manganese transport protein MntH +FIG01822795 FIG00408361: hypothetical protein +FIG01822802 benzodiazepine receptor TspO +FIG01822867 BRO family, N-terminal domain protein +FIG01822873 FIG00351577: hypothetical protein +FIG01822885 flavohemoprotein +FIG01822909 FIG00410032: hypothetical protein +FIG01822994 Co-activator of prophage gene expression IbrB +FIG01823050 FIG00412287: hypothetical protein +FIG01823067 FIG00582085: hypothetical protein +FIG01823083 Tetratricopeptide TPR_2 precursor +FIG01823129 magnesium-chelatase subunit +FIG01823168 Nucleoside recognition +FIG01823177 probable hydrolase, haloacid dehalogenase-like family +FIG01823198 YUIB protein +FIG01823200 putative exported protein of unknown function with OmpA family domain +FIG01823205 Sll0984 protein +FIG01823233 Erythrocyte binding protein 1 +FIG01823247 probable hemin degrading factor +FIG01823325 COG1180: Radical SAM, Pyruvate-formate lyase-activating enzyme like +FIG01823330 bi-functional transferase/deacetylase +FIG01823337 FIG00623588: hypothetical protein +FIG01823346 HtpT +FIG01823352 FIG00352215: hypothetical protein +FIG01823366 putative Tra3 protein +FIG01823379 COG0517: FOG: CBS domain +FIG01823389 putative flagellar protein FlaG +FIG01823426 FIG00598106: hypothetical protein +FIG01823433 FIG00533348: hypothetical protein +FIG01823434 Selenium-binding family protein +FIG01823476 FIG01245965: hypothetical protein +FIG01823643 FIG00418221: hypothetical protein +FIG01823685 Integrase/recombinase clustered with segregation and condensation protein B +FIG01823690 Protein prsK precursor +FIG01823785 FIG00520840: hypothetical protein +FIG01823790 collagen adhesin precursor +FIG01823832 flavin reductase-like protein +FIG01823903 FIG00499716: hypothetical protein +FIG01823911 Ankyrin 3 +FIG01823983 lipoprotein releasing system ATP-binding protein +FIG01824002 Replication regulatory protein repA2 +FIG01824066 FIG00468797: hypothetical protein +FIG01824118 Transcriptional regulator, SARP family +FIG01824130 Type II/IV secretion system secretin RcpA/CpaC, associated with Flp pilus assembly; interrupted +FIG01824168 Beta-lactamase class C family protein +FIG01824210 peptidase M17, leucyl aminopeptidase +FIG01824260 Long-chain fatty-acid-CoA ligase (EC 6.2.1.3), Mycobacterial subgroup FadD14 +FIG01824325 phage integrase-like protein +FIG01824354 Cro family transcriptional repressor +FIG01824466 Dipeptidyl aminopeptidase/acylaminoacyl-peptidase +FIG01824494 secreted oxidoreductase +FIG01824518 Probable pili assembly chaperone precursor +FIG01824565 hsp +FIG01824568 Predicted protein family PM-25 +FIG01824585 Peptidase M1, membrane alanine aminopeptidase +FIG01824740 HAD-superfamily hydrolase subfamily IIB +FIG01824801 FIG01192666: hypothetical protein +FIG01824809 YVTN beta-propeller repeat-containing protein +FIG01824871 FIG00630921: hypothetical protein +FIG01824881 bacteriocin-related protein +FIG01824883 Malate dehydrogenase( EC:1.1.1.37 ) +FIG01824921 Glucose oligosaccharide ABC transport system, permease protein 1 +FIG01824934 hypothetical protein +FIG01824941 FIG00630572: hypothetical protein +FIG01824950 Glycosyl transferase +FIG01824971 blr0867; unknown protein +FIG01824993 Tetracyclin repressor-like +FIG01825020 FIG00348994: hypothetical protein +FIG01825047 mucin-associated surface protein +FIG01825052 protein of unknown function DUF574 +FIG01825099 Serine/threonine kinase related protein, inactivated (HRDL motif absent) (fragment) +FIG01825127 FIG00525507: hypothetical protein +FIG01825176 protein of unknown function DUF1653 +FIG01825223 thiol oxidoreductase-like +FIG01825225 FIG00408767: hypothetical protein +FIG01825295 FIG00527139: hypothetical protein +FIG01825305 FIG00348939: hypothetical protein +FIG01825343 hypothetical protein( EC:3.5.4.3 ) +FIG01825407 similar to hydrolase (HAD superfamily) +FIG01825425 DNA ligase( EC:6.5.1.2 ) +FIG01825472 Polymorphic membrane protein, Chlamydia +FIG01825489 FIG00731463: hypothetical protein +FIG01825493 FIG00640255: hypothetical protein +FIG01825540 Sensory transduction protein kinase (EC 2.7.3.-) +FIG01825544 FIG01165636: hypothetical protein +FIG01825576 Chalcone synthase (CHS) +FIG01825583 IS4 ORF +FIG01825608 spore-associated protein precursor +FIG01825623 VrlC +FIG01825624 YheO domain protein +FIG01825637 Periplasmic sensor diguanylate cyclase +FIG01825638 probable biopolymer transport exbD protein +FIG01825646 N-acetylglucosamine-6P-responsive transcriptional repressor NagC, ROK family +FIG01825685 antigenic membrane protein +FIG01825709 FIG00641597: hypothetical protein +FIG01825728 DNA METHYLASE-TYPE I RESTRICTION-MODIFICATION SYSTEM +FIG01825729 monovalent cation/proton antiporter subunit, putative [EC:1.6.5.3] [KO:K00341] +FIG01825770 putative 4-oxalomesaconate hydratase +FIG01825786 FIG01114405: hypothetical protein +FIG01825807 FIG00641230: hypothetical protein +FIG01825847 Ypar31 protein +FIG01825916 COG2770: FOG: HAMP domain +FIG01825927 possible Pectate lyase +FIG01825936 putative branched-chain amino acid ABC transporter, amino acid-binding protein +FIG01825947 FIG00517718: hypothetical protein +FIG01825966 Domain of unknown function DUF1833 +FIG01825981 FIG00631314: hypothetical protein +FIG01826021 heat shock protein SP21 +FIG01826036 Phosphoglycerate dehydrogenase (EC 1.1.1.95) +FIG01826047 P35 lipoprotein homolog fragment +FIG01826059 FIG00341302: hypothetical protein +FIG01826065 FIG00906030: hypothetical protein +FIG01826069 gluconate transporter +FIG01826193 FIG00834108: hypothetical protein +FIG01826202 Transcriptional regulator, AraC family +FIG01826236 RhuM +FIG01826256 possible protein-tyrosine-phosphatase +FIG01826273 probable methylated DNA-protein cysteine methyltransferase +FIG01826321 Nonribosomal peptide synthetase +FIG01826350 transcription regulator (IclR family) BH2137 +FIG01826379 XisI protein-like protein +FIG01826416 FIG00390059: hypothetical protein +FIG01826437 alpha-2,3-sialyltransferase +FIG01826443 Serine/threonine protein kinase-like protein +FIG01826487 probable GGDEF family protein +FIG01826557 hypothetical protein SCD12A.14 +FIG01826584 FIG00363338: hypothetical protein +FIG01826647 FIG00746902: hypothetical protein +FIG01826740 iron-sulfur cluster assembly/repair protein +FIG01826801 purine-ribonucleotide metabolism +FIG01826811 COGs COG0526 +FIG01826877 peptidase S9, prolyl oligopeptidase active site region +FIG01826888 serine protease inhibitor family protein +FIG01826897 Hypothetical protein, CF-45 family +FIG01826899 probable transcriptional regulator, ArsR family +FIG01826914 FIG00624499: hypothetical protein +FIG01826921 Ca ion P-type ATPase (EC 3.6.3.8) +FIG01826924 FIG00639892: hypothetical protein +FIG01826939 similar to protein disulfide-isomerase +FIG01826969 FIG00622950: hypothetical protein +FIG01827100 Co/Zn/Cd cation transporter-like protein +FIG01827130 FIG01229667: hypothetical protein +FIG01827149 ORF070 +FIG01827168 related to protein implicated in step 4 of menaquinone synthesis via futalosine +FIG01827184 FIG01070081: hypothetical protein +FIG01827195 Flagellar L-ring protein flgH +FIG01827214 copper amine oxidase N- domain superfamily +FIG01827222 Bll4978 protein +FIG01827257 DNA-3-methyladenine glycosylase II( EC:3.2.2.21 ) +FIG01827272 glycoside hydrolase, clan GH-D +FIG01827326 hypothetical protein +FIG01827390 Curlin associated repeat protein +FIG01827437 FIG01067717: hypothetical protein +FIG01827468 comZ +FIG01827493 Mll5454 protein +FIG01827495 FIG00525143: hypothetical protein +FIG01827527 FIG00687515: hypothetical protein +FIG01827529 conserved hypothetical protein, predicted phosphatidic acid-phosphatase related phosphoesterase family +FIG01827656 putative Zn-dependent hydrolase +FIG01827708 cytochrome oxidase, subunit I (cydA-2) +FIG01827761 FIG00471057: hypothetical protein +FIG01827767 Phytochrome-like protein; Cph2 +FIG01827852 Endopolygalacturonase +FIG01827872 FIG00794221: hypothetical protein +FIG01827880 Cell binding factor 2 precursor +FIG01827930 FIG00816767: hypothetical protein +FIG01827973 FIG00413160: hypothetical protein +FIG01828000 putative aromatic compounds hydrolase +FIG01828002 possible MaoC dehydratase +FIG01828007 FIG00631478: hypothetical protein +FIG01828096 Beta galactosidase +FIG01828162 putative ABC sugar transport ATP binding protein, carboxyl terminus +FIG01828221 FIG00517351: hypothetical protein +FIG01828250 ROK family member transcriptional repressor +FIG01828298 Phosphoribosylaminoimidazole carboxylase ATPase subunit (EC 4.1.1.21) +FIG01828301 FIG00344370: hypothetical protein +FIG01828453 FIG00354062: hypothetical protein +FIG01828458 FIG00961646: hypothetical protein +FIG01828461 Cytochrome b6-f complex subunit PetM +FIG01828462 PROBABLE LIPOPROTEIN LPPP +FIG01828559 FIG00684496: hypothetical protein +FIG01828560 FIG00666800: hypothetical protein +FIG01828583 URF-1 +FIG01828625 FIG00529195: hypothetical protein +FIG01828631 FIG01074915: hypothetical protein +FIG01828634 outer membrane hemolysin activator protein +FIG01828687 galactosyltransferase-related protein +FIG01828700 FIG00356802: hypothetical protein +FIG01828740 FIG01080887: hypothetical protein +FIG01828758 FIG00388805: hypothetical protein +FIG01828771 FIG01205001: hypothetical protein +FIG01828879 protein of unknown function DUF903 +FIG01828887 Lipopolysaccharide 1,2-glucosyltransferase +FIG01828909 Apo-citrate lyase phosphoribosyl-dephospho-CoA transferase (EC 2.7.7.61) +FIG01828913 methylaspartate ammonia-lyase +FIG01828950 FIG01044085: hypothetical protein +FIG01828956 FIG00525669: hypothetical protein +FIG01828971 FIG00528310: hypothetical protein +FIG01828980 WD-40 repeat-containing protein +FIG01828992 aminoglycoside acetyltransferase +FIG01829070 putative histidine-rich metal-binding protein +FIG01829095 FIG00521495: hypothetical protein +FIG01829106 FIG00528395: hypothetical protein +FIG01829124 spbA protein +FIG01829133 hypothetical RP534 +FIG01829139 FIG01128944: hypothetical protein +FIG01829166 unknown +FIG01829183 COG0494: NTP pyrophosphohydrolases including oxidative damage repair enzymes +FIG01829214 FIG00936053: hypothetical protein +FIG01829234 ORF_ID:all7664 unknown protein +FIG01829238 FIG00379857: hypothetical protein +FIG01829244 hemolysin-type calcium-binding region +FIG01829246 sodium/chloride-dependent transporter +FIG01829277 D-cysteine desulfhydrase (EC 4.4.1.15) +FIG01829294 FIG00752604: hypothetical protein +FIG01829305 RlpA-like protein +FIG01829310 FIG00517439: hypothetical protein +FIG01829320 FIG00872249: hypothetical protein +FIG01829322 cadmium resistance transporter +FIG01829337 Glycosyl transferase, group 1 +FIG01829398 syc0811_d +FIG01829413 FIG01136498: hypothetical protein +FIG01829439 mucin-desulfating sulfatase (N-acetylglucosamine-6-sulfatase) +FIG01829476 FIG01054922: hypothetical protein +FIG01829477 Cobyrinic acid A,C-diamide synthase( EC:6.3.5.9 ) +FIG01829513 BCCT transporter +FIG01829518 FIG00638892: hypothetical protein +FIG01829524 FIG01116458: hypothetical protein +FIG01829535 hypothetical protein +FIG01829590 FIG00624643: hypothetical protein +FIG01829593 FIG00388242: hypothetical protein +FIG01829657 Domain of unknown function DUF1801 +FIG01829679 X-Pro dipeptidyl-peptidase C-terminal domain protein +FIG01829732 FIG01235642: hypothetical protein +FIG01829773 C4-dicarboxylate transport system permease large protein +FIG01829807 probable aldose-1-epimerase +FIG01829824 Integral membrane protein DUF6 +FIG01829848 Putative aminotransferase in phosphonate-related cluster +FIG01829902 FIG00862579: hypothetical protein +FIG01829947 protein of unknown function Spy-related +FIG01830045 FIG01078170: hypothetical protein +FIG01830078 FIG01168058: hypothetical protein +FIG01830217 FIG00516568: hypothetical protein +FIG01830289 bacteriocin, lactococcin 972 family protein +FIG01830343 FIG00349157: hypothetical protein +FIG01830376 FIG00624325: hypothetical protein +FIG01830391 FIG01235390: hypothetical protein +FIG01830396 SMC protein-like protein +FIG01830403 FIG00624727: hypothetical protein +FIG01830415 FIG00570248: hypothetical protein +FIG01830449 tetraheme cytochrome c +FIG01830458 FIG00410004: hypothetical protein +FIG01830510 FIG00363178: hypothetical protein +FIG01830531 PTS system, hyaluronate-oligosaccharide-specific IIB component (EC 2.7.1.69) +FIG01830580 homoserine/threonine efflux protein +FIG01830623 phosphohistidine phosphatase +FIG01830652 Predicted transposase +FIG01830707 Conjugal transfer coupling protein TraG +FIG01830754 hypothetical protein +FIG01830804 FIG00762707: hypothetical protein +FIG01830808 FIG00833345: hypothetical protein +FIG01830910 FIG00632395: hypothetical protein +FIG01830921 FIG00848838: hypothetical protein +FIG01830953 cellulose-binding, family II, bacterial type +FIG01830959 FIG01234137: hypothetical protein +FIG01830998 Curculin-like (mannose-binding) lectin +FIG01831041 tripartite transporter, small subunit +FIG01831077 FIG00407163: hypothetical protein +FIG01831086 Molybdopterin oxidoreductase subunit, predicted; chaperone protein HtpG +FIG01831126 FIG00622985: hypothetical protein +FIG01831161 FIG00632001: hypothetical protein +FIG01831187 putative mannosyltransferase +FIG01831221 diguanylate cyclase, putative +FIG01831285 probable secretion protein +FIG01831289 phosphoadenosine phosphosulfate reductase +FIG01831305 Minor tail protein Z +FIG01831328 Uncharacterized protein aq_755 +FIG01831384 FIG00389228: hypothetical protein +FIG01831386 small HspC2 heat shock protein +FIG01831426 putative ribonuclease II +FIG01831448 ABC transporter ATP binding protein +FIG01831465 FIG00649640: hypothetical protein +FIG01831499 Conserved protein YtkA +FIG01831540 phage head-tail adaptor +FIG01831577 FIG00363501: hypothetical protein +FIG01831617 FIG00687783: hypothetical protein +FIG01831628 mutant NtrC-like activator +FIG01831657 phosphonoacetaldehyde hydrolase( EC:3.11.1.1 ) +FIG01831770 probable capsular polysaccharide biosynthesis glycosyltransferase +FIG01831800 Glycoside Hydrolase Family 25 +FIG01831803 FIG01136764: hypothetical protein +FIG01831836 sugar binding protein +FIG01831918 putative capsular polysaccharide biosynthesis protein,Glycosyl Transferase Family 2, YveT +FIG01831955 FIG00824469: hypothetical protein +FIG01832007 putative permease of the major facilitator superfamily protein +FIG01832014 Probable O-antigen acetylase +FIG01832026 Cysteine synthase +FIG01832048 FIG00640424: hypothetical protein +FIG01832049 FIG01131375: hypothetical protein +FIG01832126 FIG00408654: hypothetical protein +FIG01832169 FIG00519043: hypothetical protein +FIG01832190 Hpt protein +FIG01832216 FIG00417958: hypothetical protein +FIG01832228 FIG00499914: hypothetical protein +FIG01832242 IS493-like transposase +FIG01832261 MarRP +FIG01832267 FIG01131752: hypothetical protein +FIG01832276 probable tetracycline repressor +FIG01832360 oxidoreductase FAD/NAD(P)-binding +FIG01832369 Putative tail sheath protein +FIG01832422 ribbon-helix-helix protein, CopG family +FIG01832486 FIG00469221: hypothetical protein +FIG01832495 sensory histidine kinase +FIG01832557 hypothetical protein +FIG01832609 putative Mce family protein +FIG01832611 hypothetical protein +FIG01832621 FIG00380578: hypothetical protein +FIG01832622 FIG00755884: hypothetical protein +FIG01832631 All2750 protein +FIG01832633 WXG100 domain containing protein +FIG01832647 FIG00711151: hypothetical protein +FIG01832661 "Ribosomal RNA small subunit methyltransferase G " +FIG01832686 ISPg3, transposase +FIG01832716 PilI +FIG01832719 Oxidoreductase of short-chain +FIG01832732 FIG00488449: hypothetical protein +FIG01832762 Gll1416 protein +FIG01832833 Guanidinobutyrase (EC 3.5.3.7) +FIG01832859 aminomethyltransferase +FIG01832860 hypothetical protein +FIG01832894 Putative acyltransferase +FIG01832932 hypothetical protein +FIG01832938 Mlr2630 protein +FIG01832941 FIG00838722: hypothetical protein +FIG01832993 3-hydroxyisobutyrate dehydrogenase( EC:1.1.1.31 ) +FIG01833069 FIG01120825: hypothetical protein +FIG01833081 putative transposase ISMHp1-like +FIG01833083 FIG00356045: hypothetical protein +FIG01833216 COG4113: Predicted nucleic acid-binding protein, contains PIN domain +FIG01833235 COG3209: Rhs family protein +FIG01833258 Nin protein +FIG01833295 transcriptional activator FtrA +FIG01833320 FIG00533231: hypothetical protein +FIG01833330 FIG01127997: hypothetical protein +FIG01833380 FIG00532265: hypothetical protein +FIG01833431 putative pilin, type IV +FIG01833448 putative sugar ABC transporter integral membrane protein +FIG01833521 aldehyde oxidase and xanthine dehydrogenase, molybdopterin binding +FIG01833567 PrgO-like protein for plasmid replication +FIG01833582 putative integral-membrane protein +FIG01833593 FIG00872489: hypothetical protein +FIG01833622 transport system permease protein:ABC-3 +FIG01833680 precorrin-3B methylase +FIG01833683 FIG00639217: hypothetical protein +FIG01833698 Putative usher protein +FIG01833789 FIG01241346: hypothetical protein +FIG01833831 hypothetical abductin-like protein +FIG01833865 FIG00687668: hypothetical protein +FIG01833887 Strn-Mlck gene product from transcript CG18255-RD +FIG01834034 response regulator bacteriocinproduction-related +FIG01834038 multidrug resistance protein A +FIG01834084 FIG00624297: hypothetical protein +FIG01834098 Type I restriction enzyme m protein (EC 2.1.1.72) +FIG01834100 resolvase, N-terminal domain protein +FIG01834125 HypX +FIG01834139 flagellin +FIG01834141 serotype 2 fimbrial subunit precursor +FIG01834160 similar to acyl carrier protein +FIG01834164 FIG00530397: hypothetical protein +FIG01834190 Hemolysin hemolytic protein +FIG01834194 FIG00718769: hypothetical protein +FIG01834195 putative collagenase family protease +FIG01834217 small GTP-binding protein +FIG01834218 FIG01241812: hypothetical protein +FIG01834236 SENSOR PROTEIN CHVG (EC 2.7.3.-) +FIG01834254 Hexulose-6-phosphate isomerase +FIG01834259 pSQ10.5c +FIG01834293 amino acid kinase family protein +FIG01834298 pentitol PTS system enzyme II B component-like protein lmo1972 +FIG01834314 protein phosphatase 2C +FIG01834390 Membrane export protein, related to SecD/SecF protein exporters +FIG01834460 FIG01132637: hypothetical protein +FIG01834511 FIG00853888: hypothetical protein +FIG01834550 corresponds to STY3844 from Accession AL513382: Salmonella typhi CT18 +FIG01834551 Sulfotransferase family protein +FIG01834651 Gll0036 protein +FIG01834653 PUTATIVE SIGNAL-TRANSDUCTION SENSOR PROTEIN +FIG01834750 FIG01123839: hypothetical protein +FIG01834773 Di-heme cytochrome c (Class I) , probably related to cytochrome c oxidase function +FIG01834805 FIG00407350: hypothetical protein +FIG01834819 Dipeptidyl aminopeptidase/acylaminoacyl-peptidase-like +FIG01834847 putative molybdenum ABC transporter permease protein +FIG01834850 possible Heavy-metal-associated domain (N-terminus) and membrane-bounded cytochrome biogenesis cycZ-like domain protein +FIG01834861 FIG00764605: hypothetical protein +FIG01834891 FIG00412365: hypothetical protein +FIG01834904 FIG00355809: hypothetical protein +FIG01834914 FIG00351179: hypothetical protein +FIG01835033 initiator RepB protein family +FIG01835035 regulatory protein RecX, putative +FIG01835116 4-keto.6-deoxy-N-Acetyl-D-hexosaminyl-(Lipid carrier) aminotransferase +FIG01835224 FIG00643078: hypothetical protein +FIG01835235 calcium/proton antiporter, CaCA family +FIG01835254 FIG00623186: hypothetical protein +FIG01835288 FIG01117069: hypothetical protein +FIG01835312 transcriptional activator, Rgg/GadR/MutR family protein +FIG01835319 homolog to predicted helicase( EC:3.6.1.- ) +FIG01835343 FIG00834770: hypothetical protein +FIG01835414 prophage CP4-57 integrase +FIG01835554 Alkaline protease secretion ATP-binding protein AprD +FIG01835565 peptidase S45, penicillin amidase +FIG01835590 sensor histidine kinase +FIG01835633 FIG00536254: hypothetical protein +FIG01835641 FIG00674164: hypothetical protein +FIG01835734 lantibiotic modifying enzyme +FIG01835791 FIG00960476: hypothetical protein +FIG01835797 FIG00686328: hypothetical protein +FIG01835834 COG0501: Zn-dependent protease with chaperone function +FIG01835881 FIG01243605: hypothetical protein +FIG01835958 positive regulator of sigma E, RseC/MucC +FIG01835969 Cytochrome c551/c552-like +FIG01835983 probable ABC transporter, periplasmic substrate-binding protein +FIG01836016 signal transduction protein-like +FIG01836028 FIG01054983: hypothetical protein +FIG01836030 Putative oxidase +FIG01836039 periplasmic serine protease do +FIG01836093 FIG00849283: hypothetical protein +FIG01836103 phage antirepressor protein +FIG01836123 Cytochrome-c peroxidase( EC:1.11.1.5 ) +FIG01836134 putative signal-transduction protein with CBS domains +FIG01836148 RNA one modulator-like protein +FIG01836195 Cysteine dioxygenase type I (EC 1.13.11.20) +FIG01836245 116aa long hypothetical protein +FIG01836251 COGs COG0518 +FIG01836279 Alkaline phosphatase precursor (EC 3.1.3.1) +FIG01836280 Possible enoyl-CoA hydratase +FIG01836310 oxidoreductase short-chain dehydrogenase/reductase family +FIG01836340 Phospholipase C family protein +FIG01836347 CBS:Transporter-associated region +FIG01836349 conserved hypothetical/unknown transmembrane protein +FIG01836387 predicted transcription regulator, containing DNA-binding HTH domain +FIG01836462 Hypothetical protein, CF-11 family +FIG01836509 Glutathione peroxidase( EC:1.11.1.12,EC:1.11.1.9 ) +FIG01836529 similar to ABC-type nitrate/sulfonate/bicarbonate transport systems periplasmic components +FIG01836534 two component sensor histidine kinase +FIG01836539 sensory box protein/sigma-54 dependent DNA-binding response regulator +FIG01836545 FIG00733759: hypothetical protein +FIG01836546 outermembrane hypothetical protein +FIG01836551 FIG00525947: hypothetical protein +FIG01836560 FIG00956118: hypothetical protein +FIG01836584 putative mandelate racemase [EC:5.1.2.2] +FIG01836598 Cad gene transcriptional regulator +FIG01836609 FIG00726182: hypothetical protein +FIG01836645 30S ribosomal protein S16 +FIG01836666 FIG00435161: hypothetical protein +FIG01836685 Rifampin monooxygenase +FIG01836714 FIG00952084: hypothetical protein +FIG01836761 Putative DNA methylase +FIG01836772 Uncharacterized protein Mb0930 precursor +FIG01836789 FIG00344161: hypothetical protein +FIG01836795 Mlr6622 protein +FIG01836821 prophage LambdaSo, transcriptional regulator, Cro/CI family +FIG01836827 Modification methylase MjaI (EC 2.1.1.113) (N-4 cytosine-specific methyltransferase MjaI) (M.MjaI) +FIG01836886 FIG01157459: hypothetical protein +FIG01836888 Gas vesicle synthesis protein +FIG01836905 protein of unknown function DUF883 ElaB +FIG01836919 glycerate dehydrogenase/hydroxypyruvate reductase +FIG01836951 putative phosphosugar-binding transcriptional regulator +FIG01836983 MFS superfamily transporter +FIG01837018 Isobutylamine N-hydroxylase +FIG01837039 FIG01074789: hypothetical protein +FIG01837075 FIG01166558: hypothetical protein +FIG01837082 sigma 54 modulation protein/ribosomal protein S30EA +FIG01837142 Uncharacterized protein TP_0370 +FIG01837164 PROBABLE INTEGRASE PROTEIN +FIG01837206 hypothetical protein, putative ABC transporter-associated permease +FIG01837278 Mll8365 protein +FIG01837292 tetracenomycin C synthesis protein homolog +FIG01837322 RIKEN cDNA D630042P16 gene +FIG01837338 Glycosyl transferase, family 31 +FIG01837400 FIG00624114: hypothetical protein +FIG01837470 FIG01048196: hypothetical protein +FIG01837478 FIG00633718: hypothetical protein +FIG01837507 HhH-GPD domain protein +FIG01837517 FIG00510947: hypothetical protein +FIG01837525 putative binding-protein-dependent transport system protein +FIG01837528 similar to RNA polymerase sigma-E factor +FIG01837538 FIG00642672: hypothetical protein +FIG01837608 N, N-dimethyltransferase +FIG01837610 FIG00415543: hypothetical protein +FIG01837624 FIG00808894: hypothetical protein +FIG01837655 putative transposase number 1 for insertion sequence ISRM28 +FIG01837916 Transposase +FIG01838037 FIG00644775: hypothetical protein +FIG01838088 Pseudogene of Hypothetical protein (C-terminalpart) +FIG01838235 LpqC +FIG01838343 SAM:benzoic acid carboxyl methyltransferase +FIG01838427 hypothetical protein +FIG01838474 Helix-turn-helix motif +FIG01838548 lipopolysaccharide modification acyltransferase +FIG01838557 FIG00773164: hypothetical protein +FIG01838567 FIG00424641: hypothetical protein +FIG01838612 putative sigma-70 factor, ECF subfamily +FIG01838668 Predicted SAM dependent methyltransferase +FIG01838689 FIG00950960: hypothetical protein +FIG01838749 ISPsy11, transposase OrfA +FIG01838794 probable transcriptional activator +FIG01838797 FIG00352043: hypothetical protein +FIG01838964 ParA/Soj +FIG01838976 FIG00349793: hypothetical protein +FIG01838977 Uncharacterized protein YfaD +FIG01839012 FIG022160: hypothetical toxin +FIG01839014 possible cell surface protein +FIG01839131 FIG00631727: hypothetical protein +FIG01839135 FIG00734219: hypothetical protein +FIG01839197 Fumarate reductase, flavoprotein subunit, N-terminally truncated (EC 1.3.99.1) +FIG01839274 Monocarboxylate MFS permease +FIG01839355 FIG00631100: hypothetical protein +FIG01839579 FIG00768284: hypothetical protein +FIG01839684 FIG00589445: hypothetical protein +FIG01839691 FIG00388029: hypothetical protein +FIG01839744 type III effector HopPtoI +FIG01839745 Histidine kinase, homodimeric +FIG01839756 FIG01166147: hypothetical protein +FIG01839807 NagC/XylR-type transciptional regulator +FIG01839833 hypothetical protein +FIG01839845 putative N6 adenine-specific DNA methyltransferase +FIG01839938 syc1344_c +FIG01839968 ORF_ID:tlr0341 hypothetical protein +FIG01840022 daunorubicin resistance ATP-binding protein +FIG01840033 FIG004853: possible toxin to DivIC +FIG01840193 Putative transposase y4zB +FIG01840275 diguanylate phosphodiesterase (EAL domain) with GAF sensor +FIG01840283 H(+)-transporting ATPase +FIG01840287 cytochrome C family protein +FIG01840311 transcriptional regulator TetR family protein +FIG01840367 dinitrogenase iron-molybdenum cofactor family protein +FIG01840398 putative phosphoprotein phosphatase +FIG01840473 makorin ring finger protein 2 +FIG01840526 FIG00838863: hypothetical protein +FIG01840528 FIG00871182: hypothetical protein +FIG01840555 DNA polymerase III alpha subunit +FIG01840627 FIG00512870: hypothetical protein +FIG01840673 FIG00762615: hypothetical protein +FIG01840679 FIG00344547: hypothetical protein +FIG01840683 FIG00364926: hypothetical protein +FIG01840728 Pesticidial crystal protein cry6Aa +FIG01840732 Type I restriction-modification system, M subunit +FIG01840743 FIG01133450: hypothetical protein +FIG01840760 Heme biosynthesis protein +FIG01840849 cyanuric acid amidohydrolase +FIG01840850 phage-like element pbsx protein XkdK +FIG01840858 platelet activating factor +FIG01840881 protein of unknown function DUF937 +FIG01840915 COG0507: ATP-dependent exoDNAse (exonuclease V), alpha subunit - helicase superfamily I member +FIG01840924 YbfM +FIG01840963 ABC-type drug export system, ATP-binding protein +FIG01840994 Possible regulator +FIG01840999 FIG01042837: hypothetical protein +FIG01841038 DNA-directed RNA polymerase +FIG01841102 FIG01081579: hypothetical protein +FIG01841111 FIG00410299: hypothetical protein +FIG01841153 putative UDP-glucose 4-epimerase (NAD-dependent epimerase/dehydratase)( EC:5.1.3.2 ) +FIG01841186 FIG01248250: hypothetical protein +FIG01841214 FIG00795142: hypothetical protein +FIG01841232 FIG01207407: hypothetical protein +FIG01841241 FIG01036131: hypothetical protein +FIG01841265 THUA +FIG01841322 type I restriction-modification system specificity determinant +FIG01841343 FIG01081860: hypothetical protein +FIG01841349 Mll6596 protein +FIG01841423 LtrM +FIG01841426 transcriptional regulatory protein PadR- +FIG01841433 FIG00713327: hypothetical protein +FIG01841460 hypothetical protein +FIG01841476 Phospholipase A +FIG01841501 probable copper-transporting ATPase +FIG01841510 18 kDa antigen 2 +FIG01841517 FIG01224017: hypothetical protein +FIG01841577 FIG01205383: hypothetical protein +FIG01841599 FIG00522198: hypothetical protein +FIG01841750 nitrogen regulation protein NtrX +FIG01841763 FIG00521250: hypothetical protein +FIG01841765 FIG01207312: hypothetical protein +FIG01841792 FIG01094633: hypothetical protein +FIG01841881 FIG00344685: hypothetical protein +FIG01841903 putative glutamate synthase, small chain +FIG01841904 COG5305: Predicted membrane protein +FIG01841924 Putative membrane pump protein +FIG01841986 FIG00415823: hypothetical protein +FIG01842102 FIG00416349: hypothetical protein +FIG01842122 FIG00961428: hypothetical protein +FIG01842154 FIG01129145: hypothetical protein +FIG01842228 UPF0235 protein SO_3356 +FIG01842263 FIG00893283: hypothetical protein +FIG01842298 Cytochrome c oxidase subunit CcoQ (EC 1.9.3.1) +FIG01842351 FIG00362460: hypothetical protein +FIG01842356 putative agmatinase +FIG01842379 FIG00688140: hypothetical protein +FIG01842438 Transcriptional regulator, XRE family, putative +FIG01842456 FIG00688577: hypothetical protein +FIG01842530 ATP-dependent transcriptional regulator-like protein +FIG01842536 DdrA +FIG01842614 phospho-beta-galactosidase I( EC:3.2.1.86 ) +FIG01842631 hypothetical protein( EC:3.1.2.14 ) +FIG01842633 putative NADPH-quinone reductase (modulator of drug activity B) +FIG01842666 putative exported protein +FIG01842785 FIG00344119: hypothetical protein +FIG01842802 surface polysaccharides, lipopolysaccharides and antigens +FIG01842897 probable conserved integral membrane alanine and leucine rich protein +FIG01842913 Integrase +FIG01842947 FIG01198652: hypothetical protein +FIG01842970 FIG00624762: hypothetical protein +FIG01842999 FIG00343767: hypothetical protein +FIG01843005 FIG01247894: hypothetical protein +FIG01843128 FIG00439020: hypothetical protein +FIG01843158 FIG00348560: hypothetical protein +FIG01843212 prophage pi2 protein 34 +FIG01843213 possible DNA primase, putative +FIG01843248 auxin-binding protein +FIG01843249 antioxidant, AhpC/TSA family +FIG01843270 FIG01150830: hypothetical protein +FIG01843277 probable N-acetylglutamate synthase( EC:2.3.1.1 ) +FIG01843280 FIG00497502: hypothetical protein +FIG01843312 Cell wall hydrolase/autolysin +FIG01843345 FIG00356433: hypothetical protein +FIG01843350 Phosphoglyceromutase/phosphopentomutase +FIG01843400 FIG00962005: hypothetical protein +FIG01843469 Putative membrane protein SCO0839 +FIG01843470 LysM domain/M23/M37 peptidase domain protein +FIG01843508 Phosphoserine phosphatase, chloroplast precursor (EC 3.1.3.3) (PSP) (O-phosphoserine phosphohydrolase) (PSPase) +FIG01843556 Pentapeptide repeat protein +FIG01843572 possible neuromedin U +FIG01843591 Colicin-M +FIG01843612 FIG00697004: hypothetical protein +FIG01843658 FIG01135991: hypothetical protein +FIG01843707 putative glutamine amidotransferase +FIG01843719 bacteriophage replication gene A +FIG01843784 2C-methyl-D-erythritol 2,4-cyclodiphosphate synthase( EC:4.6.1.12 ) +FIG01843852 thioredoxin-related protein +FIG01843859 FIG00350688: hypothetical protein +FIG01843863 protein of unknown function DUF23 +FIG01843896 Sll1761 protein +FIG01843905 FIG00409532: hypothetical protein +FIG01843964 FIG00674290: hypothetical protein +FIG01843994 FIG01094983: hypothetical protein +FIG01844027 small multidrug resistance protein, SMR family +FIG01844071 transcription initiation factor TFB +FIG01844074 FIG00380910: hypothetical protein +FIG01844097 FIG00786182: hypothetical protein +FIG01844111 FIG01093033: hypothetical protein +FIG01844116 Ssr2047 protein +FIG01844168 FIG00353450: hypothetical protein +FIG01844179 hypothetical protein +FIG01844190 Uncharacterized protein aq_058 +FIG01844216 TonB dependent receptor domain protein +FIG01844217 putative lipase transmembrane protein +FIG01844242 putative transcriptional activator - phage associated +FIG01844248 FIG00353742: hypothetical protein +FIG01844348 FIG00447216: hypothetical protein +FIG01844382 predicted 14.0Kd protein +FIG01844416 FIG01172113: hypothetical protein +FIG01844418 small heat shock protein (class I) +FIG01844439 FIG00356316: hypothetical protein +FIG01844465 hypothetical protein, TIGR02147 +FIG01844491 KorC +FIG01844530 hypothetical protein +FIG01844576 FIG01119751: hypothetical protein +FIG01844594 Transposase +FIG01844659 nucleotidyltransferase-like +FIG01844672 FIG00956515: hypothetical protein +FIG01844674 FIG00356278: hypothetical protein +FIG01844767 FIG00349063: hypothetical protein +FIG01844831 FIG00699318: hypothetical protein +FIG01844894 FIG01249987: hypothetical protein +FIG01844920 Mll8752 protein +FIG01844987 conserved hypothetical protein-putative acetyltransferase +FIG01845028 Integrase, catalytic core +FIG01845061 hypothetical protein +FIG01845092 FIG00963823: hypothetical protein +FIG01845104 FIG01229887: hypothetical protein +FIG01845120 FIG00919924: hypothetical protein +FIG01845148 FIG00407597: hypothetical protein +FIG01845150 FCD domain protein +FIG01845205 FIG00697757: hypothetical protein +FIG01845237 Tetratricopeptide region +FIG01845279 N-carbamoyl-L-aspartate amidohydrolase (EC 3.5.1.7) +FIG01845289 FIG00674444: hypothetical protein +FIG01845302 FIG01167061: hypothetical protein +FIG01845310 rarD protein, chloamphenicol sensitive +FIG01845335 FIG00764836: hypothetical protein +FIG01845400 FIG00633461: hypothetical protein +FIG01845404 predicted acetamidase/formamidase +FIG01845410 FIG00999665: hypothetical protein +FIG01845430 Neutral endopeptidase (EC 3.4.24.-) +FIG01845522 large tegument protein +FIG01845536 poly(aspartic acid) hydrolase-1 +FIG01845540 probable 5,10-methylenetetrahydromethanopterin reductase( EC:1.5.99.11 ) +FIG01845579 FIG00622983: hypothetical protein +FIG01845618 ECF-sigma factor +FIG01845638 conserved hypothetical glycosyl transferase +FIG01845640 transcription elongation factor G +FIG01845648 transposase for IS660 +FIG01845659 putative epoxide hydrolase +FIG01845688 Isoamylase precursor +FIG01845695 FIG00380463: hypothetical protein +FIG01845774 degV protein +FIG01845783 truncated maltose-binding protein +FIG01845792 FIG00547607: hypothetical protein +FIG01845804 FIG01020402: hypothetical protein +FIG01845820 hypothetical protein, conserved +FIG01845826 putative sulfonate binding protein +FIG01845880 FIG00838006: hypothetical protein +FIG01845890 FIG01146476: hypothetical protein +FIG01845904 FIG00314463: hypothetical protein +FIG01845991 FIG01202860: hypothetical protein +FIG01846004 5'-Nucleotidase domain protein +FIG01846017 FIG00563121: hypothetical protein +FIG01846153 signal-transducing histidine kinase +FIG01846155 peptidoglycan biosynthesis protein, FtsW/RodA/SpoVE family +FIG01846166 BirA-related protein +FIG01846167 FIG00964172: hypothetical protein +FIG01846239 FIG00873205: hypothetical protein +FIG01846241 Protein tyrosine/serine phosphatase-like +FIG01846357 FIG01028767: hypothetical protein +FIG01846375 UDP-glucoronosyl and UDP-glucosyltransferases family protein +FIG01846447 FIG00964849: hypothetical protein +FIG01846474 FIG00403249: hypothetical protein +FIG01846475 RelE-like Cytotoxic translational repressor of toxin-antitoxin stability system +FIG01846520 putative ABC transporter, integral membrane subunit +FIG01846604 FIG00997578: hypothetical protein +FIG01846637 mandelate racemase +FIG01846656 FIG01082926: hypothetical protein +FIG01846742 COG4606: ABC-type enterochelin transport system, permease component +FIG01846744 putative Cold shock-like protein +FIG01846758 FIG00642252: hypothetical protein +FIG01846795 PAAR repeat-containing protein +FIG01846938 FIG00522745: hypothetical protein +FIG01846943 putative Organic solvent tolerance protein +FIG01846957 Putative Mg2+ Transporter-C (MgtC) Family +FIG01846965 Predicted protease related to collagenase +FIG01846994 NHL repeat-containing protein +FIG01846998 FIG00380008: hypothetical protein +FIG01847034 FIG01063176: hypothetical protein +FIG01847036 syc1020_d +FIG01847074 FIG038648: MoaD and/or ThiS families +FIG01847097 Protein of unknown function (DUF433) family +FIG01847178 FIG00426540: hypothetical protein +FIG01847216 Pentalenene synthase (EC 4.2.3.7) +FIG01847232 TWO-COMPONENT HYBRID SENSOR AND REGULATOR +FIG01847248 mobB +FIG01847289 putative aspartate racemase +FIG01847335 FIG00624849: hypothetical protein +FIG01847517 ribose transport system permease protein RbsC( EC:3.6.3.17 ) +FIG01847518 hypothetical phage protein +FIG01847541 PROBABLE DNA HELICASE ERCC3 (EC 3.6.1.-) +FIG01847550 FIG00700869: hypothetical protein +FIG01847575 Probable vanillate O-demethylase oxygenase subunit oxidoreductase protein (EC 1.14.13.-) +FIG01847579 FIG00528807: hypothetical protein +FIG01847616 FIG01132376: hypothetical protein +FIG01847627 COG0762 +FIG01847654 Queuine/archaeosine tRNA-ribosyltransferase +FIG01847661 hypothetical protein +FIG01847669 PhoU +FIG01847700 periplasmic serine proteinase +FIG01847722 Uncharacterized ACR, COG1259 family +FIG01847724 FIG01070294: hypothetical protein +FIG01847776 Thermonuclease (EC 3.1.31.1) +FIG01847793 FIG00756500: hypothetical protein +FIG01847812 carboxylesterase NP( EC:3.1.1.1 ) +FIG01847832 VSH-1 associated protein 1 +FIG01847834 FIG00715605: hypothetical protein +FIG01847922 FIG01131228: hypothetical protein +FIG01848008 acylglycerol lipase +FIG01848071 UPF0290 protein TK2119 +FIG01848082 FIG01132914: hypothetical protein +FIG01848123 Restriction modification enzyme +FIG01848199 FIG00629064: hypothetical protein +FIG01848221 nickel-dependent hydrogenase, iron-sulfur cluster-binding protein +FIG01848314 FIG00360865: hypothetical protein +FIG01848317 Beta-glucosidase( EC:3.2.1.21 ) +FIG01848379 FIG01223294: hypothetical protein +FIG01848392 FIG01170014: hypothetical protein +FIG01848430 dehydrogenases with different specificities (related to short-chain alcohol dehydrogenases) +FIG01848482 FIG00410891: hypothetical protein +FIG01848593 Nitrogenase +FIG01848652 putative signal peptidase, membrane protein, cleaves prepilin-like proteins +FIG01848711 FIG00356103: hypothetical protein +FIG01848769 hypothetical protein +FIG01848794 FIG00531490: hypothetical protein +FIG01848870 Bll6304 protein +FIG01848938 carboxypeptidase G2, putative +FIG01848965 FIG00524903: hypothetical protein +FIG01848976 FIG00362448: hypothetical protein +FIG01849092 molybdate ABC transporter, permease protein +FIG01849096 sodium-calcium exchanger +FIG01849161 putative oxidase +FIG01849184 GGDEF domain protein protein +FIG01849234 FIG01120724: hypothetical protein +FIG01849278 FIG01219099: hypothetical protein +FIG01849315 outer membrane protein (omp6) +FIG01849337 FIG01110460: hypothetical protein +FIG01849341 FIG01043399: hypothetical protein +FIG01849357 FIG00952102: hypothetical protein +FIG01849398 FIG00533526: hypothetical protein +FIG01849403 Streptomycin 6-kinase (EC 2.7.1.72) (Streptidine kinase) (Streptomycin 6-phosphotransferase) (APH(6)) +FIG01849420 Bll4269 protein +FIG01849423 phosphate regulon sensor protein phoR +FIG01849450 N-Acetyl-D-glucosamine-related ABC transport system, permease protein 1 +FIG01849456 FIG00387834: hypothetical protein +FIG01849476 Protein of unknown function SprT +FIG01849538 hemin ABC transporter ATP binding protein +FIG01849580 hypothetical protein +FIG01849613 FIG00675371: hypothetical protein +FIG01849669 FIG00427651: hypothetical protein +FIG01849710 FIG00532574: hypothetical protein +FIG01849787 putative magnesium transporter +FIG01850036 protein phosphatase 2C homolog (ptc1) +FIG01850101 Putative uncharacterized protein BCG_1969c +FIG01850107 FIG00628460: hypothetical protein +FIG01850207 probable flavin oxygenase +FIG01850261 ORF82 +FIG01850281 putative NAD(P)H nitroreductase +FIG01850345 FIG00515824: hypothetical protein +FIG01850410 ORF2 +FIG01850452 Probable fimbrial protein +FIG01850461 sigma-54 dependent transcriptional regulator, Fis family +FIG01850500 Putative protein-S-isoprenylcysteine methyltransferase +FIG01850506 D-alanine--D-alanine ligase( EC:6.3.2.4 ) +FIG01850540 CheY-like response regulator +FIG01850588 FIG00344612: hypothetical protein +FIG01850597 probable transposase +FIG01850674 AbgT putative transporter +FIG01850751 FIG01198746: hypothetical protein +FIG01850753 COG5433: Transposase +FIG01850758 FIG00525556: hypothetical protein +FIG01850792 2-hydroxyglutaryl-CoA dehydratase D-component +FIG01850896 Putative cI prophage repressor protein +FIG01850937 probable sensory transduction regulatory protein +FIG01850945 oxalate/formate antiporter (OxlT-2) +FIG01851000 cytidine/deoxycytidylate deaminase family protein, putative +FIG01851042 mrr restriction system protein +FIG01851081 ATPase-like +FIG01851097 long-chain fatty acid transport protein, outer membrane protein +FIG01851186 Sugar ABC transporter permease protein ycjP +FIG01851188 hypothetical protein +FIG01851254 Thiosulfate sulfurtransferase, rhodanese (EC 2.8.1.1) +FIG01851290 large, multifunctional secreted protein +FIG01851319 hypothetical protein +FIG01851362 ORF_ID:all7660 unknown protein +FIG01851400 probable 85 complex protein +FIG01851401 FIG00960335: hypothetical protein +FIG01851410 Glutenin, high molecular weight subunit type x +FIG01851434 FIG00389937: hypothetical protein +FIG01851467 Protein of unknown function DUF985 +FIG01851541 FIG00407302: hypothetical protein +FIG01851616 FIG00404508: hypothetical protein +FIG01851635 conserved hypothetical protein, membrane +FIG01851652 phosphate transport regulator +FIG01851673 putative membrane-anchored glycosyltransferase protein +FIG01851679 putative diguanylate cyclase (GGDEF)/phosphodiesterase (EAL) with PAS domain +FIG01851706 FIG00871937: hypothetical protein +FIG01851718 NAD(P)H dehydrogenase (Quinone) (EC 1.6.5.2) +FIG01851761 FIG00623456: hypothetical protein +FIG01851817 FIG00957277: hypothetical protein +FIG01851823 FIG00623749: hypothetical protein +FIG01851840 FIG00733982: hypothetical protein +FIG01851894 5-oxopent-3-ene-1,2,5-tricarboxylate decarboxylase( EC:4.1.1.68 ) +FIG01851908 FIG00524778: hypothetical protein +FIG01851959 Putative pterin-4-alpha-carbinolamine dehydratase (PHS)( EC:4.2.1.96 ) +FIG01851998 glycosyl transferase, group 2 +FIG01852010 Ribosomal protein S1 +FIG01852163 Polysaccharide export-related periplasmic protein +FIG01852266 ABC-type multidrug transport system, ATPase component +FIG01852363 FIG00597802: hypothetical protein +FIG01852384 FIG00426018: hypothetical protein +FIG01852456 Insertion element IS1 protein insA +FIG01852494 FIG00588899: hypothetical protein +FIG01852524 FIG00986943: hypothetical protein +FIG01852603 FIG00380996: hypothetical protein +FIG01852606 hypothetical protein +FIG01852620 FIG00349918: hypothetical protein +FIG01852679 FIG00667160: hypothetical protein +FIG01852738 HDIG +FIG01852739 Hypothetical protein pVir0007 +FIG01852771 Bll0856 protein +FIG01852785 putative histidine protein kinase +FIG01852797 FIG00469101: hypothetical protein +FIG01852828 Glutamine transporter ATP-binding protein +FIG01852834 Flavoprotein NADH-dependent oxidoreductase +FIG01852860 putative sugar-binding lipoprotein. +FIG01852920 putative hydrolase( EC:3.3.2.9 ) +FIG01852942 FIG00361819: hypothetical protein +FIG01852950 putative lycopene cyclase +FIG01852982 FIG00734240: hypothetical protein +FIG01853009 FIG00624124: hypothetical protein +FIG01853046 conserved protein, putative +FIG01853060 serine/threonine protein kinase Pkn6 +FIG01853105 FIG00764185: hypothetical protein +FIG01853123 FIG00567212: hypothetical protein +FIG01853161 Toll-Interleukin receptor +FIG01853166 PUTATIVE HISTIDINE KINASE (FRAGMENT) +FIG01853268 FIG00752531: hypothetical protein +FIG01853330 TetR family protein regulatory protein +FIG01853418 possible MutT/nudix family protein +FIG01853445 formyltetrahydrofolate deformylase( EC:3.5.1.10 ) +FIG01853452 FIG01207120: hypothetical protein +FIG01853486 Fucose permease +FIG01853515 FIG00864913: hypothetical protein +FIG01853530 Globin domain +FIG01853531 Superoxide dismutase SodM-like protein +FIG01853708 Uncharacterized protein AF_2205 +FIG01853749 permease cadmium resistance protein-like protein +FIG01853850 2-[hydroxy(phenyl)methyl]-succinyl-CoA dehydrogenase alpha subunit (EC 1.1.1.35) +FIG01853881 CpeT protein +FIG01853898 probable C-5 cytosine-specific DNA methylase +FIG01853902 Gluconolactonase-like +FIG01853939 FIG00672299: hypothetical protein +FIG01853941 ORF_ID:alr7086 +FIG01853965 Drug/metabolite exporter +FIG01854006 HtpX domain protein +FIG01854008 FIG00416702: hypothetical protein +FIG01854084 FIG01055142: hypothetical protein +FIG01854114 Protein ygiN +FIG01854118 Probable L-aspartate dehydrogenase (EC 1.4.1.21) +FIG01854127 Predicted PTS system, galactosamine disaccharide-specific IIA component (EC 2.7.1.69) +FIG01854134 FIG00457042: hypothetical protein +FIG01854202 UDP-glucose 6-dehydrogenase +FIG01854217 conserved hypothetical inner membrane protein +FIG01854257 FIG01233165: hypothetical protein +FIG01854306 nucleic acid-binding protein, contains PIN domain +FIG01854339 similarity to ABC transporter ATP-binding protein +FIG01854407 DNA-binding protein HU-beta +FIG01854425 FIG01039007: hypothetical protein +FIG01854429 FIG00405854: hypothetical protein +FIG01854459 omp43 precursor +FIG01854462 FIG00519801: hypothetical protein +FIG01854481 FIG00941411: hypothetical protein +FIG01854491 UPF0337 protein mlr2098 +FIG01854492 ORF_ID:tsr1840 hypothetical protein +FIG01854500 FIG00733876: hypothetical protein +FIG01854528 FIG00540014: hypothetical protein +FIG01854569 FIG00643071: hypothetical protein +FIG01854611 Similar to histidine ammonia-lyase +FIG01854633 BNR/Asp-box repeat domain protein +FIG01854702 putative cytochrome c protein +FIG01854719 putative bacteriocin ABC transporter, bacteriocin-binding protein +FIG01854753 potassium uptake protein TrkA, putative +FIG01854781 RNA methyltransferase related protein +FIG01854789 FIG01247115: hypothetical protein +FIG01854942 putative LuxA +FIG01854981 Cl- channel, voltage-gated family protein +FIG01855039 FIG00347601: hypothetical protein +FIG01855160 Sll1762 protein +FIG01855169 hypothetical protein +FIG01855254 IS4 orf +FIG01855260 FIG00559970: hypothetical protein +FIG01855276 extracellular alkaline serine protease +FIG01855337 FIG00769871: hypothetical protein +FIG01855479 FIG00624213: hypothetical protein +FIG01855499 FIG00847201: hypothetical protein +FIG01855511 IncH1 plasmid conjugative transfer protein Orf9 +FIG01855545 FIG00533571: hypothetical protein +FIG01855582 Modification methylase FokI (EC 2.1.1.72) (Adenine-specific methyltransferase FokI) (M.FokI) +FIG01855622 putative transposase +FIG01855698 PAP2 (acid phosphatase) superfamily protein-like protein +FIG01855702 Methyltransferase, homolog +FIG01855724 FIG00631468: hypothetical protein +FIG01855728 General secretory system II protein E domain protein +FIG01855736 putative endonuclease VII +FIG01855780 phage single-stranded DNA-binding protein, putative +FIG01855815 FIG00764504: hypothetical protein +FIG01855821 SNase-like nuclease( EC:3.1.31.1 ) +FIG01855878 DNA N-4 cytosine methyltransferase M.NgoMXV +FIG01856096 Uncharacterized protein MJ1295 +FIG01856099 FIG00570388: hypothetical protein +FIG01856102 ISXo8 transposase +FIG01856187 FIG00731669: hypothetical protein +FIG01856258 Conserved integral membrane protein +FIG01856270 Rab family protein +FIG01856275 putative integrase/resolvase recombinase protein +FIG01856277 FIG00816937: hypothetical protein +FIG01856292 hypothetical protein, possibly C terminus of iron ABC transporter periplasmatic solute-binding protein +FIG01856312 Transaldolase +FIG01856324 mannose-6-phosphate isomerase +FIG01856327 Type II secretion inner membrane protein (PulF) +FIG01856383 FIG01117886: hypothetical protein +FIG01856478 YeeE/YedE +FIG01856515 conserved protein YuxO +FIG01856537 methyltransferase putative +FIG01856556 Methyltransferase, UbiE/COQ5 family +FIG01856726 FIG01015649: hypothetical protein +FIG01856783 Vanadium-dependent bromoperoxidase 2 +FIG01856826 heme exporter protein CcmA +FIG01856894 FIG00520344: hypothetical protein +FIG01856904 FIG00566237: hypothetical protein +FIG01856971 FIG01251579: hypothetical protein +FIG01856982 FIG00527526: hypothetical protein +FIG01857034 FIG00466046: hypothetical protein +FIG01857188 YBTP PROTEIN +FIG01857255 FIG00744788: hypothetical protein +FIG01857258 hypothetical protein SC9B2.11 +FIG01857315 Alr7357 protein +FIG01857363 FIG00624145: hypothetical protein +FIG01857384 FIG00641447: hypothetical protein +FIG01857423 putative cytochrome P460 +FIG01857469 protein of unknown function DUF1503 +FIG01857480 similar to Transposase +FIG01857539 FIG01095058: hypothetical protein +FIG01857545 response regulator/sensor histidine kinase +FIG01857686 Lipid A export ATP-binding/permease protein MsbA +FIG01857714 FIG01121799: hypothetical protein +FIG01857733 large supernatant protein 2 +FIG01857738 FIG00388310: hypothetical protein +FIG01857778 FIG00839271: hypothetical protein +FIG01857827 Bll7858 protein +FIG01857856 putative aminoglycoside N(6')-acetyltransferase +FIG01857890 FIG00349133: hypothetical protein +FIG01857914 putative oxidoreductase/dehydrogenase family +FIG01857927 Possible periplasmic aspartyl protease +FIG01857988 Uncharacterized protein MJ1311 +FIG01857998 ribonucleotide reductase +FIG01858221 FIG00496145: hypothetical protein +FIG01858228 superoxide dismutase, copper/zinc binding +FIG01858292 FIG00519325: hypothetical protein +FIG01858314 RelB/StbD replicon stabilization protein (antitoxin to RelE/StbE) +FIG01858325 hypothetical protein +FIG01858343 FIG01250989: hypothetical protein +FIG01858368 FIG00344559: hypothetical protein +FIG01858385 FIG00514847: hypothetical protein +FIG01858456 FIG00623945: hypothetical protein +FIG01858463 N-ethylammeline chlorohydrolase +FIG01858504 NAD(P)H nitroreductase +FIG01858519 galactose mutarotase related enzyme +FIG01858523 predicted gene, EG666234 +FIG01858640 CiaB PROTEIN +FIG01858668 hypothetical protein +FIG01858677 FIG00404848: hypothetical protein +FIG01858695 Predicted metal-sulfur cluster biosynthetic enzyme +FIG01858696 FIG00434738: hypothetical protein +FIG01858703 N-acyl-D-glucosamine 2-epimerase-like protein +FIG01858705 syc0838_d +FIG01858717 Regulatory sensor-transducer, BlaR1/MecR1 family / Ankyrin-related protein +FIG01858719 Dehydrogenase-like protein +FIG01858813 uroporphyrin-III C-methyltransferase( EC:2.1.1.107 ) +FIG01858863 UPF0150 protein ssr1765 +FIG01858895 hypothetical protein +FIG01858927 Myosin heavy chain, non-muscle +FIG01858991 FIG00344414: hypothetical protein +FIG01859009 putative mercury resistance protein +FIG01859027 TOBE domain protein +FIG01859048 COG1288: Predicted membrane protein +FIG01859100 FIG01133278: hypothetical protein +FIG01859115 FIG00839181: hypothetical protein +FIG01859164 putative cell division protein +FIG01859200 RepFIB associated resolvase +FIG01859241 cell wall associated biofilm protein +FIG01859349 putative sugar ABC transporter, substrate binding protein +FIG01859353 hypothetical protein +FIG01859422 FIG00766959: hypothetical protein +FIG01859424 Transcriptional antiterminator bglG:Phosphoenolpyruvate-dependent sugar phosphotransferase system, EIIA 2 +FIG01859471 Phage related lysozyme +FIG01859502 FIG00840365: hypothetical protein +FIG01859564 Propionate kinase (EC 2.7.2.15) / Acetate kinase (EC 2.7.2.1) +FIG01859569 FIG00351504: hypothetical protein +FIG01859601 ribosomal protein L30 +FIG01859685 Autolytic lysozyme (EC 3.2.1.17) +FIG01859693 cellulose-binding, family II +FIG01859710 Putative undecaprenyl-phosphate N-acetylgalactosaminyl 1-phosphate transferase; Teichuronic acid biosynthesis glycosyltransferase TuaA +FIG01859739 molybdenum cofactor biosynthesis protein D/E +FIG01859748 FIG00344236: hypothetical protein +FIG01860017 FIG00767647: hypothetical protein +FIG01860025 conserved hypothetical lipoprotein transmembrane +FIG01860062 hypothetical protein +FIG01860180 Signaling protein without kinase domain +FIG01860199 resolvase, N terminal domain family +FIG01860256 FIG00424457: hypothetical protein +FIG01860261 UPF0147 protein MM_1385 +FIG01860268 putative regulator PapX protein +FIG01860294 COG1399 protein in cluster with ribosomal protein L32p, Bacteroidetes/Chlorobi subfamily +FIG01860326 Putative uncharacterized protein orf28 +FIG01860343 possible phage integrase family protein +FIG01860375 Putative carbohydrate kinase +FIG01860394 ATPase, E1-E2 type( EC:3.6.3.8 ) +FIG01860403 FIG00639211: hypothetical protein +FIG01860430 FIG00352522: hypothetical protein +FIG01860499 predicted hydrolase +FIG01860514 putative prophage Hp1 family holin +FIG01860520 Multidrug-efflux transporter transcription regulator, BltR +FIG01860527 amino acid MFS transporter +FIG01860683 sodium/calcium exchanger membrane region +FIG01860687 FIG00452112: hypothetical protein +FIG01860736 Uncharacterized protein TP_0572 +FIG01860764 Penicillin-resistant DD-carboxypeptidase +FIG01860779 M. jannaschii predicted coding region MJ1370 +FIG01860796 Unknown, probable transcription regulator +FIG01860806 FIG01114680: hypothetical protein +FIG01860813 lipopolysaccharide kinase +FIG01860853 transcription factor WhiB +FIG01860883 FIG00629190: hypothetical protein +FIG01860906 Oligoendopeptidase F (EC 3.4.24.-) +FIG01860915 restriction endonuclease RKpn2kI +FIG01860979 probable polyketide synthase protein +FIG01860993 putative formyltransferase +FIG01861061 Tsr0149 protein +FIG01861160 YchA +FIG01861166 Ethylbenzene dehydrogenase gamma subunit (EC 1.17.99.2) +FIG01861167 trimethylamine-N-oxide reductase (cytochrome c)( EC:1.7.2.3 ) +FIG01861179 FIG00935183: hypothetical protein +FIG01861183 probable ADP-ribosylglycohydrolase +FIG01861268 outer membrane protein Omp31 +FIG01861276 Transcriptional regulator, MarR family +FIG01861285 putative phage-related tail protein +FIG01861367 FIG00667342: hypothetical protein +FIG01861417 FIG00642780: hypothetical protein +FIG01861447 FIG00379972: hypothetical protein +FIG01861456 phosphomannomutase +FIG01861478 methyltransferase GidB +FIG01861591 hypothetical protein +FIG01861617 putative immunity repressor protein +FIG01861675 FIG00644251: hypothetical protein +FIG01861698 Chemotaxis protein histidine kinase and related kinase +FIG01861724 FIG00427598: hypothetical protein +FIG01861737 blr2321; hypothetical protein +FIG01861775 Uncharacterized conserved protein, repeats +FIG01861810 Putative fimbrial usher protein +FIG01861862 FIG01032378: hypothetical protein +FIG01861872 FIG00409040: hypothetical protein +FIG01861896 Haloacid dehalogenase-like hydrolase, type 3 +FIG01862007 FIG00547901: hypothetical protein +FIG01862034 putative orphan protein; putative secreted protein +FIG01862198 Overcoming lysogenization defect protein +FIG01862227 integrase homolog, putative +FIG01862237 hemolytic protein HlpA-like +FIG01862268 Mlr2965 protein +FIG01862325 147aa long hypothetical protein +FIG01862358 LysR family transcriptional regulatory protein +FIG01862396 Putative transcriptional regulator (MarR family) (partial) +FIG01862417 probable myo-inositol-2-dehydrogenase +FIG01862422 Phosphomethylpyrimidine kinase (EC 2.7.4.7) +FIG01862453 arylsulfatase regulatory protein, putative +FIG01862494 Putative Lipoprotein +FIG01862568 FIG00524450: hypothetical protein +FIG01862571 Oligopeptide transporter OPT superfamily:Oligopeptide transporter OPT +FIG01862606 FIG00558870: hypothetical protein +FIG01862636 protein of unknown function DUF1535 +FIG01862676 hypothetical protein +FIG01862678 putative bacteroiocin operon protein ScnG homolog +FIG01862731 outer membrane protein OprF +FIG01862755 Oxidoreductase FAD/NAD(P)-binding +FIG01862758 Putative citrate permease +FIG01862872 mannosyltransferase B +FIG01862906 D-cysteine desulfhydrase (EC 4.4.1.15) +FIG01862911 FIG00671952: hypothetical protein +FIG01862939 translation initiation factor IF-3 +FIG01862964 FIG00524764: hypothetical protein +FIG01862966 FIG00438289: hypothetical protein +FIG01862975 abortive infection protein, internal deletion +FIG01863010 Glutamine amidotransferase +FIG01863057 FIG00411283: hypothetical protein +FIG01863080 FIG00356374: hypothetical protein +FIG01863162 FIG00348438: hypothetical protein +FIG01863168 Membrane protein of uknown function UCP014873 +FIG01863226 COG3757: Lyzozyme M1 (1,4-beta-N-acetylmuramidase) +FIG01863263 FIG00344171: hypothetical protein +FIG01863314 possible transcription factor WhiB +FIG01863400 Putative enzyme +FIG01863409 putative type I specificity subunit HsdS +FIG01863421 probable 2-phosphosulfolactate phosphatase +FIG01863425 Prophage integrase +FIG01863492 predicted lipoprotein YdgR +FIG01863572 UPF0033 protein YedF +FIG01863602 FIG00356608: hypothetical protein +FIG01863623 Uncharacterized protein aq_2063 +FIG01863672 leucine-rich repeat containing protein +FIG01863728 FIG00418203: hypothetical protein +FIG01863786 hypothetical protein +FIG01863798 Ppp +FIG01863861 Sensor protein atoS (EC 2.7.3.-) +FIG01863931 conjugative relaxase domain protein +FIG01863993 FIG00388862: hypothetical protein +FIG01864191 Uncharacterized chromosomal cassette SCCmec type IVc protein CR006 +FIG01864244 FIG00733175: hypothetical protein +FIG01864255 POSSIBLE TRANSPOSASE +FIG01864422 putative phage DNA adenine methylase +FIG01864432 molybdopterin binding domain +FIG01864584 FIG00534733: hypothetical protein +FIG01864606 Related to CAAX prenyl protease +FIG01864615 hypothetical protein +FIG01864621 Tyrosine protein kinase:Aminoglycoside phosphotransferase +FIG01864637 cinnamoyl ester hydrolase +FIG01864756 phosphosugar isomerase +FIG01864812 Nodulation protein D I +FIG01864834 COG2608: Copper chaperone +FIG01864927 molybdenum-pterin binding domain +FIG01864967 Uncharacterized protein MJ1333 +FIG01865025 ABC transport protein, periplasmic component +FIG01865028 similar to serine protease +FIG01865046 conserved hypothetical protein-putative acetyltransferase( EC:2.3.1.- ) +FIG01865071 dihydroneopterin aldolase +FIG01865131 FIG00765474: hypothetical protein +FIG01865235 Cadherin domain protein +FIG01865251 cytochrome P450 family protein +FIG01865259 FIG00519263: hypothetical protein +FIG01865264 oligopeptide ABC transporter ATP-binding +FIG01865282 Phage-related terminase +FIG01865316 Amino-terminal intein-mediated trans-splice / DNA helicase, SNF2/RAD54 family +FIG01865336 Lipopolysaccharide biosynthesis protein-like +FIG01865405 ORF_ID:tlr1129 hypothetical protein +FIG01865598 FIG00537088: hypothetical protein +FIG01865610 Type II restriction enzyme Eco47I (EC 3.1.21.4) (Endonuclease Eco47I) (R.Eco47I) +FIG01865649 spore peptidoglycan hydrolase +FIG01865690 FIG00976577: hypothetical protein +FIG01865751 ABC-type uncharacterized transport system periplasmic component-like +FIG01865813 aryl-alcohol dehydrogenase +FIG01865873 Na+/H+ antiporter napA +FIG01865884 PROBABLE SHORT-CHAIN TYPE DEHYDROGENASE/REDUCTASE +FIG01865918 photosystem I assembly BtpA +FIG01866052 FIG00624256: hypothetical protein +FIG01866064 FIG00749603: hypothetical protein +FIG01866073 amidinotransferase( EC:2.1.4.2 ) +FIG01866111 Glycine rich protein +FIG01866189 FIG00831100: hypothetical protein +FIG01866230 FIG00848955: hypothetical protein +FIG01866296 related to protein-tyrosine phosphatase +FIG01866332 FIG00713467: hypothetical protein +FIG01866424 HSPC229 +FIG01866428 FIG00756995: hypothetical protein +FIG01866434 FIG00849148: hypothetical protein +FIG01866500 FIG00513996: hypothetical protein +FIG01866509 general secretion pathway protein A +FIG01866520 FIG01244194: hypothetical protein +FIG01866558 bacterial flagellin N-terminal domain protein +FIG01866579 IS1191, transposase, IS256 family +FIG01866599 ABC transporter (MsbA subfamily) +FIG01866602 Uncharacterized conserved protein, YVBJ B.subtilis ortholog with N-terminal C4-type Zn-finger domain +FIG01866636 FIG01004720: hypothetical protein +FIG01866660 ISPg7, transposase +FIG01866757 secreted metal-binding protein +FIG01866769 Mucin 2 precursor +FIG01866770 Beta-agarase precursor (EC 3.2.1.81) +FIG01866857 Chain A, Alpha-Lytic Protease (E.C.3.4.21.12) (Mutant With Met 192 Replaced By Ala) (M192A) Complex With Methoxysuccinyl-Ala-Ala-Pro-Valine Boronic Acid +FIG01866897 Uncharacterized protein y4hR +FIG01866924 FIG00385511: hypothetical protein +FIG01866987 conserved hypothetical protein-putative methyltransferase +FIG01867055 protein of unknown function DUF418 +FIG01867070 protein of unknown function DUF1491 +FIG01867089 putative DNA-binding regulatory protein +FIG01867116 Kanamycin kinase (Aminoglycoside phosphotransferase, gentamicin resistance protein) (EC 2.7.1.95) +FIG01867133 Amidohydrolase-like +FIG01867147 Biotin-protein ligase (EC 6.3.4.15) +FIG01867196 FIG00410329: hypothetical protein +FIG01867197 FIG00630123: hypothetical protein +FIG01867218 Transcriptional regulator, AcrR-family +FIG01867300 PUTATIVE GLYCOSYLTRANSFERASE PROTEIN +FIG01867313 Cytochrome b562 (Cytochrome b-562) +FIG01867328 FIG00516129: hypothetical protein +FIG01867346 FIG01245164: hypothetical protein +FIG01867351 FIG00412685: hypothetical protein +FIG01867352 FIG00344765: hypothetical protein +FIG01867384 FIG00349535: hypothetical protein +FIG01867483 putative CheA signal transduction histidine kinase +FIG01867492 FIG01093035: hypothetical protein +FIG01867545 FIG00414267: hypothetical protein +FIG01867580 dehydrogenase, FAD/FMN-containing +FIG01867642 Uncharacterized adenine-specific methylase (EC 2.1.1.72) (ORF13) +FIG01867646 conserved hypothetical protein containing Alkylhydroperoxidase AhpD core domain YdfG +FIG01867668 putative bacteriophage tail fiber protein +FIG01867681 FIG00532711: hypothetical protein +FIG01867737 Putative membrane protein mmpL4 +FIG01867827 FIG00344558: hypothetical protein +FIG01867945 Diguanylate cyclase (GGDEF domain) +FIG01867986 autoinducer synthesis protein +FIG01868049 malate-2H+/lactate-NA+ antiporter +FIG01868052 predicted transporter +FIG01868106 FIG00529375: hypothetical protein +FIG01868127 outer membrane protein-like +FIG01868173 glycoside hydrolase, family 37 +FIG01868193 possible cytochrome P450 family proteins +FIG01868214 photoactive yellow protein +FIG01868242 FIG00873422: hypothetical protein +FIG01868426 ABC transporter, periplasmic iron-transport lipoprotein +FIG01868608 acetyl esterase (acetylxylosidase) +FIG01868627 transposase, IS605 family, OrfB +FIG01868659 DJ-1/PfpI family protein +FIG01868666 Aminoglycoside N3-acetyltransferase +FIG01868668 ABC transporter related +FIG01868697 Molybdenum cofactor biosynthesis protein +FIG01868713 FIG00919893: hypothetical protein +FIG01868751 ERF family protein +FIG01868901 FIG00532329: hypothetical protein +FIG01868939 Modification methylase FnuDI (EC 2.1.1.37) +FIG01868989 FIG00415981: hypothetical protein +FIG01869004 probable membrane protein STY4870 +FIG01869034 FIG00702108: hypothetical protein +FIG01869046 L-serine dehydratase, beta subunit (EC 4.3.1.17) / L-serine dehydratase, alpha subunit (EC 4.3.1.17) +FIG01869078 FIG00840696: hypothetical protein +FIG01869104 hypothetical protein +FIG01869110 surface antigen, Wsp paralog +FIG01869113 adhesin-like protein +FIG01869134 FIG00849365: hypothetical protein +FIG01869192 Vng1440h +FIG01869245 DNA adenine methyltransferase +FIG01869319 msp2 operon associated gene 1 +FIG01869350 fatty acid alpha hydroxylase, cytochrome P450 +FIG01869374 FIG00344301: hypothetical protein +FIG01869394 phosphoesterase, RecJ-like +FIG01869398 FIG00390026: hypothetical protein +FIG01869458 FIG00756285: hypothetical protein +FIG01869702 Sensory transduction histidine kinase (with HAMP domain) +FIG01869780 Type I restriction-modification system specificity subunit +FIG01869820 hypothetical protein +FIG01869888 FIG00633166: hypothetical protein +FIG01869969 biotin carboxyl carrier protein +FIG01869983 FIG01183875: hypothetical protein +FIG01869990 cell well associated RhsD protein precursor +FIG01869999 endonuclease I +FIG01870010 Vanadium chloroperoxidase (EC 1.11.1.10) +FIG01870015 FIG01128007: hypothetical protein +FIG01870034 FIG01133100: hypothetical protein +FIG01870092 glucokinase regulatory protein +FIG01870197 peptidase dimerisation domain protein +FIG01870218 Protein related to deoxyribodipyrimidine photolyase +FIG01870246 FIG00743562: hypothetical protein +FIG01870319 Uncharacterized protein HI1680 +FIG01870338 Hypothetical protein, CF-23 family +FIG01870345 FepC protein +FIG01870391 UPF0324 membrane protein RB9488 +FIG01870435 FIG00518126: hypothetical protein +FIG01870505 Transposase IS116/IS110/IS902 +FIG01870556 fructose-bisphosphate aldolase +FIG01870631 internalin-like protein (LPXTG motif) +FIG01870684 COG2814: Arabinose efflux permease +FIG01870685 FIG00528158: hypothetical protein +FIG01870714 antibiotic efflux protein +FIG01870734 FIG00387845: hypothetical protein +FIG01870739 Isoleucyl-tRNA synthetase +FIG01870784 hypothetical protein( EC:3.4.24.35 ) +FIG01870811 FIG00538352: hypothetical protein +FIG01870868 photosystem II reaction center protein PsbX +FIG01870927 hypothetical protein +FIG01870974 Phosphoglucomutase +FIG01871049 Extracellular small neutral protease (EC 3.4.24.77) (Snapalysin) (SCNP) +FIG01871128 FIG001196: putative membrane protein +FIG01871162 Mn2+-dependent serine/threonine protein kinase +FIG01871163 outer membrane secretion protein +FIG01871166 Unknown, probable permease +FIG01871228 FIG00841180: hypothetical protein +FIG01871257 FIG01245428: hypothetical protein +FIG01871262 FIG01165928: hypothetical protein +FIG01871267 Heparinase II protein precursor +FIG01871278 membrane protein SC1C221c +FIG01871288 Helix-turn-helix, type 11 domain protein +FIG01871305 Late embryogenesis abundant protein 2 +FIG01871316 Aminoglycoside N(3')-acetyltransferase III (EC 2.3.1.81) +FIG01871323 Putative serine-threonine protein kinase( EC:2.7.1.- ) +FIG01871589 Uncharacterized protein yhcE +FIG01871598 FIG00356595: hypothetical protein +FIG01871625 possible EA31 gene protein, phage lambda +FIG01871653 Myeloid/lymphoid or mixed-lineage leukemia protein 3 homolog (Histone- lysine N-methyltransferase, H3 lysine-4 specific MLL3) (EC 2.1.1.43) +FIG01871761 Eha protein +FIG01871838 FIG00745358: hypothetical protein +FIG01871901 PUTATIVE AMINOMETHYLTRANSFERASE PROTEIN +FIG01871918 FIG00524145: hypothetical protein +FIG01871924 FIG00841687: hypothetical protein +FIG01872045 FIG01129320: hypothetical protein +FIG01872075 FIG00349726: hypothetical protein +FIG01872172 FIG00521097: hypothetical protein +FIG01872208 FIG00712158: hypothetical protein +FIG01872252 probable molybdopterin-synthase sulfurylase +FIG01872285 FIG00632162: hypothetical protein +FIG01872310 oligopeptide binding protein of oligopeptide ABC transporter +FIG01872383 Ethidium bromide-methyl viologen resistance protein EmrE +FIG01872447 FIG00831074: hypothetical protein +FIG01872460 conserved hypothetical protein-putative ATP-binding protein +FIG01872613 FIG01237099: hypothetical protein +FIG01872740 Putative phophoslipid binding protein +FIG01872768 ORF_ID:alr7643 unknown protein +FIG01872813 Peptidoglycan interpeptide bridge formation enzyme +FIG01872820 protein of unknown function DUF808 +FIG01872842 FIG00839635: hypothetical protein +FIG01872899 Putative Ser protein kinase +FIG01872938 COG2963: Transposase and inactivated derivatives +FIG01872951 manganese containing catalase +FIG01872996 predicted branched-chain amino acid permease +FIG01873008 HipA domain protein +FIG01873033 FIG00998705: hypothetical protein +FIG01873035 probable fusion protein +FIG01873060 FIG00693681: hypothetical protein +FIG01873131 drug transporters; resistance proteins +FIG01873139 coenzyme A transferase +FIG01873170 Benzoylsuccinyl-CoA thiolase beta subunit (EC:2.3.1.-) +FIG01873229 Uncharacterized 29.3 kDa protein (ORF92) +FIG01873233 Trehalose-6-phosphate hydrolase +FIG01873244 FIG00624189: hypothetical protein +FIG01873245 Biotin synthase and related enzymes +FIG01873270 ABC transporter, permease protein UspE +FIG01873279 FIG00939570: hypothetical protein +FIG01873285 FIG00348966: hypothetical protein +FIG01873290 triterpenes biosynthesis +FIG01873331 FIG01083306: hypothetical protein +FIG01873353 MutS domain-containing protein 2 +FIG01873448 exopolysaccharide polymerization protein +FIG01873489 PROBABLE TPR DOMAIN PROTEIN +FIG01873495 Bll1010 protein +FIG01873650 amidinotransferase family protein +FIG01873684 FIG00632891: hypothetical protein +FIG01873695 FIG00715649: hypothetical protein +FIG01873711 alpha-galactosidase precursor +FIG01873744 putative response regulator VieB +FIG01873774 hypothetical protein +FIG01873779 FIG00387864: hypothetical protein +FIG01873832 FIG00623916: hypothetical protein +FIG01873876 FIG00906949: hypothetical protein +FIG01873913 lactonizing lipase precursor +FIG01873933 COG0591: Na+/proline symporter +FIG01873985 FIG00994218: hypothetical protein +FIG01873989 ISSoc12, transposase +FIG01874051 Conserved putative membrane protein +FIG01874099 Succinate dehydrogenase subunit D +FIG01874103 FIG01066517: hypothetical protein +FIG01874123 EpsR +FIG01874146 crcB protein +FIG01874173 FIG00446532: hypothetical protein +FIG01874203 Transcription factor homologous to NACalpha-BTF3 +FIG01874305 Fibronectin-binding A domain protein +FIG01874323 putative sensory transduction histidine kinase of highly complex domain structure( EC:2.7.3.- ) +FIG01874401 Orf31 +FIG01874444 Arginine repressor ArgR, putative +FIG01874450 putative N-acetyltransferase +FIG01874562 FIG00347793: hypothetical protein +FIG01874564 non-hemolytic phospholipase C precursor( EC:3.1.4.3 ) +FIG01874596 Bkd operon transcriptional regulator +FIG01874617 Magnesium-chelatase, BchO +FIG01874669 FIG00933777: hypothetical protein +FIG01874724 Pirin domain protein domain protein +FIG01874726 MltA-interacting MipA precursor +FIG01874731 FIG00388048: hypothetical protein +FIG01874749 Branched-chain amino acid transport protein AzlC +FIG01874764 FIG00388454: hypothetical protein +FIG01874768 Putative carboxylesterase( EC:3.1.1.- ) +FIG01874774 FIG00848245: hypothetical protein +FIG01874782 Metallo-beta-lactamase-related protein +FIG01874867 phage repressor protein +FIG01874894 Riboflavin-specific deaminase +FIG01874943 FIG00976422: hypothetical protein +FIG01874970 drug transporters; ABC transporters +FIG01874982 FIG01120087: hypothetical protein +FIG01875001 FIG00356671: hypothetical protein +FIG01875032 FIG01047674: hypothetical protein +FIG01875120 Kinesin-related protein +FIG01875144 FIG00362285: hypothetical protein +FIG01875156 Thermostable hemolysin +FIG01875172 FIG01226034: hypothetical protein +FIG01875205 Nitrogenase( EC:1.18.6.1 ) +FIG01875213 Putative Zn-dependent protease PA5047 +FIG01875304 FIG00514686: hypothetical protein +FIG01875401 hypotetical protein +FIG01875412 Tsr1701 protein +FIG01875422 YesL +FIG01875455 FIG00530445: hypothetical protein +FIG01875498 COG0534: Na+-driven multidrug efflux pump +FIG01875537 COG3212: Predicted membrane protein +FIG01875566 alpha-L-glutamate ligases, RimK family +FIG01875595 thioredoxin peroxidase +FIG01875604 general secretion pathway protein K +FIG01875629 putative DEAH-family helicase +FIG01875637 PIN domain family protein +FIG01875646 FIG00348996: hypothetical protein +FIG01875647 Glycosyl transferase family 11 +FIG01875713 FIG00847494: hypothetical protein +FIG01875726 hypothetical protein +FIG01875767 hypothetical protein +FIG01875793 Dynamin family protein +FIG01875844 FIG00772682: hypothetical protein +FIG01875863 N-glycosylase/DNA lyase +FIG01875970 FIG00410926: hypothetical protein +FIG01875978 FIG00390389: hypothetical protein +FIG01875983 D-alanyl-D-alanine carboxypeptidase family +FIG01876120 DNA polymerase III subunit alpha +FIG01876142 Putative regulator (partial) +FIG01876171 omega-3 fatty acid desaturase +FIG01876179 COG3712: Fe2+-dicitrate sensor, membrane component +FIG01876249 FIG00642995: hypothetical protein +FIG01876261 FIG00414488: hypothetical protein +FIG01876295 Putative fimbrial biogenesis protein precursor +FIG01876382 cyclic peptide transporter +FIG01876400 related to integrase/recombinase +FIG01876455 FIG00633213: hypothetical protein +FIG01876469 alcohol dehydrogenase, zinc-binding +FIG01876477 FIG00847329: hypothetical protein +FIG01876508 transcriptional regulator, truncated +FIG01876546 FIG01134201: hypothetical protein +FIG01876552 FIG00839430: hypothetical protein +FIG01876572 serine/threonine protein kinase, putative +FIG01876577 FIG00361581: hypothetical protein +FIG01876597 FIG00390315: hypothetical protein +FIG01876649 LmbE-like protein / Methyltransferase type 12 +FIG01876679 Stress responsive alpha-beta barrel +FIG01876834 Fimbrial chaperone protein +FIG01876865 transcriptional regulator, BlaI family, putative +FIG01876928 FIG00346606: hypothetical protein +FIG01877065 hypothetical protein +FIG01877115 YdjC-like protein +FIG01877121 FIG00840577: hypothetical protein +FIG01877147 FIG01178637: hypothetical protein +FIG01877207 resolvase family protein +FIG01877294 LacI-family protein transcriptional regulator +FIG01877309 FIG00633609: hypothetical protein +FIG01877397 FIG00355814: hypothetical protein +FIG01877414 PROBABLE DEHYDROGENASE (EC 1.-.-.-) +FIG01877458 Arylsulfatase regulator (Fe-S oxidoreductase)-like protein +FIG01877466 iso-IS1 ORF2 +FIG01877519 FIG00909490: hypothetical protein +FIG01877541 Predicted b-glucoside transporter, GPH family +FIG01877607 Transposase, ISlxx5 +FIG01877640 weak: predicted nucleotidyltransferase +FIG01877713 HYBRID SENSORY HISTIDINE KINASE +FIG01877757 zinc resistance-associated protein +FIG01877771 protein of unknown function UPF0044 +FIG01877843 putative scaffolding protein +FIG01877856 FIG00756149: hypothetical protein +FIG01877872 ABC Fe(3+) transporter, permease component +FIG01877880 FIG00733238: hypothetical protein +FIG01877922 transposase TnpA +FIG01877958 FIG01122187: hypothetical protein +FIG01877959 Cytochrome P450-cam (EC 1.14.15.1) +FIG01877964 FIG00355988: hypothetical protein +FIG01878212 phage shock protein E +FIG01878231 FIG00768982: hypothetical protein +FIG01878244 WD40-repeat containing protein +FIG01878276 FIG00519063: hypothetical protein +FIG01878282 ABC transporter, ATP-binding protein, EF-3 family +FIG01878318 FIG00522731: hypothetical protein +FIG01878331 FIG00766477: hypothetical protein +FIG01878402 Calerythrin (Calcium-binding protein) +FIG01878428 Glycoside hydrolase, family 5 +FIG01878429 FIG00558377: hypothetical protein +FIG01878434 prophage MuMc02, tail fiber domain protein +FIG01878497 conserved hypothetical exported protein, glycine-rich +FIG01878609 adhesin P1 (group2) homolog +FIG01878774 FIG00724435: hypothetical protein +FIG01878796 FIG00427086: hypothetical protein +FIG01878843 FIG00768490: hypothetical protein +FIG01878848 peptidylprolyl isomerase( EC:5.2.1.8 ) +FIG01878892 FIG00755403: hypothetical protein +FIG01878932 SanC +FIG01878985 FIG01092575: hypothetical protein +FIG01878994 putative traG-family protein +FIG01879092 MATE efflux family protein +FIG01879115 FIG00388761: hypothetical protein +FIG01879205 Endoglucanase M (EC 3.2.1.4) (EGM) (Endo-1,4-beta-glucanase) (Cellulase M) +FIG01879224 metallo-beta-lactamase superfamily exported protein +FIG01879240 ORF_ID:tll1419 hypothetical protein +FIG01879254 Phosphoenolpyruvate synthase/pyruvate phosphate dikinase +FIG01879279 hypothetical sur1-like protein +FIG01879325 probable intracellular proteinase I +FIG01879371 HpaF protein +FIG01879383 transcriptional regulator, XRE family protein +FIG01879404 hypothetical protein +FIG01879420 Transposase IS66 +FIG01879476 FIG00424547: hypothetical protein +FIG01879477 peptidase U7 family [EC:3.4.-.-] +FIG01879479 putative alpha-ribazole-5'-P phosphatase +FIG01879496 FIG00344790: hypothetical protein +FIG01879521 Conserved hypothetical protein 22 +FIG01879600 Fip +FIG01879605 hypothetical protein +FIG01879655 thiosulfate sulfurtransferase +FIG01879732 putative P4-type integrase +FIG01879808 Pectate lyase, secreted, polysaccharide lyase family +FIG01879849 carbohydrate kinase, FGGY family protein +FIG01879858 putative cytochrome c class I protein +FIG01879931 Sulfotransferase:SEC-C motif +FIG01879964 FIG00764640: hypothetical protein +FIG01880029 Phage integrase +FIG01880076 FIG01128861: hypothetical protein +FIG01880114 FIG00674542: hypothetical protein +FIG01880156 Nonmuscle myosin heavy chain b +FIG01880227 ankyrin +FIG01880289 syc0948_d +FIG01880310 sugar transport protein related protein +FIG01880384 amino acid ABC transporter, ATP-binding/permease protein +FIG01880468 FIG00348673: hypothetical protein +FIG01880477 attH protein +FIG01880550 HemN domain protein +FIG01880634 Transposase and inactivated derivatives-like protein +FIG01880686 hypothetical protein +FIG01880692 trimethylamine methyltransferase family protein +FIG01880754 FIG00533261: hypothetical protein +FIG01880810 FIG01133397: hypothetical protein +FIG01880858 FIG00733428: hypothetical protein +FIG01880901 pectin degradation protein +FIG01880917 sensory transduction regulatory protein +FIG01880997 Uncharacterized protein TP_0818 +FIG01880998 hypothetical 8.2 KDA protein +FIG01881098 FIG00637878: hypothetical protein +FIG01881108 nitrogen regulation protein NtrB( EC:2.7.3.- ) +FIG01881139 signal-peptide-less P35 lipoprotein homolog +FIG01881199 Type IV fimbrial biogenesis protein PilY1 +FIG01881313 FIG00567497: hypothetical protein +FIG01881339 FIG00921206: hypothetical protein +FIG01881418 FIG00388665: hypothetical protein +FIG01881511 possible DNA integrase/recombinase +FIG01881552 FIG01250456: hypothetical protein +FIG01881556 Zn-dependent hydrolase lipoprotein +FIG01881632 Bacterial SH3 domain homologue +FIG01881652 FIG00876127: hypothetical protein +FIG01881681 FIG00689657: hypothetical protein +FIG01881706 type III restriction protein res subunit +FIG01881717 FIG01294845: hypothetical protein +FIG01881785 hypothetical protein +FIG01881807 tyrosine kinase( EC:2.7.1.112 ) +FIG01881811 carveol dehydrogenase( EC:1.1.1.243 ) +FIG01881917 Acyl-ACP thioesterase superfamily +FIG01881936 FIG01133334: hypothetical protein +FIG01881939 Sll0822 protein +FIG01881944 NICKEL RESISTANCE PROTEIN NREB +FIG01881948 FIG00415261: hypothetical protein +FIG01881969 possible ATP-dependent helicase +FIG01882012 FIG00609243: hypothetical protein +FIG01882013 uncharacterized protein, containing periplasmic binding domain +FIG01882041 Flavin reductase-like, FMN-binding:Rubredoxin-type Fe(Cys)4 protein +FIG01882093 FlaG +FIG01882098 phage tail assembly-like protein +FIG01882166 FIG01252991: hypothetical protein +FIG01882177 polysaccharides degradation +FIG01882233 transposase (12) BH3705 +FIG01882285 conserved hypothetical protein, putative hydrolase +FIG01882354 FIG00912941: hypothetical protein +FIG01882359 FIG00387911: hypothetical protein +FIG01882371 sensor histidine kinase FrgB +FIG01882404 FIG00344298: hypothetical protein +FIG01882486 FIG00528333: hypothetical protein +FIG01882534 putative regulator of Sig15 +FIG01882585 TrkA-N:TrkA-C:Sodium/hydrogen exchanger +FIG01882591 peptidase M24 +FIG01882593 holinlike protein +FIG01882656 exopolysaccharide biosynthesis +FIG01882730 FIG00669879: hypothetical protein +FIG01882753 Integral membrane protein, interacts with FtsH +FIG01882771 YjbQ (alternate ThiE) +FIG01882828 FIG01070849: hypothetical protein +FIG01882930 sulfatase( EC:3.1.6.- ) +FIG01882959 ribonuclease E +FIG01882971 YwnG +FIG01883049 Acyl carrier protein, ACP +FIG01883090 primosomal protein N' +FIG01883101 peptidase, M16 family( EC:3.4.24.64 ) +FIG01883121 FIG00939851: hypothetical protein +FIG01883142 FIG00356140: hypothetical protein +FIG01883176 Orf7 +FIG01883195 FIG00624222: hypothetical protein +FIG01883321 hypothetical protein +FIG01883404 putative amino acid-binding protein +FIG01883413 antiphagocytic M-like protein +FIG01883414 L-amino-acid oxidase( EC:1.4.3.2 ) +FIG01883440 protein of unknown function YGGT +FIG01883455 FIG00638471: hypothetical protein +FIG01883459 Cold shock protein CspD +FIG01883468 putative bifunctionnal protein : Glutamate-1-semialdehyde 2,1-aminomutase, 3-deoxy-manno-octulosonate cytidylyltransferase( EC:2.7.7.38,EC:5.4.3.8 ) +FIG01883510 FIG00633853: hypothetical protein +FIG01883523 hypothetical protein +FIG01883550 protein-export membrane protein +FIG01883622 FIG01207175: hypothetical protein +FIG01883636 ORF_ID:tll0170 hypothetical protein +FIG01883669 conserved hypothetical 1 TMS, 30-80aa Actinobacteria protein +FIG01883731 Calcium-binding EF-hand +FIG01883732 conserved hypothetical protein +FIG01883784 possible monooxygenase +FIG01883886 FIG00516350: hypothetical protein +FIG01883902 FIG00687455: hypothetical protein +FIG01883934 iron-siderophore permease transmembrane protein +FIG01884079 FIG00417123: hypothetical protein +FIG01884100 FIG00412663: hypothetical protein +FIG01884120 putative lipoprotein MlpB +FIG01884239 FIG01032357: hypothetical protein +FIG01884302 Phosphoheptose isomerase +FIG01884330 putative amine oxidase +FIG01884353 FIG00344724: hypothetical protein +FIG01884479 ISSoc1, transposase +FIG01884493 hypothetical +FIG01884706 Acyl-CoA thioesterase I (EC 3.1.2.-) +FIG01884851 peptidase M42 family protein +FIG01884869 Sulfite reductase-related protein +FIG01884908 FIG00344168: hypothetical protein +FIG01884923 FIG00516503: hypothetical protein +FIG01884949 FIG00344738: hypothetical protein +FIG01884977 FIG00669717: hypothetical protein +FIG01885010 Post-segregation antitoxin CcdA +FIG01885046 Pneumococcal surface protein +FIG01885311 YkkB +FIG01885314 Staphylococcal nuclease homologue +FIG01885326 stage III sporulation protein AH +FIG01885339 FIG01005752: hypothetical protein +FIG01885340 6-aminohexanoate-dimer hydrolase( EC:3.5.1.46 ) +FIG01885357 ABC1 family protein +FIG01885527 HrpA-like helicase, ATP-dependent +FIG01885528 Mucin-like protein 1 precursor +FIG01885558 DUF192 domain-containing protein +FIG01885606 putative transcriptional regulator, LuxR family +FIG01885623 FIG00643453: hypothetical protein +FIG01885647 hypothetical protein +FIG01885670 cro/CI family transcriptional regulator +FIG01885679 hydrolase, nudix family protein +FIG01885703 Virulence-associated E +FIG01885768 COG0431: Predicted flavoprotein +FIG01885776 putative transcripton factor for heterocyst differentiation DevT +FIG01885836 FIG00896277: hypothetical protein +FIG01885876 secretory serine protease +FIG01885927 FIG00712764: hypothetical protein +FIG01886043 FIG00674236: hypothetical protein +FIG01886065 Uncharacterized protein MJ0095 +FIG01886109 Transposase for transposon Tn4556 +FIG01886113 Possible fimbrial assembly protein fimC, putative +FIG01886129 photosystem II protein PsbY +FIG01886134 SMP-30/Gluconolaconase/LRE domain protein +FIG01886174 Glutathione peroxidase( EC:1.11.1.9 ) +FIG01886180 putative transposase, ISSmu1 +FIG01886215 FIG01199237: hypothetical protein +FIG01886229 FIG00756185: hypothetical protein +FIG01886324 putative holin protein +FIG01886336 FIG00362025: hypothetical protein +FIG01886475 FIG00733688: hypothetical protein +FIG01886542 FIG00363387: hypothetical protein +FIG01886545 Diaminobutyrate-pyruvate transaminase & L-2,4-diaminobutyrate decarboxylase +FIG01886556 High light inducible protein +FIG01886557 periplasmic sensor hybrid histidine kinase +FIG01886569 H+-transporting two-sector ATPase, B/B' subunit +FIG01886626 UPF0331 protein MJ0125 +FIG01886693 FIG00344468: hypothetical protein +FIG01886727 putative PROCESSING PROTEASE +FIG01886875 Uncharacterized protein TP_0172 +FIG01886897 amidohydrolase-like +FIG01886927 Transcriptional regulator, TetR family +FIG01886954 FIG01107966: hypothetical protein +FIG01886974 Putative amino-acid ABC transporter permease protein yhdX +FIG01886996 COG0092: Ribosomal protein S3 +FIG01887154 conserved protein, putative NADH:ubiquinone oxidoreductase +FIG01887167 FIG01128206: hypothetical protein +FIG01887210 hypothetical protein +FIG01887259 putative sugar-binding transport ATP-binding protein( EC:3.6.3.30 ) +FIG01887438 FIG00349607: hypothetical protein +FIG01887452 FIG00404782: hypothetical protein +FIG01887459 FIG00356548: hypothetical protein +FIG01887481 Conserved ankyrin repeat protein, putative +FIG01887504 possible ATP-binding protein +FIG01887507 protein of unknown function DUF339 +FIG01887580 S-layer protein (SLH domain) precursor +FIG01887583 putative CoA-substrate-specific enzyme activase +FIG01887652 nucleoside-diphosphate-sugar epimerase +FIG01887670 FIG01017367: hypothetical protein +FIG01887682 putative sodium/proton antiporter +FIG01887708 hypothetical protein +FIG01887711 FIG00773447: hypothetical protein +FIG01887747 2,3-dehydratase +FIG01887874 putative permease domain protein +FIG01887939 FIG00470044: hypothetical protein +FIG01887961 hypothetical protein SC6F7.25c. +FIG01887962 FIG00416083: hypothetical protein +FIG01887975 PROBABLE RHS-RELATED PROTEIN +FIG01888008 hypothetical metabolite transport protein +FIG01888028 acyl transferase domain protein +FIG01888226 Endoglucanase J, the largest catalytic component of the cellulosome / Endoglucanase A precursor (EC 3.2.1.4) +FIG01888246 arginine decarboxylase +FIG01888248 FIG01128075: hypothetical protein +FIG01888254 pedicted SAM-dependent methyltransferase +FIG01888271 Glycerol dehydrogenase small subunit (EC 1.1.99.22) (Gluconate/polyol dehydrogenase small subunit) (D-sorbitol dehydrogenase subunit sldB) (SLDH) (D-arabitol dehydrogenase small subunit) (ARDH) +FIG01888279 FIG01092527: hypothetical protein +FIG01888533 NAD(P)H nitroreductase (EC 1.-.-.-) +FIG01888582 sigma-70 like sigma-factor +FIG01888602 O-antigen polymerase family +FIG01888603 FIG00390363: hypothetical protein +FIG01888708 peptidase, M8 (leishmanolysin) family( EC:3.4.24.- ) +FIG01888717 Integral membrane protein +FIG01888766 Putative dehydratase RfbH +FIG01888796 bacteriophage Lambda NinG family protein +FIG01888842 autotransporter serine protease +FIG01888851 FIG00766320: hypothetical protein +FIG01888853 halomucin +FIG01888863 FIG00754695: hypothetical protein +FIG01888878 heat shock protein, family +FIG01888921 putative immediate early protein +FIG01888928 alginate regulatory protein AlgR3 +FIG01888975 oxalate/formate antiporter, MFS superfamily +FIG01889067 FIG01134503: hypothetical protein +FIG01889070 Putative substrate-binding transport protein +FIG01889077 FIG01135854: hypothetical protein +FIG01889137 protein cheY homolog +FIG01889143 Uncharacterized protein Mb2027c +FIG01889156 FIG00850186: hypothetical protein +FIG01889166 FIG00531049: hypothetical protein +FIG01889209 hypothetical protein +FIG01889244 FIG00623635: hypothetical protein +FIG01889249 bax protein, putative +FIG01889256 FIG00344784: hypothetical protein +FIG01889333 Collagen-like protein +FIG01889356 Alpha-acetolactate decarboxylase (EC 4.1.1.5) +FIG01889429 probable amino acid ABC transporter, periplasmic-binding protein +FIG01889596 Putative chloride channel protein, voltage gated +FIG01889639 FIG00631661: hypothetical protein +FIG01889686 membrane efflux protein +FIG01889709 Octopine dehydrogenase (EC 1.5.1.11) +FIG01889832 FIG00873231: hypothetical protein +FIG01889850 ISSfl1 ORF2 +FIG01889896 FIG01133872: hypothetical protein +FIG01889971 probable K+/H+-antiporter +FIG01890104 transposase, IS5 family, truncation +FIG01890207 Putative acyltransferase plsB1 +FIG01890219 bll6625; hypothetical protein +FIG01890233 HAD superfamily protein +FIG01890290 putative GntR-family transcriptional regulatory protein +FIG01890315 FIG00529836: hypothetical protein +FIG01890326 FIG00924706: hypothetical protein +FIG01890399 Uncharacterized protein aq_1201 +FIG01890420 protein of unknown function DUF92, transmembrane +FIG01890514 Tat pathway signal sequence +FIG01890614 FIG00539411: hypothetical protein +FIG01890619 PUTATIVE MRP PROTEIN HOMOLOG ATP-BINDING +FIG01890654 putative response regulator/chemotaxis protein CheW +FIG01890775 Cell wall biogenesis enzyme (N-terminal domain related to N-Acetylmuramoyl-L-alanine amidase and C-terminal domain related to L-alanoyl-D-glutamate peptidase); peptodoglycan-binding domain +FIG01890814 FIG01243152: hypothetical protein +FIG01890825 ISMsm1, transposase orfB +FIG01890841 FIG00626183: hypothetical protein +FIG01890934 3-oxoacyl-(acyl-carrier-protein (ACP)) synthase III C terminal domain protein +FIG01890964 ISSpo9, transposase +FIG01891029 FIG00513711: hypothetical protein +FIG01891033 carbohydrate kinase, FGGY family +FIG01891049 FIG01117790: hypothetical protein +FIG01891063 FIG00523148: hypothetical protein +FIG01891123 FIG00523526: hypothetical protein +FIG01891166 Excisionase/Xis, DNA-binding +FIG01891236 OmpR subfamily +FIG01891264 FIG00783265: hypothetical protein +FIG01891289 FIG00412672: hypothetical protein +FIG01891302 thermonuclease family protein +FIG01891390 protein phosphatase homolog +FIG01891487 FIG00494355: hypothetical protein +FIG01891550 FIG01170706: hypothetical protein +FIG01891557 FIG00816504: hypothetical protein +FIG01891567 Phosphatidylglycerophosphatase B +FIG01891657 addiction module toxin, Txe/YoeB family +FIG01891700 predicted ATP-dependent endonuclease, OLD family +FIG01891728 FIG00631334: hypothetical protein +FIG01891773 FIG00640947: hypothetical protein +FIG01891793 Hypothetical protein, CF-32 family +FIG01891870 acetyltransferase, GNAT family +FIG01891927 FIG00590988: hypothetical protein +FIG01891981 FIG01083939: hypothetical protein +FIG01891983 Glycosyltransferase WbpZ +FIG01892021 regulatory protein; PcrR +FIG01892028 Uncharacterized protein MTH_738 +FIG01892118 FIG00836436: hypothetical protein +FIG01892122 ORF14 +FIG01892132 potassium channel protein +FIG01892138 Transcriptional repressor protein TyrR +FIG01892157 probable lipoprotein signal peptide +FIG01892197 hypothetical protein +FIG01892277 hypothetical protein; Some similarities with putative lipoprotein +FIG01892389 putative N-acetylglucosamine kinase +FIG01892430 hypothetical protein, phage associated +FIG01892566 FIG00388008: hypothetical protein +FIG01892712 lantibiotic mersacidin modifying enzyme +FIG01892734 FIG00860721: hypothetical protein +FIG01892738 TonB domain/peptidase M56 domain protein +FIG01892799 Nidogen, extracellular region +FIG01892800 FIG01213977: hypothetical protein +FIG01892832 FIG00496415: hypothetical protein +FIG01892891 Putative copper binding protein +FIG01892899 FIG00388791: hypothetical protein +FIG01892931 glycosyltransferase sugar-binding region containing DXD motif +FIG01892940 FIG00457288: hypothetical protein +FIG01892969 ABC-type multidrug transport system, ATP-ase component +FIG01893057 FIG01237324: hypothetical protein +FIG01893084 FIG00527758: hypothetical protein +FIG01893093 tonB domain protein +FIG01893109 FIG00388197: hypothetical protein +FIG01893142 Dibenzothiophene desulfurization enzyme A +FIG01893145 Phosphoglycerate mutase (EC 5.4.2.1) (EC 3.1.3.46) +FIG01893163 sigma factor, putative +FIG01893228 Pyrophosphate-energized proton pump (EC 3.6.1.1) +FIG01893240 glycine betaine transporter +FIG01893260 conserved hypothetical protein, interruption-N +FIG01893285 probable ribonuclease D +FIG01893318 FIG00349907: hypothetical protein +FIG01893354 probable dinitrogenase reductase activating glycohydrolase (draG)( EC:3.2.2.24 ) +FIG01893371 putative restriction enzyme modulator protein +FIG01893456 coenzyme F420-dependent oxidoreductase +FIG01893481 probable Enterochelin esterase +FIG01893577 Transcriptional Regulator, DeoR family protein +FIG01893630 sorbitol dehydrogenase( EC:1.1.1.14 ) +FIG01893686 binding protein/LacI transcriptional regulator +FIG01893688 predicted choline kinase +FIG01893729 Similar to Biotin carboxylase +FIG01893775 nicotinamide mononucleotide transporter +FIG01893779 FIG00347726: hypothetical protein +FIG01893793 Putative O-antigen transporter +FIG01893806 FIG00522323: hypothetical protein +FIG01893826 putative regulatory prophage protein +FIG01893873 FIG01119887: hypothetical protein +FIG01893894 similar to beta-hydroxylase +FIG01893907 putative inner membrane transport permease +FIG01893918 FIG01247097: hypothetical protein +FIG01893966 COG5651: PPE-repeat proteins +FIG01894071 type II restriction enzyme eco47ii +FIG01894094 bll2516; hypothetical protein +FIG01894111 FIG00582440: hypothetical protein +FIG01894117 basic proline-rich protein +FIG01894275 Methyltransferase gidB (EC 2.1.-.-) +FIG01894284 probable RNA polymerase sigma factor rfaY +FIG01894309 FIG01126977: hypothetical protein +FIG01894310 FIG00589039: hypothetical protein +FIG01894362 FIG00344307: hypothetical protein +FIG01894388 possible Copper export protein +FIG01894460 McrB domain protein +FIG01894490 cobalamin biosynthesis protein +FIG01894553 FIG00468413: hypothetical protein +FIG01894572 RNA-directed DNA polymerase +FIG01894644 purine or other phosphorylase family 1 +FIG01894654 FIG00521669: hypothetical protein +FIG01894749 FIG00921445: hypothetical protein +FIG01894759 temperature sensitive supressor-like +FIG01894785 Uncharacterized protein MJ1379 +FIG01895036 transport system integral membrane protein +FIG01895050 FIG00245604: hypothetical protein +FIG01895099 FIG00356673: hypothetical protein +FIG01895119 Putative Xaa-Pro aminopeptidase +FIG01895166 FIG00495824: hypothetical protein +FIG01895259 FIG00700963: hypothetical protein +FIG01895343 Protein of unknown function DUF1334 +FIG01895432 Protease synthase and sporulation negative regulatory protein PAI 2 +FIG01895510 Fec I like protein +FIG01895573 hypothetical protein; putative transposase fragment +FIG01895575 thiol methyltransferase 1-like +FIG01895714 FIG00570263: hypothetical protein +FIG01895724 FIG00515779: hypothetical protein +FIG01895737 YiaAB two helix membrane protein +FIG01895746 PsiF repeat protein +FIG01895754 hypothetical protein +FIG01895791 syc0803_c +FIG01895795 hypothetical protein, weak similarity to amino acid permease +FIG01895805 TRAP dicarboxylate transporter, DctM subunit +FIG01895850 FIG00770799: hypothetical protein +FIG01895881 FIG01055269: hypothetical protein +FIG01895884 Putative glutathione peroxidase +FIG01895928 probable extracytoplasmic function alternative sigma factor +FIG01895942 CylX protein +FIG01896049 adhesin/virulence factor Hek +FIG01896077 FIG01131312: hypothetical protein +FIG01896133 FIG00559359: hypothetical protein +FIG01896183 oxidoreductase, FAD-dependent +FIG01896236 putative transposon excisionase; Tn916 ORF1-like +FIG01896365 Endoglucanase B precursor (EC 3.2.1.4) (Endo-1,4-beta-glucanase) (Cellulase) (EGB) +FIG01896381 hypothetical protein +FIG01896397 FIG00347875: hypothetical protein +FIG01896522 putative cation-transporting ATPase +FIG01896529 Glutathione reductase (EC 1.8.1.7) +FIG01896613 zinc finger, SWIM-type +FIG01896727 major surface protein 2 +FIG01896773 similar to IRE (iron responsive element) +FIG01896810 putative metal-dependent hydrolase; putative amidohydrolase +FIG01896823 RNA polymerase sigma-70 factor +FIG01896877 FIG00791714: hypothetical protein +FIG01897059 conserved protein YneR +FIG01897083 hypothetical protein +FIG01897124 Bacteriorhodopsin; Opsin +FIG01897159 FIG00751199: hypothetical protein +FIG01897312 protein of unknown function DUF1634 +FIG01897314 FIG01213243: hypothetical protein +FIG01897317 UPF0215 protein DR_A0167 +FIG01897408 probable carbohydrate binding domain +FIG01897420 FIG00389807: hypothetical protein +FIG01897430 FIG00836207: hypothetical protein +FIG01897450 thiamine pyrophosphate enzyme-like TPP-binding +FIG01897470 hypothetical protein +FIG01897475 flagellar protein FliT +FIG01897488 FIG00977622: hypothetical protein +FIG01897490 putative hemolysin activator protein +FIG01897528 High-potential iron-sulfur protein isozyme I (HiPIP 1) (High-redox-potential ferredoxin 1) +FIG01897541 sulfate adenylyltransferase, subunit 2 +FIG01897552 Bll5155 protein +FIG01897569 conserved hypothetical protein, CF-22 family +FIG01897635 Permease component of ABC-type transport system +FIG01897747 FIG00516404: hypothetical protein +FIG01897791 Uncharacterized protein Mb1767 +FIG01897845 Cyclopropane-fatty-acyl-phospholipid +FIG01897858 Antifreeze glycopeptide AFGP polyprotein precursor +FIG01897903 ISGsu1, transposase +FIG01897911 putative zinc metallopeptidase +FIG01897993 Transcriptional regulator MarR family +FIG01898024 FIG00352851: hypothetical protein +FIG01898089 FIG00837843: hypothetical protein +FIG01898160 FIG00647139: hypothetical protein +FIG01898223 FIG00356066: hypothetical protein +FIG01898238 FIG00963290: hypothetical protein +FIG01898254 putative fatty acid hydroxylase +FIG01898377 FIG00380925: hypothetical protein +FIG01898473 Transcriptional regulator araC family +FIG01898557 MG(2+) CHELATASE FAMILY PROTEIN +FIG01898690 transporter, NadC family VCA0025 +FIG01898728 hemin ABC transporter, ATP-binding protein +FIG01898734 FIG00341816: hypothetical protein +FIG01898763 protein of unknown function DUF985 +FIG01898784 Surface protein from Gram-positive cocci, anchor region +FIG01898806 Putative amidase amiA2 (EC 3.5.1.4) +FIG01898829 Probable cytochrome oxidase (Cbb3-type) (EC 1.9.3.1) +FIG01898840 Benzoylsuccinyl-CoA thiolase alpha subunit (EC:2.3.1.-) +FIG01898841 Phage-related holin +FIG01898857 FIG00348714: hypothetical protein +FIG01898890 xenobiotic reductase, putative +FIG01898938 metalloendopeptidase PepO +FIG01898964 FIG00426454: hypothetical protein +FIG01899090 AhpC-TSA +FIG01899128 Epstein-Barr nuclear antigen 1 +FIG01899136 iron-siderophore ABC-transporter ATP-binding protein +FIG01899150 FIG01132414: hypothetical protein +FIG01899189 FIG00775826: hypothetical protein +FIG01899209 possible dehydrogenase +FIG01899219 FIG01122550: hypothetical protein +FIG01899242 Gll1679 protein +FIG01899282 Adenine specific DNA methylase Mod +FIG01899398 FIG00523529: hypothetical protein +FIG01899560 periplasmic tail-specific protease +FIG01899564 Mll0172 protein +FIG01899598 type 4 pilin +FIG01899632 FIG00519815: hypothetical protein +FIG01899722 integrin-like protein +FIG01899800 FIG00786809: hypothetical protein +FIG01899823 FIG00344359: hypothetical protein +FIG01899830 cysteinyl-tRNA synthetase +FIG01899838 FIG00674130: hypothetical protein +FIG01899840 replication activator protein Pra +FIG01899845 Biotin carboxyl carrier protein of methylmalonyl-CoA:Pyruvate transcarboxylase; Biotin carboxyl carrier protein +FIG01899855 Peptidase M13 family protein +FIG01899952 Xenobiotic reductase B +FIG01900042 putative DNA helicase +FIG01900066 probable sugar transporter +FIG01900079 putative membrane-spanning permease +FIG01900179 hypothetical protein( EC:2.1.1.- ) +FIG01900188 FIG00513485: hypothetical protein +FIG01900267 flagellar hook-length control protein, putative +FIG01900346 Arginine/ornithine ABC transporter, permease protein +FIG01900415 Beta-glucosidase-related glycosidases +FIG01900423 transcriptional repressor of the hexuronate utilization operon +FIG01900476 sigma-70 region 4 domain protein +FIG01900532 PTS HPr component +FIG01900600 Predicted protein family PM-23 +FIG01900669 Coenzyme F390 synthetase-like +FIG01900684 Prolyl 4-hydroxylase, alpha subunit +FIG01900775 AcrA/AcrE family protein +FIG01900862 Oligopeptide transporter putative membrane permease domain +FIG01900901 conserved hypothetical protein-putative SAM-dependent methyltransferase +FIG01901146 similar to Xaa-Pro dipeptidase +FIG01901171 FIG00348800: hypothetical protein +FIG01901234 putative transport system periplasmic protein +FIG01901337 FIG01041664: hypothetical protein +FIG01901345 possible protein kinase/ transcriptional regulator, LuxR family +FIG01901369 C4-dicarboxylate transport system (permease small protein) +FIG01901379 Glycosyltransferase, probably involved in cell wall biogenesis +FIG01901411 DNA polymerase III, delta' subunit (EC 2.7.7.7) +FIG01901459 possible ATP/GTP-binding protein +FIG01901481 FIG01065255: hypothetical protein +FIG01901485 FIG01125009: hypothetical protein +FIG01901497 phage major capsid protein, HK97 +FIG01901550 PTS system, mannitol-specific IIABC component (EIIABC-Mtl) (Mannitol- permease IIABC component) (Phosphotransferase enzyme II, ABC component) (EC 2.7.1.69) +FIG01901583 amino acid ABC transporter, periplasmic +FIG01901681 FIG00734202: hypothetical protein +FIG01901767 Major ampullate spidroin 1 +FIG01901837 FIG00624185: hypothetical protein +FIG01901852 FIG00443277: hypothetical protein +FIG01901938 transcriptional regulator GerE family +FIG01901960 FIG00523276: hypothetical protein +FIG01901963 FIG00875108: hypothetical protein +FIG01901966 Multidrug ABC transporter permease +FIG01901981 FIG00642441: hypothetical protein +FIG01902046 hypothetical protein +FIG01902055 Prophage protein +FIG01902080 glycosyl transferase, group 1 family protein, putative +FIG01902153 probable proline hydroxylase +FIG01902170 FIG01251055: hypothetical protein +FIG01902176 Protein of unknown function Zn-binding +FIG01902221 InterPro IPR001226 COGs COG0790 +FIG01902327 FAD containing monooxygenase +FIG01902410 hemolysin homolog protein +FIG01902422 Protein-glutamate O-methyltransferase( EC:2.1.1.80 ) +FIG01902472 Uncharacterized protein Bsub YpbR +FIG01902484 FIG00472625: hypothetical protein +FIG01902642 ABC-2 type transport system permease protein +FIG01902710 FIG00414057: hypothetical protein +FIG01902714 3-oxoacid CoA-transferase, subunit B( EC:2.8.3.5 ) +FIG01902913 FIG01056847: hypothetical protein +FIG01903105 FIG00354022: hypothetical protein +FIG01903175 FIG01032038: hypothetical protein +FIG01903218 FIG00344031: hypothetical protein +FIG01903255 FIG01111593: hypothetical protein +FIG01903413 fibro-slime family protein +FIG01903422 putative glutamyl-endopeptidase +FIG01903461 iron chelate uptake ABC transporter (FeCT) family, permease protein +FIG01903479 aldose 1-epimerase +FIG01903507 FIG00696795: hypothetical protein +FIG01903530 Carbonic anhydrase( EC:4.2.1.1 ) +FIG01903607 type I restriction-modification system methylation subunit +FIG01903622 conserved domain protein +FIG01903633 AMINO ACID PERMEASE ATP-BINDING PROTEIN +FIG01903673 CHAP +FIG01903680 Type II Secretion System PilC +FIG01903710 FIG00344779: hypothetical protein +FIG01903734 FIG01238773: hypothetical protein +FIG01903762 FIG00521301: hypothetical protein +FIG01903770 FIG01118394: hypothetical protein +FIG01903778 FIG00755826: hypothetical protein +FIG01903806 FIG00768735: hypothetical protein +FIG01903868 putative tail component of prophage +FIG01903960 Uncharacterized protein TP_0987 +FIG01904038 response regulator receiver modulated diguanylate cyclase with PAS/PAC sensor +FIG01904271 peptidase M48 Ste24p +FIG01904291 FIG00663833: hypothetical protein +FIG01904292 Fe-S metabolism associated SufE +FIG01904310 putative HIT motif protein +FIG01904354 xanthine/uracil permease family protein +FIG01904364 hypothetical protein +FIG01904405 FIG00624708: hypothetical protein +FIG01904427 two-component signal transduction +FIG01904438 aspartate racemase( EC:5.1.1.13 ) +FIG01904456 COG2026: Cytotoxic translational repressor of toxin-antitoxin stability system +FIG01904491 pilin polypeptide PilA +FIG01904558 FIG00821671: hypothetical protein +FIG01904562 long-chain fatty acid transporter +FIG01904596 conserved phage-related protein +FIG01904597 AAA-family ATPase +FIG01904602 Subtilisin J (EC 3.4.21.62) +FIG01904615 Transposon Tn21 resolvase +FIG01904713 FIG00622847: hypothetical protein +FIG01904822 Cyclic peptide transporter precursor +FIG01904882 predicted enoate reductase [EC:1.3.1.31] +FIG01905066 FIG01134840: hypothetical protein +FIG01905101 FIG00389673: hypothetical protein +FIG01905107 acyl-CoA thioesterase I-like protein +FIG01905114 FIG00967274: hypothetical protein +FIG01905127 potassium transporter (trk family) +FIG01905187 probable two-component sensor +FIG01905220 long-chain-fatty-acid--luciferin-component ligase, Acyl-protein synthase( EC:6.2.1.19 ) +FIG01905364 FIG00764116: hypothetical protein +FIG01905528 2-ketogluconate 6-phosphate reductase( EC:1.1.1.215 ) +FIG01905605 Uncharacterized protein y4cD +FIG01905610 transcriptional regulator, Fis family protein +FIG01905676 FIG00873799: hypothetical protein +FIG01905693 putative cardiolipin synthetase +FIG01905701 Zinc-binding oxidoreductase +FIG01905708 FIG00344843: hypothetical protein +FIG01905753 transposase-like +FIG01905761 Esterase, PHB depolymerase +FIG01905793 Fatty acid desaturase related protein +FIG01905819 FIG00631225: hypothetical protein +FIG01905831 Lantibiotic mersacidin transporter system +FIG01905837 No significant database matches. +FIG01905899 Uncharacterised protein family (UPF0089) family +FIG01905939 FIG00675325: hypothetical protein +FIG01905944 alternate gene name: yeeL +FIG01905956 chondro-6-sulfatase regulatory protein isolog +FIG01905990 chromosome partitioning ATPase, ParA family +FIG01906043 putative pyridoxamine 5-phosphate-dependent dehydrase +FIG01906070 hypothetical protein, CF-30 family +FIG01906119 Proline-rich extensin-like protein +FIG01906140 FIG167255: hypothetical protein +FIG01906149 FeoA protein, involved in Fe2+ transport +FIG01906223 FIG00670503: hypothetical protein +FIG01906234 Benzil reductase +FIG01906250 peptidoglycan hydrolase +FIG01906289 Diflavin flavoprotein A 1 +FIG01906369 Flagellar hook-associated protein flgK +FIG01906380 Ribose import ATP-binding protein rbsA (EC 3.6.3.17) +FIG01906392 N-acyl-L-amino acid amidohydrolase (EC 3.5.1.14) +FIG01906455 161aa long hypothetical protein +FIG01906461 FIG01138696: hypothetical protein +FIG01906482 hypothetical signaling protein +FIG01906541 APHP domain protein +FIG01906557 FIG00959073: hypothetical protein +FIG01906567 putative transmembrane permease +FIG01906582 cellulose degradation +FIG01906590 FIG00642319: hypothetical protein +FIG01906592 hypothetical protein +FIG01906700 FIG01125137: hypothetical protein +FIG01906731 peptidase M4, thermolysin +FIG01906768 FIG00363056: hypothetical protein +FIG01906813 putative cell wall surface anchor family protein +FIG01906854 Iron-dependent peroxidase +FIG01906888 FIG00628505: hypothetical protein +FIG01906951 DNA uptake protein, DNA-binding +FIG01907115 COG0223: Methionyl-tRNA formyltransferase +FIG01907117 FIG00568024: hypothetical protein +FIG01907133 FIG00626385: hypothetical protein +FIG01907170 FIG00525246: hypothetical protein +FIG01907250 Thymidylate kinase-like +FIG01907268 Wall-associated protein +FIG01907347 ABC-type iron(III)-siderophore transport system, periplasmic component +FIG01907416 similar to Superfamily I DNA and RNA helicases and helicase subunits +FIG01907462 RNA polymerase sigma factor, ECF subfamily, SigC_1 +FIG01907551 hypothetical protein +FIG01907599 ISPsy5, transposase +FIG01907617 FIG01127572: hypothetical protein +FIG01907643 FIG01125502: hypothetical protein +FIG01907647 Internalin-related protein +FIG01907807 SOUL heme-binding protein +FIG01907912 Methylmalonyl-CoA mutase( EC:5.4.99.2 ) +FIG01907961 FIG01097586: hypothetical protein +FIG01908025 COG0464: ATPases of the AAA+ class +FIG01908093 UPF057 membrane protein PA0567 +FIG01908228 FIG00416281: hypothetical protein +FIG01908249 conserved uncharacterized protein +FIG01908275 FIG00623475: hypothetical protein +FIG01908288 FIG00387856: hypothetical protein +FIG01908492 putative methylisocitrate lyase +FIG01908526 putative oxidoreductase, FAD-binding +FIG01908602 FIG01205123: hypothetical protein +FIG01908604 COG0673: Predicted dehydrogenases and related proteins +FIG01908673 HhH-GPD:8-oxoguanine DNA glycosylase-like +FIG01908746 FIG00347963: hypothetical protein +FIG01908888 Oxidoreductase, molybdopterin binding +FIG01908946 ABC transporter oligopeptide binding protein +FIG01908976 METHYL-ACCEPTING CHEMOTAXIS PROTEIN II +FIG01908989 stable plasmid inheritance protein B +FIG01909066 Ethanolamine utilization protein +FIG01909226 putatiave glycosyltransferase +FIG01909256 FIG00388762: hypothetical protein +FIG01909337 FIG00733531: hypothetical protein +FIG01909345 FIG00679139: hypothetical protein +FIG01909369 FIG01165950: hypothetical protein +FIG01909385 FIG00440100: hypothetical protein +FIG01909480 FIG00487847: hypothetical protein +FIG01909500 FIG01191387: hypothetical protein +FIG01909516 5-methyltetrahydrofolate--homocysteine S-methyltransferase( EC:2.1.1.13 ) +FIG01909584 DINB PROTEIN +FIG01909746 FIG00363902: hypothetical protein +FIG01909828 FIG01197799: hypothetical protein +FIG01909858 FIG00623863: hypothetical protein +FIG01909887 Integrase/recombinase xerD +FIG01909932 peptidase S45 penicillin amidase +FIG01910022 FIG00344692: hypothetical protein +FIG01910050 transposase IS1201 +FIG01910092 Pks12 +FIG01910148 FIG01007376: hypothetical protein +FIG01910192 FIG00744005: hypothetical protein +FIG01910194 Strictosidine synthase +FIG01910231 RNA 2'-O ribose methyltransferase +FIG01910273 hypothetical protein +FIG01910363 conserved domain protein, histidine-rich +FIG01910378 Toxin secretion transporter, putative +FIG01910466 poly-gamma-glutamate biosynthesis (capsule formation) +FIG01910467 FIG01135634: hypothetical protein +FIG01910473 DNA modification methylase M.SthI +FIG01910516 FIG00191639: hypothetical protein +FIG01910659 hypothetical protein; putative Sensor histidine kinase +FIG01910686 similar to aspartyl protease +FIG01910694 FIG01037661: hypothetical protein +FIG01910740 FIG00349271: hypothetical protein +FIG01910811 FIG00404199: hypothetical protein +FIG01910869 FIG00838878: hypothetical protein +FIG01910885 FIG00415943: hypothetical protein +FIG01910889 O-acetylhomoserine sulfhydrylase +FIG01910899 Ribonucleoside-diphosphate reductase, adenosylcobalamin-dependent +FIG01910915 COG3391: Uncharacterized conserved protein +FIG01910936 FIG00835351: hypothetical protein +FIG01911026 Glr3834 protein +FIG01911135 FIG028220: hypothetical protein co-occurring with HEAT repeat protein +FIG01911208 FIG01092102: hypothetical protein +FIG01911321 Mercuric resistance operon regulatory protein, MerR family +FIG01911342 FIG01245127: hypothetical protein +FIG01911366 Possible sodium dependent transporter +FIG01911401 FIG00839266: hypothetical protein +FIG01911418 Possible lipase +FIG01911424 FIG00632531: hypothetical protein +FIG01911425 rhodanese-related sulfurtransferase-like protein +FIG01911491 FIG01221791: hypothetical protein +FIG01911509 FIG00385245: hypothetical protein +FIG01911525 FIG00498445: hypothetical protein +FIG01911533 Possible monooxygenase +FIG01911571 flavoprotein, possibly 3-ketosteroid dehydrogenase +FIG01911578 Bll8152 protein +FIG01911729 FIG00433399: hypothetical protein +FIG01911734 FIG00681120: hypothetical protein +FIG01911744 FIG00624323: hypothetical protein +FIG01911791 FIG00967445: hypothetical protein +FIG01911810 putative phage integrase family +FIG01911822 protein of unknown function DUF925 +FIG01911826 intercellular communication +FIG01911909 FIG00349291: hypothetical protein +FIG01911966 Auxin-binding protein, putative +FIG01912013 FIG00413170: hypothetical protein +FIG01912079 alternate gene name: yugD +FIG01912089 FIG00676676: hypothetical protein +FIG01912142 cupin 4 family protein +FIG01912176 FIG01236126: hypothetical protein +FIG01912235 FIG00512755: hypothetical protein +FIG01912241 FIG00958402: hypothetical protein +FIG01912256 predicted exonuclease +FIG01912298 putative phasin protein +FIG01912360 Peptidase A24A, prepilin type IV +FIG01912411 Uncharacterized protein MJ0150 +FIG01912434 FIG00380366: hypothetical protein +FIG01912621 FIG00527866: hypothetical protein +FIG01912623 Transposase Tn3 +FIG01912675 lysR-family trancsriptional regulator +FIG01912726 Chain A, Red Copper Protein Nitrosocyanin +FIG01912866 FIG00344123: hypothetical protein +FIG01912904 RelA/SpoT domain protein +FIG01913008 Transposase homolog +FIG01913018 FIG01056165: hypothetical protein +FIG01913063 FIG00415866: hypothetical protein +FIG01913219 Nitrogen regulation protein +FIG01913271 amidase enhancer +FIG01913293 protein dithiol-disulfide isomerase +FIG01913398 FIG00460579: hypothetical protein +FIG01913412 FIG00985944: hypothetical protein +FIG01913414 Na(+)-translocating NADH-quinone reductase subunit F (EC 1.6.5.-) homolog +FIG01913446 FIG00341985: hypothetical protein +FIG01913460 Probable enoyl-CoA hydratase (EC 4.2.1.17) +FIG01913539 FIG00451722: hypothetical protein +FIG01913578 FIG00711544: hypothetical protein +FIG01913603 tungsten-containing aldehyde ferredoxin oxidoreductase COFACTOR MODIFYING PROTEIN +FIG01913634 Mll5573 protein +FIG01913930 FIG01061058: hypothetical protein +FIG01913937 ribonuclease BN +FIG01914092 melibiase +FIG01914130 putative RNA methyltransferase +FIG01914138 uncharacterized phage-associated protein +FIG01914174 FIG00730950: hypothetical protein +FIG01914214 Flp pilus assembly protein TadB-like protein +FIG01914217 FIG00356809: hypothetical protein +FIG01914377 Radical SAM domain protein +FIG01914400 FIG00815521: hypothetical protein +FIG01914440 Alkaline phosphatase( EC:3.1.3.1 ) +FIG01914452 Probable serine/threonine protein kinase CPE1738 (EC 2.7.11.1) +FIG01914513 Metal-dependent hydrolase of the beta-lactamase superfamily III-like protein +FIG01914546 Putative Adenylate/Guanylate Cyclase +FIG01914686 FIG01121694: hypothetical protein +FIG01914731 Putative sensor histidine kinase +FIG01914866 TPR-domain containing protein, putative +FIG01914913 FIG01190802: hypothetical protein +FIG01914935 Protocatechuate dioxygenase +FIG01915018 3-DEMETHYLUBIQUINONE-9 3-METHYLTRANSFERASE +FIG01915026 Putative iron-siderophore uptake system ATP-binding component +FIG01915218 FIG00417315: hypothetical protein +FIG01915245 Gll1352 protein +FIG01915431 oxidoreductase, selenocysteine-containing +FIG01915538 sulfotransferase, putative +FIG01915571 amino transferase +FIG01915607 FIG00768544: hypothetical protein +FIG01915668 FIG00518008: hypothetical protein +FIG01915693 elements of external origin +FIG01915866 hypothetical protein +FIG01915945 Chemotaxis regulator - transmits chemoreceptor signals to flagelllar motor components CheY +FIG01916028 FIG00362259: hypothetical protein +FIG01916036 probable marR-family transcription regulator +FIG01916048 FemAB family protein +FIG01916065 MarR-family protein regulatory protein +FIG01916110 ChaB family protein +FIG01916138 FIG00841639: hypothetical protein +FIG01916153 FIG00470962: hypothetical protein +FIG01916161 glycine betaine/L-proline ABC transporter, ATP-binding protein +FIG01916165 mobilisation protein A +FIG01916185 RubW +FIG01916271 phage Tail Collar +FIG01916286 FIG01092490: hypothetical protein +FIG01916328 conserved exported hypothetical protein +FIG01916333 nickel-dependent hydrogenase b-type cytochrome subunit +FIG01916386 2-nitropropane dioxygenase NPD +FIG01916394 possible sigma factor, ECF subfamily +FIG01916425 FIG00388003: hypothetical protein +FIG01916452 FIG00364844: hypothetical protein +FIG01916474 FIG00859025: hypothetical protein +FIG01916510 putative nudix hydrolase family protein +FIG01916531 CMP/dCMP deaminase zinc-binding +FIG01916547 Uncharacterised protein family UPF0157 (COG2320) +FIG01916567 mutator family transposase +FIG01916592 Uncharacterized protein, ortholog of YYBG B.subtilis +FIG01916594 FIG00414179: hypothetical protein +FIG01916625 putative secreted esterase +FIG01916737 hypothetical protein +FIG01916823 cell-cycle regulation histidine triad protein +FIG01916842 GABA-A receptor epsilon-like subunit +FIG01916923 FIG00687622: hypothetical protein +FIG01916930 FIG00347677: hypothetical protein +FIG01916986 similar to pre-neck appendage protein +FIG01917061 serine phosphatase +FIG01917151 FIG00622910: hypothetical protein +FIG01917188 FIG01095882: hypothetical protein +FIG01917343 Phage peptidoglycan binding peptidase +FIG01917388 Aldo-keto reductase family 1 member B10 (EC 1.1.1.-) +FIG01917418 Endoglucanase D precursor (EC 3.2.1.4) (Endo-1,4-beta-glucanase D) (Cellulase D) +FIG01917440 putative molybdopterin-guanine dinucleotide biosynthesis protein +FIG01917469 FIG00848950: hypothetical protein +FIG01917516 FIG00918418: hypothetical protein +FIG01917605 Aryldialkylphosphatase +FIG01917654 probable sigma factor SigH +FIG01917676 modification methylase, HemK family +FIG01917751 FIG01067178: hypothetical protein +FIG01917787 sensor/response regulator +FIG01917915 FIG00617464: hypothetical protein +FIG01917920 bll2159; putative transposase +FIG01917938 Uncharacterized protein Mb3441 +FIG01917945 N-ethylammeline chlorohydrolase +FIG01917967 FIG01250422: hypothetical protein +FIG01917977 putative calmodulin-binding protein CaM-BP15 +FIG01918071 FIG00924718: hypothetical protein +FIG01918110 peptidoglycan-associated protein +FIG01918181 iron-sulfur cluster binding protein +FIG01918188 FIG00769904: hypothetical protein +FIG01918201 FIG00514470: hypothetical protein +FIG01918297 FIG00945898: hypothetical protein +FIG01918300 Rhodopsin-like GPCR superfamily +FIG01918304 FIG00533116: hypothetical protein +FIG01918316 Very large tegument protein +FIG01918346 putative transmembrane mobilization protein, putative TraG +FIG01918381 sugar ABC transporter, ATP binding protein +FIG01918442 FIG00839132: hypothetical protein +FIG01918458 FIG00883801: hypothetical protein +FIG01918485 Ricin B lectin +FIG01918491 Pyridoxamine 5'-phosphate oxidase-related, FMN-binding +FIG01918533 glycoside hydrolase family 5 +FIG01918608 FIG00756283: hypothetical protein +FIG01918617 FIG01154890: hypothetical protein +FIG01918633 Possible neuromedin U precursor +FIG01918636 Sll1429 protein +FIG01918666 FIG00556235: hypothetical protein +FIG01918675 transposase (10) +FIG01918767 FIG00522006: hypothetical protein +FIG01918951 endo-beta-1,3-glucanase +FIG01918958 FIG00469149: hypothetical protein +FIG01918977 similar to Ketopantoate reductase +FIG01918989 Glycosyl transferase, family 2 (EC 2.4.1.-) +FIG01919022 FIG01119176: hypothetical protein +FIG01919107 phage lysozyme lysis protein +FIG01919153 FIG00568519: hypothetical protein +FIG01919225 oxygen-insensitive NAD(P)H nitroreductase / dihydropteridine reductase( EC:1.-,EC:1.5.1.34 ) +FIG01919243 Uroporphyrinogen decarboxylase( EC:4.1.1.37 ) +FIG01919245 NrfA-putative nitrite reduction protein-like +FIG01919330 hypothetical protein ELI_09190 +FIG01919336 FIG00765639: hypothetical protein +FIG01919380 Serine/threonine phosphatase (inactivated protein) +FIG01919392 conserved hypothetical protein-putative phospholipid-binding protein +FIG01919415 FIG00498953: hypothetical protein +FIG01919438 Cyclic nucleotide-binding +FIG01919477 FIG00389692: hypothetical protein +FIG01919487 GatB/YqeY family protein +FIG01919523 parB-like partition protein +FIG01919560 2-polyprenyl-6-methoxyphenol hydroxylase and related FAD-dependent oxidoreductases +FIG01919572 Ig domain protein, group 1 domain protein +FIG01919574 Pilus assembly protein PilA +FIG01919605 YoxA +FIG01919618 Aminoglycoside N(3')-acetyltransferase III (EC 2.3.1.81) (ACC(3)-III) (Aminocyclitol 3-N-acetyltransferase type III) (Gentamicin-(3)-N-acetyl-transferase) +FIG01919622 putative flavodoxin +FIG01919630 Transport-associated domain precursor +FIG01919651 Signal Transduction Histidine Kinase +FIG01919755 hypothetical BioC +FIG01919792 FIG00876438: hypothetical protein +FIG01919794 transmembrane protein (homolog 4 to type II secretion system proteins TadC) +FIG01919809 Proline imino-peptidase +FIG01919889 FIG00653840: hypothetical protein +FIG01919955 Putative ligase/carboxylase protein +FIG01920054 FIG00520195: hypothetical protein +FIG01920072 blr1578; hypothetical protein +FIG01920112 COG0788: Formyltetrahydrofolate hydrolase +FIG01920157 UDP-glucose 6-dehydrogenase( EC:1.1.1.22 ) +FIG01920173 MlpB +FIG01920213 kinesin light chain-like protein +FIG01920216 putative insertion sequence transposase protein +FIG01920253 probable mannosyltransferase B +FIG01920327 INTEGRASE/RECOMBINASE +FIG01920370 minor extracellular serine protease +FIG01920466 methyltransferase, homolog +FIG01920520 FIG01055195: hypothetical protein +FIG01920546 FIG00766991: hypothetical protein +FIG01920547 chloramphenicol resistance protein +FIG01920551 Putative ArsR-family transcriptional regulator +FIG01920567 FIG00633243: hypothetical protein +FIG01920572 Per-hexamer repeat protein 5 +FIG01920631 FIG00385908: hypothetical protein +FIG01920759 FIG00839913: hypothetical protein +FIG01920766 putative multidrug efflux protein +FIG01920773 Cucumopine synthase +FIG01920779 FIG00717679: hypothetical protein +FIG01920799 type II restriction-modification system restriction subunit( EC:3.1.21.4 ) +FIG01920929 hypothetical protein +FIG01920942 transposase (08) +FIG01920965 FIG01048466: hypothetical protein +FIG01921017 FIG00864974: hypothetical protein +FIG01921065 ferredoxin, 4Fe-4S +FIG01921082 FIG00847033: hypothetical protein +FIG01921083 putative L-fucose isomerase +FIG01921129 FIG00694843: hypothetical protein +FIG01921177 FIG00848659: hypothetical protein +FIG01921178 Mlr8092 protein +FIG01921226 FIG00385532: hypothetical protein +FIG01921231 FIG015136: hypothetical protein +FIG01921259 FIG00529059: hypothetical protein +FIG01921315 Sigma-70 region 2:Sigma-70 region 4 +FIG01921378 hypothetical protein +FIG01921479 ABC drug efflux pump, inner membrane subunit, DrrB family +FIG01921498 O-unit polymerase-like protein +FIG01921587 FIG00521470: hypothetical protein +FIG01921609 putative replication protein (repA-like) +FIG01921666 FIG01130653: hypothetical protein +FIG01921792 Hypothetical protein; putative signal peptide +FIG01921798 Bacterial luciferase family protein (Alkanal monooxygenase, FMN- linked) (EC 1.14.14.3) +FIG01921856 FIG00656574: hypothetical protein +FIG01921892 NUDIX domain protein( EC:6.- ) +FIG01921895 Minus agglutinin +FIG01921911 FIG00445390: hypothetical protein +FIG01921953 partial transposase Orf1 in ISPg5 +FIG01922025 FIG00564314: hypothetical protein +FIG01922104 FIG01046143: hypothetical protein +FIG01922168 FIG00471368: hypothetical protein +FIG01922188 AhpC/Tsa family protein +FIG01922229 putative outer-membrane protein +FIG01922263 putative S-layer associated protein +FIG01922288 FIG00631477: hypothetical protein +FIG01922295 Streptococcal histidine triad protein +FIG01922362 prophage LambdaSa2, HNH endonuclease family protein +FIG01922383 wo-component system sensor protein / Periplasmic iron-binding protein +FIG01922394 putative cold-shock DNA-binding domain protein +FIG01922447 quinolone resistence NorA protein, major facilitator family transporter +FIG01922508 FIG01210981: hypothetical protein +FIG01922632 Acetyltransferase MppC +FIG01922701 FIG00384897: hypothetical protein +FIG01922712 FIG01114438: hypothetical protein +FIG01922766 acetyl-CoA carboxylase, biotin carboxyl carrier protein +FIG01922919 conserved domain protein +FIG01922922 integrin alpha-subunit domain-like protein +FIG01923008 attenuator role for lytABC and lytR expression +FIG01923020 FIG00734336: hypothetical protein +FIG01923028 FIG01140756: hypothetical protein +FIG01923043 FIG00525791: hypothetical protein +FIG01923053 FIG00818310: hypothetical protein +FIG01923145 lipase modulator protein +FIG01923337 FIG01024739: hypothetical protein +FIG01923353 Siroheme synthase +FIG01923500 probable multidrug resistance efflux pump +FIG01923611 FIG00613750: hypothetical protein +FIG01923650 dipeptidyl aminopeptidase/acylaminoacyl-peptidase related protein +FIG01923703 FIG00836482: hypothetical protein +FIG01923808 FIG00344674: hypothetical protein +FIG01923820 Probable signal peptidase I (EC 3.4.21.89) +FIG01923822 FIG00623553: hypothetical protein +FIG01923869 Short-chain dehydrogenase/reductase SDR( EC:1.1.1.275 ) +FIG01923901 PmgS +FIG01923912 conserved hypothetical protein-putative phosphoglycolate phosphatase +FIG01923918 conserved hypothetical protein; putative transporter (Bacterial extracellular solute-binding protein, family 3) +FIG01924007 Succinic semialdehyde reductase [NAD] (EC 1.1.1.61) +FIG01924210 FIG00944767: hypothetical protein +FIG01924219 FIG00495513: hypothetical protein +FIG01924374 probable ATP-dependent Clp protease ATP-binding subunit +FIG01924393 hydrolase, alpha-beta fold family (ephF) +FIG01924416 aldo/keto reductase( EC:1.1.1.274 ) +FIG01924449 putative F420H2-dehydrogenase +FIG01924527 FIG00515082: hypothetical protein +FIG01924579 FIG00524525: hypothetical protein +FIG01924661 GAF/GGDEF-domain containing protein +FIG01924664 IS402-like transposase +FIG01924733 blr6992; hypothetical protein +FIG01924792 FIG01157866: hypothetical protein +FIG01924883 similar to Phospholipid N-methyltransferase +FIG01924919 hypothetical protein +FIG01924923 UDP-glucose 4-epimerase( EC:5.1.3.2 ) +FIG01924926 cation transporter, permease component +FIG01924979 Membrane-associated lipoprotein precurser +FIG01925131 FIG00964010: hypothetical protein +FIG01925142 FIG00756712: hypothetical protein +FIG01925153 FIG00818275: hypothetical protein +FIG01925156 macrolide 2'-phosphotransferase +FIG01925229 FIG00580099: hypothetical protein +FIG01925282 acetyltransferase( EC:2.3.1.28 ) +FIG01925303 unidentified open reading frame +FIG01925343 blr3560; hypothetical protein +FIG01925377 multitransmembrane protein-like +FIG01925426 D-ribose-binding protein +FIG01925476 FIG01249985: hypothetical protein +FIG01925553 bifunctional homocysteine S-methyltransferase/5,10-methylenetetrahydrofolate reductase protein +FIG01925596 FIG01136620: hypothetical protein +FIG01925628 lysR-family transcriptional regulator +FIG01925777 Sugar ABC transporter, solute-binding protein +FIG01925863 putative sugar ABC transportor, ATP-binding protein +FIG01925888 putative ammonia monooxygenase superfamily protein +FIG01925929 FIG01214542: hypothetical protein +FIG01925947 conserved protein, ferredoxin-related +FIG01925979 FIG00634555: hypothetical protein +FIG01926141 FIG00665549: hypothetical protein +FIG01926179 Protein of unknown function DUF402 +FIG01926216 Protein of unknown function DUF909 +FIG01926271 hemerythrin HHE cation binding domain subfamily protein, putative +FIG01926276 METHYL-ACCEPTING CHEMOTAXIS PROTEIN MCP +FIG01926300 putative tail assembly chaperone +FIG01926302 FIG01082370: hypothetical protein +FIG01926309 integrase XerD family protein +FIG01926339 Tail completion protein S +FIG01926359 FIG00930247: hypothetical protein +FIG01926378 FIG00415789: hypothetical protein +FIG01926393 glucosyl transferase I +FIG01926414 FIG00750506: hypothetical protein +FIG01926426 TraI protein +FIG01926455 FIG01225507: hypothetical protein +FIG01926535 phage-related regulatory protein cII +FIG01926574 ABC transporter oligopeptide permease. +FIG01926609 internalin +FIG01926658 FIG00939212: hypothetical protein +FIG01926932 pirin +FIG01926969 FIG00470388: hypothetical protein +FIG01927064 peptidase, M48 family protein( EC:3.4.24.- ) +FIG01927128 Phenol-degradation regulator +FIG01927185 Cytochrome c biogenesis ResA protein +FIG01927245 N-terminal methylation domain-containing protein +FIG01927247 Squalene synthase (EC 2.5.1.21) +FIG01927264 NADH-ubiquinone/plastoquinone +FIG01927272 similar to ferrous ion transport protein A +FIG01927276 COG2382: Enterochelin esterase and related enzymes +FIG01927286 FIG00758904: hypothetical protein +FIG01927311 FIG00592360: hypothetical protein +FIG01927503 sarcosine oxidase, subunit alpha +FIG01927519 Putative RNA polymerase ECF-type sigma factor +FIG01927589 FIG01047076: hypothetical protein +FIG01927733 Succinoglycan biosynthesis protein exoV +FIG01927743 ferredoxin-thioredoxin reductase variable chain +FIG01927850 carboxyl-terminal protease family protein +FIG01927926 FIG00490004: hypothetical protein +FIG01927982 RNA polymerase sigma factor (ECF subfamily) +FIG01927984 hypothetical protein, putative bacteriocin +FIG01928063 FIG00840476: hypothetical protein +FIG01928084 protein of unknown function DUF939 +FIG01928099 Vng1746c +FIG01928188 Colicin-K +FIG01928192 FIG00344473: hypothetical protein +FIG01928244 FIG01233583: hypothetical protein +FIG01928291 oligosaccharide deacetylase +FIG01928301 FIG00364350: hypothetical protein +FIG01928384 FIG00888726: hypothetical protein +FIG01928443 putative branched-chain amino acid ABC transporter (substrate-binding protein) +FIG01928463 Collagen-binding surface protein, putative +FIG01928514 Putative metallo-beta-lactamase +FIG01928515 protein of unknown function DUF796 +FIG01928550 FIG00388079: hypothetical protein +FIG01928625 Predicted transcriptional regulator +FIG01928997 sugar ABC transportor, ATP-binding protein +FIG01929033 conserved domain protein +FIG01929065 Flagellar biosynthesis protein flhB +FIG01929086 FIG00661076: hypothetical protein +FIG01929183 expression activator-related protein +FIG01929208 FIG00955974: hypothetical protein +FIG01929234 tail length tape measure protein +FIG01929249 putative dioxygenase alpha subunit YeaW +FIG01929266 COG2198: FOG: HPt domain +FIG01929283 helix-turn-helix protein, CopG +FIG01929400 FIG00780345: hypothetical protein +FIG01929469 Membrane protein related to SecD/SecF +FIG01929542 Hypothetical protein in cluster with Ecs transporter (in Streptococci) +FIG01929565 halocyanin precursor-like +FIG01929646 Short-chain alcohol dehydrogenase family protein +FIG01929647 putative protein involved in iron transport +FIG01929664 putative cyclase family protein +FIG01929724 FIG01136188: hypothetical protein +FIG01929862 gas vesicle protein GVPa +FIG01929903 FIG01136192: hypothetical protein +FIG01929919 FIG01246197: hypothetical protein +FIG01929948 FIG00530444: hypothetical protein +FIG01929970 Late embryogenesis abundant protein +FIG01930008 carbohydrate binding domain protein +FIG01930029 serine protease inhibitor +FIG01930092 heat shock protein, molecular chaperone +FIG01930128 FIG00379936: hypothetical protein +FIG01930139 FIG00527976: hypothetical protein +FIG01930175 treponemal membrane protein, putative +FIG01930273 FIG00534205: hypothetical protein +FIG01930277 FIG00656702: hypothetical protein +FIG01930334 similar to methyl-accepting chemotaxis protein +FIG01930339 butanol dehydrogenas +FIG01930391 FIG00568546: hypothetical protein +FIG01930471 branched-chain amino acid transport ATP-binding protein livG +FIG01930503 tellurite resistance protein +FIG01930506 Uncharacterized protein, homolog of YCGL B.subtilis +FIG01930527 thiol oxidoreductase-like protein +FIG01930602 FIG00344935: hypothetical protein +FIG01930724 Thiolase precursor +FIG01930749 excinuclease ABC subunit B +FIG01930778 amino acid adenylation domain protein +FIG01930888 FIG01131433: hypothetical protein +FIG01930892 GntR family transcriptional regulator PA1654 @ Transcriptional regulator, GntR family domain +FIG01930959 Trk potassium uptake system protein +FIG01930997 Degenerate transposase +FIG01931014 Acid phosphatase/vanadium-dependent haloperoxidase related +FIG01931019 putative oxidoreductase, mmyf +FIG01931043 hypothetical protein-similar to truncated hemoglobins +FIG01931105 aromatic-ring-hydroxylating dioxygenase, beta subunit +FIG01931123 arginine repressor +FIG01931260 FIG00365014: hypothetical protein +FIG01931390 putative methyl transferase +FIG01931398 FIG00520023: hypothetical protein +FIG01931515 WbgW (Putative glycosyl transferase) +FIG01931545 FIG01250200: hypothetical protein +FIG01931567 Voltage-gated sodium channel +FIG01931572 GTP cyclohydrolase II +FIG01931578 Succinylglutamate desuccinylase +FIG01931612 Endonuclease (EC 3.1.30.-) +FIG01931684 Modification methylase DpnIIB (EC 2.1.1.72) (Adenine-specific methyltransferase DpnIIB) (M.DpnIIB) (M.DpnII 2) +FIG01931759 Polymyxin resistance protein ArnC, glycosyl transferase (EC 2.4.-.-) +FIG01931793 Membrane-fusion protein, HlyD family +FIG01931839 FIG00667997: hypothetical protein +FIG01931843 Thrombospondin-1 precursor +FIG01931884 short-chain dehydrogenase/reductase +FIG01932122 FIG01248537: hypothetical protein +FIG01932154 transcriptional repressor SmtB +FIG01932197 FIG01246815: hypothetical protein +FIG01932278 ribosomal protein S2-related protein +FIG01932281 FIG01082832: hypothetical protein +FIG01932287 ISMca1, transposase +FIG01932341 Exopolysaccharide synthesis ExoD +FIG01932391 sulfide dehydrogenase precursor +FIG01932406 Secreted polysaccharide polymerase +FIG01932458 conserved protein( EC:6.3.5.2 ) +FIG01932547 FIG00733864: hypothetical protein +FIG01932616 Acyl-ACP thioesterase, FatA +FIG01932710 PERMEASE OF ABC TRANSPORTER +FIG01932716 Dimethylhistidine N-methyltransferase (EC 2.1.1.44) +FIG01932784 FIG00388040: hypothetical protein +FIG01932948 hypothetical protein( EC:3.2.1.18 ) +FIG01932980 multicopper oxidase, type 2 +FIG01933047 FIG00834007: hypothetical protein +FIG01933050 Hemolysin-type calcium-binding toxin +FIG01933086 aminopeptidase M1 family protein +FIG01933160 ENSANGP00000024744 +FIG01933164 protein of unknown function DUF839 +FIG01933168 isopenicillin N epimerase +FIG01933233 TraG-like protein +FIG01933491 FIG01126858: hypothetical protein +FIG01933588 FIG00363780: hypothetical protein +FIG01933658 FIG00622960: hypothetical protein +FIG01933677 Sensor histidine kinase with PAS/PAC and Response regulator receiver domains +FIG01933807 Predicted phage-specific transcriptional regulator +FIG01933872 Expressed lipoprotein +FIG01933881 FIG00849520: hypothetical protein +FIG01933885 tpr protein K (tprK) +FIG01933895 Response regulators of cell autolysis +FIG01933933 Auxin-binding protein 1 precursor (ABP) +FIG01933967 LIPOPROTEIN A +FIG01933994 FIG01243603: hypothetical protein +FIG01934010 FIG01128648: hypothetical protein +FIG01934011 Putative metabolite transport protein HI1104 +FIG01934038 FIG00715003: hypothetical protein +FIG01934116 Collagenase and related protease +FIG01934154 FIG00794477: hypothetical protein +FIG01934193 FIG01031730: hypothetical protein +FIG01934352 Probable reductase +FIG01934355 probable kinesin light chain +FIG01934373 Bll7302 protein +FIG01934443 Probable cytochrome c +FIG01934496 transglutaminase, N-terminal domain protein +FIG01934545 galactofuranosyltransferase +FIG01934600 putative periplasmic component of ABC-type transport system +FIG01934711 ABC transporter, substrate-binding lipoprotein +FIG01934734 protein of unknown function DUF1345 +FIG01934778 putative iron-binding protein +FIG01934781 cytochrome c oxidoreductase subunit B +FIG01934813 transcriptional regulator-like +FIG01934823 similar to restriction endonuclease +FIG01934847 F17 fimbrial protein precursor +FIG01934861 virulence-associated protein D +FIG01934879 putative 3-oxoadipate enol-lactone hydrolase/4-carboxymuconolactone decarboxylase +FIG01934881 FIG00991672: hypothetical protein +FIG01934931 Alpha-tectorin precursor +FIG01934937 sensor histidine kinase/response regulator GacS +FIG01935028 signal peptide peptidase SppA (protease IV) +FIG01935061 HMG-I and HMG-Y DNA-binding domain protein +FIG01935062 secreted sugar hydrolase +FIG01935071 FIG00591862: hypothetical protein +FIG01935289 LasA protease precursor +FIG01935403 FIG00516014: hypothetical protein +FIG01935419 FIG01074222: hypothetical protein +FIG01935455 FIG00416425: hypothetical protein +FIG01935503 Sodium:neurotransmitter symporter +FIG01935528 putative multidrug ABC transporter, permease component +FIG01935543 PROBABLE TRANSPOSASE FUSION PROTEIN +FIG01935561 transcriptional regulator FixK +FIG01935597 putative DNA alkylation repair enzyme +FIG01935710 Thioesterase( EC:3.1.2.14 ) +FIG01935777 Elongation factor-1 alpha +FIG01935893 cytochrome c biogenesis (thioredoxin) +FIG01935925 drug resistance transporter +FIG01936091 hypothetical protein +FIG01936160 hypothetical regulator protein +FIG01936237 Acyltransferase/acetyltransferase +FIG01936301 FIG00747109: hypothetical protein +FIG01936311 containing IPT/TIG domain +FIG01936372 FIG00534078: hypothetical protein +FIG01936408 FIG01115688: hypothetical protein +FIG01936422 Aldo/keto oxidoreductase +FIG01936435 putative peptide transport system secreted peptide binding protein +FIG01936445 FIG00733204: hypothetical protein +FIG01936529 lipopolysaccharide exporter +FIG01936557 isoprenylcysteine carboxyl methyltransferase +FIG01936565 hypothetical protein +FIG01936566 ORF_ID:all7658 unknown protein +FIG01936580 FIG00406892: hypothetical protein +FIG01936607 hypothetical protein +FIG01936623 FIG00715072: hypothetical protein +FIG01936744 sigma-F transcribed protein csfB +FIG01936793 putative mercuric transport protein +FIG01936828 Cyclohex-1-ene-1-carboxyl-CoA hydratase (EC 4.2.1.17) +FIG01936975 glycoside hydrolase, family 28 +FIG01937003 FIG00759408: hypothetical protein +FIG01937064 phage regulatory protein +FIG01937084 FIG00407477: hypothetical protein +FIG01937090 serine protease, subtilase family protein +FIG01937118 HlyB family +FIG01937153 Galacturonosyl transferase +FIG01937463 uroporphyrinogen-III synthetase +FIG01937648 Chromosomal replication initiator protein dnaA +FIG01937668 protein of unknown function DUF1694 +FIG01937813 peptidase, M13 family (pepO) +FIG01937840 FIG00733172: hypothetical protein +FIG01937883 periplasmic nitrate reductase NapE +FIG01937907 probable microcin immunity protein +FIG01937916 Putative ring-cleavage dioxygenase +FIG01937937 DNA replication helicase DNA2 +FIG01938062 FIG00529635: hypothetical protein +FIG01938089 FIG00389801: hypothetical protein +FIG01938136 probable hydroxylase +FIG01938162 replicative DNA helicase( EC:3.6.1.- ) +FIG01938212 FIG00698722: hypothetical protein +FIG01938229 putative luciferase-like monooxygenase +FIG01938297 Caltractin (Centrin) +FIG01938299 hypothetical protein +FIG01938322 FIG00741833: hypothetical protein +FIG01938391 COG1123: ATPase components of various ABC-type transport systems, contain duplicated ATPase +FIG01938402 FIG00349062: hypothetical protein +FIG01938408 FIG01129886: hypothetical protein +FIG01938438 FIG00769832: hypothetical protein +FIG01938465 Trans-hexaprenyltranstransferase( EC:2.5.1.30 ) +FIG01938486 transmembrane protein MttP +FIG01938522 Leader peptidase (Prepilin peptidase) (EC 3.4.23.43) / N-methyltransferase (EC 2.1.1.-) +FIG01938656 aminotransferase class I and II +FIG01938669 Alpha-hemolysin family protein +FIG01938706 Glycine-rich protein precursor +FIG01938718 alpha-amylase, putative +FIG01938776 Foldase protein prsA precursor, putative( EC:5.2.1.8 ) +FIG01938822 phosphoglycerol transferase +FIG01938891 transglutaminase-like protein +FIG01938951 Cyanovirin-N (CV-N) +FIG01939018 Putative integrase/recombinase XerD +FIG01939069 carboxymuconolactone decarboxylase domain protein +FIG01939089 transposase-like protein B +FIG01939097 FIG00623164: hypothetical protein +FIG01939104 probable glycosyltransferase protein +FIG01939157 Beta-Ig-H3/fasciclin +FIG01939179 Precorrin-6B methylase 2-like protein +FIG01939208 response regulator/phosphatase +FIG01939273 FIG00623379: hypothetical protein +FIG01939282 putative ParB-like nuclease +FIG01939285 FIG00839630: hypothetical protein +FIG01939295 Cytochrome b561 homolog 2 +FIG01939298 FIG00344638: hypothetical protein +FIG01939357 similar to polyketide synthase +FIG01939453 conserved protein YvqG +FIG01939531 protein of unknown function DUF55 +FIG01939585 FIG00347921: hypothetical protein +FIG01939646 aminoglycoside nucleotidyltransferase +FIG01939831 putative gluconokinase +FIG01939945 NorM-like multidrug efflux protein +FIG01940066 FIG01240528: hypothetical protein +FIG01940261 Response sensor protein +FIG01940355 FIG01223733: hypothetical protein +FIG01940407 putative lipoprotein MlpA +FIG01940432 [Acyl-carrier protein] phosphodiesterase (EC 3.1.4.14) +FIG01940527 FIG00363751: hypothetical protein +FIG01940668 Predicted nucleoside phosphatase +FIG01940681 L-fucose isomerase, putative +FIG01940790 fdxN element excision controlling factor XisH +FIG01940840 similar to hydrolase +FIG01940842 putative monooxygenase protein +FIG01940956 protein of unknown function DUF1501 +FIG01941019 deoxyribonuclease gamma (precursor) +FIG01941069 FIG00356522: hypothetical protein +FIG01941084 possible metal-dependent amidohydrolase +FIG01941362 Integrase/recombinase XerD +FIG01941399 motif=sugar transport proteins signatures +FIG01941402 Competence protein ComEC/Rec2-related protein +FIG01941413 FIG00624394: hypothetical protein +FIG01941483 Chloride channel protein +FIG01941502 Foldase protein PrsA precursor (EC 5.2.1.8) +FIG01941578 ORF006 +FIG01941624 restriction enzyme, alpha subunit +FIG01941644 FIG01077519: hypothetical protein +FIG01941707 adventurous gliding motility protein U +FIG01941946 hydrolases of the alpha/beta superfamily +FIG01941958 YkuC +FIG01942008 nucleic acid-binding protein +FIG01942033 similar to Putative GTPases (G3E family) +FIG01942112 glutathione S-transferase-like protein +FIG01942306 IucA/IucC family protein +FIG01942372 S1/P1 nuclease +FIG01942461 FIG00734330: hypothetical protein +FIG01942564 prophage Lp1 protein 10 +FIG01942568 FIG00407232: hypothetical protein +FIG01942599 glycosyl hydrolases 38-like +FIG01942631 IS605 family transposase +FIG01942652 Carboxyphosphonoenolpyruvate phosphonomutase +FIG01942755 FIG00700330: hypothetical protein +FIG01942763 FIG00755701: hypothetical protein +FIG01942792 hypothetical surface-anchored protein +FIG01942910 hypothetical protein +FIG01943054 Uncharacterised protein family UPF0157 (COG2320) +FIG01943088 HtpB +FIG01943187 Choline O-acetyltransferase (EC 2.3.1.6) +FIG01943194 putative response receiver protein +FIG01943212 similar to NTPase (NACHT family) +FIG01943273 Uncharacterized protein aq_255 +FIG01943616 Pyruvate dehydrogenase complex repressor +FIG01943619 putative short chain dehydrogenase/oxidoreductase +FIG01943782 putative ATP-dependent protease ATP-binding subunit clpX'( EC:3.4.- ) +FIG01943802 Endo-1,4-beta-glucanase +FIG01943826 Free methionine-(R)-sulfoxide reductase, contains GAF domain +FIG01943932 Cytochrome c-type biogenesis protein CcsA/ResC +FIG01944075 FIG00564435: hypothetical protein +FIG01944104 DNA double-strand break repair rad50 ATPase +FIG01944181 FIG01117869: hypothetical protein +FIG01944238 IAA acetyltransferase +FIG01944321 FIG01252901: hypothetical protein +FIG01944340 putative reverse transcriptase +FIG01944438 FIG01007044: hypothetical protein +FIG01944539 FIG00741840: hypothetical protein +FIG01944549 protein of unknown function DUF1603 +FIG01944564 Hemerythrin HHE cation binding protein +FIG01944574 FIG00925282: hypothetical protein +FIG01944576 probable regulator of polyketide synthase expression +FIG01944648 K+ channel beta subunit +FIG01944698 Bll4862 protein +FIG01944749 FIG01126773: hypothetical protein +FIG01944774 hypothetical protein +FIG01944839 FIG01151749: hypothetical protein +FIG01944883 Fimbria associated protein +FIG01944900 Transposase for IS3509a +FIG01944961 Flagellar biosynthesis protein +FIG01944999 FIG00348015: hypothetical protein +FIG01945009 secreted protein Hcp +FIG01945077 Streptokinase (Fragment) +FIG01945129 FIG01122309: hypothetical protein +FIG01945296 Transposase, ISL2 +FIG01945373 2-isopropylmalate synthase( EC:2.3.3.13 ) +FIG01945531 FIG00646983: hypothetical protein +FIG01945541 plastocyanin +FIG01945583 Uncharacterized protein aq_1465 precursor +FIG01945735 Sigma54 specific transcriptional regulator, Fis family +FIG01945831 putative Pit accessory protein +FIG01945837 Putative phosphohistidine phosphatase (EC 3.1.3.-) +FIG01945874 Probable leucine/isoleucine/valine-binding protein +FIG01945896 Pectate lyase/Amb allergen +FIG01945912 dipeptide ABC transporter, periplasmic dipeptide-binding protein +FIG01945985 FIG00590176: hypothetical protein +FIG01945990 putative Beta-lactamase +FIG01946019 FIG00577989: hypothetical protein +FIG01946221 FIG00633770: hypothetical protein +FIG01946506 C4-dicarboxylate transport sensor protein dctS (EC 2.7.3.-) +FIG01946595 probable secreted solute-binding lipoprotein +FIG01946603 SMC protein-like +FIG01946686 Cache type 2 domain protein +FIG01946759 ABC-type multidrug transport system, ATPase component +FIG01946870 ORF_ID:alr7149 +FIG01947074 acetylxylan esterase (cephalosporin-C deacetylase)( EC:3.1.1.41 ) +FIG01947098 Esterase/lipase/thioesterase( EC:3.1.1.3 ) +FIG01947185 Adenine-specific methyltransferase (EC 2.1.1.72) +FIG01947273 outer membrane OmpA family protein +FIG01947412 cytidylyltransferase domain protein +FIG01947435 FIG00413928: hypothetical protein +FIG01947445 phosphoesterase( EC:3.1.- ) +FIG01947478 Glutamate transport system permease protein gluD +FIG01947576 FIG00385623: hypothetical protein +FIG01947593 HYBRID HISTIDINE KINASE +FIG01947680 L-arabinose ABC transporter (permease) +FIG01947681 similar to serine/threonine protein kinase( EC:2.7.1.- ) +FIG01947887 cytochrome b562 +FIG01947955 peptidase, M48B family( EC:3.4.- ) +FIG01947974 FIG00840683: hypothetical protein +FIG01947977 putative conserved dna-binding protein +FIG01948116 putative integrase for prophage CP-933U +FIG01948144 COG4572: Putative cation transport regulator +FIG01948172 FIG00405392: hypothetical protein +FIG01948335 doxorubicin biosynthesis enzyme DnrV +FIG01948373 Putative RNA polymerase sigma factor +FIG01948470 corresponds to STY1604 from Accession AL513382: Salmonella typhi CT18 +FIG01948521 IS1381, transposase OrfA +FIG01948623 hypothetical protein +FIG01948659 putative DNA integrase/recombinase +FIG01948711 Protein of unknown function DUF967 +FIG01948912 FIG01140165: hypothetical protein +FIG01948921 carboxylesterase precursor( EC:3.1.1.1 ) +FIG01948923 transposase mutator type +FIG01948933 FIG00803220: hypothetical protein +FIG01948959 Beta-ketoadipyl CoA thiolase +FIG01948967 cons hyp Pro/Syn (e-6) +FIG01949016 RecA-family ATPase-like protein +FIG01949050 SpoIIAA family protein +FIG01949052 FIG00347466: hypothetical protein +FIG01949145 FIG00865382: hypothetical protein +FIG01949191 FIG00733668: hypothetical protein +FIG01949198 truncated replication protein +FIG01949314 Peptidoglycan-associated protein +FIG01949419 COG2215: ABC-type uncharacterized transport system, permease component +FIG01949448 Protein of unknown function DUF302 +FIG01949449 FIG01001290: hypothetical protein +FIG01949481 TPR domain-containing protein +FIG01949501 putative phosphoesterase or phosphohydrolase +FIG01949566 protein of unknown function DUF1194 +FIG01949621 "Modification methylase HpaII " +FIG01949684 Type IV pilus biogenesis protein PilO +FIG01949722 probable c-type cytochrome precursor +FIG01949766 CheA signal transduction histidine kinases +FIG01949827 splicing factor proline/glutamine rich (polypyrimidine tract binding protein associated) +FIG01950089 macrolide efflux protein +FIG01950126 similar to membrane spanning export protein +FIG01950147 FIG01139167: hypothetical protein +FIG01950346 FIG01126036: hypothetical protein +FIG01950364 Acetoin utilization acuC protein +FIG01950392 FIG00631780: hypothetical protein +FIG01950448 FIG00572780: hypothetical protein +FIG01950496 two-component sensor PilS +FIG01950566 COG3247: Uncharacterized conserved protein +FIG01950682 lactoylglutathione lyase-related protein +FIG01950771 Vanillate O-demethylase oxygenase reductase component, predicted +FIG01950833 IS element transposase +FIG01951008 sugar transferase( EC:2.7.8.6 ) +FIG01951029 methylisocitrate lyase (prpB) +FIG01951075 Ribosome-associated heat shock protein implicated in the recycling of the 50S subunit (S4 paralog) +FIG01951102 FIG00346625: hypothetical protein +FIG01951205 Autotransporter beta-domain +FIG01951230 regulatory protein PupR, putative +FIG01951279 FIG01191024: hypothetical protein +FIG01951350 FIG00769321: hypothetical protein +FIG01951382 FIG00921389: hypothetical protein +FIG01951424 D-stereospecific aminopeptidase (EC 3.4.11.19) +FIG01951557 YD repeat-containing protein +FIG01951570 probable Cytochrome ba3-putative manganese transport protein mntH +FIG01951705 FIG00571470: hypothetical protein +FIG01951783 Probable two component response regulator transcription regulator protein +FIG01951806 fimbriae-associated protein, putative +FIG01951971 transcriptional factor MdcH +FIG01952107 protein of unknown function nitrogen fixation +FIG01952135 regulatory protein GntR, HTH:GntR, C-terminal +FIG01952237 FIG00406457: hypothetical protein +FIG01952285 hemimethylated DNA binding protein +FIG01952368 COG1538: Outer membrane protein +FIG01952369 insertion element transposase +FIG01952447 putative BfpG-like protein +FIG01952497 diheme cytochrome c +FIG01952502 sodium/bile acid symporter family protein +FIG01952594 AAA ATPase, central region (EC 2.7.7.7) +FIG01952673 FIG01150599: hypothetical protein +FIG01952858 probable beta-subunit of geranylgeranyltransferase or farnesyltransferase +FIG01952938 Putative transcriptional regulator, LysR family (N-terminal fragment), degenerate +FIG01952961 Protein of unknown function DUF1304 +FIG01953049 toxin secretion ABC transporter, ATP-binding subunit/permease protein, putative +FIG01953067 FIG00348145: hypothetical protein +FIG01953157 FIG00833787: hypothetical protein +FIG01953165 similar to Polyferredoxin +FIG01953246 O-GlcNAc transferase variant 1 +FIG01953314 thermostable carboxylesterase +FIG01953417 FIG00912394: hypothetical protein +FIG01953439 ABC transporter related +FIG01953486 FIG00556318: hypothetical protein +FIG01953586 FIG00586469: hypothetical protein +FIG01953598 probable stress response protein +FIG01953605 Exoribonuclease II( EC:3.1.13.1 ) +FIG01953669 Transglutaminase-like protein +FIG01953711 Shikimate kinase I (EC 2.7.1.71) / Chorismate mutase I (EC 5.4.99.5) +FIG01953726 Mg chelatase-related protein +FIG01953728 Competence protein ComM +FIG01953734 RNA methyltransferase, TrmH family, group 1 +FIG01953756 Predicted glycolate dehydrogenase, 2-subunit type (EC 1.1.99.14), iron-sulfur subunit GlcF +FIG01953760 L-fuconate dehydratase (EC 4.2.1.68), type 2 +FIG01953766 Allantoin racemase (EC 5.1.99.3) +FIG01953768 Similar to carbon monoxide oxidation accessory protein CoxG +FIG01953773 homoprotocatechuate 2,3-dioxygenase +FIG01953776 Phenanthrene-4,5-dicarboxylate 5-decarboxylase @ 3,4-dihydroxyphthalate decarboxylase +FIG01953785 hypothetical protein +FIG01953795 Hydrolase (HAD superfamily) +FIG01953799 NAD-reducing [Fe]-hydrogenase, cytoplasmic, beta subunit (EC 1.12.1.4) +FIG01953806 Putative structural protein +FIG01953807 FIG002813: hypothetical protein +FIG01953830 Capsule polysaccharide export inner-membrane protein +FIG01953831 Vi polysaccharide export inner-membrane protein vexD +FIG01953833 Phosphoglycerate mutase family +FIG01953834 Ammonia permease +FIG01953835 ACT-domain-containing protein, predicted allosteric regulator of homoserine dehydrogenase +FIG01953839 NifU-like domain protein +FIG01953843 Aminopyrrolnitrin oxidase PrnD +FIG01953852 Na(+) H(+) antiporter subunit G (TC 2.A.63.1.3) +FIG01953855 PTS system, galactose-inducible IIB component (EC 2.7.1.69) / PTS system, galactose-inducible IIC component (EC 2.7.1.69) +FIG01953864 RNA:NAD 2'-phosphotransferase, fragment +FIG01953879 Glycosyl transferase, family 2 +FIG01953891 2-acylglycerophosphoethanolamine acyltransferase (EC 2.3.1.40) / Acyl-[acyl-carrier-protein] synthetase (EC 6.2.1.20) +FIG01953893 Fibronectin binding protein FnbA +FIG01953895 Major facilitator family transporter +FIG01953897 Hydrogen-sensing hydrogenase large subunit (HoxC/HupV) +FIG01953904 Phage lysin, L-alanyl-D-glutamate peptidase (EC 3.4.-.-) +FIG01953915 putative Cytochrome bd2, subunit II / Cyanide insensitive terminal oxidase, subunit II +FIG01953920 Re face-specific citrate synthase (EC 2.3.3.3) +FIG01953927 Hypothetical similar to heme lyase subunit CcmH, colocalized with sarcosine oxidase +FIG01953929 2-oxoglutarate oxidoreductase, gamma subunit (EC 1.2.7.3) +FIG01953930 Siderophore staphylobactin ABC transporter, permease protein SirB +FIG01953931 Iron compound ABC uptake transporter permease protein PiaC +FIG01953937 Iron compound ABC uptake transporter substrate-binding protein PiaA +FIG01953939 cyclolysin-activating lysine-acyltransferase +FIG01953944 2-chlorobenzoate 1,2-dioxygenase beta subunit (EC 1.14.12.13) +FIG01953952 Homolog of E. coli HemX protein +FIG01953957 Hypothetical protein PvdY @ Siderophore synthetase small component, acetyltransferase +FIG01953959 O-antigen export system, permease protein +FIG01953960 Hemophore HasA outer membrane receptor HasR +FIG01953971 Ferric vibriobactin, enterobactin transport system, permease protein VctG (TC 3.A.1.14.6) +FIG01953973 Iron compound ABC uptake transporter ATP-binding protein PiuD +FIG01953974 Iron compound ABC transporter, ATP-binding protein +FIG01953977 Ferric vibriobactin, enterobactin transport system, ATP-binding protein (TC 3.A.1.14.6) +FIG01953978 Catechol siderophore ABC transporter, ATP-binding component +FIG01953986 DMSP demethylase EC 2.1.2.10 +FIG01953992 Ribosomal silencing factor RsfA (former Iojap) +FIG01953993 Nicotinate-nucleotide adenylyltransferase (EC 2.7.7.18) / Ribosomal silencing factor RsfA (former Iojap) +FIG01953994 Probable exosome complex exonuclease 2 (EC 3.1.13.-) +FIG01953996 Long-chain fatty-acid-CoA ligase (EC 6.2.1.3), Mycobacterial subgroup FadD6 +FIG01954004 Transcriptional regulator YqhC, positively regulates YqhD and DkgA +FIG01954013 glycogen debranching enzyme-related protein +FIG01954015 Mg(2+) Citrate transporter (TC 2.A.11.1.1) +FIG01954022 quinoprotein alcohol dehydrogenase +FIG01954028 Transcriptional regulator +FIG01954035 DgcA Dimethylglycine demethylase subunit A +FIG01954041 Probable acetyl/propionyl-CoA carboxylase alpha subunit (EC 6.3.4.14) +FIG01954061 Putative membrane protein +FIG01954071 Fumarate reductase flavoprotein subunit (EC 1.3.99.1); Probable Flavocytochrome c , subunit fusion && probably related to thiamine biosynthesis or metabolism +FIG01954074 oxidoreductase, aldo/keto reductase family +FIG01954075 Lin2022 protein +FIG01954080 Probable arabinosyltransferase A (EC 2.4.2.-) +FIG01954081 Acyl-CoA dehydrogenase (EC 1.3.8.7) +FIG01954082 Acyl-CoA dehydrogenase (EC 1.3.8.7) +FIG01954087 AMP-binding domain protein +FIG01954090 Heavy-Metal transporting ATPase +FIG01954092 Quinohemoprotein amine dehydrogenase 60 kDa subunit +FIG01954096 putative ThiJ family intracellular protease +FIG01954097 Dipeptide transport system permease protein DppB (TC 3.A.1.5.2) +FIG01954100 Acyl-CoA dehydrogenase (EC 1.3.8.7) +FIG01954103 "Periplasmic aromatic aldehyde oxidoreductase, molybdenum binding subunit YagR @ 4-hydroxybenzoyl-CoA reductase, alpha subunit " +FIG01954108 Flavodoxin reductases (ferredoxin-NADPH reductases) family 1 +FIG01954109 D-beta-hydroxybutyrate dehydrogenase (EC 1.1.1.30) +FIG01954112 Mll0508 protein +FIG01954116 Cyclopropane-fatty-acyl-phospholipid synthase +FIG01954121 Phage minor head protein +FIG01954122 Oxidoreductase, aldo-keto reductase family +FIG01954125 tRNA (5-methylaminomethyl-2-thiouridylate)-methyltransferase (EC 2.1.1.61) +FIG01954148 Alkan-1-ol dehydrogenase, PQQ-dependent (EC 1.1.99.20) +FIG01954155 Inositol transport system permease protein +FIG01954162 Hemolysin III +FIG01954163 N-acetylmuramoyl-L-alanine amidase, family 2 (EC 3.5.1.28) +FIG01954166 COG1576: Uncharacterized conserved protein +FIG01954180 tRNA (adenine37-N(6))-methyltransferase TrmN6 (EC 2.1.1.223) +FIG01954182 Putative dioxygenase, alpha subunit (EC 1.-.-.-); Choline monooxygenase, alpha subunit (EC 1.14.15.7) +FIG01954187 Acetyl-CoA:acetoacetyl-CoA transferase alpha subunit (EC 2.8.3.-) +FIG01954192 HflK protein paralog among fluorescent pseudomonads +FIG01954198 Outer membrane lipoprotein precursor, OmpA family +FIG01954207 Vanillin dehydrogenase (Hydroxybenzaldehyde dehydrogenase) (EC 1.2.1.28) +FIG01954213 FIG053235: Diacylglucosamine hydrolase like +FIG01954219 DMSP demthylase transcriptional regulator +FIG01954224 Uricase (EC 1.7.3.3) +FIG01954225 UPF0313 protein ygiQ +FIG01954227 small molecule metabolism; fatty acid biosynthesis +FIG01954230 Putative electron transport protein YsaA +FIG01954234 Anti-sigma regulatory factor (Ser/Thr protein kinase) +FIG01954236 Phage replication initiation protein +FIG01954238 Phosphoserine phosphatase rsbX (EC 3.1.3.3) +FIG01954244 putative polysialic acid transport protein +FIG01954245 ABC transporter membrane-spanning permease, Pep export, Vex1 +FIG01954253 NLP/P60 family lipoprotein +FIG01954258 Transposase KPN_02656 +FIG01954260 Arylsulfatase regulator (Fe-S oxidoreductase) +FIG01954261 Hydrolase (HAD superfamily) +FIG01954263 unknown protein encoded within prophage CP-933V +FIG01954264 POSSIBLE METHYLTRANSFERASE (METHYLASE) +FIG01954266 AMP-binding domain protein +FIG01954267 Uncharacterized protein YfcI +FIG01954268 hypothetical protein +FIG01954271 Acyl-CoA dehydrogenase (EC 1.3.8.7) +FIG01954273 FIG053235: Diacylglucosamine hydrolase like +FIG01954278 Periplasmic aromatic aldehyde oxidoreductase, molybdenum binding subunit YagR @ 4-hydroxybenzoyl-CoA reductase, alpha subunit (EC 1.3.99.20) +FIG01954280 4-methyl-5(B-hydroxyethyl)-thiazole monophosphate biosynthesis enzyme +FIG01954284 Transposase KPN_00447 +FIG01954287 3-methylmercaptopropionyl-CoA dehydrogenase (DmdC) +FIG01954288 Probable VANILLIN dehydrogenase oxidoreductase protein (EC 1.-.-.-) +FIG01954293 Acyl-CoA dehydrogenase, short-chain specific (EC 1.3.8.1) +FIG01954294 FIG053235: Diacylglucosamine hydrolase like +FIG01954298 medium-chain-fatty-acid--CoA ligase +FIG01954301 Epoxyqueuosine (oQ) reductase QueG +FIG01954304 Putative Rieske protein +FIG01954306 Methyltransferase corrinoid activation protein Rsph17029_1409 +FIG01954307 Transposase +FIG01954308 FIG000506: Predicted P-loop-containing kinase +FIG01954310 hypothetical protein +FIG01954319 HEAT repeat-containing protein +FIG01954320 Sodium/glutamine symporter glnT +FIG01954324 Acyl-CoA dehydrogenase (EC 1.3.8.7) +FIG01954334 Arylsulfatase regulator (Fe-S oxidoreductase) +FIG01954336 Acyl-CoA dehydrogenase (EC 1.3.8.7) +FIG01954341 Acyl-CoA dehydrogenase (EC 1.3.8.7) +FIG01954345 Quinohemoprotein amine dehydrogenase 40 kDa subunit +FIG01954350 Uncharacterized isomerase yddE, PhzC-PhzF family +FIG01954353 Acyl-CoA dehydrogenase (EC 1.3.99.-) +FIG01954358 FIG053235: Diacylglucosamine hydrolase like +FIG01954363 Probable AMP-binding enzyme +FIG01954366 FIG002813: LPPG:FO 2-phospho-L-lactate transferase like, CofD-like +FIG01954377 Epoxyqueuosine (oQ) reductase QueG +FIG01954382 AMP-binding domain protein +FIG01954384 Uncharacterized isomerase yddE, PhzC-PhzF family +FIG01954390 5-aminopentanamidase (EC 3.5.1.30) / Aliphatic amidase AmiE (EC 3.5.1.4) +FIG01954412 TonB family protein / TonB-dependent receptor +FIG01954413 Siderophore biosynthesis non-ribosomal peptide synthetase modules @ Bacillibactin synthetase component F (EC 2.7.7.-) +FIG01954415 Glycine betaine ABC transport system permease protein +FIG01954418 Bacitracin synthetase 3 (BA3) [Includes: ATP-dependent isoleucine adenylase (IleA) (Isoleucine activase); ATP-dependent D-phenylalanine adenylase (D-PheA) (D-phenylalanine activase); ATP-dependent histidine adenylase (HisA) (Histidine activase); ATP-dependent D-aspartate adenylase (D-AspA) (D-aspartate activase); ATP-dependent asparagine adenylase (AsnA) (Asparagine activase); Aspartate racemase (EC 5.1.1.13); Phenylalanine racemase [ATP hydrolyzing] (EC 5.1.1.11)] +FIG01954419 Iron(III) dicitrate transport protein FecA @ Iron siderophore receptor protein +FIG01954426 Glutamine-dependent 2-keto-4-methylthiobutyrate transaminase / Aspartate/tyrosine/aromatic aminotransferase +FIG01954434 Shikimate DH-like protein associated with RibB / Shikimate 5-dehydrogenase I alpha (EC 1.1.1.25) +FIG01954451 GTP-binding protein Obg +FIG01954455 Metal-dependent hydrolase YbeY, involved in rRNA and/or ribosome maturation and assembly +FIG01954457 Putative efflux protein in 2-methylcitrate synthase cluster; Homoserine/threonine efflux protein +FIG01954458 Homoserine/threonine efflux protein +FIG01954464 ABC1 family protein +FIG01954472 Ferrochelatase, protoheme ferro-lyase (EC 4.99.1.1) / Hemoprotein HemQ, essential component of heme biosynthetic pathway in Gram-positive bacteria +FIG01954482 Exodeoxyribonuclease IX (EC 3.1.11.-) +FIG01954487 Homoserine dehydrogenase +FIG01954488 DnaA regulatory inactivator Hda (Homologous to DnaA) +FIG01954490 Protein:protein lipoyl transferase +FIG01954496 Cyanobacterial polyprenyltransferase (UbiA homolog) +FIG01954502 UbiD family decarboxylase +FIG01954506 UbiX family decarboxylase Gmet_2105 +FIG01954509 tRNA (adenine-N(6)-)-methyltransferase +FIG01954514 2-octaprenyl-3-methyl-6-methoxy-1,4-benzoquinol hydroxylase (EC 1.14.13.-) +FIG01954522 Thiamine biosynthesis protein thiI +FIG01954533 Phosphocarrier protein of PTS system +FIG01954543 Uncharacterized protein EC-HemY, likely associated with heme metabolism based on gene clustering with hemC, hemD in Proteobacteria (unrelated to HemY-type PPO in GramPositives) +FIG01954552 Biotin-protein ligase (EC 6.3.4.15) +FIG01954554 Peptidyl-prolyl cis-trans isomerase ppiB (EC 5.2.1.8) +FIG01954564 molecular chaperone +FIG01954570 N-acetylgalactosamine 6-sulfate sulfatase (GALNS) +FIG01954571 GCN5-related N-acetyltransferase +FIG01954579 Ribonuclease J1 (endonuclease and 5' exonuclease) +FIG01954580 Ribonuclease J1 (endonuclease and 5' exonuclease) +FIG01954585 Type cbb3 cytochrome oxidase biogenesis protein CcoI; Copper-translocating P-type ATPase (EC 3.6.3.4); FUPA29 P-type ATPase +FIG01954594 F0F1 ATP synthase subunit I +FIG01954595 Acetyl-CoA acetyltransferase (EC 2.3.1.9) / Hydroxymethylglutaryl-CoA reductase (EC 1.1.1.34) +FIG01954607 Possible bifunctional enzyme: 2-hydroxyhepta-2,4-diene-1,7-dioate isomerase + cyclase/dehydrase (EC 5.3.3.-) +FIG01954608 Recombination protein RecU +FIG01954609 Allantoin racemase (EC 5.1.99.3) +FIG01954611 Alanine racemase, biosynthetic (EC 5.1.1.1) +FIG01954612 Alanine racemase (EC 5.1.1.1) +FIG01954615 Alanine racemase, catabolic (EC 5.1.1.1) +FIG01954616 Alanine racemase (EC 5.1.1.1) +FIG01954617 two-component hybrid sensor and regulator +FIG01954630 Acetyltransferase, CysE/LacA/LpxA/NodL family +FIG01954644 Outer membrane lipoprotein LolB precursor +FIG01954651 Phosphomannomutase (EC 5.4.2.8); Phosphoglucosamine mutase (EC 5.4.2.10) +FIG01954657 Sirohydrochlorin cobaltochelatase CbiK (EC 4.99.1.3) / Cobalt-precorrin-2 C20-methyltransferase (EC 2.1.1.130) +FIG01954659 Capsular polysaccharide synthesis enzyme Cap5C; Manganese-dependent protein-tyrosine phosphatase (EC 3.1.3.48) +FIG01954665 IncP-type conjugative transfer protein TrbJ +FIG01954666 Functional role page for TorCAD operon transcriptional regulatory protein TorR +FIG01954669 IncP-type conjugative transfer protein TrbI +FIG01954672 IncP-type conjugative transfer protein TrbE +FIG01954677 IncP-type conjugative transfer protein TrbG +FIG01954687 IncP-type conjugative transfer protein TrbL +FIG01954688 Membrane-associated zinc metalloprotease / Metalloprotease Eep, required for pheromone maturation +FIG01954690 protein of hypothetical function UPF0052 and CofD +FIG01954692 Inner membrane protein translocase component YidC, short form OxaI-like +FIG01954693 Inner membrane protein translocase component YidC, OxaA protein +FIG01954695 ProX +FIG01954697 ATP-dependent RNA helicase YejH +FIG01954698 IncP-type conjugative transfer protein TrbB +FIG01954699 NADPH-dependent broad range aldehyde dehydrogenase YqhD +FIG01954700 Hypothetical lysR-family transcriptional regulator YdhB +FIG01954710 N5-glutamine S-adenosyl-L-methionine-dependent methyltransferase +FIG01954717 Putative esterase/lipase ybfF (EC 3.1.-.-) +FIG01954733 LarE: implicated in lactate racemization +FIG01954736 Omega amidase (Nit2 homolog) +FIG01954752 Possible hydrolase or acyltransferase RutD in novel oxidative pyrimidine catabolism pathway +FIG01954753 Thiosulfate sulfurtransferase, rhodanese (EC 2.8.1.1) +FIG01954755 3-mercaptopyruvate sulfurtransferase (EC 2.8.1.2) +FIG01954759 Carbohydrate Esterase Family 4 +FIG01954769 putative glycosyl transferase +FIG01954773 ATP-dependent RNA helicase DbpA +FIG01954776 GntR family transcriptional regulator YdcR @ Transcriptional regulator, GntR family domain +FIG01954777 GntR family transcriptional regulator SAV0108 @ Transcriptional regulator, GntR family domain +FIG01954778 GntR family transcriptional regulator SAR2593 @ Transcriptional regulator, GntR family domain +FIG01954780 GntR family transcriptional regulator Atu0235 @ Transcriptional regulator, GntR family domain +FIG01954781 GntR family transcriptional regulator Dvul_2931 @ Transcriptional regulator, GntR family domain +FIG01954784 GntR family transcriptional regulator Bsu0357 (YcxD) @ Transcriptional regulator, GntR family domain +FIG01954794 Osmoprotectant ABC transporter inner membrane protein YehW +FIG01954797 Methyl-accepting chemotaxis protein +FIG01954802 Nitrogen-fixing NifU domain protein +FIG01954816 IncP-type conjugative transfer protein TrbD +FIG01954818 2-heptaprenyl-1,4-naphthoquinone methyltransferase MenG of phylloquinone biosynthesis (EC 2.1.1.-) +FIG01954826 Para-aminobenzoate synthase, amidotransferase component (EC 6.3.5.8) / Para-aminobenzoate synthase, aminase component (EC 6.3.5.8) +FIG01954830 Uncharacterized transcriptional regulator YfaX, HTH-type +FIG01954831 Enoyl-[acyl-carrier-protein] reductase [FMN] (EC 1.3.1.9) +FIG01954833 Oxaloacetate decarboxylase, divalent-cation-dependent (EC 4.1.1.3) +FIG01954840 Tetracycline resistance protein TetP +FIG01954846 DNA polymerase III epsilon subunit-related protein MSMEG4261 +FIG01954849 Hypothetical protein Fjoh_1965 +FIG01954850 Exonuclease domain protein +FIG01954854 ABC transporter, ATP-binding protein +FIG01954866 DNA polymerase III alpha subunit (EC 2.7.7.7); DNA polymerase III epsilon chain (EC 2.7.7.7) +FIG01954878 Biotin synthesis protein BioK +FIG01954897 ATP-dependent protease ATP-binding subunit ClpC2 +FIG01954901 Periplasmic binding protein-related protein +FIG01954905 dipeptide transporter ATP-binding subunit +FIG01954907 Coenzyme PQQ synthesis protein F (EC 3.4.99.-) +FIG01954914 Peptidase M20D, amidohydrolase +FIG01954918 Putative permease often clustered with de novo purine synthesis +FIG01954925 Putative phage tail protein +FIG01954933 Capsular polysaccharide synthesis enzyme Cap5G; UDP-N-acetylglucosamine 2-epimerase (EC 5.1.3.14) +FIG01954934 Capsular polysaccharide synthesis enzyme Cap8G; UDP-N-acetylglucosamine 2-epimerase (EC 5.1.3.14) +FIG01954935 FKBP-type peptidyl-prolyl cis-trans isomerase slpA (EC 5.2.1.8) +FIG01954945 Biotin synthesis protein BioZ +FIG01954946 UDP-N-acetylglucosamine 4-epimerase (EC 5.1.3.7) +FIG01954949 Phosphonate ABC transporter ATP-binding protein (TC 3.A.1.9.1) +FIG01954958 DNA-binding protein HU +FIG01954966 xanthine permease family protein +FIG01954969 Aspartate-semialdehyde dehydrogenase +FIG01954971 aspartate-semialdehyde dehydrogenase( EC:1.2.1.11 ) +FIG01954973 2-dehydro-3-deoxy-L-rhamnonate aldolase (EC 4.1.2.n3) +FIG01954984 Methyltransferase type 12 +FIG01954985 hypothetical protein +FIG01954987 Serine/threonine-protein kinase PknB (EC 2.7.11.1) +FIG01954989 putative ethanolamine utilization protein EutN +FIG01954999 Thioredoxin +FIG01955004 RD1 region associated protein Rv3865 +FIG01955008 Major pilus subunit of type IV secretion complex, VirB2 +FIG01955011 Hypothetical protein DUF454 +FIG01955012 Biotin synthesis protein BioG / Biotin synthesis protein BioC +FIG01955029 Protein EspH, component of Type VII secretion system ESX-1 +FIG01955032 Hypothetical protein in pyoverdin gene cluster, PA2406 homolog +FIG01955033 Biotin synthesis protein BioC / Dethiobiotin synthetase (EC 6.3.3.3) +FIG01955037 Branched-chain amino acid aminotransferase (EC 2.6.1.42) / Aminodeoxychorismate lyase (EC 4.1.3.38) +FIG01955038 Serine palmitoyltransferase (EC 2.3.1.50) +FIG01955039 Pyridoxal phosphate (PLP)-dependent aspartate aminotransferase +FIG01955050 CRISPR-associated RAMP Cmr1 / Nucleotidyltransferase (EC 2.7.7.-) +FIG01955052 D-amino acid dehydrogenase small subunit (EC 1.4.99.1) / Alanine racemase (EC 5.1.1.1) +FIG01955057 Chorismate mutase I (EC 5.4.99.5) +FIG01955058 Isochorismate pyruvate-lyase (EC 4.-.-.-) [pyochelin] siderophore +FIG01955070 IncP-type conjugative transfer protein TrbM +FIG01955071 Streptomycin 3''-O-adenylyltransferase (EC 2.7.7.47); Spectinomycin 9-O-adenylyltransferase +FIG01955074 Protoporphyrinogen IX oxidase, aerobic (EC 1.3.3.4) +FIG01955079 Prephenate and/or arogenate dehydrogenase (unknown specificity) (EC 1.3.1.12)(EC 1.3.1.43) / Chorismate mutase I (EC 5.4.99.5) / Prephenate dehydratase (EC 4.2.1.51) +FIG01955081 PhoH-like protein +FIG01955085 Cu+ P-type ATPase +FIG01955092 Sirohydrochlorin cobaltochelatase (EC 4.99.1.3) / Uroporphyrinogen-III methyltransferase (EC 2.1.1.107) +FIG01955093 2,3-dihydroxyphenylpropionate 1,2-dioxygenase (EC 1.13.11.-) +FIG01955094 Similar to coproporphyrinogen III oxidase, oxygen-independent (EC 1.3.99.22) +FIG01955100 IncP-type conjugative transfer protein TrbA +FIG01955105 FIG137478: Hypothetical protein YbgI +FIG01955111 Peptidyl-prolyl cis-trans isomerase ppiA precursor (EC 5.2.1.8) +FIG01955114 Molybdenum transport ATP-binding protein ModC (TC 3.A.1.8.1) +FIG01955117 IncP-type conjugative transfer protein TrbN +FIG01955119 Ribose 5-phosphate isomerase B (EC 5.3.1.6) / 3-demethylubiquinone-9 3-methyltransferase (EC 2.1.1.64) +FIG01955120 Cyclohexadienyl dehydrogenase (EC 1.3.1.12)(EC 1.3.1.43) / 5-Enolpyruvylshikimate-3-phosphate synthase (EC 2.5.1.19) +FIG01955124 IncP-type conjugative transfer protein TrbC +FIG01955125 Alkyl hydroperoxide reductase subunit C-like protein +FIG01955127 Anthranilate synthase, amidotransferase component (EC 4.1.3.27) +FIG01955131 Chorismate mutase I (EC 5.4.99.5) / Cyclohexadienyl dehydrogenase (EC 1.3.1.12)(EC 1.3.1.43) +FIG01955139 Anthranilate synthase, aminase component (EC 4.1.3.27) / Anthranilate synthase, amidotransferase component (EC 4.1.3.27) @ Para-aminobenzoate synthase, amidotransferase component (EC 6.3.5.8) +FIG01955141 Iron compound ABC transporter, ATP-binding protein +FIG01955148 Heme-degrading cytoplasmic oxygenase IsdG +FIG01955153 Inactive homolog of metal-dependent proteases, putative molecular chaperone / Ribosomal-protein-S18p-alanine acetyltransferase (EC 2.3.1.-) / YgjD/Kae1/Qri7 family, required for threonylcarbamoyladenosine (t(6)A) formation in tRNA +FIG01955155 FIG00945233: hypothetical protein +FIG01955161 Long-chain fatty-acid-CoA ligase (EC 6.2.1.3), Mycobacterial subgroup FadD35 +FIG01955165 VWA containing CoxE family protein +FIG01955166 Putative iron-regulated membrane protein, PA2403 homolog +FIG01955167 LysR family transcriptional regulator YiaU +FIG01955168 FIG137877: Hypothetical protein in pyoverdin gene cluster +FIG01955169 IncP-type conjugative transfer protein TrbF +FIG01955175 Peptidyl-prolyl cis-trans isomerase ppiC (EC 5.2.1.8) +FIG01955176 Probable aromatic ring hydroxylating enzyme, evidenced by COGnitor; PaaD-like protein (DUF59) involved in Fe-S cluster assembly +FIG01955177 Phenazine biosynthesis protein PhzC @ 2-keto-3-deoxy-D-arabino-heptulosonate-7-phosphate synthase II PhzC (EC 2.5.1.54) @ 2-keto-3-deoxy-D-arabino-heptulosonate-7-phosphate synthase II (EC 2.5.1.54) +FIG01955195 Putative thiamine pyrophosphate-requiring enzyme, PA2404 homolog +FIG01955196 IncP-type conjugative transfer protein TrbP +FIG01955200 Thiamine biosynthesis protein thiI-like +FIG01955205 FIG002082: Protein sirB2 +FIG01955211 Phenazine biosynthesis protein PhzE +FIG01955219 Thioredoxin +FIG01955222 RNA pseudouridylate synthase BT0642 +FIG01955225 IncP-type conjugative transfer protein TrbO +FIG01955234 S4-domain-containing heat shock protein; S4-domain-containing heat shock protein +FIG01955238 UPF0135 protein Bsu YqfO @ Bsu YqfO NIF3/CutA domain +FIG01955243 Para-aminobenzoate synthase, aminase component (EC 6.3.5.8) +FIG01955245 Tyrosyl-tRNA synthetase (EC 6.1.1.1) +FIG01955247 ABC transporter ATP-binding protein +FIG01955249 NifU protein homolog +FIG01955253 Magnesium transporter +FIG01955255 Nitrogen-fixing NifU domain protein +FIG01955257 Thioredoxin-like proteins and domains +FIG01955258 Bll0800 protein +FIG01955262 Phage lysozyme +FIG01955265 16S RNA G1207 methylase RsmC +FIG01955269 nifU protein, putative +FIG01955289 Oxidoreductase, short-chain dehydrogenase/reductase family (EC 1.1.1.-) +FIG01955292 Phage major tail sheath protein +FIG01955293 Endonuclease I precursor (EC 3.1.21.1) @ Extracellular deoxyribonuclease Dns (EC 3.1.21.-) +FIG01955298 Para-aminobenzoate synthase, amidotransferase component (EC 6.3.5.8) +FIG01955303 putative xanthine/uracil permeases family protein +FIG01955304 Xanthine/uracil/thiamine/ascorbate permease family protein +FIG01955305 N-acetyl-L,L-diaminopimelate aminotransferase homolog +FIG01955314 Bacteriophage-encoded homolog of DNA replication protein DnaC +FIG01955315 POSSIBLE FATTY-ACID-COA LIGASE FADD16 (FATTY-ACID-COA SYNTHETASE) (FATTY-ACID-COA SYNTHASE) +FIG01955318 Multifunctional mycocerosic acid synthase membrane-associated mas (Multi-functional membrane-associated mycocerosic acid synthase mas) +FIG01955322 Hypothetical ATP-binding protein UPF0042, contains P-loop +FIG01955326 4-amino, 4-deoxyprephenate dehydrogenase +FIG01955327 Oligopeptide transport system permease protein OppD (TC 3.A.1.5.1) +FIG01955330 Proton/glutamate symport protein @ Sodium/glutamate symport protein +FIG01955333 Hydrolase, alpha/beta fold family protein +FIG01955336 Putative electron transport protein YsaA +FIG01955338 C-terminal domain of CinA, fragment of +FIG01955341 Ribosomal RNA small subunit methyltransferase C (EC 2.1.1.52) +FIG01955346 Exodeoxyribonuclease IX (EC 3.1.11.-) +FIG01955350 Putative permease, ortholog yfkN B.subtilis +FIG01955351 Bacillus phage RNA polymerase sigma factor (SigF-like) +FIG01955352 COG0028: Thiamine pyrophosphate-requiring enzymes +FIG01955374 Adenylylsulfate reductase alpha-subunit (EC 1.8.99.2) / HEAT repeat-containing protein +FIG01955377 Maltose oligosaccharide ABC transporter, permease protein MalG1 +FIG01955414 PLP-dependent enzyme +FIG01955415 Nicotinate-nucleotide--dimethylbenzimidazole phosphoribosyltransferase (EC 2.4.2.21) / Adenosylcobinamide-phosphate guanylyltransferase (EC 2.7.7.62) +FIG01955418 Inner membrane transport protein YfaV +FIG01955421 nudix hydrolase, YffH family +FIG01955426 Candidate substrate-specific domain of ECF transporters in Mycobacteria / Duplicated ATPase component of energizing module of predicted ECF transporter in Mycobacteria / Transmembrane component of energizing module of ECF transporters in Mycobacteria +FIG01955428 Aspartate/tyrosine/aromatic aminotransferase +FIG01955442 Octaprenyl-diphosphate synthase (EC 2.5.1.-) +FIG01955456 Uracil DNA glycosylase +FIG01955457 L-serine dehydratase (EC 4.3.1.17) +FIG01955462 Uracil phosphoribosyltransferase (EC 2.4.2.9) / Pyrimidine operon regulatory protein pyrR +FIG01955471 Portal protein +FIG01955473 Predicted glycolate dehydrogenase, 2-subunit type (EC 1.1.99.14), iron-sulfur subunit GlcF +FIG01955479 S4-domain-containing heat shock protein +FIG01955482 Aconitate hydratase 2 (EC 4.2.1.3) +FIG01955489 putative ferredoxin +FIG01955491 N-terminal domain of CinA protein, COG1058 / C-terminal domain of CinA type E +FIG01955499 Na(+) H(+) antiporter subunit A; NADH-ubiquinone oxidoreductase chain L (EC 1.6.5.3) +FIG01955501 polysaccharide biosynthesis protein +FIG01955504 Putative translation initiation inhibitor, YjgF family +FIG01955506 FIG002343: hypothetical protein-2 +FIG01955514 Anthranilate dioxygenase reductase +FIG01955516 general L-amino acid transport ATP-binding protein aapP +FIG01955519 Uncharacterized protein YgeA of aspartate/glutamate/hydantoin racemase family +FIG01955521 Di-/tripeptide transporter +FIG01955529 Glycosyl transferase, family 2 +FIG01955551 tail fiber assembly protein +FIG01955554 leucine-specific binding protein +FIG01955557 ribitol-5-phosphate cytidylyltransferase (EC 2.7.7.40) +FIG01955561 Outer membrane chaperone Skp (OmpH) precursor @ Outer membrane protein H precursor +FIG01955567 TonB-dependent receptor; Outer membrane receptor for ferrienterochelin and colicins +FIG01955570 Anthranilate synthase, amidotransferase component (EC 4.1.3.27) / Para-aminobenzoate synthase, amidotransferase component like (EC 6.3.5.8) +FIG01955576 Biotin synthesis protein BioH +FIG01955585 Transcriptional regulator YqhC, positively regulates YqhD and DkgA +FIG01955588 Modification methylase, HemK family (EC 2.1.1.72) +FIG01955595 Cysteine desulfurase (EC 2.8.1.7); Selenocysteine lyase( EC:4.4.1.16 ) subunit +FIG01955598 Novel D-tagaturonate epimerase +FIG01955599 Para-aminobenzoate synthase, aminase component (EC 6.3.5.8) / Para-aminobenzoate synthase, amidotransferase component (EC 6.3.5.8) +FIG01955601 Para-aminobenzoate synthase, amidotransferase component (EC 6.3.5.8) @ Anthranilate synthase, amidotransferase component (EC 4.1.3.27) +FIG01955602 Putative electron transport protein YsaA +FIG01955605 Putative polyamine transporter; +FIG01955606 Heme-degrading cytoplasmic oxygenase IsdI +FIG01955626 Cytoplasmic axial filament protein CafA and Ribonuclease G (EC 3.1.4.-) @ Ribonuclease E (EC 3.1.26.12) +FIG01955643 Putative transposase, YhgA family protein +FIG01955645 """3,4-dihydroxy-2-butanone 4-phosphate synthase (EC 4.1.99.12) / GTP cyclohydrolase II (EC 3.5.4.25)""" +FIG01955655 ATP-dependent efflux pump essential for phthiocerol dimycocerosates translocation, integral membrane protein DrrB-like +FIG01955660 rhamnose-containing polysacharide translocation permease +FIG01955663 2-ketocyclohexanecarboxyl-CoA hydrolase (EC 4.1.3.36) +FIG01955665 PPO candidate 1 +FIG01955668 Acyl-CoA dehydrogenase (EC 1.3.8.7) +FIG01955674 Uncharacterized isomerase yddE, PhzC-PhzF family +FIG01955680 Hypothetical sugar ABC transporter TM1149, permease protein +FIG01955685 Outer membrane protein X precursor +FIG01955689 Glutamyl-tRNA(Gln) amidotransferase subunit A (EC 6.3.5.7) +FIG01955690 fatty-acid-CoA ligase FadD32 +FIG01955692 Anaerobic selenate reductase, molybdenum cofactor-containing periplasmic protein +FIG01955693 N-acetylgalactosamine-6-phosphate deacetylase (EC 3.5.1.25) +FIG01955694 Conjugative transposon protein TraM +FIG01955695 Beta-galactosidase (EC 3.2.1.23), LacZ family +FIG01955699 Homolog of anaerobic selenate reductase +FIG01955700 Predicted rhamnose oligosaccharide ABC transporter, permease component 2 +FIG01955701 Acetyl-CoA C-acyltransferase (EC 2.3.1.16); Acetyl-CoA acetyltransferase (EC 2.3.1.9) +FIG01955703 Long-chain fatty-acid-AMP ligase, Mycobacterial subgroup FadD29 +FIG01955704 Similar to tRNA pseudouridine synthase C, group TruC2 +FIG01955705 ABC transport system, permease protein Z5690 +FIG01955706 Galactose oligosaccharide ABC transporter, substrate binding protein +FIG01955707 Nitrogenase (vanadium-iron) reductase and maturation protein VnfH +FIG01955709 Maltose/maltodextrin ABC transporter 2, substrate binding periplasmic protein MalE2 +FIG01955712 IncH1 plasmid conjugative transfer pilus assembly protein TrhB +FIG01955714 Histidinol-phosphate aminotransferase (EC 2.6.1.9) @ Aspartate aminotransferase (EC 2.6.1.1) +FIG01955715 Light-harvesting LHII, beta subunit C +FIG01955717 Similar to tRNA pseudouridine synthase A, group TruA2 +FIG01955718 Chorismate mutase I (EC 5.4.99.5) / EPT-like Enolpyruvate transferase (EPSP synthase-like (EC 2.5.1.19)) +FIG01955720 IncH1 plasmid conjugative transfer pilin precursor TrhA +FIG01955721 IncH1 plasmid conjugative transfer pilus assembly protein TrhK +FIG01955722 Hypothetical sugar ABC transporter TM1150, substrate-binding protein +FIG01955724 Putative phosphoglycolate phosphatase (EC 3.1.3.18 ) +FIG01955726 Beta-mannan and fructose induced hypothetical ABC transporter, periplasmic oligopeptide-binding protein +FIG01955730 Topoisomerase IV subunit B (EC 5.99.1.-) / Topoisomerase IV subunit A (EC 5.99.1.-) +FIG01955732 Tape measure protein [SA bacteriophages 11, Mu50B] +FIG01955734 Error-prone repair homolog of DNA polymerase III alpha subunit (EC 2.7.7.7) +FIG01955737 Low-affinity inorganic phosphate transporter +FIG01955739 Beta-mannan and fructose induced hypothetical ABC transporter, ATP-binding protein 2 +FIG01955743 Phosphoribosylaminoimidazolecarboxamide formyltransferase (EC 2.1.2.3) / IMP cyclohydrolase (EC 3.5.4.10) +FIG01955745 Predicted galactoside ABC transporter, permease protein 1 +FIG01955748 IncH1 plasmid conjugative transfer protein HtdW +FIG01955751 Guanosine-5'-triphosphate,3'-diphosphate pyrophosphatase (EC 3.6.1.40) +FIG01955754 Biotin synthesis protein BioH / Biotin synthesis protein BioC +FIG01955755 Glutamate N-acetyltransferase (EC 2.3.1.35) / N-acetylglutamate synthase (EC 2.3.1.1) / Acetylglutamate kinase (EC 2.7.2.8) +FIG01955758 Biosynthetic Aromatic amino acid aminotransferase alpha (EC 2.6.1.57) @ Aspartate aminotransferase (EC 2.6.1.1) / Possible Met transaminase +FIG01955759 Maltose/maltodextrin ABC transporter 2, permease protein MalG2 +FIG01955774 Prophage Clp protease-like protein +FIG01955775 Tryptophanyl-tRNA synthetase (EC 6.1.1.2) +FIG01955776 Tryptophanyl-tRNA synthetase (EC 6.1.1.2) +FIG01955777 SSU ribosomal protein S14p (S29e) +FIG01955778 SSU ribosomal protein S14p (S29e) +FIG01955779 Prolyl-tRNA synthetase (EC 6.1.1.15), archaeal/eukaryal type +FIG01955781 Ribosomal large subunit pseudouridine synthase D (EC 4.2.1.70) +FIG01955782 Undecaprenyl-phosphate N-acetylglucosaminyl 1-phosphate transferase (EC 2.7.8.-) +FIG01955784 ABC1 family protein +FIG01955785 ABC1 family protein +FIG01955786 ABC1 family protein +FIG01955787 ABC1 family protein +FIG01955788 ABC1 family protein +FIG01955789 ABC1 family protein +FIG01955790 Coenzyme B synthesis from 2-oxoglutarate: steps 5, 9, and 13 +FIG01955791 phosphoribosyltransferase +FIG01955792 Octanoate-[acyl-carrier-protein]-protein-N-octanoyltransferase, LipM +FIG01955794 IncP-type DNA topoisomerase III TraE (EC 5.99.1.2) @ DNA topoisomerase III, TraE-type (EC 5.99.1.2) +FIG01955796 Deoxyribodipyrimidine photolyase, type II (EC 4.1.99.3) +FIG01955797 COG2827: putative endonuclease containing a URI domain +FIG01955798 Acylamino-acid-releasing enzyme (EC 3.4.19.1) +FIG01955799 Aspartyl-tRNA synthetase (EC 6.1.1.12) @ Aspartyl-tRNA(Asn) synthetase (EC 6.1.1.23) +FIG01955800 Purine nucleoside phosphorylase (EC 2.4.2.1); N-Ribosylnicotinamide phosphorylase (EC 2.4.2.1) +FIG01955803 NAD-dependent formate dehydrogenase gamma subunit +FIG01955804 Glucitol operon GutQ protein +FIG01955805 Beta-lactamase +FIG01955806 Aspartyl-tRNA synthetase (EC 6.1.1.12) +FIG01955808 Metal-dependent hydrolases of the beta-lactamase superfamily I; PhnP protein +FIG01955809 Cytoplasmic copper homeostasis protein cutC +FIG01955810 Periplasmic divalent cation tolerance protein cutA +FIG01955811 Putative diheme cytochrome c-553 +FIG01955812 Sensor histidine protein kinase UhpB, glucose-6-phosphate specific (EC 2.7.13.3) +FIG01955813 ATP:Cob(I)alamin adenosyltransferase (EC 2.5.1.17) @ ATP:Cob(I)alamin adenosyltransferase (EC 2.5.1.17), propanediol utilization +FIG01955814 Beta-N-acetylhexosaminidase, (GlcNAc)2 catabolism +FIG01955816 N-acetylglutamate synthase related protein +FIG01955817 D-glycero-D-manno-heptose 1,7-bisphosphate phosphatase (EC 3.1.1.-); Histidinol-phosphatase (EC 3.1.3.15) +FIG01955818 Pyruvate:ferredoxin oxidoreductase, alpha subunit (EC 1.2.7.1) +FIG01955819 FHA domain containing protein +FIG01955820 FIG048548: ATP synthase protein I2 +FIG01955821 Cyclopropane-fatty-acyl-phospholipid synthase-like protein, clusters with FIG005069 +FIG01955822 S-adenosyl-L-methionine dependent methyltransferase, similar to cyclopropane-fatty-acyl-phospholipid synthase +FIG01955823 Cyclopropane-fatty-acyl-phospholipid synthase (EC 2.1.1.79), plant type +FIG01955826 Acyl-CoA hydrolase (EC 3.1.2.20) +FIG01955827 Acetylspermidine deacetylase (EC 3.5.1.48); Deacetylases, including yeast histone deacetylase and acetoin utilization protein +FIG01955828 Inner membrane protein forms channel for type IV secretion of T-DNA complex, VirB3 +FIG01955829 Cobalt-precorrin-6x reductase (EC 1.3.1.54) / Cobalt-precorrin-6y C15-methyltransferase [decarboxylating] (EC 2.1.1.-) / Precorrin-6B methylase 2 +FIG01955830 Uncharacterized protein YbeL / FIG002095: hypothetical protein +FIG01955831 Ferredoxin--nitrite reductase (EC 1.7.7.1) +FIG01955832 Putative translation initiation inhibitor, yjgF family +FIG01955835 D-amino-acid oxidase (EC 1.4.3.3) / Opine oxidase subunit B +FIG01955836 Serine-protein kinase RsbW (EC 2.7.11.1) +FIG01955837 FIG143042: Thioesterase-like protein +FIG01955838 Crotonobetainyl-CoA dehydrogenase (EC 1.3.99.-) +FIG01955839 Acyl-CoA dehydrogenase (EC 1.3.8.7) +FIG01955840 Hydrolase (HAD superfamily) +FIG01955841 related to 6-phospho-3-hexuloisomerase +FIG01955843 Peptidoglycan hydrolase VirB1, involved in T-DNA transfer +FIG01955844 CDP-glycerol:poly(glycerophosphate) glycerophosphotransferase (EC 2.7.8.12) +FIG01955845 CDP-ribitol:poly(ribitol phosphate) ribitol phosphotransferase +FIG01955846 COG1887: Putative glycosyl/glycerophosphate transferases involved in teichoic acid biosynthesis TagF/TagB/EpsJ/RodC +FIG01955847 4-methyl-5(B-hydroxyethyl)-thiazole monophosphate biosynthesis enzyme +FIG01955848 putative ThiJ family intracellular protease/amidase +FIG01955849 ThiJ/PfpI family protein +FIG01955850 Lipid carrier : UDP-N-acetylgalactosaminyltransferase (EC 2.4.1.-) +FIG01955851 Putative Zn-dependent oxidoreductase PA5234 +FIG01955853 Putative alpha-xylosidase (EC 3.2.1.-) +FIG01955856 Mannitol operon activator, BglG family / PTS system, mannitol-specific IIB component (EC 2.7.1.69) +FIG01955857 Sensor protein of zinc sigma-54-dependent two-component system +FIG01955859 Hydrogenase 3 maturation protease (EC 3.4.-.-) +FIG01955860 hypothetical protein +FIG01955862 Aspartate racemase +FIG01955863 thiosulfate sulfurtransferase +FIG01955865 Lactoylglutathione lyase (EC 4.4.1.5) @ Cadmium-induced protein CadI +FIG01955866 ACT domain-containing protein +FIG01955867 ACT-domain-containing protein, predicted allosteric regulator of homoserine dehydrogenase +FIG01955868 Peptidyl-prolyl cis-trans isomerase (EC 5.2.1.8) +FIG01955869 Ribosomal RNA small subunit methyltransferase D (EC 2.1.1.-) +FIG01955870 Transcriptional regulator, AraC family +FIG01955871 Coenzyme A transferase +FIG01955872 Superfamily II DNA/RNA helicases, SNF2 family +FIG01955875 Putative dioxygenase, alpha subunit (EC 1.-.-.-); Choline monooxygenase, alpha subunit (EC 1.14.15.7) +FIG01955876 Phosphoesterase family protein +FIG01955877 hypothetical protein +FIG01955879 FIG092679: Fe-S oxidoreductase / FIG017108: hypothetical protein +FIG01955881 Predicted L-rhamnose isomerase RhaI (EC 5.3.1.14) +FIG01955883 Geranylgeranylglyceryl phosphate synthase-like protein YerE +FIG01955885 Fumarylpyruvate hydrolase (EC 3.7.1.5) +FIG01955887 Osmoprotectant ABC transporter ATP-binding subunit YehX +FIG01955888 Signal peptidase-like protein / Stage 0 sporulation protein YaaT +FIG01955889 Hypothetical protein Fjoh_3451 +FIG01955890 Glyoxalase family protein +FIG01955892 Amidases related to nicotinamidase +FIG01955893 Anthrachelin biosynthesis protein AsbB @ Siderophore synthetase superfamily, group C @ Siderophore synthetase component, ligase +FIG01955894 Siderophore synthetase superfamily, group A @ Siderophore synthetase large component, acetyltransferase +FIG01955895 Alpha-1,4-N-acetylgalactosamine transferase PglJ (EC 2.4.1.-) +FIG01955896 2,4-diketo-3-deoxy-L-fuconate hydrolase +FIG01955899 Cellobiose phosphotransferase system YdjC-like protein +FIG01955900 prolyl oligopeptidase family protein +FIG01955901 Serine proteases of the peptidase family S9A +FIG01955902 Rubredoxin +FIG01955903 Rubredoxin-NAD(+) reductase (EC 1.18.1.1) +FIG01955905 C3: similar to Vanillate O-demethylase oxygenase +FIG01955906 Vanillate O-demethylase oxygenase subunit (EC 1.14.13.82) +FIG01955907 Probable vanillate O-demethylase oxygenase subunit oxidoreductase protein (EC 1.14.13.-) +FIG01955908 Formylmethanofuran dehydrogenase (tungsten) subunit B (EC 1.2.99.5) +FIG01955909 benzoate MFS transporter BenK +FIG01955910 Acetyl xylan esterase (EC 3.1.1.41) +FIG01955912 Putative major head protein, phage associated +FIG01955914 Pectinesterase (EC 3.1.1.11) +FIG01955915 dihydroxyacetone kinase family protein +FIG01955916 Predicted glycogen debranching enzyme (pullulanase-like, but lacking signal peptide) +FIG01955917 NUDIX hydrolase +FIG01955918 Lipopolysaccharide 1,2-N-acetylglucosaminetransferase (EC 2.4.1.56) +FIG01955919 Thioredoxin reductase (EC 1.8.1.9) +FIG01955921 Putative oxidoreductase in 4-hydroxyproline catabolic gene cluster / Opine oxidase subunit A +FIG01955922 Putative deacetylase YgeY +FIG01955924 Succinic semialdehyde reductase [NAD] (EC 1.1.1.61) +FIG01955925 Glutathione peroxidase family protein +FIG01955926 Membrane proteins related to metalloendopeptidases +FIG01955927 Cell wall endopeptidase, family M23/M37 +FIG01955928 dNTP triphosphohydrolase, putative +FIG01955929 Putative dNTP triphosphohydrolase, Archaeal subgroup +FIG01955930 Uncharacterized spore germination protein YndF +FIG01955931 Citrate-proton symporter +FIG01955932 Maltose/maltodextrin transport ATP-binding protein MalK (EC 3.6.3.19) +FIG01955933 Capsular polysaccharide synthesis enzyme Cap8L +FIG01955934 Heme-degrading monooxygenase IsdG (EC 1.14.99.3) +FIG01955935 Hypothetical, distant similarity with heme-degrading oxygenase IsdG +FIG01955936 Phage endolysin +FIG01955938 Large subunit naph/bph dioxygenase +FIG01955939 Nucleotide sugar epimerase +FIG01955940 Pyruvate:Oxaloacetate transcarboxylase domain protein / Biotin carboxyl carrier protein +FIG01955942 internalin, putative +FIG01955943 Biotin synthesis protein BioC +FIG01955945 Flagellum-specific ATP synthase FliI +FIG01955947 Penicillin-binding protein 3 +FIG01955948 Aromatic amino acid aminotransferase gamma (EC 2.6.1.57) @ N-acetyl-L,L-diaminopimelate aminotransferase (EC 2.6.1.-) +FIG01955949 Periplasmic nitrate reductase precursor (EC 1.7.99.4) +FIG01955950 Iron-sulfur cluster-binding protein +FIG01955951 Carnitine 3-dehydrogenase (EC 1.1.1.108) @ 3-hydroxybutyryl-CoA dehydrogenase (EC 1.1.1.157) @ 3-hydroxyacyl-CoA dehydrogenase (EC 1.1.1.35) +FIG01955952 Hydrogenase-4 component B / Formate hydrogenlyase subunit 3 +FIG01955953 Iron(III) dicitrate transport ATP-binding protein FecE (TC 3.A.1.14.1) +FIG01955954 Resolvase/integrase +FIG01955955 Resolvase/integrase Bin +FIG01955956 Uncharacterized spore germination protein YndD +FIG01955957 SAM-dependent methyltransferase DSY4148 (UbiE paralog) +FIG01955958 Menaquinone via futalosine polyprenyltransferase (MenA homolog), Nitrosopumilus/Caldivirga type +FIG01955959 3-carboxyethylcatechol 2,3-dioxygenase (EC 1.13.11.16) +FIG01955961 Hypothetical sugar kinase in cluster with indigoidine synthase indA , PfkB family of kinases +FIG01955962 Probable 3-phenylpropionic acid transporter +FIG01955963 IncP-type conjugative transfer protein TrbH +FIG01955964 Diflavin flavoprotein Sll1521 +FIG01955965 Anthranilate synthase, amidotransferase component (EC 4.1.3.27) / Para-aminobenzoate synthase, amidotransferase component (EC 2.6.1.85) +FIG01955966 Aspartate aminotransferase (EC 2.6.1.1) +FIG01955967 L-alanine-DL-glutamate epimerase +FIG01955968 L-ribulose-5-phosphate 3-epimerase UlaE (EC 5.1.3.22) (L-ascorbate utilization protein E) +FIG01955969 3-oxoadipate CoA-transferase subunit B (EC 2.8.3.6); Glutaconate CoA-transferase subunit B (EC 2.8.3.12) +FIG01955970 Alpha/beta hydrolase fold (EC 3.8.1.5) +FIG01955971 2-keto-4-pentenoate hydratase (EC 4.2.1.80) +FIG01955972 Lysyl-lysine 2,3-aminomutase +FIG01955974 Transcriptional regulator, GABA/putrescine utiliation cluster +FIG01955975 [Ni/Fe] hydrogenase, group 1, large subunit +FIG01955976 Beta-ketoadipyl CoA thiolase (EC 2.3.1.-) +FIG01955977 ABC-type nitrate/sulfonate/bicarbonate transport system, permease component +FIG01955978 L-threonine 3-O-phosphate decarboxylase (EC 4.1.1.81) / Cobyrinic acid A,C-diamide synthase +FIG01955979 Hypothetical with similarity to BchE, but NOT Mg-protoporphyrin monomethyl ester cyclase (anaerobic) +FIG01955980 Coupling protein VirD4, ATPase required for T-DNA transfer +FIG01955981 L-malyl-CoA/beta-methylmalyl-CoA lyase (EC 4.1.3.-), actinobacterial type +FIG01955982 Biphenyl dioxygenase beta subunit (EC 1.14.12.18) +FIG01955983 Acetoacetyl-CoA synthetase [leucine] (EC 6.2.1.16) +FIG01955984 D-proline reductase, 26 kDa subunit @ selenocysteine-containing +FIG01955986 Putative translation initiation inhibitor, yjgF family +FIG01955987 Desferrioxamine E biosynthesis protein DesB @ Siderophore biosynthesis protein, monooxygenase +FIG01955988 Phage coat protein +FIG01955989 IncI1 plasmid conjugative transfer pilus-tip adhesin protein PilV +FIG01955990 Capsular polysaccharide synthesis enzyme Cap5D +FIG01955991 "Tyrosyl-tRNA synthetase " +FIG01955992 Tyrosyl-tRNA synthetase (EC 6.1.1.1) +FIG01955994 Putative terminase, superantigen-encoding pathogenicity islands SaPI +FIG01955995 NADPH:quinone oxidoreductase 2 +FIG01955996 Type III polyketide sythase producing alkylpyrones (B. subtilis BpsA) +FIG01955997 Galactonate dehydratase (EC 4.2.1.6) +FIG01955999 Starvation sensing protein RspB +FIG01956000 Bactoprenol glucosyl transferase (EC 2.4.1.-); Glycosyltransferase, group 2 family protein +FIG01956001 Tungsten-containing formaldehyde:ferredoxin oxidoreductase +FIG01956002 SAM-dependent methyltransferase (EC 2.1.1.-) +FIG01956004 16S rRNA m(2)G 1207 methyltransferase (EC 2.1.1.52) +FIG01956005 Ribosomal large subunit pseudouridine synthase E (EC 4.2.1.70) +FIG01956006 SAM-dependent methyltransferase YafE (UbiE paralog) +FIG01956007 Transcriptional regulatory protein +FIG01956008 hypothetical protein +FIG01956009 Glycosyl transferase, family 2 +FIG01956010 tRNA pseudouridine synthase C (EC 4.2.1.70) +FIG01956012 NADPH:quinone reductase (Quinone oxidoreductase) (EC 1.6.5.5) +FIG01956013 Periplasmic aromatic aldehyde oxidoreductase, molybdenum binding subunit YagR @ 4-hydroxybenzoyl-CoA reductase, alpha subunit (EC 1.3.99.20) +FIG01956014 Integral membrane protein +FIG01956015 prolyl oligopeptidase family protein +FIG01956016 FIG006542: Phosphoesterase +FIG01956017 Glycosyl transferase, family 2 +FIG01956018 putative lipoprotein +FIG01956019 putative exported protein +FIG01956020 Secreted protein Hcp +FIG01956022 Phage DNA replication protein P +FIG01956023 Transcriptional regulator, AsnC family +FIG01956025 4Fe-4S ferredoxin, iron-sulfur binding domain protein +FIG01956026 Ribosomal large subunit pseudouridine synthase C (EC 4.2.1.70) +FIG01956027 Alanine transaminase (EC 2.6.1.2) +FIG01956030 aminotransferase +FIG01956032 Tagatose 1,6-bisphosphate aldolase (EC 4.1.2.40) +FIG01956033 Tagatose-1,6-bisphosphate aldolase GatY (EC 4.1.2.-) +FIG01956035 hypothetical protein +FIG01956036 Periplasmic aromatic aldehyde oxidoreductase, iron-sulfur subunit YagT @ 4-hydroxybenzoyl-CoA reductase, gamma subunit (EC 1.3.99.20) +FIG01956037 FAD-dependent monooxygenase +FIG01956038 Ribosomal large subunit pseudouridine synthase B (EC 4.2.1.70) +FIG01956039 Cinnamyl-alcohol dehydrogenase (EC 1.1.1.195) +FIG01956040 Zn-dependent hydroxyacylglutathione hydrolase / Polysulfide binding protein +FIG01956041 Asp-tRNAAsn/Glu-tRNAGln amidotransferase A subunit and related amidases +FIG01956042 Amidase +FIG01956043 Hydrolase, alpha/beta fold family +FIG01956044 binding-protein-dependent transport systems inner membrane component +FIG01956045 Na(+)/H(+) antiporter +FIG01956046 hypothetical protein +FIG01956047 Alkanesulfonates ABC transporter permease protein +FIG01956048 Hypothetical oxidoreductase YqhD (EC 1.1.-.-) +FIG01956049 oxidoreductase of aldo/keto reductase family, subgroup 1 +FIG01956050 Integral membrane protein +FIG01956051 Capsular polysaccharide synthesis enzyme Cap8M +FIG01956052 ABC transporter ATP-binding protein +FIG01956054 Two-component response regulator +FIG01956055 Phage integrase +FIG01956056 Carboxypeptidase T (EC 3.4.17.18) +FIG01956057 Alkanesulfonates ABC transporter substrate-binding protein +FIG01956058 stearoyl-CoA 9-desaturase( EC:1.14.19.1 ) +FIG01956060 2,3-dihydro-2,3-dihydroxybenzoate dehydrogenase (EC 1.3.1.28) of siderophore biosynthesis +FIG01956061 hypothetical protein +FIG01956062 Arylesterase +FIG01956063 SAM-dependent methyltransferase (EC 2.1.1.-) +FIG01956064 Xanthine dehydrogenase iron-sulfur subunit (EC 1.17.1.4) / Xanthine dehydrogenase, FAD binding subunit (EC 1.17.1.4) +FIG01956066 D-alanine--D-alanine ligase (EC 6.3.2.4) MysD +FIG01956068 Transketolase, C-terminal section (EC 2.2.1.1) +FIG01956069 unknown protein encoded by bacteriophage BP-933W +FIG01956070 "Lysyl endopeptidase " +FIG01956071 Nicotinate-nucleotide adenylyltransferase (EC 2.7.7.18) +FIG01956072 Cyclopropane-fatty-acyl-phospholipid synthase 1, CmaA1 (EC 2.1.1.79) +FIG01956073 LSU m3Psi1915 methyltransferase RlmH +FIG01956074 FIG137268: Possible translation factor Sua5/YciO/YrdC/YwlC family +FIG01956075 Putative sulfide reductase +FIG01956076 S-layer protein / N-acetylmuramoyl-L-alanine amidase +FIG01956080 Hemolysins and related proteins containing CBS domains +FIG01956083 Tetracycline resistance protein TetQ +FIG01956085 FIG008220: hypothetical protein +FIG01956088 Na(+) H(+) antiporter subunit A; Na(+) H(+) antiporter subunit B; NADH-ubiquinone oxidoreductase chain L (EC 1.6.5.3) +FIG01956089 FIG002076: hypothetical protein +FIG01956090 hypothetical protein +FIG01956092 FIG137887: membrane protein related to purine degradation +FIG01956093 PTS system, lichenan-, cellobiose-specific IIA component (EC 2.7.1.69); PTS system, cellobiose-specific IIC component (EC 2.7.1.69) +FIG01956095 Predicted cellobiose ABC transport system, sugar-binding protein +FIG01956096 CDP-6-deoxy-delta-3,4-glucoseen reductase-like +FIG01956098 Believed to be an alternative form of N-formylglutamate deformylase (EC 3.5.1.68), but experimentally invalidated +FIG01956101 hypothetical protein +FIG01956102 Capsular polysaccharide synthesis enzyme Cap5A; truncated +FIG01956105 PE family protein +FIG01956106 Phage neck protein +FIG01956108 Putative transcriptional regulator of sorbose uptake and utilization genes +FIG01956110 Glutamine amidotransferase chain of NAD synthetase +FIG01956111 2-Methylcitrate dehydratase AcnD +FIG01956112 Novel D-mannonate dehydrogenase (EC 1.1.1.57) +FIG01956113 LarA: implicated in lactate racemization +FIG01956114 Predicted hydrolase +FIG01956115 Hydrolase (HAD superfamily) +FIG01956119 PnuC-like transporter of unknown specificity +FIG01956120 2-polyprenyl-6-methoxyphenol hydroxylase and related FAD-dependent oxidoreductases +FIG01956121 Site-specific recombinase, phage integrase +FIG01956122 Hydrolase, alpha/beta fold family +FIG01956123 GGDEF family protein +FIG01956124 Autoinducer-binding transcriptional regulator BpsR +FIG01956125 predicted nucleotidyltransferases +FIG01956126 Protein of unknown function DUF208 +FIG01956127 Sodium/glutamine symporter GlnT +FIG01956130 Long-chain-fatty-acid--CoA ligase FadD22 (EC 6.2.1.3) +FIG01956132 FIG001154: CcsA-related protein +FIG01956133 Nitrogenase FeMo-cofactor scaffold and assembly protein NifE +FIG01956134 Probable polyketide synthase, similar to many. e.g. gp|M63676|SERERYAA_1 S.erythraea first ORF of eryA gene, involved in complex polyketide formation in erythromycin biosynthesis. +FIG01956135 Beta-N-acetylhexosaminidase, (GlcNAc)2 catabolism +FIG01956136 Phycobilisome rod linker polypeptide, phycoerythrocyanin-associated +FIG01956137 5'-methylthioadenosine/S-adenosylhomocysteine nucleosidase related protein BCZK2595 +FIG01956138 Functional role page for Anaerobic nitric oxide reductase transcription regulator NorR +FIG01956139 Nitrogenase FeMo-cofactor scaffold and assembly protein NifE +FIG01956143 Beta-glucosidase (EC 3.2.1.21); 6-phospho-beta-glucosidase (EC 3.2.1.86) +FIG01956145 Xylose ABC transporter, ATP-binding component +FIG01956146 CDP-glycerol:poly(glycerophosphate) glycerophosphotransferase (EC 2.7.8.12) +FIG01956147 Rubredoxin-NAD(+) reductase (EC 1.18.1.1) +FIG01956148 S-adenosyl-L-methionine dependent methyltransferase, similar to cyclopropane-fatty-acyl-phospholipid synthase +FIG01956149 Octaprenyl-diphosphate synthase (EC 2.5.1.90) / Dimethylallyltransferase (EC 2.5.1.1) / Geranyltranstransferase (farnesyldiphosphate synthase) (EC 2.5.1.10) / Geranylgeranyl pyrophosphate synthetase (EC 2.5.1.29) +FIG01956151 LSU ribosomal protein L33p @ LSU ribosomal protein L33p, zinc-independent +FIG01956152 LSU ribosomal protein L33p @ LSU ribosomal protein L33p, zinc-dependent +FIG01956154 Prolyl-tRNA synthetase related protein +FIG01956155 LSU ribosomal protein L31p @ LSU ribosomal protein L31p, zinc-independent +FIG01956156 LSU ribosomal protein L31p @ LSU ribosomal protein L31p, zinc-dependent +FIG01956157 LSU ribosomal protein L31p @ LSU ribosomal protein L31p, zinc-dependent / domain of low sequence complexity +FIG01956158 Undecaprenyl diphosphate synthase (EC 2.5.1.31); Di-trans,poly-cis-decaprenylcistransferase +FIG01956161 SSU ribosomal protein S18p +FIG01956163 Shikimate kinase I (EC 2.7.1.71) / 3-dehydroquinate synthase (EC 4.2.3.4) +FIG01956164 Twin-arginine translocation protein TatCd +FIG01956169 Deoxyribose-specific ABC transporter, permease protein +FIG01956172 UDP-glucose dehydrogenase in hyaluronic acid synthesis (EC 1.1.1.22) +FIG01956173 4-hydroxy-2-oxoglutarate aldolase (EC 4.1.3.16) @ 2-dehydro-3-deoxyphosphogluconate aldolase (EC 4.1.2.14) +FIG01956175 SAM-dependent methyltransferase +FIG01956176 Biotin operon repressor / Biotin-protein ligase (EC 6.3.4.15) +FIG01956179 Acetyltransferase (GNAT) domain / Aminotransferase class II, serine palmitoyltransferase like (EC 2.3.1.50) +FIG01956187 phosphoglycerate mutase family protein +FIG01956188 Alpha-ribazole-5'-phosphate phosphatase (EC 3.1.3.73) +FIG01956192 tRNA/rRNA methylase SpoU +FIG01956194 Taurine-binding periplasmic protein TauA +FIG01956199 Alanyl-tRNA synthetase domain protein +FIG01956201 FUPA27 P-type ATPase fragment +FIG01956202 Cu+ P-type ATPase +FIG01956204 D-galactarate dehydratase/Altronate hydrolase domain protein +FIG01956205 Probable coniferyl aldehyde dehydrogenase (EC 1.2.1.68) +FIG01956206 Oxidoreductase, short-chain dehydrogenase/reductase family +FIG01956208 4-hydroxy-2-oxovalerate aldolase (EC 4.1.3.39) +FIG01956209 Pseudouridine 5'-phosphate glycosidase +FIG01956210 Phage major tail sheath protein +FIG01956211 8-amino-7-oxononanoate synthase (EC 2.3.1.47) +FIG01956212 Cell division protein DivIC (FtsB), stabilizes FtsL against RasP cleavage +FIG01956213 hypothetical protein +FIG01956215 DoxX family protein +FIG01956216 Phosphopantetheine-binding acyl carrier protein +FIG01956217 protein of unknown function DUF101 +FIG01956218 hypothetical protein +FIG01956219 3-ketoacyl-CoA thiolase (EC 2.3.1.16) @ Acetyl-CoA acetyltransferase (EC 2.3.1.9) +FIG01956222 iron compound ABC transporter, permease protein +FIG01956224 2-deoxyglucose-6-phosphate hydrolase YniC +FIG01956226 Mannose-6-phosphate isomerase (EC 5.3.1.8) / Mannose-1-phosphate guanylyltransferase (GDP) (EC 2.7.7.22) +FIG01956227 Possible flavoprotein, Beta-lactamase domain protein +FIG01956228 Phage tail fiber +FIG01956229 similar to ribulose-1,5-bisphosphate carboxylase, Type III +FIG01956230 Hydrogenase-2 operon protein hybA precursor +FIG01956232 Transcriptional regulator, GntR family +FIG01956236 GTP pyrophosphokinase (EC 2.7.6.5) +FIG01956238 ABC transporter ATP-binding protein +FIG01956239 ABC transporter ATP-binding protein; Branched-chain amino acid transport ATP-binding protein LivF (TC 3.A.1.4.1) +FIG01956242 Predicted nucleoside phosphatase; Acylphosphate phosphohydrolase (EC 3.6.1.7) +FIG01956244 NTP pyrophosphohydrolases including oxidative damage repair enzymes +FIG01956247 Squalene-associated FAD-dependent desaturase, HpnE +FIG01956249 Phage head maturation protease +FIG01956250 Omega-amino acid--pyruvate aminotransferase (EC 2.6.1.18) +FIG01956251 Aminotransferase class-III +FIG01956253 Dehydrosqualene synthase (EC 2.5.1.96) +FIG01956254 PPE family protein +FIG01956255 Cobalamin biosynthesis protein CbiG / Cobalt-precorrin-3b C17-methyltransferase +FIG01956257 Vitamin B12 transport protein btuF precursor +FIG01956259 N-acetyl-L,L-diaminopimelate deacetylase (EC 3.5.1.47) +FIG01956261 putative porphyrin biosynthetic protein +FIG01956268 Methyltransferase type 11 +FIG01956272 23S rRNA (guanine-N-2-) -methyltransferase rlmL EC 2.1.1.-) +FIG01956273 aminotransferase class I and II +FIG01956274 Phage minor capsid protein +FIG01956281 Aminotransferase class II, serine palmitoyltransferase like (EC 2.3.1.50) +FIG01956282 Oxononanoate Synthase like protein +FIG01956283 N-Acyltransferase +FIG01956287 Hydroxyneurosporene methyltransferase (EC 2.1.1.210) +FIG01956289 hypothetical protein Bcep3774, commonly clustered with carotenoid biosynthesis +FIG01956290 FIG054432: hypothetical protein +FIG01956291 Additional lipoprotein component of predicted cobalamin ECF transporter +FIG01956292 Type II, N-methyl DNA methyltransferase (group alpha) +FIG01956294 Cu+ P-type ATPase fragment +FIG01956295 Lead, cadmium, zinc and mercury transporting ATPase (EC 3.6.3.3) (EC 3.6.3.5); Copper-translocating P-type ATPase (EC 3.6.3.4) +FIG01956296 Lead, cadmium, zinc and mercury transporting ATPase (EC 3.6.3.-) +FIG01956297 Urea ABC transporter, substrate binding protein UrtA +FIG01956298 Melibiose carrier protein, Na+/melibiose symporter; Glucuronide permease +FIG01956299 DNA binding protein starved cells-like peroxide resistance protein/ Iron-binding ferritin-like antioxidant protein / Ferroxidase (EC 1.16.3.1) +FIG01956300 Deaminase +FIG01956301 Teichuronic acid biosynthesis glycosyl transferase TuaC +FIG01956306 Beta-ketoadipate enol-lactone hydrolase (EC 3.1.1.24) +FIG01956307 Hydrolase, haloacid dehalogenase-like family +FIG01956312 Twin-arginine translocation protein TatAd +FIG01956314 Kef-type K+ transport system, membrane component +FIG01956315 Mannose-1-phosphate guanylyltransferase (GDP) (EC 2.7.7.22) / Mannose-6-phosphate isomerase (EC 2.7.7.22) +FIG01956318 ATP-binding protein +FIG01956322 Putative secreted polysaccharide polymerase +FIG01956324 Heavy-Metal transporting ATPase fragment +FIG01956325 rRNA small subunit methyltransferase J +FIG01956326 FIG002344: Hydrolase (HAD superfamily) +FIG01956327 O-antigen export system permease protein Wzm +FIG01956328 membrane-bounded cytochrome biogenesis DsbD/cycZ-like domain +FIG01956329 hypothetical protein +FIG01956333 Mannose-6-phosphate isomerase ManA (EC 5.3.1.8) +FIG01956335 Trk system potassium uptake protein TrkH +FIG01956337 4-hydroxy-2-oxoglutarate aldolase (EC 4.1.3.16) +FIG01956340 Cu+ P-type ATPase fragment +FIG01956344 biotin/lipoate A/B protein ligase +FIG01956349 P pilus assembly/Cpx signaling pathway, periplasmic inhibitor/zinc-resistance associated protein +FIG01956351 putative ribonucleoprotein-related protein +FIG01956356 Mannose-1-phosphate guanylyltransferase (GDP) (EC 2.7.7.22) +FIG01956357 Mannose-1-phosphate guanylyltransferase (GDP) ManC (EC 2.7.7.22) / Mannose-6-phosphate isomerase ManC (EC 5.3.1.8) +FIG01956361 FIG01280259: hypothetical protein +FIG01956365 Trk system potassium uptake protein TrkA +FIG01956366 GTP-binding protein HflX +FIG01956367 Maltodextrin phosphorylase (EC 2.4.1.1); Glycogen/starch/alpha-glucan phosphorylase (EC 2.4.1.1) +FIG01956368 Maltodextrin phosphorylase (EC 2.4.1.1) / Glycogen phosphorylase (EC 2.4.1.1) +FIG01956369 2-dehydro-3-deoxyphosphogluconate aldolase (EC 4.1.2.14) @ 4-hydroxy-2-oxoglutarate aldolase (EC 4.1.3.16) +FIG01956377 FIG006789: Stage V sporulation protein; Low temperature requirement B protein +FIG01956378 Predicted L-fucose-specific phosphotransferase system, EIIA component +FIG01956379 Membrane-associated zinc metalloprotease +FIG01956384 2-keto-4-pentenoate hydratase (EC 4.2.1.80) +FIG01956385 4-oxalocrotonate decarboxylase (EC 4.1.1.77) +FIG01956390 Inosine-5'-monophosphate dehydrogenase (EC 1.1.1.205) +FIG01956392 GMP synthase [glutamine-hydrolyzing] (EC 6.3.5.2) +FIG01956396 DNA binding protein starved cells-like peroxide resistance protein +FIG01956399 Acetoin utilization CBS domain-containing protein; Inosine-5'-monophosphate dehydrogenase (EC 1.1.1.205) +FIG01956400 Adenylate cyclase (EC 4.6.1.1) +FIG01956402 PE FAMILY PROTEIN +FIG01956403 Octaprenyl-diphosphate synthase (EC 2.5.1.-) / Dimethylallyltransferase (EC 2.5.1.1) / Geranyltranstransferase (farnesyldiphosphate synthase) (EC 2.5.1.10) / Geranylgeranyl pyrophosphate synthetase (EC 2.5.1.29) +FIG01956410 N-acetyl-L,L-diaminopimelate deacetylase (EC 3.5.1.47) +FIG01956412 CobN component of cobalt chelatase involved in B12 biosynthesis +FIG01956413 O-antigen export system, ATP-binding protein Wzt +FIG01956414 Prolyl oligopeptidase family protein +FIG01956415 HEAT-like repeat containing protein +FIG01956416 Putative ribonucleoprotein related-protein +FIG01956417 hypothetical protein +FIG01956422 Ubiquinone biosynthesis monooxygenase UbiB +FIG01956423 ABC1 family protein +FIG01956428 Uncharacterized protein YfaU +FIG01956429 Aminotransferase class II, serine palmitoyltransferase like (EC 2.3.1.50) +FIG01956430 Cu+ P-type ATPase fragment +FIG01956434 alpha/beta hydrolase fold +FIG01956436 Amine oxidase [flavin-containing] A (EC 1.4.3.4) +FIG01956438 DNA topoisomerase III, TraE-type (EC 5.99.1.2) +FIG01956440 Rubredoxin-NAD(+) reductase (EC 1.18.1.1) +FIG01956443 Maltose/maltodextrin transport ATP-binding protein MalK (EC 3.6.3.19); Multiple sugar ABC transporter, ATP-binding protein +FIG01956446 Methyltransferase type 11 +FIG01956447 Methyltransferase +FIG01956450 Surface presentation of antigens protein SpaR; Type III secretion inner membrane protein (YscT,HrcT,SpaR,EscT,EpaR1,homologous to flagellar export components) +FIG01956451 ABC transporter, ATP-binding protein +FIG01956454 hypothetical protein +FIG01956455 N-ethylammeline chlorohydrolase +FIG01956456 Beta-lactamase (EC 3.5.2.6) +FIG01956457 Apolipoprotein N-acyltransferase (EC 2.3.1.-) in lipid-linked oligosaccharide synthesis cluster / Dolichol-phosphate mannosyltransferase (EC 2.4.1.83) in lipid-linked oligosaccharide synthesis cluster +FIG01956461 hypothetical protein +FIG01956462 Lyzozyme M1 (1,4-beta-N-acetylmuramidase) (EC 3.2.1.17) +FIG01956464 BOX elements +FIG01956465 Capsular polysaccharide biosynthesis protein Cps4E +FIG01956468 L-aspartate oxidase (EC 1.4.3.16) +FIG01956470 Uncharacterized secreted protein associated with spyDAC +FIG01956471 Phosphomannomutase ManB (EC 5.4.2.8) +FIG01956474 Transcriptional regulator, repressor of the glutamine synthetase, MerR family +FIG01956478 putative transport system permease protein +FIG01956480 Endo-beta-N-acetylglucosaminidase (EC 3.2.1.96) +FIG01956481 phage shock protein C, putative stress-responsive transcriptional regulator +FIG01956483 DNA-binding response regulator +FIG01956486 hypothetical protein +FIG01956487 Zinc ABC transporter, ATP-binding protein ZnuC +FIG01956488 FIG009210: peptidase, M16 family +FIG01956489 Nucleoside-binding protein +FIG01956490 FIG01116016: hypothetical protein +FIG01956493 ECF family DNA-directed RNA polymerase sigma subunit SigW +FIG01956497 Multiple sugar ABC transporter, membrane-spanning permease protein MsmG +FIG01956498 Foldase protein prsA 1 precursor (EC 5.2.1.8) +FIG01956499 hypothetical protein +FIG01956500 N-ethylammeline chlorohydrolase +FIG01956504 Multiple sugar ABC transporter, membrane-spanning permease protein MsmF +FIG01956505 multidrug ABC superfamily ATP binding cassette transporter +FIG01956506 ABC transporter permease protein +FIG01956507 PTS system, mannose/fructose family IIB component +FIG01956508 Arginine repressor ArgR, putative +FIG01956511 Zinc ABC transporter, ATP-binding protein ZnuC +FIG01956512 hypothetical protein +FIG01956513 putative integrase - phage associated +FIG01956517 conserved hypothetical protein +FIG01956519 hypothetical protein +FIG01956522 FIG009210: peptidase, M16 family +FIG01956524 Response regulator CsrR +FIG01956526 Phosphomethylpyrimidine kinase (EC 2.7.4.7) +FIG01956528 FIG01115820: hypothetical protein +FIG01956530 IS66 family element, Orf1 +FIG01956531 FIG01113978: hypothetical protein +FIG01956535 Cholinephosphate cytidylyltransferase (EC 2.7.7.15) +FIG01956536 Probable transmembrane protein +FIG01956538 RNA methyltransferase, TrmA family +FIG01956539 NanA gene +FIG01956540 FIG01119886: hypothetical protein +FIG01956541 Thiamin pyrophosphokinase (EC 2.7.6.2) +FIG01956548 short chain dehydrogenase/reductase family oxidoreductase +FIG01956550 hypothetical protein +FIG01956553 hypothetical protein +FIG01956555 DNA-damage-inducible protein J, putative +FIG01956556 surface protein D +FIG01956558 Amino acid ABC transporter, ATP-binding protein +FIG01956559 hypothetical protein +FIG01956561 Pullulanase (EC 3.2.1.41) +FIG01956562 FIG001621: Zinc protease +FIG01956563 Nucleoside-binding protein +FIG01956564 hypothetical protein +FIG01956567 hypothetical protein +FIG01956569 N-ethylammeline chlorohydrolase +FIG01956570 FIG01115516: hypothetical protein +FIG01956572 brp/Blh family beta-carotene 15,15'-monooxygenase +FIG01956575 2-haloalkanoic acid dehalogenase (EC 3.8.1.2) +FIG01956578 NanA gene +FIG01956584 Histidine triad (HIT) nucleotide-binding protein, similarity with At5g48545 and yeast YDL125C (HNT1) +FIG01956586 putative transcriptional regulator +FIG01956587 FIG001621: Zinc protease +FIG01956588 Phage portal protein +FIG01956590 Arginine repressor ArgR, putative +FIG01956592 helix-turn-helix domain protein +FIG01956593 ABC transporter, ATP-binding protein +FIG01956594 Type I restriction-modification system, DNA-methyltransferase subunit M (EC 2.1.1.72) +FIG01956596 FIG001621: Zinc protease +FIG01956598 Lyzozyme M1 (1,4-beta-N-acetylmuramidase) (EC 3.2.1.17) +FIG01956599 ATP-binding cassette, subfamily C, bacterial +FIG01956601 hypothetical protein +FIG01956604 ferrichrome ABC superfamily ATP binding cassette transporter, binding protein +FIG01956606 Vitamin B12 ABC transporter, B12-binding component BtuF +FIG01956607 arginine repressor +FIG01956613 ABC transporter ATP-binding protein +FIG01956614 unknown protein +FIG01956615 hypothetical protein +FIG01956617 NanA gene +FIG01956618 Maturase-related protein +FIG01956619 FIG01119961: hypothetical protein +FIG01956622 hypothetical protein +FIG01956624 cell wall surface anchor family domain protein +FIG01956626 hypothetical protein +FIG01956627 Trehalose-6-phosphate hydrolase (EC 3.2.1.93), truncated +FIG01956628 hypothetical protein +FIG01956631 putative membrane protein +FIG01956633 Integral membrane protein +FIG01956634 glycosyltransferase +FIG01956637 2-haloalkanoic acid dehalogenase (EC 3.8.1.2) +FIG01956641 FIG01120044: hypothetical protein +FIG01956642 PTS system, galactosamine-specific IIA component (EC 2.7.1.69) +FIG01956643 potassium transporter peripheral membrane component +FIG01956647 enterocin A Immunity protein +FIG01956650 conjugal transfer protein, putative +FIG01956652 Pullulanase (EC 3.2.1.41) +FIG01956653 FIG01116188: hypothetical protein +FIG01956654 hypothetical protein +FIG01956656 Endo-beta-N-acetylglucosaminidase (EC 3.2.1.96) +FIG01956657 hypothetical protein +FIG01956658 Conserved domain protein +FIG01956661 hypothetical protein +FIG01956664 hypothetical protein +FIG01956666 hypothetical protein +FIG01956672 FIG01120689: hypothetical protein +FIG01956673 Tyrosine-protein phosphatase CpsB (EC 3.1.3.48) +FIG01956675 hypothetical protein +FIG01956676 TerD family tellurium resistance protein +FIG01956678 accessory secretory protein Asp4 +FIG01956679 Flagellar hook-length control protein FliK +FIG01956680 FIG009210: peptidase, M16 family +FIG01956682 Membrane-bound amino protease, CAAX family +FIG01956683 Uncharacterized conserved protein, contains double-stranded beta-helix domain +FIG01956684 Transcriptional regulator, repressor of the glutamine synthetase, MerR family +FIG01956686 Promiscuous sugar phosphatase YidA, haloacid dehalogenase-like phosphatase family +FIG01956690 brp/Blh family beta-carotene 15,15'-monooxygenase +FIG01956692 putative transport ATP-binding protein +FIG01956693 N-ethylammeline chlorohydrolase +FIG01956694 N-ethylammeline chlorohydrolase +FIG01956695 TetR family transcriptional regulator +FIG01956697 NanA gene +FIG01956699 Huntingtin interacting protein E-like protein +FIG01956705 putative membrane protein +FIG01956706 probable esterase of alpha/beta hydrolase superfamily, YBBA B. subtilis ortholog +FIG01956708 Uridine phosphorylase (EC 2.4.2.3) +FIG01956709 Amino acid ABC transporter, ATP-binding protein +FIG01956711 TonB system biopolymer transport component +FIG01956713 ABC-transporter (ATP-binding protein) -possibly involved in cell wall localization and side chain formation of rhamnose-glucose polysaccharide +FIG01956715 ABC-transporter (ATP-binding protein) -possibly involved in cell wall localization and side chain formation of rhamnose-glucose polysaccharide +FIG01956716 hypothetical protein +FIG01956721 Putative DNA-binding protein in cluster with Type I restriction-modification system +FIG01956722 NanA gene +FIG01956724 Phage lysin, glycosyl hydrolase, family 25 +FIG01956725 hypothetical protein +FIG01956728 unknown +FIG01956729 ABC transporter, ATP-binding/permease protein +FIG01956730 FIG01116975: hypothetical protein +FIG01956731 predicted membrane protein +FIG01956733 polar amino acid transport system ATP-binding protein +FIG01956734 hypothetical protein +FIG01956737 Nucleoside-binding protein +FIG01956739 Multidrug resistance efflux pump PmrA +FIG01956741 NanA gene +FIG01956746 Degenerative transposase +FIG01956749 hypothetical protein +FIG01956750 oxidoreductase +FIG01956752 multidrug resistance ABC superfamily ATP binding cassette transporter, ABC protein +FIG01956757 hypothetical protein +FIG01956761 N-ethylammeline chlorohydrolase +FIG01956764 hypothetical protein +FIG01956766 Nitric oxide reductase NorD / Von Willebrand factor type A (vWA) domain protein, putative +FIG01956767 Phage lysin, glycosyl hydrolase, family 25 +FIG01956771 FIG001621: Zinc protease +FIG01956772 hypothetical protein +FIG01956775 ABC superfamily ATP binding cassette transporter, membrane protein +FIG01956776 competence-induced protein Ccs16 +FIG01956777 hypothetical protein +FIG01956780 FIG01117752: hypothetical protein +FIG01956782 Maturase-related protein +FIG01956783 BOX elements +FIG01956784 CAAX amino terminal protease family protein +FIG01956789 N-ethylammeline chlorohydrolase +FIG01956791 Transcriptional regulator GlnR, repressor of the glutamine synthetase, MerR family +FIG01956797 Mobile element protein +FIG01956798 MutT/NUDIX family protein +FIG01956802 hypothetical protein +FIG01956804 hypothetical protein +FIG01956809 hypothetical protein +FIG01956810 Maltose operon transcriptional repressor MalR, LacI family +FIG01956811 YitT family protein +FIG01956812 FIG01120562: hypothetical protein +FIG01956813 Type I restriction-modification system, restriction subunit R (EC 3.1.21.3) +FIG01956814 hypothetical protein +FIG01956818 ABC transporter permease protein +FIG01956822 alpha/beta fold family hydrolase +FIG01956825 N-ethylammeline chlorohydrolase +FIG01956828 Glycosyl transferase, family 2 +FIG01956831 hypothetical protein +FIG01956839 CoA-disulfide reductase (EC 1.8.1.14) +FIG01956840 FIG009210: peptidase, M16 family +FIG01956842 hypothetical protein +FIG01956843 toxic anion resistance protein +FIG01956846 conserved domain protein +FIG01956847 FtsK/SpoIIIE family protein +FIG01956849 NanA gene +FIG01956853 FIG001621: Zinc protease +FIG01956855 FIG01115411: hypothetical protein +FIG01956858 Lyzozyme M1 (1,4-beta-N-acetylmuramidase) (EC 3.2.1.17) +FIG01956859 CAAX amino terminal protease family protein +FIG01956861 brp/Blh family beta-carotene 15,15'-monooxygenase +FIG01956864 hypothetical protein +FIG01956866 hypothetical protein +FIG01956870 Nucleoside-binding protein +FIG01956872 PTS system, galactosamine-specific IID component (EC 2.7.1.69) +FIG01956876 FIG01117728: hypothetical protein +FIG01956877 FIG01114110: hypothetical protein +FIG01956878 Xaa-Pro dipeptidyl-peptidase (EC 3.4.14.11) +FIG01956891 Nickel transport ATP-binding protein NikE (TC 3.A.1.5.3) +FIG01956892 hypothetical protein +FIG01956893 Conserved domain protein +FIG01956894 arginine repressor +FIG01956896 NAD dependent epimerase/dehydratase +FIG01956897 Transcriptional regulator +FIG01956898 hypothetical protein +FIG01956903 glycosyl transferase family 8 +FIG01956905 Mannosyltransferase WbkE +FIG01956906 predicted membrane protein +FIG01956907 N-ethylammeline chlorohydrolase +FIG01956909 hypothetical protein +FIG01956914 dihydroxyacetone kinase family protein +FIG01956915 Putative uncharacterized protein SPs0573 +FIG01956916 hypothetical protein +FIG01956922 hypothetical protein +FIG01956923 hypothetical protein +FIG01956936 FIG01120680: hypothetical protein +FIG01956937 N-ethylammeline chlorohydrolase +FIG01956938 MutT/NUDIX family protein +FIG01956947 FIG009210: peptidase, M16 family +FIG01956949 acyl-CoA thioester hydrolase +FIG01956950 Type I restriction-modification system, specificity subunit S (EC 3.1.21.3) +FIG01956955 hypothetical protein +FIG01956961 uncharacterized secreted protein, YBBR Bacillus subtilis homolog +FIG01956963 Amino acid ABC transporter, ATP-binding protein +FIG01956965 membrane protein +FIG01956966 MSM (multiple sugar metabolism) operon regulatory protein +FIG01956967 tellurium resistance protein TerD +FIG01956969 hypothetical protein +FIG01956973 2-haloalkanoic acid dehalogenase (EC 3.8.1.2) +FIG01956974 transposon protein +FIG01956975 pncL +FIG01956976 diacylglycerol kinase catalytic domain protein +FIG01956977 Phage lysin, glycosyl hydrolase, family 25 +FIG01956982 hypothetical protein +FIG01956984 ABC transporter permease protein +FIG01956986 Arginine repressor ArgR, putative +FIG01956988 Lon-like protease with PDZ domain +FIG01956989 Chloride channel (CIC) family protein +FIG01956990 TetR family transcriptional regulator +FIG01956991 hypothetical protein +FIG01956994 lipoprotein +FIG01956999 FIG009210: peptidase, M16 family +FIG01957002 Kae1-associated kinase +FIG01957003 hypothetical protein +FIG01957005 MutG family lantibiotic protection ABC superfamily ATP binding cassette transporter permease subunit +FIG01957006 3-oxoacyl-[acyl-carrier protein] reductase (EC 1.1.1.100) +FIG01957008 hypothetical protein +FIG01957013 hypothetical protein +FIG01957014 hypothetical protein +FIG01957016 hypothetical protein +FIG01957020 hypothetical protein +FIG01957021 Short chain dehydrogenase +FIG01957022 NanA gene +FIG01957023 FIG01116946: hypothetical protein +FIG01957026 hypothetical protein +FIG01957030 +FIG01957032 PTS system, fructose-specific IIA component / PTS system, fructose-specific IIB component (EC 2.7.1.69) / PTS system, fructose-specific IIC component +FIG01957033 ion channel +FIG01957036 hypothetical protein +FIG01957037 GNAT family acetyltransferase +FIG01957044 hypothetical protein +FIG01957050 Acetyltransferase, GNAT family +FIG01957058 hypothetical protein +FIG01957060 PTS system, hyaluronate-oligosaccharide-specific IIB component (EC 2.7.1.69) +FIG01957065 FIG00695783: hypothetical protein +FIG01957067 ABC transporter, ATP-binding/permease protein +FIG01957072 hypothetical protein +FIG01957081 transcriptional regulator, TetR family +FIG01957082 hypothetical protein +FIG01957084 TonB-dependent receptor +FIG01957085 UPF0135 protein Bsu YqfO +FIG01957091 FIG00772004: hypothetical protein +FIG01957093 ABC transporter, ATP-binding/permease protein +FIG01957094 ABC transporter family protein +FIG01957099 hypothetical protein +FIG01957100 hypothetical protein +FIG01957101 Na+/H+ antiporter +FIG01957102 4-carboxymuconolactone decarboxylase (EC 4.1.1.44) +FIG01957103 Multiple sugar ABC transporter, substrate-binding protein +FIG01957105 Integral membrane protein +FIG01957111 Arginine repressor ArgR, putative +FIG01957112 FIG01116924: hypothetical protein +FIG01957116 NanA gene +FIG01957118 hypothetical protein +FIG01957119 hypothetical protein +FIG01957121 NanA gene +FIG01957122 hypothetical protein +FIG01957126 Na+/H+ antiporter +FIG01957127 membrane protein +FIG01957130 Helicase loader DnaB +FIG01957133 hypothetical protein +FIG01957135 FIG014387: Transcriptional regulator, PadR family +FIG01957137 Multiple sugar ABC transporter, substrate-binding protein +FIG01957138 FIG01117728: hypothetical protein +FIG01957140 N-acyl-L-amino acid amidohydrolase (EC 3.5.1.14) +FIG01957143 FIG01114021: hypothetical protein +FIG01957144 Neopullulanase (EC 3.2.1.135) +FIG01957146 hypothetical protein +FIG01957147 PTS system, fructose-specific IIA component (EC 2.7.1.69) / PTS system, fructose-specific IIB component (EC 2.7.1.69) / PTS system, fructose-specific IIC component (EC 2.7.1.69) +FIG01957149 hypothetical protein +FIG01957150 hypothetical protein +FIG01957151 hypothetical protein +FIG01957152 Putative hemagglutinin/hemolysin-related protein +FIG01957154 ABC transporter, ATP-binding/permease protein +FIG01957156 NanA gene +FIG01957157 hypothetical protein +FIG01957160 hypothetical protein +FIG01957161 hypothetical protein +FIG01957162 NAD(P)H-dependent glycerol-3-phosphate dehydrogenase +FIG01957163 Putative deoxyribose-specific ABC transporter, permease protein +FIG01957168 acetyltransferase, GNAT family +FIG01957169 transcription regulator +FIG01957171 hypothetical protein +FIG01957172 Beta-lactamase (EC 3.5.2.6) +FIG01957177 hypothetical protein +FIG01957178 PTS system, N-acetylgalactosamine- and galactosamine-specific IIA component +FIG01957182 ABC transporter, ATP-binding/permease protein +FIG01957187 Nucleoside-binding protein +FIG01957189 hypothetical protein +FIG01957192 Vitamin B12 ABC transporter, B12-binding component BtuF +FIG01957196 FIG01117778: hypothetical protein +FIG01957199 FIG01114096: hypothetical protein +FIG01957205 Multiple sugar ABC transporter, membrane-spanning permease protein MsmF +FIG01957208 FIG01114191: hypothetical protein +FIG01957209 Short chain dehydrogenase +FIG01957210 Phage lysin, glycosyl hydrolase, family 25 +FIG01957211 Death on curing protein, Doc toxin +FIG01957212 ISSpn1, transposase, IS3 family, truncated +FIG01957219 Alpha-amylase (EC 3.2.1.1) +FIG01957220 hypothetical protein +FIG01957222 antibiotic ABC superfamily ATP binding cassette transporter permease protein +FIG01957225 Phage protein +FIG01957227 Transcriptional regulator, TetR family +FIG01957229 hypothetical protein +FIG01957230 putative transport system permease protein +FIG01957232 Type 4 prepilin peptidase pilD +FIG01957237 Trehalose-6-phosphate hydrolase (EC 3.2.1.93) +FIG01957239 Probable transcription regulator +FIG01957240 hypothetical protein +FIG01957245 transcription antiterminator LicT +FIG01957251 MutT/nudix family protein +FIG01957252 putative transposon integrase; Tn916 ORF3-like +FIG01957254 Neopullulanase (EC 3.2.1.135) +FIG01957256 SAM-dependent methyltransferase, MraW methylase family (EC 2.1.1.-) +FIG01957257 hypothetical protein +FIG01957263 Hypothetical sugar kinase TM0795, PfkB family +FIG01957264 FIG01117505: hypothetical protein +FIG01957267 FIG01115489: hypothetical protein +FIG01957272 FIG01114037: hypothetical protein +FIG01957273 N-terminal domain of CinA protein, COG1058 / C-terminal domain of CinA type S +FIG01957274 predicted membrane protein +FIG01957276 Neopullulanase (EC 3.2.1.135) +FIG01957279 Cold shock protein CspA +FIG01957280 Type I restriction-modification system, specificity subunit S (EC 3.1.21.3) +FIG01957281 Tellurium resistance protein TerD +FIG01957282 Mutator mutT protein (7,8-dihydro-8-oxoguanine-triphosphatase) (EC 3.6.1.-) +FIG01957284 Arginine repressor ArgR, putative +FIG01957286 TetR/AcrR family transcriptional regulator +FIG01957292 putative membrane protein +FIG01957297 Transposase +FIG01957298 GTP-binding protein +FIG01957300 FIG001621: Zinc protease +FIG01957305 Endo-beta-N-acetylglucosaminidase (EC 3.2.1.96) +FIG01957308 N-ethylammeline chlorohydrolase +FIG01957313 FIG01114918: hypothetical protein +FIG01957315 FIG00849775: hypothetical protein +FIG01957318 cobalt ABC transporter ATP-binding protein +FIG01957320 NanA gene +FIG01957324 YjbE family integral membrane protein +FIG01957327 beta-lactamase type II +FIG01957332 L-aspartate oxidase (EC 1.4.3.16) +FIG01957336 MSM (multiple sugar metabolism) operon regulatory protein +FIG01957340 TetR family transcriptional regulator +FIG01957341 transcriptional regulator, Cro/CI family +FIG01957345 ABC superfamily ATP binding cassette transporter ABC protein +FIG01957347 FIG01115595: hypothetical protein +FIG01957349 FIG01115096: hypothetical protein +FIG01957354 hypothetical protein +FIG01957356 FIG01114766: hypothetical protein +FIG01957357 FIG001621: Zinc protease +FIG01957362 camphor resistance protein CrcB2 +FIG01957363 Phage capsid and scaffold +FIG01957364 hypothetical protein +FIG01957367 Prophage Lp1 protein 6 +FIG01957370 hypothetical protein +FIG01957372 hypothetical protein +FIG01957376 hypothetical protein +FIG01957378 hypothetical protein +FIG01957379 COG1242: Predicted Fe-S oxidoreductase +FIG01957380 hypothetical protein +FIG01957381 Ribosomal small subunit pseudouridine synthase A (EC 4.2.1.70) +FIG01957382 hypothetical protein +FIG01957383 TonB-dependent receptor +FIG01957386 FIG01114516: hypothetical protein +FIG01957388 phosphopyruvate hydratase +FIG01957390 hypothetical protein +FIG01957398 RNA methyltransferase, TrmA family +FIG01957399 LysR family transcriptional regulator +FIG01957400 glyoxalase +FIG01957404 hypothetical protein +FIG01957406 Integral membrane protein +FIG01957407 NanA gene +FIG01957409 putative repressor protein +FIG01957413 Predicted N-ribosylNicotinamide CRP-like regulator +FIG01957415 Lipid A export ATP-binding/permease protein MsbA +FIG01957419 ABC transporter BlpC or comB +FIG01957421 protein of hypothetical function DUF262 +FIG01957424 hypothetical protein +FIG01957425 Type I restriction-modification system, specificity subunit S (EC 3.1.21.3) +FIG01957426 hypothetical protein +FIG01957428 hypothetical protein +FIG01957430 Cysteine ABC transporter, permease protein +FIG01957431 FIG01115449: hypothetical protein +FIG01957432 conserved hypothetical protein, putative protein kinase +FIG01957434 FIG01120689: hypothetical protein +FIG01957435 ABC transporter permease protein +FIG01957439 Beta-1,3-glucosyltransferase +FIG01957441 hypothetical protein +FIG01957446 hypothetical protein +FIG01957447 hypothetical protein +FIG01957448 hypothetical protein +FIG01957457 hypothetical protein +FIG01957460 Aconitate hydratase (EC 4.2.1.3) +FIG01957461 lipoprotein +FIG01957463 ribose-phosphate pyrophosphokinase +FIG01957472 histone acetyltransferase Gcn5, putative +FIG01957475 iron ABC superfamily ATP binding cassette transporter, membrane protein +FIG01957476 hypothetical protein +FIG01957481 Mobile element protein +FIG01957483 Lyzozyme M1 (1,4-beta-N-acetylmuramidase) (EC 3.2.1.17) +FIG01957485 FIG01118090: hypothetical protein +FIG01957488 glyoxalase +FIG01957489 hypothetical protein +FIG01957490 brp/Blh family beta-carotene 15,15'-monooxygenase +FIG01957495 hypothetical protein +FIG01957498 hypothetical protein +FIG01957503 acetyltransferase +FIG01957505 ferrichrome ABC superfamily ATP binding cassette transporter, ABC protein +FIG01957512 N-ethylammeline chlorohydrolase +FIG01957513 conserved hypothetical protein +FIG01957515 hypothetical protein +FIG01957518 hypothetical protein +FIG01957519 YjbE family integral membrane protein +FIG01957522 Acetyltransferase, putative +FIG01957523 hypothetical protein - phage associated +FIG01957525 RNA methyltransferase, TrmA family +FIG01957530 FIG01114212: hypothetical protein +FIG01957542 putative domain protein +FIG01957543 3-oxoacyl-[acyl-carrier protein] reductase (EC 1.1.1.100) +FIG01957545 hypothetical protein +FIG01957548 Diadenosine tetraphosphatase and related serine/threonine protein phosphatases +FIG01957551 hypothetical protein +FIG01957557 Transcriptional regulator, DeoR family +FIG01957558 UPF0135 protein Bsu YqfO +FIG01957562 FIG01114766: hypothetical protein +FIG01957565 Vitamin B12 ABC transporter, B12-binding component BtuF +FIG01957568 ferrichrome ABC superfamily ATP binding cassette transporter, permease protein +FIG01957570 histidine kinase +FIG01957572 FIG011440: Integral membrane protein +FIG01957576 ABC transporter ATP-binding protein +FIG01957578 helix-turn-helix domain protein +FIG01957587 glutamine ABC superfamily ATP binding cassette transporter, ABC protein +FIG01957589 DJ-1/PfpI family protein +FIG01957591 conserved hypothetical protein - phage associated +FIG01957595 phage integrase family protein +FIG01957597 hypothetical protein +FIG01957599 UvrABC system protein B +FIG01957602 Signal transduction histidine kinase +FIG01957603 ABC-type amino acid transport/signal transduction systems, periplasmic component/domain +FIG01957604 tRNA-dependent lipid II--L-alanine ligase / tRNA-dependent lipid II-Ala--L-alanine ligase +FIG01957606 BOX elements +FIG01957607 N-ethylammeline chlorohydrolase +FIG01957608 hypothetical protein +FIG01957611 Endo-beta-N-acetylglucosaminidase (EC 3.2.1.96) +FIG01957612 transcriptional regulator +FIG01957623 GNAT family acetyltransferase +FIG01957626 alpha/beta fold family hydrolase +FIG01957627 FIG01118403: hypothetical protein +FIG01957628 ABC transporter permease protein +FIG01957631 FIG01117948: hypothetical protein +FIG01957637 ABC superfamily ATP binding cassette transporter ATP binding/permease +FIG01957638 hypothetical protein +FIG01957640 hypothetical protein +FIG01957643 hypothetical protein +FIG01957647 Beta-lactamase (EC 3.5.2.6) +FIG01957651 FIG01118802: hypothetical protein +FIG01957653 hypothetical protein +FIG01957654 predicted membrane protein +FIG01957658 FIG009210: peptidase, M16 family +FIG01957661 putative lipoprotein +FIG01957672 hypothetical protein +FIG01957673 hypothetical protein +FIG01957679 ABC transporter ATP binding protein +FIG01957681 Endo-beta-N-acetylglucosaminidase (EC 3.2.1.96) +FIG01957682 Probable transmembrane protein +FIG01957683 conserved hypothetical protein +FIG01957684 Exopolysaccharide biosynthesis transcriptional activator EpsA +FIG01957688 Competence/damage-inducible protein CinA +FIG01957691 ABC-transporter (ATP-binding protein) -possibly involved in cell wall localization and side chain formation of rhamnose-glucose polysaccharide +FIG01957695 hypothetical protein +FIG01957699 FIG01114020: hypothetical protein +FIG01957704 Beta-lactamase, class C +FIG01957707 3-oxoacyl-[acyl-carrier protein] reductase (EC 1.1.1.100) +FIG01957710 putative endonuclease, point mutation +FIG01957712 Cps6bQ +FIG01957713 Glucan 1,6-alpha-glucosidase (EC 3.2.1.70) +FIG01957716 transcriptional regulator +FIG01957719 Lipid A export ATP-binding/permease protein MsbA +FIG01957724 ABC transporter, ATP-binding protein +FIG01957733 dam-replacing family protein +FIG01957739 N-acyl-L-amino acid amidohydrolase (EC 3.5.1.14) +FIG01957742 ABC transporter, ATP-binding/permease protein +FIG01957744 hypothetical protein +FIG01957746 Beta-1,3-glucosyltransferase +FIG01957752 hypothetical protein +FIG01957753 hypothetical protein +FIG01957756 hypothetical protein +FIG01957757 Short chain dehydrogenase +FIG01957769 PTS system, glucitol/sorbitol-specific IIA component +FIG01957771 Short chain dehydrogenase +FIG01957772 spn1, transposase Orf2 +FIG01957778 calcium-binding protein, putative +FIG01957780 Integrase/recombinase, phage associated +FIG01957784 hypothetical protein +FIG01957788 unknown +FIG01957798 Multiple sugar ABC transporter, membrane-spanning permease protein MsmG +FIG01957803 DNA-binding protein +FIG01957806 Choline binding protein PcpA +FIG01957812 N-acyl-L-amino acid amidohydrolase (EC 3.5.1.14) +FIG01957815 hydrolase, alpha/beta fold family +FIG01957821 Probable sugar ABC transporter, sugar-binding protein +FIG01957822 Degenerative transposase +FIG01957825 Conserved domain protein +FIG01957826 hypothetical protein +FIG01957830 FIG01119245: hypothetical protein +FIG01957832 putative extracellular protein +FIG01957836 Phage single-strand DNA binding protein +FIG01957838 hypothetical protein +FIG01957842 hypothetical protein +FIG01957843 hypothetical protein +FIG01957855 Ribosomal-protein-serine acetyltransferase (EC 2.3.1.-) +FIG01957860 FIG001621: Zinc protease +FIG01957864 PTS system, fructose-specific IIA component / PTS system, fructose-specific IIB component (EC 2.7.1.69) / PTS system, fructose-specific IIC component +FIG01957867 MutS-related protein, family 1 +FIG01957869 transcriptional regulator +FIG01957872 ATP/GTP-binding protein +FIG01957873 hypothetical protein +FIG01957875 UPF0135 protein Bsu YqfO +FIG01957895 ABC transporter permease protein +FIG01957897 hypothetical protein +FIG01957899 phage protein +FIG01957904 Predicted transcriptional regulator +FIG01957907 hypothetical protein +FIG01957916 PTS system, L-fucose-specific IIA component (EC 2.7.1.69) +FIG01957920 Bipolar DNA helicase +FIG01957923 putative ATPase +FIG01957924 conserved hypothetical protein +FIG01957928 ABC superfamily ATP binding cassette transporter, ABC protein +FIG01957929 protein of hypothetical function DUF262 +FIG01957940 ABC transporter ATP-binding protein +FIG01957941 N-ethylammeline chlorohydrolase +FIG01957949 glycyl-tRNA synthetase subunit alpha +FIG01957955 PTS system, N-acetylgalactosamine-specific IID component +FIG01957957 putative membrane protein +FIG01957958 hypothetical protein +FIG01957960 FIG01115977: hypothetical protein +FIG01957965 FIG01119053: hypothetical protein +FIG01957969 cytosolic protein +FIG01957972 hypothetical protein +FIG01957974 50S ribosomal protein L22 +FIG01957977 FIG009210: peptidase, M16 family +FIG01957984 PTS system, fructose-specific IIA component (EC 2.7.1.69) +FIG01957988 putative bacteriocin +FIG01958005 putative transport ATP-binding protein +FIG01958006 FIG00631813: hypothetical protein +FIG01958008 hypothetical protein +FIG01958010 cell wall surface anchor family protein +FIG01958011 +FIG01958017 N-acyl-L-amino acid amidohydrolase (EC 3.5.1.14) +FIG01958029 Endo-beta-N-acetylglucosaminidase (EC 3.2.1.96) +FIG01958031 FIG001621: Zinc protease +FIG01958035 PTS system, maltose and glucose-specific IIC component (EC 2.7.1.69) / PTS system, maltose and glucose-specific IIB component (EC 2.7.1.69) / PTS system, maltose and glucose-specific IIA component (EC 2.7.1.69) +FIG01958041 Integral membrane protein +FIG01958042 UDP-N-acetylmuramoylalanyl-D-glutamyl-2,6-diaminopimelate--D-alanyl-D-alanine ligase (EC 6.3.2.10) +FIG01958048 unknown +FIG01958051 Oligoendopeptidase F (EC 3.4.24.-) +FIG01958058 Chloride channel protein +FIG01958059 ABC superfamily ATP binding cassette transporter, membrane protein +FIG01958063 conserved hypothetical protein +FIG01958064 Glutathione reductase (EC 1.8.1.7) +FIG01958069 Zinc ABC transporter, ATP-binding protein ZnuC +FIG01958072 Short chain dehydrogenase +FIG01958073 Retron-type RNA-directed DNA polymerase (EC 2.7.7.49) +FIG01958079 FIG01115840: hypothetical protein +FIG01958084 predicted membrane protein +FIG01958097 Maltose operon transcriptional repressor MalR, LacI family +FIG01958098 hypothetical protein +FIG01958099 FIG01114468: hypothetical protein +FIG01958103 Arginine repressor ArgR, putative +FIG01958110 putative HsdR +FIG01958114 conserved hypothetical protein +FIG01958128 HD domain protein +FIG01958130 FIG01115450: hypothetical protein +FIG01958135 hypothetical protein +FIG01958139 FIG01116753: hypothetical protein +FIG01958141 FIG01119382: hypothetical protein +FIG01958142 Neopullulanase (EC 3.2.1.135) +FIG01958146 ABC transporter membrane-spanning permease - macrolide efflux +FIG01958147 NanA gene +FIG01958167 Type I restriction-modification system, DNA-methyltransferase subunit M (EC 2.1.1.72) +FIG01958173 hypothetical protein +FIG01958183 hypothetical protein +FIG01958184 hypothetical protein +FIG01958188 Unknown +FIG01958194 hypothetical protein +FIG01958201 hypothetical protein +FIG01958205 Multiple sugar ABC transporter, membrane-spanning permease protein MsmF +FIG01958213 zinc-binding dehydrogenase family oxidoreductase +FIG01958217 hypothetical protein +FIG01958220 Transcriptional regulator, ArsR family +FIG01958222 predicted membrane protein +FIG01958225 acetyltransferase, GNAT family +FIG01958226 Receptor polysaccharide phosphotransferase wefC (EC 2.7.-.-) (Stealth protein wefC) +FIG01958232 Multi Antimicrobial Extrusion (MATE) family transporter +FIG01958247 hypothetical protein +FIG01958255 +FIG01958256 predicted membrane protein +FIG01958257 hypothetical protein +FIG01958258 hypothetical protein +FIG01958266 ABC transporter, ATP-binding/permease protein +FIG01958268 ABC transporter ATP-binding protein YvcR +FIG01958270 transcriptional regulator +FIG01958271 Sensor histidine kinase VraS +FIG01958286 Ribosomal small subunit pseudouridine synthase A (EC 4.2.1.70) +FIG01958291 GtrA family protein +FIG01958292 PTS system, fructose-specific IIC component +FIG01958296 hypothetical protein +FIG01958299 hypothetical protein +FIG01958313 brp/Blh family beta-carotene 15,15'-monooxygenase +FIG01958319 Phage protein +FIG01958336 Histidine triad (HIT) nucleotide-binding protein, similarity with At5g48545 and yeast YDL125C (HNT1) +FIG01958337 +FIG01958350 hypothetical protein +FIG01958361 Transcription antiterminator, BglG family (EC 2.7.1.69) +FIG01958363 FIG009210: peptidase, M16 family +FIG01958369 FIG001621: Zinc protease +FIG01958383 putative transport system permease protein +FIG01958386 FIG01114989: hypothetical protein +FIG01958389 CAAX amino protease +FIG01958402 hypothetical protein +FIG01958412 hypothetical protein +FIG01958425 hypothetical protein +FIG01958426 SMI1/KNR4 family protein +FIG01958436 N-ethylammeline chlorohydrolase +FIG01958440 hypothetical protein +FIG01958444 Cysteine ABC transporter, substrate-binding protein +FIG01958445 Lactoylglutathione lyase and related lyases +FIG01958452 Cardiolipin synthetase (EC 2.7.8.-) +FIG01958459 Endo-beta-N-acetylglucosaminidase (EC 3.2.1.96) +FIG01958461 TetR/AcrR family transcriptional regulator +FIG01958465 putative methyltransferase-endonuclease +FIG01958475 FIG01118680: hypothetical protein +FIG01958487 hypothetical protein +FIG01958490 hypothetical protein +FIG01958491 Positive transcriptional regulator, MutR family +FIG01958494 hypothetical protein +FIG01958497 major facilitator family transporter +FIG01958530 putative transcriptional regulator +FIG01958543 hypothetical protein +FIG01958568 Acetyltransferase, GNAT family +FIG01958582 hypothetical protein +FIG01958615 N-terminal acetyltransferase related protein +FIG01958616 hypothetical protein +FIG01958648 GNAT family acetyltransferase +FIG01958657 MSM (multiple sugar metabolism) operon regulatory protein +FIG01958659 hypothetical protein +FIG01958672 hypothetical protein +FIG01958708 conjugative transposon protein +FIG01958718 TetR family transcriptional regulator +FIG01958735 hypothetical protein +FIG01958767 hypothetical protein +FIG01958790 Short chain dehydrogenase +FIG01958800 Glyoxalase family protein +FIG01958803 hypothetical protein +FIG01958805 Degenerative transposase +FIG01958807 Ribosomal small subunit pseudouridine synthase A (EC 4.2.1.70) +FIG01958810 tRNA dimethylallyltransferase (EC 2.5.1.75) +FIG01958812 "SSU rRNA (adenine(1518)-N(6)/adenine(1519)- N(6))-dimethyltransferase " +FIG01958814 Dihydropteroate synthase (EC 2.5.1.15) / 2-amino-4-hydroxy-6-hydroxymethyldihydropteridine pyrophosphokinase (EC 2.7.6.3) +FIG01958815 hypothetical protein +FIG01958821 dihydrouridine synthase family protein +FIG01958823 Hydroxymethylpyrimidine phosphate synthase ThiC (EC 4.1.99.17) +FIG01958828 RNA methyltransferase, TrmH family +FIG01958829 Uncharacterized protein EC-HemY, likely associated with heme metabolism based on gene clustering with hemC, hemD in Proteobacteria (unrelated to HemY-type PPO in GramPositives) +FIG01958832 CsbD family protein +FIG01958834 Phenylacetate-coenzyme A ligase (EC 6.2.1.30) PaaF +FIG01958835 tRNA (cytidine(34)-2'-O)-methyltransferase (EC 2.1.1.207) +FIG01958836 Predicted secretion system W protein GspG-like 2 +FIG01958837 Two component transcriptional regulator, LuxR family +FIG01958838 thiamine pyrophosphokinase +FIG01958840 General secretion pathway protein F +FIG01958841 Phage portal (connector) protein +FIG01958842 General secretion pathway protein E +FIG01958845 Cu+ P-type ATPase; FUPA27 P-type ATPase +FIG01958846 FUPA29 P-type ATPase; FUPA27 P-type ATPase +FIG01958847 Cu+ P-type ATPase fragment; FUPA27 P-type ATPase fragment +FIG01958848 Metal-dependent hydrolase +FIG01958849 Possible phosphodiesterase +FIG01958850 Proline,Na+ Cotransport +FIG01958851 Sodium/proline symporter +FIG01958852 sodium-solute symporter, putative +FIG01958855 tRNA (uracil(54)-C5)-methyltransferase (EC 2.1.1.35) +FIG01958857 Alkaline phosphodiesterase I (EC 3.1.4.1) @ Nucleotide pyrophosphatase (EC 3.6.1.9) +FIG01958858 Diguanylate cyclase +FIG01958859 FIG006789: Stage V sporulation protein; Low temperature requirement B protein +FIG01958861 Cytoplasmic hypothetical protein DUF199, a subgroup +FIG01958862 tRNA (guanosine(18)-2'-O)-methyltransferase (EC 2.1.1.34) +FIG01958863 Anti-sigma B factor RsbT +FIG01958864 Propanediol utilization protein similar to EutJ +FIG01958865 TldE protein, part of TldE/TldD proteolytic complex +FIG01958866 TldD protein, part of TldE/TldD proteolytic complex +FIG01958868 FIG002813: LPPG:FO 2-phospho-L-lactate transferase like, CofD-like +FIG01958872 S-adenosylhomocysteine deaminase ; Methylthioadenosine deaminase +FIG01958874 Cationic amino acid transport integral membrane protein +FIG01958875 hypothetical protein +FIG01958877 Rhodanese domain protein +FIG01958878 Glutamate decarboxylase and related pyridoxal-dependent proteins +FIG01958880 PROBABLE PYRUVATE FORMATE LYASE ACTIVATING PROTEIN PFLA (FORMATE ACETYLTRANSFERASE ACTIVATING ENZYME) ([PYRUVATE FORMATE-LYASE] ACTIVATING ENZYME) (EC 1.97.1.4) +FIG01958881 tRNA (5-methylaminomethyl-2-thiouridylate)-methyltransferase (EC 2.1.1.61) / FAD-dependent cmnm(5)s(2)U34 oxidoreductase +FIG01958882 5-methylaminomethyl-2-thiouridine-forming enzyme mnmC +FIG01958885 16S rRNA (guanine(966)-N(2))-methyltransferase (EC 2.1.1.171) +FIG01958886 Glutamyl aminopeptidase (EC 3.4.11.7) @ Prolyl aminopeptidase (EC 3.4.11.5) +FIG01958888 Prevent host death protein, Phd antitoxin +FIG01958889 ParA-like membrane-associated ATPase +FIG01958890 Transcriptional regulator, LysR family +FIG01958891 Ubiquinone biosynthesis methyltransferase COQ5, mitochondrial precursor (EC 2.1.1.-) +FIG01958892 Transcriptional regulator, AraC family +FIG01958893 hypothetical protein +FIG01958897 Uncharacterized domain COG3236 / GTP cyclohydrolase II (EC 3.5.4.25) +FIG01958898 Alginate o-acetyltransferase AlgF +FIG01958899 Poly (beta-D-mannuronate) C5 epimerase precursor (EC 5.1.3.-) +FIG01958902 Dihydroneopterin aldolase (EC 4.1.2.25) / 2-amino-4-hydroxy-6-hydroxymethyldihydropteridine pyrophosphokinase (EC 2.7.6.3) / 2-amino-4-hydroxy-6-hydroxymethyldihydropteridine pyrophosphokinase (EC 2.7.6.3) +FIG01958907 Phage terminase +FIG01958908 Kf-pending protein +FIG01958909 Outer membrane protein AlgE +FIG01958910 Pyruvate dehydrogenase complex repressor +FIG01958913 deoxyhypusine synthase +FIG01958914 Probable deoxyhypusine synthase 1 (EC 2.5.1.46) +FIG01958915 Kynurenine 3-monooxygenase (EC 1.14.13.9) homolog +FIG01958916 putative monooxygenase +FIG01958917 Sensor histidine kinase +FIG01958919 S-adenosylmethionine-dependent methyltransferase +FIG01958920 SAM-dependent methyltransferases +FIG01958921 putative DNA-binding protein +FIG01958922 PnuC-like transporter of unknown specificity +FIG01958923 Transcriptional regulator, LysR family +FIG01958925 2-dehydropantoate 2-reductase +FIG01958927 Error-prone repair homolog of DNA polymerase III alpha subunit (EC 2.7.7.7) +FIG01958928 AMMECR1 domain protein +FIG01958929 hypothetical protein +FIG01958930 Alginate biosynthesis protein AlgJ +FIG01958938 Cu+ P-type ATPase +FIG01958939 Copper-translocating P-type ATPase (EC 3.6.3.4); FUPA31 P-type ATPase +FIG01958940 membrane-flanked domain +FIG01958941 protein-L-isoaspartate methyltransferase-like protein +FIG01958942 5-Formyltetrahydrofolate cycloligase paralog implicated in thiamin metabolism +FIG01958943 Succinate-semialdehyde dehydrogenase [NADP+] (EC 1.2.1.16) +FIG01958944 tRNA (Guanine37-N1) -methyltransferase (EC 2.1.1.31) +FIG01958945 protein of unknown function aq_054 +FIG01958946 Deoxycytidine triphosphate deaminase (EC 3.5.4.30) (dUMP-forming) +FIG01958947 Poly (beta-D-mannuronate) lyase (EC 4.2.2.3) +FIG01958948 Anti-sigma F factor antagonist (spoIIAA-2); Anti-sigma B factor antagonist RsbV +FIG01958949 Novel pyridoxal kinase, thiD family (EC 2.7.1.35) +FIG01958950 Hydroxymethylpyrimidine phosphate kinase ThiD (EC 2.7.4.7) +FIG01958951 hypothetical protein +FIG01958953 Manganese uptake regulation protein MUR +FIG01958954 Carbon monoxide dehydrogenase large chain (EC 1.2.99.2) parolog without usual motifs +FIG01958957 Alcohol dehydrogenase, zinc-binding protein +FIG01958958 VWA containing CoxE family protein +FIG01958959 Acetate kinase (EC 2.7.2.1) @ Propionate kinase (EC 2.7.2.15) +FIG01958960 Chlorohydrolase/deaminase family protein +FIG01958961 amidohydrolase +FIG01958964 Ribosomal RNA small subunit methyltransferase B (EC 2.1.1.-) +FIG01958965 FAD/FMN-containing dehydrogenase +FIG01958967 2-methylaconitate cis-trans isomerase +FIG01958970 Predicted secretion system W protein GspD-like +FIG01958974 hypothetical protein +FIG01958977 protein of unknown function DUF52 +FIG01958983 Phage protein inside capsid C +FIG01958985 Phage protein inside capsid D +FIG01958986 ADP-ribose pyrophosphatase +FIG01958987 Pyrophosphatase, MutT/nudix family +FIG01958989 FAD pyrophosphatase (EC 3.6.1.18) +FIG01958990 mutT/nudix family protein +FIG01958991 NUDIX hydrolase +FIG01958992 Sugar transporter +FIG01958993 2-oxoglutarate decarboxylase (EC 4.1.1.71) +FIG01958995 Multi antimicrobial extrusion protein (Na(+)/drug antiporter), MATE family of MDR efflux pumps +FIG01958997 Phage tail completion protein +FIG01958998 SAM-dependent methyltransferase YafE (UbiE paralog) +FIG01958999 Bona fide RidA/YjgF/TdcF/RutC subgroup +FIG01959000 Aspartate dehydrogenase homolog +FIG01959001 FIG017822: Ferredoxin +FIG01959002 Succinate-semialdehyde dehydrogenase [NAD] (EC 1.2.1.24); Succinate-semialdehyde dehydrogenase [NAD(P)+] (EC 1.2.1.16) +FIG01959003 Cl- channel, voltage-gated family protein +FIG01959004 Protein of unknown function DUF1341 +FIG01959007 FUPA32 P-type ATPase +FIG01959017 SirA family protein +FIG01959018 Phosphoglycolate phosphatase (EC 3.1.3.18) +FIG01959019 Ribosomal large subunit pseudouridine synthase B (EC 4.2.1.70) +FIG01959022 LysR family transcriptional regulator STM2281 +FIG01959024 COG1180: Radical SAM, Pyruvate-formate lyase-activating enzyme like +FIG01959025 CbbY family protein +FIG01959026 Putative CbbY homolog +FIG01959027 HAD-superfamily hydrolase, subfamily IA, variant 3 +FIG01959028 HAD-superfamily hydrolase subfamily IA, variant 3 +FIG01959029 Glycosyl transferase, family 2 +FIG01959030 Cinnamyl alcohol dehydrogenase/reductase (EC 1.1.1.195) @ Alcohol dehydrogenase (EC 1.1.1.1) +FIG01959031 1,3-propanediol dehydrogenase (EC 1.1.1.202) +FIG01959033 FIG010773: NAD-dependent epimerase/dehydratase +FIG01959034 RNA polymerase, sigma-24 subunit, ECF subfamily +FIG01959035 RNA polymerase sigma factor +FIG01959040 Cyclopropane-fatty-acyl-phospholipid synthase 1, CmaA1 (EC 2.1.1.79) +FIG01959042 Deoxyguanosinetriphosphate triphosphohydrolase (EC 3.1.5.1) +FIG01959043 L-glutamine synthetase +FIG01959053 CRISPR-associated protein, Csd2/Csh2 family +FIG01959057 Phage protein +FIG01959058 YrdC/Sua5 family protein, required for threonylcarbamoyladenosine (t(6)A) formation in tRNA +FIG01959060 Glycerate dehydrogenase (EC 1.1.1.29) +FIG01959063 Isochorismate synthase (EC 5.4.4.2) @ Phylloquinone-specific isochorismate synthase (EC 5.4.4.2) +FIG01959066 hypothetical protein +FIG01959069 O-succinylbenzoate synthase +FIG01959070 Carbon monoxide oxidation accessory protein CoxG +FIG01959071 Methyltransferase TM1293 +FIG01959072 VWA containing CoxE family protein +FIG01959074 Trehalose-6-phosphate phosphatase (EC 3.1.3.12) +FIG01959075 Alkyl hydroperoxide reductase and/or thiol-specific antioxidant family (AhpC/TSA) protein +FIG01959076 gamma-tocopherol methyltransferase (EC 2.1.1.95) @ delta-tocopherol methyltransferase (EC 2.1.1.95) +FIG01959079 Nudix hydrolase family protein +FIG01959081 tRNA dihydrouridine synthase B (EC 1.-.-.-) +FIG01959082 hypothetical protein +FIG01959083 protein of unknown function UPF0066 +FIG01959084 tRNA (5-methylaminomethyl-2-thiouridylate)-methyltransferase( EC:2.1.1.61 ) +FIG01959093 Glutamyl-tRNA synthetase (EC 6.1.1.17) @ Glutamyl-tRNA(Gln) synthetase (EC 6.1.1.24) +FIG01959095 FIG002344: Hydrolase (HAD superfamily) +FIG01959097 LSU m3Psi1915 methyltransferase RlmH +FIG01959099 hypothetical +FIG01959100 L-talarate dehydratase @ Galactarate dehydratase (EC 4.2.1.42) +FIG01959102 Heavy-metal-associated domain (N-terminus) and membrane-bounded cytochrome biogenesis cycZ-like domain, possible membrane copper tolerance protein +FIG01959103 Acetoin utilization protein AcuB +FIG01959104 Hydroxypyruvate isomerase (EC 5.3.1.22) +FIG01959105 Glycerol uptake facilitator protein +FIG01959106 Isocitrate dehydrogenase [NADP] (EC 1.1.1.42) +FIG01959107 5-methylthioribose kinase (EC 2.7.1.100) +FIG01959108 Choloylglycine hydrolase (EC 3.5.1.24) +FIG01959109 Positive regulator of L-idonate catabolism +FIG01959110 Glutathione biosynthesis bifunctional protein gshF (EC 6.3.2.2)(EC 6.3.2.3) +FIG01959111 "Phosphate butyryltransferase / Phosphate acetyltransferase " +FIG01959112 Inosine-5'-monophosphate dehydrogenase (EC 1.1.1.205) +FIG01959113 Tetraacyldisaccharide 4'-kinase (EC 2.7.1.130) +FIG01959115 BatA (Bacteroides aerotolerance operon) +FIG01959117 Catabolite control protein A +FIG01959119 Recombination inhibitory protein MutS2 +FIG01959120 2-hydroxy-3-keto-5-methylthiopentenyl-1- phosphate phosphatase +FIG01959122 Predicted transcriptional regulator of N-Acetylglucosamine utilization, GntR family +FIG01959123 Translation elongation factor P +FIG01959124 3-oxoacyl-[acyl-carrier-protein] synthase, KASII (EC 2.3.1.179) +FIG01959126 Predicted transcriptional regulator of the myo-inositol catabolic operon +FIG01959127 Toluene-4-monooxygenase, subunit TmoA alpha +FIG01959128 Tetrathionate reductase subunit A +FIG01959129 Cytochrome O ubiquinol oxidase subunit I (EC 1.10.3.-) +FIG01959131 N-acetyl-gamma-glutamyl-phosphate reductase (EC 1.2.1.38) +FIG01959132 Putative glucanase glgE (EC 3.2.1.-) +FIG01959133 Flagellar biosynthesis protein FliR +FIG01959134 tRNA (adenine57/58-N1)-methyltransferase (EC 2.1.1.36) +FIG01959135 Glycogen debranching enzyme (EC 3.2.1.-) +FIG01959136 NADP-specific glutamate dehydrogenase (EC 1.4.1.4) +FIG01959138 Ferredoxin--NADP(+) reductase (EC 1.18.1.2) +FIG01959139 4-hydroxyphenylacetate 3-monooxygenase (EC 1.14.13.3) +FIG01959140 Regulatory protein SoxS +FIG01959141 ABC-type nitrate/sulfonate/bicarbonate transport systems, periplasmic components +FIG01959142 Multidrug resistance transporter, Bcr/CflA family +FIG01959143 Cytochrome c oxidase subunit CcoO (EC 1.9.3.1) +FIG01959146 ABC transport system, permease component YbhS +FIG01959147 Aconitate hydratase (EC 4.2.1.3) +FIG01959148 Anaerobic glycerol-3-phosphate dehydrogenase subunit C (EC 1.1.5.3) +FIG01959149 Phosphoribosylformylglycinamidine synthase, synthetase subunit (EC 6.3.5.3) +FIG01959150 Flagellar hook-associated protein FlgK +FIG01959151 Ribose ABC transport system, ATP-binding protein RbsA (TC 3.A.1.2.1) +FIG01959152 Ribonuclease HI (EC 3.1.26.4) +FIG01959153 Phosphoribosylformylglycinamidine synthase, synthetase subunit (EC 6.3.5.3) / Phosphoribosylformylglycinamidine synthase, glutamine amidotransferase subunit (EC 6.3.5.3) +FIG01959154 TRAP transporter solute receptor, TAXI family precursor +FIG01959155 Aspartyl-tRNA(Asn) amidotransferase subunit C (EC 6.3.5.6) @ Glutamyl-tRNA(Gln) amidotransferase subunit C (EC 6.3.5.7) +FIG01959157 Fumarylacetoacetase (EC 3.7.1.2) +FIG01959158 Glutathione S-transferase (EC 2.5.1.18) +FIG01959159 Acyl carrier protein +FIG01959160 Cytoplasmic alpha-amylase (EC 3.2.1.1) +FIG01959161 FIG019733: possible DNA-binding protein +FIG01959162 Tricarboxylate transport membrane protein TctA +FIG01959163 7,8-didemethyl-8-hydroxy-5-deazariboflavin synthase subunit 1 / 7,8-didemethyl-8-hydroxy-5-deazariboflavin synthase subunit 2 +FIG01959164 Ascorbate-specific PTS system, EIIC component +FIG01959165 Nitrogen regulatory protein P-II +FIG01959169 Ribokinase (EC 2.7.1.15) +FIG01959170 Hydroxymethylglutaryl-CoA synthase (EC 2.3.3.10) +FIG01959171 Putrescine importer +FIG01959172 TRAP-type C4-dicarboxylate transport system, periplasmic component +FIG01959173 Carbon starvation protein A paralog +FIG01959175 Teichoic acid translocation permease protein TagG +FIG01959176 Nickel transport system permease protein NikC (TC 3.A.1.5.3) +FIG01959177 ADP-L-glycero-D-manno-heptose-6-epimerase (EC 5.1.3.20) +FIG01959178 G:T/U mismatch-specific uracil/thymine DNA-glycosylase +FIG01959179 Plasmid replication protein RepA +FIG01959180 Transcriptional regulator, IclR family +FIG01959181 LSU m5C1962 methyltransferase RlmI +FIG01959182 ABC transporter permease protein YvcS +FIG01959183 Maltose operon transcriptional repressor MalR, LacI family +FIG01959184 Dipeptide transport system permease protein DppB (TC 3.A.1.5.2); putative hemin permease +FIG01959185 FIG003492: Threonine dehydrogenase and related Zn-dependent dehydrogenases +FIG01959186 Putative electron transfer flavoprotein subunit YgcQ +FIG01959187 Electron transfer flavoprotein-ubiquinone oxidoreductase (EC 1.5.5.1) +FIG01959188 Biosynthetic arginine decarboxylase (EC 4.1.1.19) +FIG01959189 PTS system, mannose-specific IIC component (EC 2.7.1.69) +FIG01959190 Galactose/methyl galactoside ABC transport system, D-galactose-binding periplasmic protein MglB (TC 3.A.1.2.3) +FIG01959191 Propionyl-CoA carboxylase beta chain (EC 6.4.1.3) +FIG01959192 Anaerobic sulfite reductase subunit B +FIG01959193 Flagellar basal-body rod protein FlgF +FIG01959194 SSU ribosomal protein S8p (S15Ae) +FIG01959195 Dihydrolipoamide succinyltransferase component (E2) of 2-oxoglutarate dehydrogenase complex (EC 2.3.1.61) / 2-oxoglutarate dehydrogenase E1 component (EC 1.2.4.2) +FIG01959196 Phenylalanyl-tRNA synthetase domain protein (Bsu YtpR) +FIG01959197 Septation ring formation regulator EzrA +FIG01959198 Chemotaxis protein CheC -- inhibitor of MCP methylation +FIG01959199 3-hydroxybutyryl-CoA dehydrogenase (EC 1.1.1.157) +FIG01959201 Na(+) H(+) antiporter subunit D (TC 2.A.63.1.3) +FIG01959202 [Protein-PII] uridylyltransferase (EC 2.7.7.59) +FIG01959205 TonB-dependent receptor +FIG01959206 Purine trans deoxyribosylase (Nucleoside deoxyribosyltransferase-I) (EC 2.4.2.6) +FIG01959207 Cys regulon transcriptional activator CysB +FIG01959208 Metal-dependent hydrolase YbeY, involved in rRNA and/or ribosome maturation and assembly / Diacylglycerol kinase (EC 2.7.1.107) +FIG01959210 Biotin-protein ligase (EC 6.3.4.15) +FIG01959212 GTP-binding protein YqeH, required for biogenesis of 30S ribosome subunit +FIG01959213 Duplicated ATPase component MtsB of energizing module of methionine-regulated ECF transporter +FIG01959215 Putrescine transport system permease protein PotH (TC 3.A.1.11.2) +FIG01959216 Flagellar L-ring protein FlgH +FIG01959217 Transcription elongation factor GreA +FIG01959218 Penicillin-insensitive transglycosylase (EC 2.4.2.-) & transpeptidase PBP-1C +FIG01959219 D-glycerate 2-kinase (EC 2.7.1.-) +FIG01959220 Glutamate-1-semialdehyde aminotransferase (EC 5.4.3.8) +FIG01959221 Branched-chain amino acid transport system permease protein LivM (TC 3.A.1.4.1) +FIG01959222 Transcriptional regulator of catabolic arginine decarboxylase (adiA) +FIG01959225 Proline/sodium symporter PutP (TC 2.A.21.2.1) @ Propionate/sodium symporter +FIG01959226 LysR family regulatory protein CidR +FIG01959227 Flavodoxin reductases (ferredoxin-NADPH reductases) family 1; Vanillate O-demethylase oxidoreductase (EC 1.14.13.-) +FIG01959228 Tryptophan synthase alpha chain (EC 4.2.1.20) +FIG01959230 Queuosine Biosynthesis QueC ATPase +FIG01959231 Phosphoribosylaminoimidazole-succinocarboxamide synthase (EC 6.3.2.6) +FIG01959232 TonB family protein / TonB-dependent receptor +FIG01959234 Glucokinase (EC 2.7.1.2) +FIG01959237 Ferredoxin--NADP(+) reductase, actinobacterial (eukaryote-like) type (EC 1.18.1.2) +FIG01959238 Ribonuclease D (EC 3.1.26.3) +FIG01959239 Deoxyguanosinetriphosphate triphosphohydrolase (EC 3.1.5.1), subgroup 1 +FIG01959240 Conserved protein YcjX with nucleoside triphosphate hydrolase domain +FIG01959241 Pantothenate:Na+ symporter (TC 2.A.21.1.1) +FIG01959242 Shikimate/quinate 5-dehydrogenase I beta (EC 1.1.1.282) +FIG01959243 tRNA uridine 5-carboxymethylaminomethyl modification enzyme GidA +FIG01959244 Type II, N4M-methylcytosine DNA methyltransferase (group beta) +FIG01959245 Transmembrane component MtsC of energizing module of methionine-regulated ECF transporter +FIG01959246 CRISPR-associated protein, Csm2 family +FIG01959248 Putative outer membrane lipoprotein YmcA +FIG01959249 Isovaleryl-CoA dehydrogenase (EC 1.3.99.10); Butyryl-CoA dehydrogenase (EC 1.3.99.2) +FIG01959250 Fructose-1,6-bisphosphatase, GlpX type (EC 3.1.3.11) +FIG01959251 LSU ribosomal protein L2p (L8e) +FIG01959252 TldD protein, part of proposed TldE/TldD proteolytic complex (PMID 12029038) +FIG01959255 Molybdenum cofactor biosynthesis protein MoaA +FIG01959256 D-hydantoinase (EC 3.5.2.2) +FIG01959257 GDP-mannose 4,6-dehydratase (EC 4.2.1.47) +FIG01959259 Cytochrome c-type heme lyase subunit nrfF, nitrite reductase complex assembly +FIG01959260 NADH dehydrogenase, subunit 5 +FIG01959261 Cytochrome c-type biogenesis protein CcsA/ResC +FIG01959263 DJ-1/YajL/PfpI superfamily, includes chaperone protein YajL (former ThiJ), parkinsonism-associated protein DJ-1, peptidases PfpI, Hsp31 +FIG01959265 Anaerobic dimethyl sulfoxide reductase chain B (EC 1.8.5.3) +FIG01959266 Tryptophan synthase alpha chain (EC 4.2.1.20) +FIG01959267 Protein of unknown function Smg +FIG01959268 Dipeptidyl peptidase IV in 4-hydroxyproline catabolic gene cluster +FIG01959269 3-keto-L-gulonate-6-phosphate decarboxylase UlaD (EC 4.1.1.85) (L-ascorbate utilization protein D) +FIG01959270 Aspartokinase (EC 2.7.2.4) associated with ectoine biosynthesis +FIG01959271 ABC transporter involved in cytochrome c biogenesis, CcmB subunit +FIG01959272 Ornithine decarboxylase (EC 4.1.1.17) / Arginine decarboxylase (EC 4.1.1.19) +FIG01959273 MreB-like protein (Mbl protein) +FIG01959275 O-antigen flippase Wzx +FIG01959276 Propionyl-CoA carboxylase carboxyl transferase subunit (EC 6.4.1.3) +FIG01959277 Blue copper oxidase CueO precursor +FIG01959278 Gluconolactonase (EC 3.1.1.17) +FIG01959279 Cytochrome c-type biogenesis protein CcmC, putative heme lyase for CcmE +FIG01959280 CidA-associated membrane protein CidB +FIG01959281 Aerobactin siderophore receptor IutA +FIG01959282 COG3118: Thioredoxin domain-containing protein EC-YbbN +FIG01959284 Diaminopimelate epimerase (EC 5.1.1.7) +FIG01959286 Anaerobic sulfite reductase subunit C (EC 1.8.1.-) +FIG01959288 Heme efflux system permease HrtB +FIG01959289 Fumarate hydratase class II (EC 4.2.1.2) +FIG01959290 RNA methyltransferase, TrmA family +FIG01959293 Excinuclease ABC subunit C +FIG01959294 Chemotaxis protein CheV (EC 2.7.3.-) +FIG01959295 Bacterial luciferase family protein YtmO, in cluster with L-cystine ABC transporter +FIG01959296 3-dehydroquinate dehydratase I (EC 4.2.1.10) +FIG01959297 COG3178: Predicted phosphotransferase related to Ser/Thr protein kinases +FIG01959299 Octaprenyl diphosphate synthase (EC 2.5.1.90) / Dimethylallyltransferase (EC 2.5.1.1) / (2E,6E)-farnesyl diphosphate synthase (EC 2.5.1.10) / Geranylgeranyl diphosphate synthase (EC 2.5.1.29) +FIG01959300 ATPase, AFG1 family +FIG01959301 Predicted arginine uptake transporter +FIG01959302 N-carbamoylputrescine amidase (3.5.1.53) +FIG01959305 Cytochrome O ubiquinol oxidase subunit I (EC 1.10.3.-) +FIG01959307 Late competence protein ComGB, access of DNA to ComEA +FIG01959308 PTS system, lactose-specific IIA component (EC 2.7.1.69) +FIG01959309 ProQ: influences osmotic activation of compatible solute ProP +FIG01959310 Protein acetyltransferase +FIG01959311 PTS system, N-acetylglucosamine-specific IIB component (EC 2.7.1.69) / PTS system, N-acetylglucosamine-specific IIC component +FIG01959312 Hca operon (3-phenylpropionic acid catabolism) transcriptional activator HcaR +FIG01959314 tRNA-specific adenosine-34 deaminase (EC 3.5.4.-) +FIG01959315 Hypothetical protein SAV1869 +FIG01959316 Putative arylsulfatase regulatory protein +FIG01959317 Anaerobic glycerol-3-phosphate dehydrogenase subunit A (EC 1.1.5.3) +FIG01959318 formate dehydrogenase formation protein FdhE +FIG01959319 Electron transport complex protein RnfD +FIG01959320 Heteropolysaccharide repeat unit export protein +FIG01959321 Nopaline transporter permease protein NocQ +FIG01959322 Transcription regulator [contains diacylglycerol kinase catalytic domain] +FIG01959323 Teichuronic acid biosynthesis protein TuaE, putative secreted polysaccharide polymerase +FIG01959324 L-arabinose-binding periplasmic protein precursor AraF (TC 3.A.1.2.2) +FIG01959325 Glutamyl aminopeptidase (EC 3.4.11.7) +FIG01959327 Periplasmic aromatic aldehyde oxidoreductase, FAD binding subunit YagS +FIG01959328 Succinyl-CoA ligase [ADP-forming] alpha chain (EC 6.2.1.5) +FIG01959329 Glutathione synthetase (EC 6.3.2.3) +FIG01959331 Uracil-xanthine permease +FIG01959334 Cytochrome c heme lyase subunit CcmL / Cytochrome c heme lyase subunit CcmH +FIG01959335 Tetraacyldisaccharide 4'-kinase (EC 2.7.1.130) +FIG01959336 CO dehydrogenase accessory protein CooC (nickel insertion) +FIG01959340 Glutathione reductase (EC 1.8.1.7) +FIG01959342 Isovaleryl-CoA dehydrogenase (EC 1.3.99.10) +FIG01959343 Phage shock protein C +FIG01959344 O-acetylhomoserine sulfhydrylase (EC 2.5.1.49) / O-succinylhomoserine sulfhydrylase (EC 2.5.1.48) +FIG01959345 Inorganic pyrophosphatase (EC 3.6.1.1) +FIG01959346 Tricarboxylate transport protein TctC +FIG01959347 Rod shape-determining protein MreB +FIG01959348 Isocitrate lyase (EC 4.1.3.1) +FIG01959349 Formyltetrahydrofolate deformylase (EC 3.5.1.10) +FIG01959351 Oxaloacetate decarboxylase beta chain (EC 4.1.1.3) @ Methylmalonyl-CoA decarboxylase, beta chain (EC 4.1.1.41) +FIG01959352 Transcriptional regulator, LysR family, in glycolate utilization operon +FIG01959353 Lacto-N-biose phosphorylase (EC 2.4.1.211) +FIG01959354 Aspartyl-tRNA synthetase (EC 6.1.1.12) @ Aspartyl-tRNA(Asn) synthetase (EC 6.1.1.23) +FIG01959355 FIG009210: peptidase, M16 family +FIG01959356 LSU ribosomal protein L5p (L11e) +FIG01959357 Phage tail protein +FIG01959358 Dipeptide transport system permease protein DppC (TC 3.A.1.5.2) +FIG01959360 Acetyl-coenzyme A carboxyl transferase alpha chain (EC 6.4.1.2) / Acetyl-coenzyme A carboxyl transferase beta chain (EC 6.4.1.2); Propionyl-CoA carboxylase beta chain (EC 6.4.1.3) +FIG01959361 Tricarboxylate transport protein TctC +FIG01959365 Multimodular transpeptidase-transglycosylase (EC 2.4.1.129) (EC 3.4.-.-) +FIG01959368 2-oxo-4-hydroxy-4-carboxy--5-ureidoimidazoline (OHCU) decarboxylase / 5-Hydroxyisourate Hydrolase (HIUase) (EC 3.5.2.17) +FIG01959369 Magnesium and cobalt transport protein CorA +FIG01959370 D-glucarate permease +FIG01959372 Copper-sensing two-component system response regulator CusR +FIG01959373 Mannose-6-phosphate isomerase (EC 5.3.1.8) / Mannose-1-phosphate guanylyltransferase (GDP) (EC 2.7.7.22) +FIG01959374 Glycerol-3-phosphate regulon repressor, DeoR family +FIG01959375 Succinylglutamate desuccinylase (EC 3.5.1.96) +FIG01959377 AmpG permease +FIG01959378 Formate dehydrogenase N gamma subunit (EC 1.2.1.2) +FIG01959379 2-keto-3-deoxygluconate permease (KDG permease) +FIG01959381 Putrescine transport system permease protein PotI (TC 3.A.1.11.2) +FIG01959382 PTS system, fructose-specific IIB component (EC 2.7.1.69) / PTS system, fructose-specific IIC component (EC 2.7.1.69) +FIG01959383 Electron transfer flavoprotein, alpha subunit +FIG01959384 ATP-dependent Clp protease ATP-binding subunit ClpX +FIG01959385 Foldase protein PrsA precursor (EC 5.2.1.8) +FIG01959386 Xylose-responsive transcription regulator, ROK family +FIG01959387 AmpG permease +FIG01959388 Putative dihydroxyacetone kinase (EC 2.7.1.29), dihydroxyacetone binding subunit +FIG01959389 PTS system, cellobiose-specific IIB component (EC 2.7.1.69) +FIG01959390 Hydrogenase-4 maturation protease / Hydrogenase-4 maturation protease 2 +FIG01959391 Conjugative transfer protein TrbJ +FIG01959392 Formate dehydrogenase O beta subunit (EC 1.2.1.2) +FIG01959394 Succinylglutamic semialdehyde dehydrogenase (EC 1.2.1.71) +FIG01959395 NADH-ubiquinone oxidoreductase chain H (EC 1.6.5.3) +FIG01959396 Succinyl-CoA ligase [ADP-forming] alpha chain (EC 6.2.1.5) +FIG01959397 Maleylacetoacetate isomerase (EC 5.2.1.2) / Glutathione S-transferase +FIG01959398 Biotin carboxylase of acetyl-CoA carboxylase (EC 6.3.4.14) +FIG01959399 Serine--glyoxylate aminotransferase (EC 2.6.1.45) +FIG01959400 Phycoerythrin linker protein CpeS homolog +FIG01959401 Predicted 2-keto-4-pentenoate hydratase/2-oxohepta-3-ene-1,7-dioic acid hydratase +FIG01959403 GlpG protein (membrane protein of glp regulon) +FIG01959405 tRNA nucleotidyltransferase (EC 2.7.7.21) (EC 2.7.7.25) +FIG01959406 Indolepyruvate ferredoxin oxidoreductase, alpha and beta subunits +FIG01959407 Riboflavin synthase eubacterial/eukaryotic (EC 2.5.1.9) +FIG01959408 Fe-S-cluster-containing hydrogenase components 2 +FIG01959409 Taurine-binding periplasmic protein TauA +FIG01959410 Phenylalanine-specific permease +FIG01959411 Pyruvate dehydrogenase E1 component beta subunit (EC 1.2.4.1) +FIG01959412 Iron-sulfur cluster assembly ATPase protein SufC +FIG01959413 FIG011178: rRNA methylase +FIG01959414 Respiratory nitrate reductase gamma chain (EC 1.7.99.4) +FIG01959415 Benzoate 1,2-dioxygenase beta subunit (EC 1.14.12.10) +FIG01959416 Glutamate-1-semialdehyde aminotransferase (EC 5.4.3.8) +FIG01959417 Tartrate dehydrogenase (EC 1.1.1.93) / Tartrate decarboxylase (EC 4.1.1.73) / D-malic enzyme (EC 1.1.1.83) +FIG01959418 Glutathionylspermidine synthase (EC 6.3.1.8) / Glutathionylspermidine amidohydrolase (EC 3.5.1.78) +FIG01959419 Gamma-glutamyl-putrescine oxidase (EC1.4.3.-) +FIG01959421 Predicted L-lactate dehydrogenase, hypothetical protein subunit YkgG +FIG01959422 Alpha-ribazole-5'-phosphate phosphatase (EC 3.1.3.73) +FIG01959424 Aspartokinase (EC 2.7.2.4) +FIG01959425 Pyruvate kinase (EC 2.7.1.40) +FIG01959426 Serine protein kinase (prkA protein), P-loop containing +FIG01959427 Glutamyl-tRNA reductase (EC 1.2.1.70) +FIG01959428 SOS-response repressor and protease LexA (EC 3.4.21.88) +FIG01959429 Phosphoenolpyruvate carboxylase (EC 4.1.1.31) +FIG01959430 Inosose isomerase (EC 5.3.99.-) +FIG01959432 Chromosome initiation inhibitor +FIG01959433 Flagellar biosynthesis protein FliT +FIG01959435 GTP-binding protein related to HflX +FIG01959436 Phosphoribulokinase (EC 2.7.1.19) homolog, function unknown +FIG01959438 Putrescine importer +FIG01959439 Leucine dehydrogenase (EC 1.4.1.9) +FIG01959440 Dipeptide transport system permease protein DppB (TC 3.A.1.5.2) +FIG01959441 Rod shape-determining membrane protein MrdB (RodA) / Cell division protein FtsW +FIG01959442 Cysteine desulfurase CsdA-CsdE (EC 2.8.1.7), main protein CsdA +FIG01959443 Alkanesulfonates-binding protein +FIG01959444 Phosphopentomutase (EC 5.4.2.7) +FIG01959447 Heme A synthase, cytochrome oxidase biogenesis protein Cox15-CtaA +FIG01959449 FIG004819: Prepilin peptidase dependent protein B precursor +FIG01959450 4-hydroxyphenylacetate 3-monooxygenase, reductase component (EC 1.6.8.-) +FIG01959452 Transmembrane component BL0694 of energizing module of predicted ECF transporter +FIG01959454 L-O-lysylphosphatidylglycerol synthase (EC 2.3.2.3) / Lysyl-tRNA synthetase (class II) related protein found fused to membrane protein +FIG01959455 Polyphosphate kinase (EC 2.7.4.1) +FIG01959456 Nucleotide excision repair protein, with UvrB/UvrC motif +FIG01959458 Flagellar motor switch protein FliM +FIG01959459 "UDP-glucose:(heptosyl) LPS alpha1,3- glucosyltransferase WaaG " +FIG01959461 Glutaminyl-tRNA synthetase (EC 6.1.1.18) +FIG01959462 Similarity with glutathionylspermidine synthase (EC 6.3.1.8), group 2 +FIG01959463 Periplasmic beta-glucosidase (EC 3.2.1.21) +FIG01959464 D-glycerate transporter (predicted) +FIG01959465 18K peptidoglycan-associated outer membrane lipoprotein; Peptidoglycan-associated lipoprotein precursor; Outer membrane protein P6; OmpA/MotB precursor +FIG01959466 Ni/Fe-hydrogenase 2 B-type cytochrome subunit +FIG01959467 transmembrane protein, distant homology with ydbS +FIG01959468 Fumarate respiration sensor kinase protein DcuS +FIG01959469 LysR family transcriptional regulator YcjZ +FIG01959470 Di/tripeptide permease YbgH +FIG01959471 RNA polymerase associated protein RapA (EC 3.6.1.-) +FIG01959472 Heavy metal RND efflux outer membrane protein, CzcC family +FIG01959473 2-keto-3-deoxygluconate permease (KDG permease) +FIG01959474 Biotin--protein ligase (EC 6.3.4.9, EC 6.3.4.10, EC 6.3.4.11, EC 6.3.4.15) / Biotin operon repressor +FIG01959475 Replication factor C small subunit +FIG01959476 Transcriptional repressor of PutA and PutP / Proline dehydrogenase (EC 1.5.99.8) (Proline oxidase) / Delta-1-pyrroline-5-carboxylate dehydrogenase (EC 1.5.1.12) +FIG01959477 Gluconate permease +FIG01959478 1-acyl-sn-glycerol-3-phosphate acyltransferase (EC 2.3.1.51) +FIG01959479 Uptake hydrogenase large subunit (EC 1.12.99.6) +FIG01959480 Phosphoadenylyl-sulfate reductase [thioredoxin] (EC 1.8.4.8) / Adenylyl-sulfate reductase [thioredoxin] (EC 1.8.4.10) +FIG01959481 Putative polysaccharide export protein YccZ precursor +FIG01959484 Hydrolase, alpha/beta fold family functionally coupled to Phosphoribulokinase +FIG01959485 "V-type ATP synthase subunit E " +FIG01959486 Phytoene desaturase, neurosporene or lycopene producing (EC 1.3.-.-) +FIG01959487 Phosphoenolpyruvate-dihydroxyacetone phosphotransferase (EC 2.7.1.121), dihydroxyacetone binding subunit DhaK +FIG01959488 Activator of the mannose operon (transcriptional antiterminator), BglG family +FIG01959489 Regulatory sensor-transducer, BlaR1/MecR1 family / TonB-dependent receptor +FIG01959490 L-cystine uptake protein TcyP +FIG01959491 3-dehydro-L-gulonate 2-dehydrogenase (EC 1.1.1.130) +FIG01959492 Sucrose permease, major facilitator superfamily +FIG01959495 Glutamate Aspartate transport ATP-binding protein GltL (TC 3.A.1.3.4) +FIG01959497 preQ1-regulated inosine-uridine nucleoside hydrolase (EC 3.2.2.1) +FIG01959498 PutR, transcriptional activator of PutA and PutP +FIG01959499 2-oxo-hepta-3-ene-1,7-dioic acid hydratase (EC 4.2.-.-) +FIG01959500 NADH dehydrogenase subunit 1 +FIG01959501 Conserved hypothetical integral membrane protein YrbE B Subgroup +FIG01959502 conserved hypothetical protein in cyt c oxidase gene clusters +FIG01959504 Dipeptide transport system permease protein DppB (TC 3.A.1.5.2) +FIG01959505 Protein-N(5)-glutamine methyltransferase PrmC, methylates polypeptide chain release factors RF1 and RF2 +FIG01959506 Glycolate utilization operon transcriptional activator GlcC +FIG01959507 Dipeptide transport system permease protein DppB (TC 3.A.1.5.2); putative hemin permease +FIG01959508 Pyrophosphate--fructose 6-phosphate 1-phosphotransferase, alpha subunit (EC 2.7.1.90) +FIG01959509 PTS system, galactose-specific IIC component (EC 2.7.1.69) +FIG01959510 N-carbamoyl-L-amino acid hydrolase (EC 3.5.1.87) +FIG01959511 Ferric enterobactin transport system permease protein FepG (TC 3.A.1.14.2) +FIG01959512 Aerobic cobaltochelatase CobT subunit (EC 6.6.1.2) +FIG01959513 Lipoprotein releasing system transmembrane protein LolC +FIG01959514 DNA-binding protein HU-beta +FIG01959515 3-ketoacyl-CoA thiolase (EC 2.3.1.16) +FIG01959516 Transcriptional regulator GabR of GABA utilization (GntR family with aminotransferase-like domain) +FIG01959517 Cobyric acid synthase +FIG01959519 D-2-hydroxyglutarate dehydrogenase +FIG01959520 ATP synthase F0 sector subunit a +FIG01959521 Succinyl-CoA ligase [ADP-forming] beta chain (EC 6.2.1.5) +FIG01959522 Nucleoside permease NupC +FIG01959523 Membrane protein CarB involved in the export of O-antigen and teichoic acid, Streptococci specific +FIG01959524 KH domain RNA binding protein YlqC +FIG01959525 Transmembrane component BL0694 of energizing module of predicted ECF transporter +FIG01959526 Seryl-tRNA synthetase (EC 6.1.1.11) +FIG01959527 Enoyl-CoA hydratase (EC 4.2.1.17) / Delta(3)-cis-delta(2)-trans-enoyl-CoA isomerase (EC 5.3.3.8) / 3-hydroxyacyl-CoA dehydrogenase (EC 1.1.1.35) / 3-hydroxybutyryl-CoA epimerase (EC 5.1.2.3) +FIG01959528 Hemin ABC transporter, permease protein +FIG01959529 Phosphoglycolate phosphatase (EC 3.1.3.18) +FIG01959530 Thymidylate synthase (EC 2.1.1.45) +FIG01959531 Pyridoxamine 5'-phosphate oxidase (EC 1.4.3.5) +FIG01959535 Methylglyoxal reductase, acetol producing (EC 1.1.1.-) / 2,5-diketo-D-gluconate reductase A (EC 1.1.1.274) +FIG01959536 tRNA S(4)U 4-thiouridine synthase (former ThiI) +FIG01959537 Glucans biosynthesis protein G precursor +FIG01959538 Carbamoyl-phosphate synthase large chain (EC 6.3.5.5) +FIG01959539 Propionyl-CoA carboxylase beta chain (EC 6.4.1.3) +FIG01959540 2-dehydro-3-deoxyglucarate aldolase (EC 4.1.2.20) +FIG01959541 Pyruvate dehydrogenase E1 component (EC 1.2.4.1) +FIG01959542 Bacitracin export permease protein BceB +FIG01959543 COG2047: Uncharacterized protein (ATP-grasp superfamily) +FIG01959545 Outer membrane protein NlpB, lipoprotein component of the protein assembly complex (forms a complex with YaeT, YfiO, and YfgL); Lipoprotein-34 precursor +FIG01959546 UDP-N-acetylglucosamine 1-carboxyvinyltransferase (EC 2.5.1.7) +FIG01959547 DNA-directed RNA polymerase delta (= beta'') subunit (EC 2.7.7.6) +FIG01959548 L-carnitine/gamma-butyrobetaine antiporter +FIG01959549 Beta-galactosidase 3 +FIG01959551 Thioredoxin-like protein clustered with PA0057 +FIG01959552 Photosystem II CP47 protein (PsbB) +FIG01959554 ATP-dependent Clp protease ATP-binding subunit ClpA +FIG01959555 Glutathione-regulated potassium-efflux system ATP-binding protein +FIG01959557 Isoleucyl-tRNA synthetase (EC 6.1.1.5) +FIG01959558 TrkA-N:Sodium/hydrogen exchanger +FIG01959559 Maltoporin (maltose/maltodextrin high-affinity receptor, phage lambda receptor protein) +FIG01959560 Polysaccharide intercellular adhesin (PIA) biosynthesis protein IcaC +FIG01959561 Arginine exporter protein ArgO +FIG01959563 Glutamyl-tRNA synthetase (EC 6.1.1.17) +FIG01959564 Tryptophan 2-monooxygenase (EC 1.13.12.3) +FIG01959565 Periplasmic thiol:disulfide interchange protein DsbA +FIG01959566 Mlr7403 protein +FIG01959567 L-rhamnose isomerase (EC 5.3.1.14) +FIG01959568 Glutathione S-transferase, unnamed subgroup (EC 2.5.1.18) +FIG01959569 Stage V sporulation protein involved in spore cortex synthesis (SpoVR) +FIG01959571 Uncharacterized GST-like protein yghU associated with glutathionylspermidine synthetase/amidase +FIG01959572 N-acetyl-gamma-glutamyl-phosphate reductase (EC 1.2.1.38) +FIG01959573 Putative deoxyribose-specific ABC transporter, permease protein +FIG01959574 Heme ABC transporter, ATPase component HmuV +FIG01959575 Flagellar biosynthesis protein FlhA +FIG01959576 Virulence factor MviM +FIG01959577 Aromatic-L-amino-acid decarboxylase (EC 4.1.1.28) +FIG01959578 Putrescine aminotransferase (EC 2.6.1.82) +FIG01959579 Sugar ABC transporter, sugar-binding protein +FIG01959580 "Membrane-bound lytic murein transglycosylase C precursor " +FIG01959581 Chemotaxis regulator - transmits chemoreceptor signals to flagelllar motor components CheY +FIG01959582 N-acetylglutamate synthase related protein +FIG01959583 Ribulokinase (EC 2.7.1.16) +FIG01959584 Acetyl-CoA C-acyltransferase (EC 2.3.1.16) @ Acetyl-CoA acetyltransferase (EC 2.3.1.9) +FIG01959585 Chorismate synthase (EC 4.2.3.5) +FIG01959586 PTS system, maltose and glucose-specific IIC component (EC 2.7.1.69) / PTS system, maltose and glucose-specific IIB component (EC 2.7.1.69) +FIG01959587 Arsenical resistance operon repressor +FIG01959589 Hemoglobin-like protein HbO +FIG01959591 Isocitrate dehydrogenase [NADP] (EC 1.1.1.42); Monomeric isocitrate dehydrogenase [NADP] (EC 1.1.1.42) +FIG01959593 Two-component sensor kinase SA14-24 +FIG01959594 NADH pyrophosphatase (EC 3.6.1.22) +FIG01959596 3-oxoacyl-[acyl-carrier-protein] synthase, KASII (EC 2.3.1.179) +FIG01959597 Methylmalonate-semialdehyde dehydrogenase (EC 1.2.1.27) +FIG01959598 D-glycerate 3-kinase (EC 2.7.1.31), plant type +FIG01959600 Phosphomevalonate kinase (EC 2.7.4.2) +FIG01959601 Hypoxanthine-guanine phosphoribosyltransferase (EC 2.4.2.8) +FIG01959603 Hypothetical protein +FIG01959604 "Enoyl-CoA hydratase [isoleucine degradation] / 3-hydroxyacyl-CoA dehydrogenase / 3-hydroxybutyryl-CoA epimerase " +FIG01959605 Putative deoxyribose-specific ABC transporter, ATP-binding protein +FIG01959606 Glutathione S-transferase, pi (EC 2.5.1.18) +FIG01959607 Glucose-methanol-choline (GMC) oxidoreductase:NAD binding site +FIG01959608 FIG061771: ATP-dependent nuclease subunit A +FIG01959610 [Citrate [pro-3S]-lyase] ligase (EC 6.2.1.22) +FIG01959612 Positive transcription regulator EvgA +FIG01959613 CRISPR-associated protein, Cse2 family +FIG01959614 Dihydrolipoamide succinyltransferase component (E2) of 2-oxoglutarate dehydrogenase complex (EC 2.3.1.61) / 2-oxoglutarate dehydrogenase E1 component (EC 1.2.4.2) +FIG01959616 Putative Dihydrolipoamide dehydrogenase (EC 1.8.1.4); Mercuric ion reductase (EC 1.16.1.1); PF00070 family, FAD-dependent NAD(P)-disulphide oxidoreductase +FIG01959618 Branched-chain alpha-keto acid dehydrogenase, E1 component, beta subunit (EC 1.2.4.4) +FIG01959619 Para-aminobenzoate synthase, amidotransferase component (EC 2.6.1.85) +FIG01959620 4-hydroxy-tetrahydrodipicolinate synthase (EC 4.3.3.7) +FIG01959622 Formate dehydrogenase O beta subunit (EC 1.2.1.2) +FIG01959623 Xanthine phosphoribosyltransferase (EC 2.4.2.22) +FIG01959624 Aerobic glycerol-3-phosphate dehydrogenase (EC 1.1.5.3) +FIG01959625 Glycerol-3-phosphate acyltransferase (EC 2.3.1.15) +FIG01959628 Lipopolysaccharide heptosyltransferase III (EC 2.4.1.-) +FIG01959629 2-deoxy-D-gluconate 3-dehydrogenase (EC 1.1.1.125) +FIG01959630 FIG004453: protein YceG like +FIG01959632 Starvation sensing protein RspA +FIG01959633 FIG135464: Cytochrome c4 +FIG01959636 Purine nucleotide synthesis repressor +FIG01959637 Phosphoenolpyruvate carboxylase (EC 4.1.1.31) +FIG01959638 Predicted glycogen synthase, ADP-glucose transglucosylase (EC 2.4.1.21), Actinobacterial type +FIG01959639 Phage shock protein A +FIG01959640 NAD-specific glutamate dehydrogenase (EC 1.4.1.2); NADP-specific glutamate dehydrogenase (EC 1.4.1.4) +FIG01959641 Undecaprenyl diphosphate synthase (EC 2.5.1.31) +FIG01959642 dNTP triphosphohydrolase, broad substrate specificity, subgroup 3 +FIG01959643 Colanic acid biosynthesis glycosyl transferase WcaC +FIG01959644 tRNA pseudouridine 13 synthase (EC 4.2.1.-) +FIG01959647 Ubiquinone biosynthesis monooxygenase UbiB +FIG01959648 Predicted L-lactate dehydrogenase, Fe-S oxidoreductase subunit YkgE +FIG01959649 FIG146085: 3'-to-5' oligoribonuclease A, Bacillus type +FIG01959650 Putative glycosyl/glycerophosphate transferase in teichoic acid biosynthesis +FIG01959651 Uracil phosphoribosyltransferase (EC 2.4.2.9) +FIG01959652 FIGfam010146: Two component system histidine kinase +FIG01959653 Cytochrome c-type biogenesis protein CcmE, heme chaperone +FIG01959654 Nitric oxide-dependent regulator DnrN or NorA +FIG01959655 Flp pilus assembly protein TadB +FIG01959658 BarA sensory histidine kinase (= VarS = GacS) +FIG01959659 Penicillin-binding protein 2B +FIG01959660 2-Keto-3-deoxy-D-manno-octulosonate-8-phosphate synthase (EC 2.5.1.55) +FIG01959661 Dehydrosqualene synthase (EC 2.5.1.-) +FIG01959662 Translation elongation factor G-related protein +FIG01959664 Iron-sulfur cluster assembly protein SufB +FIG01959666 Conjugative transfer protein TrbE +FIG01959667 Outer membrane lipoprotein LolB precursor +FIG01959668 2-polyprenylphenol hydroxylase and related flavodoxin oxidoreductases +FIG01959669 Menaquinone-cytochrome C oxidoreductase, cytochrome C subunit +FIG01959671 "Urease gamma subunit " +FIG01959672 Anaerobic glycerol-3-phosphate dehydrogenase subunit B (EC 1.1.5.3) +FIG01959674 ATP-binding protein PhnN; Guanylate kinase (EC 2.7.4.8) +FIG01959675 Cytochrome c-type heme lyase subunit nrfE, nitrite reductase complex assembly +FIG01959676 PTS system, mannose-specific IIA component +FIG01959677 DNA mismatch repair endonuclease MutH +FIG01959678 Flagellar biosynthesis protein FliS +FIG01959679 TRAP dicarboxylate transporter, DctQ subunit, unknown substrate 6 +FIG01959680 Membrane protease family protein BA0301 +FIG01959681 Biotin synthesis protein BioH +FIG01959682 Arginine decarboxylase (EC 4.1.1.19) / Lysine decarboxylase (EC 4.1.1.18) +FIG01959684 Tricarboxylate transport transcriptional regulator TctD +FIG01959686 PTS system, fructose- and mannose-inducible IIC component (EC 2.7.1.69) +FIG01959687 ABC transporter, predicted N-acetylneuraminate transport system permease protein 1 +FIG01959688 Alpha-D-GlcNAc alpha-1,2-L-rhamnosyltransferase (EC 2.4.1.-) +FIG01959689 Phytoene desaturase, pro-zeta-carotene producing (EC 1.-.-.-) +FIG01959690 Glutathione biosynthesis bifunctional protein gshF (EC 6.3.2.2)(EC 6.3.2.3) +FIG01959693 Oligo-1,6-glucosidase (EC 3.2.1.10) +FIG01959695 50S ribosomal subunit maturation GTPase RbgA (B. subtilis YlqF) +FIG01959696 Fumarate reductase subunit D +FIG01959697 Flagellar basal-body rod protein FlgC +FIG01959698 Ortho-halobenzoate 1,2-dioxygenase beta-ISP protein OhbA +FIG01959699 Predicted N-ribosylNicotinamide CRP-like regulator +FIG01959700 L-sorbose 1-phosphate reductase (EC 1.1.1.-) +FIG01959701 DJ-1/YajL/PfpI superfamily, includes chaperone protein YajL (former ThiJ), parkinsonism-associated protein DJ-1, peptidases PfpI, Hsp31 +FIG01959702 Nitrous oxide reductase maturation transmembrane protein NosY +FIG01959703 6-phosphofructokinase class II (EC 2.7.1.11) +FIG01959704 Biotin carboxylase of acetyl-CoA carboxylase (EC 6.3.4.14) +FIG01959705 Collagen alpha 1(I) chain precursor +FIG01959706 Ethanolamine utilization polyhedral-body-like protein EutK +FIG01959707 biphenyl-2,3-diol 1,2-dioxygenase III-related protein +FIG01959708 Ribonuclease J1 (endonuclease and 5' exonuclease) +FIG01959709 Alpha-2-macroglobulin +FIG01959710 Acetyl-coenzyme A carboxyl transferase alpha chain (EC 6.4.1.2) +FIG01959711 Glycolate dehydrogenase (EC 1.1.99.14), FAD-binding subunit GlcE +FIG01959712 Deoxyribose-phosphate aldolase (EC 4.1.2.4) +FIG01959714 Thrombin, protease S01.217 +FIG01959715 Flagellar P-ring protein FlgI +FIG01959716 tRNA pseudouridine synthase C (EC 4.2.1.70) +FIG01959717 ABC transporter, periplasmic spermidine putrescine-binding protein PotD (TC 3.A.1.11.1) +FIG01959719 Osmotically activated L-carnitine/choline ABC transporter, permease protein OpuCD +FIG01959720 Phage lysis protein S +FIG01959721 Two-component response regulator, malate (EC 2.7.3.-) +FIG01959722 Aromatic amino acid transport protein AroP +FIG01959723 Transcriptional repressor of the lac operon +FIG01959725 Nickel transport system permease protein NikC (TC 3.A.1.5.3) +FIG01959726 L-serine dehydratase, beta subunit (EC 4.3.1.17) +FIG01959727 Acetoacetyl-CoA synthetase (EC 6.2.1.16) / Long-chain-fatty-acid--CoA ligase (EC 6.2.1.3) +FIG01959728 Ribonuclease PH (EC 2.7.7.56) +FIG01959729 Uracil phosphoribosyltransferase (EC 2.4.2.9) / Pyrimidine operon regulatory protein PyrR +FIG01959730 Endonuclease V (EC 3.1.21.7) +FIG01959731 FIG015287: Zinc protease +FIG01959733 Delta-1-pyrroline-5-carboxylate dehydrogenase (EC 1.5.1.12) +FIG01959734 Succinylglutamate desuccinylase (EC 3.5.1.96) +FIG01959735 Chalcone synthase (EC 2.3.1.74) +FIG01959736 Glutamyl aminopeptidase (EC 3.4.11.7) +FIG01959737 ATP-dependent RNA helicase, eIF-4A family / Putative ski2-type helicase MJ1124 @ intein-containing +FIG01959738 Inner membrane protein translocase component YidC, OxaA protein +FIG01959739 Glutamate--cysteine ligase (EC 6.3.2.2) +FIG01959740 Nitrogenase (molybdenum-iron) reductase and maturation protein NifH +FIG01959741 Sarcosine dehydrogenase (EC 1.5.99.1) +FIG01959742 Beta-ketoadipate enol-lactone hydrolase (EC 3.1.1.24) +FIG01959743 ATPase provides energy for both assembly of type IV secretion complex and secretion of T-DNA complex (VirB11) +FIG01959744 Leucyl/phenylalanyl-tRNA--protein transferase (EC 2.3.2.6) +FIG01959745 Nitrite transporter from formate/nitrite family +FIG01959747 RsbR, positive regulator of sigma-B +FIG01959748 CDP-diacylglycerol pyrophosphatase (EC 3.6.1.26) +FIG01959749 Dihydropyrimidine dehydrogenase [NADP+] (EC 1.3.1.2) +FIG01959750 Pyridoxine biosynthesis glutamine amidotransferase, synthase subunit (EC 2.4.2.-) +FIG01959751 Hydrogenase-4 component E +FIG01959752 Cell division protein GpsB, coordinates the switch between cylindrical and septal cell wall synthesis by re-localization of PBP1 +FIG01959753 Alanyl-tRNA synthetase family protein +FIG01959754 Acetolactate synthase, catabolic (EC 2.2.1.6) +FIG01959755 extracellular solute-binding protein family 1 +FIG01959756 Predicted ATPase related to phosphate starvation-inducible protein PhoH +FIG01959758 Aspartokinase (EC 2.7.2.4) / Homoserine dehydrogenase (EC 1.1.1.3) +FIG01959759 Multiple sugar ABC transporter, ATP-binding protein +FIG01959760 Formate dehydrogenase related protein +FIG01959761 PTS system, glucitol/sorbitol-specific IIA component (EC 2.7.1.69) +FIG01959764 Heavy metal sensor histidine kinase +FIG01959765 Tagatose-6-phosphate kinase (EC 2.7.1.144) +FIG01959766 Spermidine Putrescine ABC transporter permease component potC (TC_3.A.1.11.1) +FIG01959767 Predicted L-lactate dehydrogenase, Fe-S oxidoreductase subunit YkgE +FIG01959768 23S rRNA (guanosine-2'-O-) -methyltransferase rlmB (EC 2.1.1.-) +FIG01959769 Not a Proline racemase, nor 4-hydroxyproline epimerase [missing catalytic residues] +FIG01959770 Two-component response regulator YvcP +FIG01959771 Phosphate starvation-inducible ATPase PhoH with RNA binding motif +FIG01959772 Hydrolase (HAD superfamily) in cluster with DUF1447 +FIG01959773 Aerobic glycerol-3-phosphate dehydrogenase (EC 1.1.5.3) +FIG01959774 5-methylaminomethyl-2-thiouridine-forming enzyme mnmC +FIG01959775 Glutathione synthetase (EC 6.3.2.3) +FIG01959776 Flagellar biosynthesis protein FliP +FIG01959779 Sulfate adenylyltransferase (EC 2.7.7.4) / Adenylylsulfate kinase (EC 2.7.1.25) +FIG01959780 Methionine ABC transporter permease protein +FIG01959781 Heme ABC type transporter HtsABC, heme-binding protein +FIG01959782 Arabinose operon regulatory protein +FIG01959783 Thiosulfate sulfurtransferase GlpE (EC 2.8.1.1) +FIG01959786 Pyrimidine-nucleoside phosphorylase (EC 2.4.2.2) +FIG01959788 Lysine decarboxylase, inducible (EC 4.1.1.18) +FIG01959789 S-layer protein / N-acetylmuramoyl-L-alanine amidase (EC 3.5.1.28) +FIG01959790 Periplasmic aromatic aldehyde oxidoreductase, FAD binding subunit YagS +FIG01959791 Probable L-ascorbate-6-phosphate lactonase UlaG (EC 3.1.1.-) (L-ascorbate utilization protein G) +FIG01959793 Dihydrolipoamide dehydrogenase (EC 1.8.1.4) / Dihydrolipoamide dehydrogenase of pyruvate dehydrogenase complex (EC 1.8.1.4) +FIG01959794 Na(+)-translocating NADH-quinone reductase subunit A (EC 1.6.5.-) +FIG01959795 2-hydroxy-6-ketonona-2,4-dienedioic acid hydrolase (EC 3.7.1.-) +FIG01959796 Transcriptional regulator of various polyols utilization, AraC family +FIG01959800 Aldehyde dehydrogenase (EC 1.2.1.3); Probable coniferyl aldehyde dehydrogenase (EC 1.2.1.68) +FIG01959801 Threonine dehydratase, catabolic (EC 4.3.1.19) +FIG01959802 Putative lipoprotein SAV1865 +FIG01959803 Enoyl-CoA hydratase [isoleucine degradation] (EC 4.2.1.17) / 3-hydroxyacyl-CoA dehydrogenase (EC 1.1.1.35) +FIG01959804 NAD(P) transhydrogenase subunit beta (EC 1.6.1.2) +FIG01959805 Thiazole biosynthesis protein ThiG +FIG01959806 Glutamine amidotransferase protein GlxB (EC 2.4.2.-) +FIG01959807 Aconitate hydratase 2 (EC 4.2.1.3) @ 2-methylisocitrate dehydratase (EC 4.2.1.99) +FIG01959808 Uncharacterized protein similar to VCA0109 +FIG01959809 LSU ribosomal protein L24p (L26e) +FIG01959810 Gluconate dehydratase (EC 4.2.1.39) +FIG01959811 "NADH-ubiquinone oxidoreductase chain L " +FIG01959812 Histidinol-phosphate aminotransferase (EC 2.6.1.9) +FIG01959813 Ribonuclease HIII (EC 3.1.26.4) +FIG01959814 Transcriptional regulator NanR +FIG01959815 Catalase (EC 1.11.1.6) / Peroxidase (EC 1.11.1.7) +FIG01959816 Isovaleryl-CoA dehydrogenase (EC 1.3.99.10) +FIG01959817 FIG005453: Putative DeoR-family transcriptional regulator +FIG01959818 Maltose/maltodextrin ABC transporter, permease protein MalG +FIG01959822 Glycine betaine ABC transport system, glycine betaine-binding protein OpuAC +FIG01959823 Plasmid partitioning protein ParA +FIG01959824 4-hydroxybenzoyl-CoA thioesterase family active site +FIG01959825 Chromosome partition protein MukF +FIG01959826 dTDP-4-dehydrorhamnose reductase (EC 1.1.1.133) +FIG01959827 Aconitate hydratase (EC 4.2.1.3) +FIG01959828 Sarcosine dehydrogenase (EC 1.5.99.1) +FIG01959830 Cold shock protein CspG +FIG01959831 Zn-dependent hydrolase (beta-lactamase superfamily) +FIG01959834 Type IV pilus biogenesis protein PilE +FIG01959835 Lipopolysaccharide core biosynthesis protein WaaP (EC 2.7.-.-), heptosyl-I-kinase +FIG01959836 Lipoteichoic acid synthase LtaS Type IIIa +FIG01959837 Transketolase, C-terminal section (EC 2.2.1.1) +FIG01959838 NADH-ubiquinone oxidoreductase chain I (EC 1.6.5.3) +FIG01959839 Methyl-directed repair DNA adenine methylase (EC 2.1.1.72) +FIG01959840 Lipoteichoic acid synthase LtaS Type Ib +FIG01959841 Alkaline phosphatase (EC 3.1.3.1) +FIG01959842 Sulfate and thiosulfate import ATP-binding protein CysA (EC 3.6.3.25) +FIG01959843 Cytochrome c-type protein NapC +FIG01959846 Urease accessory protein UreD +FIG01959847 Guanine deaminase (EC 3.5.4.3); Hydroxydechloroatrazine ethylaminohydrolase (EC 3.5.99.3) +FIG01959848 tRNA-dihydrouridine synthase C (EC 1.-.-.-) +FIG01959850 Glucans biosynthesis protein C (EC 2.1.-.-) +FIG01959851 COG2833: uncharacterized protein +FIG01959852 Dihydroxyacetone kinase family protein +FIG01959853 Sugar/maltose fermentation stimulation protein homolog +FIG01959854 Transcriptional regulatory protein RtcR +FIG01959855 Cobalamin synthase +FIG01959857 Lactose phosphotransferase system repressor +FIG01959858 Lipid IVA 3-deoxy-D-manno-octulosonic acid transferase (EC 2.4.99.12) [often with (EC 2.4.99.13) also] +FIG01959859 Anthranilate synthase, amidotransferase component (EC 4.1.3.27) +FIG01959861 "DNA-directed RNA polymerase subunit A'' " +FIG01959862 Acetate permease ActP (cation/acetate symporter) +FIG01959864 Dihydrolipoamide dehydrogenase of 2-oxoglutarate dehydrogenase (EC 1.8.1.4) +FIG01959865 Branched-chain alpha-keto acid dehydrogenase, E1 component, beta subunit (EC 1.2.4.4) +FIG01959867 Duplicated ATPase component YkoD of energizing module of thiamin-regulated ECF transporter for HydroxyMethylPyrimidine +FIG01959868 Arginine utilization protein RocB +FIG01959869 Isocitrate lyase (EC 4.1.3.1) @ Methylisocitrate lyase (EC 4.1.3.30) +FIG01959870 Activator of the mannose operon (transcriptional antiterminator), BglG family +FIG01959871 Alkaline phosphatase synthesis transcriptional regulatory protein PhoP +FIG01959872 Fructose-1,6-bisphosphatase, Bacillus type (EC 3.1.3.11) +FIG01959873 Cytochrome c-552 precursor +FIG01959874 FIG002842: hypothetical protein +FIG01959876 L-serine dehydratase, alpha subunit (EC 4.3.1.17) +FIG01959877 Nitrilotriacetate monooxygenase component B (EC 1.14.13.-) +FIG01959880 FIG146085: 3'-to-5' oligoribonuclease A, Bacillus type +FIG01959881 Branched-chain amino acid transport system permease protein LivM (TC 3.A.1.4.1) +FIG01959882 Phenazine biosynthesis protein PhzE @ 2-Amino-2-deoxy-isochorismate synthase (EC 4.1.3.-) +FIG01959883 ABC transporter (iron.B12.siderophore.hemin) , ATP-binding component +FIG01959884 TsgA protein homolog +FIG01959885 Thiaminase II (EC 3.5.99.2) +FIG01959887 Periplasmic beta-glucosidase (EC 3.2.1.21) +FIG01959888 Hypothetical protein SAV1869 +FIG01959889 Copper resistance protein C precursor +FIG01959890 Glutamate-ammonia-ligase adenylyltransferase (EC 2.7.7.42) +FIG01959891 formate dehydrogenase formation protein FdhE +FIG01959892 Autolysis response regulater LytR +FIG01959893 NAD-reducing hydrogenase subunit HoxU (EC 1.12.1.2) +FIG01959895 Galactitol-1-phosphate 5-dehydrogenase (EC 1.1.1.251) +FIG01959896 PTS system, arbutin-, cellobiose-, and salicin-specific IIBC component (EC 2.7.1.69) +FIG01959897 Arginine utilization protein RocB +FIG01959898 Dihydrolipoamide dehydrogenase of branched-chain alpha-keto acid dehydrogenase (EC 1.8.1.4) +FIG01959899 2-ketoglutaric semialdehyde dehydrogenase (EC 1.2.1.26) +FIG01959901 Anhydro-N-acetylmuramic acid kinase (EC 2.7.1.-) +FIG01959902 Alanine racemase, biosynthetic (EC 5.1.1.1) +FIG01959903 Histidine ABC transporter, permease protein HisM (TC 3.A.1.3.1) +FIG01959904 IMP cyclohydrolase (EC 3.5.4.10) / Phosphoribosylaminoimidazolecarboxamide formyltransferase (EC 2.1.2.3) +FIG01959905 Glycine betaine transporter OpuD +FIG01959906 Chorismate mutase I (EC 5.4.99.5) / Prephenate dehydratase (EC 4.2.1.51) +FIG01959907 Mevalonate kinase (EC 2.7.1.36) +FIG01959908 UDP-N-acetylglucosamine 2-epimerase (EC 5.1.3.14) +FIG01959909 "Glucoamylase " +FIG01959910 Sulfate adenylyltransferase subunit 1 (EC 2.7.7.4) / Adenylylsulfate kinase (EC 2.7.1.25) +FIG01959911 3-deoxy-D-manno-octulosonate 8-phosphate phosphatase (EC 3.1.3.45) +FIG01959912 Isochorismatase (EC 3.3.2.1) +FIG01959913 6-phospho-beta-galactosidase (EC 3.2.1.85) +FIG01959915 Outer membrane usher protein HtrE +FIG01959918 Cobalt-precorrin-6y C5-methyltransferase (EC 2.1.1.-) / Cobalt-precorrin-6y C15-methyltransferase [decarboxylating] (EC 2.1.1.-) +FIG01959919 Duplicated ATPase component MtsB of energizing module of methionine-regulated ECF transporter +FIG01959921 GNAT family acetyltransferase YjcF +FIG01959922 Anaerobic selenate reductase protein YnfG +FIG01959923 FtsK/SpoIIIE family protein Rv3870, component of ESX-1 secretion system +FIG01959924 Uridine phosphorylase (EC 2.4.2.3) +FIG01959925 Cd(II)/Pb(II)-responsive transcriptional regulator +FIG01959926 Aconitate hydratase 2 (EC 4.2.1.3) +FIG01959927 Anaerobic nitric oxide reductase flavorubredoxin +FIG01959928 Biosynthetic Aromatic amino acid aminotransferase alpha (EC 2.6.1.57) @ Aspartate aminotransferase (EC 2.6.1.1) +FIG01959929 Sulfate permease, Trk-type +FIG01959930 L-threonine transporter, anaerobically inducible +FIG01959931 Ascorbate-specific PTS system, EIIC component +FIG01959935 Putrescine transport system permease protein PotI (TC 3.A.1.11.2) +FIG01959936 RuBisCO operon transcriptional regulator CbbR +FIG01959937 Aspartate--ammonia ligase (EC 6.3.1.1) +FIG01959938 "NADH-ubiquinone oxidoreductase chain D " +FIG01959939 dTDP-Rha:A-D-GlcNAc-diphosphoryl polyprenol, A-3-L-rhamnosyl transferase WbbL +FIG01959940 Conjugative transfer protein TrbF +FIG01959941 Uncharacterized protein ImpC +FIG01959942 Arginase (EC 3.5.3.1) +FIG01959943 Glycogen synthase, ADP-glucose transglucosylase (EC 2.4.1.21) +FIG01959944 ATP-dependent DNA helicase RecG (EC 3.6.1.-) +FIG01959945 Similar to ribosomal large subunit pseudouridine synthase D, Bacillus subtilis YhcT type +FIG01959946 Biotin-protein ligase (EC 6.3.4.15) +FIG01959947 Acetylornithine deacetylase/Succinyl-diaminopimelate desuccinylase and related deacylases +FIG01959948 Dipeptide transport system permease protein DppC (TC 3.A.1.5.2) +FIG01959950 5-keto-D-gluconate 5-reductase (EC 1.1.1.69) +FIG01959951 2,3-butanediol dehydrogenase, S-alcohol forming, (S)-acetoin-specific (EC 1.1.1.76) +FIG01959952 N-acetylglucosamine related transporter, NagX +FIG01959953 Phenylacetate-coenzyme A ligase (EC 6.2.1.30) +FIG01959954 L-xylulokinase (EC 2.7.1.53) @ 3-keto-L-gulonate kinase +FIG01959956 Isopentenyl-diphosphate delta-isomerase, FMN-dependent (EC 5.3.3.2) +FIG01959958 Phosphopantothenoylcysteine decarboxylase (EC 4.1.1.36) / Phosphopantothenoylcysteine synthetase (EC 6.3.2.5) +FIG01959959 NADH dehydrogenase I subunit 4, Involved in photosystem-1 cyclic electron flow +FIG01959960 Galactosamine-6-phosphate isomerase (EC 5.3.1.-) +FIG01959961 Excinuclease ABC subunit A +FIG01959962 S-adenosylmethionine decarboxylase proenzyme (EC 4.1.1.50), prokaryotic class 1B +FIG01959963 Cobalamin biosynthesis protein BluB @ 5,6-dimethylbenzimidazole synthase, flavin destructase family +FIG01959964 Membrane proteins related to metalloendopeptidases +FIG01959965 Enoyl-CoA hydratase [isoleucine degradation] (EC 4.2.1.17) / 3-hydroxyacyl-CoA dehydrogenase (EC 1.1.1.35) / 3-hydroxybutyryl-CoA epimerase (EC 5.1.2.3) +FIG01959966 Cytochrome c heme lyase subunit CcmL +FIG01959968 FIG003492: Threonine dehydrogenase and related Zn-dependent dehydrogenases +FIG01959969 4-hydroxyphenylacetate 3-monooxygenase (EC 1.14.13.3) +FIG01959970 Hemin ABC transporter, permease protein +FIG01959971 Nitrogenase (molybdenum-iron) alpha chain (EC 1.18.6.1) +FIG01959972 3-polyprenyl-4-hydroxybenzoate carboxy-lyase (EC 4.1.1.-) +FIG01959973 Uroporphyrinogen-III methyltransferase (EC 2.1.1.107) / Uroporphyrinogen-III synthase (EC 4.2.1.75) +FIG01959974 TPR-repeat-containing protein, putative component of Menaquinone-cytochrome C reductase +FIG01959975 Malate Na(+) symporter +FIG01959976 LSU ribosomal protein L9p +FIG01959977 Glycogen biosynthesis protein GlgD, glucose-1-phosphate adenylyltransferase family +FIG01959978 Universal stress protein E +FIG01959979 IncF plasmid conjugative transfer pilus assembly protein TraE +FIG01959981 Glutamyl-tRNA synthetase (EC 6.1.1.17) @ Glutamyl-tRNA(Gln) synthetase (EC 6.1.1.24) +FIG01959982 Ferredoxin--NADP(+) reductase (EC 1.18.1.2) +FIG01959983 Proline dehydrogenase (EC 1.5.99.8) (Proline oxidase) +FIG01959984 Malate synthase (EC 2.3.3.9) +FIG01959985 Polyferredoxin NapH (periplasmic nitrate reductase) +FIG01959986 [NiFe] hydrogenase metallocenter assembly protein HypD +FIG01959987 Glucans biosynthesis glucosyltransferase H (EC 2.4.1.-) +FIG01959990 Tetrathionate reductase subunit A +FIG01959991 Methanol dehydrogenase large subunit protein (EC 1.1.99.8) +FIG01959992 Glycine dehydrogenase [decarboxylating] (glycine cleavage system P1 protein) (EC 1.4.4.2) +FIG01959993 Sigma factor RpoE negative regulatory protein RseB precursor +FIG01959995 Dihydropyrimidinase (EC 3.5.2.2) +FIG01959996 2-hydroxy-6-oxo-6-phenylhexa-2,4-dienoate hydrolase (EC 3.7.1.-) +FIG01959997 Treacle protein +FIG01959999 Periplasmic nitrate reductase precursor (EC 1.7.99.4) +FIG01960001 Acetyl-coenzyme A synthetase (EC 6.2.1.1) +FIG01960002 Benzoate-CoA ligase (EC 6.2.1.25) +FIG01960004 Formate dehydrogenase O putative subunit +FIG01960008 Menaquinone-cytochrome C reductase iron-sulfur subunit +FIG01960009 CidA-associated membrane protein CidB +FIG01960011 Cysteine synthase (EC 2.5.1.47) +FIG01960014 ABC transporter ATP-binding protein uup +FIG01960015 Ribonuclease E inhibitor RraA +FIG01960016 cAMP-dependent Kef-type K+ transport system +FIG01960017 Glutathione peroxidase (EC 1.11.1.9) +FIG01960019 NAD synthetase (EC 6.3.1.5) / Glutamine amidotransferase chain of NAD synthetase +FIG01960020 Plasmid replication protein RepB +FIG01960021 Flagellar motor switch protein FliG +FIG01960022 FIG001553: Hydrolase, HAD subfamily IIIA +FIG01960023 Nickel ABC transporter, periplasmic nickel-binding protein nikA2 (TC 3.A.1.5.3) +FIG01960025 Putative outer membrane lipoprotein YmcA +FIG01960027 5-methyl-dCTP pyrophosphohydrolase (EC 3.6.1.-) +FIG01960028 N-acetylglucosamine-regulated TonB-dependent outer membrane receptor +FIG01960029 Ferredoxin--sulfite reductase, actinobacterial type (EC 1.8.7.1) +FIG01960030 Translation elongation factor G-related protein +FIG01960032 Glycolate oxidase (EC 1.1.3.15) +FIG01960034 Malate:quinone oxidoreductase (EC 1.1.5.4) +FIG01960035 Epi-inositol hydrolase (EC 3.7.1.-) +FIG01960036 Nitrate ABC transporter, nitrate-binding protein +FIG01960037 Glucosamine--fructose-6-phosphate aminotransferase [isomerizing] (EC 2.6.1.16) +FIG01960038 Uncharacterized protein ImpJ/VasE +FIG01960039 Putative oxidoreductase YcjS (EC 1.-.-.-), NADH-binding +FIG01960040 Histidine ABC transporter, permease protein HisQ (TC 3.A.1.3.1) +FIG01960041 N6-hydroxylysine O-acetyltransferase (EC 2.3.1.102), aerobactin biosynthesis protein IucB @ Siderophore synthetase small component, acetyltransferase +FIG01960042 Cobalt-precorrin-8x methylmutase (EC 5.4.1.2) +FIG01960045 N-acetylmuramic acid 6-phosphate etherase (EC 4.2.-.-) +FIG01960046 Hydrolase in cluster with beta-lactamase (HAD superfamily) +FIG01960049 Multimodular transpeptidase-transglycosylase (EC 2.4.1.129) (EC 3.4.-.-) / Penicillin-binding protein 1A/1B (PBP1) +FIG01960050 PTS system, mannose-specific IID component +FIG01960052 Na(+) H(+) antiporter subunit F +FIG01960053 Phosphomannomutase (EC 5.4.2.8) / Phosphoglucomutase (EC 5.4.2.2) / Phosphoglucosamine mutase (EC 5.4.2.10) +FIG01960055 Na(+)-translocating NADH-quinone reductase subunit E (EC 1.6.5.-) +FIG01960056 NAD(P)H-plastoquinone oxidoreductase (EC 1.6.5.-) chain 5, NDHF +FIG01960057 Type IV pilus biogenesis protein PilF +FIG01960058 Lipoprotein releasing system transmembrane protein LolE +FIG01960059 Homogentisate 1,2-dioxygenase (EC 1.13.11.5) +FIG01960061 Sulfite reductase [NADPH] hemoprotein beta-component (EC 1.8.1.2) +FIG01960062 Alpha-1,4-N-acetylgalactosamine transferase PglH (EC 2.4.1.-) +FIG01960063 Forms the bulk of type IV secretion complex that spans outer membrane and periplasm (VirB9) +FIG01960065 LysR-family transcriptional regulator YhaJ +FIG01960066 Ribonuclease PH (EC 2.7.7.56) +FIG01960068 FIG005080: Possible exported protein +FIG01960070 Periplasmic thiol:disulfide oxidoreductase DsbB, required for DsbA reoxidation +FIG01960073 "Prephenate and/or arogenate dehydrogenase (unknown specificity) / Chorismate mutase I / Prephenate dehydratase " +FIG01960075 FIG000557: hypothetical protein co-occurring with RecR +FIG01960076 "Carbon monoxide dehydrogenase medium chain " +FIG01960078 LSU rRNA 2'-O-methyl-C2498 methyltransferase RlmM +FIG01960079 RecA protein +FIG01960080 AA3-600 quinol oxidase subunit I +FIG01960081 Predicted signal-transduction protein containing cAMP-binding and CBS domains +FIG01960082 Acetoacetyl-CoA reductase (EC 1.1.1.36) +FIG01960083 DNA polymerase X family +FIG01960084 Putative glycogen debranching enzyme, archaeal type, TIGR01561 +FIG01960088 Unknown domain / N-terminal domain of CinA protein, COG1058 / C-terminal domain of CinA type S +FIG01960089 Cytosol aminopeptidase PepA (EC 3.4.11.1) +FIG01960090 Xanthine dehydrogenase, FAD binding subunit (EC 1.17.1.4) +FIG01960092 Anaerobic sulfite reductase subunit A +FIG01960093 Fumarate and nitrate reduction regulatory protein +FIG01960094 Anthranilate synthase, amidotransferase component (EC 4.1.3.27) +FIG01960095 Lead, cadmium, zinc and mercury transporting ATPase (EC 3.6.3.3) (EC 3.6.3.5); Copper-translocating P-type ATPase (EC 3.6.3.4) +FIG01960096 Mgl repressor and galactose ultrainduction factor GalS, HTH-type transcriptional regulator +FIG01960097 LSU ribosomal protein L2p (L8e) +FIG01960099 Capsular polysaccharide export system protein KpsS +FIG01960100 Dihydrolipoamide dehydrogenase of acetoin dehydrogenase (EC 1.8.1.4) +FIG01960103 5-deoxy-glucuronate isomerase (EC 5.3.1.-) +FIG01960104 Two component system sensor histidine kinase PnpS; Phosphate regulon sensor protein PhoR (SphS) (EC 2.7.13.3) +FIG01960105 Phosphoserine phosphatase (EC 3.1.3.3) +FIG01960106 Nickel responsive regulator NikR +FIG01960107 Twin-arginine translocation protein TatB +FIG01960110 3-deoxy-manno-octulosonate cytidylyltransferase (EC 2.7.7.38) +FIG01960111 Anthranilate synthase, aminase component (EC 4.1.3.27) +FIG01960112 benzoate degradation ring-cleavage hydrolase +FIG01960113 Dihydrolipoamide dehydrogenase of pyruvate dehydrogenase complex (EC 1.8.1.4) +FIG01960115 FIG149030: hypothetical protein +FIG01960117 UDP-N-acetylmuramate:L-alanyl-gamma-D-glutamyl-meso-diaminopimelate ligase (EC 6.3.2.-) +FIG01960118 Hemoprotein HemQ, essential component of heme biosynthetic pathway in Gram-positive bacteria +FIG01960119 COG3118: Thioredoxin domain-containing protein EC-YbbN +FIG01960120 V-type ATP synthase subunit B (EC 3.6.3.14) +FIG01960121 Glutathione peroxidase (EC 1.11.1.9) +FIG01960122 Zinc ABC transporter, inner membrane permease protein ZnuB +FIG01960123 PTS system, galactitol-specific IIC component (EC 2.7.1.69) +FIG01960124 Hydroxymethylglutaryl-CoA synthase (EC 2.3.3.10) +FIG01960126 Cell division protein FtsI [Peptidoglycan synthetase] (EC 2.4.1.129) / Transpeptidase, Penicillin binding protein transpeptidase domain +FIG01960127 Pyrophosphate-energized proton pump (EC 3.6.1.1) +FIG01960128 Helicase loader DnaI +FIG01960129 Phosphoribosylformylglycinamidine synthase, glutamine amidotransferase subunit (EC 6.3.5.3) +FIG01960130 TonB-dependent receptor; Outer membrane receptor for ferrienterochelin and colicins +FIG01960132 Maltodextrin phosphorylase (EC 2.4.1.1) +FIG01960135 O-acetylhomoserine sulfhydrylase (EC 2.5.1.49) +FIG01960136 Urease accessory protein UreF +FIG01960137 5-keto-2-deoxygluconokinase (EC 2.7.1.92) +FIG01960138 Putative glucanase glgE (EC 3.2.1.-) +FIG01960139 FIG005429: hypothetical protein +FIG01960140 PvcB protein, related to amino acid oxidizing enzymes +FIG01960142 Imidazolonepropionase (EC 3.5.2.7) +FIG01960143 PTS system, beta-glucoside-specific IIA component (EC 2.7.1.69); PTS system, cellobiose-specific IIA component (EC 2.7.1.69) +FIG01960145 Pectate lyase precursor (EC 4.2.2.2) +FIG01960146 Proline/sodium symporter PutP (TC 2.A.21.2.1) @ Propionate/sodium symporter +FIG01960147 Chorismate mutase I (EC 5.4.99.5) / Biosynthetic Aromatic amino acid aminotransferase alpha (EC 2.6.1.57) +FIG01960148 Inosose dehydratase (EC 4.2.1.44) +FIG01960149 Inner membrane protein CreD-like protein +FIG01960151 Phosphoserine phosphatase (EC 3.1.3.3) / 1-acyl-sn-glycerol-3-phosphate acyltransferase (EC 2.3.1.51) +FIG01960152 Zinc transporter ZitB +FIG01960154 Hemin transport protein HmuS +FIG01960155 L-rhamnose operon transcriptional activator RhaR +FIG01960156 5-keto-2-deoxygluconokinase (EC 2.7.1.92) +FIG01960157 Sialidase (EC 3.2.1.18) +FIG01960158 Proline dehydrogenase (EC 1.5.99.8) (Proline oxidase) / Delta-1-pyrroline-5-carboxylate dehydrogenase (EC 1.5.1.12) +FIG01960160 Flagellar basal-body rod protein FlgG +FIG01960161 3-deoxy-D-manno-octulosonate 8-phosphate phosphatase (EC 3.1.3.45) +FIG01960162 Capsular polysaccharide synthesis enzyme CpsD, exopolysaccharide synthesis +FIG01960163 RND efflux system, membrane fusion protein CmeA +FIG01960164 Phosphoenolpyruvate-dihydroxyacetone phosphotransferase (EC 2.7.1.121), ADP-binding subunit DhaL +FIG01960165 Eukaryotic translation initiation factor 4G +FIG01960167 dTDP-4-dehydrorhamnose 3,5-epimerase (EC 5.1.3.13) +FIG01960169 Starvation sensing protein RspA +FIG01960171 Probable electron transfer flavoprotein-quinone oxidoreductase FixC (EC 1.5.5.-) +FIG01960172 Diaminopimelate decarboxylase (EC 4.1.1.20) +FIG01960173 Multidrug efflux pump component MtrF +FIG01960174 Hexose phosphate uptake regulatory protein UhpC +FIG01960175 COG2740: Predicted nucleic-acid-binding protein implicated in transcription termination +FIG01960178 Substrate-specific component RibU of riboflavin ECF transporter +FIG01960179 NADPH:quinone oxidoreductase 2 +FIG01960180 Lysyl-tRNA synthetase (class I) (EC 6.1.1.6) +FIG01960181 ThiJ/PfpI family protein +FIG01960182 TRAP-type transport system, small permease component, predicted N-acetylneuraminate transporter +FIG01960184 L-beta-lysine 5,6-aminomutase alpha subunit (EC 5.4.3.3) +FIG01960185 Stage III sporulation protein AE +FIG01960186 Altronate oxidoreductase (EC 1.1.1.58) +FIG01960187 Hydrogenase-4 component F +FIG01960188 Sulfate-binding protein Sbp +FIG01960191 NrfC protein +FIG01960192 Phage shock protein A +FIG01960193 Flagellar hook-length control protein FliK +FIG01960194 Hexuronate transporter +FIG01960195 PhnI protein +FIG01960196 Lipopolysaccharide heptosyltransferase I (EC 2.4.1.-) +FIG01960197 ErpA, essential respiratory protein A / probable iron binding protein from the HesB_IscA_SufA family +FIG01960198 ComF operon protein C +FIG01960200 Purine nucleotide synthesis repressor +FIG01960201 Creatinine amidohydrolase (EC 3.5.2.10) +FIG01960203 Phage major tail tube protein +FIG01960205 Putative formate dehydrogenase-specific chaperone +FIG01960206 Hydroxymethylglutaryl-CoA lyase (EC 4.1.3.4) +FIG01960209 [NiFe] hydrogenase metallocenter assembly protein HybG +FIG01960210 Uroporphyrinogen III decarboxylase (EC 4.1.1.37) +FIG01960211 FIG014356: hypothetical protein +FIG01960215 Para-aminobenzoate synthase, aminase component (EC 2.6.1.85) +FIG01960216 Putative stomatin/prohibitin-family membrane protease subunit YbbK +FIG01960217 putative Cytochrome bd2, subunit I +FIG01960218 Spermidine Putrescine ABC transporter permease component potC (TC_3.A.1.11.1) +FIG01960219 Sulfate permease, Pit-type +FIG01960220 Tryptophan synthase alpha chain (EC 4.2.1.20) +FIG01960221 Cytoplasmic alpha-amylase (EC 3.2.1.1) +FIG01960222 NifX-associated protein +FIG01960223 Histidine ABC transporter, permease protein HisQ (TC 3.A.1.3.1) +FIG01960224 Lactose permease +FIG01960225 TonB-dependent hemin , ferrichrome receptor +FIG01960226 Dihydroneopterin triphosphate epimerase +FIG01960227 FIG002344: Hydrolase (HAD superfamily) +FIG01960228 Hypothetical transcriptional regulator YqhC +FIG01960229 Thiosulfate reductase cytochrome B subunit +FIG01960230 Predicted nucleoside ABC transporter, substrate-binding component +FIG01960231 Translation elongation factor G-related protein +FIG01960232 Na(+)-translocating NADH-quinone reductase subunit F (EC 1.6.5.-) +FIG01960234 4-hydroxyproline epimerase (EC 5.1.1.8) +FIG01960236 Paratox +FIG01960239 Threonyl-tRNA synthetase fragment +FIG01960240 Ferredoxin--NADP(+) reductase, actinobacterial (eukaryote-like) type (EC 1.18.1.2) +FIG01960241 D-mannose isomerase (EC 5.3.1.7) +FIG01960242 Lysine-arginine-ornithine-binding periplasmic protein precursor (TC 3.A.1.3.1) +FIG01960243 Acyl-[acyl-carrier-protein]--UDP-N-acetylglucosamine O-acyltransferase (EC 2.3.1.129) +FIG01960244 ATPase component NikO of energizing module of nickel ECF transporter +FIG01960245 Adenylate cyclase (EC 4.6.1.1) @ Guanylate cyclase (EC 4.6.1.2) +FIG01960246 Arginine N-succinyltransferase (EC 2.3.1.109) +FIG01960248 Anaerobic sulfite reductase subunit A +FIG01960249 Clock-associated two-component sensor histidine kinase SasA +FIG01960250 L-proline glycine betaine binding ABC transporter protein ProX (TC 3.A.1.12.1) +FIG01960251 3'(2'),5'-bisphosphate nucleotidase (EC 3.1.3.7) +FIG01960253 Xanthine permease +FIG01960254 Uroporphyrinogen-III methyltransferase (EC 2.1.1.107) / Uroporphyrinogen-III synthase (EC 4.2.1.75) +FIG01960255 Branched-chain amino acid transport ATP-binding protein LivF (TC 3.A.1.4.1) +FIG01960256 Threonyl-tRNA synthetase (EC 6.1.1.3) +FIG01960257 Cobalt-precorrin-6y C15-methyltransferase [decarboxylating] (EC 2.1.1.-) +FIG01960258 N-methylhydantoinase A (EC 3.5.2.14) +FIG01960259 Ornithine aminotransferase (EC 2.6.1.13); Succinylornithine transaminase (EC 2.6.1.81); Acetylornithine aminotransferase (EC 2.6.1.11) +FIG01960260 Inner membrane ABC transporter permease protein YcjP +FIG01960263 Flagellar synthesis regulator FleN +FIG01960264 Gluconate 2-dehydrogenase (EC 1.1.99.3), membrane-bound, flavoprotein +FIG01960265 Cytosol aminopeptidase PepA (EC 3.4.11.1) +FIG01960267 5-carboxymethyl-2-hydroxymuconate semialdehyde dehydrogenase (EC 1.2.1.60) +FIG01960270 Methylglyoxal reductase, acetol producing (EC 1.1.1.-) / 2,5-diketo-D-gluconic acid reductase B (EC 1.1.1.274) +FIG01960271 TPR repeat containing exported protein; Putative periplasmic protein contains a protein prenylyltransferase domain +FIG01960273 TldD protein, part of proposed TldE/TldD proteolytic complex (PMID 12029038) +FIG01960274 Two-component response regulator BceR +FIG01960277 MazG-related protein +FIG01960279 Dihydrolipoamide dehydrogenase (EC 1.8.1.4) +FIG01960281 Thiamine biosynthesis protein thiI +FIG01960282 L(+)-tartrate dehydratase alpha subunit (EC 4.2.1.32) +FIG01960283 Putrescine ABC transporter putrescine-binding protein PotF (TC 3.A.1.11.2) +FIG01960284 Methionine synthase activation domain (EC 2.1.1.13) +FIG01960285 Thiol peroxidase, Tpx-type (EC 1.11.1.15) +FIG01960287 polyhydroxyalkanoate synthesis repressor PhaR +FIG01960288 Sulfate adenylyltransferase, dissimilatory-type (EC 2.7.7.4) +FIG01960289 Hydrogenase-4 component E (EC 1.-.-.-) +FIG01960290 Type III secretion injected virulence protein (YopE) +FIG01960291 Dihydroneopterin aldolase (EC 4.1.2.25) / unknown domain / 2-amino-4-hydroxy-6-hydroxymethyldihydropteridine pyrophosphokinase (EC 2.7.6.3) +FIG01960293 Phosphate starvation-inducible protein PhoH, predicted ATPase +FIG01960294 Deoxyribose-phosphate aldolase (EC 4.1.2.4) +FIG01960295 FIG001583: hypothetical protein, contains S4-like RNA binding domain +FIG01960296 Dihydrolipoamide dehydrogenase of branched-chain alpha-keto acid dehydrogenase (EC 1.8.1.4) +FIG01960297 Protocatechuate 3,4-dioxygenase alpha chain (EC 1.13.11.3) +FIG01960298 4-keto-6-deoxy-N-Acetyl-D-hexosaminyl-(Lipid carrier) aminotransferase +FIG01960299 LysR-family transcriptional regulator clustered with PA0057 +FIG01960302 Transcriptional regulator of rhamnose utilization, AraC family +FIG01960304 Gluconate transporter family protein +FIG01960305 Nitrite reductase [NAD(P)H] small subunit (EC 1.7.1.4) +FIG01960306 putative Glutathione-regulated potassium-efflux system protein KefB +FIG01960307 Sirohydrochlorin ferrochelatase (EC 4.99.1.4) +FIG01960308 Energy conserving hydrogenase Ehb protein H +FIG01960309 Cytoplasmic copper homeostasis protein CutC +FIG01960310 LysR family regulatory protein CidR +FIG01960311 Arginine ABC transporter, periplasmic arginine-binding protein ArtI +FIG01960312 ATP synthase F0 sector subunit c +FIG01960313 2-succinyl-5-enolpyruvyl-6-hydroxy-3-cyclohexene-1-carboxylic-acid synthase (EC 2.2.1.9) +FIG01960314 Ferrous iron transport peroxidase EfeB +FIG01960316 Phenol hydroxylase, assembly protein DmpK / Phenol hydroxylase, P1 oxygenase component DmpL (EC 1.14.13.7) +FIG01960319 Superoxide dismutase [Cu-Zn] precursor (EC 1.15.1.1) +FIG01960320 Redox-sensitive transcriptional regulator (AT-rich DNA-binding protein) +FIG01960321 Branched-chain alpha-keto acid dehydrogenase, E1 component, alpha subunit (EC 1.2.4.4) +FIG01960322 Major myo-inositol transporter IolT +FIG01960323 alternate gene name: yzbB +FIG01960324 L-serine dehydratase, beta subunit (EC 4.3.1.17) +FIG01960325 Non-phosphorylating glyceraldehyde-3-phosphate dehydrogenase (NADP) (EC 1.2.1.9) +FIG01960326 Alpha-glucosides-binding periplasmic protein AglE precursor +FIG01960327 Phage baseplate wedge subunit and tail pin (T4-like gp11) +FIG01960328 Sodium-Choline Symporter +FIG01960329 Nicel/Cobalt-specific TonB-dependent outer membrane receptor +FIG01960330 Serine hydroxymethyltransferase (EC 2.1.2.1) +FIG01960331 Multidrug resistance efflux pump PmrA +FIG01960332 Predicted L-lactate dehydrogenase, Iron-sulfur cluster-binding subunit YkgF +FIG01960335 Arginine decarboxylase, catabolic (EC 4.1.1.19) +FIG01960336 D-amino acid dehydrogenase small subunit (EC 1.4.99.1) +FIG01960337 Flagellar motor switch protein FliG +FIG01960338 Undecaprenyl-diphosphatase (EC 3.6.1.27) +FIG01960339 response regulator in two-component regulatory system with PhoQ +FIG01960340 DinG family ATP-dependent helicase CPE1197 +FIG01960341 p53-regulating protein kinase (human PRPK/yeast YGR262c) +FIG01960342 Transmembrane component MtsC of energizing module of methionine-regulated ECF transporter +FIG01960343 ABC-type nitrate/sulfonate/bicarbonate transport systems, periplasmic components +FIG01960345 ATP-dependent RNA helicase RhlE +FIG01960346 Valyl-tRNA synthetase (EC 6.1.1.9) +FIG01960347 Creatinine amidohydrolase (EC 3.5.2.10) +FIG01960348 Phytoene synthase (EC 2.5.1.32) +FIG01960349 Flagellar basal-body rod modification protein FlgD +FIG01960350 Fosfomycin resistance protein FosB +FIG01960351 Pyrroline-5-carboxylate reductase (EC 1.5.1.2) +FIG01960352 Biotin-protein ligase (EC 6.3.4.15) / Biotin operon repressor +FIG01960353 2,3-dihydro-2,3-dihydroxybenzoate dehydrogenase [enterobactin] siderophore @ 2,3-dihydro-2,3- dihydroxybenzoate dehydrogenase of siderophore biosynthesis +FIG01960354 Sodium/glycine symporter GlyP +FIG01960355 Predicted cobalt transporter CbtA +FIG01960356 Methionine gamma-lyase (EC 4.4.1.11) +FIG01960357 Flagellar basal-body rod modification protein FlgD +FIG01960358 "5-formyltetrahydrofolate cyclo-ligase " +FIG01960359 Pectinesterase (EC 3.1.1.11) +FIG01960360 5-dehydro-4-deoxyglucarate dehydratase (EC 4.2.1.41) +FIG01960362 Acetolactate synthase, catabolic (EC 2.2.1.6) +FIG01960363 Mercuric ion reductase (EC 1.16.1.1) +FIG01960364 Excinuclease ABC subunit B +FIG01960365 D-arabinose 5-phosphate isomerase (EC 5.3.1.13) +FIG01960366 RND efflux system, membrane fusion protein CmeA +FIG01960367 tRNA-dependent lipid II--amino acid ligase +FIG01960368 N-methylhydantoinase A (EC 3.5.2.14) +FIG01960371 Holliday junction DNA helicase RuvA +FIG01960372 Phosphoenolpyruvate carboxykinase [ATP] (EC 4.1.1.49) +FIG01960373 Thioredoxin +FIG01960374 8-amino-7-oxononanoate synthase (EC 2.3.1.47) +FIG01960375 4-oxalocrotonate decarboxylase (EC 4.1.1.77) +FIG01960376 Xaa-Pro aminopeptidase (EC 3.4.11.9) +FIG01960377 Sodium-transporting ATPase subunit E +FIG01960378 Transcriptional regulator GabR of GABA utilization (GntR family with aminotransferase-like domain) +FIG01960379 toluenesulfonate zinc-independent alcohol dehydrogenase +FIG01960380 Periplasmic [Fe] hydrogenase (EC 1.12.7.2) +FIG01960381 Cyclohexadienyl dehydrogenase (EC 1.3.1.12)(EC 1.3.1.43) / 5-Enolpyruvylshikimate-3-phosphate synthase (EC 2.5.1.19) +FIG01960382 SAM-dependent methlytransferase YrrT +FIG01960383 TonB system biopolymer transport component +FIG01960384 Salicylate hydroxylase (EC 1.14.13.1) +FIG01960385 Beta-lactamase, class C +FIG01960386 Quinolinate synthetase (EC 2.5.1.72) +FIG01960389 Enoyl-[acyl-carrier-protein] reductase [FMN] (EC 1.3.1.9) +FIG01960390 O-succinylbenzoic acid--CoA ligase (EC 6.2.1.26) +FIG01960391 putative Cytochrome bd2, subunit I +FIG01960392 Uncharacterized polyferredoxin MJ0749 +FIG01960393 LSU ribosomal protein L6p (L9e) +FIG01960394 tRNA 2-thiouridine synthesizing protein E (EC 2.8.1.-) @ Sulfite reductase, dissimilatory-type gamma subunit (EC 1.8.99.3) +FIG01960395 Cobyrinic acid A,C-diamide synthase +FIG01960396 ATP synthase F0 sector subunit c (EC 3.6.3.14) +FIG01960397 Outer membrane porin, OprD family +FIG01960400 "Shikimate kinase I / 3-dehydroquinate dehydratase II / Shikimate 5-dehydrogenase I alpha " +FIG01960401 Phosphoribosylformylglycinamidine synthase, synthetase subunit (EC 6.3.5.3) / Phosphoribosylformylglycinamidine synthase, glutamine amidotransferase subunit (EC 6.3.5.3) +FIG01960402 Protoporphyrinogen IX oxidase, aerobic, HemY (EC 1.3.3.4) +FIG01960404 Transcriptional regulator KdgR, KDG operon repressor +FIG01960405 Alpha-D-GlcNAc alpha-1,2-L-rhamnosyltransferase (EC 2.4.1.-) +FIG01960407 Uridine monophosphate kinase (EC 2.7.4.22) +FIG01960408 Phosphoheptose isomerase (EC 5.3.1.-) +FIG01960410 Protein of unknown function DUF1009 clustered with KDO2-Lipid A biosynthesis genes +FIG01960412 Nickel transport ATP-binding protein NikD (TC 3.A.1.5.3) +FIG01960413 Alpha-related fimbriae major subunit +FIG01960415 5-nucleotidase SurE (EC 3.1.3.5) +FIG01960416 PTS system, chitobiose-specific IIA component (EC 2.7.1.69) +FIG01960417 Urease alpha subunit (EC 3.5.1.5) +FIG01960418 CBSS-272943.3.peg.263: thioredoxin +FIG01960419 2'-5' RNA ligase +FIG01960420 4-aminobutyraldehyde dehydrogenase (EC 1.2.1.19) +FIG01960421 2,3,4,5-tetrahydropyridine-2,6-dicarboxylate N-succinyltransferase (EC 2.3.1.117) +FIG01960422 Exodeoxyribonuclease V gamma chain (EC 3.1.11.5) +FIG01960424 NADH dehydrogenase I subunit 4, Involved in photosystem-1 cyclic electron flow +FIG01960425 Hypothetical protein in predicted poly-gamma-glutamate synthase operon +FIG01960426 GTP cyclohydrolase II (EC 3.5.4.25) +FIG01960428 Transcription initiation factor B-related protein +FIG01960429 Succinate dehydrogenase cytochrome b560 subunit +FIG01960430 ATP-dependent Clp protease proteolytic subunit (EC 3.4.21.92) +FIG01960431 1-hydroxy-2-naphthaldehyde dehydrogenase +FIG01960432 TRAP dicarboxylate transporter, DctM subunit, unknown substrate 6 +FIG01960433 D(-)-3-hydroxybutyrate oligomer hydrolase (EC 3.1.1.22) +FIG01960434 1-phosphofructokinase (EC 2.7.1.56) +FIG01960436 Guanine-hypoxanthine permease +FIG01960437 ABC1 family protein Namu_1592 +FIG01960438 Bactriocin immunity protein BlpY +FIG01960439 Carboxynorspermidine dehydrogenase, putative (EC 1.1.1.-) +FIG01960440 tRNA nucleotidyltransferase, CC-adding (EC 2.7.7.21) +FIG01960441 Fructose-bisphosphate aldolase class II (EC 4.1.2.13) +FIG01960442 Nickel transport system permease protein NikB (TC 3.A.1.5.3) +FIG01960443 Acylphosphate phosphohydrolase (EC 3.6.1.7), putative +FIG01960444 Type II, N6M-methyladenine DNA methyltransferase (group beta) +FIG01960445 2-deoxyglucose-6-phosphate hydrolase YniC +FIG01960446 Uncharacterized protein with LysM domain, COG1652 +FIG01960447 UDP-N-acetylmuramoylalanine--D-glutamate ligase (EC 6.3.2.9) +FIG01960450 Acetoin dehydrogenase E1 component alpha-subunit (EC 1.2.4.-) / Acetoin dehydrogenase E1 component beta-subunit (EC 1.2.4.-) +FIG01960451 Cell wall surface anchor family protein +FIG01960452 Ethanolamine sensory transduction histidine kinase +FIG01960453 Peptide chain release factor 1 +FIG01960454 Polyribonucleotide nucleotidyltransferase (EC 2.7.7.8) +FIG01960456 Phosphoheptose isomerase 1 (EC 5.3.1.-) +FIG01960457 Hypothetical NagD-like phosphatase +FIG01960458 Glutamyl-tRNA(Gln) synthetase (EC 6.1.1.24) +FIG01960459 Vitamin B12 ABC transporter, ATPase component BtuD +FIG01960460 tRNA (cytosine34-2'-O-)-methyltransferase (EC 2.1.1.-) +FIG01960462 Phosphonate ABC transporter ATP-binding protein (TC 3.A.1.9.1) +FIG01960463 Pantothenate kinase (EC 2.7.1.33) +FIG01960465 NADH dehydrogenase, subunit 5 +FIG01960466 Leucyl-tRNA synthetase (EC 6.1.1.4) +FIG01960467 ; Acetaldehyde dehydrogenase (EC 1.2.1.3) +FIG01960468 Putative sugar ABC transport system, periplasmic binding protein YtfQ precursor +FIG01960469 Cytochrome c-type heme lyase subunit nrfE, nitrite reductase complex assembly +FIG01960470 Electron transport complex protein RnfD +FIG01960471 Fructose-bisphosphate aldolase class I (EC 4.1.2.13) +FIG01960472 IncH1 plasmid conjugative transfer protein Orf17 +FIG01960474 Flagellar hook-length control protein FliK +FIG01960475 Two-component response regulator SA14-24 +FIG01960476 Dihydroorotate dehydrogenase, catalytic subunit (EC 1.3.3.1) +FIG01960477 Putative n-hydroxybenzoate hydroxylase +FIG01960478 Folate carrier, cyanobacterial type +FIG01960481 Threonine dehydratase biosynthetic (EC 4.3.1.19) +FIG01960482 Selenocysteine-specific translation elongation factor +FIG01960483 O-succinylbenzoate synthase (EC 4.2.1.113) +FIG01960484 TonB-dependent receptor +FIG01960485 Chitin binding protein +FIG01960487 Dihydrolipoamide dehydrogenase of 2-oxoglutarate dehydrogenase (EC 1.8.1.4) +FIG01960488 Putative preQ0 transporter +FIG01960489 Phosphoenolpyruvate-protein phosphotransferase of PTS system (EC 2.7.3.9) +FIG01960490 Methylmalonate-semialdehyde dehydrogenase (EC 1.2.1.27) +FIG01960491 SSU ribosomal protein S9p (S16e) +FIG01960492 Oligopeptide transport system permease protein OppC (TC 3.A.1.5.1) +FIG01960493 Positive regulator of CheA protein activity (CheW) +FIG01960494 Beta-glucosidase (EC 3.2.1.21); 6-phospho-beta-glucosidase (EC 3.2.1.86) +FIG01960495 GDP-L-fucose synthetase (EC 1.1.1.271) +FIG01960496 Naphthoate synthase (EC 4.1.3.36) +FIG01960498 UDP-glucose:(heptosyl) LPS alpha1,3-glucosyltransferase WaaG (EC 2.4.1.-) +FIG01960499 Homogentisate 1,2-dioxygenase (EC 1.13.11.5) +FIG01960500 L-fucose operon activator +FIG01960501 Peroxide stress regulator PerR, FUR family +FIG01960502 Duplicated ATPase component CbrU of energizing module of predicted cobalamin ECF transporter +FIG01960503 Electron transport complex cytochrome- containing, methanophenazine reductase +FIG01960504 Acetate permease ActP (cation/acetate symporter) +FIG01960506 Oligogalacturonate lyase (EC 4.2.2.6) +FIG01960507 Protein YicC +FIG01960510 Cysteine desulfurase CsdA-CsdE (EC 2.8.1.7), main protein CsdA +FIG01960511 Phosphoribosyl-AMP cyclohydrolase (EC 3.5.4.19) +FIG01960512 Zinc ABC transporter, inner membrane permease protein ZnuB +FIG01960513 Homocysteine S-methyltransferase (EC 2.1.1.10) +FIG01960514 NAD-dependent formate dehydrogenase alpha subunit +FIG01960515 Cytochrome O ubiquinol oxidase subunit II (EC 1.10.3.-) +FIG01960519 SoxH protein, homolog +FIG01960520 D-lactate dehydrogenase (EC 1.1.1.28) +FIG01960521 Fructose-1,6-bisphosphatase, type I (EC 3.1.3.11) +FIG01960522 Queuosine biosynthesis QueD, PTPS-I / Folate biosynthesis protein PTPS-III, catalyzes a reaction that bypasses dihydroneopterin aldolase (FolB) / partial? +FIG01960523 Fructuronate transporter GntP +FIG01960524 Putative transcriptional regulator of sorbose uptake and utilization genes +FIG01960525 Cyanate hydratase (EC 4.2.1.104) +FIG01960527 Signal transduction protein CetB, mediates an energy taxis response +FIG01960528 Glutaredoxin-related protein +FIG01960529 Transcriptional regulator in cluster with beta-lactamase, GntR family +FIG01960530 Gluconate utilization system Gnt-I transcriptional repressor +FIG01960531 Alkanesulfonate monooxygenase (EC 1.14.14.5) +FIG01960532 ATP-dependent hsl protease ATP-binding subunit HslU +FIG01960533 transmembrane protein, distant homology with ydbT +FIG01960534 Cytochrome c heme lyase subunit CcmF +FIG01960536 Lysyl-tRNA synthetase (class I) (EC 6.1.1.6) +FIG01960537 Sulfate transport system permease protein CysW +FIG01960539 Ni,Fe-hydrogenase I cytochrome b subunit +FIG01960540 Glutathione-regulated potassium-efflux system ATP-binding protein +FIG01960541 Eukaryotic-type low-affinity urea transporter +FIG01960542 Sulfite reductase [NADPH] hemoprotein beta-component (EC 1.8.1.2) +FIG01960543 Putrescine aminotransferase (EC 2.6.1.82) +FIG01960544 Putative preQ0 transporter +FIG01960545 Excinuclease ABC subunit A +FIG01960546 P-hydroxybenzoate hydroxylase (EC 1.14.13.2) +FIG01960547 NADH dehydrogenase subunit 4L +FIG01960548 Glutaredoxin-like protein NrdH, required for reduction of Ribonucleotide reductase class Ib +FIG01960549 "Enoyl-CoA hydratase / 3-hydroxyacyl-CoA dehydrogenase / 3-hydroxybutyryl-CoA epimerase " +FIG01960551 Nickel transport ATP-binding protein NikD (TC 3.A.1.5.3) +FIG01960552 Ferric hydroxamate ABC transporter (TC 3.A.1.14.3), periplasmic substrate binding protein FhuD +FIG01960553 Pyridine nucleotide-disulfide oxidoreductase; NADH dehydrogenase (EC 1.6.99.3) +FIG01960554 Peptidyl-tRNA hydrolase (EC 3.1.1.29) +FIG01960555 Glutamate--cysteine ligase (EC 6.3.2.2) +FIG01960556 Outer membrane protein YfgL, lipoprotein component of the protein assembly complex (forms a complex with YaeT, YfiO, and NlpB) +FIG01960557 TonB-dependent receptor +FIG01960558 PTS system, fructose-specific IIB component (EC 2.7.1.69) / PTS system, fructose-specific IIC component (EC 2.7.1.69) +FIG01960559 Cyanate transport protein CynX +FIG01960560 IncH1 plasmid conjugative transfer protein HtdA +FIG01960561 Nitrite reductase probable [NAD(P)H] subunit (EC 1.7.1.4) +FIG01960562 Putative deoxyribose-specific ABC transporter, ATP-binding protein +FIG01960563 Non-specific DNA-binding protein Dps / Iron-binding ferritin-like antioxidant protein / Ferroxidase (EC 1.16.3.1) +FIG01960564 Stage III sporulation protein AE +FIG01960566 Indole-3-glycerol phosphate synthase (EC 4.1.1.48) +FIG01960567 Poly(A) polymerase (EC 2.7.7.19) +FIG01960568 Respiratory nitrate reductase gamma chain (EC 1.7.99.4) +FIG01960569 L-idonate, D-gluconate, 5-keto-D-gluconate transporter +FIG01960570 Serine acetyltransferase (EC 2.3.1.30) +FIG01960571 MiaB family protein, possibly involved in tRNA or rRNA modification +FIG01960572 ATP-dependent hsl protease ATP-binding subunit HslU +FIG01960573 Na(+)-translocating NADH-quinone reductase subunit F (EC 1.6.5.-) +FIG01960574 Sarcosine oxidase beta subunit (EC 1.5.3.1) +FIG01960575 5'-nucleotidase YjjG (EC 3.1.3.5) +FIG01960576 Phosphomevalonate kinase (EC 2.7.4.2) +FIG01960577 Phytoene desaturase, pro-zeta-carotene producing (EC 1.-.-.-) +FIG01960578 Fumarate reductase subunit C +FIG01960579 Chorismate--pyruvate lyase (EC 4.1.3.40) +FIG01960580 RecD-like DNA helicase Atu2026 +FIG01960582 FIG002708: Protein SirB1 +FIG01960583 Isochorismate synthase (EC 5.4.4.2) [enterobactin] siderophore +FIG01960584 Putative dihydroxyacetone kinase (EC 2.7.1.29), ADP-binding subunit +FIG01960585 Xaa-Pro dipeptidyl-peptidase (EC 3.4.14.11) +FIG01960586 D-alanine--poly(phosphoribitol) ligase subunit 1 (EC 6.1.1.13) +FIG01960588 N-acetyl-L,L-diaminopimelate deacetylase (EC 3.5.1.47) +FIG01960589 Quinone-reactive Ni/Fe hydrogenase, cytochrome b subunit +FIG01960590 Glyoxylate reductase (EC 1.1.1.79) / Glyoxylate reductase (EC 1.1.1.26) / Hydroxypyruvate reductase (EC 1.1.1.81) +FIG01960593 ABC transporter permease protein YvcS +FIG01960594 Trk system potassium uptake protein TrkA +FIG01960595 Putative oxidoreductase component of anaerobic dehydrogenases; Functional role page for Chaperone protein TorD +FIG01960596 Electron transport complex protein RnfG +FIG01960597 DNA recombination and repair protein RecO +FIG01960598 Dihydrolipoamide succinyltransferase component (E2) of 2-oxoglutarate dehydrogenase complex (EC 2.3.1.61) +FIG01960600 Exoribonuclease II (EC 3.1.13.1) +FIG01960601 Putative Dihydrolipoamide dehydrogenase (EC 1.8.1.4); Mercuric reductase (EC 1.16.1.1); Probable pyridine nucleotide-disulfide oxidoreductase YkgC +FIG01960602 MCE-family lipoprotein LprK (MCE-family lipoprotein Mce1e) +FIG01960605 2,3-dihydroxybiphenyl 1,2-dioxygenase +FIG01960606 Type cbb3 cytochrome oxidase biogenesis protein CcoH +FIG01960607 Sialic acid transporter (permease) NanT +FIG01960608 Maltose/maltodextrin transport ATP-binding protein MalK (EC 3.6.3.19); Multiple sugar ABC transporter, ATP-binding protein +FIG01960609 3-polyprenyl-4-hydroxybenzoate carboxy-lyase (EC 4.1.1.-) +FIG01960610 Histidinol-phosphatase [alternative form] (EC 3.1.3.15) +FIG01960611 Phosphoheptose isomerase (EC 5.3.1.-) +FIG01960613 UDP-glucose dehydrogenase (EC 1.1.1.22) +FIG01960615 Menaquinone-specific isochorismate synthase (EC 5.4.4.2) +FIG01960616 Cytochrome c oxidase polypeptide I (EC 1.9.3.1) +FIG01960617 rRNA small subunit 7-methylguanosine (m7G) methyltransferase GidB +FIG01960618 Capsular polysaccharide ABC transporter, permease protein KpsM +FIG01960619 Formate dehydrogenase related protein +FIG01960620 Rhamnulokinase RhaK in alpha-proteobacteria (EC 2.7.1.5) +FIG01960621 NADH-ubiquinone oxidoreductase chain L (EC 1.6.5.3) +FIG01960623 Acetoin catabolism protein X +FIG01960625 Homoserine O-succinyltransferase (EC 2.3.1.46) +FIG01960627 Sucrose operon repressor ScrR, LacI family +FIG01960628 Heme efflux system permease HrtB +FIG01960629 Homocysteine S-methyltransferase (EC 2.1.1.10) +FIG01960631 Anaerobic dimethyl sulfoxide reductase chain C (EC 1.8.5.3) +FIG01960632 NnrS protein involved in response to NO +FIG01960635 2-dehydro-3-deoxygalactonokinase (EC 2.7.1.58) +FIG01960636 Low molecular weight protein tyrosine phosphatase (EC 3.1.3.48) / Ribose 5-phosphate isomerase B (EC 5.3.1.6) +FIG01960637 Phosphoribosyl-AMP cyclohydrolase (EC 3.5.4.19) / Phosphoribosyl-ATP pyrophosphatase (EC 3.6.1.31) +FIG01960638 Inositol transport system permease protein +FIG01960639 Menaquinone via futalosine step 1 +FIG01960640 Protein containing PTS-regulatory domain +FIG01960641 Potassium uptake protein, integral membrane component, KtrA +FIG01960643 Manganese superoxide dismutase (EC 1.15.1.1) +FIG01960644 Prolyl-tRNA synthetase (EC 6.1.1.15), bacterial type +FIG01960645 Flagellar hook-basal body complex protein FliE +FIG01960646 Dihydrolipoamide dehydrogenase of acetoin dehydrogenase (EC 1.8.1.4) +FIG01960648 Dipeptide-binding ABC transporter, periplasmic substrate-binding component (TC 3.A.1.5.2); Putative hemin-binding lipoprotein +FIG01960649 Alpha-L-Rha alpha-1,3-L-rhamnosyltransferase (EC 2.4.1.-) +FIG01960651 Transcriptional regulatory protein RtcR +FIG01960652 Hypothetical protein VC0266 (sugar utilization related?) +FIG01960653 Xaa-Pro dipeptidyl-peptidase (EC 3.4.14.11) +FIG01960654 GTP cyclohydrolase I (EC 3.5.4.16) type 2 +FIG01960655 Heavy metal sensor histidine kinase +FIG01960657 Metallo-beta-lactamase family protein, RNA-specific +FIG01960659 Phosphoribosylglycinamide formyltransferase 2 (EC 2.1.2.-) +FIG01960660 Geranylgeranyl pyrophosphate synthetase (GGPP synthetase) (GGPS) [Includes: Dimethylallyltranstransferase (EC 2.5.1.1); (2E,6E)-farnesyl diphosphate synthase (EC 2.5.1.10); Farnesyltranstransferase (EC 2.5.1.29)] +FIG01960661 Adenosylmethionine-8-amino-7-oxononanoate aminotransferase (EC 2.6.1.62) +FIG01960663 Zinc metalloproteinase precursor (EC 3.4.24.29) / aureolysin +FIG01960664 Phosphoheptose isomerase (EC 5.3.1.-) +FIG01960665 2-hydroxymuconic semialdehyde hydrolase (EC 3.7.1.9) +FIG01960667 L-arabinolactonase (EC 3.1.1.15) +FIG01960668 Lactate-responsive regulator LldR in Enterobacteria, GntR family +FIG01960669 SSU ribosomal protein S19p (S15e) +FIG01960671 Formate hydrogenlyase subunit 2 +FIG01960672 Autoinducer 2 sensor kinase/phosphatase LuxQ (EC 2.7.3.-) (EC 3.1.3.-) +FIG01960673 HoxN/HupN/NixA family nickel/cobalt transporter +FIG01960674 Phytoene dehydrogenase (EC 1.14.99.-) +FIG01960675 Phage baseplate assembly protein V +FIG01960676 Cysteine desulfurase (EC 2.8.1.7), SufS subfamily +FIG01960677 "Phosphatidylinositol-specific phospholipase C " +FIG01960678 Adenosylcobinamide-phosphate synthase +FIG01960679 Gluconate 2-dehydrogenase (EC 1.1.99.3), membrane-bound, cytochrome c +FIG01960680 L-threonine 3-O-phosphate decarboxylase (EC 4.1.1.81) +FIG01960682 FIG050068: DNA-binding protein +FIG01960683 Arabinose-proton symporter +FIG01960684 Putative heat shock protein YegD +FIG01960685 Candidate substrate-specific domain of ECF transporters in Mycobacteria / Duplicated ATPase component of energizing module of predicted ECF transporter in Mycobacteria +FIG01960686 Various polyols ABC transporter, permease component 2 +FIG01960687 Inactive homolog of metal-dependent proteases, putative molecular chaperone +FIG01960688 Sensor histidine kinase VanS (EC 2.7.3.-) +FIG01960689 3,4-dihydroxyphenylacetate 2,3-dioxygenase (EC 1.13.11.15) +FIG01960691 Biotin carboxyl carrier protein of oxaloacetate decarboxylase; Biotin carboxyl carrier protein +FIG01960692 4-hydroxyproline epimerase (EC 5.1.1.8) +FIG01960693 Tagatose-6-phosphate kinase (EC 2.7.1.144) +FIG01960694 tungsten-containing formate dehydrogenase alpha subunit +FIG01960695 5-dehydro-4-deoxyglucarate dehydratase (EC 4.2.1.41) +FIG01960696 5-keto-2-deoxygluconokinase (EC 2.7.1.92) / uncharacterized domain +FIG01960697 Beta N-acetyl-glucosaminidase (EC 3.2.1.52) +FIG01960698 Hydroxyethylthiazole kinase (EC 2.7.1.50) +FIG01960699 FIG001621: Zinc protease +FIG01960700 Benzoate 1,2-dioxygenase alpha subunit (EC 1.14.12.10) +FIG01960701 L-seryl-tRNA(Sec) selenium transferase (EC 2.9.1.1) +FIG01960703 probable beta-D-galactosidase +FIG01960704 D-nopaline catabolic operon protein 2 @ Opine oxidase subunit C +FIG01960705 Protoporphyrin IX Mg-chelatase subunit H (EC 6.6.1.1) +FIG01960706 Fructose-1,6-bisphosphatase, Bacillus type (EC 3.1.3.11) +FIG01960707 Polysaccharide export lipoprotein Wza +FIG01960708 Starvation sensing protein RspA +FIG01960709 HNH endonuclease family protein +FIG01960710 LSU ribosomal protein L35p +FIG01960711 Methylenetetrahydrofolate dehydrogenase (NADP+) (EC 1.5.1.5) / Methenyltetrahydrofolate cyclohydrolase (EC 3.5.4.9) +FIG01960713 Sugar/maltose fermentation stimulation protein homolog +FIG01960714 Ribosome-binding factor A +FIG01960715 Putative deoxyribose-specific ABC transporter, permease protein +FIG01960716 Glutamyl-tRNA(Gln) synthetase (EC 6.1.1.24) +FIG01960718 Cobalt/zinc/cadmium efflux RND transporter, membrane fusion protein, CzcB family +FIG01960719 Sensor histidine kinase colocalized with HrtAB transporter +FIG01960720 2-methylcitrate synthase (EC 2.3.3.5) +FIG01960721 Nitric oxide reductase activation protein NorD +FIG01960724 Oxalyl-CoA decarboxylase (EC 4.1.1.8) +FIG01960725 Dihydrolipoamide acetyltransferase component (E2) of acetoin dehydrogenase complex (EC 2.3.1.-) +FIG01960726 HtrA protease/chaperone protein / Serine protease (Protease DO) (EC 3.4.21.-) +FIG01960727 Chaperone protein HscA +FIG01960729 IncH1 plasmid conjugative transfer protein HtdO +FIG01960731 N-acetylglucosamine-regulated TonB-dependent outer membrane receptor +FIG01960733 Evolved beta-D-galactosidase, alpha subunit +FIG01960735 Hypothetical SAV0790 homolog in superantigen-encoding pathogenicity islands SaPI +FIG01960736 Malonyl CoA acyl carrier protein transacylase (EC 2.3.1.39) +FIG01960737 Ferric hydroxamate outer membrane receptor FhuA +FIG01960738 Lactaldehyde dehydrogenase involved in fucose or rhamnose utilization (EC 1.2.1.22) +FIG01960739 Arginyl-tRNA synthetase (EC 6.1.1.19) +FIG01960740 Histidine utilization repressor +FIG01960741 Cobalt-precorrin-2 C20-methyltransferase (EC 2.1.1.130) +FIG01960742 Phosphoesterase, DHH family protein +FIG01960744 Substrate-specific component PdxU2 of predicted pyridoxin-related ECF transporter +FIG01960745 4-hydroxybenzoate polyprenyltransferase (EC 2.5.1.39) +FIG01960747 RNA polymerase sigma factor +FIG01960748 Lysine decarboxylase, inducible (EC 4.1.1.18) +FIG01960749 2-ketoaldonate reductase, broad specificity (EC 1.1.1.215) (EC 1.1.1.-) +FIG01960750 "Dihydroneopterin aldolase " +FIG01960751 Anthranilate synthase, amidotransferase component (EC 4.1.3.27) @ Para-aminobenzoate synthase, amidotransferase component (EC 2.6.1.85) +FIG01960752 Hypothetical protein ywlG +FIG01960754 Glutathione S-transferase, omega (EC 2.5.1.18) +FIG01960755 2-methylcitrate dehydratase (EC 4.2.1.79) +FIG01960757 3-oxoadipate CoA-transferase subunit B (EC 2.8.3.6) +FIG01960758 Malto-oligosyltrehalose trehalohydrolase (EC 3.2.1.141) +FIG01960759 Replicative DNA helicase (EC 3.6.1.-) [SA14-24] +FIG01960760 Succinyl-CoA:3-ketoacid-coenzyme A transferase subunit A (EC 2.8.3.5) +FIG01960761 Duplicated ATPase component MtsB of energizing module of methionine-regulated ECF transporter +FIG01960762 Catabolite control protein A +FIG01960763 Probable 3-phenylpropionic acid transporter +FIG01960764 Hexuronate utilization operon transcriptional repressor ExuR +FIG01960765 Rhamnulokinase (EC 2.7.1.5) +FIG01960766 2,4-dihydroxyhept-2-ene-1,7-dioic acid aldolase (EC 4.1.2.-) +FIG01960767 tRNA (Guanine37-N1) -methyltransferase (EC 2.1.1.31) +FIG01960768 Radical SAM family enzyme, similar to coproporphyrinogen III oxidase, oxygen-independent, clustered with nucleoside-triphosphatase RdgB +FIG01960769 Iron-sulfur cluster assembly protein SufD +FIG01960770 SSU ribosomal protein S16p +FIG01960771 Various polyols ABC transporter, permease component 1 +FIG01960772 Conjugative transfer protein TrbB +FIG01960773 Thymidine kinase (EC 2.7.1.21) +FIG01960774 Cysteine desulfurase (EC 2.8.1.7), SufS subfamily +FIG01960777 Galactose/methyl galactoside ABC transport system, D-galactose-binding periplasmic protein MglB (TC 3.A.1.2.3) +FIG01960778 Butyrate kinase (EC 2.7.2.7) +FIG01960779 Flagellar basal-body rod protein FlgG +FIG01960780 Probable L-ascorbate-6-phosphate lactonase UlaG (EC 3.1.1.-) (L-ascorbate utilization protein G) +FIG01960781 Glucosamine-6-phosphate deaminase [isomerizing], alternative (EC 3.5.99.6) +FIG01960782 Heme transporter IsdDEF, permease component IsdF +FIG01960783 Energy conserving hydrogenase Eha polyferredoxin (protein P) +FIG01960784 NADH-ubiquinone oxidoreductase chain L (EC 1.6.5.3) +FIG01960785 23S rRNA (guanine-N-2-) -methyltransferase rlmG (EC 2.1.1.-) +FIG01960786 Deoxyadenosine kinase (EC 2.7.1.76) / Deoxyguanosine kinase (EC 2.7.1.113) +FIG01960787 6-phosphogluconolactonase (EC 3.1.1.31), eukaryotic type +FIG01960788 Putative sugar transporter +FIG01960791 3-deoxy-manno-octulosonate cytidylyltransferase (EC 2.7.7.38) +FIG01960793 Dihydrolipoamide succinyltransferase component (E2) of 2-oxoglutarate dehydrogenase complex (EC 2.3.1.61) +FIG01960794 "Formylmethanofuran dehydrogenase subunit D / Formylmethanofuran dehydrogenase subunit B " +FIG01960796 O-acetylhomoserine sulfhydrylase (EC 2.5.1.49) / O-succinylhomoserine sulfhydrylase (EC 2.5.1.48) +FIG01960798 DNA recombination protein RmuC +FIG01960799 2-octaprenyl-3-methyl-6-methoxy-1,4-benzoquinol hydroxylase (EC 1.14.13.-) +FIG01960800 Glycine dehydrogenase [decarboxylating] (glycine cleavage system P2 protein) (EC 1.4.4.2) +FIG01960801 6-phospho-3-hexuloisomerase +FIG01960802 Phycocyanin alpha chain +FIG01960803 Macrolide-specific efflux protein MacA +FIG01960804 Putative phosphatase YfbT +FIG01960805 tRNA (Uracil54-C5-)-methyltransferase (EC 2.1.1.35) +FIG01960806 Iron compound ABC uptake transporter substrate-binding protein +FIG01960809 Propionate kinase (EC 2.7.2.15) / Acetate kinase (EC 2.7.2.1) +FIG01960811 Putative bacterial haemoglobin +FIG01960812 Psp operon transcriptional activator +FIG01960813 Tetrachloroethene reductive dehalogenase TceA +FIG01960814 SSU ribosomal protein S6p +FIG01960820 Urea ABC transporter, permease protein UrtC +FIG01960823 D-alanine--D-alanine ligase (EC 6.3.2.4) +FIG01960824 Squalene--hopene cyclase (EC 5.4.99.17) +FIG01960826 Uroporphyrinogen-III synthase (EC 4.2.1.75) +FIG01960827 Lipoprotein releasing system ATP-binding protein LolD +FIG01960828 Survival protein SurA precursor (Peptidyl-prolyl cis-trans isomerase SurA) (EC 5.2.1.8) +FIG01960829 Mannonate dehydratase (EC 4.2.1.8) +FIG01960833 Na(+)-translocating NADH-quinone reductase subunit C (EC 1.6.5.-) +FIG01960834 Transcriptional antiterminator with PTS regulation domain, SPy0181 ortholog +FIG01960835 Acyl-coenzyme A synthetases/AMP-(fatty) acid ligases, YtcI homolog +FIG01960836 N-methylhydantoinase B (EC 3.5.2.14) +FIG01960837 3-(3-hydroxy-phenyl)propionate hydroxylase (EC 1.14.13.-) +FIG01960841 Ribose operon repressor +FIG01960843 Monoglyceride lipase (EC 3.1.1.23) +FIG01960844 3-oxoadipate CoA-transferase subunit B (EC 2.8.3.6) +FIG01960845 CrtV-methyltransferase-like protein +FIG01960846 Uncharacterized GST-like protein yghU associated with glutathionylspermidine synthetase/amidase +FIG01960847 Rubisco activation protein CbbO +FIG01960848 D-galactarate permease +FIG01960849 Hydroxysteroid sulfotransferase SULT2B1a (EC 2.8.2.2) +FIG01960850 GTP-sensing transcriptional pleiotropic repressor codY +FIG01960851 Homoserine O-succinyltransferase (EC 2.3.1.46) +FIG01960852 Inner membrane protein YrbG, predicted calcium/sodium:proton antiporter +FIG01960853 Branched-chain amino acid transport ATP-binding protein LivF (TC 3.A.1.4.1) +FIG01960854 twitching motility protein PilG +FIG01960856 rRNA small subunit methyltransferase I +FIG01960859 Rrf2 family transcriptional regulator, group III +FIG01960860 Substrate-specific component RibU of riboflavin ECF transporter +FIG01960863 Predicted P-loop ATPase fused to an acetyltransferase COG1444 +FIG01960864 AA3-600 quinol oxidase subunit I +FIG01960866 Peptidyl-prolyl cis-trans isomerase PpiB (EC 5.2.1.8) +FIG01960867 4-amino-6-deoxy-N-Acetyl-D-hexosaminyl-(Lipid carrier) acetyltrasferase +FIG01960868 Putative phosphatase YfbT +FIG01960871 YjbH outer membrane lipoprotein +FIG01960873 IncH1 plasmid conjugative transfer partition protein ParR +FIG01960874 Two-component response regulator VncR +FIG01960875 8-amino-7-oxononanoate synthase (EC 2.3.1.47) +FIG01960877 Ribosome modulation factor +FIG01960879 Allophanate hydrolase 2 subunit 2 (EC 3.5.1.54) +FIG01960881 Deoxyribodipyrimidine photolyase (EC 4.1.99.3) +FIG01960882 Cytochrome oxidase biogenesis protein Surf1, facilitates heme A insertion +FIG01960883 IncQ plasmid conjugative transfer protein TraP +FIG01960884 Ccs1/ResB-related putative cytochrome C-type biogenesis protein +FIG01960885 Hypothetical protein, ydbS homolog +FIG01960886 Proline dipeptidase (EC 3.4.13.9) +FIG01960887 Putative deoxyribonuclease similar to YcfH, type 2 +FIG01960888 Trimethylamine-N-oxide reductase (EC 1.6.6.9) +FIG01960889 Probable L-ascorbate-6-phosphate lactonase UlaG (EC 3.1.1.-) (L-ascorbate utilization protein G) +FIG01960890 PTS system, fructose-specific IIA component (EC 2.7.1.69) +FIG01960891 "Transketolase, C-terminal section " +FIG01960892 Transmembrane component NikQ of energizing module of nickel ECF transporter +FIG01960893 Molybdopterin biosynthesis enzyme +FIG01960894 Uncharacterized protein ImpJ/VasE +FIG01960895 CRISPR-associated protein, Cas5d family +FIG01960896 Tungsten-containing aldehyde:ferredoxin oxidoreductase (EC 1.2.7.5) +FIG01960897 Cobalt-precorrin-6 synthase, anaerobic +FIG01960900 Zn-dependent hydrolase (beta-lactamase superfamily) +FIG01960901 Selenide,water dikinase (EC 2.7.9.3) +FIG01960902 Dethiobiotin synthetase (EC 6.3.3.3) / Adenosylmethionine-8-amino-7-oxononanoate aminotransferase (EC 2.6.1.62) +FIG01960903 Metal-dependent hydrolases of the beta-lactamase superfamily I; PhnP protein +FIG01960904 Acriflavin resistance protein / Multidrug efflux system CmeDEF +FIG01960905 GTP-binding protein Obg +FIG01960906 Hcp transcriptional regulator HcpR (Crp/Fnr family) +FIG01960907 Cytochrome c-type biogenesis protein CcmC, putative heme lyase for CcmE +FIG01960908 IncH1 plasmid conjugative signal peptidase TrhP +FIG01960909 Methylthioribose-1-phosphate isomerase (EC 5.3.1.23) +FIG01960910 Methionine transporter MetT +FIG01960911 Membrane protein containing HD superfamily hydrolase domain, YQFF ortholog +FIG01960913 Erythronate-4-phosphate dehydrogenase (EC 1.1.1.290) +FIG01960914 Creatinase (EC 3.5.3.3) +FIG01960915 Uncharacterized protein similar to VCA0109 +FIG01960916 Outer membrane receptor for ferric coprogen and ferric-rhodotorulic acid +FIG01960917 D-alanyl transfer protein DltB +FIG01960921 Cytochrome c-type heme lyase subunit nrfG, nitrite reductase complex assembly +FIG01960922 Sodium-transporting ATPase subunit G +FIG01960923 Phycobilisome rod linker polypeptide, phycocyanin-associated +FIG01960925 HtrA protease/chaperone protein / Serine protease (Protease DO) (EC 3.4.21.-) +FIG01960926 ATP-dependent helicase DinG/Rad3 +FIG01960927 NAD-reducing hydrogenase subunit HoxH (EC 1.12.1.2) +FIG01960928 Various polyols ABC transporter, permease component 2 +FIG01960929 NADPH:quinone oxidoreductase 2 +FIG01960930 Homoserine O-succinyltransferase (EC 2.3.1.46) +FIG01960931 Alginate lyase precursor (EC 4.2.2.3) +FIG01960933 "Cobalamin biosynthesis protein CbiG / Cobalt- precorrin-6y C5-methyltransferase " +FIG01960937 Lipopolysaccharide core biosynthesis protein WaaP (EC 2.7.-.-), heptosyl-I-kinase +FIG01960938 Beta-phosphoglucomutase (EC 5.4.2.6) +FIG01960940 Fructose-1,6-bisphosphatase, Bacillus type (EC 3.1.3.11) +FIG01960941 Inner membrane protein forms channel for type IV secretion of T-DNA complex (VirB8) +FIG01960942 Transcriptional antiterminator with PTS regulation domain, SPy0181 ortholog +FIG01960943 Heme transporter IsdDEF, membrane component IsdD +FIG01960946 Iron compound ABC uptake transporter permease protein PiuB +FIG01960947 Fructose-bisphosphate aldolase class II (EC 4.1.2.13) +FIG01960948 DNA polymerase III delta prime subunit (EC 2.7.7.7) +FIG01960950 Tryptophanase (EC 4.1.99.1) +FIG01960952 Anaerobic glycerol-3-phosphate dehydrogenase subunit C (EC 1.1.5.3) +FIG01960953 Ku domain protein +FIG01960955 Peptide chain release factor 2 +FIG01960956 Putative formate dehydrogenase oxidoreductase protein +FIG01960957 Ortho-halobenzoate 1,2-dioxygenase alpha-ISP protein OhbB +FIG01960958 Niacin transporter NiaP +FIG01960959 Cyanophycinase (EC 3.4.15.6) +FIG01960960 Cytoplasmic protein YaiE +FIG01960961 ABC transporter membrane-spanning permease, Pep export, Vex3 +FIG01960963 CRISPR-associated RAMP Cmr4 +FIG01960964 "tRNA-specific adenosine-34 deaminase / Glycerate kinase " +FIG01960965 Fucose permease +FIG01960967 Phosphoenolpyruvate carboxykinase [ATP] (EC 4.1.1.49) +FIG01960969 Alpha-ribazole-5'-phosphate phosphatase (EC 3.1.3.73) +FIG01960970 D-alanine--poly(phosphoribitol) ligase subunit 1 (EC 6.1.1.13) +FIG01960971 Indigoidine synthase A-like protein, uncharacterized enzyme involved in pigment biosynthesis +FIG01960972 Phenylalanyl-tRNA synthetase beta chain (EC 6.1.1.20) +FIG01960973 Swarming motility protein SwrC +FIG01960974 Sucrose specific transcriptional regulator CscR, LacI family +FIG01960975 DNA polymerase III psi subunit (EC 2.7.7.7) +FIG01960977 Putative capsular polysaccharide transport protein YegH +FIG01960978 Various polyols ABC transporter, permease component 2 +FIG01960980 Phosphoribosylformylglycinamidine synthase, synthetase subunit (EC 6.3.5.3) / Phosphoribosylformylglycinamidine synthase, glutamine amidotransferase subunit (EC 6.3.5.3) +FIG01960981 Bacterial luciferase family protein YtmO, in cluster with L-cystine ABC transporter +FIG01960983 Predicted L-lactate dehydrogenase, Iron-sulfur cluster-binding subunit YkgF +FIG01960985 Tetrathionate reductase sensory transduction histidine kinase +FIG01960986 Uronate isomerase (EC 5.3.1.12) +FIG01960987 Phosphonates transport ATP-binding protein PhnK +FIG01960990 Beta-galactosidase large subunit (EC 3.2.1.23) +FIG01960991 LSU ribosomal protein L22p (L17e) / domain of unknown function +FIG01960992 Succinylglutamate desuccinylase (EC 3.5.1.96) +FIG01960993 Lipopolysaccharide heptosyltransferase I (EC 2.4.1.-) +FIG01960994 Formate hydrogenlyase subunit 3 +FIG01960996 Phosphoribosyl-ATP pyrophosphatase (EC 3.6.1.31) +FIG01960997 23S rRNA (Uracil-5-) -methyltransferase rumB (EC 2.1.1.-) +FIG01960998 UDP-N-acetylmuramate:L-alanyl-gamma-D-glutamyl-meso-diaminopimelate ligase (EC 6.3.2.-) +FIG01960999 Substrate-specific component PdxU2 of predicted pyridoxin-related ECF transporter +FIG01961000 Glucans biosynthesis protein D precursor +FIG01961001 Sulfate and thiosulfate import ATP-binding protein CysA (EC 3.6.3.25) +FIG01961003 Translation initiation factor 3 +FIG01961005 PTS system, maltose and glucose-specific IIC component (EC 2.7.1.69) / PTS system, maltose and glucose-specific IIB component (EC 2.7.1.69) +FIG01961006 Catabolite control protein A +FIG01961008 Galactose/methyl galactoside ABC transport system, D-galactose-binding periplasmic protein MglB (TC 3.A.1.2.3) +FIG01961009 RuBisCO operon transcriptional regulator CbbR +FIG01961010 Alpha-glycerophosphate oxidase (EC 1.1.3.21) +FIG01961011 Sodium/glutamate symport protein +FIG01961012 Malate synthase G (EC 2.3.3.9) +FIG01961013 Glycerol-3-phosphate ABC transporter, permease protein UgpE (TC 3.A.1.1.3) +FIG01961015 Pyruvate oxidase [ubiquinone, cytochrome] (EC 1.2.2.2) +FIG01961016 Fused spore maturation proteins A and B +FIG01961017 DinG family ATP-dependent helicase YpvA +FIG01961018 Probable glutathione S-transferase (EC 2.5.1.18), YfcF homolog +FIG01961021 Methylthiol:coenzyme M methyltransferase corrinoid protein +FIG01961023 FIG145533: Methyltransferase (EC 2.1.1.-) +FIG01961025 DnaJ-class molecular chaperone CbpA +FIG01961026 Nickel transport system permease protein NikB (TC 3.A.1.5.3) +FIG01961027 Electron transport complex protein RnfD +FIG01961028 Methionine aminotransferase, PLP-dependent +FIG01961029 Glucoamylase (EC 3.2.1.3) +FIG01961030 GTP-binding and nucleic acid-binding protein YchF +FIG01961031 Ribonuclease HI (EC 3.1.26.4) +FIG01961032 NAD-specific glutamate dehydrogenase (EC 1.4.1.2) +FIG01961034 Tetrathionate reductase sensory transduction histidine kinase +FIG01961037 Frataxin homolog CyaY, facilitates iron supply for heme A synthesis or Fe-S cluster assembly +FIG01961039 Putative N-acetylgalactosaminyl-diphosphoundecaprenol glucuronosyltransferase +FIG01961040 Serine--pyruvate aminotransferase (EC 2.6.1.51) / L-alanine:glyoxylate aminotransferase (EC 2.6.1.44) +FIG01961041 Predicted regulator of methionine metabolism, ArsR family +FIG01961046 L-serine dehydratase 1 (EC 4.3.1.17) +FIG01961047 gliding motility protein MglA +FIG01961048 3-oxoacyl-[acyl-carrier-protein] synthase, KASIII (EC 2.3.1.41) +FIG01961049 Glucose-methanol-choline (GMC) oxidoreductase:NAD binding site +FIG01961050 Inner membrane protein YqcE +FIG01961051 Spermidine N1-acetyltransferase (EC 2.3.1.57) +FIG01961053 Prephenate dehydratase (EC 4.2.1.51) +FIG01961054 Gamma-glutamyl-putrescine synthetase (EC 6.3.1.11) +FIG01961055 Tetraacyldisaccharide 4'-kinase (EC 2.7.1.130) / UPF0434 protein YcaR +FIG01961056 Sodium-transporting ATPase subunit A +FIG01961057 Outer membrane TonB-dependent transducer VreA of trans-envelope signaling system +FIG01961058 Mg(2+) transport ATPase, P-type (EC 3.6.3.2) +FIG01961060 Acetaldehyde dehydrogenase, acetylating, (EC 1.2.1.10) in gene cluster for degradation of phenols, cresols, catechol +FIG01961063 Phosphoglucosamine mutase (EC 5.4.2.10) / Phosphomannomutase (EC 5.4.2.8) +FIG01961064 GDP-L-fucose synthetase (EC 1.1.1.271) +FIG01961065 High-affinity gluconate transporter GntT +FIG01961066 Glyoxylate reductase (EC 1.1.1.79) / Glyoxylate reductase (EC 1.1.1.26) / Hydroxypyruvate reductase (EC 1.1.1.81); 2-ketoaldonate reductase, broad specificity (EC 1.1.1.215) (EC 1.1.1.-) +FIG01961067 Putative thiol:disulfide oxidoreductase, nitrite reductase complex assembly +FIG01961068 3-oxoacyl-[acyl-carrier-protein] synthase, KASIII (EC 2.3.1.41) +FIG01961070 Very-short-patch mismatch repair endonuclease (G-T specific) +FIG01961071 L-allo-threonine aldolase (EC 2.1.2.1) +FIG01961072 Uncharacterized protein ImpH/VasB +FIG01961073 Ribosomal RNA small subunit methyltransferase D (EC 2.1.1.-) +FIG01961075 Translation elongation factor P-related protein +FIG01961076 Indolepyruvate oxidoreductase subunit IorA (EC 1.2.7.8) +FIG01961078 Serine protein kinase (prkA protein), P-loop containing +FIG01961079 Cation efflux system protein CusC precursor +FIG01961081 Rod shape-determining protein RodA +FIG01961082 POSSIBLE LINOLEOYL-CoA DESATURASE (DELTA(6)-DESATURASE) +FIG01961083 L-idonate 5-dehydrogenase (EC 1.1.1.264) +FIG01961086 Family 13 glycosyl hydrolase, row 724 +FIG01961087 Functional role page for TorCAD operon transcriptional regulatory protein TorR +FIG01961088 RND efflux system, outer membrane lipoprotein CmeC +FIG01961089 UDP-4-amino-4-deoxy-L-arabinose--oxoglutarate aminotransferase (EC 2.6.1.-) +FIG01961090 "Diaminopimelate decarboxylase " +FIG01961092 Glutamate Aspartate transport ATP-binding protein GltL (TC 3.A.1.3.4) +FIG01961093 Soluble pyridine nucleotide transhydrogenase (EC 1.6.1.1) +FIG01961094 Cytochrome c4 +FIG01961095 N-acetylmuramic acid 6-phosphate etherase +FIG01961097 Toluene-4-monooxygenase, subunit TmoA beta +FIG01961098 3-hydroxybutyryl-CoA dehydrogenase (EC 1.1.1.157) +FIG01961099 Heavy metal-(Cd/Co/Hg/Pb/Zn)-translocating P-type ATPase:Heavy metal translocating P-type ATPase +FIG01961100 Teichoic acid translocation permease protein TagG +FIG01961101 Hemoprotein HemQ, essential component of heme biosynthetic pathway in Gram-positive bacteria +FIG01961102 (R)-citramalate synthase (EC 2.3.1.182) +FIG01961103 Trehalose-regulated TonB-dependent outer membrane receptor +FIG01961104 Sarcosine oxidase gamma subunit (EC 1.5.3.1) +FIG01961106 DNA replication protein DnaC +FIG01961107 Glyoxylate reductase (EC 1.1.1.79) / Glyoxylate reductase (EC 1.1.1.26) / Hydroxypyruvate reductase (EC 1.1.1.81) +FIG01961108 HtrA protease/chaperone protein +FIG01961109 3-isopropylmalate dehydrogenase (EC 1.1.1.85) +FIG01961111 Aminodeoxychorismate lyase (EC 4.1.3.38) +FIG01961112 Tetrathionate reductase subunit C +FIG01961116 IncH1 plasmid conjugative transfer protein HtdF +FIG01961117 Malonate transporter, MadM subunit +FIG01961120 Substrate-specific component QueT (COG4708) of predicted queuosine-regulated ECF transporter +FIG01961122 FIG003879: Predicted amidohydrolase +FIG01961124 TldD protein, part of TldE/TldD proteolytic complex +FIG01961125 Lipid A export ATP-binding/permease protein MsbA (EC 3.6.3.25) +FIG01961126 Siroheme synthase / Precorrin-2 oxidase (EC 1.3.1.76) +FIG01961127 Acriflavin resistance protein / Multidrug efflux system CmeDEF +FIG01961128 PTS system, galactosamine-specific IID component (EC 2.7.1.69) +FIG01961129 Tyrosyl-tRNA synthetase (EC 6.1.1.1) +FIG01961130 Phosphoribosylaminoimidazole carboxylase ATPase subunit (EC 4.1.1.21) +FIG01961131 Formiminoglutamase (EC 3.5.3.8) +FIG01961132 Putative membrane protein Q2 colocalized with Q +FIG01961133 FKBP-type peptidyl-prolyl cis-trans isomerase FklB (EC 5.2.1.8) +FIG01961135 2-keto-4-pentenoate hydratase (EC 4.2.1.-) +FIG01961136 UDP-3-O-[3-hydroxymyristoyl] N-acetylglucosamine deacetylase (EC 3.5.1.-) +FIG01961137 Phosphoglucosamine mutase (EC 5.4.2.10) / Phosphomannomutase (EC 5.4.2.8) +FIG01961138 D-alanine aminotransferase (EC 2.6.1.21) +FIG01961139 Sulfite reductase alpha subunit (EC 1.8.99.1) +FIG01961140 Non-phosphorylating glyceraldehyde-3-phosphate dehydrogenase (NADP) (EC 1.2.1.9) +FIG01961141 Phosphate regulon sensor protein PhoR (SphS) (EC 2.7.13.3); Sensor-like histidine kinase senX3 (EC 2.7.13.3) +FIG01961143 ADP-heptose--lipooligosaccharide heptosyltransferase II (EC 2.4.1.-) +FIG01961145 Iron compound ABC uptake transporter ATP-binding protein +FIG01961146 Acetoacetyl-CoA synthetase (EC 6.2.1.16) / Long-chain-fatty-acid--CoA ligase (EC 6.2.1.3) +FIG01961147 Peptide methionine sulfoxide reductase MsrA (EC 1.8.4.11) / Peptide methionine sulfoxide reductase MsrB (EC 1.8.4.12) +FIG01961149 [Protein-PII] uridylyltransferase (EC 2.7.7.59) +FIG01961150 Electron transfer flavoprotein, beta subunit +FIG01961152 NADH oxidoreductase hcr (EC 1.-.-.-) +FIG01961153 2,3-bisphosphoglycerate-independent phosphoglycerate mutase (EC 5.4.2.1) +FIG01961155 Lipoate synthase, cyanobacterial paralog +FIG01961156 Propionyl-CoA carboxylase carboxyl transferase subunit (EC 6.4.1.3) +FIG01961157 Putative predicted metal-dependent hydrolase +FIG01961160 Para-aminobenzoate synthase, amidotransferase component (EC 2.6.1.85) +FIG01961161 Peptidyl-prolyl cis-trans isomerase PpiA precursor (EC 5.2.1.8) +FIG01961163 Cobalt-precorrin-2 C20-methyltransferase (EC 2.1.1.130) +FIG01961164 LSU ribosomal protein L9p +FIG01961166 NAD kinase (EC 2.7.1.23) +FIG01961167 3-phenylpropionate dioxygenase, alpha subunit (EC 1.14.12.19) +FIG01961168 Pectate lyase precursor (EC 4.2.2.2) +FIG01961169 Phage baseplate +FIG01961170 Aconitate hydratase (EC 4.2.1.3) @ 2-methylisocitrate dehydratase (EC 4.2.1.99) +FIG01961171 Hexose phosphate transport protein UhpT +FIG01961173 LysR family transcriptional regulator YeiE +FIG01961174 Branched-chain amino acid aminotransferase (EC 2.6.1.42) +FIG01961179 Translation elongation factor P-related protein +FIG01961180 Uroporphyrinogen-III methyltransferase (EC 2.1.1.107) +FIG01961182 ATP-binding protein PhnN +FIG01961183 Menaquinone via futalosine polyprenyltransferase (MenA homolog), Nitrosopumilus/Caldivirga type +FIG01961185 Ribosomal RNA small subunit methyltransferase B (EC 2.1.1.-) +FIG01961186 D-glycerate transporter (predicted) +FIG01961187 5-carboxymethyl-2-hydroxymuconate semialdehyde dehydrogenase (EC 1.2.1.60) +FIG01961189 3'-to-5' exoribonuclease RNase R +FIG01961190 5-formyltetrahydrofolate cyclo-ligase (EC 6.3.3.2) +FIG01961194 Rrf2 family transcriptional regulator, group III +FIG01961195 Tricarboxylate transport protein TctC +FIG01961196 Bundle-forming pilus protein BfpU +FIG01961197 POTASSIUM/PROTON ANTIPORTER ROSB +FIG01961198 soluble [2Fe-2S] ferredoxin +FIG01961199 Aquaporin Z +FIG01961200 ATP-dependent DNA helicase RecG (EC 3.6.1.-) +FIG01961201 Potassium channel protein 1 (MjK1) +FIG01961202 Putative heat shock protein YegD +FIG01961203 Glutamate N-acetyltransferase (EC 2.3.1.35) / N-acetylglutamate synthase (EC 2.3.1.1) +FIG01961206 Glycine/sarcosine/betaine reductase component C chain 2 +FIG01961207 Dehydrosqualene desaturase (EC 1.14.99.-) (Diapophytoene desaturase) (4,4'-diapophytoene desaturase) +FIG01961208 FIG003620: Proteophosphoglycan precursor (Fragment) +FIG01961210 DnaJ-class molecular chaperone CbpA +FIG01961211 1,3-propanediol dehydrogenase (EC 1.1.1.202) +FIG01961212 Cell surface receptor IsdB for hemoglobin and hemoglobin-haptoglobin complexes +FIG01961213 Predicted amidohydrolase RutB in novel pyrimidine catabolism pathway +FIG01961214 Predicted L-rhamnose ABC transporter, ATP-binding component +FIG01961216 Biosynthetic Aromatic amino acid aminotransferase alpha (EC 2.6.1.57) @ Aspartate aminotransferase (EC 2.6.1.1) +FIG01961217 Alpha-acetolactate decarboxylase ; interrupted +FIG01961219 Possible pyrimidine permease in reductive pathway +FIG01961220 NADH peroxidase (EC 1.11.1.1) +FIG01961221 Glutamyl aminopeptidase (EC 3.4.11.7); Deblocking aminopeptidase +FIG01961223 diglucosyldiacylglycerol synthase (LTA membrane anchor synthesis) +FIG01961225 Cell division protein FtsI [Peptidoglycan synthetase] (EC 2.4.1.129) / Transpeptidase, Penicillin binding protein transpeptidase domain +FIG01961228 Flagellar synthesis regulator FleN +FIG01961229 Exoenzymes regulatory protein AepA precursor +FIG01961231 Methylglutaconyl-CoA hydratase (EC 4.2.1.18) +FIG01961232 Predicted Lactate-responsive regulator, LysR family +FIG01961234 Butyrate-acetoacetate CoA-transferase subunit B (EC 2.8.3.9) +FIG01961235 Outer membrane stress sensor protease DegS +FIG01961237 Segregation and condensation protein B +FIG01961240 Isoleucyl-tRNA synthetase (EC 6.1.1.5) +FIG01961241 S-adenosylmethionine synthetase (EC 2.5.1.6) +FIG01961245 Possible hypoxanthine oxidase XdhD (EC 1.-.-.-) +FIG01961246 Thiol:disulfide oxidoreductase related to ResA +FIG01961247 General secretion pathway protein K +FIG01961248 GTP-binding protein HflX +FIG01961249 Uroporphyrinogen-III synthase (EC 4.2.1.75) +FIG01961250 Putative N-acetylgalactosaminyl-diphosphoundecaprenol glucuronosyltransferase +FIG01961251 Aconitate hydratase (EC 4.2.1.3) @ 2-methylisocitrate dehydratase (EC 4.2.1.99) +FIG01961252 DNA helicase, SNF2/RAD54 family / Carboxy-terminal intein-mediated trans-splice +FIG01961253 CTP synthase (EC 6.3.4.2) +FIG01961254 Gamma-glutamyl-putrescine synthetase (EC 6.3.1.11) +FIG01961255 ABC-type probable sulfate transporter, periplasmic binding protein +FIG01961256 Substrate-specific component ThiT of thiamin ECF transporter +FIG01961258 Tetrathionate reductase subunit C +FIG01961259 Lysyl-tRNA synthetase (class I) (EC 6.1.1.6) +FIG01961260 V-type ATP synthase subunit B (EC 3.6.3.14) +FIG01961261 Fe-bacillibactin uptake system FeuA, Fe-bacillibactin binding +FIG01961262 Phosphoribosylglycinamide formyltransferase 2 (EC 2.1.2.-) +FIG01961263 Ccs1/ResB-related putative cytochrome C-type biogenesis protein +FIG01961264 Putrescine carbamoyltransferase (EC 2.1.3.6) +FIG01961266 Galactose operon repressor, GalR-LacI family of transcriptional regulators +FIG01961267 PTS system, N-acetylglucosamine-specific IIB component (EC 2.7.1.69) / PTS system, N-acetylglucosamine-specific IIC component +FIG01961268 Formaldehyde activating enzyme +FIG01961270 Inosose dehydratase (EC 4.2.1.44) +FIG01961271 FtsK/SpoIIIE family protein Rv3871, component of ESX-1 secretion system +FIG01961272 Acyl-CoA dehydrogenase; probable dibenzothiophene desulfurization enzyme +FIG01961273 Osmotically activated L-carnitine/choline ABC transporter, substrate-binding protein OpuCC +FIG01961274 Ferric enterobactin uptake protein FepE +FIG01961275 Nucleoside 5-triphosphatase RdgB (dHAPTP, dITP, XTP-specific) (EC 3.6.1.15) +FIG01961277 Multidrug-efflux transporter, major facilitator superfamily (MFS) (TC 2.A.1); Efflux pump Lde +FIG01961279 Two-component response regulator SA14-24 +FIG01961280 GDP-mannose 4,6-dehydratase (EC 4.2.1.47) / GDP-L-fucose synthetase (EC 1.1.1.271) +FIG01961281 Hypothetical SAR0385 homolog in superantigen-encoding pathogenicity islands SaPI +FIG01961282 Beta-ureidopropionase (EC 3.5.1.6) +FIG01961283 Von Willebrand factor type A domain protein, associated with Flp pilus assembly +FIG01961285 Urea ABC transporter, substrate binding protein UrtA +FIG01961286 NAD-reducing hydrogenase subunit HoxF (EC 1.12.1.2) +FIG01961287 V-type ATP synthase subunit I (EC 3.6.3.14) +FIG01961288 Phosphoglycerate mutase family 1 +FIG01961289 Formyltetrahydrofolate deformylase (EC 3.5.1.10) +FIG01961290 Peptidyl-tRNA hydrolase (EC 3.1.1.29) +FIG01961291 Cysteine desulfurase (EC 2.8.1.7), SufS subfamily +FIG01961292 Protease III precursor (EC 3.4.24.55) +FIG01961295 tmRNA-binding protein SmpB +FIG01961296 Na(+) H(+) antiporter subunit D +FIG01961297 2-dehydro-3-deoxygalactonokinase (EC 2.7.1.58) +FIG01961299 Malonate decarboxylase alpha subunit +FIG01961301 Polyferredoxin NapH (periplasmic nitrate reductase) +FIG01961302 Gamma-hemolysin component A +FIG01961303 PurR: transcription regulator associated with purine metabolism +FIG01961304 Cobalt-precorrin-2 C20-methyltransferase (EC 2.1.1.130) / Cobalt-precorrin-3b C17-methyltransferase +FIG01961305 Cyclopropane-fatty-acyl-phospholipid synthase (EC 2.1.1.79) +FIG01961308 L-idonate 5-dehydrogenase (EC 1.1.1.264) +FIG01961309 Urea ABC transporter, ATPase protein UrtE +FIG01961310 Serine--glyoxylate aminotransferase (EC 2.6.1.45) +FIG01961311 Malto-oligosyltrehalose trehalohydrolase (EC 3.2.1.141) +FIG01961312 Acetyl-CoA:acetoacetyl-CoA transferase, beta subunit (EC 2.8.3.8) +FIG01961313 Predicted Lactate-responsive regulator, LysR family +FIG01961314 "Phage lysin " +FIG01961317 IncH1 plasmid conjugative transfer protein TrhZ +FIG01961318 Glutamate-ammonia-ligase adenylyltransferase (EC 2.7.7.42) +FIG01961321 Sensor histidine kinase VraS +FIG01961322 2,3-butanediol dehydrogenase, S-alcohol forming, (S)-acetoin-specific (EC 1.1.1.76) +FIG01961324 FIG005069: Hypothetical protein +FIG01961325 Glycine betaine ABC transport system permease protein +FIG01961328 Substrate-specific component ThiW of predicted thiazole ECF transporter +FIG01961329 Anthranilate synthase, aminase component (EC 4.1.3.27) / Anthranilate synthase, amidotransferase component (EC 4.1.3.27) +FIG01961330 Streptolysin S export transmembrane permease (SagH) +FIG01961332 Glutamyl-tRNA reductase (EC 1.2.1.70) +FIG01961333 General secretion pathway protein G / Type II secretion envelope pseudopilin (PulG,guides folded protein to PulD in outer membrane) +FIG01961334 GTP-binding protein EngA +FIG01961337 Putative deoxyribonuclease YcfH +FIG01961338 SSU rRNA (adenine(1518)-N(6)/adenine(1519)-N(6))-dimethyltransferase (EC 2.1.1.182) +FIG01961339 Putative oxidoreductase ferredoxin-type protein, clusters with CPO +FIG01961340 D-allose-6-phosphate isomerase (EC 5.3.1.-) / Ribose 5-phosphate isomerase B (EC 5.3.1.6) +FIG01961343 Iron binding protein IscA for iron-sulfur cluster assembly +FIG01961345 GTP pyrophosphokinase (EC 2.7.6.5), (p)ppGpp synthetase I +FIG01961346 Putative lipoprotein SAV1865 +FIG01961348 GDP-mannose mannosyl hydrolase (EC 3.6.1.-) +FIG01961349 Cell division protein FtsW / Stage V sporulation protein E +FIG01961350 Ribulosamine/erythrulosamine 3-kinase potentially involved in protein deglycation +FIG01961351 High-affinity choline uptake protein BetT +FIG01961352 FIG006972: hypothetical protein +FIG01961353 Predicted alternative glutathione synthetase (EC 6.3.2.3) +FIG01961354 SSU ribosomal protein S4p (S9e) +FIG01961356 Heme ABC transporter, ATPase component HmuV +FIG01961359 Phosphoenolpyruvate carboxykinase [ATP] (EC 4.1.1.49) +FIG01961360 Hypothetical protein GlcG in glycolate utilization operon +FIG01961361 Proline dehydrogenase (EC 1.5.99.8) (Proline oxidase) +FIG01961363 Adenosylmethionine-8-amino-7-oxononanoate aminotransferase (EC 2.6.1.62) +FIG01961364 Sodium-transporting ATPase subunit I +FIG01961365 poly(beta-D-mannuronate) lyase (EC 4.2.2.3) +FIG01961366 Nitrogenase (molybdenum-iron) reductase and maturation protein NifH +FIG01961367 Potassium uptake protein TrkH +FIG01961368 Methylthioribose-1-phosphate isomerase (EC 5.3.1.23) +FIG01961369 Flagellar biosynthesis protein FlgN +FIG01961370 Choline ABC transporter permease protein +FIG01961371 Aconitate hydratase (EC 4.2.1.3) @ 2-methylisocitrate dehydratase (EC 4.2.1.99) +FIG01961372 Two-component system histidine kinase DccS +FIG01961373 Type III secretion inner membrane channel protein (LcrD,HrcV,EscV,SsaV) +FIG01961375 2-deoxy-D-gluconate 3-dehydrogenase (EC 1.1.1.125) +FIG01961376 Putative periplasmic phosphate-binding protein PstS (Halobacteriales type) +FIG01961378 Ferredoxin / Ferredoxin--NADP(+) reductase, actinobacterial (eukaryote-like) type (EC 1.18.1.2) +FIG01961379 2-hydroxy-3-oxopropionate reductase (EC 1.1.1.60) +FIG01961381 Carbon starvation protein A paralog +FIG01961383 Pyruvate formate-lyase activating enzyme (EC 1.97.1.4) +FIG01961384 Hypothetical radical SAM family enzyme in heat shock gene cluster, similarity with CPO of BS HemN-type +FIG01961386 Sodium-transporting ATPase subunit B +FIG01961387 Hydrolase, alpha/beta fold family functionally coupled to Phosphoribulokinase +FIG01961389 NADH-reducing hydrogenase maturation factor +FIG01961390 C-terminal binding protein 2 +FIG01961392 Glucosamine--fructose-6-phosphate aminotransferase [isomerizing] (EC 2.6.1.16) +FIG01961393 Glutathione-regulated potassium-efflux system protein KefC +FIG01961396 Heme ABC transporter, permease protein HmuU +FIG01961397 Anaerobic glycerol-3-phosphate dehydrogenase subunit B (EC 1.1.5.3) +FIG01961398 Anaerobic sulfite reductase subunit C (EC 1.8.1.-) +FIG01961399 Inosine-5'-monophosphate dehydrogenase (EC 1.1.1.205) +FIG01961402 Phenylalanyl-tRNA synthetase alpha chain (EC 6.1.1.20) +FIG01961403 Copper-sensing two-component system response regulator CpxR +FIG01961406 Xylonate dehydratase (EC 4.2.1.82) +FIG01961407 Formate hydrogenlyase subunit 5 +FIG01961408 secreted alkaline phosphatase +FIG01961414 ATP-dependent DNA helicase Rep +FIG01961416 Nitrite transporter from formate/nitrite family +FIG01961417 Manganese superoxide dismutase (EC 1.15.1.1) +FIG01961418 Glutamine synthetase, clostridia type (EC 6.3.1.2) +FIG01961420 Proteasome subunit alpha (EC 3.4.25.1), bacterial +FIG01961421 SgrR, sugar-phosphate stress, transcriptional activator of SgrS small RNA +FIG01961422 Pantothenate kinase type III, CoaX-like (EC 2.7.1.33) +FIG01961423 Sulfate transporter, CysZ-type +FIG01961424 UDP-N-acetylglucosamine--N-acetylmuramyl-(pentapeptide) pyrophosphoryl-undecaprenol N-acetylglucosamine transferase (EC 2.4.1.227) +FIG01961426 Methylmalonate-semialdehyde dehydrogenase [inositol] (EC 1.2.1.27) +FIG01961428 Exodeoxyribonuclease V alpha chain (EC 3.1.11.5) +FIG01961429 LSU ribosomal protein L44e +FIG01961430 Creatinine amidohydrolase (EC 3.5.2.10) +FIG01961432 Acetylglutamate kinase (EC 2.7.2.8) +FIG01961433 LSU ribosomal protein L28p +FIG01961434 Capsular polysaccharide glycosyltransferase biosynthesis protein WcbB +FIG01961435 Transposase (maltose area) +FIG01961436 "DNA-directed RNA polymerase subunit A " +FIG01961437 ABC transporter involved in cytochrome c biogenesis, ATPase component CcmA +FIG01961438 Conjugative transfer protein TrbJ +FIG01961439 NADPH:quinone oxidoreductase 2 +FIG01961440 Putative cytochrome c biogenesis factor, archaeal +FIG01961442 Tricarboxylate transport membrane protein TctA +FIG01961443 NAD-specific glutamate dehydrogenase (EC 1.4.1.2), large form +FIG01961444 Enoyl-CoA hydratase [branched-chain amino acid degradation] (EC 4.2.1.17) +FIG01961445 Nitrous oxide reductase maturation protein, outer-membrane lipoprotein NosL +FIG01961446 Alanyl-tRNA synthetase (EC 6.1.1.7) +FIG01961447 ATP-dependent protease HslV (EC 3.4.25.-) +FIG01961448 Valyl-tRNA synthetase (EC 6.1.1.9) +FIG01961449 Uncharacterized protein ImpH/VasB +FIG01961450 DNA topoisomerase I (EC 5.99.1.2) +FIG01961451 Cystathionine gamma-lyase (EC 4.4.1.1) +FIG01961454 Aspartyl-tRNA(Asn) amidotransferase subunit A (EC 6.3.5.6) / Glutamyl-tRNA(Gln) amidotransferase subunit A +FIG01961460 Ferric iron ABC transporter, ATP-binding protein +FIG01961465 Metal-dependent hydrolase involved in phosphonate metabolism +FIG01961467 Nitrate reductase cytochrome c550-type subunit +FIG01961468 Nitric oxide reductase activation protein NorD +FIG01961470 Glycolate dehydrogenase (EC 1.1.99.14), subunit GlcD +FIG01961472 Selenophosphate-dependent tRNA 2-selenouridine synthase +FIG01961474 AscBF operon repressor +FIG01961475 Glycine dehydrogenase [decarboxylating] (glycine cleavage system P protein) (EC 1.4.4.2) +FIG01961476 Predicted 4-hydroxyproline dipeptidase +FIG01961477 RNA binding protein, contains ribosomal protein S1 domain +FIG01961479 L-arabinose isomerase (EC 5.3.1.4) +FIG01961480 FIG136845: Rhodanese-related sulfurtransferase +FIG01961481 Glycine cleavage system transcriptional activator GcvA +FIG01961482 5-methylthioribose kinase (EC 2.7.1.100) +FIG01961483 D-ribulokinase (EC 2.7.1.47) +FIG01961485 Topoisomerase IV subunit B (EC 5.99.1.-) +FIG01961486 tRNA 5-methylaminomethyl-2-thiouridine synthase TusC +FIG01961487 Alanyl-tRNA synthetase (EC 6.1.1.7) +FIG01961489 D-amino-acid oxidase (EC 1.4.3.3) +FIG01961492 2-Keto-D-gluconate dehydrogenase (EC 1.1.99.4), membrane-bound, flavoprotein +FIG01961493 Ubiquinone/menaquinone biosynthesis methyltransferase UbiE (EC 2.1.1.-) +FIG01961494 Cell division protein FtsI [Peptidoglycan synthetase] (EC 2.4.1.129) / Stage V sporulation protein D (Sporulation-specific penicillin-binding protein) +FIG01961495 Indolepyruvate ferredoxin oxidoreductase, alpha and beta subunits +FIG01961496 2-Keto-D-gluconate dehydrogenase (EC 1.1.99.4), membrane-bound, flavoprotein +FIG01961497 Copper-sensing two-component system response regulator CusR +FIG01961499 Nucleoside-diphosphate-sugar epimerases +FIG01961503 Arginine decarboxylase (EC 4.1.1.19) / Lysine decarboxylase (EC 4.1.1.18) +FIG01961504 Beta-galactosidase small subunit (EC 3.2.1.23) +FIG01961507 Chromosome partition protein MukE +FIG01961510 Phosphoribosylformimino-5-aminoimidazole carboxamide ribotide isomerase (EC 5.3.1.16) / Acting phosphoribosylanthranilate isomerase (EC 5.3.1.24) +FIG01961512 Tagatose 1,6-bisphosphate aldolase (EC 4.1.2.40) +FIG01961513 Pyruvate dehydrogenase E1 component (EC 1.2.4.1) +FIG01961514 Excinuclease ABC subunit A +FIG01961516 Glutamate synthase [NADPH] putative GlxC chain (EC 1.4.1.13) +FIG01961517 Duplicated ATPase component BL0693 of energizing module of predicted ECF transporter +FIG01961521 Energy conserving hydrogenase Eha transmembrane protein K +FIG01961522 "D-erythrose-4-phosphate dehydrogenase " +FIG01961524 Radical SAM family protein HutW, similar to coproporphyrinogen III oxidase, oxygen-independent, associated with heme uptake +FIG01961525 4'-phosphopantetheinyl transferase (EC 2.7.8.-) [enterobactin] siderophore +FIG01961526 Hydroxylamine reductase (EC 1.7.-.-) +FIG01961529 Sensor histidine kinase colocalized with HrtAB transporter +FIG01961530 Aspartyl-tRNA(Asn) amidotransferase subunit A (EC 6.3.5.6) +FIG01961532 Ethanolamine utilization protein similar to PduV +FIG01961535 N-formylglutamate deformylase (EC 3.5.1.68) +FIG01961536 Malate synthase G (EC 2.3.3.9) +FIG01961537 UDP-N-acetylmuramate--alanine ligase (EC 6.3.2.8) +FIG01961538 Transcriptional regulator, PadR family / Regulator of K+ conductance +FIG01961539 Phosphoribosylanthranilate isomerase (EC 5.3.1.24) +FIG01961543 YciL protein +FIG01961546 DNA repair protein RadC +FIG01961547 Dehydrosqualene desaturase (EC 1.14.99.-) (Diapophytoene desaturase) (4,4'-diapophytoene desaturase) +FIG01961548 Pectinesterase (EC 3.1.1.11) +FIG01961550 6-phosphogluconolactonase (EC 3.1.1.31), eukaryotic type / O-methyltransferase family 3 +FIG01961551 Glycine cleavage system transcriptional activator GcvA +FIG01961552 Phosphopentomutase (EC 5.4.2.7) +FIG01961553 DNA-directed RNA polymerase alpha subunit (EC 2.7.7.6) +FIG01961555 Gluconate utilization system Gnt-I transcriptional repressor +FIG01961556 Phosphoenolpyruvate synthase @ intein- containing +FIG01961557 Putative capsular polysaccharide transport protein YegH +FIG01961559 Tryptophanase (EC 4.1.99.1) +FIG01961560 NADH ubiquinone oxidoreductase chain A (EC 1.6.5.3) +FIG01961561 Nitrilotriacetate monooxygenase component B (EC 1.14.13.-) / Transcriptional regulator, IclR family +FIG01961562 Substrate-specific component glr2052 of predicted ECF transporter +FIG01961564 FIG065221: Holliday junction DNA helicase +FIG01961568 RND efflux system, membrane fusion protein CmeA +FIG01961569 Protein YhjJ, putative peptidase +FIG01961570 Hypothetical protein pVir0016 +FIG01961572 Heme ABC type transporter HtsABC, heme-binding protein +FIG01961573 Putative formate dehydrogenase oxidoreductase protein +FIG01961578 Stringent starvation protein A +FIG01961583 Anaerobic sulfite reductase subunit B +FIG01961584 D-erythrose-4-phosphate dehydrogenase (EC 1.2.1.72) +FIG01961585 (2E,6E)-farnesyl diphosphate synthase (EC 2.5.1.10) +FIG01961586 L-idonate 5-dehydrogenase (EC 1.1.1.264) +FIG01961587 Phage EaF protein +FIG01961588 ATP synthase gamma chain (EC 3.6.3.14) +FIG01961590 Sulfate permease, Trk-type +FIG01961593 tRNA (Uracil54-C5-)-methyltransferase (EC 2.1.1.35) +FIG01961594 AroM protein +FIG01961595 Low molecular weight protein-tyrosine-phosphatase Wzb (EC 3.1.3.48) +FIG01961599 Glycerol-3-phosphate ABC transporter, periplasmic glycerol-3-phosphate-binding protein (TC 3.A.1.1.3) +FIG01961600 Negative regulator of phenolic acid metabolism PadR +FIG01961601 GTP-binding protein Obg +FIG01961608 Phage major tail protein +FIG01961609 3-dehydroquinate dehydratase I (EC 4.2.1.10) / Shikimate kinase I (EC 2.7.1.71) +FIG01961615 Osmotically activated L-carnitine/choline ABC transporter, permease protein OpuCD +FIG01961617 PTS system, mannose-specific IIC component +FIG01961618 Acetyl-CoA acetyltransferase (EC 2.3.1.9) @ Beta-ketoadipyl CoA thiolase (EC 2.3.1.-) +FIG01961619 Transcriptional regulatory protein RtcR +FIG01961620 NAD(P) transhydrogenase alpha subunit (EC 1.6.1.2) +FIG01961621 Cold shock protein CspE +FIG01961622 GTP-binding protein EngA +FIG01961623 Uncharacterized protein with LysM domain, COG1652 +FIG01961624 POTASSIUM/PROTON ANTIPORTER ROSB +FIG01961626 Cell surface receptor IsdB for hemoglobin and hemoglobin-haptoglobin complexes +FIG01961627 L-arabinose transport ATP-binding protein AraG (TC 3.A.1.2.2) +FIG01961629 Agmatinase (EC 3.5.3.11) +FIG01961631 Uronate isomerase (EC 5.3.1.12) +FIG01961634 DNA repair exonuclease family protein YhaO +FIG01961635 Glutamine synthetase type II, eukaryotic (EC 6.3.1.2) +FIG01961636 Xanthine-guanine phosphoribosyltransferase (EC 2.4.2.22) +FIG01961638 Thymidylate synthase ThyX (EC 2.1.1.-) +FIG01961639 Cytosine permease +FIG01961641 Hypothetical transcriptional regulator YqhC +FIG01961642 UDP-galactopyranose mutase (EC 5.4.99.9) +FIG01961643 "Alkanesulfonate monooxygenase " +FIG01961645 Flp pilus assembly protein TadB +FIG01961648 Lipoprotein releasing system transmembrane protein LolE +FIG01961649 Various polyols ABC transporter, periplasmic substrate-binding protein +FIG01961650 1-pyrroline-4-hydroxy-2-carboxylate deaminase (EC 3.5.4.22) +FIG01961651 Flagellar hook protein FlgE +FIG01961652 Transcriptional regulator ArcR essential for anaerobic expression of the ADI pathway, Crp/Fnr family +FIG01961654 Cell division protein ZipA +FIG01961658 Iron compound ABC uptake transporter permease protein +FIG01961659 Two-component sensor histidine kinase BceS +FIG01961660 Sodium-transporting ATPase subunit D +FIG01961662 SSU ribosomal protein S21p +FIG01961663 Flagellar basal-body rod protein FlgB +FIG01961664 Methionine transporter MetT +FIG01961666 15,16-dihydrobiliverdin:ferredoxin oxidoreductase PebA (EC 1.3.7.2) +FIG01961668 Argininosuccinate synthase (EC 6.3.4.5) +FIG01961669 Cell wall surface anchor family protein, LPXTG motif +FIG01961670 Beta-ureidopropionase (EC 3.5.1.6) / N-formylglutamate deformylase (EC 3.5.1.68) [alternative form] +FIG01961672 Cytochrome oxidase biogenesis protein Surf1, facilitates heme A insertion +FIG01961674 Probable low-affinity inorganic phosphate transporter +FIG01961678 Carboxynorspermidine dehydrogenase, putative (EC 1.1.1.-) +FIG01961679 3-deoxy-manno-octulosonate cytidylyltransferase (EC 2.7.7.38) +FIG01961681 Type III secretion bridge between inner and outermembrane lipoprotein (YscJ,HrcJ,EscJ, PscJ) +FIG01961683 Chitinase (EC 3.2.1.14) +FIG01961684 Uncharacterized protein YtfM precursor +FIG01961685 Triphosphoribosyl-dephospho-CoA synthetase (EC 2.7.8.25) +FIG01961686 PhnJ protein +FIG01961687 UPF0234 protein YajQ +FIG01961688 3-keto-L-gulonate 6-phosphate decarboxylase +FIG01961690 Hydroxymethylglutaryl-CoA synthase (EC 2.3.3.10) +FIG01961693 Acetyl-coenzyme A carboxyl transferase beta chain (EC 6.4.1.2) +FIG01961694 N-acetylneuraminic acid outer membrane channel protein NanC +FIG01961695 Benzoate 1,2-dioxygenase (EC 1.14.12.10) +FIG01961700 Hcp transcriptional regulator HcpR (Crp/Fnr family) +FIG01961703 Orotate phosphoribosyltransferase (EC 2.4.2.10) +FIG01961708 Multiple antibiotic resistance protein MarC +FIG01961709 Deblocking aminopeptidase (EC 3.4.11.-) +FIG01961710 Stringent starvation protein B +FIG01961711 Pup ligase PafA, possible component of postulated heterodimer PafA-PafA' +FIG01961712 Iron compound ABC uptake transporter permease protein PiuB +FIG01961713 L-aspartate oxidase (EC 1.4.3.16) +FIG01961714 Xylose ABC transporter, periplasmic xylose-binding protein XylF +FIG01961715 TRAP transporter solute receptor, TAXI family precursor +FIG01961716 Phosphogluconate dehydratase (EC 4.2.1.12) +FIG01961717 Type IV fimbrial biogenesis protein PilV +FIG01961718 salicylate esterase +FIG01961719 Energy-conserving hydrogenase (ferredoxin), subunit E +FIG01961721 Ribonucleotide reductase of class Ia (aerobic), beta subunit (EC 1.17.4.1) +FIG01961722 Hypothetical protein, ydbT homolog +FIG01961723 Phosphonate ABC transporter phosphate-binding periplasmic component (TC 3.A.1.9.1) +FIG01961726 Transcriptional activator of maltose regulon, MalT +FIG01961727 FIG001621: Zinc protease +FIG01961728 Cysteine desulfurase (EC 2.8.1.7), IscS subfamily +FIG01961731 Putrescine ABC transporter putrescine-binding protein PotF (TC 3.A.1.11.2) +FIG01961732 Guanine deaminase (EC 3.5.4.3); Hydroxydechloroatrazine ethylaminohydrolase (EC 3.5.99.3) +FIG01961735 1-phosphofructokinase (EC 2.7.1.56) +FIG01961738 Indolepyruvate oxidoreductase subunit IorA (EC 1.2.7.8) +FIG01961740 tmRNA-binding protein SmpB +FIG01961743 "phi-Carotenoid synthase" (EC 1.3.-.- and EC 2.1.1-) +FIG01961744 D-Galactonate repressor DgoR +FIG01961745 Lipopolysaccharide cholinephosphotransferase LicD3 (EC 2.7.8.-) +FIG01961747 D-alanine--D-alanine ligase (EC 6.3.2.4) +FIG01961748 UDP-3-O-[3-hydroxymyristoyl] N-acetylglucosamine deacetylase (EC 3.5.1.-) +FIG01961750 FIG011501: YycH protein +FIG01961751 Anthranilate synthase, amidotransferase component (EC 4.1.3.27) / Anthranilate phosphoribosyltransferase (EC 2.4.2.18) +FIG01961753 Iron-sulfur cluster regulator IscR / Cysteine desulfurase (EC 2.8.1.7) +FIG01961754 Glyoxylate carboligase (EC 4.1.1.47) +FIG01961755 probable class-V aminotransferase +FIG01961756 PAPS reductase-like domain +FIG01961758 Cobalt-precorrin-4 C11-methyltransferase (EC 2.1.1.133) +FIG01961762 SSU ribosomal protein S16p +FIG01961763 Quinone-reactive Ni/Fe hydrogenase, cytochrome b subunit +FIG01961765 Aconitate hydratase 2 (EC 4.2.1.3) +FIG01961767 UDP-glucose dehydrogenase @ intein-containing diff --git a/tests/example_output/ref_db/ontologies/go.txt b/tests/example_output/ref_db/ontologies/go.txt new file mode 100644 index 0000000..7c6b2f6 --- /dev/null +++ b/tests/example_output/ref_db/ontologies/go.txt @@ -0,0 +1,1245 @@ +GO:0000034 adenine deaminase activity +GO:0000104 succinate dehydrogenase activity +GO:0000105 histidine biosynthetic process +GO:0000150 recombinase activity +GO:0000154 rRNA modification +GO:0000155 two-component sensor activity +GO:0000156 two-component response regulator activity +GO:0000166 nucleotide binding +GO:0000210 NAD+ diphosphatase activity +GO:0000213 tRNA-intron endonuclease activity +GO:0000257 nitrilase activity +GO:0000270 peptidoglycan metabolic process +GO:0000271 polysaccharide biosynthetic process +GO:0000286 alanine dehydrogenase activity +GO:0000287 magnesium ion binding +GO:0000309 nicotinamide-nucleotide adenylyltransferase activity +GO:0000310 xanthine phosphoribosyltransferase activity +GO:0000334 3-hydroxyanthranilate 3,4-dioxygenase activity +GO:0000774 adenyl-nucleotide exchange factor activity +GO:0000908 taurine dioxygenase activity +GO:0001539 ciliary or flagellar motility +GO:0001882 nucleoside binding +GO:0003676 nucleic acid binding +GO:0003677 DNA binding +GO:0003678 DNA helicase activity +GO:0003684 damaged DNA binding +GO:0003697 single-stranded DNA binding +GO:0003700 transcription factor activity +GO:0003711 transcription elongation regulator activity +GO:0003715 transcription termination factor activity +GO:0003723 RNA binding +GO:0003735 structural constituent of ribosome +GO:0003743 translation initiation factor activity +GO:0003746 translation elongation factor activity +GO:0003747 translation release factor activity +GO:0003755 peptidyl-prolyl cis-trans isomerase activity +GO:0003774 motor activity +GO:0003810 protein-glutamine gamma-glutamyltransferase activity +GO:0003824 catalytic activity +GO:0003825 alpha,alpha-trehalose-phosphate synthase (UDP-forming) activity +GO:0003837 beta-ureidopropionase activity +GO:0003839 gamma-glutamylcyclotransferase activity +GO:0003840 gamma-glutamyltransferase activity +GO:0003841 1-acylglycerol-3-phosphate O-acyltransferase activity +GO:0003842 1-pyrroline-5-carboxylate dehydrogenase activity +GO:0003844 1,4-alpha-glucan branching enzyme activity +GO:0003848 2-amino-4-hydroxy-6-hydroxymethyldihydropteridine diphosphokinase activity +GO:0003852 2-isopropylmalate synthase activity +GO:0003853 2-methylacyl-CoA dehydrogenase activity +GO:0003856 3-dehydroquinate synthase activity +GO:0003857 3-hydroxyacyl-CoA dehydrogenase activity +GO:0003858 3-hydroxybutyrate dehydrogenase activity +GO:0003859 3-hydroxybutyryl-CoA dehydratase activity +GO:0003860 3-hydroxyisobutyryl-CoA hydrolase activity +GO:0003861 3-isopropylmalate dehydratase activity +GO:0003862 3-isopropylmalate dehydrogenase activity +GO:0003863 3-methyl-2-oxobutanoate dehydrogenase (2-methylpropanoyl-transferring) activity +GO:0003864 3-methyl-2-oxobutanoate hydroxymethyltransferase activity +GO:0003866 3-phosphoshikimate 1-carboxyvinyltransferase activity +GO:0003867 4-aminobutyrate transaminase activity +GO:0003868 4-hydroxyphenylpyruvate dioxygenase activity +GO:0003870 5-aminolevulinate synthase activity +GO:0003871 5-methyltetrahydropteroyltriglutamate-homocysteine S-methyltransferase activity +GO:0003872 6-phosphofructokinase activity +GO:0003874 6-pyruvoyltetrahydropterin synthase activity +GO:0003879 ATP phosphoribosyltransferase activity +GO:0003882 CDP-diacylglycerol-serine O-phosphatidyltransferase activity +GO:0003883 CTP synthase activity +GO:0003887 DNA-directed DNA polymerase activity +GO:0003896 DNA primase activity +GO:0003899 DNA-directed RNA polymerase activity +GO:0003905 alkylbase DNA N-glycosylase activity +GO:0003906 DNA-(apurinic or apyrimidinic site) lyase activity +GO:0003908 methylated-DNA-[protein]-cysteine S-methyltransferase activity +GO:0003910 DNA ligase (ATP) activity +GO:0003911 DNA ligase (NAD+) activity +GO:0003913 DNA photolyase activity +GO:0003916 DNA topoisomerase activity +GO:0003917 DNA topoisomerase type I activity +GO:0003918 DNA topoisomerase (ATP-hydrolyzing) activity +GO:0003919 FMN adenylyltransferase activity +GO:0003920 GMP reductase activity +GO:0003922 GMP synthase (glutamine-hydrolyzing) activity +GO:0003924 GTPase activity +GO:0003934 GTP cyclohydrolase I activity +GO:0003935 GTP cyclohydrolase II activity +GO:0003937 IMP cyclohydrolase activity +GO:0003938 IMP dehydrogenase activity +GO:0003939 L-iditol 2-dehydrogenase activity +GO:0003941 L-serine ammonia-lyase activity +GO:0003942 N-acetyl-gamma-glutamyl-phosphate reductase activity +GO:0003949 1-(5-phosphoribosyl)-5-[(5-phosphoribosylamino)methylideneamino]imidazole-4-carboxamide isomerase activity +GO:0003950 NAD+ ADP-ribosyltransferase activity +GO:0003951 NAD+ kinase activity +GO:0003953 NAD+ nucleosidase activity +GO:0003954 NADH dehydrogenase activity +GO:0003957 NAD(P)+ transhydrogenase (B-specific) activity +GO:0003961 O-acetylhomoserine aminocarboxypropyltransferase activity +GO:0003962 cystathionine gamma-synthase activity +GO:0003963 RNA-3'-phosphate cyclase activity +GO:0003977 UDP-N-acetylglucosamine diphosphorylase activity +GO:0003978 UDP-glucose 4-epimerase activity +GO:0003979 UDP-glucose 6-dehydrogenase activity +GO:0003983 UTP:glucose-1-phosphate uridylyltransferase activity +GO:0003984 acetolactate synthase activity +GO:0003985 acetyl-CoA C-acetyltransferase activity +GO:0003987 acetate-CoA ligase activity +GO:0003988 acetyl-CoA C-acyltransferase activity +GO:0003989 acetyl-CoA carboxylase activity +GO:0003991 acetylglutamate kinase activity +GO:0003992 acetylornithine transaminase activity +GO:0003994 aconitate hydratase activity +GO:0003995 acyl-CoA dehydrogenase activity +GO:0003997 acyl-CoA oxidase activity +GO:0003998 acylphosphatase activity +GO:0003999 adenine phosphoribosyltransferase activity +GO:0004000 adenosine deaminase activity +GO:0004003 ATP-dependent DNA helicase activity +GO:0004008 copper-exporting ATPase activity +GO:0004013 adenosylhomocysteinase activity +GO:0004014 adenosylmethionine decarboxylase activity +GO:0004015 adenosylmethionine-8-amino-7-oxononanoate transaminase activity +GO:0004016 adenylate cyclase activity +GO:0004017 adenylate kinase activity +GO:0004018 adenylosuccinate lyase activity +GO:0004019 adenylosuccinate synthase activity +GO:0004020 adenylylsulfate kinase activity +GO:0004021 alanine transaminase activity +GO:0004022 alcohol dehydrogenase activity +GO:0004027 alcohol sulfotransferase activity +GO:0004029 aldehyde dehydrogenase (NAD) activity +GO:0004034 aldose 1-epimerase activity +GO:0004035 alkaline phosphatase activity +GO:0004037 allantoicase activity +GO:0004038 allantoinase activity +GO:0004040 amidase activity +GO:0004042 amino-acid N-acetyltransferase activity +GO:0004043 L-aminoadipate-semialdehyde dehydrogenase activity +GO:0004044 amidophosphoribosyltransferase activity +GO:0004045 aminoacyl-tRNA hydrolase activity +GO:0004047 aminomethyltransferase activity +GO:0004048 anthranilate phosphoribosyltransferase activity +GO:0004049 anthranilate synthase activity +GO:0004053 arginase activity +GO:0004055 argininosuccinate synthase activity +GO:0004056 argininosuccinate lyase activity +GO:0004058 aromatic-L-amino-acid decarboxylase activity +GO:0004061 arylformamidase activity +GO:0004065 arylsulfatase activity +GO:0004066 asparagine synthase (glutamine-hydrolyzing) activity +GO:0004067 asparaginase activity +GO:0004068 aspartate 1-decarboxylase activity +GO:0004069 aspartate transaminase activity +GO:0004070 aspartate carbamoyltransferase activity +GO:0004071 aspartate-ammonia ligase activity +GO:0004072 aspartate kinase activity +GO:0004073 aspartate-semialdehyde dehydrogenase activity +GO:0004074 biliverdin reductase activity +GO:0004075 biotin carboxylase activity +GO:0004076 biotin synthase activity +GO:0004077 biotin-[acetyl-CoA-carboxylase] ligase activity +GO:0004081 bis(5'-nucleosyl)-tetraphosphatase (asymmetrical) activity +GO:0004084 branched-chain-amino-acid transaminase activity +GO:0004085 butyryl-CoA dehydrogenase activity +GO:0004088 carbamoyl-phosphate synthase (glutamine-hydrolyzing) activity +GO:0004089 carbonate dehydratase activity +GO:0004095 carnitine O-palmitoyltransferase activity +GO:0004096 catalase activity +GO:0004103 choline kinase activity +GO:0004105 choline-phosphate cytidylyltransferase activity +GO:0004106 chorismate mutase activity +GO:0004107 chorismate synthase activity +GO:0004108 citrate (Si)-synthase activity +GO:0004109 coproporphyrinogen oxidase activity +GO:0004121 cystathionine beta-lyase activity +GO:0004122 cystathionine beta-synthase activity +GO:0004123 cystathionine gamma-lyase activity +GO:0004124 cysteine synthase activity +GO:0004125 L-seryl-tRNASec selenium transferase activity +GO:0004126 cytidine deaminase activity +GO:0004127 cytidylate kinase activity +GO:0004129 cytochrome-c oxidase activity +GO:0004131 cytosine deaminase activity +GO:0004132 dCMP deaminase activity +GO:0004134 4-alpha-glucanotransferase activity +GO:0004136 deoxyadenosine kinase activity +GO:0004138 deoxyguanosine kinase activity +GO:0004139 deoxyribose-phosphate aldolase activity +GO:0004140 dephospho-CoA kinase activity +GO:0004141 dethiobiotin synthase activity +GO:0004143 diacylglycerol kinase activity +GO:0004145 diamine N-acetyltransferase activity +GO:0004146 dihydrofolate reductase activity +GO:0004148 dihydrolipoyl dehydrogenase activity +GO:0004149 dihydrolipoyllysine-residue succinyltransferase activity +GO:0004150 dihydroneopterin aldolase activity +GO:0004151 dihydroorotase activity +GO:0004156 dihydropteroate synthase activity +GO:0004157 dihydropyrimidinase activity +GO:0004158 dihydroorotate oxidase activity +GO:0004160 dihydroxy-acid dehydratase activity +GO:0004163 diphosphomevalonate decarboxylase activity +GO:0004165 dodecenoyl-CoA delta-isomerase activity +GO:0004170 dUTP diphosphatase activity +GO:0004177 aminopeptidase activity +GO:0004178 leucyl aminopeptidase activity +GO:0004179 membrane alanyl aminopeptidase activity +GO:0004222 metalloendopeptidase activity +GO:0004237 membrane dipeptidase activity +GO:0004239 methionyl aminopeptidase activity +GO:0004251 X-Pro dipeptidase activity +GO:0004252 serine-type endopeptidase activity +GO:0004289 subtilase activity +GO:0004300 enoyl-CoA hydratase activity +GO:0004304 estrone sulfotransferase activity +GO:0004308 exo-alpha-sialidase activity +GO:0004309 exopolyphosphatase activity +GO:0004311 farnesyltranstransferase activity +GO:0004314 [acyl-carrier-protein] S-malonyltransferase activity +GO:0004315 3-oxoacyl-[acyl-carrier-protein] synthase activity +GO:0004316 3-oxoacyl-[acyl-carrier-protein] reductase activity +GO:0004317 3-hydroxypalmitoyl-[acyl-carrier-protein] dehydratase activity +GO:0004318 enoyl-[acyl-carrier-protein] reductase (NADH) activity +GO:0004319 enoyl-[acyl-carrier-protein] reductase (NADPH, B-specific) activity +GO:0004322 ferroxidase activity +GO:0004324 ferredoxin-NADP+ reductase activity +GO:0004325 ferrochelatase activity +GO:0004326 tetrahydrofolylpolyglutamate synthase activity +GO:0004328 formamidase activity +GO:0004329 formate-tetrahydrofolate ligase activity +GO:0004332 fructose-bisphosphate aldolase activity +GO:0004333 fumarate hydratase activity +GO:0004334 fumarylacetoacetase activity +GO:0004335 galactokinase activity +GO:0004336 galactosylceramidase activity +GO:0004337 geranyltranstransferase activity +GO:0004340 glucokinase activity +GO:0004341 gluconolactonase activity +GO:0004342 glucosamine-6-phosphate deaminase activity +GO:0004343 glucosamine 6-phosphate N-acetyltransferase activity +GO:0004345 glucose-6-phosphate dehydrogenase activity +GO:0004347 glucose-6-phosphate isomerase activity +GO:0004349 glutamate 5-kinase activity +GO:0004350 glutamate-5-semialdehyde dehydrogenase activity +GO:0004354 glutamate dehydrogenase (NADP+) activity +GO:0004355 glutamate synthase (NADPH) activity +GO:0004356 glutamate-ammonia ligase activity +GO:0004357 glutamate-cysteine ligase activity +GO:0004358 glutamate N-acetyltransferase activity +GO:0004360 glutamine-fructose-6-phosphate transaminase (isomerizing) activity +GO:0004361 glutaryl-CoA dehydrogenase activity +GO:0004362 glutathione-disulfide reductase activity +GO:0004363 glutathione synthase activity +GO:0004364 glutathione transferase activity +GO:0004365 glyceraldehyde-3-phosphate dehydrogenase (phosphorylating) activity +GO:0004366 glycerol-3-phosphate O-acyltransferase activity +GO:0004370 glycerol kinase activity +GO:0004371 glycerone kinase activity +GO:0004372 glycine hydroxymethyltransferase activity +GO:0004375 glycine dehydrogenase (decarboxylating) activity +GO:0004385 guanylate kinase activity +GO:0004386 helicase activity +GO:0004392 heme oxygenase (decyclizing) activity +GO:0004396 hexokinase activity +GO:0004397 histidine ammonia-lyase activity +GO:0004399 histidinol dehydrogenase activity +GO:0004400 histidinol-phosphate transaminase activity +GO:0004401 histidinol-phosphatase activity +GO:0004409 homoaconitate hydratase activity +GO:0004410 homocitrate synthase activity +GO:0004411 homogentisate 1,2-dioxygenase activity +GO:0004412 homoserine dehydrogenase activity +GO:0004413 homoserine kinase activity +GO:0004414 homoserine O-acetyltransferase activity +GO:0004416 hydroxyacylglutathione hydrolase activity +GO:0004417 hydroxyethylthiazole kinase activity +GO:0004418 hydroxymethylbilane synthase activity +GO:0004419 hydroxymethylglutaryl-CoA lyase activity +GO:0004420 hydroxymethylglutaryl-CoA reductase (NADPH) activity +GO:0004421 hydroxymethylglutaryl-CoA synthase activity +GO:0004422 hypoxanthine phosphoribosyltransferase activity +GO:0004424 imidazoleglycerol-phosphate dehydratase activity +GO:0004425 indole-3-glycerol-phosphate synthase activity +GO:0004427 inorganic diphosphatase activity +GO:0004436 phosphatidylinositol diacylglycerol-lyase activity +GO:0004437 inositol or phosphatidylinositol phosphatase activity +GO:0004449 isocitrate dehydrogenase (NAD+) activity +GO:0004450 isocitrate dehydrogenase (NADP+) activity +GO:0004451 isocitrate lyase activity +GO:0004452 isopentenyl-diphosphate delta-isomerase activity +GO:0004455 ketol-acid reductoisomerase activity +GO:0004456 phosphogluconate dehydratase activity +GO:0004459 L-lactate dehydrogenase activity +GO:0004460 L-lactate dehydrogenase (cytochrome) activity +GO:0004462 lactoylglutathione lyase activity +GO:0004467 long-chain-fatty-acid-CoA ligase activity +GO:0004473 malate dehydrogenase (oxaloacetate-decarboxylating) (NADP+) activity +GO:0004474 malate synthase activity +GO:0004476 mannose-6-phosphate isomerase activity +GO:0004477 methenyltetrahydrofolate cyclohydrolase activity +GO:0004478 methionine adenosyltransferase activity +GO:0004479 methionyl-tRNA formyltransferase activity +GO:0004485 methylcrotonoyl-CoA carboxylase activity +GO:0004488 methylenetetrahydrofolate dehydrogenase (NADP+) activity +GO:0004490 methylglutaconyl-CoA hydratase activity +GO:0004491 methylmalonate-semialdehyde dehydrogenase (acylating) activity +GO:0004492 methylmalonyl-CoA decarboxylase activity +GO:0004494 methylmalonyl-CoA mutase activity +GO:0004496 mevalonate kinase activity +GO:0004502 kynurenine 3-monooxygenase activity +GO:0004505 phenylalanine 4-monooxygenase activity +GO:0004512 inositol-3-phosphate synthase activity +GO:0004514 nicotinate-nucleotide diphosphorylase (carboxylating) activity +GO:0004515 nicotinate-nucleotide adenylyltransferase activity +GO:0004516 nicotinate phosphoribosyltransferase activity +GO:0004517 nitric-oxide synthase activity +GO:0004518 nuclease activity +GO:0004519 endonuclease activity +GO:0004523 ribonuclease H activity +GO:0004525 ribonuclease III activity +GO:0004526 ribonuclease P activity +GO:0004540 ribonuclease activity +GO:0004550 nucleoside diphosphate kinase activity +GO:0004555 alpha,alpha-trehalase activity +GO:0004556 alpha-amylase activity +GO:0004557 alpha-galactosidase activity +GO:0004558 alpha-glucosidase activity +GO:0004560 alpha-L-fucosidase activity +GO:0004561 alpha-N-acetylglucosaminidase activity +GO:0004563 beta-N-acetylhexosaminidase activity +GO:0004564 beta-fructofuranosidase activity +GO:0004565 beta-galactosidase activity +GO:0004566 beta-glucuronidase activity +GO:0004568 chitinase activity +GO:0004574 oligo-1,6-glucosidase activity +GO:0004579 dolichyl-diphosphooligosaccharide-protein glycotransferase activity +GO:0004585 ornithine carbamoyltransferase activity +GO:0004586 ornithine decarboxylase activity +GO:0004587 ornithine-oxo-acid transaminase activity +GO:0004588 orotate phosphoribosyltransferase activity +GO:0004590 orotidine-5'-phosphate decarboxylase activity +GO:0004591 oxoglutarate dehydrogenase (succinyl-transferring) activity +GO:0004592 pantoate-beta-alanine ligase activity +GO:0004594 pantothenate kinase activity +GO:0004595 pantetheine-phosphate adenylyltransferase activity +GO:0004601 peroxidase activity +GO:0004602 glutathione peroxidase activity +GO:0004604 phosphoadenylyl-sulfate reductase (thioredoxin) activity +GO:0004605 phosphatidate cytidylyltransferase activity +GO:0004609 phosphatidylserine decarboxylase activity +GO:0004612 phosphoenolpyruvate carboxykinase (ATP) activity +GO:0004613 phosphoenolpyruvate carboxykinase (GTP) activity +GO:0004614 phosphoglucomutase activity +GO:0004615 phosphomannomutase activity +GO:0004616 phosphogluconate dehydrogenase (decarboxylating) activity +GO:0004617 phosphoglycerate dehydrogenase activity +GO:0004618 phosphoglycerate kinase activity +GO:0004619 phosphoglycerate mutase activity +GO:0004622 lysophospholipase activity +GO:0004629 phospholipase C activity +GO:0004631 phosphomevalonate kinase activity +GO:0004632 phosphopantothenate--cysteine ligase activity +GO:0004633 phosphopantothenoylcysteine decarboxylase activity +GO:0004634 phosphopyruvate hydratase activity +GO:0004635 phosphoribosyl-AMP cyclohydrolase activity +GO:0004636 phosphoribosyl-ATP diphosphatase activity +GO:0004637 phosphoribosylamine-glycine ligase activity +GO:0004638 phosphoribosylaminoimidazole carboxylase activity +GO:0004639 phosphoribosylaminoimidazolesuccinocarboxamide synthase activity +GO:0004640 phosphoribosylanthranilate isomerase activity +GO:0004641 phosphoribosylformylglycinamidine cyclo-ligase activity +GO:0004642 phosphoribosylformylglycinamidine synthase activity +GO:0004643 phosphoribosylaminoimidazolecarboxamide formyltransferase activity +GO:0004644 phosphoribosylglycinamide formyltransferase activity +GO:0004645 phosphorylase activity +GO:0004647 phosphoserine phosphatase activity +GO:0004648 phosphoserine transaminase activity +GO:0004652 polynucleotide adenylyltransferase activity +GO:0004654 polyribonucleotide nucleotidyltransferase activity +GO:0004655 porphobilinogen synthase activity +GO:0004657 proline dehydrogenase activity +GO:0004658 propionyl-CoA carboxylase activity +GO:0004659 prenyltransferase activity +GO:0004664 prephenate dehydratase activity +GO:0004672 protein kinase activity +GO:0004673 protein histidine kinase activity +GO:0004713 protein-tyrosine kinase activity +GO:0004721 phosphoprotein phosphatase activity +GO:0004725 protein tyrosine phosphatase activity +GO:0004729 protoporphyrinogen oxidase activity +GO:0004730 pseudouridylate synthase activity +GO:0004731 purine-nucleoside phosphorylase activity +GO:0004733 pyridoxamine-phosphate oxidase activity +GO:0004735 pyrroline-5-carboxylate reductase activity +GO:0004736 pyruvate carboxylase activity +GO:0004737 pyruvate decarboxylase activity +GO:0004739 pyruvate dehydrogenase (acetyl-transferring) activity +GO:0004742 dihydrolipoyllysine-residue acetyltransferase activity +GO:0004743 pyruvate kinase activity +GO:0004746 riboflavin synthase activity +GO:0004747 ribokinase activity +GO:0004748 ribonucleoside-diphosphate reductase activity +GO:0004749 ribose phosphate diphosphokinase activity +GO:0004750 ribulose-phosphate 3-epimerase activity +GO:0004751 ribose-5-phosphate isomerase activity +GO:0004754 saccharopine dehydrogenase (NAD+, L-lysine-forming) activity +GO:0004755 saccharopine dehydrogenase (NADP+, L-glutamate-forming) activity +GO:0004756 selenide, water dikinase activity +GO:0004757 sepiapterin reductase activity +GO:0004758 serine C-palmitoyltransferase activity +GO:0004760 serine-pyruvate transaminase activity +GO:0004765 shikimate kinase activity +GO:0004766 spermidine synthase activity +GO:0004773 steryl-sulfatase activity +GO:0004775 succinate-CoA ligase (ADP-forming) activity +GO:0004777 succinate-semialdehyde dehydrogenase activity +GO:0004781 sulfate adenylyltransferase (ATP) activity +GO:0004783 sulfite reductase (NADPH) activity +GO:0004784 superoxide dismutase activity +GO:0004788 thiamin diphosphokinase activity +GO:0004789 thiamin-phosphate diphosphorylase activity +GO:0004791 thioredoxin-disulfide reductase activity +GO:0004793 threonine aldolase activity +GO:0004794 L-threonine ammonia-lyase activity +GO:0004795 threonine synthase activity +GO:0004797 thymidine kinase activity +GO:0004798 thymidylate kinase activity +GO:0004799 thymidylate synthase activity +GO:0004801 transaldolase activity +GO:0004802 transketolase activity +GO:0004806 triacylglycerol lipase activity +GO:0004807 triose-phosphate isomerase activity +GO:0004808 tRNA (5-methylaminomethyl-2-thiouridylate)-methyltransferase activity +GO:0004809 tRNA (guanine-N2-)-methyltransferase activity +GO:0004811 tRNA isopentenyltransferase activity +GO:0004813 alanine-tRNA ligase activity +GO:0004814 arginine-tRNA ligase activity +GO:0004815 aspartate-tRNA ligase activity +GO:0004816 asparagine-tRNA ligase activity +GO:0004817 cysteine-tRNA ligase activity +GO:0004818 glutamate-tRNA ligase activity +GO:0004819 glutamine-tRNA ligase activity +GO:0004820 glycine-tRNA ligase activity +GO:0004821 histidine-tRNA ligase activity +GO:0004822 isoleucine-tRNA ligase activity +GO:0004823 leucine-tRNA ligase activity +GO:0004824 lysine-tRNA ligase activity +GO:0004825 methionine-tRNA ligase activity +GO:0004826 phenylalanine-tRNA ligase activity +GO:0004827 proline-tRNA ligase activity +GO:0004828 serine-tRNA ligase activity +GO:0004829 threonine-tRNA ligase activity +GO:0004830 tryptophan-tRNA ligase activity +GO:0004831 tyrosine-tRNA ligase activity +GO:0004832 valine-tRNA ligase activity +GO:0004833 tryptophan 2,3-dioxygenase activity +GO:0004834 tryptophan synthase activity +GO:0004845 uracil phosphoribosyltransferase activity +GO:0004846 urate oxidase activity +GO:0004848 ureidoglycolate hydrolase activity +GO:0004849 uridine kinase activity +GO:0004850 uridine phosphorylase activity +GO:0004851 uroporphyrin-III C-methyltransferase activity +GO:0004852 uroporphyrinogen-III synthase activity +GO:0004853 uroporphyrinogen decarboxylase activity +GO:0004855 xanthine oxidase activity +GO:0004856 xylulokinase activity +GO:0004871 signal transducer activity +GO:0004872 receptor activity +GO:0005198 structural molecule activity +GO:0005215 transporter activity +GO:0005216 ion channel activity +GO:0005247 voltage-gated chloride channel activity +GO:0005315 inorganic phosphate transmembrane transporter activity +GO:0005351 sugar:hydrogen ion symporter activity +GO:0005381 iron ion transmembrane transporter activity +GO:0005488 binding +GO:0005506 iron ion binding +GO:0005507 copper ion binding +GO:0005509 calcium ion binding +GO:0005515 protein binding +GO:0005518 collagen binding +GO:0005524 ATP binding +GO:0005525 GTP binding +GO:0005529 sugar binding +GO:0005576 extracellular region +GO:0005618 cell wall +GO:0005622 intracellular +GO:0005694 chromosome +GO:0005737 cytoplasm +GO:0005840 ribosome +GO:0005960 glycine cleavage complex +GO:0005975 carbohydrate metabolic process +GO:0006047 UDP-N-acetylglucosamine metabolic process +GO:0006071 glycerol metabolic process +GO:0006096 glycolysis +GO:0006097 glyoxylate cycle +GO:0006099 tricarboxylic acid cycle +GO:0006106 fumarate metabolic process +GO:0006109 regulation of carbohydrate metabolic process +GO:0006118 electron transport +GO:0006207 'de novo' pyrimidine base biosynthetic process +GO:0006259 DNA metabolic process +GO:0006260 DNA replication +GO:0006265 DNA topological change +GO:0006268 DNA unwinding during replication +GO:0006281 DNA repair +GO:0006284 base-excision repair +GO:0006289 nucleotide-excision repair +GO:0006298 mismatch repair +GO:0006304 DNA modification +GO:0006310 DNA recombination +GO:0006323 DNA packaging +GO:0006352 transcription initiation +GO:0006353 transcription termination +GO:0006364 rRNA processing +GO:0006396 RNA processing +GO:0006412 translation +GO:0006413 translational initiation +GO:0006414 translational elongation +GO:0006415 translational termination +GO:0006424 glutamyl-tRNA aminoacylation +GO:0006457 protein folding +GO:0006461 protein complex assembly +GO:0006464 protein modification process +GO:0006479 protein amino acid methylation +GO:0006508 proteolysis +GO:0006520 amino acid metabolic process +GO:0006546 glycine catabolic process +GO:0006596 polyamine biosynthetic process +GO:0006605 protein targeting +GO:0006614 SRP-dependent cotranslational protein targeting to membrane +GO:0006629 lipid metabolic process +GO:0006633 fatty acid biosynthetic process +GO:0006725 aromatic compound metabolic process +GO:0006777 Mo-molybdopterin cofactor biosynthetic process +GO:0006790 sulfur metabolic process +GO:0006807 nitrogen compound metabolic process +GO:0006808 regulation of nitrogen utilization +GO:0006809 nitric oxide biosynthetic process +GO:0006810 transport +GO:0006811 ion transport +GO:0006812 cation transport +GO:0006813 potassium ion transport +GO:0006814 sodium ion transport +GO:0006817 phosphate transport +GO:0006821 chloride transport +GO:0006825 copper ion transport +GO:0006826 iron ion transport +GO:0006827 high affinity iron ion transport +GO:0006857 oligopeptide transport +GO:0006858 extracellular transport +GO:0006865 amino acid transport +GO:0006878 cellular copper ion homeostasis +GO:0006879 cellular iron ion homeostasis +GO:0006885 regulation of pH +GO:0006886 intracellular protein transport +GO:0006928 cell motility +GO:0006935 chemotaxis +GO:0006950 response to stress +GO:0006980 redox signal response +GO:0007047 cell wall organization and biogenesis +GO:0007049 cell cycle +GO:0007059 chromosome segregation +GO:0007155 cell adhesion +GO:0007165 signal transduction +GO:0007205 protein kinase C activation +GO:0008026 ATP-dependent helicase activity +GO:0008033 tRNA processing +GO:0008080 N-acetyltransferase activity +GO:0008097 5S rRNA binding +GO:0008114 phosphogluconate 2-dehydrogenase activity +GO:0008121 ubiquinol-cytochrome-c reductase activity +GO:0008124 4-alpha-hydroxytetrahydrobiopterin dehydratase activity +GO:0008131 amine oxidase activity +GO:0008134 transcription factor binding +GO:0008137 NADH dehydrogenase (ubiquinone) activity +GO:0008152 metabolic process +GO:0008168 methyltransferase activity +GO:0008171 O-methyltransferase activity +GO:0008173 RNA methyltransferase activity +GO:0008175 tRNA methyltransferase activity +GO:0008176 tRNA (guanine-N7-)-methyltransferase activity +GO:0008199 ferric iron binding +GO:0008233 peptidase activity +GO:0008234 cysteine-type peptidase activity +GO:0008235 metalloexopeptidase activity +GO:0008236 serine-type peptidase activity +GO:0008237 metallopeptidase activity +GO:0008243 plasminogen activator activity +GO:0008253 5'-nucleotidase activity +GO:0008260 3-oxoacid CoA-transferase activity +GO:0008270 zinc ion binding +GO:0008276 protein methyltransferase activity +GO:0008299 isoprenoid biosynthetic process +GO:0008324 cation transmembrane transporter activity +GO:0008415 acyltransferase activity +GO:0008422 beta-glucosidase activity +GO:0008423 bleomycin hydrolase activity +GO:0008442 3-hydroxyisobutyrate dehydrogenase activity +GO:0008444 CDP-diacylglycerol-glycerol-3-phosphate 3-phosphatidyltransferase activity +GO:0008446 GDP-mannose 4,6-dehydratase activity +GO:0008448 N-acetylglucosamine-6-phosphate deacetylase activity +GO:0008450 O-sialoglycoprotein endopeptidase activity +GO:0008451 X-Pro aminopeptidase activity +GO:0008453 alanine-glyoxylate transaminase activity +GO:0008460 dTDP-glucose 4,6-dehydratase activity +GO:0008462 endopeptidase Clp activity +GO:0008470 isovaleryl-CoA dehydrogenase activity +GO:0008473 ornithine cyclodeaminase activity +GO:0008477 purine nucleosidase activity +GO:0008478 pyridoxal kinase activity +GO:0008479 queuine tRNA-ribosyltransferase activity +GO:0008508 bile acid:sodium symporter activity +GO:0008514 organic anion transmembrane transporter activity +GO:0008531 riboflavin kinase activity +GO:0008534 oxidized purine base lesion DNA N-glycosylase activity +GO:0008535 respiratory chain complex IV assembly +GO:0008556 potassium-transporting ATPase activity +GO:0008565 protein transporter activity +GO:0008615 pyridoxine biosynthetic process +GO:0008616 queuosine biosynthetic process +GO:0008643 carbohydrate transport +GO:0008649 rRNA methyltransferase activity +GO:0008658 penicillin binding +GO:0008661 1-deoxy-D-xylulose-5-phosphate synthase activity +GO:0008662 1-phosphofructokinase activity +GO:0008663 2',3'-cyclic-nucleotide 2'-phosphodiesterase activity +GO:0008666 2,3,4,5-tetrahydropyridine-2,6-dicarboxylate N-succinyltransferase activity +GO:0008667 2,3-dihydro-2,3-dihydroxybenzoate dehydrogenase activity +GO:0008668 (2,3-dihydroxybenzoyl)adenylate synthase activity +GO:0008671 2-dehydro-3-deoxygalactonokinase activity +GO:0008672 2-dehydro-3-deoxyglucarate aldolase activity +GO:0008673 2-dehydro-3-deoxygluconokinase activity +GO:0008674 2-dehydro-3-deoxy-6-phosphogalactonate aldolase activity +GO:0008675 2-dehydro-3-deoxy-phosphogluconate aldolase activity +GO:0008677 2-dehydropantoate 2-reductase activity +GO:0008679 2-hydroxy-3-oxopropionate reductase activity +GO:0008685 2-C-methyl-D-erythritol 2,4-cyclodiphosphate synthase activity +GO:0008687 3,4-dihydroxyphenylacetate 2,3-dioxygenase activity +GO:0008690 3-deoxy-manno-octulosonate cytidylyltransferase activity +GO:0008691 3-hydroxybutyryl-CoA dehydrogenase activity +GO:0008692 3-hydroxybutyryl-CoA epimerase activity +GO:0008693 3-hydroxydecanoyl-[acyl-carrier-protein] dehydratase activity +GO:0008696 4-amino-4-deoxychorismate lyase activity +GO:0008700 4-hydroxy-2-oxoglutarate aldolase activity +GO:0008703 5-amino-6-(5-phosphoribosylamino)uracil reductase activity +GO:0008704 5-carboxymethyl-2-hydroxymuconate delta-isomerase activity +GO:0008705 methionine synthase activity +GO:0008706 6-phospho-beta-glucosidase activity +GO:0008710 8-amino-7-oxononanoate synthase activity +GO:0008712 ADP-glyceromanno-heptose 6-epimerase activity +GO:0008714 AMP nucleosidase activity +GO:0008715 CDP-diacylglycerol diphosphatase activity +GO:0008716 D-alanine-D-alanine ligase activity +GO:0008718 D-amino-acid dehydrogenase activity +GO:0008720 D-lactate dehydrogenase activity +GO:0008721 D-serine ammonia-lyase activity +GO:0008725 DNA-3-methyladenine glycosylase I activity +GO:0008726 alkanesulfonate monooxygenase activity +GO:0008728 GTP diphosphokinase activity +GO:0008733 L-arabinose isomerase activity +GO:0008734 L-aspartate oxidase activity +GO:0008736 L-fucose isomerase activity +GO:0008737 L-fuculokinase activity +GO:0008738 L-fuculose-phosphate aldolase activity +GO:0008740 L-rhamnose isomerase activity +GO:0008741 ribulokinase activity +GO:0008742 L-ribulose-phosphate 4-epimerase activity +GO:0008743 L-threonine 3-dehydrogenase activity +GO:0008745 N-acetylmuramoyl-L-alanine amidase activity +GO:0008747 N-acetylneuraminate lyase activity +GO:0008750 NAD(P)+ transhydrogenase (AB-specific) activity +GO:0008752 FMN reductase activity +GO:0008756 o-succinylbenzoate-CoA ligase activity +GO:0008759 UDP-3-O-[3-hydroxymyristoyl] N-acetylglucosamine deacetylase activity +GO:0008760 UDP-N-acetylglucosamine 1-carboxyvinyltransferase activity +GO:0008761 UDP-N-acetylglucosamine 2-epimerase activity +GO:0008762 UDP-N-acetylmuramate dehydrogenase activity +GO:0008763 UDP-N-acetylmuramate-L-alanine ligase activity +GO:0008764 UDP-N-acetylmuramoylalanine-D-glutamate ligase activity +GO:0008765 UDP-N-acetylmuramoylalanyl-D-glutamate-2,6-diaminopimelate ligase activity +GO:0008767 UDP-galactopyranose mutase activity +GO:0008768 UDP-sugar diphosphatase activity +GO:0008769 X-His dipeptidase activity +GO:0008770 [acyl-carrier-protein] phosphodiesterase activity +GO:0008771 [citrate (pro-3S)-lyase] ligase activity +GO:0008773 [protein-PII] uridylyltransferase activity +GO:0008774 acetaldehyde dehydrogenase (acetylating) activity +GO:0008776 acetate kinase activity +GO:0008777 acetylornithine deacetylase activity +GO:0008780 acyl-[acyl-carrier-protein]-UDP-N-acetylglucosamine O-acyltransferase activity +GO:0008781 N-acylneuraminate cytidylyltransferase activity +GO:0008782 adenosylhomocysteine nucleosidase activity +GO:0008783 agmatinase activity +GO:0008784 alanine racemase activity +GO:0008787 allose kinase activity +GO:0008788 alpha,alpha-phosphotrehalase activity +GO:0008789 altronate dehydratase activity +GO:0008791 arginine N-succinyltransferase activity +GO:0008792 arginine decarboxylase activity +GO:0008793 aromatic-amino-acid transaminase activity +GO:0008794 arsenate reductase (glutaredoxin) activity +GO:0008795 NAD+ synthase activity +GO:0008797 aspartate ammonia-lyase activity +GO:0008798 beta-aspartyl-peptidase activity +GO:0008800 beta-lactamase activity +GO:0008801 beta-phosphoglucomutase activity +GO:0008802 betaine-aldehyde dehydrogenase activity +GO:0008804 carbamate kinase activity +GO:0008811 chloramphenicol O-acetyltransferase activity +GO:0008812 choline dehydrogenase activity +GO:0008815 citrate (pro-3S)-lyase activity +GO:0008817 cob(I)yrinic acid a,c-diamide adenosyltransferase activity +GO:0008818 cobalamin 5'-phosphate synthase activity +GO:0008824 cyanate hydratase activity +GO:0008827 cytochrome o ubiquinol oxidase activity +GO:0008829 dCTP deaminase activity +GO:0008830 dTDP-4-dehydrorhamnose 3,5-epimerase activity +GO:0008831 dTDP-4-dehydrorhamnose reductase activity +GO:0008832 dGTPase activity +GO:0008833 deoxyribonuclease IV (phage-T4-induced) activity +GO:0008834 di-trans,poly-cis-decaprenylcistransferase activity +GO:0008835 diaminohydroxyphosphoribosylaminopyrimidine deaminase activity +GO:0008836 diaminopimelate decarboxylase activity +GO:0008837 diaminopimelate epimerase activity +GO:0008839 dihydrodipicolinate reductase activity +GO:0008840 dihydrodipicolinate synthase activity +GO:0008841 dihydrofolate synthase activity +GO:0008846 endopeptidase La activity +GO:0008847 Enterobacter ribonuclease activity +GO:0008851 ethanolamine ammonia-lyase activity +GO:0008852 exodeoxyribonuclease I activity +GO:0008853 exodeoxyribonuclease III activity +GO:0008854 exodeoxyribonuclease V activity +GO:0008855 exodeoxyribonuclease VII activity +GO:0008859 exoribonuclease II activity +GO:0008860 ferredoxin-NAD+ reductase activity +GO:0008861 formate C-acetyltransferase activity +GO:0008863 formate dehydrogenase activity +GO:0008864 formyltetrahydrofolate deformylase activity +GO:0008865 fructokinase activity +GO:0008866 fructuronate reductase activity +GO:0008867 galactarate dehydratase activity +GO:0008868 galactitol-1-phosphate 5-dehydrogenase activity +GO:0008869 galactonate dehydratase activity +GO:0008870 galactoside O-acetyltransferase activity +GO:0008872 glucarate dehydratase activity +GO:0008876 quinoprotein glucose dehydrogenase activity +GO:0008878 glucose-1-phosphate adenylyltransferase activity +GO:0008879 glucose-1-phosphate thymidylyltransferase activity +GO:0008880 glucuronate isomerase activity +GO:0008881 glutamate racemase activity +GO:0008882 [glutamate-ammonia-ligase] adenylyltransferase activity +GO:0008883 glutamyl-tRNA reductase activity +GO:0008886 glyceraldehyde-3-phosphate dehydrogenase (NADP+) activity +GO:0008887 glycerate kinase activity +GO:0008888 glycerol dehydrogenase activity +GO:0008889 glycerophosphodiester phosphodiesterase activity +GO:0008890 glycine C-acetyltransferase activity +GO:0008892 guanine deaminase activity +GO:0008893 guanosine-3',5'-bis(diphosphate) 3'-diphosphatase activity +GO:0008894 guanosine-5'-triphosphate,3'-diphosphate diphosphatase activity +GO:0008897 phosphopantetheinyltransferase activity +GO:0008898 homocysteine S-methyltransferase activity +GO:0008899 homoserine O-succinyltransferase activity +GO:0008901 ferredoxin hydrogenase activity +GO:0008906 inosine kinase activity +GO:0008908 isochorismatase activity +GO:0008909 isochorismate synthase activity +GO:0008911 lactaldehyde dehydrogenase activity +GO:0008912 lactaldehyde reductase activity +GO:0008914 leucyltransferase activity +GO:0008915 lipid-A-disaccharide synthase activity +GO:0008917 lipopolysaccharide N-acetylglucosaminyltransferase activity +GO:0008919 lipopolysaccharide glucosyltransferase I activity +GO:0008923 lysine decarboxylase activity +GO:0008924 malate dehydrogenase (acceptor) activity +GO:0008925 maltose O-acetyltransferase activity +GO:0008926 mannitol-1-phosphate 5-dehydrogenase activity +GO:0008927 mannonate dehydratase activity +GO:0008928 mannose-1-phosphate guanylyltransferase (GDP) activity +GO:0008929 methylglyoxal synthase activity +GO:0008930 methylthioadenosine nucleosidase activity +GO:0008935 naphthoate synthase activity +GO:0008936 nicotinamidase activity +GO:0008939 nicotinate-nucleotide-dimethylbenzimidazole phosphoribosyltransferase activity +GO:0008940 nitrate reductase activity +GO:0008941 nitric oxide dioxygenase activity +GO:0008942 nitrite reductase [NAD(P)H] activity +GO:0008948 oxaloacetate decarboxylase activity +GO:0008949 oxalyl-CoA decarboxylase activity +GO:0008955 peptidoglycan glycosyltransferase activity +GO:0008957 phenylacetaldehyde dehydrogenase activity +GO:0008959 phosphate acetyltransferase activity +GO:0008962 phosphatidylglycerophosphatase activity +GO:0008963 phospho-N-acetylmuramoyl-pentapeptide-transferase activity +GO:0008964 phosphoenolpyruvate carboxylase activity +GO:0008965 phosphoenolpyruvate-protein phosphotransferase activity +GO:0008966 phosphoglucosamine mutase activity +GO:0008972 phosphomethylpyrimidine kinase activity +GO:0008973 phosphopentomutase activity +GO:0008974 phosphoribulokinase activity +GO:0008976 polyphosphate kinase activity +GO:0008977 prephenate dehydrogenase activity +GO:0008982 protein-N(PI)-phosphohistidine-sugar phosphotransferase activity +GO:0008983 protein-glutamate O-methyltransferase activity +GO:0008984 protein-glutamate methylesterase activity +GO:0008985 pyruvate dehydrogenase (cytochrome) activity +GO:0008986 pyruvate, water dikinase activity +GO:0008992 repressor LexA activity +GO:0008993 rhamnulokinase activity +GO:0008994 rhamnulose-1-phosphate aldolase activity +GO:0008998 ribonucleoside-triphosphate reductase activity +GO:0009001 serine O-acetyltransferase activity +GO:0009002 serine-type D-Ala-D-Ala carboxypeptidase activity +GO:0009007 site-specific DNA-methyltransferase (adenine-specific) activity +GO:0009010 sorbitol-6-phosphate 2-dehydrogenase activity +GO:0009011 starch synthase activity +GO:0009013 succinate-semialdehyde dehydrogenase [NAD(P)+] activity +GO:0009014 succinyl-diaminopimelate desuccinylase activity +GO:0009016 succinyldiaminopimelate transaminase activity +GO:0009018 sucrose phosphorylase activity +GO:0009019 tRNA (guanine-N1-)-methyltransferase activity +GO:0009020 tRNA (guanosine-2'-O-)-methyltransferase activity +GO:0009021 tRNA (uracil-5-)-methyltransferase activity +GO:0009022 tRNA nucleotidyltransferase activity +GO:0009024 tagatose-6-phosphate kinase activity +GO:0009025 tagatose-bisphosphate aldolase activity +GO:0009026 tagaturonate reductase activity +GO:0009028 tartronate-semialdehyde synthase activity +GO:0009029 tetraacyldisaccharide 4'-kinase activity +GO:0009030 thiamin phosphate kinase activity +GO:0009032 thymidine phosphorylase activity +GO:0009033 trimethylamine-N-oxide reductase activity +GO:0009039 urease activity +GO:0009040 ureidoglycolate dehydrogenase activity +GO:0009042 valine-pyruvate transaminase activity +GO:0009044 xylan 1,4-beta-xylosidase activity +GO:0009045 xylose isomerase activity +GO:0009055 electron carrier activity +GO:0009058 biosynthetic process +GO:0009073 aromatic amino acid family biosynthetic process +GO:0009102 biotin biosynthetic process +GO:0009103 lipopolysaccharide biosynthetic process +GO:0009228 thiamin biosynthetic process +GO:0009231 riboflavin biosynthetic process +GO:0009236 cobalamin biosynthetic process +GO:0009244 lipopolysaccharide core region biosynthetic process +GO:0009245 lipid A biosynthetic process +GO:0009252 peptidoglycan biosynthetic process +GO:0009253 peptidoglycan catabolic process +GO:0009267 cellular response to starvation +GO:0009289 fimbrium +GO:0009296 flagellum biogenesis +GO:0009297 pilus biogenesis +GO:0009306 protein secretion +GO:0009341 beta-galactosidase complex +GO:0009375 ferredoxin hydrogenase complex +GO:0009378 Holliday junction helicase activity +GO:0009379 Holliday junction helicase complex +GO:0009384 N-acylmannosamine kinase activity +GO:0009401 phosphoenolpyruvate-dependent sugar phosphotransferase system +GO:0009405 pathogenesis +GO:0009607 response to biotic stimulus +GO:0009847 spore germination +GO:0009935 nutrient import +GO:0009986 cell surface +GO:0010033 response to organic substance +GO:0010181 FMN binding +GO:0015031 protein transport +GO:0015035 protein disulfide oxidoreductase activity +GO:0015036 disulfide oxidoreductase activity +GO:0015044 rubredoxin-NAD+ reductase activity +GO:0015049 methane monooxygenase activity +GO:0015074 DNA integration +GO:0015075 ion transmembrane transporter activity +GO:0015079 potassium ion transmembrane transporter activity +GO:0015093 ferrous iron transmembrane transporter activity +GO:0015105 arsenite transmembrane transporter activity +GO:0015128 gluconate transmembrane transporter activity +GO:0015129 lactate transmembrane transporter activity +GO:0015137 citrate transmembrane transporter activity +GO:0015159 polysaccharide transmembrane transporter activity +GO:0015204 urea transmembrane transporter activity +GO:0015205 nucleobase transmembrane transporter activity +GO:0015232 heme transporter activity +GO:0015288 porin activity +GO:0015299 solute:hydrogen antiporter activity +GO:0015343 siderophore-iron transmembrane transporter activity +GO:0015385 sodium:hydrogen antiporter activity +GO:0015423 maltose-transporting ATPase activity +GO:0015446 arsenite transmembrane-transporting ATPase activity +GO:0015450 P-P-bond-hydrolysis-driven protein transmembrane transporter activity +GO:0015556 C4-dicarboxylate transmembrane transporter activity +GO:0015627 type II protein secretion system complex +GO:0015628 protein secretion by the type II secretion system +GO:0015635 short-chain fatty acid transporter activity +GO:0015671 oxygen transport +GO:0015684 ferrous iron transport +GO:0015711 organic anion transport +GO:0015725 gluconate transport +GO:0015727 lactate transport +GO:0015740 C4-dicarboxylate transport +GO:0015746 citrate transport +GO:0015774 polysaccharide transport +GO:0015840 urea transport +GO:0015886 heme transport +GO:0015912 short-chain fatty acid transport +GO:0015934 large ribosomal subunit +GO:0015986 ATP synthesis coupled proton transport +GO:0016002 sulfite reductase activity +GO:0016020 membrane +GO:0016021 integral to membrane +GO:0016034 maleylacetoacetate isomerase activity +GO:0016036 cellular response to phosphate starvation +GO:0016041 glutamate synthase (ferredoxin) activity +GO:0016044 membrane organization and biogenesis +GO:0016051 carbohydrate biosynthetic process +GO:0016071 mRNA metabolic process +GO:0016151 nickel ion binding +GO:0016152 mercury (II) reductase activity +GO:0016153 urocanate hydratase activity +GO:0016154 pyrimidine-nucleoside phosphorylase activity +GO:0016159 muconolactone delta-isomerase activity +GO:0016163 nitrogenase activity +GO:0016207 4-coumarate-CoA ligase activity +GO:0016210 naringenin-chalcone synthase activity +GO:0016223 beta-alanine-pyruvate transaminase activity +GO:0016301 kinase activity +GO:0016310 phosphorylation +GO:0016403 dimethylargininase activity +GO:0016429 tRNA (adenine-N1-)-methyltransferase activity +GO:0016469 proton-transporting two-sector ATPase complex +GO:0016481 negative regulation of transcription +GO:0016491 oxidoreductase activity +GO:0016564 transcription repressor activity +GO:0016566 specific transcriptional repressor activity +GO:0016597 amino acid binding +GO:0016619 malate dehydrogenase (oxaloacetate-decarboxylating) activity +GO:0016621 cinnamoyl-CoA reductase activity +GO:0016630 protochlorophyllide reductase activity +GO:0016740 transferase activity +GO:0016767 geranylgeranyl-diphosphate geranylgeranyltransferase activity +GO:0016779 nucleotidyltransferase activity +GO:0016787 hydrolase activity +GO:0016829 lyase activity +GO:0016830 carbon-carbon lyase activity +GO:0016836 hydro-lyase activity +GO:0016851 magnesium chelatase activity +GO:0016852 sirohydrochlorin cobaltochelatase activity +GO:0016853 isomerase activity +GO:0016887 ATPase activity +GO:0016966 nitric oxide reductase activity +GO:0016984 ribulose-bisphosphate carboxylase activity +GO:0016987 sigma factor activity +GO:0016990 arginine deiminase activity +GO:0016993 precorrin-8X methylmutase activity +GO:0016994 precorrin-6A reductase activity +GO:0016998 cell wall catabolic process +GO:0017004 cytochrome complex assembly +GO:0017038 protein import +GO:0017057 6-phosphogluconolactonase activity +GO:0017061 S-methyl-5-thioadenosine phosphorylase activity +GO:0017103 UTP:galactose-1-phosphate uridylyltransferase activity +GO:0017113 dihydropyrimidine dehydrogenase (NADP+) activity +GO:0017165 dipeptidase E activity +GO:0017168 5-oxoprolinase (ATP-hydrolyzing) activity +GO:0017174 glycine N-methyltransferase activity +GO:0018112 proline racemase activity +GO:0018454 acetoacetyl-CoA reductase activity +GO:0018456 aryl-alcohol dehydrogenase activity +GO:0018468 alcohol dehydrogenase (acceptor) activity +GO:0018479 benzaldehyde dehydrogenase (NAD+) activity +GO:0018480 5-carboxymethyl-2-hydroxymuconic-semialdehyde dehydrogenase activity +GO:0018485 salicylaldehyde dehydrogenase activity +GO:0018489 vanillate monooxygenase activity +GO:0018492 carbon-monoxide dehydrogenase (acceptor) activity +GO:0018493 formylmethanofuran dehydrogenase activity +GO:0018509 cis-2,3-dihydrobiphenyl-2,3-diol dehydrogenase activity +GO:0018522 benzoyl-CoA reductase activity +GO:0018537 coenzyme F420-dependent N5,N10-methenyltetrahydromethanopterin reductase activity +GO:0018551 hydrogensulfite reductase activity +GO:0018576 catechol 1,2-dioxygenase activity +GO:0018577 catechol 2,3-dioxygenase activity +GO:0018578 protocatechuate 3,4-dioxygenase activity +GO:0018579 protocatechuate 4,5-dioxygenase activity +GO:0018583 biphenyl-2,3-diol 1,2-dioxygenase activity +GO:0018620 phthalate 4,5-dioxygenase activity +GO:0018623 benzoate 1,2-dioxygenase activity +GO:0018658 salicylate 1-monooxygenase activity +GO:0018659 4-hydroxybenzoate 3-monooxygenase activity +GO:0018660 4-hydroxyphenylacetate 3-monooxygenase activity +GO:0018685 alkane 1-monooxygenase activity +GO:0018687 biphenyl 2,3-dioxygenase activity +GO:0018695 4-cresol dehydrogenase (hydroxylating) activity +GO:0018759 methenyltetrahydromethanopterin cyclohydrolase activity +GO:0018775 2-hydroxymuconate-semialdehyde hydrolase activity +GO:0018796 4,5-dihydroxyphthalate decarboxylase activity +GO:0018801 glutaconyl-CoA decarboxylase activity +GO:0018836 alkylmercury lyase activity +GO:0018849 muconate cycloisomerase activity +GO:0018858 benzoate-CoA ligase activity +GO:0019008 molybdopterin synthase complex +GO:0019028 viral capsid +GO:0019133 choline monooxygenase activity +GO:0019134 glucosamine-1-phosphate N-acetyltransferase activity +GO:0019143 3-deoxy-manno-octulosonate-8-phosphatase activity +GO:0019145 aminobutyraldehyde dehydrogenase activity +GO:0019150 D-ribulokinase activity +GO:0019164 pyruvate synthase activity +GO:0019165 thiamin kinase activity +GO:0019290 siderophore biosynthetic process +GO:0019344 cysteine biosynthetic process +GO:0019350 teichoic acid biosynthetic process +GO:0019538 protein metabolic process +GO:0019627 urea metabolic process +GO:0019836 hemolysis by symbiont of host red blood cells +GO:0019861 flagellum +GO:0019865 immunoglobulin binding +GO:0019867 outer membrane +GO:0020037 heme binding +GO:0030001 metal ion transport +GO:0030058 amine dehydrogenase activity +GO:0030060 L-malate dehydrogenase activity +GO:0030151 molybdenum ion binding +GO:0030234 enzyme regulator activity +GO:0030246 carbohydrate binding +GO:0030268 methylenetetrahydromethanopterin dehydrogenase activity +GO:0030269 tetrahydromethanopterin S-methyltransferase activity +GO:0030270 formylmethanofuran-tetrahydromethanopterin N-formyltransferase activity +GO:0030272 5-formyltetrahydrofolate cyclo-ligase activity +GO:0030409 glutamate formimidoyltransferase activity +GO:0030412 formimidoyltetrahydrofolate cyclodeaminase activity +GO:0030429 kynureninase activity +GO:0030528 transcription regulator activity +GO:0030529 ribonucleoprotein complex +GO:0030604 1-deoxy-D-xylulose-5-phosphate reductoisomerase activity +GO:0030655 beta-lactam antibiotic catabolic process +GO:0030699 glycine reductase activity +GO:0030729 acetoacetate-CoA ligase activity +GO:0030788 precorrin-2 C20-methyltransferase activity +GO:0030798 trans-aconitate 2-methyltransferase activity +GO:0030976 thiamin pyrophosphate binding +GO:0031071 cysteine desulfurase activity +GO:0031072 heat shock protein binding +GO:0031176 endo-1,4-beta-xylanase activity +GO:0031216 neopullulanase activity +GO:0031219 levanase activity +GO:0042132 fructose-bisphosphatase activity +GO:0042254 ribosome biogenesis and assembly +GO:0042279 nitrite reductase (cytochrome, ammonia-forming) activity +GO:0042286 glutamate-1-semialdehyde 2,1-aminomutase activity +GO:0042410 6-carboxyhexanoate-CoA ligase activity +GO:0042586 peptide deformylase activity +GO:0042597 periplasmic space +GO:0042619 poly-hydroxybutyrate biosynthetic process +GO:0042773 ATP synthesis coupled electron transport +GO:0042803 protein homodimerization activity +GO:0042972 licheninase activity +GO:0043064 flagellum organization and biogenesis +GO:0043115 precorrin-2 dehydrogenase activity +GO:0043169 cation binding +GO:0043234 protein complex +GO:0043365 [formate-C-acetyltransferase]-activating enzyme activity +GO:0043565 sequence-specific DNA binding +GO:0044237 cellular metabolic process +GO:0044267 cellular protein metabolic process +GO:0045127 N-acetylglucosamine kinase activity +GO:0045135 poly(beta-D-mannuronate) lyase activity +GO:0045300 acyl-[acyl-carrier-protein] desaturase activity +GO:0045449 regulation of transcription +GO:0045454 cell redox homeostasis +GO:0045551 cinnamyl-alcohol dehydrogenase activity +GO:0045552 dihydrokaempferol 4-reductase activity +GO:0046026 precorrin-4 C11-methyltransferase activity +GO:0046316 gluconokinase activity +GO:0046405 glycerol dehydratase activity +GO:0046406 magnesium protoporphyrin IX methyltransferase activity +GO:0046421 methylisocitrate lyase activity +GO:0046509 1,2-diacylglycerol 3-beta-galactosyltransferase activity +GO:0046522 S-methyl-5-thioribose kinase activity +GO:0046523 S-methyl-5-thioribose-1-phosphate isomerase activity +GO:0046526 D-xylulose reductase activity +GO:0046556 alpha-N-arabinofuranosidase activity +GO:0046558 arabinan endo-1,5-alpha-L-arabinosidase activity +GO:0046677 response to antibiotic +GO:0046688 response to copper ion +GO:0046820 4-amino-4-deoxychorismate synthase activity +GO:0046872 metal ion binding +GO:0046917 triphosphoribosyl-dephospho-CoA synthase activity +GO:0046933 hydrogen ion transporting ATP synthase activity, rotational mechanism +GO:0046961 hydrogen ion transporting ATPase activity, rotational mechanism +GO:0046983 protein dimerization activity +GO:0047042 3-alpha-hydroxysteroid dehydrogenase (B-specific) activity +GO:0047046 homoisocitrate dehydrogenase activity +GO:0047051 D-lactate dehydrogenase (cytochrome c-553) activity +GO:0047100 glyceraldehyde-3-phosphate dehydrogenase (NADP+) (phosphorylating) activity +GO:0047112 pyruvate oxidase activity +GO:0047121 isoquinoline 1-oxidoreductase activity +GO:0047125 delta1-piperideine-2-carboxylate reductase activity +GO:0047130 saccharopine dehydrogenase (NADP+, L-lysine-forming) activity +GO:0047131 saccharopine dehydrogenase (NAD+, L-glutamate-forming) activity +GO:0047134 protein-disulfide reductase activity +GO:0047150 betaine-homocysteine S-methyltransferase activity +GO:0047154 methylmalonyl-CoA carboxytransferase activity +GO:0047200 tetrahydrodipicolinate N-acetyltransferase activity +GO:0047244 N-acetylglucosaminyldiphosphoundecaprenol N-acetyl-beta-D-mannosaminyltransferase activity +GO:0047265 poly(glycerol-phosphate) alpha-glucosyltransferase activity +GO:0047280 nicotinamide phosphoribosyltransferase activity +GO:0047286 NAD+-diphthamide ADP-ribosyltransferase activity +GO:0047307 diaminobutyrate-pyruvate transaminase activity +GO:0047330 polyphosphate-glucose phosphotransferase activity +GO:0047334 diphosphate-fructose-6-phosphate 1-phosphotransferase activity +GO:0047348 glycerol-3-phosphate cytidylyltransferase activity +GO:0047349 D-ribitol-5-phosphate cytidylyltransferase activity +GO:0047355 CDP-glycerol glycerophosphotransferase activity +GO:0047360 undecaprenyl-phosphate galactose phosphotransferase activity +GO:0047372 acylglycerol lipase activity +GO:0047423 N-methylhydantoinase (ATP-hydrolyzing) activity +GO:0047434 indolepyruvate decarboxylase activity +GO:0047437 4-oxalocrotonate decarboxylase activity +GO:0047441 5-dehydro-2-deoxyphosphogluconate aldolase activity +GO:0047448 5-dehydro-4-deoxyglucarate dehydratase activity +GO:0047456 2-methylisocitrate dehydratase activity +GO:0047465 N-acylglucosamine-6-phosphate 2-epimerase activity +GO:0047470 (1,4)-alpha-D-glucan 1-alpha-D-glucosylmutase activity +GO:0047472 3-carboxy-cis,cis-muconate cycloisomerase activity +GO:0047473 D-alanine-poly(phosphoribitol) ligase activity +GO:0047474 long-chain-fatty-acid-luciferin-component ligase activity +GO:0047475 phenylacetate-CoA ligase activity +GO:0047480 UDP-N-acetylmuramoyl-tripeptide-D-alanyl-D-alanine ligase activity +GO:0047516 1,3-propanediol dehydrogenase activity +GO:0047519 quinate dehydrogenase (pyrroloquinoline-quinone) activity +GO:0047536 2-aminoadipate transaminase activity +GO:0047547 2-methylcitrate dehydratase activity +GO:0047553 2-oxoglutarate synthase activity +GO:0047569 3-oxoadipate CoA-transferase activity +GO:0047570 3-oxoadipate enol-lactonase activity +GO:0047575 4-carboxymuconolactone decarboxylase activity +GO:0047588 5-aminopentanamidase activity +GO:0047589 5-aminovalerate transaminase activity +GO:0047590 5-dehydro-2-deoxygluconokinase activity +GO:0047605 acetolactate decarboxylase activity +GO:0047631 ADP-ribose diphosphatase activity +GO:0047632 agmatine deiminase activity +GO:0047646 alkanal monooxygenase (FMN-linked) activity +GO:0047652 allantoate deiminase activity +GO:0047653 allantoin racemase activity +GO:0047656 alpha,alpha-trehalose phosphorylase activity +GO:0047686 arylsulfate sulfotransferase activity +GO:0047702 beta-lysine 5,6-aminomutase activity +GO:0047733 CDP-glucose 4,6-dehydratase activity +GO:0047753 choline-sulfatase activity +GO:0047761 butyrate kinase activity +GO:0047810 D-alanine transaminase activity +GO:0047813 D-arabinitol 4-dehydrogenase activity +GO:0047841 dehydrogluconokinase activity +GO:0047850 diaminopimelate dehydrogenase activity +GO:0047878 erythritol kinase activity +GO:0047905 fructose-6-phosphate phosphoketolase activity +GO:0047919 GDP-mannose 6-dehydrogenase activity +GO:0047922 gentisate 1,2-dioxygenase activity +GO:0047929 gluconate dehydratase activity +GO:0047936 glucose 1-dehydrogenase activity +GO:0047949 glutarate-semialdehyde dehydrogenase activity +GO:0047952 glycerol-3-phosphate dehydrogenase [NAD(P)+] activity +GO:0047985 hydrogen dehydrogenase activity +GO:0047989 hydroxybutyrate-dimer hydrolase activity +GO:0048037 cofactor binding +GO:0048307 ferredoxin-nitrite reductase activity +GO:0048472 threonine-phosphate decarboxylase activity +GO:0048529 magnesium-protoporphyrin IX monomethyl ester (oxidative) cyclase activity +GO:0050049 leucine dehydrogenase activity +GO:0050053 levansucrase activity +GO:0050062 long-chain-fatty-acyl-CoA reductase activity +GO:0050066 lysine 2,3-aminomutase activity +GO:0050067 lysine 2-monooxygenase activity +GO:0050076 maleate isomerase activity +GO:0050081 maltose-6'-phosphate glucosidase activity +GO:0050082 maltose phosphorylase activity +GO:0050083 malyl-CoA lyase activity +GO:0050112 inositol 2-dehydrogenase activity +GO:0050113 inositol oxygenase activity +GO:0050114 myo-inosose-2 dehydratase activity +GO:0050118 N-acetyldiaminopimelate deacetylase activity +GO:0050129 N-formylglutamate deformylase activity +GO:0050136 NADH dehydrogenase (quinone) activity +GO:0050144 nucleoside deoxyribosyltransferase activity +GO:0050182 phosphate butyryltransferase activity +GO:0050193 phosphoketolase activity +GO:0050215 propanediol dehydratase activity +GO:0050218 propionate-CoA ligase activity +GO:0050242 pyruvate, phosphate dikinase activity +GO:0050255 ribitol 2-dehydrogenase activity +GO:0050262 ribosylnicotinamide kinase activity +GO:0050278 sedoheptulose-bisphosphatase activity +GO:0050281 serine-glyoxylate transaminase activity +GO:0050304 nitrous-oxide reductase activity +GO:0050311 sulfite reductase (ferredoxin) activity +GO:0050334 thiaminase activity +GO:0050342 tocopherol O-methyltransferase activity +GO:0050361 tryptophan 2-monooxygenase activity +GO:0050380 undecaprenyl-diphosphatase activity +GO:0050415 formimidoylglutamase activity +GO:0050416 formimidoylglutamate deiminase activity +GO:0050421 nitrite reductase (NO-forming) activity +GO:0050440 2-methylcitrate synthase activity +GO:0050454 coenzyme F420 hydrogenase activity +GO:0050462 N-acetylneuraminate synthase activity +GO:0050480 imidazolonepropionase activity +GO:0050501 hyaluronan synthase activity +GO:0050503 trehalose 6-phosphate phosphorylase activity +GO:0050511 undecaprenyldiphospho-muramoylpentapeptide beta-N-acetylglucosaminyltransferase activity +GO:0050515 4-(cytidine 5'-diphospho)-2-C-methyl-D-erythritol kinase activity +GO:0050518 2-C-methyl-D-erythritol 4-phosphate cytidylyltransferase activity +GO:0050519 holo-citrate lyase synthase activity +GO:0050524 coenzyme-B sulfoethylthiotransferase activity +GO:0050532 2-phosphosulfolactate phosphatase activity +GO:0050545 sulfopyruvate decarboxylase activity +GO:0050570 4-hydroxythreonine-4-phosphate dehydrogenase activity +GO:0050572 L-idonate 5-dehydrogenase activity +GO:0050577 GDP-L-fucose synthase activity +GO:0050578 (R)-2-hydroxyacid dehydrogenase activity +GO:0050617 15,16-dihydrobiliverdin:ferredoxin oxidoreductase activity +GO:0050618 phycoerythrobilin:ferredoxin oxidoreductase activity +GO:0050620 phycocyanobilin:ferredoxin oxidoreductase activity +GO:0050626 trimethylamine-N-oxide reductase (cytochrome c) activity +GO:0050660 FAD binding +GO:0050661 NADP binding +GO:0050662 coenzyme binding +GO:0050695 benzoylformate decarboxylase activity +GO:0050920 regulation of chemotaxis +GO:0051082 unfolded protein binding +GO:0051085 chaperone cofactor-dependent protein folding +GO:0051087 chaperone binding +GO:0051258 protein polymerization +GO:0051262 protein tetramerization +GO:0051266 sirohydrochlorin ferrochelatase activity +GO:0051276 chromosome organization and biogenesis +GO:0051301 cell division +GO:0051745 4-hydroxy-3-methylbut-2-en-1-yl diphosphate reductase activity +GO:0051911 Methanosarcina-phenazine hydrogenase activity +GO:0051912 CoB--CoM heterodisulfide reductase activity +GO:0051989 coproporphyrinogen dehydrogenase activity diff --git a/tests/example_output/ref_db/ontologies/path.txt b/tests/example_output/ref_db/ontologies/path.txt new file mode 100644 index 0000000..1813cff --- /dev/null +++ b/tests/example_output/ref_db/ontologies/path.txt @@ -0,0 +1,146 @@ +00010 Glycolysis / Gluconeogenesis +00020 Citrate cycle (TCA cycle) +00030 Pentose phosphate pathway +00040 Pentose and glucuronate interconversions +00051 Fructose and mannose metabolism +00052 Galactose metabolism +00053 Ascorbate and aldarate metabolism +00061 Fatty acid biosynthesis +00062 Fatty acid elongation in mitochondria +00071 Fatty acid metabolism +00072 Synthesis and degradation of ketone bodies +00100 Steroid biosynthesis +00120 Primary bile acid biosynthesis +00121 Secondary bile acid biosynthesis +00130 Ubiquinone and other terpenoid-quinone biosynthesis +00140 C21-Steroid hormone metabolism +00190 Oxidative phosphorylation +00195 Photosynthesis +00196 Photosynthesis - antenna proteins +00230 Purine metabolism +00231 Puromycin biosynthesis +00232 Caffeine metabolism +00240 Pyrimidine metabolism +00250 Alanine, aspartate and glutamate metabolism +00253 Tetracycline biosynthesis +00260 Glycine, serine and threonine metabolism +00270 Cysteine and methionine metabolism +00280 Valine, leucine and isoleucine degradation +00281 Geraniol degradation +00290 Valine, leucine and isoleucine biosynthesis +00300 Lysine biosynthesis +00310 Lysine degradation +00311 Penicillin and cephalosporin biosynthesis +00312 beta-Lactam resistance +00330 Arginine and proline metabolism +00331 Clavulanic acid biosynthesis +00340 Histidine metabolism +00350 Tyrosine metabolism +00351 1,1,1-Trichloro-2,2-bis(4-chlorophenyl)ethane (DDT) degradation +00360 Phenylalanine metabolism +00361 gamma-Hexachlorocyclohexane degradation +00362 Benzoate degradation via hydroxylation +00363 Bisphenol A degradation +00364 Fluorobenzoate degradation +00380 Tryptophan metabolism +00400 Phenylalanine, tyrosine and tryptophan biosynthesis +00401 Novobiocin biosynthesis +00410 beta-Alanine metabolism +00430 Taurine and hypotaurine metabolism +00440 Phosphonate and phosphinate metabolism +00450 Selenoamino acid metabolism +00460 Cyanoamino acid metabolism +00471 D-Glutamine and D-glutamate metabolism +00472 D-Arginine and D-ornithine metabolism +00473 D-Alanine metabolism +00480 Glutathione metabolism +00500 Starch and sucrose metabolism +00510 N-Glycan biosynthesis +00512 O-Glycan biosynthesis +00513 High-mannose type N-glycan biosynthesis +00520 Amino sugar and nucleotide sugar metabolism +00521 Streptomycin biosynthesis +00522 Biosynthesis of 12-, 14- and 16-membered macrolides +00523 Polyketide sugar unit biosynthesis +00531 Glycosaminoglycan degradation +00532 Chondroitin sulfate biosynthesis +00534 Heparan sulfate biosynthesis +00540 Lipopolysaccharide biosynthesis +00550 Peptidoglycan biosynthesis +00561 Glycerolipid metabolism +00562 Inositol phosphate metabolism +00563 Glycosylphosphatidylinositol(GPI)-anchor biosynthesis +00564 Glycerophospholipid metabolism +00565 Ether lipid metabolism +00590 Arachidonic acid metabolism +00591 Linoleic acid metabolism +00592 alpha-Linolenic acid metabolism +00600 Sphingolipid metabolism +00601 Glycosphingolipid biosynthesis - lacto and neolacto series +00603 Glycosphingolipid biosynthesis - globo series +00604 Glycosphingolipid biosynthesis - ganglio series +00620 Pyruvate metabolism +00621 Biphenyl degradation +00622 Toluene and xylene degradation +00623 2,4-Dichlorobenzoate degradation +00624 1- and 2-Methylnaphthalene degradation +00625 Tetrachloroethene degradation +00626 Naphthalene and anthracene degradation +00627 1,4-Dichlorobenzene degradation +00630 Glyoxylate and dicarboxylate metabolism +00633 Trinitrotoluene degradation +00640 Propanoate metabolism +00642 Ethylbenzene degradation +00643 Styrene degradation +00650 Butanoate metabolism +00660 C5-Branched dibasic acid metabolism +00670 One carbon pool by folate +00680 Methane metabolism +00710 Carbon fixation in photosynthetic organisms +00720 Reductive carboxylate cycle (CO2 fixation) +00730 Thiamine metabolism +00740 Riboflavin metabolism +00750 Vitamin B6 metabolism +00760 Nicotinate and nicotinamide metabolism +00770 Pantothenate and CoA biosynthesis +00780 Biotin metabolism +00790 Folate biosynthesis +00791 Atrazine degradation +00830 Retinol metabolism +00860 Porphyrin and chlorophyll metabolism +00900 Terpenoid backbone biosynthesis +00901 Indole alkaloid biosynthesis +00902 Monoterpenoid biosynthesis +00903 Limonene and pinene degradation +00904 Diterpenoid biosynthesis +00905 Brassinosteroid biosynthesis +00906 Carotenoid biosynthesis +00908 Zeatin biosynthesis +00909 Sesquiterpenoid biosynthesis +00910 Nitrogen metabolism +00920 Sulfur metabolism +00930 Caprolactam degradation +00940 Phenylpropanoid biosynthesis +00941 Flavonoid biosynthesis +00942 Anthocyanin biosynthesis +00943 Isoflavonoid biosynthesis +00944 Flavone and flavonol biosynthesis +00945 Stilbenoid, diarylheptanoid and gingerol biosynthesis +00950 Isoquinoline alkaloid biosynthesis +00960 Tropane, piperidine and pyridine alkaloid biosynthesis +00965 Betalain biosynthesis +00970 Aminoacyl-tRNA biosynthesis +00980 Metabolism of xenobiotics by cytochrome P450 +00981 Insect hormone biosynthesis +00982 Drug metabolism - cytochrome P450 +00983 Drug metabolism - other enzymes +01040 Biosynthesis of unsaturated fatty acids +01051 Biosynthesis of ansamycins +01053 Biosynthesis of siderophore group nonribosomal peptides +01055 Biosynthesis of vancomycin group antibiotics +01056 Biosynthesis of type II polyketide backbone +01057 Biosynthesis of type II polyketide products +01058 Acridone alkaloid biosynthesis +04070 Phosphatidylinositol signaling system +04150 mTOR signaling pathway +04660 T cell receptor signaling pathway diff --git a/tests/example_output/ref_db/pan_genomes/Salmonella_enterica_58156/centroid_functions.txt.gz b/tests/example_output/ref_db/pan_genomes/Salmonella_enterica_58156/centroid_functions.txt.gz new file mode 100644 index 0000000..c712d1e Binary files /dev/null and b/tests/example_output/ref_db/pan_genomes/Salmonella_enterica_58156/centroid_functions.txt.gz differ diff --git a/tests/example_output/ref_db/pan_genomes/Salmonella_enterica_58156/centroids.ffn.gz b/tests/example_output/ref_db/pan_genomes/Salmonella_enterica_58156/centroids.ffn.gz new file mode 100644 index 0000000..6d89391 Binary files /dev/null and b/tests/example_output/ref_db/pan_genomes/Salmonella_enterica_58156/centroids.ffn.gz differ diff --git a/tests/example_output/ref_db/pan_genomes/Salmonella_enterica_58156/gene_info.txt.gz b/tests/example_output/ref_db/pan_genomes/Salmonella_enterica_58156/gene_info.txt.gz new file mode 100644 index 0000000..db2387e Binary files /dev/null and b/tests/example_output/ref_db/pan_genomes/Salmonella_enterica_58156/gene_info.txt.gz differ diff --git a/tests/example_output/snps/log.txt b/tests/example_output/snps/log.txt new file mode 100644 index 0000000..135f612 --- /dev/null +++ b/tests/example_output/snps/log.txt @@ -0,0 +1,43 @@ + +MIDAS: Metagenomic Intra-species Diversity Analysis System +version 1.3.0; github.com/snayfach/MIDAS +Copyright (C) 2015-2016 Stephen Nayfach +Freely distributed under the GNU General Public License (GPLv3) + +===========Parameters=========== +Command: /usr/midas/MIDAS-1.3.2/scripts/run_midas.py snps /share/SRR1297187_1.midas -1 /share/SRR1297187_1.fastq.gz -n 100000 -t 4 --remove_temp -d /share/midas_db_v1.2 +Script: run_midas.py snps +Database: /share/midas_db_v1.2 +Output directory: /share/SRR1297187_1.midas +Remove temporary files: True +Pipeline options: + build bowtie2 database of genomes + align reads to bowtie2 genome database + use samtools to generate pileups and count variants +Database options: + include all species with >=3.0X genome coverage +Read alignment options: + input reads (unpaired): /share/SRR1297187_1.fastq.gz + alignment speed/sensitivity: very-sensitive + alignment mode: global + number of reads to use from input: 100000 + number of threads for database search: 4 +SNP calling options: + minimum alignment percent identity: 94.0 + minimum mapping quality score: 20 + minimum base quality score: 30 + minimum read quality score: 20 + minimum alignment coverage of reads: 0.75 + trim 0 base-pairs from 3'/right end of read +================================ + +Building database of representative genomes +command: /usr/midas/MIDAS-1.3.2/bin/Linux/bowtie2-build --threads 4 /share/SRR1297187_1.midas/snps/temp/genomes.fa /share/SRR1297187_1.midas/snps/temp/genomes + +Mapping reads to representative genomes +command: /usr/midas/MIDAS-1.3.2/bin/Linux/bowtie2 --no-unal -x /share/SRR1297187_1.midas/snps/temp/genomes -u 100000 --very-sensitive --threads 4 -q -U /share/SRR1297187_1.fastq.gz | /usr/midas/MIDAS-1.3.2/bin/Linux/samtools view -b - --threads 4 | /usr/midas/MIDAS-1.3.2/bin/Linux/samtools sort - --threads 4 -o /share/SRR1297187_1.midas/snps/temp/genomes.bam + +Indexing bamfile +command: /usr/midas/MIDAS-1.3.2/bin/Linux/samtools index /share/SRR1297187_1.midas/snps/temp/genomes.bam + +Counting alleles diff --git a/tests/example_output/snps/output/Salmonella_enterica_58156.snps.gz b/tests/example_output/snps/output/Salmonella_enterica_58156.snps.gz new file mode 100644 index 0000000..7eac287 Binary files /dev/null and b/tests/example_output/snps/output/Salmonella_enterica_58156.snps.gz differ diff --git a/tests/example_output/snps/readme.txt b/tests/example_output/snps/readme.txt new file mode 100644 index 0000000..a494080 --- /dev/null +++ b/tests/example_output/snps/readme.txt @@ -0,0 +1,43 @@ + +Description of output files and file formats from 'run_midas.py snps' + +Output files +############ +output + directory of per-species output files + files are tab-delimited, gzip-compressed, with header + naming convention of each file is: {SPECIES_ID}.snps.gz +species.txt + list of species_ids included in local database +summary.txt + tab-delimited with header + summarizes alignment results per-species +log.txt + log file containing parameters used +temp + directory of intermediate files + run with `--remove_temp` to remove these files + +Output formats +############ +output/{SPECIES_ID}.snps.gz + ref_id: id of reference scaffold/contig/genome + ref_pos: position in ref_id (1-indexed) + ref_allele: reference nucleotide + depth: number of mapped reads + count_a: count of A allele + count_c: count of C allele + count_g: count of G allele + count_t: count of T allele + +summary.txt + species_id: species id + genome_length: number of base pairs in representative genome + covered_bases: number of reference sites with at least 1 mapped read + fraction_covered: proportion of reference sites with at least 1 mapped read + mean_coverage: average read-depth across reference sites with at least 1 mapped read + aligned_reads: number of aligned reads BEFORE quality filtering + mapped_reads: number of aligned reads AFTER quality filtering + +Additional information for each species can be found in the reference database: + /share/midas_db_v1.2/rep_genomes diff --git a/tests/example_output/snps/species.txt b/tests/example_output/snps/species.txt new file mode 100644 index 0000000..ddb360a --- /dev/null +++ b/tests/example_output/snps/species.txt @@ -0,0 +1 @@ +Salmonella_enterica_58156 diff --git a/tests/example_output/snps/summary.txt b/tests/example_output/snps/summary.txt new file mode 100644 index 0000000..d2caee7 --- /dev/null +++ b/tests/example_output/snps/summary.txt @@ -0,0 +1,2 @@ +species_id genome_length covered_bases fraction_covered mean_coverage aligned_reads mapped_reads +Salmonella_enterica_58156 4685779 3917368 0.836012112394 3.97788515146 85419 79852 diff --git a/tests/example_output/species/log.txt b/tests/example_output/species/log.txt new file mode 100644 index 0000000..4e03fbc --- /dev/null +++ b/tests/example_output/species/log.txt @@ -0,0 +1,25 @@ + +MIDAS: Metagenomic Intra-species Diversity Analysis System +version 1.3.0; github.com/snayfach/MIDAS +Copyright (C) 2015-2016 Stephen Nayfach +Freely distributed under the GNU General Public License (GPLv3) + +===========Parameters=========== +Command: /usr/midas/MIDAS-1.3.2/scripts/run_midas.py species /share/SRR1297187_1.midas -1 /share/SRR1297187_1.fastq.gz -n 100000 -t 4 --remove_temp -d /share/midas_db_v1.2 +Script: run_midas.py species +Database: /share/midas_db_v1.2 +Output directory: /share/SRR1297187_1.midas +Input reads (unpaired): /share/SRR1297187_1.fastq.gz +Remove temporary files: True +Word size for database search: 28 +Minimum mapping alignment coverage: 0.75 +Number of reads to use from input: 100000 +Number of threads for database search: 4 +================================ + +Aligning reads to marker-genes database +command: python /usr/midas/MIDAS-1.3.2/midas/run/stream_seqs.py -1 /share/SRR1297187_1.fastq.gz -n 100000 2> /share/SRR1297187_1.midas/species/temp/read_count.txt | /usr/midas/MIDAS-1.3.2/bin/Linux/hs-blastn align -word_size 28 -query /dev/stdin -db /share/midas_db_v1.2/marker_genes/phyeco.fa -outfmt 6 -num_threads 4 -out /share/SRR1297187_1.midas/species/temp/alignments.m8 -evalue 1e-3 + +Classifying reads + +Estimating species abundance diff --git a/tests/example_output/species/readme.txt b/tests/example_output/species/readme.txt new file mode 100644 index 0000000..a56812d --- /dev/null +++ b/tests/example_output/species/readme.txt @@ -0,0 +1,25 @@ + +Description of output files and file formats from 'run_midas.py species' + +Output files +############ +species_profile.txt + tab-delimited with header + each line contains the abundance values for 1 species (5,952 total species) + sorted by decreasing relative abundance +log.txt + log file containing parameters used +temp + directory of intermediate files + run with `--remove_temp` to remove these files + +Output formats +############ +species_profile.txt + species_id: species identifier + count_reads: number of reads mapped to marker genes + coverage: estimated genome-coverage (i.e. read-depth) of species in metagenome + relative_abundance: estimated relative abundance of species in metagenome + +Additional information for each species can be found in the reference database: + /share/midas_db_v1.2/marker_genes diff --git a/tests/example_output/species/species_profile.txt b/tests/example_output/species/species_profile.txt new file mode 100644 index 0000000..0f841be --- /dev/null +++ b/tests/example_output/species/species_profile.txt @@ -0,0 +1,5953 @@ +species_id count_reads coverage relative_abundance +Salmonella_enterica_58156 147 3.13765227021 0.815123262907 +Salmonella_enterica_58266 27 0.558183718058 0.145009228041 +Salmonella_enterica_53987 7 0.139110604333 0.0361392149109 +Klebsiella_oxytoca_56762 1 0.00539967216276 0.00140276806124 +Xanthomonas_campestris_57487 1 0.00895164267257 0.00232552607978 +Yaniella_halotolerans_59132 0 0.0 0.0 +Thermodesulfovibrio_thiophilus_59110 0 0.0 0.0 +Bradyrhizobium_sp_59283 0 0.0 0.0 +Rhodopseudomonas_palustris_61217 0 0.0 0.0 +Porphyromonas_sp_60792 0 0.0 0.0 +Mesorhizobium_sp_61369 0 0.0 0.0 +Haemophilus_influenzae_58001 0 0.0 0.0 +Arcobacter_sp_55051 0 0.0 0.0 +Rhizobium_leguminosarum_57834 0 0.0 0.0 +Halomonas_sp_60361 0 0.0 0.0 +Coprothermobacter_proteolyticus_61171 0 0.0 0.0 +Streptococcus_sobrinus_56802 0 0.0 0.0 +Magnetospirillum_magneticum_61293 0 0.0 0.0 +Actinobacillus_pleuropneumoniae_57270 0 0.0 0.0 +Cronobacter_malonaticus_56861 0 0.0 0.0 +Selenomonas_ruminantium_59914 0 0.0 0.0 +Anaerosalibacter_sp_60200 0 0.0 0.0 +Bacillus_vireti_59178 0 0.0 0.0 +Polaromonas_naphthalenivorans_61338 0 0.0 0.0 +Atopobium_rimae_61781 0 0.0 0.0 +Bradyrhizobium_japonicum_58400 0 0.0 0.0 +Caminibacter_mediatlanticus_61405 0 0.0 0.0 +Exiguobacterium_sp_60679 0 0.0 0.0 +Lactococcus_chungangensis_58904 0 0.0 0.0 +Nocardia_sp_59340 0 0.0 0.0 +Deinococcus_radiodurans_45653 0 0.0 0.0 +Mesorhizobium_sp_60010 0 0.0 0.0 +Aquimarina_muelleri_58703 0 0.0 0.0 +Salmonella_bongori_55351 0 0.0 0.0 +Caulobacter_segnis_61668 0 0.0 0.0 +Methylotenera_versatilis_62070 0 0.0 0.0 +Bifidobacterium_thermacidophilum_58040 0 0.0 0.0 +Exiguobacterium_sp_57070 0 0.0 0.0 +Peptostreptococcaceae_bacterium_60690 0 0.0 0.0 +Gardnerella_vaginalis_58140 0 0.0 0.0 +Orbaceae_bacterium_60326 0 0.0 0.0 +Bacillus_endophyticus_54286 0 0.0 0.0 +Acetobacter_nitrogenifigens_58657 0 0.0 0.0 +Pseudomonas_chloritidismutans_57851 0 0.0 0.0 +Pseudomonas_tuomuerensis_55970 0 0.0 0.0 +Flavobacterium_sp_60019 0 0.0 0.0 +Gamma_proteobacterium_62246 0 0.0 0.0 +Mycobacterium_avium_58507 0 0.0 0.0 +Hippea_maritima_62267 0 0.0 0.0 +Aggregatibacter_aphrophilus_58143 0 0.0 0.0 +Reinekea_blandensis_61207 0 0.0 0.0 +Burkholderia_phytofirmans_61447 0 0.0 0.0 +Tolumonas_auensis_61915 0 0.0 0.0 +Eubacterium_limosum_62476 0 0.0 0.0 +Vibrio_fortis_61007 0 0.0 0.0 +Streptomyces_ruber_33758 0 0.0 0.0 +Methyloversatilis_universalis_62706 0 0.0 0.0 +Hippea_alviniae_62608 0 0.0 0.0 +Bartonella_bovis_58544 0 0.0 0.0 +Comamonas_testosteroni_58338 0 0.0 0.0 +Basilea_psittacipulmonis_58484 0 0.0 0.0 +Methylophilaceae_bacterium_57038 0 0.0 0.0 +Hymenobacter_sp_60321 0 0.0 0.0 +Acholeplasma_modicum_60413 0 0.0 0.0 +Flavobacteria_bacterium_60885 0 0.0 0.0 +Ruegeria_pomeroyi_61060 0 0.0 0.0 +Rhodopirellula_europaea_57936 0 0.0 0.0 +Methylacidiphilum_infernorum_61616 0 0.0 0.0 +Erwinia_tracheiphila_58427 0 0.0 0.0 +Teredinibacter_turnerae_56939 0 0.0 0.0 +Porphyromonadaceae_bacterium_52280 0 0.0 0.0 +Bacillus_subtilis_55718 0 0.0 0.0 +Burkholderia_nodosa_58740 0 0.0 0.0 +Peptoniphilus_rhinitidis_62391 0 0.0 0.0 +Paenibacillus_sp_59613 0 0.0 0.0 +Nitratireductor_indicus_59646 0 0.0 0.0 +Sphingobacterium_sp_60842 0 0.0 0.0 +Streptococcus_parasanguinis_62442 0 0.0 0.0 +Flavobacterium_antarcticum_58606 0 0.0 0.0 +Clostridium_ultunense_52043 0 0.0 0.0 +Sphingopyxis_alaskensis_61226 0 0.0 0.0 +Mariprofundus_ferrooxydans_56677 0 0.0 0.0 +Fluoribacter_dumoffii_52104 0 0.0 0.0 +Lactobacillus_otakiensis_59976 0 0.0 0.0 +Frankia_sp_61340 0 0.0 0.0 +Paracoccus_versutus_61288 0 0.0 0.0 +Actinoplanes_sp_60193 0 0.0 0.0 +Necropsobacter_rosorum_62489 0 0.0 0.0 +Comamonadaceae_bacterium_60823 0 0.0 0.0 +Dickeya_sp_60896 0 0.0 0.0 +Caulobacter_sp_61342 0 0.0 0.0 +Geomicrobium_sp_58004 0 0.0 0.0 +Vibrio_fischeri_58199 0 0.0 0.0 +Serratia_odorifera_62077 0 0.0 0.0 +Streptomyces_virginiae_57925 0 0.0 0.0 +Fischerella_thermalis_62650 0 0.0 0.0 +Pseudomonas_sp_60708 0 0.0 0.0 +Staphylococcus_equorum_54689 0 0.0 0.0 +Clostridium_celatum_61754 0 0.0 0.0 +Pseudomonas_cremoricolorata_59982 0 0.0 0.0 +Sphingobacterium_sp_59627 0 0.0 0.0 +Aminomonas_paucivorans_61873 0 0.0 0.0 +Kocuria_palustris_56547 0 0.0 0.0 +Gordonia_namibiensis_59487 0 0.0 0.0 +Alkalibacterium_sp_59634 0 0.0 0.0 +Ruegeria_sp_60901 0 0.0 0.0 +Ruegeria_sp_60900 0 0.0 0.0 +Streptococcus_suis_58133 0 0.0 0.0 +Enterococcus_gilvus_44054 0 0.0 0.0 +Campylobacter_concisus_59746 0 0.0 0.0 +Helicobacter_pylori_51394 0 0.0 0.0 +Campylobacter_concisus_59748 0 0.0 0.0 +Campylobacter_concisus_59749 0 0.0 0.0 +Carnobacterium_inhibens_56670 0 0.0 0.0 +Geitlerinema_sp_58340 0 0.0 0.0 +Chryseobacterium_sp_44548 0 0.0 0.0 +Halomonas_hydrothermalis_59263 0 0.0 0.0 +Lactobacillus_hayakitensis_59721 0 0.0 0.0 +Pseudomonas_caeni_61697 0 0.0 0.0 +Lachnospiraceae_bacterium_59690 0 0.0 0.0 +Salegentibacter_sp_59799 0 0.0 0.0 +Corynebacterium_humireducens_59600 0 0.0 0.0 +Vibrio_cholerae_57327 0 0.0 0.0 +Bacteroides_thetaiotaomicron_56941 0 0.0 0.0 +Acinetobacter_sp_59499 0 0.0 0.0 +Parachlamydiaceae_bacterium_60084 0 0.0 0.0 +Microbacterium_yannicii_59416 0 0.0 0.0 +Fischerella_sp_59348 0 0.0 0.0 +Fischerella_sp_59349 0 0.0 0.0 +Streptomyces_sp_59965 0 0.0 0.0 +Streptomyces_sp_59964 0 0.0 0.0 +Thioalkalivibrio_sp_56293 0 0.0 0.0 +Lactobacillus_crispatus_56887 0 0.0 0.0 +Ensifer_adhaerens_60480 0 0.0 0.0 +Cronobacter_sp_60724 0 0.0 0.0 +Cyanobacterium_aponinum_62256 0 0.0 0.0 +Oceanimonas_smirnovii_59890 0 0.0 0.0 +Staphylococcus_chromogenes_59592 0 0.0 0.0 +Streptacidiphilus_melanogenes_61471 0 0.0 0.0 +Novosphingobium_nitrogenifigens_62646 0 0.0 0.0 +Geminocystis_herdmanii_59185 0 0.0 0.0 +Polycyclovorans_algicola_60477 0 0.0 0.0 +Bifidobacterium_merycicum_38038 0 0.0 0.0 +Microvirga_aerilata_62082 0 0.0 0.0 +Comamonas_testosteroni_61121 0 0.0 0.0 +Comamonadaceae_bacterium_60618 0 0.0 0.0 +Azospirillum_brasilense_58073 0 0.0 0.0 +Kocuria_rhizophila_61365 0 0.0 0.0 +Clostridium_sulfidigenes_61231 0 0.0 0.0 +Saccharopolyspora_erythraea_48523 0 0.0 0.0 +Thalassobacter_stenotrophicus_43368 0 0.0 0.0 +Clostridium_sp_60707 0 0.0 0.0 +Deinococcus_apachensis_58784 0 0.0 0.0 +Acetobacter_tropicalis_62242 0 0.0 0.0 +Alicyclobacillus_herbarius_58690 0 0.0 0.0 +Clostridium_josui_59974 0 0.0 0.0 +Borrelia_hispanica_60483 0 0.0 0.0 +Aestuariibacter_salexigens_58677 0 0.0 0.0 +Gordonia_terrae_46644 0 0.0 0.0 +Ochrobactrum_intermedium_57339 0 0.0 0.0 +Flavobacterium_saliperosum_60176 0 0.0 0.0 +Marinobacterium_jannaschii_58925 0 0.0 0.0 +Xanthobacter_autotrophicus_62311 0 0.0 0.0 +Accumulibacter_sp_60601 0 0.0 0.0 +Accumulibacter_sp_60602 0 0.0 0.0 +Accumulibacter_sp_60603 0 0.0 0.0 +Accumulibacter_sp_60604 0 0.0 0.0 +Mollicutes_bacterium_60853 0 0.0 0.0 +Accumulibacter_sp_60606 0 0.0 0.0 +Pseudomonas_syringae_58106 0 0.0 0.0 +WWE1_bacterium_45113 0 0.0 0.0 +Fibrobacter_succinogenes_47270 0 0.0 0.0 +Streptomyces_wedmorensis_56899 0 0.0 0.0 +Campylobacter_coli_58237 0 0.0 0.0 +Nitrospira_defluvii_61267 0 0.0 0.0 +Rhodococcus_ruber_58245 0 0.0 0.0 +Sulfurimonas_sp_59343 0 0.0 0.0 +Leptospira_borgpetersenii_56569 0 0.0 0.0 +Cyanothece_sp_62039 0 0.0 0.0 +Actinosporangium_sp_60634 0 0.0 0.0 +Ponticaulis_koreensis_61774 0 0.0 0.0 +Hahella_chejuensis_61306 0 0.0 0.0 +Nocardia_cerradoensis_58045 0 0.0 0.0 +Methylohalobius_crimeensis_59939 0 0.0 0.0 +Vibrio_splendidus_61940 0 0.0 0.0 +Calditerrivibrio_nitroreducens_62303 0 0.0 0.0 +Clostridiales_bacterium_45941 0 0.0 0.0 +Flammeovirga_sp_60300 0 0.0 0.0 +Mycobacterium_rhodesiae_62177 0 0.0 0.0 +Cryptosporangium_arvum_62530 0 0.0 0.0 +Acetobacter_malorum_60951 0 0.0 0.0 +Mobilicoccus_pelagius_58529 0 0.0 0.0 +Citreicella_sp_62296 0 0.0 0.0 +Sphingopyxis_sp_59359 0 0.0 0.0 +Pseudomonas_sp_59230 0 0.0 0.0 +Pseudaminobacter_salicylatoxidans_59410 0 0.0 0.0 +Methylobacter_tundripaludum_58166 0 0.0 0.0 +Dongia_sp_60284 0 0.0 0.0 +Bilophila_wadsworthia_57364 0 0.0 0.0 +Prevotella_melaninogenica_58075 0 0.0 0.0 +Methylophaga_lonarensis_59951 0 0.0 0.0 +Arcobacter_cibarius_60534 0 0.0 0.0 +Chryseobacterium_taiwanense_61336 0 0.0 0.0 +Salinispora_pacifica_57915 0 0.0 0.0 +Helicobacter_pylori_44545 0 0.0 0.0 +Leucobacter_sp_59979 0 0.0 0.0 +Helicobacter_pylori_62683 0 0.0 0.0 +Helicobacter_pylori_62682 0 0.0 0.0 +Helicobacter_pylori_62681 0 0.0 0.0 +Helicobacter_pylori_62680 0 0.0 0.0 +Mycobacterium_tuberculosis_57439 0 0.0 0.0 +Helicobacter_pylori_62684 0 0.0 0.0 +Bacillus_akibai_59729 0 0.0 0.0 +Acinetobacter_ursingii_57496 0 0.0 0.0 +Arthrobacter_sp_58574 0 0.0 0.0 +Marine_actinobacterium_61178 0 0.0 0.0 +Finegoldia_magna_57293 0 0.0 0.0 +Roseivivax_sp_60090 0 0.0 0.0 +Psychrobacter_lutiphocae_59016 0 0.0 0.0 +Bibersteinia_trehalosi_57640 0 0.0 0.0 +Carnobacterium_funditum_60575 0 0.0 0.0 +Pseudomonas_sp_59942 0 0.0 0.0 +Proteocatella_sphenisci_59007 0 0.0 0.0 +Kyrpidia_tusciae_61815 0 0.0 0.0 +Porphyrobacter_cryptus_58998 0 0.0 0.0 +Citrobacter_amalonaticus_54491 0 0.0 0.0 +Chlamydia_psittaci_52935 0 0.0 0.0 +Paenibacillus_mucilaginosus_55060 0 0.0 0.0 +Borrelia_spielmanii_61649 0 0.0 0.0 +Streptococcus_pyogenes_56747 0 0.0 0.0 +Pseudonocardia_dioxanivorans_62092 0 0.0 0.0 +Nocardiopsis_lucentensis_59771 0 0.0 0.0 +Gillisia_sp_62652 0 0.0 0.0 +Dehalococcoides_mccartyi_57615 0 0.0 0.0 +Salimicrobium_sp_59639 0 0.0 0.0 +Bacteroides_sp_38040 0 0.0 0.0 +Pseudomonas_mendocina_57420 0 0.0 0.0 +Oribacterium_sp_60403 0 0.0 0.0 +Thermodesulfobacterium_thermophilum_59109 0 0.0 0.0 +Mesotoga_prima_62054 0 0.0 0.0 +Enterococcus_faecalis_55915 0 0.0 0.0 +Leisingera_sp_60898 0 0.0 0.0 +Leisingera_sp_60899 0 0.0 0.0 +Leisingera_sp_60897 0 0.0 0.0 +Agrobacterium_tumefaciens_61326 0 0.0 0.0 +Emticicia_oligotrophica_62538 0 0.0 0.0 +Pelagibacter_sp_58309 0 0.0 0.0 +Tropheryma_whipplei_53771 0 0.0 0.0 +Streptomyces_galbus_61284 0 0.0 0.0 +Starkeya_novella_61986 0 0.0 0.0 +Thioalkalivibrio_sp_60672 0 0.0 0.0 +Chlorobaculum_parvum_61681 0 0.0 0.0 +Clostridiales_bacterium_58600 0 0.0 0.0 +Gracilibacillus_halophilus_60066 0 0.0 0.0 +Streptacidiphilus_anmyonensis_61466 0 0.0 0.0 +Lactococcus_garvieae_59650 0 0.0 0.0 +Buttiauxella_agrestis_58324 0 0.0 0.0 +Deinococcus_peraridilitoris_62590 0 0.0 0.0 +Acinetobacter_sp_43453 0 0.0 0.0 +Nonlabens_ulvanivorans_56594 0 0.0 0.0 +Chromohalobacter_japonicus_61028 0 0.0 0.0 +Acetivibrio_cellulolyticus_61669 0 0.0 0.0 +Wolbachia_endosymbiont_54269 0 0.0 0.0 +Actinomyces_neuii_62451 0 0.0 0.0 +Bacteroidetes_bacterium_62594 0 0.0 0.0 +Prevotella_sp_61856 0 0.0 0.0 +Rhizobium_sp_60753 0 0.0 0.0 +Terrisporobacter_sp_60894 0 0.0 0.0 +Rhizobium_sp_60754 0 0.0 0.0 +Rhizobium_sp_60755 0 0.0 0.0 +Amycolatopsis_halophila_61910 0 0.0 0.0 +Myroides_injenensis_58332 0 0.0 0.0 +Eikenella_corrodens_58486 0 0.0 0.0 +Granulicoccus_phenolivorans_58872 0 0.0 0.0 +Viridibacillus_arenosi_59621 0 0.0 0.0 +Acinetobacter_calcoaceticus_59553 0 0.0 0.0 +Epilithonimonas_sp_59668 0 0.0 0.0 +Herbaspirillum_seropedicae_62261 0 0.0 0.0 +Streptococcus_parasanguinis_58487 0 0.0 0.0 +Clostridiaceae_bacterium_60908 0 0.0 0.0 +Bacillus_selenatarsenatis_60096 0 0.0 0.0 +Campylobacter_sp_59757 0 0.0 0.0 +Bacillus_niacini_62369 0 0.0 0.0 +Rheinheimera_perlucida_59023 0 0.0 0.0 +Staphylococcus_aureus_56630 0 0.0 0.0 +Nakamurella_multipartita_61612 0 0.0 0.0 +Bradyrhizobium_japonicum_60045 0 0.0 0.0 +Prevotella_sp_59946 0 0.0 0.0 +Pseudonocardia_asaccharolytica_59012 0 0.0 0.0 +Kurthia_sp_60133 0 0.0 0.0 +Sphingobium_sp_59212 0 0.0 0.0 +Ruminococcus_gauvreauii_59033 0 0.0 0.0 +Desulfatirhabdium_butyrativorans_58792 0 0.0 0.0 +Bordetella_petrii_62572 0 0.0 0.0 +Bordetella_petrii_62571 0 0.0 0.0 +Chryseobacterium_daeguense_58752 0 0.0 0.0 +Bifidobacterium_pullorum_60518 0 0.0 0.0 +Actinomyces_johnsonii_57359 0 0.0 0.0 +Phascolarctobacterium_succinatutens_61948 0 0.0 0.0 +Streptomyces_sp_52691 0 0.0 0.0 +Curtobacterium_sp_62628 0 0.0 0.0 +Gamma_proteobacterium_58329 0 0.0 0.0 +Thioalkalivibrio_sp_62239 0 0.0 0.0 +Methylobacter_luteus_58553 0 0.0 0.0 +Marinobacter_lipolyticus_60093 0 0.0 0.0 +Corynebacterium_capitovis_58769 0 0.0 0.0 +Porphyromonas_catoniae_58136 0 0.0 0.0 +Hyphomonas_sp_59485 0 0.0 0.0 +Prevotella_sp_59619 0 0.0 0.0 +Nocardia_sp_60636 0 0.0 0.0 +Thioalkalivibrio_sp_44152 0 0.0 0.0 +Leptospira_alstoni_59577 0 0.0 0.0 +Paludibacterium_yongneupense_58984 0 0.0 0.0 +Parvimonas_micra_57958 0 0.0 0.0 +Spiroplasma_chrysopicola_59873 0 0.0 0.0 +Aeromonas_schubertii_62036 0 0.0 0.0 +Rhodospirillales_bacterium_60287 0 0.0 0.0 +Scytonema_hofmanni_60675 0 0.0 0.0 +Mycobacterium_sp_56261 0 0.0 0.0 +Streptococcus_oralis_59303 0 0.0 0.0 +Legionella_shakespearei_58910 0 0.0 0.0 +Acidocella_facilis_57188 0 0.0 0.0 +Deinococcus_misasensis_58788 0 0.0 0.0 +Leisingera_methylohalidivorans_62704 0 0.0 0.0 +Mastigocoleus_testarum_61352 0 0.0 0.0 +Marinomonas_sp_61203 0 0.0 0.0 +Exiguobacterium_marinum_60363 0 0.0 0.0 +Nonlabens_sediminis_61236 0 0.0 0.0 +Chlamydophila_pneumoniae_54194 0 0.0 0.0 +Ruania_albidiflava_59028 0 0.0 0.0 +Virgibacillus_sp_61463 0 0.0 0.0 +Brevibacillus_agri_54300 0 0.0 0.0 +Rubrivivax_gelatinosus_62645 0 0.0 0.0 +Rhodococcus_fascians_57101 0 0.0 0.0 +Granulicella_mallensis_62118 0 0.0 0.0 +Thioalkalimicrobium_cyclicum_62197 0 0.0 0.0 +Mycobacterium_mageritense_59501 0 0.0 0.0 +Marmoricola_aequoreus_61438 0 0.0 0.0 +Gamma_proteobacterium_59327 0 0.0 0.0 +Desulfovibrio_longus_58817 0 0.0 0.0 +Nitrosococcus_halophilus_61599 0 0.0 0.0 +Weeksella_virosa_62366 0 0.0 0.0 +Prochlorococcus_marinus_47596 0 0.0 0.0 +Acetobacterium_dehalogenans_58472 0 0.0 0.0 +Thermobaculum_terrenum_61722 0 0.0 0.0 +Streptomyces_sp_61316 0 0.0 0.0 +Clostridium_straminisolvens_59990 0 0.0 0.0 +Bacillus_coagulans_56287 0 0.0 0.0 +Desulfovibrio_gigas_44737 0 0.0 0.0 +Coraliomargarita_akajimensis_61869 0 0.0 0.0 +Asticcacaulis_biprosthecum_62188 0 0.0 0.0 +Thioalkalivibrio_sulfidophilus_61437 0 0.0 0.0 +Porphyromonas_crevioricanis_52672 0 0.0 0.0 +Pseudomonas_corrugata_60087 0 0.0 0.0 +Halothermothrix_orenii_61355 0 0.0 0.0 +Pseudomonas_fluorescens_60997 0 0.0 0.0 +Chlorobium_limicola_61129 0 0.0 0.0 +Dictyoglomus_turgidum_61679 0 0.0 0.0 +Bacillus_thermoamylovorans_61325 0 0.0 0.0 +Microbacterium_sp_60186 0 0.0 0.0 +Raphidiopsis_brookii_61739 0 0.0 0.0 +Micromonospora_aurantiaca_58255 0 0.0 0.0 +Cupriavidus_necator_59551 0 0.0 0.0 +Cycloclasticus_pugetii_55016 0 0.0 0.0 +Alpha_proteobacterium_61272 0 0.0 0.0 +Lactobacillus_curieae_59201 0 0.0 0.0 +Phaeobacter_gallaeciensis_57642 0 0.0 0.0 +Bartonella_birtlesii_51815 0 0.0 0.0 +Streptomyces_sp_55166 0 0.0 0.0 +Streptococcus_lutetiensis_58501 0 0.0 0.0 +Streptococcus_mitis_58304 0 0.0 0.0 +Comamonas_testosteroni_57821 0 0.0 0.0 +Prevotella_marshii_50397 0 0.0 0.0 +Arthrobacter_sp_59181 0 0.0 0.0 +Tenacibaculum_maritimum_60216 0 0.0 0.0 +Sodalis_glossinidius_61296 0 0.0 0.0 +Streptomyces_novaecaesareae_33739 0 0.0 0.0 +Rhizobium_sp_61618 0 0.0 0.0 +Gordonia_rubripertincta_58506 0 0.0 0.0 +Geobacillus_sp_60191 0 0.0 0.0 +Sporocytophaga_myxococcoides_62522 0 0.0 0.0 +Novosphingobium_subterraneum_61634 0 0.0 0.0 +Xanthomonas_translucens_57878 0 0.0 0.0 +Rhizobium_giardinii_58412 0 0.0 0.0 +Thermomicrobium_roseum_61173 0 0.0 0.0 +Chryseobacterium_sp_60748 0 0.0 0.0 +Alteromonas_sp_60016 0 0.0 0.0 +Chryseobacterium_sp_60744 0 0.0 0.0 +Chryseobacterium_sp_60745 0 0.0 0.0 +Chryseobacterium_sp_60746 0 0.0 0.0 +Mycobacterium_kansasii_55037 0 0.0 0.0 +Chryseobacterium_sp_60742 0 0.0 0.0 +Neisseria_mucosa_61504 0 0.0 0.0 +Bacteroides_pyogenes_58220 0 0.0 0.0 +Amycolatopsis_rifamycinica_61125 0 0.0 0.0 +Kingella_kingae_56809 0 0.0 0.0 +Lentzea_albidocapillata_61465 0 0.0 0.0 +Allofustis_seminis_58693 0 0.0 0.0 +Pleurocapsa_sp_59379 0 0.0 0.0 +Olsenella_sp_62055 0 0.0 0.0 +Thalassobacter_arenae_59102 0 0.0 0.0 +Lysobacter_daejeonensis_60316 0 0.0 0.0 +Paenibacillus_daejeonensis_58975 0 0.0 0.0 +Erythrobacter_sp_60927 0 0.0 0.0 +Deefgea_rivuli_58783 0 0.0 0.0 +Fangia_hongkongensis_58838 0 0.0 0.0 +Ochrobactrum_anthropi_57711 0 0.0 0.0 +Bradyrhizobium_sp_59244 0 0.0 0.0 +Thiobacillus_denitrificans_61140 0 0.0 0.0 +Atopobium_parvulum_59960 0 0.0 0.0 +Escherichia_coli_57907 0 0.0 0.0 +Sphingobium_chlorophenolicum_62136 0 0.0 0.0 +Oceanobacillus_picturae_60941 0 0.0 0.0 +Butyrivibrio_sp_60400 0 0.0 0.0 +Lactobacillus_gasseri_55805 0 0.0 0.0 +Bradyrhizobium_sp_60002 0 0.0 0.0 +Sporolactobacillus_inulinus_58475 0 0.0 0.0 +Ruminococcus_callidus_61479 0 0.0 0.0 +Vibrio_furnissii_57003 0 0.0 0.0 +Streptomyces_nodosus_61459 0 0.0 0.0 +Xanthomonas_arboricola_57436 0 0.0 0.0 +Serratia_marcescens_58205 0 0.0 0.0 +Treponema_maltophilum_59146 0 0.0 0.0 +Guyana_massiliensis_60772 0 0.0 0.0 +Cellulomonas_flavigena_61539 0 0.0 0.0 +Burkholderia_oklahomensis_61294 0 0.0 0.0 +Pseudomonas_syringae_60238 0 0.0 0.0 +Saccharothrix_sp_60637 0 0.0 0.0 +Campylobacter_curvus_58744 0 0.0 0.0 +Pediococcus_acidilactici_57243 0 0.0 0.0 +Agrobacterium_albertimagni_59273 0 0.0 0.0 +Pseudomonas_syringae_60237 0 0.0 0.0 +Devosia_sp_60765 0 0.0 0.0 +Micromonospora_purpureochromogenes_57479 0 0.0 0.0 +Eubacterium_brachy_60105 0 0.0 0.0 +Cytophaga_aurantiaca_58781 0 0.0 0.0 +Vibrio_tasmaniensis_57351 0 0.0 0.0 +Lactobacillus_acidophilus_51143 0 0.0 0.0 +Glaciecola_agarilytica_56488 0 0.0 0.0 +Desulfurivibrio_alkaliphilus_61891 0 0.0 0.0 +Burkholderia_sp_60759 0 0.0 0.0 +Ferrimonas_balearica_61769 0 0.0 0.0 +Desulfonatronospira_thiodismutans_61797 0 0.0 0.0 +Actinobaculum_urinale_58662 0 0.0 0.0 +Lactobacillus_nodensis_59723 0 0.0 0.0 +Microbacterium_sp_40026 0 0.0 0.0 +Alpha_proteobacterium_62342 0 0.0 0.0 +Pseudomonas_sp_59614 0 0.0 0.0 +Streptomyces_sp_57934 0 0.0 0.0 +Sanguibacter_sp_58572 0 0.0 0.0 +Clostridium_acidurici_59166 0 0.0 0.0 +Megasphaera_sp_58302 0 0.0 0.0 +Erythrobacter_sp_61380 0 0.0 0.0 +Cupriavidus_taiwanensis_58404 0 0.0 0.0 +Perlucidibaca_piscinae_58992 0 0.0 0.0 +Geovibrio_thiophilus_60051 0 0.0 0.0 +Pseudoalteromonas_haloplanktis_60127 0 0.0 0.0 +Clostridium_akagii_58756 0 0.0 0.0 +Methylomonas_sp_59329 0 0.0 0.0 +Actibacterium_sp_60628 0 0.0 0.0 +Sulfurimonas_gotlandica_62537 0 0.0 0.0 +Helicobacter_pylori_53184 0 0.0 0.0 +Streptomyces_griseus_57232 0 0.0 0.0 +Acidobacterium_sp_62152 0 0.0 0.0 +Aquimarina_agarilytica_61941 0 0.0 0.0 +Cohnella_sp_60917 0 0.0 0.0 +Mycobacterium_smegmatis_48553 0 0.0 0.0 +Desulfovibrio_desulfuricans_55193 0 0.0 0.0 +Sphingobacterium_paucimobilis_60192 0 0.0 0.0 +Arthrobacter_nicotinovorans_56451 0 0.0 0.0 +Pseudomonas_sp_60468 0 0.0 0.0 +Legionella_wadsworthii_58911 0 0.0 0.0 +Sediminibacterium_salmoneum_60370 0 0.0 0.0 +Collinsella_stercoris_61536 0 0.0 0.0 +Proteus_hauseri_60069 0 0.0 0.0 +Erysipelotrichaceae_bacterium_62396 0 0.0 0.0 +Pseudomonas_fuscovaginae_60088 0 0.0 0.0 +Parascardovia_denticolens_55181 0 0.0 0.0 +Ornithinimicrobium_pekingense_58971 0 0.0 0.0 +Acidithiobacillus_thiooxidans_56869 0 0.0 0.0 +Prevotella_fusca_59711 0 0.0 0.0 +Ruminococcus_sp_55468 0 0.0 0.0 +Streptococcus_sinensis_60947 0 0.0 0.0 +Mycobacterium_rufum_61230 0 0.0 0.0 +Thermus_thermophilus_58025 0 0.0 0.0 +Actinomyces_sp_59450 0 0.0 0.0 +Clostridium_citroniae_62210 0 0.0 0.0 +Parachlamydia_acanthamoebae_52874 0 0.0 0.0 +Rickettsia_rickettsii_57256 0 0.0 0.0 +Citrobacter_freundii_60527 0 0.0 0.0 +Pelagibacter_ubique_58575 0 0.0 0.0 +Streptomyces_venezuelae_62622 0 0.0 0.0 +Prevotella_buccae_56058 0 0.0 0.0 +Skermanella_stibiiresistens_60311 0 0.0 0.0 +Helicobacter_pylori_58141 0 0.0 0.0 +Lactobacillus_fructivorans_57394 0 0.0 0.0 +Pseudoalteromonas_haloplanktis_61262 0 0.0 0.0 +Hyphomonas_jannaschiana_59922 0 0.0 0.0 +Thermaerobacter_marianensis_62013 0 0.0 0.0 +Helicobacter_pylori_60231 0 0.0 0.0 +Prevotella_sp_59962 0 0.0 0.0 +Paenibacillus_pini_59730 0 0.0 0.0 +Aeromonas_eucrenophila_62023 0 0.0 0.0 +Methylacidiphilum_kamchatkense_59445 0 0.0 0.0 +Psychrobacter_sp_58612 0 0.0 0.0 +Brevundimonas_subvibrioides_61961 0 0.0 0.0 +Oxalobacter_formigenes_61802 0 0.0 0.0 +Capnocytophaga_ochracea_58179 0 0.0 0.0 +Oxalobacter_formigenes_61801 0 0.0 0.0 +Anaerococcus_hydrogenalis_58044 0 0.0 0.0 +Bacillus_sp_60626 0 0.0 0.0 +Exiguobacterium_sp_62333 0 0.0 0.0 +Legionella_longbeachae_61983 0 0.0 0.0 +Fusobacterium_nucleatum_57855 0 0.0 0.0 +Burkholderia_bryophila_57897 0 0.0 0.0 +Sphingobacterium_antarcticus_60243 0 0.0 0.0 +Acinetobacter_baumannii_57648 0 0.0 0.0 +Pseudomonas_psychrophila_59507 0 0.0 0.0 +Gluconacetobacter_rhaeticus_55413 0 0.0 0.0 +Pedosphaera_parvula_61244 0 0.0 0.0 +Methylobacterium_sp_58583 0 0.0 0.0 +Herbaspirillum_sp_59221 0 0.0 0.0 +Brochothrix_campestris_59837 0 0.0 0.0 +Streptococcus_sp_62479 0 0.0 0.0 +Pedobacter_borealis_60607 0 0.0 0.0 +Xanthomonas_axonopodis_56719 0 0.0 0.0 +Amycolatopsis_nigrescens_58473 0 0.0 0.0 +Clostridium_sp_59312 0 0.0 0.0 +Acanthamoeba_endosymbiont_62345 0 0.0 0.0 +Acanthamoeba_endosymbiont_62344 0 0.0 0.0 +Gluconacetobacter_oboediens_62599 0 0.0 0.0 +Propionibacterium_acidipropionici_53960 0 0.0 0.0 +Bacillus_hemicellulosilyticus_59728 0 0.0 0.0 +Oceanicola_nanhaiensis_58965 0 0.0 0.0 +Streptomyces_bikiniensis_34863 0 0.0 0.0 +Rhodobacteraceae_bacterium_61392 0 0.0 0.0 +Acinetobacter_sp_57696 0 0.0 0.0 +Pedobacter_kyungheensis_58477 0 0.0 0.0 +Selenomonas_sp_62361 0 0.0 0.0 +Rhizobium_larrymoorei_60150 0 0.0 0.0 +Thermoanaerobaculum_aquaticum_60070 0 0.0 0.0 +Leptospirillum_ferriphilum_58442 0 0.0 0.0 +Thauera_linaloolentis_59105 0 0.0 0.0 +SAR406_cluster_45166 0 0.0 0.0 +Dysgonomonas_mossii_62215 0 0.0 0.0 +Streptococcus_mitis_60474 0 0.0 0.0 +Streptococcus_mitis_60473 0 0.0 0.0 +Veillonella_parvula_57794 0 0.0 0.0 +Thioclava_dalianensis_59391 0 0.0 0.0 +Cellvibrio_gilvus_61912 0 0.0 0.0 +Selenomonas_sp_62584 0 0.0 0.0 +Selenomonas_sp_62580 0 0.0 0.0 +Kocuria_marina_61027 0 0.0 0.0 +Kibdelosporangium_sp_62166 0 0.0 0.0 +Bacillus_nealsonii_59443 0 0.0 0.0 +Shewanella_colwelliana_60144 0 0.0 0.0 +Pseudomonas_fluorescens_57180 0 0.0 0.0 +Ewingella_americana_62496 0 0.0 0.0 +Bacteroides_rodentium_59708 0 0.0 0.0 +Stenoxybacter_acetivorans_59076 0 0.0 0.0 +Aureispira_sp_60079 0 0.0 0.0 +Thioalkalivibrio_sp_59284 0 0.0 0.0 +Pseudomonas_agarici_62139 0 0.0 0.0 +Bacillus_megaterium_60213 0 0.0 0.0 +Lactobacillus_gallinarum_59714 0 0.0 0.0 +Clostridium_cf_54592 0 0.0 0.0 +Porphyromonas_sp_57899 0 0.0 0.0 +Shewanella_sp_61263 0 0.0 0.0 +Caldicellulosiruptor_acetigenus_56472 0 0.0 0.0 +Bacillus_badius_52685 0 0.0 0.0 +Rhizobium_etli_57652 0 0.0 0.0 +Acinetobacter_rudis_61490 0 0.0 0.0 +Lachnospiraceae_bacterium_57656 0 0.0 0.0 +Desulfuromonas_acetoxidans_61114 0 0.0 0.0 +Halomonas_sp_61893 0 0.0 0.0 +Phaeospirillum_fulvum_60089 0 0.0 0.0 +Psychroserpens_mesophilus_61255 0 0.0 0.0 +Streptococcus_mitis_61875 0 0.0 0.0 +Fusobacterium_necrophorum_57474 0 0.0 0.0 +Oscillatoria_acuminata_61810 0 0.0 0.0 +Alteromonas_australica_61892 0 0.0 0.0 +Scytonema_millei_59763 0 0.0 0.0 +Corynebacterium_ulceribovis_58779 0 0.0 0.0 +Rhodovibrio_salinarum_58538 0 0.0 0.0 +Paenibacillus_sp_61622 0 0.0 0.0 +Helicobacter_pylori_58098 0 0.0 0.0 +Thermoanaerobacter_kivui_61039 0 0.0 0.0 +Desulfotomaculum_kuznetsovii_62270 0 0.0 0.0 +Sinobacter_flavus_59058 0 0.0 0.0 +Taylorella_asinigenitalis_56694 0 0.0 0.0 +Photobacterium_profundum_61205 0 0.0 0.0 +Aeromonas_hydrophila_57540 0 0.0 0.0 +Sinorhizobium_sp_62312 0 0.0 0.0 +Bacillus_gaemokensis_61848 0 0.0 0.0 +Bacteriovorax_sp_59439 0 0.0 0.0 +Bacteriovorax_sp_59438 0 0.0 0.0 +Lactobacillus_hokkaidonensis_59412 0 0.0 0.0 +Geobacillus_thermodenitrificans_53785 0 0.0 0.0 +Methylomonas_sp_59176 0 0.0 0.0 +Rhodococcus_sp_60909 0 0.0 0.0 +Fructobacillus_fructosus_62549 0 0.0 0.0 +Legionella_sainthelensi_60426 0 0.0 0.0 +Desulfocapsa_sulfexigens_59323 0 0.0 0.0 +Pseudomonas_sp_60680 0 0.0 0.0 +Dokdonia_donghaensis_60025 0 0.0 0.0 +Pseudomonas_sp_60359 0 0.0 0.0 +Pseudomonas_sp_60358 0 0.0 0.0 +Methylocystis_sp_60961 0 0.0 0.0 +Staphylococcus_vitulinus_59324 0 0.0 0.0 +Synechococcus_sp_62507 0 0.0 0.0 +Staphylococcus_simiae_62499 0 0.0 0.0 +Helicobacter_pylori_59241 0 0.0 0.0 +Helicobacter_pylori_59240 0 0.0 0.0 +Helicobacter_pylori_59243 0 0.0 0.0 +Helicobacter_pylori_59242 0 0.0 0.0 +Leptotrichia_sp_59617 0 0.0 0.0 +Thermomonospora_curvata_61590 0 0.0 0.0 +Thiothrix_disciformis_59117 0 0.0 0.0 +Mycobacterium_asiaticum_59821 0 0.0 0.0 +Gordonia_bronchialis_61729 0 0.0 0.0 +Leucobacter_chironomi_58914 0 0.0 0.0 +Methylomirabilis_oxyfera_62085 0 0.0 0.0 +Pseudomonas_sp_62500 0 0.0 0.0 +Lactobacillus_amylovorus_55674 0 0.0 0.0 +Streptococcus_macacae_62284 0 0.0 0.0 +Carnobacterium_gallinarum_60576 0 0.0 0.0 +Thiothrix_flexilis_59118 0 0.0 0.0 +Chlamydophila_abortus_53678 0 0.0 0.0 +Saccharophagus_degradans_60989 0 0.0 0.0 +Desulfosporosinus_sp_62506 0 0.0 0.0 +Streptococcus_mitis_61111 0 0.0 0.0 +Streptococcus_mitis_61110 0 0.0 0.0 +Rhizobium_sp_59770 0 0.0 0.0 +Algibacter_lectus_54369 0 0.0 0.0 +Methylotenera_mobilis_61868 0 0.0 0.0 +Nocardia_seriolae_51294 0 0.0 0.0 +Clostridium_symbiosum_54029 0 0.0 0.0 +Gardnerella_vaginalis_58127 0 0.0 0.0 +Caedibacter_acanthamoebae_61055 0 0.0 0.0 +Bacteroides_clarus_62282 0 0.0 0.0 +Methylobacillus_flagellatus_61077 0 0.0 0.0 +Campylobacter_concisus_59747 0 0.0 0.0 +Achromobacter_undefined_58128 0 0.0 0.0 +Bacteroides_propionicifaciens_44747 0 0.0 0.0 +Nocardiopsis_alkaliphila_59772 0 0.0 0.0 +Klebsiella_sp_59419 0 0.0 0.0 +Anabaena_sp_61563 0 0.0 0.0 +Leptolyngbya_sp_59356 0 0.0 0.0 +Herbaspirillum_lusitanum_59305 0 0.0 0.0 +Pseudomonas_mendocina_56846 0 0.0 0.0 +Bartonella_alsatica_58546 0 0.0 0.0 +Pseudomonas_luteola_57118 0 0.0 0.0 +Arthrobacter_sp_61134 0 0.0 0.0 +Gordonia_malaquae_59603 0 0.0 0.0 +Facklamia_sourekii_60422 0 0.0 0.0 +Tatumella_morbirosei_61999 0 0.0 0.0 +Prochlorococcus_sp_57810 0 0.0 0.0 +Streptomyces_turgidiscabies_62156 0 0.0 0.0 +Desulfovibrio_putealis_58819 0 0.0 0.0 +Mycobacterium_hassiacum_58951 0 0.0 0.0 +Thioalkalivibrio_versutus_62437 0 0.0 0.0 +Sulfuricurvum_sp_60839 0 0.0 0.0 +Dehalobacter_sp_58256 0 0.0 0.0 +Oscillatoria_nigro-viridis_60952 0 0.0 0.0 +Streptococcus_equinus_57951 0 0.0 0.0 +Enterobacter_cloacae_38756 0 0.0 0.0 +Nitrosospira_multiformis_61250 0 0.0 0.0 +Anabaena_variabilis_61051 0 0.0 0.0 +Listeria_seeligeri_62121 0 0.0 0.0 +Derxia_gummosa_58791 0 0.0 0.0 +Bartonella_clarridgeiae_48289 0 0.0 0.0 +Pseudomonas_simiae_54024 0 0.0 0.0 +Lachnospiraceae_bacterium_60620 0 0.0 0.0 +Corynebacterium_variabile_60945 0 0.0 0.0 +Sutterella_parvirubra_62279 0 0.0 0.0 +Corynebacterium_ureicelerivorans_61456 0 0.0 0.0 +Snodgrassella_alvi_55236 0 0.0 0.0 +Flavobacterium_sp_56962 0 0.0 0.0 +Riemerella_anatipestifer_54399 0 0.0 0.0 +Roseburia_inulinivorans_61943 0 0.0 0.0 +Erysipelotrichaceae_bacterium_55770 0 0.0 0.0 +Clostridium_aerotolerans_60450 0 0.0 0.0 +Mesorhizobium_metallidurans_59998 0 0.0 0.0 +Cellulomonas_carbonis_62619 0 0.0 0.0 +Streptococcus_suis_56056 0 0.0 0.0 +Corynebacterium_glutamicum_56976 0 0.0 0.0 +Psychroflexus_tropicus_59018 0 0.0 0.0 +Prevotella_sp_61818 0 0.0 0.0 +Prochloron_didemni_58551 0 0.0 0.0 +Luminiphilus_syltensis_61825 0 0.0 0.0 +Pontibacillus_halophilus_44726 0 0.0 0.0 +Porphyromonas_asaccharolytica_56465 0 0.0 0.0 +Ilumatobacter_coccineum_61571 0 0.0 0.0 +Pseudomonas_japonica_59542 0 0.0 0.0 +Spirochaeta_thermophila_62379 0 0.0 0.0 +Nitrosomonas_cryotolerans_59177 0 0.0 0.0 +Acetobacter_persici_59703 0 0.0 0.0 +Streptococcus_porcinus_62388 0 0.0 0.0 +Actinomyces_sp_56280 0 0.0 0.0 +Staphylococcus_capitis_55595 0 0.0 0.0 +Amycolatopsis_orientalis_60158 0 0.0 0.0 +Microbacterium_sp_62631 0 0.0 0.0 +Caldicellulosiruptor_saccharolyticus_58246 0 0.0 0.0 +Arsenicicoccus_bolidensis_58708 0 0.0 0.0 +Sphaerochaeta_coccoides_62265 0 0.0 0.0 +Helicobacter_sp_61496 0 0.0 0.0 +Nitrobacter_winogradskyi_61249 0 0.0 0.0 +Thermobispora_bispora_61579 0 0.0 0.0 +Sinorhizobium_arboris_62566 0 0.0 0.0 +Acinetobacter_oleivorans_59248 0 0.0 0.0 +Oceaniovalibus_guishaninsula_59653 0 0.0 0.0 +Peptoniphilus_sp_58646 0 0.0 0.0 +Acinetobacter_baumannii_57660 0 0.0 0.0 +Acinetobacter_baumannii_57668 0 0.0 0.0 +Thiothrix_lacustris_59119 0 0.0 0.0 +Lentibacillus_sp_61805 0 0.0 0.0 +Granulicatella_elegans_61945 0 0.0 0.0 +Helicobacter_pylori_62707 0 0.0 0.0 +Acidithiobacillus_ferrooxidans_34835 0 0.0 0.0 +Amycolatopsis_mediterranei_47955 0 0.0 0.0 +Chryseobacterium_antarcticum_61081 0 0.0 0.0 +Dickeya_sp_61831 0 0.0 0.0 +Vibrio_sp_46803 0 0.0 0.0 +Lactobacillus_pasteurii_59447 0 0.0 0.0 +Salinicoccus_luteus_59041 0 0.0 0.0 +Streptomyces_monomycini_57894 0 0.0 0.0 +Thermopetrobacter_sp_60719 0 0.0 0.0 +Clostridium_spiroforme_61500 0 0.0 0.0 +Campylobacter_mucosalis_60987 0 0.0 0.0 +Thiomicrospira_crunogena_61224 0 0.0 0.0 +Nostoc_azollae_61772 0 0.0 0.0 +Bacteroides_acidifaciens_59693 0 0.0 0.0 +Thauera_sp_56136 0 0.0 0.0 +Rhizobium_undicola_60252 0 0.0 0.0 +Trueperella_pyogenes_56752 0 0.0 0.0 +Microbacterium_gubbeenense_58945 0 0.0 0.0 +Meiothermus_rufus_61933 0 0.0 0.0 +Streptomyces_sp_59963 0 0.0 0.0 +Methylobacter_marinus_55881 0 0.0 0.0 +Bacteroides_faecichinchillae_59709 0 0.0 0.0 +Myroides_odoratimimus_58215 0 0.0 0.0 +Enterococcus_raffinosus_44063 0 0.0 0.0 +Streptococcus_oralis_58561 0 0.0 0.0 +Streptococcus_oralis_58560 0 0.0 0.0 +Vibrio_parahaemolyticus_57034 0 0.0 0.0 +Aureimonas_altamirensis_61350 0 0.0 0.0 +Bartonella_vinsonii_52598 0 0.0 0.0 +Pseudomonas_fluorescens_58402 0 0.0 0.0 +Helicobacter_hepaticus_55684 0 0.0 0.0 +Streptomyces_sp_60624 0 0.0 0.0 +Ferrimonas_senticii_58842 0 0.0 0.0 +Blautia_producta_61268 0 0.0 0.0 +Megasphaera_elsdenii_56779 0 0.0 0.0 +Amycolatopsis_azurea_59733 0 0.0 0.0 +Burkholderia_fungorum_56741 0 0.0 0.0 +Bacillus_macauensis_59423 0 0.0 0.0 +Nocardia_takedensis_59473 0 0.0 0.0 +Nevskia_soli_58956 0 0.0 0.0 +Flavobacterium_aquatile_60596 0 0.0 0.0 +Dermatophilus_congolensis_58790 0 0.0 0.0 +Chitiniphilus_shinanonensis_58750 0 0.0 0.0 +Laribacter_hongkongensis_56529 0 0.0 0.0 +Vibrio_splendidus_58453 0 0.0 0.0 +Lachnospiraceae_bacterium_62206 0 0.0 0.0 +Variovorax_paradoxus_61918 0 0.0 0.0 +Streptomyces_sp_60020 0 0.0 0.0 +Afipia_sp_42814 0 0.0 0.0 +Streptomyces_sp_60021 0 0.0 0.0 +Leuconostoc_citreum_54667 0 0.0 0.0 +Spirosoma_spitsbergense_59071 0 0.0 0.0 +Fusobacterium_periodonticum_58002 0 0.0 0.0 +Acaryochloris_sp_61175 0 0.0 0.0 +Streptomyces_hygroscopicus_62108 0 0.0 0.0 +Streptomyces_mobaraensis_59602 0 0.0 0.0 +Synechococcus_sp_61038 0 0.0 0.0 +Synechococcus_sp_61037 0 0.0 0.0 +Methylovulum_miyakonense_58513 0 0.0 0.0 +Corynebacterium_freneyi_59961 0 0.0 0.0 +Kordia_algicida_61403 0 0.0 0.0 +Paenibacillus_taiwanensis_58982 0 0.0 0.0 +Vibrio_azureus_59585 0 0.0 0.0 +Lachnospiraceae_bacterium_60406 0 0.0 0.0 +Sciscionella_marina_59050 0 0.0 0.0 +Legionella_pneumophila_55786 0 0.0 0.0 +Desulfurobacterium_thermolithotrophum_62376 0 0.0 0.0 +Janthinobacterium_lividum_58613 0 0.0 0.0 +Escherichia_fergusonii_56914 0 0.0 0.0 +Bradyrhizobium_sp_58401 0 0.0 0.0 +Bacillus_cereus_57982 0 0.0 0.0 +Tsukamurella_paurometabola_61693 0 0.0 0.0 +Mycobacterium_sp_60015 0 0.0 0.0 +Lactobacillus_mali_58435 0 0.0 0.0 +Mucispirillum_schaedleri_60262 0 0.0 0.0 +Shewanella_halifaxensis_61561 0 0.0 0.0 +Atelocyanobacterium_thalassa_33710 0 0.0 0.0 +Selenomonas_sp_60703 0 0.0 0.0 +Leeia_oryzae_58905 0 0.0 0.0 +Comamonadaceae_bacterium_60617 0 0.0 0.0 +Clostridiales_bacterium_55184 0 0.0 0.0 +Lactobacillus_versmoldensis_58437 0 0.0 0.0 +Herbaspirillum_sp_58569 0 0.0 0.0 +Clostridium_beijerinckii_60451 0 0.0 0.0 +Belliella_baltica_62367 0 0.0 0.0 +Pimelobacter_simplex_60993 0 0.0 0.0 +Paenibacillus_sanguinis_58981 0 0.0 0.0 +Pontibacillus_yanchengensis_60315 0 0.0 0.0 +Streptomyces_sp_35073 0 0.0 0.0 +Gilliamella_apicola_59420 0 0.0 0.0 +Peptococcaceae_bacterium_60706 0 0.0 0.0 +Aneurinibacillus_terranovensis_58700 0 0.0 0.0 +Pseudomonas_protegens_55935 0 0.0 0.0 +Roseburia_intestinalis_56239 0 0.0 0.0 +Aerococcus_urinae_62371 0 0.0 0.0 +Paenibacillus_curdlanolyticus_62195 0 0.0 0.0 +Paenibacillus_popilliae_59518 0 0.0 0.0 +Thermocrispum_agreste_58611 0 0.0 0.0 +Helicobacter_pylori_39970 0 0.0 0.0 +Carnobacterium_sp_61000 0 0.0 0.0 +Helicobacter_pylori_39977 0 0.0 0.0 +Helicobacter_pylori_39978 0 0.0 0.0 +Pseudomonas_stutzeri_59576 0 0.0 0.0 +Succinivibrio_dextrinosolvens_60460 0 0.0 0.0 +Virgibacillus_halodenitrificans_54445 0 0.0 0.0 +Thiomicrospira_sp_62487 0 0.0 0.0 +Thiomicrospira_sp_62488 0 0.0 0.0 +Rhizobium_tropici_61445 0 0.0 0.0 +Rhizobium_tropici_61444 0 0.0 0.0 +Allobaculum_stercoricanis_58449 0 0.0 0.0 +Aeromonas_diversa_43116 0 0.0 0.0 +Sulfurihydrogenibium_azorense_60994 0 0.0 0.0 +Pseudomonas_stutzeri_59141 0 0.0 0.0 +Diplosphaera_colitermitum_61099 0 0.0 0.0 +Deinococcus_swuensis_59384 0 0.0 0.0 +Micromonospora_lupini_59258 0 0.0 0.0 +Streptococcus_caballi_59077 0 0.0 0.0 +Bacteroides_barnesiae_47015 0 0.0 0.0 +Paenibacillus_vortex_54521 0 0.0 0.0 +Burkholderiales_bacterium_62359 0 0.0 0.0 +Haemophilus_sp_35076 0 0.0 0.0 +Alcanivorax_sp_61044 0 0.0 0.0 +Neptunomonas_japonica_58952 0 0.0 0.0 +Celeribacter_baekdonensis_59489 0 0.0 0.0 +Faecalibacterium_prausnitzii_61481 0 0.0 0.0 +Lachnospiraceae_bacterium_62350 0 0.0 0.0 +Herpetosiphon_aurantiacus_61219 0 0.0 0.0 +Dyella_ginsengisoli_59670 0 0.0 0.0 +Pantoea_sp_59854 0 0.0 0.0 +Paenibacillus_sp_60129 0 0.0 0.0 +Shewanella_benthica_61212 0 0.0 0.0 +Corynebacterium_argentoratense_60209 0 0.0 0.0 +Streptococcus_agalactiae_58299 0 0.0 0.0 +Propionibacterium_granulosum_57661 0 0.0 0.0 +Enterobacter_hormaechei_50416 0 0.0 0.0 +Clostridium_sp_60465 0 0.0 0.0 +Cyanobacterium_endosymbiont_59623 0 0.0 0.0 +Halomonas_salina_61497 0 0.0 0.0 +Zetaproteobacteria_bacterium_60705 0 0.0 0.0 +Shuttleworthia_satelles_57139 0 0.0 0.0 +Anaeroglobus_geminatus_62348 0 0.0 0.0 +Polaribacter_irgensii_57989 0 0.0 0.0 +Haliscomenobacter_hydrossis_62269 0 0.0 0.0 +Bacillus_isronensis_56027 0 0.0 0.0 +Prochlorococcus_marinus_60934 0 0.0 0.0 +Prochlorococcus_marinus_60935 0 0.0 0.0 +Prochlorococcus_marinus_60936 0 0.0 0.0 +Pseudomonas_aeruginosa_57148 0 0.0 0.0 +Stenotrophomonas_maltophilia_57083 0 0.0 0.0 +Arthrobacter_arilaitensis_62347 0 0.0 0.0 +SAR86_cluster_59143 0 0.0 0.0 +Butyrivibrio_sp_59905 0 0.0 0.0 +Butyrivibrio_sp_59904 0 0.0 0.0 +Butyrivibrio_sp_59903 0 0.0 0.0 +Butyrivibrio_sp_59900 0 0.0 0.0 +Streptomyces_globisporus_62079 0 0.0 0.0 +Anoxybacillus_sp_60829 0 0.0 0.0 +Lactobacillus_sucicola_59715 0 0.0 0.0 +Lactococcus_garvieae_59633 0 0.0 0.0 +Flavobacterium_sasangense_58848 0 0.0 0.0 +Clostridium_sporosphaeroides_58760 0 0.0 0.0 +Pectobacterium_carotovorum_54353 0 0.0 0.0 +Rhizobium_sp_60735 0 0.0 0.0 +Rhizobium_sp_60736 0 0.0 0.0 +Methylobacterium_extorquens_57587 0 0.0 0.0 +Eubacterium_dolichum_61501 0 0.0 0.0 +Pannonibacter_phragmitetus_58985 0 0.0 0.0 +Leptospira_interrogans_57802 0 0.0 0.0 +Nitrolancetus_hollandicus_59172 0 0.0 0.0 +Treponema_socranskii_50175 0 0.0 0.0 +Lactococcus_raffinolactis_59544 0 0.0 0.0 +Streptococcus_mitis_58558 0 0.0 0.0 +Streptococcus_mitis_58557 0 0.0 0.0 +Streptococcus_mitis_58556 0 0.0 0.0 +Streptococcus_sp_59302 0 0.0 0.0 +Myxococcus_fulvus_61620 0 0.0 0.0 +Belnapia_moabensis_58732 0 0.0 0.0 +Vibrio_alginolyticus_56932 0 0.0 0.0 +Taylorella_equigenitalis_52955 0 0.0 0.0 +Rhodomicrobium_vannielii_62019 0 0.0 0.0 +Bacillus_sp_60198 0 0.0 0.0 +Bacillus_sp_60195 0 0.0 0.0 +Corynebacterium_pseudogenitalium_61708 0 0.0 0.0 +Legionella_sp_58380 0 0.0 0.0 +Bacillus_gelatini_58726 0 0.0 0.0 +Corynebacterium_bovis_62528 0 0.0 0.0 +Bradyrhizobium_sp_61234 0 0.0 0.0 +Bradyrhizobium_sp_61233 0 0.0 0.0 +Thermanaerovibrio_velox_62524 0 0.0 0.0 +Lysinibacillus_sphaericus_59948 0 0.0 0.0 +Bacillus_fordii_58725 0 0.0 0.0 +Streptococcus_marimammalium_59084 0 0.0 0.0 +Alicycliphilus_sp_59436 0 0.0 0.0 +Dickeya_dadantii_57917 0 0.0 0.0 +Propionibacterium_acnes_57367 0 0.0 0.0 +Anoxybacillus_flavithermus_61640 0 0.0 0.0 +Stenotrophomonas_maltophilia_55906 0 0.0 0.0 +Dermacoccus_nishinomiyaensis_56168 0 0.0 0.0 +Xylella_fastidiosa_60549 0 0.0 0.0 +Corynebacterium_jeikeium_57623 0 0.0 0.0 +Hyphomicrobium_denitrificans_62083 0 0.0 0.0 +Streptococcus_mitis_59739 0 0.0 0.0 +Corynebacterium_lipophiloflavum_61707 0 0.0 0.0 +Clostridium_sp_59421 0 0.0 0.0 +Patulibacter_sp_58577 0 0.0 0.0 +Streptacidiphilus_carbonis_58458 0 0.0 0.0 +Leeuwenhoekiella_blandensis_61450 0 0.0 0.0 +Caulobacter_henricii_54487 0 0.0 0.0 +Spirillospora_albida_61863 0 0.0 0.0 +Stenotrophomonas_rhizophila_61014 0 0.0 0.0 +Vibrio_sp_60699 0 0.0 0.0 +Thermosediminibacter_oceani_61791 0 0.0 0.0 +Legionella_anisa_59641 0 0.0 0.0 +Synechococcus_sp_62331 0 0.0 0.0 +Curtobacterium_ginsengisoli_58780 0 0.0 0.0 +Cronobacter_helveticus_61318 0 0.0 0.0 +Bradyrhizobium_sp_60981 0 0.0 0.0 +Thermus_antranikianii_59112 0 0.0 0.0 +Dechloromonas_agitata_60048 0 0.0 0.0 +Intrasporangium_sp_61872 0 0.0 0.0 +Caulobacter_henricii_62143 0 0.0 0.0 +Carnobacterium_divergens_60574 0 0.0 0.0 +Streptomyces_sp_44295 0 0.0 0.0 +Pseudomonas_fulva_57974 0 0.0 0.0 +Brevundimonas_nasdae_60942 0 0.0 0.0 +Elizabethkingia_miricola_60943 0 0.0 0.0 +Methylopila_sp_58582 0 0.0 0.0 +Azovibrio_restrictus_58721 0 0.0 0.0 +Pseudomonas_sp_58268 0 0.0 0.0 +Lactobacillus_heilongjiangensis_58492 0 0.0 0.0 +Desulfovibrio_sp_61921 0 0.0 0.0 +Mesorhizobium_loti_56292 0 0.0 0.0 +Acinetobacter_sp_57877 0 0.0 0.0 +Rubritepida_flocculans_59031 0 0.0 0.0 +Rhodanobacter_spathiphylli_59308 0 0.0 0.0 +Enterobacter_asburiae_61990 0 0.0 0.0 +Enterobacter_cloacae_60366 0 0.0 0.0 +Mollicutes_bacterium_60854 0 0.0 0.0 +Proteiniphilum_acetatigenes_59006 0 0.0 0.0 +Accumulibacter_sp_60605 0 0.0 0.0 +Pelobacter_propionicus_61282 0 0.0 0.0 +Flavobacterium_soli_58849 0 0.0 0.0 +Psychromonas_ossibalaenae_59884 0 0.0 0.0 +Serratia_liquefaciens_58210 0 0.0 0.0 +Nocardia_testacea_59476 0 0.0 0.0 +Rubrobacter_radiotolerans_61494 0 0.0 0.0 +Propionibacterium_acnes_50902 0 0.0 0.0 +Porphyromonas_cangingivalis_56783 0 0.0 0.0 +Clostridium_sp_60782 0 0.0 0.0 +Bifidobacterium_animalis_58116 0 0.0 0.0 +Bartonella_sp_62534 0 0.0 0.0 +Halanaerobium_hydrogeniformans_62043 0 0.0 0.0 +Mycobacterium_parascrofulaceum_61714 0 0.0 0.0 +Helicobacter_cetorum_59315 0 0.0 0.0 +Pelagibacter_ubique_61569 0 0.0 0.0 +Solibacter_usitatus_61042 0 0.0 0.0 +Desulfovibrio_zosterae_58820 0 0.0 0.0 +Amycolatopsis_orientalis_59152 0 0.0 0.0 +Anaerostipes_caccae_55430 0 0.0 0.0 +Marinospirillum_insulare_58930 0 0.0 0.0 +Pseudoalteromonas_piscicida_58042 0 0.0 0.0 +Finegoldia_magna_61710 0 0.0 0.0 +Psychroflexus_gondwanensis_59398 0 0.0 0.0 +Rickettsia_prowazekii_51996 0 0.0 0.0 +Chloroherpeton_thalassium_61682 0 0.0 0.0 +Rhodococcus_rhodnii_59866 0 0.0 0.0 +Paenibacillus_massiliensis_57716 0 0.0 0.0 +Syntrophobotulus_glycolicus_62016 0 0.0 0.0 +Helicobacter_pylori_61001 0 0.0 0.0 +Streptacidiphilus_jiangxiensis_61043 0 0.0 0.0 +Pseudomonas_rhizosphaerae_61010 0 0.0 0.0 +Blautia_wexlerae_56130 0 0.0 0.0 +Clostridium_sp_61991 0 0.0 0.0 +Arthrobacter_chlorophenolicus_61551 0 0.0 0.0 +Corynebacterium_sp_58512 0 0.0 0.0 +Pontibacillus_litoralis_60313 0 0.0 0.0 +Robinsoniella_peoriensis_54117 0 0.0 0.0 +Comamonas_sp_58462 0 0.0 0.0 +Streptococcus_urinalis_50015 0 0.0 0.0 +Oceanicaulis_sp_61193 0 0.0 0.0 +Clostridiales_genomosp_54611 0 0.0 0.0 +Acidovorax_sp_61324 0 0.0 0.0 +Burkholderia_thailandensis_59791 0 0.0 0.0 +Bifidobacterium_moukalabense_60512 0 0.0 0.0 +Hirschia_baltica_61865 0 0.0 0.0 +Streptomyces_sclerotialus_60978 0 0.0 0.0 +Streptomyces_sclerotialus_60977 0 0.0 0.0 +Oceanimonas_sp_61673 0 0.0 0.0 +Leisingera_aquimarina_62705 0 0.0 0.0 +Acinetobacter_baumannii_56211 0 0.0 0.0 +Pseudomonas_fluorescens_58167 0 0.0 0.0 +Singulisphaera_acidiphila_62433 0 0.0 0.0 +Burkholderia_ferrariae_59567 0 0.0 0.0 +Modestobacter_marinus_61604 0 0.0 0.0 +Acidobacteriaceae_bacterium_59852 0 0.0 0.0 +Acidobacteriaceae_bacterium_59851 0 0.0 0.0 +Acidobacteriaceae_bacterium_59850 0 0.0 0.0 +Pandoraea_sp_59456 0 0.0 0.0 +Herbaspirillum_sp_59360 0 0.0 0.0 +Eubacterium_sp_60798 0 0.0 0.0 +Lysinibacillus_fusiformis_58088 0 0.0 0.0 +Paenibacillus_borealis_60925 0 0.0 0.0 +Acinetobacter_sp_60785 0 0.0 0.0 +Chryseobacterium_jeonii_61082 0 0.0 0.0 +Thiomicrospira_sp_60570 0 0.0 0.0 +Borrelia_afzelii_54058 0 0.0 0.0 +Streptococcus_suis_58291 0 0.0 0.0 +Streptococcus_suis_58290 0 0.0 0.0 +Caulobacter_sp_59210 0 0.0 0.0 +Clostridium_hiranonis_61655 0 0.0 0.0 +Enterococcus_casseliflavus_56514 0 0.0 0.0 +Exiguobacterium_antarcticum_55961 0 0.0 0.0 +Pseudomonas_stutzeri_59517 0 0.0 0.0 +Bacillus_sp_37296 0 0.0 0.0 +Leeuwenhoekiella_sp_60339 0 0.0 0.0 +Leeuwenhoekiella_sp_60338 0 0.0 0.0 +Vibrio_variabilis_57947 0 0.0 0.0 +Propionibacterium_propionicum_62297 0 0.0 0.0 +Lawsonia_intracellularis_43332 0 0.0 0.0 +Tomitella_biformata_60554 0 0.0 0.0 +Stenotrophomonas_maltophilia_56867 0 0.0 0.0 +Lactobacillus_sp_62632 0 0.0 0.0 +Enterococcus_mundtii_57674 0 0.0 0.0 +Halonatronum_saccharophilum_62526 0 0.0 0.0 +Yersinia_similis_61344 0 0.0 0.0 +Streptomyces_scopuliridis_60530 0 0.0 0.0 +Rhodococcus_sp_60565 0 0.0 0.0 +Rhodococcus_sp_60566 0 0.0 0.0 +Streptomyces_bottropensis_58461 0 0.0 0.0 +Muricauda_sp_59798 0 0.0 0.0 +Chryseobacterium_indologenes_54335 0 0.0 0.0 +Meiothermus_chliarophilus_62519 0 0.0 0.0 +Stenotrophomonas_maltophilia_61398 0 0.0 0.0 +Plesiocystis_pacifica_61418 0 0.0 0.0 +Trabulsiella_guamensis_58322 0 0.0 0.0 +Hyphomonas_polymorpha_59924 0 0.0 0.0 +Rothia_aeria_57338 0 0.0 0.0 +Helicobacter_magdeburgensis_61595 0 0.0 0.0 +Campylobacter_ureolyticus_62430 0 0.0 0.0 +Algiphilus_aromaticivorans_60478 0 0.0 0.0 +Colwellia_piezophila_59825 0 0.0 0.0 +Spirochaeta_sp_60064 0 0.0 0.0 +Pseudomonas_sp_59673 0 0.0 0.0 +Streptomyces_griseoflavus_61573 0 0.0 0.0 +Staphylococcus_sp_54766 0 0.0 0.0 +Streptococcus_canis_61617 0 0.0 0.0 +Helicobacter_pylori_53127 0 0.0 0.0 +Sanguibacter_keddieii_61540 0 0.0 0.0 +Bacteroides_fragilis_56548 0 0.0 0.0 +Austwickia_chelonae_59387 0 0.0 0.0 +Desulfotomaculum_nigrificans_53828 0 0.0 0.0 +Staphylococcus_epidermidis_57523 0 0.0 0.0 +Moorea_producens_61635 0 0.0 0.0 +Cellulomonas_fimi_61895 0 0.0 0.0 +Thermacetogenium_phaeum_58539 0 0.0 0.0 +Chthonomonas_calidirosea_60035 0 0.0 0.0 +Bradyrhizobium_yuanmingense_57605 0 0.0 0.0 +Clostridium_saccharolyticum_61936 0 0.0 0.0 +Carnobacterium_maltaromaticum_54241 0 0.0 0.0 +Veillonella_sp_62611 0 0.0 0.0 +Streptomyces_aureus_60971 0 0.0 0.0 +Pseudomonas_sp_54652 0 0.0 0.0 +Salinisphaera_hydrothermalis_60037 0 0.0 0.0 +Enterorhabdus_caecimuris_59685 0 0.0 0.0 +Orientia_tsutsugamushi_57793 0 0.0 0.0 +Rhodopirellula_sp_61914 0 0.0 0.0 +Citrobacter_rodentium_43449 0 0.0 0.0 +Nocardioides_sp_60285 0 0.0 0.0 +Aeromonas_australiensis_58621 0 0.0 0.0 +Nocardioides_sp_60281 0 0.0 0.0 +Gallibacterium_anatis_57930 0 0.0 0.0 +Pseudomonas_fluorescens_56262 0 0.0 0.0 +Gillisia_sp_59793 0 0.0 0.0 +Arenibacter_latericius_58705 0 0.0 0.0 +Streptococcus_merionis_59085 0 0.0 0.0 +Asticcacaulis_benevestitus_58712 0 0.0 0.0 +Blautia_hansenii_56031 0 0.0 0.0 +Actinomyces_sp_59161 0 0.0 0.0 +Labrenzia_sp_38957 0 0.0 0.0 +Sphingomonas_paucimobilis_49128 0 0.0 0.0 +Bacillus_sp_62642 0 0.0 0.0 +Pseudomonas_syringae_62088 0 0.0 0.0 +Rhodococcus_defluvii_60109 0 0.0 0.0 +Actinomyces_odontolyticus_57475 0 0.0 0.0 +Curvibacter_lanceolatus_59826 0 0.0 0.0 +Burkholderia_zhejiangensis_53847 0 0.0 0.0 +Streptococcus_parasanguinis_58381 0 0.0 0.0 +Streptomyces_sp_58511 0 0.0 0.0 +Fusobacterium_gonidiaformans_57045 0 0.0 0.0 +Cetobacterium_somerae_60094 0 0.0 0.0 +Actinopolyspora_mortivallis_58450 0 0.0 0.0 +Paenibacillus_larvae_52123 0 0.0 0.0 +Bacteroides_ovatus_58035 0 0.0 0.0 +Odoribacter_splanchnicus_62174 0 0.0 0.0 +Salinispora_pacifica_57294 0 0.0 0.0 +Pelobacter_seleniigenes_58991 0 0.0 0.0 +Pandoraea_pulmonicola_62555 0 0.0 0.0 +Actinomyces_massiliensis_56461 0 0.0 0.0 +Paenibacillus_terrae_62653 0 0.0 0.0 +Butyrivibrio_sp_56129 0 0.0 0.0 +Sphingomonas_melonis_46852 0 0.0 0.0 +Rhodopseudomonas_palustris_62035 0 0.0 0.0 +Sulfitobacter_mediterraneus_60537 0 0.0 0.0 +Campylobacter_fetus_53261 0 0.0 0.0 +Streptococcus_agalactiae_55593 0 0.0 0.0 +Solirubrobacterales_bacterium_60283 0 0.0 0.0 +Endolissoclinum_faulkneri_60377 0 0.0 0.0 +Wenxinia_marina_59129 0 0.0 0.0 +Streptomyces_griseoaurantiacus_62689 0 0.0 0.0 +Fusobacterium_nucleatum_57345 0 0.0 0.0 +Streptococcus_sp_59997 0 0.0 0.0 +Streptococcus_suis_58197 0 0.0 0.0 +Streptococcus_cristatus_62470 0 0.0 0.0 +Caulobacter_crescentus_59984 0 0.0 0.0 +Thauera_phenylacetica_59671 0 0.0 0.0 +Prochlorococcus_sp_35052 0 0.0 0.0 +Prochlorococcus_sp_35053 0 0.0 0.0 +Lactobacillus_apodemi_59722 0 0.0 0.0 +Erwinia_mallotivora_62141 0 0.0 0.0 +Helicobacter_pylori_59431 0 0.0 0.0 +Morganella_morganii_60481 0 0.0 0.0 +Roseovarius_nubinhibens_62474 0 0.0 0.0 +Bacillus_simplex_60379 0 0.0 0.0 +Prosthecochloris_aestuarii_61136 0 0.0 0.0 +Ammonifex_degensii_61502 0 0.0 0.0 +Pseudoalteromonas_sp_61390 0 0.0 0.0 +Marinobacter_similis_60490 0 0.0 0.0 +Bifidobacterium_boum_38039 0 0.0 0.0 +Bacteroides_vulgatus_57955 0 0.0 0.0 +Burkholderia_sp_60616 0 0.0 0.0 +Paenibacillus_sp_60734 0 0.0 0.0 +Haliea_rubra_59822 0 0.0 0.0 +Streptomyces_sp_60662 0 0.0 0.0 +Streptomyces_sp_60663 0 0.0 0.0 +Streptomyces_sp_60660 0 0.0 0.0 +Streptomyces_sp_60661 0 0.0 0.0 +Streptomyces_sp_60666 0 0.0 0.0 +Streptomyces_sp_60667 0 0.0 0.0 +Streptomyces_sp_60664 0 0.0 0.0 +Streptomyces_sp_60665 0 0.0 0.0 +Saccharomonospora_azurea_54839 0 0.0 0.0 +Myroides_odoratimimus_62302 0 0.0 0.0 +Prevotella_corporis_50024 0 0.0 0.0 +Gamma_proteobacterium_62327 0 0.0 0.0 +Peptoniphilus_sp_62403 0 0.0 0.0 +Porphyromonas_gulae_56965 0 0.0 0.0 +Pelagibacter_ubique_59237 0 0.0 0.0 +Sphingomonas_sp_60293 0 0.0 0.0 +Centipeda_periodontii_62449 0 0.0 0.0 +Leptospira_interrogans_46161 0 0.0 0.0 +Thioalkalivibrio_sp_59842 0 0.0 0.0 +Pseudomonas_mandelii_58267 0 0.0 0.0 +Megasphaera_sp_58602 0 0.0 0.0 +Chlorobium_luteolum_61235 0 0.0 0.0 +Streptococcus_infantarius_58294 0 0.0 0.0 +Serratia_marcescens_59790 0 0.0 0.0 +Staphylococcus_xylosus_56919 0 0.0 0.0 +Mycobacterium_aromaticivorans_60532 0 0.0 0.0 +Cyanobacterium_PCC_59346 0 0.0 0.0 +Helcococcus_kunzii_62427 0 0.0 0.0 +Bartonella_sp_58550 0 0.0 0.0 +Helicobacter_pylori_56616 0 0.0 0.0 +Corynebacterium_accolens_58243 0 0.0 0.0 +Lachnospiraceae_bacterium_60410 0 0.0 0.0 +Parabacteroides_gordonii_58986 0 0.0 0.0 +Leucobacter_chromiiresistens_62184 0 0.0 0.0 +Hymenobacter_sp_60774 0 0.0 0.0 +Alpha_proteobacterium_62227 0 0.0 0.0 +Subdoligranulum_sp_62068 0 0.0 0.0 +Bifidobacterium_actinocoloniiforme_60520 0 0.0 0.0 +Veillonella_sp_62404 0 0.0 0.0 +Burkholderia_kirkii_58463 0 0.0 0.0 +Flavobacteria_bacterium_61410 0 0.0 0.0 +Yersinia_mollaretii_61308 0 0.0 0.0 +Clostridium_hathewayi_61827 0 0.0 0.0 +Helicobacter_pylori_60155 0 0.0 0.0 +Helicobacter_pylori_60154 0 0.0 0.0 +Streptomyces_clavuligerus_34390 0 0.0 0.0 +Helicobacter_pylori_60156 0 0.0 0.0 +Helicobacter_pylori_60153 0 0.0 0.0 +Acetobacter_pomorum_62053 0 0.0 0.0 +Yersinia_frederiksenii_61307 0 0.0 0.0 +Lactobacillus_parabrevis_59845 0 0.0 0.0 +Lonsdalea_quercina_58520 0 0.0 0.0 +Pseudomonas_putida_53076 0 0.0 0.0 +Photodesmus_katoptron_52138 0 0.0 0.0 +Pseudoramibacter_alactolyticus_62441 0 0.0 0.0 +Nocardiopsis_gilva_59677 0 0.0 0.0 +Cellulomonas_sp_60031 0 0.0 0.0 +Myroides_odoratimimus_33551 0 0.0 0.0 +Desulfovibrio_magneticus_59482 0 0.0 0.0 +Novosphingobium_tardaugens_59579 0 0.0 0.0 +Paracoccus_sp_58581 0 0.0 0.0 +Cellulomonas_bogoriensis_60323 0 0.0 0.0 +Algoriphagus_mannitolivorans_58683 0 0.0 0.0 +Calothrix_sp_61243 0 0.0 0.0 +Shewanella_amazonensis_61258 0 0.0 0.0 +Jeotgalibacillus_campisalis_61018 0 0.0 0.0 +Atopobium_parvulum_61692 0 0.0 0.0 +Clostridium_sp_61482 0 0.0 0.0 +Syntrophomonas_wolfei_61277 0 0.0 0.0 +Neisseria_mucosa_61632 0 0.0 0.0 +Congregibacter_litoralis_61208 0 0.0 0.0 +Cellulophaga_sp_59792 0 0.0 0.0 +Clavibacter_michiganensis_61237 0 0.0 0.0 +Ishikawaella_capsulata_61600 0 0.0 0.0 +Marinithermus_hydrothermalis_62378 0 0.0 0.0 +Idiomarina_loihiensis_58227 0 0.0 0.0 +Listeria_ivanovii_54314 0 0.0 0.0 +Ruminococcus_flavefaciens_61992 0 0.0 0.0 +Desulfosporosinus_sp_60709 0 0.0 0.0 +Streptococcus_sp_59452 0 0.0 0.0 +Oscillibacter_ruminantium_58326 0 0.0 0.0 +Citrobacter_freundii_56776 0 0.0 0.0 +Acinetobacter_baumannii_57014 0 0.0 0.0 +Arthrobacter_sp_58628 0 0.0 0.0 +Mannheimia_haemolytica_55106 0 0.0 0.0 +Serratia_fonticola_58091 0 0.0 0.0 +Sphingobacterium_sp_62222 0 0.0 0.0 +Pseudomonas_fluorescens_62219 0 0.0 0.0 +Nocardia_jiangxiensis_59470 0 0.0 0.0 +Ideonella_sp_60254 0 0.0 0.0 +Lactobacillus_saerimneri_56378 0 0.0 0.0 +Achromobacter_sp_60824 0 0.0 0.0 +Leptospira_kirschneri_57296 0 0.0 0.0 +Loktanella_cinnabarina_60152 0 0.0 0.0 +Pseudomonas_cremoricolorata_60895 0 0.0 0.0 +Streptomyces_bicolor_33824 0 0.0 0.0 +Acidovorax_ebreus_57143 0 0.0 0.0 +Pelotomaculum_thermopropionicum_61349 0 0.0 0.0 +Aeromonas_sobria_62017 0 0.0 0.0 +Thioploca_ingrica_61468 0 0.0 0.0 +Mesorhizobium_sp_57412 0 0.0 0.0 +Agrobacterium_tumefaciens_56379 0 0.0 0.0 +Enterococcus_asini_44060 0 0.0 0.0 +Olleya_sp_62231 0 0.0 0.0 +Colwellia_psychrerythraea_61115 0 0.0 0.0 +Colwellia_psychrerythraea_61116 0 0.0 0.0 +Flavobacterium_sp_59864 0 0.0 0.0 +Flavobacteriaceae_bacterium_58421 0 0.0 0.0 +Roseiflexus_castenholzii_61379 0 0.0 0.0 +Pleomorphomonas_koreensis_58995 0 0.0 0.0 +Nitratireductor_pacificus_61422 0 0.0 0.0 +Stackebrandtia_nassauensis_61541 0 0.0 0.0 +Nesterenkonia_sp_62034 0 0.0 0.0 +Dehalococcoides_mccartyi_54897 0 0.0 0.0 +Geminicoccus_roseus_58537 0 0.0 0.0 +Fusobacterium_sp_62349 0 0.0 0.0 +Prevotella_ruminicola_57600 0 0.0 0.0 +Corynebacterium_amycolatum_61782 0 0.0 0.0 +Burkholderia_glumae_53803 0 0.0 0.0 +Glaciecola_lipolytica_59160 0 0.0 0.0 +Zooshikella_ganghwensis_59134 0 0.0 0.0 +Mitsuaria_sp_61803 0 0.0 0.0 +Paenibacillus_sp_61252 0 0.0 0.0 +Enterorhabdus_mucosicola_58833 0 0.0 0.0 +Marinobacter_santoriniensis_59969 0 0.0 0.0 +Simplicispira_psychrophila_59056 0 0.0 0.0 +Oceanobacillus_manasiensis_61886 0 0.0 0.0 +Serratia_plymuthica_57582 0 0.0 0.0 +Clostridium_lundense_60452 0 0.0 0.0 +Alistipes_sp_59510 0 0.0 0.0 +Microbacterium_oleivorans_61096 0 0.0 0.0 +Saccharopolyspora_rectivirgula_42917 0 0.0 0.0 +Lactobacillus_jensenii_52961 0 0.0 0.0 +Aeromonas_veronii_58488 0 0.0 0.0 +Nocardia_araoensis_59464 0 0.0 0.0 +Helicobacter_pylori_46621 0 0.0 0.0 +Pseudomonas_cichorii_60533 0 0.0 0.0 +Nitratireductor_aquibiodomus_57174 0 0.0 0.0 +Bifidobacterium_mongoliense_60519 0 0.0 0.0 +Leucobacter_salsicius_59736 0 0.0 0.0 +Hoeflea_phototrophica_61483 0 0.0 0.0 +Knoellia_flava_60317 0 0.0 0.0 +Chlorobium_chlorochromatii_61291 0 0.0 0.0 +Negativicoccus_succinicivorans_57482 0 0.0 0.0 +Bradyrhizobium_sp_61279 0 0.0 0.0 +Pseudomonas_alcaligenes_56085 0 0.0 0.0 +Uncultured_Termite_61589 0 0.0 0.0 +Streptomyces_glaucescens_60967 0 0.0 0.0 +Methylocapsa_acidiphila_61433 0 0.0 0.0 +Campylobacter_rectus_61785 0 0.0 0.0 +Vibrio_fluvialis_57225 0 0.0 0.0 +Borrelia_bissettii_61690 0 0.0 0.0 +Helicobacter_felis_62579 0 0.0 0.0 +Corynebacterium_ammoniagenes_62029 0 0.0 0.0 +Agrobacterium_sp_43897 0 0.0 0.0 +Lysinibacillus_massiliensis_59506 0 0.0 0.0 +Phocaeicola_abscessus_52822 0 0.0 0.0 +Leptospira_fainei_59411 0 0.0 0.0 +Streptomyces_sp_60865 0 0.0 0.0 +Arthrobacter_sp_61638 0 0.0 0.0 +Thermotoga_naphthophila_58031 0 0.0 0.0 +Rickettsia_tamurae_56215 0 0.0 0.0 +Photobacterium_sp_59550 0 0.0 0.0 +Legionella_geestiana_58907 0 0.0 0.0 +Sulfuritalea_hydrogenivorans_59607 0 0.0 0.0 +Lactobacillus_fuchuensis_59719 0 0.0 0.0 +Anoxybacillus_flavithermus_60085 0 0.0 0.0 +Enterobacter_cancerogenus_61658 0 0.0 0.0 +Ruminococcus_flavefaciens_60458 0 0.0 0.0 +Azospirillum_lipoferum_62354 0 0.0 0.0 +Aeromonas_rivuli_62020 0 0.0 0.0 +Ruminococcus_flavefaciens_60457 0 0.0 0.0 +Ruminococcus_flavefaciens_60456 0 0.0 0.0 +Thermocrispum_municipale_58610 0 0.0 0.0 +Burkholderia_sp_62563 0 0.0 0.0 +Crocosphaera_watsonii_60931 0 0.0 0.0 +Flavobacterium_reichenbachii_61335 0 0.0 0.0 +Bifidobacterium_pseudocatenulatum_57754 0 0.0 0.0 +Halobacteroides_halobius_62238 0 0.0 0.0 +Sphingobium_sp_59484 0 0.0 0.0 +Parabacteroides_distasonis_56985 0 0.0 0.0 +Bifidobacterium_stellenboschense_62274 0 0.0 0.0 +Clostridium_colicanis_62697 0 0.0 0.0 +Zobellia_uliginosa_60507 0 0.0 0.0 +Clostridium_saccharoperbutylacetonicum_33466 0 0.0 0.0 +Aquimarina_latercula_58702 0 0.0 0.0 +Chondromyces_apiculatus_59407 0 0.0 0.0 +Thermoactinomyces_sp_60828 0 0.0 0.0 +Mycobacterium_kansasii_60023 0 0.0 0.0 +Gramella_forsetii_61470 0 0.0 0.0 +Desulfomonile_tiedjei_62168 0 0.0 0.0 +Variovorax_paradoxus_59765 0 0.0 0.0 +Shewanella_frigidimarina_61229 0 0.0 0.0 +Alistipes_indistinctus_62207 0 0.0 0.0 +Pseudomonas_mosselii_60380 0 0.0 0.0 +Staphylococcus_hominis_57055 0 0.0 0.0 +Francisella_sp_61846 0 0.0 0.0 +Streptomyces_sp_60640 0 0.0 0.0 +Streptomyces_sp_60641 0 0.0 0.0 +Streptomyces_sp_60642 0 0.0 0.0 +Streptomyces_sp_60643 0 0.0 0.0 +Streptomyces_sp_60644 0 0.0 0.0 +Streptomyces_sp_60645 0 0.0 0.0 +Streptomyces_sp_60646 0 0.0 0.0 +Streptomyces_sp_60647 0 0.0 0.0 +Streptomyces_sp_60648 0 0.0 0.0 +Streptomyces_sp_60649 0 0.0 0.0 +Renibacterium_salmoninarum_61127 0 0.0 0.0 +Thioclava_sp_60092 0 0.0 0.0 +Chryseobacterium_sp_62400 0 0.0 0.0 +Erythrobacter_sp_61048 0 0.0 0.0 +Arenibacter_certesii_58704 0 0.0 0.0 +Streptococcus_mitis_61341 0 0.0 0.0 +Helicobacter_typhlonius_52773 0 0.0 0.0 +Chroococcidiopsis_thermalis_61067 0 0.0 0.0 +Flavobacterium_sp_59630 0 0.0 0.0 +Helicobacter_pylori_57819 0 0.0 0.0 +Janthinobacterium_sp_58495 0 0.0 0.0 +Prochlorococcus_marinus_51374 0 0.0 0.0 +Lactobacillus_coryniformis_56771 0 0.0 0.0 +Ralstonia_solanacearum_57559 0 0.0 0.0 +Fischerella_sp_59358 0 0.0 0.0 +Flavobacterium_gelidilacus_58847 0 0.0 0.0 +Halomonas_sp_58652 0 0.0 0.0 +Burkholderia_sp_56159 0 0.0 0.0 +Streptomyces_vietnamensis_61334 0 0.0 0.0 +Pectobacterium_carotovorum_61812 0 0.0 0.0 +Brucella_abortus_57261 0 0.0 0.0 +Streptomyces_roseoverticillatus_62064 0 0.0 0.0 +Actinomadura_oligospora_60368 0 0.0 0.0 +Komagataeibacter_intermedius_60622 0 0.0 0.0 +Peptostreptococcaceae_bacterium_60103 0 0.0 0.0 +Clostridium_sp_35050 0 0.0 0.0 +Dietzia_cinnamea_62495 0 0.0 0.0 +Anoxybacillus_flavithermus_60000 0 0.0 0.0 +Desulfonatronum_lacustre_62575 0 0.0 0.0 +Bacteroides_coprophilus_61767 0 0.0 0.0 +Prevotella_sp_54790 0 0.0 0.0 +Pseudoalteromonas_marina_56774 0 0.0 0.0 +Lachnospiraceae_bacterium_60438 0 0.0 0.0 +Lachnospiraceae_bacterium_60439 0 0.0 0.0 +Sphingomonas_sp_58049 0 0.0 0.0 +Lachnospiraceae_bacterium_60437 0 0.0 0.0 +Dorea_formicigenerans_56346 0 0.0 0.0 +Moritella_dasanensis_59440 0 0.0 0.0 +Brevundimonas_aveniformis_58737 0 0.0 0.0 +Buchnera_aphidicola_60984 0 0.0 0.0 +Bacteroides_pectinophilus_61619 0 0.0 0.0 +Leptospira_sp_59751 0 0.0 0.0 +Lactobacillus_vini_54110 0 0.0 0.0 +Eubacteriaceae_bacterium_57478 0 0.0 0.0 +Geobacter_lovleyi_61451 0 0.0 0.0 +Providencia_rettgeri_61888 0 0.0 0.0 +Calothrix_sp_62687 0 0.0 0.0 +Propionibacterium_jensenii_59003 0 0.0 0.0 +Burkholderia_cepacia_56702 0 0.0 0.0 +Streptomycetaceae_bacterium_60290 0 0.0 0.0 +Lactobacillus_casei_50461 0 0.0 0.0 +Lachnoclostridium_phytofermentans_46804 0 0.0 0.0 +Pseudonocardia_spinosispora_59013 0 0.0 0.0 +Vibrio_genomosp_59402 0 0.0 0.0 +Beta_proteobacterium_61746 0 0.0 0.0 +Streptomyces_vitaminophilus_59095 0 0.0 0.0 +Chromobacterium_violaceum_55554 0 0.0 0.0 +Streptomyces_albus_62086 0 0.0 0.0 +Francisella_sp_60864 0 0.0 0.0 +Nitratiruptor_sp_61387 0 0.0 0.0 +Clostridium_botulinum_57820 0 0.0 0.0 +Enterococcus_hirae_55131 0 0.0 0.0 +Brachybacterium_phenoliresistens_61435 0 0.0 0.0 +Nocardiopsis_chromatogenes_59774 0 0.0 0.0 +Prevotella_copri_61740 0 0.0 0.0 +Achromobacter_arsenitoxydans_61601 0 0.0 0.0 +Gammaproteobacteria_bacterium_60717 0 0.0 0.0 +Streptococcus_sp_61820 0 0.0 0.0 +Sinorhizobium_terangae_58416 0 0.0 0.0 +Paenibacillus_polymyxa_58056 0 0.0 0.0 +Prochlorococcus_marinus_62548 0 0.0 0.0 +Pantoea_sp_60700 0 0.0 0.0 +Pantoea_sp_60701 0 0.0 0.0 +Streptococcus_suis_56807 0 0.0 0.0 +Prochlorococcus_marinus_62547 0 0.0 0.0 +Cloacibacillus_evryensis_54931 0 0.0 0.0 +Desulfovibrio_aespoeensis_62002 0 0.0 0.0 +Paenibacillus_sp_58378 0 0.0 0.0 +Paenibacillus_sp_58371 0 0.0 0.0 +Yersinia_enterocolitica_57651 0 0.0 0.0 +Ottowia_thiooxydans_58972 0 0.0 0.0 +Bacillus_cereus_58113 0 0.0 0.0 +Shewanella_woodyi_61423 0 0.0 0.0 +Frankia_sp_61025 0 0.0 0.0 +Rhizobium_selenitireducens_60141 0 0.0 0.0 +Helicobacter_pullorum_61742 0 0.0 0.0 +Nonlabens_marinus_60609 0 0.0 0.0 +Coprobacillus_sp_47700 0 0.0 0.0 +Desulfotomaculum_ruminis_62150 0 0.0 0.0 +Bifidobacterium_minimum_46334 0 0.0 0.0 +Pseudomonas_fulva_61610 0 0.0 0.0 +Alcanivorax_jadensis_59365 0 0.0 0.0 +Bartonella_elizabethae_53954 0 0.0 0.0 +Pseudobutyrivibrio_ruminis_59908 0 0.0 0.0 +Bifidobacterium_asteroides_44522 0 0.0 0.0 +Knoellia_subterranea_60320 0 0.0 0.0 +Burkholderia_cenocepacia_58253 0 0.0 0.0 +Pseudomonas_fluorescens_62233 0 0.0 0.0 +Riemerella_columbina_59025 0 0.0 0.0 +Brevibacillus_borstelensis_53776 0 0.0 0.0 +Zimmermannella_faecalis_59885 0 0.0 0.0 +Anaplasma_marginale_55765 0 0.0 0.0 +Prevotella_bryantii_53955 0 0.0 0.0 +Streptacidiphilus_jeojiense_61507 0 0.0 0.0 +Pantoea_stewartii_54929 0 0.0 0.0 +Leptotrichia_hofstadii_57828 0 0.0 0.0 +Ralstonia_pickettii_57911 0 0.0 0.0 +Pseudomonas_taeanensis_60351 0 0.0 0.0 +Slackia_piriformis_62217 0 0.0 0.0 +Lactobacillus_plantarum_54610 0 0.0 0.0 +Methylobacterium_populi_61518 0 0.0 0.0 +Tepidiphilus_margaritifer_59099 0 0.0 0.0 +Thermodesulfobacterium_geofontis_62313 0 0.0 0.0 +Ruminococcus_bromii_62047 0 0.0 0.0 +Gluconacetobacter_xylinus_61965 0 0.0 0.0 +Rhizobium_tropici_62157 0 0.0 0.0 +Alteromonas_sp_58422 0 0.0 0.0 +Tistrella_mobilis_58598 0 0.0 0.0 +Persephonella_sp_59290 0 0.0 0.0 +Persephonella_sp_59291 0 0.0 0.0 +Frankia_sp_59933 0 0.0 0.0 +Ehrlichia_mineirensis_59752 0 0.0 0.0 +Anaerophaga_thermohalophila_59207 0 0.0 0.0 +Lachnospiraceae_bacterium_56970 0 0.0 0.0 +Pyrinomonas_methylaliphatogenes_61552 0 0.0 0.0 +Cyanothece_sp_61647 0 0.0 0.0 +Neisseria_polysaccharea_62560 0 0.0 0.0 +Idiomarina_sediminum_58888 0 0.0 0.0 +Streptococcus_oralis_58319 0 0.0 0.0 +Coriobacteriaceae_bacterium_58375 0 0.0 0.0 +Dickeya_chrysanthemi_57954 0 0.0 0.0 +Chryseobacterium_solincola_61671 0 0.0 0.0 +Anaerophaga_sp_61385 0 0.0 0.0 +Streptomyces_albulus_60352 0 0.0 0.0 +Enterococcus_gallinarum_52312 0 0.0 0.0 +Helicobacter_pylori_59959 0 0.0 0.0 +Helicobacter_pylori_59958 0 0.0 0.0 +Helicobacter_pylori_61834 0 0.0 0.0 +Kitasatospora_phosalacinea_58242 0 0.0 0.0 +Actinomyces_coleocanis_61704 0 0.0 0.0 +Rhodospirillum_rubrum_45135 0 0.0 0.0 +Arenimonas_metalli_60306 0 0.0 0.0 +Burkholderia_thailandensis_54362 0 0.0 0.0 +Fibrisoma_limi_59392 0 0.0 0.0 +Commensalibacter_intestini_58526 0 0.0 0.0 +Bartonella_doshiae_44885 0 0.0 0.0 +Agromyces_subbeticus_58681 0 0.0 0.0 +Clostridium_stercorarium_52315 0 0.0 0.0 +Bacillus_sp_59251 0 0.0 0.0 +Cellvibrio_japonicus_61648 0 0.0 0.0 +Pseudomonas_fluorescens_61148 0 0.0 0.0 +Pseudomonas_fluorescens_61149 0 0.0 0.0 +Azonexus_hydrophilus_58718 0 0.0 0.0 +Burkholderia_terrae_58119 0 0.0 0.0 +Clostridiales_bacterium_60572 0 0.0 0.0 +Butyricimonas_virosa_58742 0 0.0 0.0 +Thiorhodovibrio_sp_61955 0 0.0 0.0 +Bacillus_pumilus_58137 0 0.0 0.0 +Campylobacter_sp_60760 0 0.0 0.0 +Leuconostoc_pseudomesenteroides_51925 0 0.0 0.0 +Acinetobacter_tandoii_58658 0 0.0 0.0 +Thermithiobacillus_tepidarius_59106 0 0.0 0.0 +Helicobacter_canis_60239 0 0.0 0.0 +Thiomicrospira_halophila_59138 0 0.0 0.0 +Methylocystis_rosea_58208 0 0.0 0.0 +Rhodanobacter_fulvus_59309 0 0.0 0.0 +Lewinella_persica_58916 0 0.0 0.0 +Streptococcus_dysgalactiae_58236 0 0.0 0.0 +Fluviicola_taffensis_62258 0 0.0 0.0 +Corynebacterium_timonense_59449 0 0.0 0.0 +Segniliparus_rotundus_61988 0 0.0 0.0 +Alteromonas_macleodii_57644 0 0.0 0.0 +Xenococcus_sp_58339 0 0.0 0.0 +Nonomuraea_coxensis_58962 0 0.0 0.0 +Marinobacter_manganoxydans_58552 0 0.0 0.0 +Mahella_australiensis_62153 0 0.0 0.0 +Allochromatium_vinosum_61838 0 0.0 0.0 +Rhizobium_leguminosarum_62565 0 0.0 0.0 +Buchnera_aphidicola_58317 0 0.0 0.0 +Staphylococcus_schleiferi_56081 0 0.0 0.0 +Acidovorax_sp_59876 0 0.0 0.0 +Acidovorax_sp_59875 0 0.0 0.0 +Gloeocapsa_sp_59351 0 0.0 0.0 +Paracoccus_pantotrophus_50212 0 0.0 0.0 +Campylobacter_peloridis_60331 0 0.0 0.0 +Acaricomes_phytoseiuli_58656 0 0.0 0.0 +Leuconostoc_sp_62637 0 0.0 0.0 +Clostridium_sticklandii_61652 0 0.0 0.0 +Azorhizobium_doebereinerae_58394 0 0.0 0.0 +Patulibacter_americanus_58988 0 0.0 0.0 +Pseudonocardia_sp_62273 0 0.0 0.0 +Streptomyces_yeochonensis_60585 0 0.0 0.0 +Vibrio_orientalis_33744 0 0.0 0.0 +Beggiatoa_alba_61428 0 0.0 0.0 +Photobacterium_damselae_62096 0 0.0 0.0 +Novosphingobium_acidiphilum_58963 0 0.0 0.0 +Symbiobacterium_thermophilum_61141 0 0.0 0.0 +Mycobacterium_sp_60249 0 0.0 0.0 +Clostridium_phytofermentans_61323 0 0.0 0.0 +Pseudomonas_sp_62126 0 0.0 0.0 +Legionella_lansingensis_58908 0 0.0 0.0 +Leptospira_borgpetersenii_59975 0 0.0 0.0 +Demetria_terragena_58789 0 0.0 0.0 +Prevotella_sp_60509 0 0.0 0.0 +Lactobacillus_sakei_57195 0 0.0 0.0 +Pseudomonas_nitroreducens_54558 0 0.0 0.0 +Alkaliphilus_transvaalensis_60415 0 0.0 0.0 +Psychrobacter_sp_61302 0 0.0 0.0 +Bacillus_licheniformis_58033 0 0.0 0.0 +Bacteroides_paurosaccharolyticus_59699 0 0.0 0.0 +Bacteroides_stercoris_56735 0 0.0 0.0 +Pseudomonas_putida_62305 0 0.0 0.0 +Eggerthella_lenta_56463 0 0.0 0.0 +Alpha_proteobacterium_58335 0 0.0 0.0 +Kytococcus_sedentarius_61609 0 0.0 0.0 +Lactobacillus_sanfranciscensis_62185 0 0.0 0.0 +Aggregatibacter_actinomycetemcomitans_57999 0 0.0 0.0 +Corynebacterium_sp_60711 0 0.0 0.0 +Microcystis_aeruginosa_58066 0 0.0 0.0 +Oligella_urethralis_56744 0 0.0 0.0 +Acholeplasma_equifetale_60411 0 0.0 0.0 +Bifidobacterium_gallicum_34096 0 0.0 0.0 +Cyanobium_sp_60954 0 0.0 0.0 +Balneatrix_alpica_58729 0 0.0 0.0 +Enterococcus_columbae_44734 0 0.0 0.0 +Diplorickettsia_massiliensis_59275 0 0.0 0.0 +Verrucomicrobium_sp_60383 0 0.0 0.0 +Methylomarinum_vadi_61511 0 0.0 0.0 +Achromobacter_xylosoxidans_56249 0 0.0 0.0 +Pseudomonas_poae_54483 0 0.0 0.0 +Pseudomonas_sp_59155 0 0.0 0.0 +Haloferula_sp_60353 0 0.0 0.0 +Caulobacter_sp_60013 0 0.0 0.0 +Lactobacillus_farraginis_59707 0 0.0 0.0 +Wolbachia_endosymbiont_61061 0 0.0 0.0 +Jonesia_denitrificans_61594 0 0.0 0.0 +Sphingopyxis_sp_60791 0 0.0 0.0 +Corallococcus_coralloides_59208 0 0.0 0.0 +Mobilicoccus_sp_60804 0 0.0 0.0 +Lactobacillus_hilgardii_56983 0 0.0 0.0 +Actinobacillus_ureae_62439 0 0.0 0.0 +Anaerovibrio_sp_59434 0 0.0 0.0 +Alkanindiges_illinoisensis_58692 0 0.0 0.0 +Nocardia_niigatensis_59471 0 0.0 0.0 +Klebsiella_pneumoniae_54688 0 0.0 0.0 +Burkholderia_sp_53411 0 0.0 0.0 +Bacillus_panaciterrae_58728 0 0.0 0.0 +Moraxella_macacae_59638 0 0.0 0.0 +Carnobacterium_jeotgali_49590 0 0.0 0.0 +Neisseria_subflava_61760 0 0.0 0.0 +Lactobacillus_murinus_59691 0 0.0 0.0 +Pantoea_sp_61911 0 0.0 0.0 +Lactobacillus_parafarraginis_62320 0 0.0 0.0 +Bacillus_sp_59406 0 0.0 0.0 +Bradyrhizobium_japonicum_56600 0 0.0 0.0 +Saccharomonospora_cyanea_62411 0 0.0 0.0 +Desulforudis_audaxviator_61605 0 0.0 0.0 +Alpha_proteobacterium_59674 0 0.0 0.0 +Knoellia_sinensis_60319 0 0.0 0.0 +Catellibacterium_nectariphilum_58745 0 0.0 0.0 +Philaenus_spumarius_symbiont_59396 0 0.0 0.0 +Desulfovermiculus_halophilus_58807 0 0.0 0.0 +Cetobacterium_sp_53242 0 0.0 0.0 +Pusillimonas_sp_58328 0 0.0 0.0 +Gluconobacter_oxydans_48286 0 0.0 0.0 +Marinobacterium_rhizophilum_58927 0 0.0 0.0 +Rothia_mucilaginosa_62109 0 0.0 0.0 +Lonsdalea_quercina_51572 0 0.0 0.0 +Carnobacterium_alterfunditum_60573 0 0.0 0.0 +Thiorhodococcus_sp_59789 0 0.0 0.0 +Clostridium_sp_62634 0 0.0 0.0 +Clostridium_sp_62633 0 0.0 0.0 +Enterococcus_saccharolyticus_44559 0 0.0 0.0 +Butyrivibrio_sp_57178 0 0.0 0.0 +Marivirga_tractuosa_62004 0 0.0 0.0 +Fischerella_muscicola_61354 0 0.0 0.0 +Synechococcus_sp_59355 0 0.0 0.0 +Enterobacter_cloacae_58479 0 0.0 0.0 +Porphyromonas_levii_59000 0 0.0 0.0 +Fusobacterium_perfoetens_60423 0 0.0 0.0 +Loktanella_vestfoldensis_58918 0 0.0 0.0 +Arenimonas_donghaensis_58706 0 0.0 0.0 +Achromobacter_piechaudii_59272 0 0.0 0.0 +Glomeribacter_gigasporarum_58478 0 0.0 0.0 +Shewanella_xiamenensis_57641 0 0.0 0.0 +Sinorhizobium_fredii_56213 0 0.0 0.0 +Halomonas_zhanjiangensis_61851 0 0.0 0.0 +Deinococcus_frigens_58786 0 0.0 0.0 +Campylobacter_lari_61167 0 0.0 0.0 +Oceanobacillus_iheyensis_61020 0 0.0 0.0 +Planococcus_sp_60852 0 0.0 0.0 +Sporolactobacillus_laevolacticus_60350 0 0.0 0.0 +Halomonas_titanicae_56683 0 0.0 0.0 +Gluconobacter_oxydans_59967 0 0.0 0.0 +Elioraea_tepidiphila_58831 0 0.0 0.0 +Ferrimonas_futtsuensis_58840 0 0.0 0.0 +Arthrobacter_gangotriensis_59877 0 0.0 0.0 +Mycobacterium_rhodesiae_62551 0 0.0 0.0 +Bradyrhizobium_sp_58221 0 0.0 0.0 +Acidothermus_cellulolyticus_61314 0 0.0 0.0 +Idiomarina_xiamenensis_62203 0 0.0 0.0 +Dickeya_sp_59612 0 0.0 0.0 +Desulfotomaculum_alcoholivorax_58803 0 0.0 0.0 +Photorhabdus_temperata_55030 0 0.0 0.0 +Pseudoxanthomonas_spadix_58430 0 0.0 0.0 +Klebsiella_oxytoca_57801 0 0.0 0.0 +Phaeomarinobacter_ectocarpi_60619 0 0.0 0.0 +Geoalkalibacter_ferrihydriticus_58857 0 0.0 0.0 +Tannerella_forsythia_60991 0 0.0 0.0 +SAR406_cluster_62595 0 0.0 0.0 +Staphylococcus_warneri_61923 0 0.0 0.0 +Lactobacillus_ultunensis_61712 0 0.0 0.0 +Synechococcus_sp_61636 0 0.0 0.0 +Pantoea_vagans_57743 0 0.0 0.0 +Leminorella_grimontii_45169 0 0.0 0.0 +Rickettsia_typhi_45301 0 0.0 0.0 +Pseudomonas_sp_59307 0 0.0 0.0 +Prevotella_bergensis_61881 0 0.0 0.0 +Criblamydia_sequanensis_60515 0 0.0 0.0 +Fervidobacterium_nodosum_61373 0 0.0 0.0 +Helicobacter_pylori_59598 0 0.0 0.0 +Fischerella_muscicola_61168 0 0.0 0.0 +Massilia_sp_60758 0 0.0 0.0 +Haemophilus_haemolyticus_58352 0 0.0 0.0 +Haemophilus_haemolyticus_58351 0 0.0 0.0 +Haemophilus_haemolyticus_58350 0 0.0 0.0 +Desulfurobacterium_sp_59289 0 0.0 0.0 +Xenophilus_azovorans_59131 0 0.0 0.0 +Streptomyces_sulphureus_57871 0 0.0 0.0 +Anaerobaculum_hydrogeniformans_61903 0 0.0 0.0 +Kaistia_granuli_58894 0 0.0 0.0 +Clostridium_sp_61556 0 0.0 0.0 +Salinispora_pacifica_60058 0 0.0 0.0 +Frankia_sp_58353 0 0.0 0.0 +Nostoc_punctiforme_61976 0 0.0 0.0 +Pseudoalteromonas_haloplanktis_57908 0 0.0 0.0 +Roseovarius_sp_61197 0 0.0 0.0 +Yersinia_kristensenii_61733 0 0.0 0.0 +Kinetoplastibacterium_blastocrithidii_43515 0 0.0 0.0 +Flavobacterium_denitrificans_58844 0 0.0 0.0 +Rhodococcus_sp_60052 0 0.0 0.0 +Actinomadura_madurae_60348 0 0.0 0.0 +Acinetobacter_gerneri_44753 0 0.0 0.0 +Sorangium_cellulosum_61543 0 0.0 0.0 +Lewinella_cohaerens_58915 0 0.0 0.0 +Roseobacter_sp_61196 0 0.0 0.0 +Turicibacter_sanguinis_52329 0 0.0 0.0 +Dickeya_zeae_57297 0 0.0 0.0 +Streptococcus_sp_58554 0 0.0 0.0 +Lysinibacillus_fusiformis_53142 0 0.0 0.0 +Marinococcus_halotolerans_58928 0 0.0 0.0 +Bacillus_boroniphilus_48964 0 0.0 0.0 +Burkholderia_cenocepacia_62624 0 0.0 0.0 +Prevotella_bivia_55194 0 0.0 0.0 +Borrelia_persica_60484 0 0.0 0.0 +Alistipes_shahii_62199 0 0.0 0.0 +Selenomonas_infelix_62103 0 0.0 0.0 +Streptococcus_sp_61583 0 0.0 0.0 +Roseovarius_mucosus_59966 0 0.0 0.0 +Pandoraea_pnomenusa_53996 0 0.0 0.0 +Flavobacterium_sp_59179 0 0.0 0.0 +Campylobacter_cuniculorum_58743 0 0.0 0.0 +Aggregatibacter_segnis_62447 0 0.0 0.0 +Corynebacterium_striatum_61709 0 0.0 0.0 +Mesoflavibacter_zeaxanthinifaciens_58941 0 0.0 0.0 +Burkholderia_sp_62078 0 0.0 0.0 +Arthrobacter_sp_60718 0 0.0 0.0 +Clostridium_anorexicamassiliense_59513 0 0.0 0.0 +Campylobacter_lari_58359 0 0.0 0.0 +Olivibacter_sitiensis_58970 0 0.0 0.0 +Gemella_haemolysans_61816 0 0.0 0.0 +Intrasporangium_oryzae_60325 0 0.0 0.0 +Planctomyces_maris_61298 0 0.0 0.0 +Flavobacterium_chungangense_60600 0 0.0 0.0 +Listeria_welshimeri_61386 0 0.0 0.0 +Olsenella_profusa_59149 0 0.0 0.0 +Alcaligenes_sp_60356 0 0.0 0.0 +Wolbachia_endosymbiont_58286 0 0.0 0.0 +Nocardia_rhamnosiphila_34405 0 0.0 0.0 +Psychrobacter_sp_58307 0 0.0 0.0 +Brevundimonas_naejangsanensis_58739 0 0.0 0.0 +Ralstonia_pickettii_56648 0 0.0 0.0 +Corynebacterium_matruchotii_57066 0 0.0 0.0 +Clostridium_cadaveris_59910 0 0.0 0.0 +Nocardioidaceae_bacterium_61469 0 0.0 0.0 +Bacillus_azotoformans_56969 0 0.0 0.0 +Staphylococcus_pseudintermedius_53521 0 0.0 0.0 +Pseudomonas_synxantha_56835 0 0.0 0.0 +Cedecea_davisae_61828 0 0.0 0.0 +Prevotella_amnii_56408 0 0.0 0.0 +Gluconobacter_thailandicus_57529 0 0.0 0.0 +Deinococcus_sp_60713 0 0.0 0.0 +Clostridium_pasteurianum_43207 0 0.0 0.0 +Chryseobacterium_sp_60752 0 0.0 0.0 +Chryseobacterium_sp_60750 0 0.0 0.0 +Blastococcus_sp_60270 0 0.0 0.0 +Acinetobacter_sp_58355 0 0.0 0.0 +Nocardia_paucivorans_59472 0 0.0 0.0 +Bacillus_atrophaeus_55742 0 0.0 0.0 +Sulfurovum_sp_60844 0 0.0 0.0 +Sulfurovum_sp_60845 0 0.0 0.0 +Sulfurovum_sp_60843 0 0.0 0.0 +Psychromonas_sp_61206 0 0.0 0.0 +Acidobacterium_sp_60303 0 0.0 0.0 +Cronobacter_muytjensii_59294 0 0.0 0.0 +Lactobacillus_rhamnosus_57549 0 0.0 0.0 +Coriobacteriaceae_bacterium_60818 0 0.0 0.0 +Synergistetes_bacterium_62033 0 0.0 0.0 +Flavobacterium_subsaxonicum_44731 0 0.0 0.0 +Xylanibacter_oryzae_62511 0 0.0 0.0 +Streptomyces_griseorubens_58249 0 0.0 0.0 +Tepidanaerobacter_acetatoxydans_47107 0 0.0 0.0 +Loktanella_hongkongensis_58917 0 0.0 0.0 +Ensifer_sp_60163 0 0.0 0.0 +Photobacterium_halotolerans_58993 0 0.0 0.0 +Holospora_undulata_55121 0 0.0 0.0 +Deinococcus_maricopensis_62173 0 0.0 0.0 +Marinimicrobium_agarilyticum_58923 0 0.0 0.0 +Pseudomonas_sp_59823 0 0.0 0.0 +Rhodococcus_pyridinivorans_54937 0 0.0 0.0 +Streptomyces_erythrochromogenes_58252 0 0.0 0.0 +Campylobacter_hyointestinalis_62505 0 0.0 0.0 +Treponema_sp_60430 0 0.0 0.0 +Treponema_saccharophilum_62485 0 0.0 0.0 +Acetobacter_aceti_60614 0 0.0 0.0 +Bacillus_sp_35049 0 0.0 0.0 +Listeriaceae_bacterium_54420 0 0.0 0.0 +Anaerovibrio_lipolyticus_60416 0 0.0 0.0 +Propionibacterium_sp_59454 0 0.0 0.0 +Helicobacter_pylori_62679 0 0.0 0.0 +Propionibacterium_sp_59451 0 0.0 0.0 +Helicobacter_pylori_62672 0 0.0 0.0 +Brachyspira_aalborgi_61157 0 0.0 0.0 +Helicobacter_pylori_62670 0 0.0 0.0 +Helicobacter_pylori_62671 0 0.0 0.0 +Helicobacter_pylori_62676 0 0.0 0.0 +Helicobacter_pylori_62677 0 0.0 0.0 +Aliivibrio_salmonicida_56849 0 0.0 0.0 +Helicobacter_pylori_62675 0 0.0 0.0 +Clostridium_methylpentosum_61741 0 0.0 0.0 +Photobacterium_aphoticum_62250 0 0.0 0.0 +Metascardovia_criceti_58943 0 0.0 0.0 +Xanthomonas_vesicatoria_55368 0 0.0 0.0 +Empedobacter_brevis_59574 0 0.0 0.0 +Corynebacterium_falsenii_60592 0 0.0 0.0 +Microbacterium_sp_60740 0 0.0 0.0 +Leptolyngbya_sp_59624 0 0.0 0.0 +Lachnospiraceae_bacterium_61439 0 0.0 0.0 +Streptomyces_sp_60689 0 0.0 0.0 +Beijerinckia_mobilis_61035 0 0.0 0.0 +Actinopolyspora_erythraea_61488 0 0.0 0.0 +Clostridiales_bacterium_52957 0 0.0 0.0 +Flavihumibacter_sp_60632 0 0.0 0.0 +Prochlorococcus_marinus_58124 0 0.0 0.0 +Treponema_caldaria_62224 0 0.0 0.0 +Microbacterium_sp_60910 0 0.0 0.0 +Buttiauxella_agrestis_62324 0 0.0 0.0 +Rothia_mucilaginosa_58144 0 0.0 0.0 +Streptomyces_viridochromogenes_59297 0 0.0 0.0 +Formosa_agariphila_60197 0 0.0 0.0 +Ferriphaselus_sp_60704 0 0.0 0.0 +Sulfurospirillum_arsenophilum_60217 0 0.0 0.0 +Bdellovibrio_bacteriovorus_55420 0 0.0 0.0 +Erysipelothrix_rhusiopathiae_56338 0 0.0 0.0 +Chlamydophila_caviae_61033 0 0.0 0.0 +Enterococcus_cecorum_44736 0 0.0 0.0 +Bacillus_marmarensis_57685 0 0.0 0.0 +Proteus_mirabilis_55046 0 0.0 0.0 +Brachyspira_hampsonii_59971 0 0.0 0.0 +Streptomonospora_alba_60957 0 0.0 0.0 +Holdemania_sp_59514 0 0.0 0.0 +Tannerella_sp_60461 0 0.0 0.0 +Alcanivorax_borkumensis_54471 0 0.0 0.0 +Oscillibacter_sp_60799 0 0.0 0.0 +Rhodococcus_opacus_58217 0 0.0 0.0 +Serratia_marcescens_43442 0 0.0 0.0 +Vibrio_sp_59669 0 0.0 0.0 +Streptomyces_sp_60656 0 0.0 0.0 +Sediminimonas_qiaohouensis_59051 0 0.0 0.0 +Moraxella_bovoculi_62223 0 0.0 0.0 +Lachnospiraceae_bacterium_61440 0 0.0 0.0 +Lebetimonas_sp_62658 0 0.0 0.0 +Lachnospiraceae_bacterium_61441 0 0.0 0.0 +Paenibacillus_alginolyticus_58973 0 0.0 0.0 +Serratia_grimesii_62325 0 0.0 0.0 +Paenirhodobacter_enshiensis_58590 0 0.0 0.0 +Mannheimia_granulomatis_58222 0 0.0 0.0 +Desulfarculus_baarsii_62007 0 0.0 0.0 +Wohlfahrtiimonas_chitiniclastica_57893 0 0.0 0.0 +Synechococcus_sp_61187 0 0.0 0.0 +Clostridium_hathewayi_62211 0 0.0 0.0 +Pseudomonas_alcaligenes_59541 0 0.0 0.0 +Streptomyces_sp_60659 0 0.0 0.0 +Bosea_sp_60787 0 0.0 0.0 +Rhodopseudomonas_sp_62627 0 0.0 0.0 +Neisseria_weaveri_56837 0 0.0 0.0 +Bartonella_vinsonii_53507 0 0.0 0.0 +Salinibacter_ruber_61174 0 0.0 0.0 +Amycolatopsis_decaplanina_59941 0 0.0 0.0 +Burkholderia_grimmiae_58482 0 0.0 0.0 +Streptococcus_salivarius_58022 0 0.0 0.0 +Streptococcus_salivarius_58024 0 0.0 0.0 +Nitrosomonas_sp_61072 0 0.0 0.0 +Thiothrix_nivea_62381 0 0.0 0.0 +Thermus_oshimai_55214 0 0.0 0.0 +Pseudomonas_fluorescens_59651 0 0.0 0.0 +Elizabethkingia_meningoseptica_43467 0 0.0 0.0 +Bacillus_psychrosaccharolyticus_59357 0 0.0 0.0 +Staphylococcus_arlettae_53435 0 0.0 0.0 +Hydrogenobaculum_sp_46940 0 0.0 0.0 +Helicobacter_pylori_58192 0 0.0 0.0 +Comamonadaceae_bacterium_61937 0 0.0 0.0 +Asaia_astilbis_59700 0 0.0 0.0 +Pseudomonas_aeruginosa_55861 0 0.0 0.0 +Oenococcus_oeni_56041 0 0.0 0.0 +Clostridiales_bacterium_62395 0 0.0 0.0 +Moraxella_catarrhalis_55777 0 0.0 0.0 +Thermosipho_africanus_54847 0 0.0 0.0 +Serratia_sp_58432 0 0.0 0.0 +Streptococcus_thoraltensis_59092 0 0.0 0.0 +Nocardia_thailandica_59477 0 0.0 0.0 +Alloscardovia_omnicolens_54782 0 0.0 0.0 +Tetragenococcus_muriaticus_53913 0 0.0 0.0 +Weissella_oryzae_60117 0 0.0 0.0 +Pseudoalteromonas_undina_58637 0 0.0 0.0 +Lactobacillus_jensenii_51108 0 0.0 0.0 +Formosa_sp_59199 0 0.0 0.0 +Stenotrophomonas_maltophilia_62375 0 0.0 0.0 +Sporosarcina_ureae_59074 0 0.0 0.0 +Martelella_mediterranea_58933 0 0.0 0.0 +Geopsychrobacter_electrodiphilus_58859 0 0.0 0.0 +Chlamydophila_felis_61076 0 0.0 0.0 +Haemophilus_parainfluenzae_62356 0 0.0 0.0 +Syntrophus_aciditrophicus_61830 0 0.0 0.0 +Clostridium_sp_60113 0 0.0 0.0 +Pseudomonas_putida_60588 0 0.0 0.0 +Gluconacetobacter_xylinus_59996 0 0.0 0.0 +Sphingobium_xenophagum_57391 0 0.0 0.0 +Piscirickettsia_salmonis_58108 0 0.0 0.0 +Thermovibrio_ammonificans_62022 0 0.0 0.0 +Pseudovibrio_sp_58019 0 0.0 0.0 +Oscillatoria_formosa_34823 0 0.0 0.0 +Bacillus_cereus_61731 0 0.0 0.0 +Pelagibacter_ubique_57110 0 0.0 0.0 +Planococcus_antarcticus_59390 0 0.0 0.0 +Intestinimonas_butyriciproducens_60001 0 0.0 0.0 +Streptacidiphilus_neutrinimicus_58456 0 0.0 0.0 +Kandleria_vitulina_54464 0 0.0 0.0 +Corynebacterium_caspium_58770 0 0.0 0.0 +Campylobacter_lari_58115 0 0.0 0.0 +Lactobacillus_brevis_56823 0 0.0 0.0 +Ectothiorhodospira_haloalkaliphila_46691 0 0.0 0.0 +Salinibacterium_sp_58617 0 0.0 0.0 +Methylosinus_sp_58083 0 0.0 0.0 +Prevotella_scopos_59712 0 0.0 0.0 +Afipia_sp_60503 0 0.0 0.0 +Uliginosibacterium_gangwonense_59121 0 0.0 0.0 +Clostridium_clariflavum_53531 0 0.0 0.0 +Humibacter_albus_58885 0 0.0 0.0 +Phyllobacterium_sp_59233 0 0.0 0.0 +Massilia_alkalitolerans_58103 0 0.0 0.0 +Mycobacterium_tuberculosis_57144 0 0.0 0.0 +Desulfovibrio_alaskensis_54439 0 0.0 0.0 +Labrenzia_aggregata_61384 0 0.0 0.0 +Pelagibaca_bermudensis_61198 0 0.0 0.0 +Actinomyces_naeslundii_58629 0 0.0 0.0 +Streptomyces_sp_57280 0 0.0 0.0 +Arthrobacter_castelli_58710 0 0.0 0.0 +Isosphaera_pallida_61852 0 0.0 0.0 +Rhodococcus_sp_59862 0 0.0 0.0 +Bradyrhizobium_sp_60965 0 0.0 0.0 +Curtobacterium_flaccumfaciens_54656 0 0.0 0.0 +Helicobacter_pylori_58201 0 0.0 0.0 +Prevotella_buccalis_62098 0 0.0 0.0 +Gamma_proteobacterium_61415 0 0.0 0.0 +Alicyclobacillus_pomorum_58603 0 0.0 0.0 +Leadbetterella_byssophila_62024 0 0.0 0.0 +Catenovulum_agarivorans_62052 0 0.0 0.0 +Saccharibacter_sp_60184 0 0.0 0.0 +Accumulibacter_phosphatis_61698 0 0.0 0.0 +Desulfococcus_multivorans_58799 0 0.0 0.0 +Helicobacter_pylori_58343 0 0.0 0.0 +Weissella_ceti_50390 0 0.0 0.0 +Bacillus_sp_60397 0 0.0 0.0 +Nocardia_concava_59478 0 0.0 0.0 +Vibrio_halioticoli_59584 0 0.0 0.0 +Ruminococcus_lactaris_55568 0 0.0 0.0 +Desulfovibrio_magneticus_61844 0 0.0 0.0 +Streptococcus_suis_59539 0 0.0 0.0 +Streptococcus_suis_59538 0 0.0 0.0 +Streptococcus_suis_59537 0 0.0 0.0 +Streptococcus_suis_59536 0 0.0 0.0 +Streptococcus_suis_59535 0 0.0 0.0 +Streptococcus_suis_59534 0 0.0 0.0 +Streptococcus_suis_59533 0 0.0 0.0 +Mycobacterium_leprae_49575 0 0.0 0.0 +Streptococcus_suis_59531 0 0.0 0.0 +Streptococcus_suis_59530 0 0.0 0.0 +Mycobacterium_sp_60280 0 0.0 0.0 +Streptomyces_zinciresistens_62161 0 0.0 0.0 +Ketogulonicigenium_vulgare_46611 0 0.0 0.0 +Paenisporosarcina_sp_59509 0 0.0 0.0 +Vibrio_tubiashii_61156 0 0.0 0.0 +Ilumatobacter_nonamiense_60074 0 0.0 0.0 +Flavobacterium_indicum_58542 0 0.0 0.0 +Frankia_sp_61163 0 0.0 0.0 +Frankia_sp_61162 0 0.0 0.0 +Frankia_sp_61161 0 0.0 0.0 +Cellulophaga_algicola_62131 0 0.0 0.0 +Flavobacterium_columnare_58418 0 0.0 0.0 +Vibrio_diazotrophicus_60207 0 0.0 0.0 +Firmicutes_bacterium_60165 0 0.0 0.0 +Salinimicrobium_terrae_59042 0 0.0 0.0 +Saxeibacter_lacteus_59048 0 0.0 0.0 +Streptococcus_pneumoniae_60081 0 0.0 0.0 +Borrelia_garinii_57511 0 0.0 0.0 +Bacillus_sp_60728 0 0.0 0.0 +Modestobacter_sp_60809 0 0.0 0.0 +Oceanobacillus_oncorhynchi_61750 0 0.0 0.0 +Arthrobacter_sp_58580 0 0.0 0.0 +Acholeplasma_hippikon_60412 0 0.0 0.0 +Silicibacter_lacuscaerulensis_62006 0 0.0 0.0 +Leptospira_terpstrae_59803 0 0.0 0.0 +Psychromonas_arctica_59019 0 0.0 0.0 +Acetobacter_pasteurianus_59840 0 0.0 0.0 +Microbacterium_testaceum_62636 0 0.0 0.0 +Tenacibaculum_sp_60278 0 0.0 0.0 +Pseudomonas_sp_59805 0 0.0 0.0 +Pseudomonas_sp_59807 0 0.0 0.0 +Pseudomonas_sp_59806 0 0.0 0.0 +Rhizobium_sp_60825 0 0.0 0.0 +Pedobacter_saltans_62276 0 0.0 0.0 +Anaerococcus_prevotii_62402 0 0.0 0.0 +Gamma_proteobacterium_58013 0 0.0 0.0 +Escherichia_hermannii_58626 0 0.0 0.0 +Luteibacter_sp_60757 0 0.0 0.0 +Acinetobacter_harbinensis_60227 0 0.0 0.0 +Gordonia_amarae_58494 0 0.0 0.0 +Akkermansia_muciniphila_55290 0 0.0 0.0 +Burkholderia_acidipaludis_59565 0 0.0 0.0 +Leptospira_weilii_58090 0 0.0 0.0 +Legionella_massiliensis_45137 0 0.0 0.0 +Promicromonospora_sukumoe_59337 0 0.0 0.0 +Acinetobacter_sp_59562 0 0.0 0.0 +Acinetobacter_sp_59560 0 0.0 0.0 +Acinetobacter_sp_59561 0 0.0 0.0 +Bartonella_tribocorum_61376 0 0.0 0.0 +Burkholderiales_bacterium_60673 0 0.0 0.0 +Hyphomicrobium_zavarzinii_59847 0 0.0 0.0 +Desulfovibrio_desulfuricans_58813 0 0.0 0.0 +Corynebacterium_halotolerans_58773 0 0.0 0.0 +Bacteroidaceae_bacterium_60201 0 0.0 0.0 +Desulfosporosinus_acidiphilus_62018 0 0.0 0.0 +Prevotella_enoeca_59694 0 0.0 0.0 +Brevibacterium_massiliense_59361 0 0.0 0.0 +Vibrio_sinaloensis_62614 0 0.0 0.0 +Alicyclobacillus_contaminans_58689 0 0.0 0.0 +Burkholderia_dolosa_61311 0 0.0 0.0 +Enterobacter_lignolyticus_62163 0 0.0 0.0 +Pseudoalteromonas_haloplanktis_60126 0 0.0 0.0 +Prevotella_disiens_56471 0 0.0 0.0 +Alkaliphilus_metalliredigens_61146 0 0.0 0.0 +Rhodonellum_psychrophilum_45738 0 0.0 0.0 +Virgibacillus_sp_60727 0 0.0 0.0 +Acinetobacter_junii_57406 0 0.0 0.0 +Methylomonas_denitrificans_60841 0 0.0 0.0 +Waddlia_chondrophila_62190 0 0.0 0.0 +Streptococcus_sp_60086 0 0.0 0.0 +Bacillus_bogoriensis_60417 0 0.0 0.0 +Halomonas_campaniensis_61008 0 0.0 0.0 +Pseudomonas_chlororaphis_58080 0 0.0 0.0 +Selenomonas_sp_60435 0 0.0 0.0 +Streptomyces_sp_59503 0 0.0 0.0 +Kurthia_sp_58369 0 0.0 0.0 +Brachyspira_hampsonii_59957 0 0.0 0.0 +Prochlorococcus_marinus_49991 0 0.0 0.0 +Lachnoanaerobaculum_saburreum_57248 0 0.0 0.0 +Bacillus_halodurans_61094 0 0.0 0.0 +Enterobacter_sp_59441 0 0.0 0.0 +Gramella_portivictoriae_58871 0 0.0 0.0 +Sphingobium_sp_58455 0 0.0 0.0 +Halomonas_alkaliantarctica_61036 0 0.0 0.0 +Streptococcus_mitis_61876 0 0.0 0.0 +Streptococcus_mitis_61874 0 0.0 0.0 +Sporocytophaga_myxococcoides_60836 0 0.0 0.0 +Lactococcus_lactis_57073 0 0.0 0.0 +Lactobacillus_equicursoris_56389 0 0.0 0.0 +Acinetobacter_baumannii_58016 0 0.0 0.0 +Clostridium_sp_57418 0 0.0 0.0 +Enterococcus_sp_60486 0 0.0 0.0 +Variovorax_paradoxus_59280 0 0.0 0.0 +Corynebacterium_tuscaniense_60375 0 0.0 0.0 +Glaciecola_nitratireducens_58524 0 0.0 0.0 +Xanthomonas_axonopodis_61257 0 0.0 0.0 +Paenibacillus_wynnii_61086 0 0.0 0.0 +Pseudomonas_fluorescens_59815 0 0.0 0.0 +Listeria_fleischmannii_58260 0 0.0 0.0 +Chitinophaga_pinensis_61629 0 0.0 0.0 +Aeromonas_hydrophila_57782 0 0.0 0.0 +Amphibacillus_jilinensis_61814 0 0.0 0.0 +Pseudogulbenkiania_ferrooxidans_57466 0 0.0 0.0 +Lysobacter_dokdonensis_60026 0 0.0 0.0 +Acholeplasma_granularum_59882 0 0.0 0.0 +Brachybacterium_squillarum_58493 0 0.0 0.0 +Lactobacillus_florum_54012 0 0.0 0.0 +Thiomicrospira_chilensis_59137 0 0.0 0.0 +Bacillus_kribbensis_58727 0 0.0 0.0 +Desulfovibrio_aminophilus_58810 0 0.0 0.0 +Shewanella_marina_59716 0 0.0 0.0 +Oceanospirillum_beijerinckii_58967 0 0.0 0.0 +Campylobacter_lari_60330 0 0.0 0.0 +Advenella_kashmirensis_60498 0 0.0 0.0 +Corynebacterium_minutissimum_61377 0 0.0 0.0 +Ehrlichia_canis_61088 0 0.0 0.0 +Faecalibacterium_cf_62236 0 0.0 0.0 +Clostridium_sp_59546 0 0.0 0.0 +Stenotrophomonas_maltophilia_59502 0 0.0 0.0 +Mesorhizobium_loti_62564 0 0.0 0.0 +Helicobacter_sp_60869 0 0.0 0.0 +Helicobacter_sp_60868 0 0.0 0.0 +Butyrivibrio_sp_59895 0 0.0 0.0 +Streptomyces_mutabilis_62089 0 0.0 0.0 +Butyrivibrio_sp_59896 0 0.0 0.0 +Streptococcus_suis_58277 0 0.0 0.0 +Clostridium_difficile_59262 0 0.0 0.0 +Thiobacillus_denitrificans_59115 0 0.0 0.0 +Hydrocarboniphaga_effusa_59344 0 0.0 0.0 +Methylobacterium_nodulans_61562 0 0.0 0.0 +Carnimonas_nigrificans_60148 0 0.0 0.0 +Novosphingobium_sp_59462 0 0.0 0.0 +Bartonella_koehlerae_59191 0 0.0 0.0 +Actinomyces_sp_58589 0 0.0 0.0 +Salinimicrobium_xinjiangense_59043 0 0.0 0.0 +Amycolatopsis_jejuensis_61266 0 0.0 0.0 +Treponema_brennaborense_62482 0 0.0 0.0 +Yokenella_regensburgei_54641 0 0.0 0.0 +Desulfobacula_toluolica_62032 0 0.0 0.0 +Megasphaera_micronuciformis_62167 0 0.0 0.0 +Rhizobium_etli_55139 0 0.0 0.0 +Rhizobium_alamii_61642 0 0.0 0.0 +Lysinibacillus_boronitolerans_54563 0 0.0 0.0 +Oligotropha_carboxidovorans_45140 0 0.0 0.0 +Nocardia_sp_59296 0 0.0 0.0 +Streptomyces_rapamycinicus_57891 0 0.0 0.0 +Brachyspira_intermedia_58431 0 0.0 0.0 +Nocardia_brasiliensis_57995 0 0.0 0.0 +Rickettsia_helvetica_59236 0 0.0 0.0 +Lachnospiraceae_bacterium_62399 0 0.0 0.0 +Lachnospiraceae_bacterium_62398 0 0.0 0.0 +Kineosphaera_limosa_59388 0 0.0 0.0 +Bartonella_quintana_55497 0 0.0 0.0 +Rheinheimera_nanhaiensis_61813 0 0.0 0.0 +Leptospira_biflexa_34567 0 0.0 0.0 +Prevotella_shahii_59695 0 0.0 0.0 +Photorhabdus_temperata_58314 0 0.0 0.0 +Nocardiopsis_valliformis_59769 0 0.0 0.0 +Kitasatospora_setae_34852 0 0.0 0.0 +Helicobacter_pylori_59931 0 0.0 0.0 +Streptomyces_sp_59338 0 0.0 0.0 +Streptomyces_sp_59339 0 0.0 0.0 +Microbacterium_maritypicum_56228 0 0.0 0.0 +Sorangium_cellulosum_59800 0 0.0 0.0 +Saccharomonospora_marina_62412 0 0.0 0.0 +Tessaracoccus_sp_60805 0 0.0 0.0 +Streptomyces_sp_59333 0 0.0 0.0 +Desulfohalobium_retbaense_61626 0 0.0 0.0 +Lactobacillus_malefermentans_58433 0 0.0 0.0 +Actinobacterium_SCGC_62504 0 0.0 0.0 +Leifsonia_rubra_60206 0 0.0 0.0 +Sphingomonas_jaspsi_59064 0 0.0 0.0 +Atopobium_minutum_50290 0 0.0 0.0 +Streptomyces_sp_59194 0 0.0 0.0 +Streptomyces_sp_59196 0 0.0 0.0 +Paucisalibacillus_globulus_58989 0 0.0 0.0 +Thermodesulfovibrio_yellowstonii_56001 0 0.0 0.0 +Streptococcus_minor_59086 0 0.0 0.0 +Aphanocapsa_montana_46612 0 0.0 0.0 +Bacillus_aquimaris_60964 0 0.0 0.0 +Prevotella_sp_58566 0 0.0 0.0 +Sphingomonas_sp_60872 0 0.0 0.0 +Corynebacterium_nuruki_62357 0 0.0 0.0 +Variovorax_paradoxus_61292 0 0.0 0.0 +Secondary_endosymbiont_59430 0 0.0 0.0 +Vibrio_proteolyticus_59583 0 0.0 0.0 +Micavibrio_aeruginosavorus_61305 0 0.0 0.0 +Aeromonas_veronii_58155 0 0.0 0.0 +Enterococcus_faecalis_59809 0 0.0 0.0 +Algoriphagus_marincola_60055 0 0.0 0.0 +Legionella_cherrii_58906 0 0.0 0.0 +Propionibacteriaceae_bacterium_60446 0 0.0 0.0 +Sphingomonas_bacterium_62626 0 0.0 0.0 +Sutterella_wadsworthensis_56828 0 0.0 0.0 +Pseudomonas_putida_57890 0 0.0 0.0 +Melioribacter_roseus_59405 0 0.0 0.0 +Burkholderia_cenocepacia_62623 0 0.0 0.0 +Cyanobium_sp_60720 0 0.0 0.0 +Streptomyces_flavochromogenes_62113 0 0.0 0.0 +Arsenophonus_nasoniae_58709 0 0.0 0.0 +Pseudomonas_sp_60810 0 0.0 0.0 +Hymenobacter_sp_60235 0 0.0 0.0 +Meganema_perideroedes_58936 0 0.0 0.0 +Bacteroides_xylanisolvens_57185 0 0.0 0.0 +Mycobacterium_smegmatis_62178 0 0.0 0.0 +Leptospira_licerasiae_45090 0 0.0 0.0 +Bacillus_manliponensis_61849 0 0.0 0.0 +Sphingobacterium_sp_60915 0 0.0 0.0 +Comamonas_aquatica_57513 0 0.0 0.0 +Pseudomonas_syringae_57194 0 0.0 0.0 +Veillonella_ratti_62429 0 0.0 0.0 +Clostridium_cellulovorans_33915 0 0.0 0.0 +Mycobacterium_sp_60559 0 0.0 0.0 +Halomonas_sp_61771 0 0.0 0.0 +Bacteroides_finegoldii_57739 0 0.0 0.0 +Bacillus_mycoides_60386 0 0.0 0.0 +Legionella_pneumophila_62513 0 0.0 0.0 +Peptoniphilus_harei_62491 0 0.0 0.0 +Neisseria_mucosa_61758 0 0.0 0.0 +Acetobacter_okinawensis_59701 0 0.0 0.0 +Exiguobacterium_acetylicum_54868 0 0.0 0.0 +Acinetobacter_sp_59558 0 0.0 0.0 +Francisella_sp_60312 0 0.0 0.0 +Lactobacillus_ceti_58900 0 0.0 0.0 +Chelativorans_sp_62569 0 0.0 0.0 +Cupriavidus_sp_60071 0 0.0 0.0 +Haloglycomyces_albus_58535 0 0.0 0.0 +Atelocyanobacterium_thalassa_60813 0 0.0 0.0 +Streptococcus_gallolyticus_57748 0 0.0 0.0 +Clostridium_lentocellum_62000 0 0.0 0.0 +Soleaferrea_massiliensis_59515 0 0.0 0.0 +Acinetobacter_sp_61570 0 0.0 0.0 +Pedobacter_sp_61408 0 0.0 0.0 +Streptococcus_tigurinus_59929 0 0.0 0.0 +Thioalkalivibrio_sp_55622 0 0.0 0.0 +Streptococcus_henryi_59083 0 0.0 0.0 +Aeromonas_bestiarum_58177 0 0.0 0.0 +Actinokineospora_inagensis_58664 0 0.0 0.0 +Bacillus_aidingensis_58722 0 0.0 0.0 +Nocardia_sp_58469 0 0.0 0.0 +Paraoerskovia_marina_58987 0 0.0 0.0 +Paenibacillus_sp_56934 0 0.0 0.0 +Paenibacillus_chondroitinus_61927 0 0.0 0.0 +Burkholderia_kururiensis_59570 0 0.0 0.0 +Brevibacterium_linens_61247 0 0.0 0.0 +Fusobacterium_periodonticum_61765 0 0.0 0.0 +Cronobacter_zurichensis_60329 0 0.0 0.0 +Filifactor_alocis_61761 0 0.0 0.0 +Amycolatopsis_orientalis_57016 0 0.0 0.0 +Johnsonella_ignava_62102 0 0.0 0.0 +Butyrivibrio_sp_60398 0 0.0 0.0 +Pelosinus_fermentans_51468 0 0.0 0.0 +Rudaea_cellulosilytica_59032 0 0.0 0.0 +Beutenbergia_cavernae_61591 0 0.0 0.0 +Streptomyces_sp_56763 0 0.0 0.0 +Parvularcula_bermudensis_61195 0 0.0 0.0 +Leptospira_meyeri_56688 0 0.0 0.0 +Nesterenkonia_alba_58954 0 0.0 0.0 +Bartonella_tamiae_48051 0 0.0 0.0 +Nocardia_sp_59332 0 0.0 0.0 +Ruminococcus_sp_62394 0 0.0 0.0 +Contendobacter_odensis_60373 0 0.0 0.0 +Rhodococcus_fascians_55788 0 0.0 0.0 +Ralstonia_sp_59549 0 0.0 0.0 +Brevundimonas_sp_57758 0 0.0 0.0 +Sphingobacterium_thalpophilum_59062 0 0.0 0.0 +Aminobacterium_colombiense_61842 0 0.0 0.0 +Streptomyces_griseus_54957 0 0.0 0.0 +Sebaldella_termitidis_61725 0 0.0 0.0 +Beta_proteobacterium_61211 0 0.0 0.0 +Herbaspirillum_sp_60542 0 0.0 0.0 +Enterococcus_haemoperoxidus_44058 0 0.0 0.0 +Methylocystis_parvus_59192 0 0.0 0.0 +Clostridiales_bacterium_61057 0 0.0 0.0 +Agrobacterium_tumefaciens_58522 0 0.0 0.0 +Acidobacteria_bacterium_61984 0 0.0 0.0 +Streptococcus_oralis_46145 0 0.0 0.0 +Lactobacillus_kisonensis_62321 0 0.0 0.0 +Salinicoccus_albus_59040 0 0.0 0.0 +Halocynthiibacter_sp_60903 0 0.0 0.0 +Saprospira_grandis_62649 0 0.0 0.0 +Meiothermus_ruber_54920 0 0.0 0.0 +Sphingobium_baderi_58624 0 0.0 0.0 +Anabaena_cylindrica_61092 0 0.0 0.0 +Lactobacillus_iners_56384 0 0.0 0.0 +Psychroserpens_burtonensis_59020 0 0.0 0.0 +Arthrobacter_sp_60072 0 0.0 0.0 +Arthrobacter_sp_60073 0 0.0 0.0 +Citricoccus_sp_58429 0 0.0 0.0 +Acetobacter_pomorum_62615 0 0.0 0.0 +Exiguobacterium_alkaliphilum_57319 0 0.0 0.0 +Enterobacter_cloacae_58148 0 0.0 0.0 +Ochrobactrum_rhizosphaerae_60516 0 0.0 0.0 +Dolichospermum_circinale_57567 0 0.0 0.0 +Amycolatopsis_thermoflava_57694 0 0.0 0.0 +Cardiobacterium_hominis_61979 0 0.0 0.0 +Caloranaerobacter_azorensis_59268 0 0.0 0.0 +Pelistega_sp_60466 0 0.0 0.0 +Bacillus_cereus_61732 0 0.0 0.0 +Pectobacterium_carotovorum_61794 0 0.0 0.0 +Pectobacterium_carotovorum_61793 0 0.0 0.0 +Pectobacterium_carotovorum_61790 0 0.0 0.0 +Tepidimonas_taiwanensis_61170 0 0.0 0.0 +Magnetobacterium_sp_60612 0 0.0 0.0 +Exiguobacterium_sp_56562 0 0.0 0.0 +Snodgrassella_alvi_57464 0 0.0 0.0 +Adlercreutzia_equolifaciens_60310 0 0.0 0.0 +Elizabethkingia_anophelis_56788 0 0.0 0.0 +Actinoplanes_utahensis_60959 0 0.0 0.0 +Rhodovulum_sp_60676 0 0.0 0.0 +Agrobacterium_vitis_61176 0 0.0 0.0 +Neisseria_meningitidis_58195 0 0.0 0.0 +Eggerthella_sp_61662 0 0.0 0.0 +Lebetimonas_sp_57742 0 0.0 0.0 +Scardovia_wiggsiae_62335 0 0.0 0.0 +Bifidobacterium_psychraerophilum_47056 0 0.0 0.0 +Leptotrichia_sp_60099 0 0.0 0.0 +Xanthomonas_fragariae_59175 0 0.0 0.0 +Mycobacterium_chubuense_62176 0 0.0 0.0 +Kinetoplastibacterium_oncopeltii_59496 0 0.0 0.0 +Thioalkalivibrio_sp_57972 0 0.0 0.0 +Clostridium_beijerinckii_56479 0 0.0 0.0 +Streptococcus_parauberis_53510 0 0.0 0.0 +Serinicoccus_marinus_59053 0 0.0 0.0 +Burkholderia_phymatum_61401 0 0.0 0.0 +Sphingobium_lactosutens_60123 0 0.0 0.0 +Geobacillus_kaustophilus_57937 0 0.0 0.0 +Filamentous_cyanobacterium_59168 0 0.0 0.0 +Bacillus_sp_56348 0 0.0 0.0 +Duganella_violaceinigra_58824 0 0.0 0.0 +Chryseobacterium_haifense_60590 0 0.0 0.0 +Saccharothrix_espanaensis_59376 0 0.0 0.0 +Clostridium_tyrobutyricum_53488 0 0.0 0.0 +Chelatococcus_sp_59508 0 0.0 0.0 +Gordonia_kroppenstedtii_61577 0 0.0 0.0 +Yersinia_bercovieri_61309 0 0.0 0.0 +Bacteroides_coprocola_61586 0 0.0 0.0 +Pseudoalteromonas_lipolytica_60595 0 0.0 0.0 +Edwardsiella_hoshinae_59548 0 0.0 0.0 +Planomicrobium_glaciei_59867 0 0.0 0.0 +Nocardioides_sp_58586 0 0.0 0.0 +Pseudoalteromonas_ruthenica_59545 0 0.0 0.0 +Pasteurella_bettyae_58565 0 0.0 0.0 +Clostridium_cellulolyticum_61426 0 0.0 0.0 +Thermomonas_fusca_59111 0 0.0 0.0 +Campylobacter_jejuni_54938 0 0.0 0.0 +Clostridiales_bacterium_57827 0 0.0 0.0 +Butyrivibrio_sp_60399 0 0.0 0.0 +Streptomyces_sp_60057 0 0.0 0.0 +Mannheimia_varigena_60506 0 0.0 0.0 +Enterobacter_cloacae_60571 0 0.0 0.0 +Peptostreptococcus_stomatis_61922 0 0.0 0.0 +Lactobacillus_farciminis_62578 0 0.0 0.0 +Corynebacterium_ulcerans_56105 0 0.0 0.0 +Clostridium_sp_60334 0 0.0 0.0 +Alishewanella_jeotgali_59169 0 0.0 0.0 +Lacinutrix_sp_60674 0 0.0 0.0 +Rhizobium_sp_59156 0 0.0 0.0 +Prevotella_sp_58138 0 0.0 0.0 +Scytonema_hofmanni_59940 0 0.0 0.0 +Methylobacterium_oryzae_55240 0 0.0 0.0 +Myxococcus_xanthus_46080 0 0.0 0.0 +Pantoea_sp_58264 0 0.0 0.0 +Deinococcus_gobiensis_62232 0 0.0 0.0 +Burkholderia_sp_61680 0 0.0 0.0 +Actinomadura_flavalba_61811 0 0.0 0.0 +Methylophilus_sp_58152 0 0.0 0.0 +Aurantimonas_manganoxydans_61124 0 0.0 0.0 +Leptospira_alexanderi_58446 0 0.0 0.0 +Maritimibacter_alkaliphilus_61201 0 0.0 0.0 +Actinomyces_sp_62445 0 0.0 0.0 +Actinomyces_sp_62446 0 0.0 0.0 +Exiguobacterium_undae_56994 0 0.0 0.0 +Oceanobacillus_kimchii_59735 0 0.0 0.0 +Francisella_philomiragia_61113 0 0.0 0.0 +Mycobacterium_marinum_56420 0 0.0 0.0 +Clostridium_bartlettii_61535 0 0.0 0.0 +Thermoanaerobacterium_thermosaccharolyticum_57043 0 0.0 0.0 +Actinokineospora_enzanensis_58663 0 0.0 0.0 +Desulfosporosinus_sp_60819 0 0.0 0.0 +Bacillus_cereus_56751 0 0.0 0.0 +Helicobacter_pylori_38375 0 0.0 0.0 +Aureimonas_ureilytica_58716 0 0.0 0.0 +Desulfovibrio_piezophilus_62405 0 0.0 0.0 +Shimazuella_kribbensis_59054 0 0.0 0.0 +Streptomyces_purpeofuscus_55276 0 0.0 0.0 +Paenibacillus_lactis_56242 0 0.0 0.0 +Caldicellulosiruptor_kronotskyensis_58082 0 0.0 0.0 +Asaia_platycodi_39834 0 0.0 0.0 +Lactobacillus_zeae_58436 0 0.0 0.0 +Staphylococcus_saprophyticus_54575 0 0.0 0.0 +Bacteroides_massiliensis_44749 0 0.0 0.0 +Gracilimonas_tropica_58869 0 0.0 0.0 +Altuibacter_lentus_59599 0 0.0 0.0 +Pseudoxanthomonas_sp_62570 0 0.0 0.0 +Bacteroides_stercorirosoris_59710 0 0.0 0.0 +Sphaerobacter_thermophilus_61614 0 0.0 0.0 +Bdellovibrio_bacteriovorus_62287 0 0.0 0.0 +Gordonia_polyisoprenivorans_56253 0 0.0 0.0 +Flexibacter_litoralis_62407 0 0.0 0.0 +Hyphomonas_adhaerens_59920 0 0.0 0.0 +Chryseobacterium_sp_60749 0 0.0 0.0 +Oscillibacter_sp_59687 0 0.0 0.0 +Caulobacteraceae_bacterium_60295 0 0.0 0.0 +Kangiella_aquimarina_58895 0 0.0 0.0 +Maribacter_forsetii_60343 0 0.0 0.0 +Nocardia_otitidiscaviarum_56901 0 0.0 0.0 +Midichloria_mitochondrii_62149 0 0.0 0.0 +Streptomyces_violaceusniger_60060 0 0.0 0.0 +Pseudomonas_chlororaphis_57255 0 0.0 0.0 +Pseudomonas_sp_46559 0 0.0 0.0 +Chryseobacterium_sp_60747 0 0.0 0.0 +Bordetella_sp_59295 0 0.0 0.0 +Chromobacterium_subtsugae_61068 0 0.0 0.0 +Modulibacteria_UASB270_60733 0 0.0 0.0 +Vibrio_pacinii_59125 0 0.0 0.0 +Chryseobacterium_sp_60743 0 0.0 0.0 +Vibrio_kanaloae_59403 0 0.0 0.0 +Mycobacterium_farcinogenes_60953 0 0.0 0.0 +Chryseobacterium_piperi_61804 0 0.0 0.0 +Lactobacillus_curvatus_54601 0 0.0 0.0 +Campylobacter_sputorum_61239 0 0.0 0.0 +Conexibacter_woesei_59938 0 0.0 0.0 +Eubacterium_sp_59682 0 0.0 0.0 +Cellulomonas_sp_58567 0 0.0 0.0 +Streptomyces_pristinaespiralis_61558 0 0.0 0.0 +Rhizobium_leguminosarum_58171 0 0.0 0.0 +Thermogemmatispora_sp_60298 0 0.0 0.0 +Aeromonas_salmonicida_57597 0 0.0 0.0 +Tumebacillus_flagellatus_59276 0 0.0 0.0 +Prevotella_paludivivens_44720 0 0.0 0.0 +Caldalkalibacillus_thermarum_62656 0 0.0 0.0 +Gelidibacter_mesophilus_58855 0 0.0 0.0 +Pseudomonas_plecoglossicida_51812 0 0.0 0.0 +Eubacterium_rectale_56927 0 0.0 0.0 +Aquimarina_sp_60091 0 0.0 0.0 +Serinicoccus_profundi_58424 0 0.0 0.0 +Pseudomonas_sp_57852 0 0.0 0.0 +Kinetoplastibacterium_galatii_59497 0 0.0 0.0 +Turicella_otitidis_62431 0 0.0 0.0 +Sulfurospirillum_cavolei_57760 0 0.0 0.0 +Anoxybacillus_flavithermus_60288 0 0.0 0.0 +Erythrobacter_vulgaris_61138 0 0.0 0.0 +Rhodopseudomonas_palustris_57502 0 0.0 0.0 +Lactococcus_garvieae_57061 0 0.0 0.0 +Rickettsia_hoogstraalii_61572 0 0.0 0.0 +Bartonella_queenslandensis_59597 0 0.0 0.0 +Terrimonas_ferruginea_59101 0 0.0 0.0 +Psychromonas_sp_60244 0 0.0 0.0 +Balneimonas_flocculans_60146 0 0.0 0.0 +Alkaliphilus_oremlandii_61310 0 0.0 0.0 +Ruminococcus_flavefaciens_55887 0 0.0 0.0 +Helicobacter_pylori_62341 0 0.0 0.0 +Oceanicola_sp_60470 0 0.0 0.0 +Actinocatenispora_sera_61397 0 0.0 0.0 +Arthrobacter_sp_58273 0 0.0 0.0 +Streptomyces_atroolivaceus_62080 0 0.0 0.0 +Frankia_symbiont_62042 0 0.0 0.0 +Scardovia_inopinata_61993 0 0.0 0.0 +Hymenobacter_sp_59622 0 0.0 0.0 +Erwinia_typographi_61351 0 0.0 0.0 +Enterobacteriaceae_bacterium_58100 0 0.0 0.0 +Neisseria_elongata_61756 0 0.0 0.0 +Psychrobacter_sp_45027 0 0.0 0.0 +Agrobacterium_sp_56572 0 0.0 0.0 +Streptomyces_scabiei_60969 0 0.0 0.0 +Brevundimonas_naejangsanensis_61890 0 0.0 0.0 +Amphibacillus_xylanus_62154 0 0.0 0.0 +Veillonella_parvula_58184 0 0.0 0.0 +Rhodobacteraceae_bacterium_60246 0 0.0 0.0 +Actinoplanes_missouriensis_61677 0 0.0 0.0 +Monju_endosymbiont_52360 0 0.0 0.0 +Campylobacter_concisus_61330 0 0.0 0.0 +Streptomyces_mirabilis_62116 0 0.0 0.0 +Streptomyces_mirabilis_62117 0 0.0 0.0 +Lachnospiraceae_bacterium_62587 0 0.0 0.0 +Streptomyces_sp_59279 0 0.0 0.0 +Streptomyces_sp_59278 0 0.0 0.0 +Streptomyces_sp_59277 0 0.0 0.0 +Shewanella_violacea_61977 0 0.0 0.0 +Alicyclobacillus_macrosporangiidus_60296 0 0.0 0.0 +Selenomonas_noxia_56778 0 0.0 0.0 +Bacillus_acidiproducens_61530 0 0.0 0.0 +Chlamydia_muridarum_57609 0 0.0 0.0 +Methylotenera_sp_60767 0 0.0 0.0 +Clostridium_sp_60677 0 0.0 0.0 +Microscilla_marina_61184 0 0.0 0.0 +Arcticibacter_svalbardensis_59255 0 0.0 0.0 +Fusobacterium_mortiferum_61584 0 0.0 0.0 +Gluconacetobacter_europaeus_56709 0 0.0 0.0 +Pelagibacter_ubique_60372 0 0.0 0.0 +Deinococcus_pimensis_62516 0 0.0 0.0 +Arcobacter_sp_39857 0 0.0 0.0 +Leclercia_adecarboxylata_62328 0 0.0 0.0 +Aliihoeflea_sp_60291 0 0.0 0.0 +Agrobacterium_fabrum_57555 0 0.0 0.0 +Pedobacter_glucosidilyticus_58990 0 0.0 0.0 +Treponema_azotonutricium_61752 0 0.0 0.0 +Azospirillum_irakense_58720 0 0.0 0.0 +Actinomyces_sp_62581 0 0.0 0.0 +Actinomyces_sp_62582 0 0.0 0.0 +Meiothermus_cerbereus_58937 0 0.0 0.0 +Streptomyces_sp_57507 0 0.0 0.0 +Streptococcus_ictaluri_62285 0 0.0 0.0 +Streptococcus_infantis_58320 0 0.0 0.0 +Haemophilus_parasuis_57880 0 0.0 0.0 +Rhizobium_sullae_58413 0 0.0 0.0 +Gamma_proteobacterium_58334 0 0.0 0.0 +Shewanella_decolorationis_60225 0 0.0 0.0 +Pseudomonas_sp_61516 0 0.0 0.0 +Streptococcus_equi_58454 0 0.0 0.0 +Desulfovibrio_sp_62014 0 0.0 0.0 +Jeotgalibacillus_sp_60784 0 0.0 0.0 +Clostridium_butyricum_56361 0 0.0 0.0 +Methylocaldum_szegediense_62091 0 0.0 0.0 +Campylobacter_concisus_62542 0 0.0 0.0 +Burkholderia_kururiensis_59861 0 0.0 0.0 +Thalassospira_lucentensis_59104 0 0.0 0.0 +Bifidobacterium_indicum_56644 0 0.0 0.0 +Pseudomonas_fulva_58092 0 0.0 0.0 +Gilvimarinus_agarilyticus_62104 0 0.0 0.0 +Streptomyces_griseolus_54539 0 0.0 0.0 +Spirochaeta_bajacaliforniensis_59067 0 0.0 0.0 +Providencia_rettgeri_61688 0 0.0 0.0 +Leucothrix_mucor_62695 0 0.0 0.0 +Cupriavidus_basilensis_62132 0 0.0 0.0 +Corynebacterium_urealyticum_55994 0 0.0 0.0 +Enterobacter_cloacae_55612 0 0.0 0.0 +Bacillus_cellulosilyticus_62026 0 0.0 0.0 +Clostridiales_bacterium_55367 0 0.0 0.0 +Lactobacillus_acidipiscis_58438 0 0.0 0.0 +Kiloniella_laminariae_58896 0 0.0 0.0 +Staphylococcus_sp_58509 0 0.0 0.0 +Rhodoluna_lacicola_61735 0 0.0 0.0 +Deinococcus_marmoris_58787 0 0.0 0.0 +Thioalkalivibrio_sp_57956 0 0.0 0.0 +Bradyrhizobium_sp_60269 0 0.0 0.0 +Aquimarina_sp_59994 0 0.0 0.0 +Aquimarina_sp_59995 0 0.0 0.0 +Porphyromonas_uenonis_61926 0 0.0 0.0 +Thioalkalivibrio_thiocyanoxidans_56652 0 0.0 0.0 +Pseudoalteromonas_rubra_58635 0 0.0 0.0 +Sphingomonas_wittichii_55547 0 0.0 0.0 +Rikenellaceae_bacterium_60508 0 0.0 0.0 +Nocardiopsis_potens_61833 0 0.0 0.0 +Zeta_proteobacterium_59174 0 0.0 0.0 +Protochlamydia_amoebophila_56560 0 0.0 0.0 +Paenibacillus_sp_57943 0 0.0 0.0 +Xylanimonas_cellulosilytica_61542 0 0.0 0.0 +Pseudomonas_sp_60778 0 0.0 0.0 +Lactobacillus_gastricus_59209 0 0.0 0.0 +Trichodesmium_erythraeum_60990 0 0.0 0.0 +Photobacterium_halotolerans_61079 0 0.0 0.0 +Bradyrhizobium_sp_59395 0 0.0 0.0 +Salinicoccus_carnicancri_59681 0 0.0 0.0 +Secondary_endosymbiont_60183 0 0.0 0.0 +Pectobacterium_betavasculorum_54396 0 0.0 0.0 +Paenibacillus_forsythiae_60131 0 0.0 0.0 +Bacteroides_ureolyticus_58254 0 0.0 0.0 +Paenibacillus_chitinolyticus_58207 0 0.0 0.0 +Vibrio_campbellii_57463 0 0.0 0.0 +Lactobacillus_vaginalis_61713 0 0.0 0.0 +Prochlorococcus_marinus_57812 0 0.0 0.0 +Halomonas_caseinilytica_61509 0 0.0 0.0 +Thioalkalivibrio_sp_44149 0 0.0 0.0 +Blattabacterium_sp_57952 0 0.0 0.0 +Alpha_proteobacterium_62122 0 0.0 0.0 +Actinokineospora_sp_62492 0 0.0 0.0 +Sphingobacterium_spiritivorum_61717 0 0.0 0.0 +Sphingobacterium_spiritivorum_61716 0 0.0 0.0 +Listeriaceae_bacterium_60876 0 0.0 0.0 +Burkholderia_glumae_61916 0 0.0 0.0 +Streptococcus_entericus_59081 0 0.0 0.0 +Thermotoga_hypogea_44713 0 0.0 0.0 +Bradyrhizobium_japonicum_42727 0 0.0 0.0 +Acinetobacter_baumannii_57323 0 0.0 0.0 +Streptomyces_collinus_59540 0 0.0 0.0 +Prevotella_timonensis_58235 0 0.0 0.0 +Neisseria_gonorrhoeae_53748 0 0.0 0.0 +Lactobacillus_amylolyticus_61883 0 0.0 0.0 +Lachnospiraceae_bacterium_59317 0 0.0 0.0 +Pseudomonas_batumici_61032 0 0.0 0.0 +Kitasatospora_azatica_60580 0 0.0 0.0 +Streptococcus_sanguinis_61395 0 0.0 0.0 +Bacteroides_oleiciplenus_62209 0 0.0 0.0 +Thioclava_sp_60221 0 0.0 0.0 +Pseudomonas_sp_60513 0 0.0 0.0 +Anaerovorax_odorimutans_58698 0 0.0 0.0 +Nitrococcus_mobilis_61204 0 0.0 0.0 +Azoarcus_sp_62237 0 0.0 0.0 +Cyanothece_sp_34394 0 0.0 0.0 +Aquifex_aeolicus_61029 0 0.0 0.0 +Anditalea_andensis_58445 0 0.0 0.0 +Helicobacter_canadensis_34147 0 0.0 0.0 +Butyrivibrio_hungatei_56803 0 0.0 0.0 +Pantoea_sp_59231 0 0.0 0.0 +Anaerolinea_thermophila_62525 0 0.0 0.0 +Geobacter_sulfurreducens_54469 0 0.0 0.0 +Pseudomonas_brassicacearum_57978 0 0.0 0.0 +Gamma_proteobacterium_59173 0 0.0 0.0 +Mesorhizobium_loti_58407 0 0.0 0.0 +Jeddahella_massiliensis_35045 0 0.0 0.0 +Streptococcus_ratti_62159 0 0.0 0.0 +Oceanobacter_kriegii_58966 0 0.0 0.0 +Desulfosporosinus_sp_60830 0 0.0 0.0 +Desulfatibacillum_alkenivorans_57094 0 0.0 0.0 +Nitrosomonas_europaea_61034 0 0.0 0.0 +Arthrobacter_sp_61087 0 0.0 0.0 +Paenibacillus_zanthoxyli_58276 0 0.0 0.0 +Belnapia_sp_60859 0 0.0 0.0 +Streptomyces_himastatinicus_61557 0 0.0 0.0 +Mesorhizobium_sp_58409 0 0.0 0.0 +Mesorhizobium_sp_58408 0 0.0 0.0 +Thiocystis_violascens_62290 0 0.0 0.0 +Bifidobacterium_saguini_60522 0 0.0 0.0 +Lachnospiraceae_bacterium_51870 0 0.0 0.0 +Corynebacterium_tuberculostearicum_61783 0 0.0 0.0 +Blattabacterium_sp_61269 0 0.0 0.0 +Pseudomonas_denitrificans_59989 0 0.0 0.0 +Corynebacterium_massiliense_58775 0 0.0 0.0 +Prevotella_dentasini_59706 0 0.0 0.0 +Marinimicrobium_sp_60292 0 0.0 0.0 +Planomicrobium_sp_60731 0 0.0 0.0 +Lactobacillus_fabifermentans_50692 0 0.0 0.0 +Streptomyces_lavendulae_61870 0 0.0 0.0 +Eggerthia_catenaformis_62698 0 0.0 0.0 +Prevotella_nigrescens_56706 0 0.0 0.0 +Xanthomonadaceae_bacterium_60857 0 0.0 0.0 +Glaciecola_arctica_61643 0 0.0 0.0 +Helicobacter_macacae_60240 0 0.0 0.0 +Actinomyces_suimastitidis_58671 0 0.0 0.0 +Paenibacillus_elgii_58327 0 0.0 0.0 +Sulfitobacter_sp_60273 0 0.0 0.0 +Actinomyces_sp_59588 0 0.0 0.0 +Lactobacillus_paralimentarius_58902 0 0.0 0.0 +Richelia_intracellularis_59316 0 0.0 0.0 +Sphingomonas_echinoides_58614 0 0.0 0.0 +Devosia_sp_57843 0 0.0 0.0 +Photorhabdus_asymbiotica_61137 0 0.0 0.0 +Ruminococcus_albus_45637 0 0.0 0.0 +Desulfovibrio_africanus_58111 0 0.0 0.0 +Spirochaeta_thermophila_62065 0 0.0 0.0 +Aurantimonas_coralicida_58715 0 0.0 0.0 +Bergeyella_zoohelcum_57177 0 0.0 0.0 +Dethiobacter_alkaliphilus_61792 0 0.0 0.0 +Arthrobacter_sp_60219 0 0.0 0.0 +Clostridium_papyrosolvens_60120 0 0.0 0.0 +Clostridium_scindens_58238 0 0.0 0.0 +Bacteroides_nordii_55557 0 0.0 0.0 +Sporolactobacillus_vineae_59073 0 0.0 0.0 +Deinococcus_phoenicis_60687 0 0.0 0.0 +Delftia_acidovorans_58200 0 0.0 0.0 +Arenimonas_composti_44751 0 0.0 0.0 +Ruminococcus_obeum_62046 0 0.0 0.0 +Parabacteroides_goldsteinii_56831 0 0.0 0.0 +Prevotella_intermedia_57633 0 0.0 0.0 +Nocardiopsis_prasina_59761 0 0.0 0.0 +Brevibacillus_sp_58644 0 0.0 0.0 +Sphingobacteriaceae_bacterium_60873 0 0.0 0.0 +Kocuria_polaris_54814 0 0.0 0.0 +Alicyclobacillus_pohliae_58691 0 0.0 0.0 +Lactococcus_garvieae_56603 0 0.0 0.0 +Shewanella_sp_60793 0 0.0 0.0 +Enterobacteriaceae_bacterium_60920 0 0.0 0.0 +Corynebacterium_sp_48834 0 0.0 0.0 +Marinilabilia_salmonicolor_59330 0 0.0 0.0 +Caldibacillus_debilis_58858 0 0.0 0.0 +Polynucleobacter_necessarius_61177 0 0.0 0.0 +Mycobacterium_austroafricanum_53654 0 0.0 0.0 +Streptococcus_sp_60922 0 0.0 0.0 +Labrenzia_sp_62111 0 0.0 0.0 +Arthrobacter_sp_59282 0 0.0 0.0 +Planococcus_sp_60812 0 0.0 0.0 +Streptococcus_oralis_57895 0 0.0 0.0 +Pontibacter_actiniarum_62170 0 0.0 0.0 +Lysinibacillus_sphaericus_54092 0 0.0 0.0 +Citrobacter_freundii_56148 0 0.0 0.0 +Chlorobium_phaeobacteroides_61130 0 0.0 0.0 +Collinsella_tanakaei_62212 0 0.0 0.0 +Anoxybacillus_ayderensis_57275 0 0.0 0.0 +Alteromonas_macleodii_58315 0 0.0 0.0 +Alpha_proteobacterium_59930 0 0.0 0.0 +Alcanivorax_hongdengensis_59364 0 0.0 0.0 +Chromobacterium_piscinae_62128 0 0.0 0.0 +Pseudomonas_sp_58041 0 0.0 0.0 +Flavobacterium_johnsoniae_61361 0 0.0 0.0 +Micromonospora_sp_61017 0 0.0 0.0 +Serratia_sp_60436 0 0.0 0.0 +Alpha_proteobacterium_44631 0 0.0 0.0 +Holospora_obtusa_60367 0 0.0 0.0 +Lachnospiraceae_bacterium_56833 0 0.0 0.0 +Endozoicomonas_elysicola_48897 0 0.0 0.0 +Thiomicrospira_pelophila_59139 0 0.0 0.0 +Aeromonas_tecta_61253 0 0.0 0.0 +Lysinibacillus_sphaericus_49271 0 0.0 0.0 +Listeria_rocourtiae_59836 0 0.0 0.0 +Clostridium_leptum_61499 0 0.0 0.0 +Pseudomonas_stutzeri_58597 0 0.0 0.0 +Pseudomonas_resinovorans_59010 0 0.0 0.0 +Enterobacteriaceae_bacterium_59520 0 0.0 0.0 +Paenibacillus_barengoltzii_56244 0 0.0 0.0 +Novispirillum_itersonii_59892 0 0.0 0.0 +Bacteroides_uniformis_57318 0 0.0 0.0 +Streptococcus_suis_57371 0 0.0 0.0 +Achromobacter_xylosoxidans_62275 0 0.0 0.0 +Micromonospora_parva_60668 0 0.0 0.0 +Actinopolyspora_halophila_58532 0 0.0 0.0 +Sinomonas_sp_60159 0 0.0 0.0 +Desulfovibrio_alkalitolerans_58809 0 0.0 0.0 +Varibaculum_cambriense_59122 0 0.0 0.0 +Campylobacter_insulaenigrae_58360 0 0.0 0.0 +Anaerococcus_prevotii_61724 0 0.0 0.0 +Spongiibacter_tropicus_59072 0 0.0 0.0 +Butyrivibrio_sp_54783 0 0.0 0.0 +Burkholderia_sp_56738 0 0.0 0.0 +Geobacter_sp_60786 0 0.0 0.0 +Collinsella_intestinalis_61689 0 0.0 0.0 +Aeromonas_bivalvium_61515 0 0.0 0.0 +Actinomyces_gerencseriae_58668 0 0.0 0.0 +Clostridium_novyi_56884 0 0.0 0.0 +Ferrimonas_kyonanensis_58841 0 0.0 0.0 +Persephonella_marina_59655 0 0.0 0.0 +Desulfovibrio_desulfuricans_61703 0 0.0 0.0 +Burkholderia_sp_62606 0 0.0 0.0 +Burkholderia_sp_62605 0 0.0 0.0 +Nodosilinea_nodulosa_59381 0 0.0 0.0 +Endosymbiont_of_59782 0 0.0 0.0 +Eubacterium_acidaminophilum_59952 0 0.0 0.0 +Succinispira_mobilis_58474 0 0.0 0.0 +Sphingopyxis_sp_60837 0 0.0 0.0 +Gamma_proteobacterium_61826 0 0.0 0.0 +Kaistia_adipata_58893 0 0.0 0.0 +Mesorhizobium_alhagi_58594 0 0.0 0.0 +Microthrix_parvicella_53446 0 0.0 0.0 +Flavobacterium_cauense_60175 0 0.0 0.0 +Prochlorococcus_marinus_62230 0 0.0 0.0 +Desulfocurvus_vexinensis_58800 0 0.0 0.0 +Paenibacillus_sp_59422 0 0.0 0.0 +Hirschia_maritima_61773 0 0.0 0.0 +Dechloromonas_aromatica_60918 0 0.0 0.0 +Kordiimonas_gwangyangensis_46381 0 0.0 0.0 +Vibrio_rumoiensis_59394 0 0.0 0.0 +Leuconostoc_lactis_59766 0 0.0 0.0 +Selenomonas_flueggei_61981 0 0.0 0.0 +Roseobacter_litoralis_61407 0 0.0 0.0 +Stenotrophomonas_maltophilia_61460 0 0.0 0.0 +Stenotrophomonas_maltophilia_61461 0 0.0 0.0 +Deinococcus_ficus_57410 0 0.0 0.0 +Mycobacterium_abscessus_57844 0 0.0 0.0 +Bradyrhizobium_sp_59157 0 0.0 0.0 +Erwinia_tasmaniensis_61568 0 0.0 0.0 +Serratia_fonticola_35677 0 0.0 0.0 +Sphingomonas_sp_61953 0 0.0 0.0 +Paenibacillus_sp_57961 0 0.0 0.0 +Rhodocyclaceae_bacterium_44758 0 0.0 0.0 +Cryobacterium_sp_60816 0 0.0 0.0 +Mycobacterium_simiae_59698 0 0.0 0.0 +Acidomonas_methanolica_59649 0 0.0 0.0 +Capnocytophaga_canimorsus_56428 0 0.0 0.0 +Flavobacterium_beibuense_60388 0 0.0 0.0 +Pantoea_sp_60125 0 0.0 0.0 +Helicobacter_muridarum_61012 0 0.0 0.0 +Pseudomonas_tolaasii_54494 0 0.0 0.0 +Dyadobacter_tibetensis_60510 0 0.0 0.0 +Clostridium_papyrosolvens_61889 0 0.0 0.0 +Elusimicrobium_minutum_61531 0 0.0 0.0 +Borrelia_crocidurae_56341 0 0.0 0.0 +Paenibacillus_macerans_61522 0 0.0 0.0 +Streptococcus_oralis_62443 0 0.0 0.0 +Syntrophobacter_fumaroxidans_61278 0 0.0 0.0 +Pandoraea_sputorum_62556 0 0.0 0.0 +Glaciecola_pallidula_58862 0 0.0 0.0 +Acetobacter_papayae_59675 0 0.0 0.0 +Paracoccus_halophilus_61362 0 0.0 0.0 +Hepatobacter_penaei_59870 0 0.0 0.0 +Polaribacter_sp_59796 0 0.0 0.0 +Brachyspira_innocens_59846 0 0.0 0.0 +Polaribacter_sp_59797 0 0.0 0.0 +Bifidobacterium_cuniculi_35924 0 0.0 0.0 +Clostridium_carboxidivorans_50592 0 0.0 0.0 +Geobacter_uraniireducens_61313 0 0.0 0.0 +Flexithrix_dorotheae_58853 0 0.0 0.0 +Sporomusa_ovata_44718 0 0.0 0.0 +Wolbachia_endosymbiont_61144 0 0.0 0.0 +Streptomyces_canus_57829 0 0.0 0.0 +Geobacter_daltonii_61218 0 0.0 0.0 +Virgibacillus_sp_52682 0 0.0 0.0 +Eubacterium_xylanophilum_60145 0 0.0 0.0 +Halobacillus_kuroshimensis_58877 0 0.0 0.0 +Oligella_ureolytica_58969 0 0.0 0.0 +Prevotella_falsenii_59704 0 0.0 0.0 +Carnobacterium_pleistocenium_60578 0 0.0 0.0 +Atopobium_sp_59401 0 0.0 0.0 +Paenibacillus_sp_60275 0 0.0 0.0 +Brachybacterium_paraconglomeratum_58470 0 0.0 0.0 +Desulfovibrio_fructosovorans_61920 0 0.0 0.0 +Runella_limosa_59034 0 0.0 0.0 +Maribius_sp_60817 0 0.0 0.0 +Spirochaeta_smaragdinae_61845 0 0.0 0.0 +Helicobacter_pylori_58282 0 0.0 0.0 +Clostridium_sp_60730 0 0.0 0.0 +Shewanella_piezotolerans_61030 0 0.0 0.0 +Helicobacter_pylori_50266 0 0.0 0.0 +Helicobacter_rodentium_60579 0 0.0 0.0 +Planococcus_donghaensis_62557 0 0.0 0.0 +Erysipelotrichaceae_bacterium_59516 0 0.0 0.0 +Actinobacillus_capsulatus_58661 0 0.0 0.0 +Gloeocapsa_sp_58342 0 0.0 0.0 +Dickeya_solani_57842 0 0.0 0.0 +Nitrobacter_hamburgensis_61248 0 0.0 0.0 +Acholeplasma_laidlawii_61519 0 0.0 0.0 +Rhizobium_sp_57624 0 0.0 0.0 +Megasphaera_genomosp_55017 0 0.0 0.0 +Aquabacterium_sp_60840 0 0.0 0.0 +Sulfitobacter_mediterraneus_62326 0 0.0 0.0 +Prauserella_rugosa_54672 0 0.0 0.0 +Rhizobiales_bacterium_60462 0 0.0 0.0 +Sphingobacterium_sp_60428 0 0.0 0.0 +Prochlorococcus_marinus_61931 0 0.0 0.0 +Prochlorococcus_marinus_61930 0 0.0 0.0 +Rhizobium_sp_57489 0 0.0 0.0 +Bartonella_bacilliformis_59987 0 0.0 0.0 +Vibrio_owensii_57591 0 0.0 0.0 +Marinobacter_sp_61090 0 0.0 0.0 +Prevotella_micans_49965 0 0.0 0.0 +Selenomonas_ruminantium_58283 0 0.0 0.0 +Corynebacterium_casei_59947 0 0.0 0.0 +Vibrio_splendidus_59404 0 0.0 0.0 +Vibrio_ichthyoenteri_62383 0 0.0 0.0 +Jiangella_gansuensis_62657 0 0.0 0.0 +Blattabacterium_sp_59632 0 0.0 0.0 +Sulfurovum_sp_59319 0 0.0 0.0 +Hippea_jasoniae_62607 0 0.0 0.0 +Fervidobacterium_islandicum_61052 0 0.0 0.0 +Pontibacillus_chungwhensis_60314 0 0.0 0.0 +Nocardia_vinacea_59479 0 0.0 0.0 +Aeromonas_taiwanensis_61963 0 0.0 0.0 +Treponema_pallidum_55260 0 0.0 0.0 +Spirochaeta_alkalica_62603 0 0.0 0.0 +Chryseobacterium_oranimense_60024 0 0.0 0.0 +Dyella_japonica_60272 0 0.0 0.0 +Pseudoxanthomonas_suwonensis_62221 0 0.0 0.0 +Caloramator_australicus_62336 0 0.0 0.0 +SAR86_cluster_59142 0 0.0 0.0 +Neorickettsia_sennetsu_61026 0 0.0 0.0 +Advenella_mimigardefordensis_59780 0 0.0 0.0 +Catonella_morbi_61904 0 0.0 0.0 +Bartonella_grahamii_51388 0 0.0 0.0 +Olleya_marilimosa_60220 0 0.0 0.0 +Sporosarcina_sp_60907 0 0.0 0.0 +Parabacteroides_merdae_56972 0 0.0 0.0 +Acetobacter_pasteurianus_61967 0 0.0 0.0 +Acetobacter_pasteurianus_61966 0 0.0 0.0 +Cyanobium_gracile_61143 0 0.0 0.0 +Acetobacter_pasteurianus_61968 0 0.0 0.0 +Acetobacter_pasteurianus_62597 0 0.0 0.0 +Bacteroidales_bacterium_38755 0 0.0 0.0 +Acetobacter_pasteurianus_62598 0 0.0 0.0 +Weissella_cibaria_62498 0 0.0 0.0 +Brevundimonas_diminuta_62245 0 0.0 0.0 +Streptococcus_pseudoporcinus_48591 0 0.0 0.0 +Streptococcus_pleomorphus_59089 0 0.0 0.0 +Xanthomonas_axonopodis_57683 0 0.0 0.0 +Roseobacter_sp_61406 0 0.0 0.0 +Roseobacter_sp_61404 0 0.0 0.0 +Bacillus_methanolicus_62316 0 0.0 0.0 +Acinetobacter_sp_60880 0 0.0 0.0 +Corynebacterium_propinquum_58778 0 0.0 0.0 +Borrelia_valaisiana_53629 0 0.0 0.0 +Corynebacterium_kroppenstedtii_62015 0 0.0 0.0 +Fulvimarina_pelagi_61191 0 0.0 0.0 +Pseudomonas_mandelii_59247 0 0.0 0.0 +Caulobacter_crescentus_34861 0 0.0 0.0 +Streptococcus_massiliensis_44717 0 0.0 0.0 +Sphingomonas_sp_60568 0 0.0 0.0 +Carnobacterium_sp_59841 0 0.0 0.0 +Rhodanobacter_sp_56366 0 0.0 0.0 +Bacillus_licheniformis_54104 0 0.0 0.0 +Methylopila_sp_44756 0 0.0 0.0 +Kosakonia_sacchari_43321 0 0.0 0.0 +Burkholderia_gladioli_56724 0 0.0 0.0 +Catenulispora_acidiphila_61613 0 0.0 0.0 +Neisseria_cinerea_61755 0 0.0 0.0 +Oribacterium_sp_57590 0 0.0 0.0 +Paenibacillus_odorifer_54315 0 0.0 0.0 +Marinomonas_posidonica_61641 0 0.0 0.0 +Marinobacter_nanhaiticus_61947 0 0.0 0.0 +Streptomyces_acidiscabies_58630 0 0.0 0.0 +Runella_slithyformis_62272 0 0.0 0.0 +Weissella_confusa_59158 0 0.0 0.0 +Actinotalea_ferrariae_62621 0 0.0 0.0 +Epilithonimonas_tenax_58835 0 0.0 0.0 +Pantoea_ananatis_58251 0 0.0 0.0 +Grimontia_sp_58467 0 0.0 0.0 +Desulfonauticus_sp_60259 0 0.0 0.0 +Azoarcus_sp_61951 0 0.0 0.0 +Methyloversatilis_sp_58639 0 0.0 0.0 +Methylobacterium_radiotolerans_54853 0 0.0 0.0 +Burkholderia_pyrrocinia_61934 0 0.0 0.0 +Gamma_proteobacterium_62589 0 0.0 0.0 +Agrobacterium_rhizogenes_61328 0 0.0 0.0 +Ruminococcus_sp_58571 0 0.0 0.0 +Chitinilyticum_aquatile_58748 0 0.0 0.0 +Nostoc_sp_58392 0 0.0 0.0 +Desulfosporosinus_orientis_62307 0 0.0 0.0 +Thermus_tengchongensis_60586 0 0.0 0.0 +Acinetobacter_calcoaceticus_57657 0 0.0 0.0 +Microbacterium_luticocti_58947 0 0.0 0.0 +Thioalkalivibrio_thiocyanoxidans_62183 0 0.0 0.0 +Vibrio_coralliilyticus_57977 0 0.0 0.0 +Treponema_succinifaciens_62377 0 0.0 0.0 +Bifidobacterium_subtile_44746 0 0.0 0.0 +Sulfurihydrogenibium_sp_61506 0 0.0 0.0 +Maricaulis_maris_61425 0 0.0 0.0 +Alicyclobacillus_acidocaldarius_58444 0 0.0 0.0 +Bacillus_sp_62072 0 0.0 0.0 +Streptomyces_sp_60639 0 0.0 0.0 +Streptomyces_scabiei_62107 0 0.0 0.0 +Streptococcus_suis_62688 0 0.0 0.0 +Dichelobacter_nodosus_61058 0 0.0 0.0 +Gordonia_araii_58489 0 0.0 0.0 +Streptomyces_aureocirculatus_33757 0 0.0 0.0 +Streptococcus_sanguinis_62456 0 0.0 0.0 +Streptococcus_sanguinis_62457 0 0.0 0.0 +Mobiluncus_curtisii_58281 0 0.0 0.0 +Stanieria_cyanosphaera_58641 0 0.0 0.0 +Burkholderia_sp_62620 0 0.0 0.0 +Pseudobutyrivibrio_sp_60404 0 0.0 0.0 +Wolinella_succinogenes_61095 0 0.0 0.0 +Campylobacter_sp_60555 0 0.0 0.0 +Fusobacterium_russii_59883 0 0.0 0.0 +Sporosarcina_newyorkensis_62264 0 0.0 0.0 +Ectothiorhodospira_sp_61687 0 0.0 0.0 +Paenisporosarcina_sp_58510 0 0.0 0.0 +Paenibacillus_sp_59620 0 0.0 0.0 +Helicobacter_cetorum_60955 0 0.0 0.0 +Curtobacterium_sp_60696 0 0.0 0.0 +Desulfovibrio_termitidis_62012 0 0.0 0.0 +Rhodococcus_equi_54882 0 0.0 0.0 +Kitasatospora_cheerisanensis_60210 0 0.0 0.0 +Clostridium_hylemonae_61789 0 0.0 0.0 +Prevotella_oris_57058 0 0.0 0.0 +Solirubrobacter_sp_60009 0 0.0 0.0 +Desulfovibrio_cuneatus_58812 0 0.0 0.0 +Pontibacter_roseus_58997 0 0.0 0.0 +Pleomorphomonas_oryzae_58996 0 0.0 0.0 +Prevotella_sp_60402 0 0.0 0.0 +Bifidobacterium_catenulatum_58257 0 0.0 0.0 +Prevotella_sp_60401 0 0.0 0.0 +Clostridium_sp_58419 0 0.0 0.0 +Pseudomonas_fragi_59193 0 0.0 0.0 +Epilithonimonas_lactis_61491 0 0.0 0.0 +Clostridium_sordellii_57678 0 0.0 0.0 +Leucobacter_sp_60357 0 0.0 0.0 +Janibacter_hoylei_59504 0 0.0 0.0 +Brachyspira_murdochii_61727 0 0.0 0.0 +Lactobacillus_hominis_62387 0 0.0 0.0 +Acinetobacter_parvus_58065 0 0.0 0.0 +Clostridium_intestinale_59988 0 0.0 0.0 +Terriglobus_roseus_62523 0 0.0 0.0 +Tatumella_sp_60185 0 0.0 0.0 +Streptomyces_griseus_62087 0 0.0 0.0 +Robiginitalea_biformata_61181 0 0.0 0.0 +Vibrio_vulnificus_58105 0 0.0 0.0 +Actinospica_robiniae_61611 0 0.0 0.0 +Prevotella_aurantiaca_59705 0 0.0 0.0 +Atopobium_fossor_58713 0 0.0 0.0 +Paenibacillus_alvei_59483 0 0.0 0.0 +Ruegeria_sp_61514 0 0.0 0.0 +Bacillus_clausii_53464 0 0.0 0.0 +Methylophaga_thiooxydans_57805 0 0.0 0.0 +Desulfospira_joergensenii_59827 0 0.0 0.0 +Massilia_sp_60797 0 0.0 0.0 +Citrobacter_sp_58515 0 0.0 0.0 +Sphingopyxis_sp_58654 0 0.0 0.0 +Pseudomonas_putida_58043 0 0.0 0.0 +Lachnospiraceae_bacterium_59689 0 0.0 0.0 +Actinomyces_georgiae_55085 0 0.0 0.0 +Lachnospiraceae_bacterium_59683 0 0.0 0.0 +Aequorivita_sublithincola_62234 0 0.0 0.0 +Lachnospiraceae_bacterium_59684 0 0.0 0.0 +Sphingobium_chlorophenolicum_61565 0 0.0 0.0 +Alistipes_putredinis_61533 0 0.0 0.0 +Frankia_sp_52591 0 0.0 0.0 +Fervidobacterium_pennivorans_62310 0 0.0 0.0 +Chthoniobacter_flavus_61646 0 0.0 0.0 +Nigerium_massiliensis_60808 0 0.0 0.0 +Kluyvera_ascorbata_58323 0 0.0 0.0 +Streptomyces_sp_55062 0 0.0 0.0 +Corynebacterium_aurimucosum_34136 0 0.0 0.0 +Enterococcus_sulfureus_44556 0 0.0 0.0 +Alcaligenes_faecalis_59573 0 0.0 0.0 +Pseudomonas_stutzeri_62011 0 0.0 0.0 +Rhodobacter_sphaeroides_61301 0 0.0 0.0 +Bacillus_firmus_60062 0 0.0 0.0 +Sandarakinorhabdus_limnophila_59047 0 0.0 0.0 +Enterobacter_cloacae_57303 0 0.0 0.0 +Klebsiella_pneumoniae_54788 0 0.0 0.0 +Sinorhizobium_meliloti_58050 0 0.0 0.0 +Sediminibacterium_sp_57886 0 0.0 0.0 +Desulfobacterium_anilini_58795 0 0.0 0.0 +Roseomonas_gilardii_60138 0 0.0 0.0 +Melitea_salexigens_58940 0 0.0 0.0 +Ralstonia_pickettii_60247 0 0.0 0.0 +Erysipelothrix_tonsillarum_58836 0 0.0 0.0 +Amycolatopsis_alba_59153 0 0.0 0.0 +Thermotoga_thermarum_62130 0 0.0 0.0 +Kallotenue_papyrolyticum_59167 0 0.0 0.0 +Fulvivirga_imtechensis_59731 0 0.0 0.0 +Peptococcaceae_bacterium_60822 0 0.0 0.0 +Peptococcaceae_bacterium_60821 0 0.0 0.0 +SAR116_cluster_62494 0 0.0 0.0 +Streptococcus_oralis_57687 0 0.0 0.0 +Octadecabacter_arcticus_61416 0 0.0 0.0 +Streptococcus_equi_57942 0 0.0 0.0 +Mannheimia_succiniciproducens_61024 0 0.0 0.0 +Petrotoga_mobilis_61462 0 0.0 0.0 +Halothiobacillus_neapolitanus_61796 0 0.0 0.0 +Methylophaga_sp_62251 0 0.0 0.0 +Methylophaga_sp_62252 0 0.0 0.0 +Pseudomonas_extremaustralis_58643 0 0.0 0.0 +Flavobacterium_sp_60494 0 0.0 0.0 +Gillisia_sp_59935 0 0.0 0.0 +Corynebacterium_efficiens_34857 0 0.0 0.0 +Corynebacterium_glycinophilum_60385 0 0.0 0.0 +Granulicatella_adiacens_61980 0 0.0 0.0 +Accumulibacter_sp_60613 0 0.0 0.0 +Clostridium_botulinum_56419 0 0.0 0.0 +Sphingomonas_sp_58615 0 0.0 0.0 +Sphingomonas_sp_58616 0 0.0 0.0 +Deinococcus_deserti_61766 0 0.0 0.0 +Marinomonas_ushuaiensis_58929 0 0.0 0.0 +Acetobacteraceae_bacterium_58457 0 0.0 0.0 +Sphingomonas_sp_58618 0 0.0 0.0 +Streptomyces_purpureus_58460 0 0.0 0.0 +Lachnospiraceae_bacterium_61442 0 0.0 0.0 +Streptococcus_mitis_58331 0 0.0 0.0 +Streptococcus_mitis_58330 0 0.0 0.0 +Prochlorococcus_sp_60681 0 0.0 0.0 +Prochlorococcus_sp_60683 0 0.0 0.0 +Prochlorococcus_sp_60682 0 0.0 0.0 +Agrobacterium_tumefaciens_58230 0 0.0 0.0 +Microbacterium_sp_59645 0 0.0 0.0 +Pandoraea_apista_62553 0 0.0 0.0 +Solemya_velum_61041 0 0.0 0.0 +Marinobacter_sp_60692 0 0.0 0.0 +Streptococcus_sobrinus_57517 0 0.0 0.0 +Synechococcus_spongiarum_60594 0 0.0 0.0 +Hydrogenobacter_thermophilus_33896 0 0.0 0.0 +Enterobacter_aerogenes_55704 0 0.0 0.0 +Streptococcus_constellatus_57767 0 0.0 0.0 +Helicobacter_pylori_55393 0 0.0 0.0 +Janthinobacterium_sp_60766 0 0.0 0.0 +Cupriavidus_sp_58517 0 0.0 0.0 +Prevotella_stercorea_58308 0 0.0 0.0 +Azotobacter_chroococcum_60116 0 0.0 0.0 +Mesorhizobium_ciceri_56634 0 0.0 0.0 +Pseudoalteromonas_agarivorans_56740 0 0.0 0.0 +Porphyromonas_macacae_57163 0 0.0 0.0 +Bartonella_australis_58543 0 0.0 0.0 +Acinetobacter_beijerinckii_57526 0 0.0 0.0 +Bosea_sp_59154 0 0.0 0.0 +Pseudanabaena_sp_59383 0 0.0 0.0 +Desulfurella_acetivorans_62147 0 0.0 0.0 +Verminephrobacter_eiseniae_61420 0 0.0 0.0 +Vibrio_rhizosphaerae_59126 0 0.0 0.0 +Bacteroides_coprosuis_62106 0 0.0 0.0 +Bifidobacterium_reuteri_60525 0 0.0 0.0 +Nitrincola_sp_60858 0 0.0 0.0 +Desulfobulbus_mediterraneus_58798 0 0.0 0.0 +Desulfobacter_curvatus_58793 0 0.0 0.0 +Chitinimonas_koreensis_58749 0 0.0 0.0 +Mesorhizobium_sp_61372 0 0.0 0.0 +Mesorhizobium_sp_61371 0 0.0 0.0 +Mesorhizobium_sp_61370 0 0.0 0.0 +Thioalkalivibrio_sp_57499 0 0.0 0.0 +Mycobacterium_setense_57116 0 0.0 0.0 +Thermoactinomyces_daqus_60118 0 0.0 0.0 +Rhodobacter_sp_61353 0 0.0 0.0 +Psychrobacter_aquaticus_60230 0 0.0 0.0 +Desulfovibrio_sp_61164 0 0.0 0.0 +Chryseobacterium_luteum_61492 0 0.0 0.0 +Pseudomonas_sp_54203 0 0.0 0.0 +Eubacterium_plexicaudatum_59692 0 0.0 0.0 +Xanthomonas_sacchari_58265 0 0.0 0.0 +Corynebacterium_ulcerans_49663 0 0.0 0.0 +Herminiimonas_sp_60218 0 0.0 0.0 +Sphingobium_quisquiliarum_56723 0 0.0 0.0 +Butyrivibrio_sp_60781 0 0.0 0.0 +Sinorhizobium_medicae_53134 0 0.0 0.0 +Atopobium_vaginae_62370 0 0.0 0.0 +Parabacteroides_johnsonii_55217 0 0.0 0.0 +Terasakiella_pusilla_59100 0 0.0 0.0 +Halomonas_boliviensis_58483 0 0.0 0.0 +Marinomonas_mediterranea_62198 0 0.0 0.0 +Erwinia_pyrifoliae_56987 0 0.0 0.0 +Capnocytophaga_gingivalis_61780 0 0.0 0.0 +Treponema_denticola_58011 0 0.0 0.0 +Eubacterium_desmolans_60421 0 0.0 0.0 +Inquilinus_limosus_58889 0 0.0 0.0 +Cronobacter_dublinensis_57140 0 0.0 0.0 +Rhizobium_mesoamericanum_57690 0 0.0 0.0 +Mesorhizobium_sp_40295 0 0.0 0.0 +Fodinicurvata_sediminis_61835 0 0.0 0.0 +Bradyrhizobium_sp_61529 0 0.0 0.0 +Jeotgalibacillus_soli_62472 0 0.0 0.0 +Beta_proteobacterium_59631 0 0.0 0.0 +Myxosarcina_sp_60851 0 0.0 0.0 +Bartonella_washoensis_55925 0 0.0 0.0 +Synechococcus_elongatus_51654 0 0.0 0.0 +Empedobacter_falsenii_61297 0 0.0 0.0 +Idiomarina_sp_60794 0 0.0 0.0 +Saccharothrix_syringae_58393 0 0.0 0.0 +Staphylococcus_sp_59500 0 0.0 0.0 +Erysipelotrichaceae_bacterium_62051 0 0.0 0.0 +Thioflavicoccus_mobilis_62291 0 0.0 0.0 +Gardnerella_vaginalis_58289 0 0.0 0.0 +Anabaena_sp_60930 0 0.0 0.0 +Thauera_sp_61645 0 0.0 0.0 +Pseudomonas_umsongensis_57944 0 0.0 0.0 +Nocardioides_sp_60567 0 0.0 0.0 +Kocuria_rhizophila_57520 0 0.0 0.0 +Acinetobacter_oleivorans_57892 0 0.0 0.0 +Saccharibacillus_sacchari_62510 0 0.0 0.0 +Herbiconiux_sp_60741 0 0.0 0.0 +Clostridiales_bacterium_60100 0 0.0 0.0 +Pseudomonas_entomophila_61383 0 0.0 0.0 +Rubrivivax_benzoatilyticus_33432 0 0.0 0.0 +Flexibacter_roseolus_58852 0 0.0 0.0 +Octadecabacter_antarcticus_61419 0 0.0 0.0 +Pseudogulbenkiania_sp_62661 0 0.0 0.0 +Rhizobium_sp_57781 0 0.0 0.0 +Phaeobacter_gallaeciensis_57593 0 0.0 0.0 +Mesoaciditoga_lauensis_59253 0 0.0 0.0 +Helicobacter_pylori_61004 0 0.0 0.0 +Rheinheimera_texasensis_59024 0 0.0 0.0 +Helicobacter_pylori_61002 0 0.0 0.0 +Helicobacter_pylori_61003 0 0.0 0.0 +Aequorivita_capsosiphonis_58676 0 0.0 0.0 +Lachnospiraceae_bacterium_60342 0 0.0 0.0 +Haemophilus_influenzae_60134 0 0.0 0.0 +Psychromonas_hadalis_59881 0 0.0 0.0 +Acinetobacter_baumannii_62478 0 0.0 0.0 +Enterobacter_cloacae_55011 0 0.0 0.0 +Nocardia_cyriacigeorgica_59467 0 0.0 0.0 +Prochlorococcus_sp_60762 0 0.0 0.0 +Prochlorococcus_sp_60763 0 0.0 0.0 +Providencia_stuartii_53536 0 0.0 0.0 +Streptococcus_infantis_58384 0 0.0 0.0 +Nesterenkonia_sp_62315 0 0.0 0.0 +Chamaesiphon_minutus_59345 0 0.0 0.0 +Hyphomonas_neptunium_43067 0 0.0 0.0 +Xanthomonas_perforans_55843 0 0.0 0.0 +Streptomyces_sp_62181 0 0.0 0.0 +Ehrlichia_sp_61400 0 0.0 0.0 +Geitlerinema_sp_59350 0 0.0 0.0 +Streptomyces_tsukubaensis_58623 0 0.0 0.0 +Thermincola_potens_61975 0 0.0 0.0 +Gramella_echinicola_58870 0 0.0 0.0 +Aggregatibacter_actinomycetemcomitans_57720 0 0.0 0.0 +Acidovorax_radicis_33253 0 0.0 0.0 +Echinicola_pacifica_58829 0 0.0 0.0 +Thermotoga_sp_59647 0 0.0 0.0 +Polaromonas_sp_61159 0 0.0 0.0 +Methylobacterium_mesophilicum_62490 0 0.0 0.0 +Leuconostoc_fallax_62486 0 0.0 0.0 +Actinosynnema_mirum_61537 0 0.0 0.0 +Streptomyces_aureofaciens_54407 0 0.0 0.0 +Aminobacterium_mobile_60044 0 0.0 0.0 +Oscillospiraceae_bacterium_54867 0 0.0 0.0 +Porphyrobacter_sp_60694 0 0.0 0.0 +Nitrosococcus_oceani_56447 0 0.0 0.0 +Bifidobacterium_tsurumiense_46912 0 0.0 0.0 +Microbacterium_sp_59366 0 0.0 0.0 +Acholeplasma_axanthum_59887 0 0.0 0.0 +Methylococcaceae_bacterium_58632 0 0.0 0.0 +Sphingobium_yanoikuyae_58162 0 0.0 0.0 +Pseudomonas_viridiflava_57558 0 0.0 0.0 +Campylobacter_concisus_59753 0 0.0 0.0 +Campylobacter_concisus_59750 0 0.0 0.0 +Thalassolituus_oleivorans_56743 0 0.0 0.0 +Pseudomonas_sp_60712 0 0.0 0.0 +Planctomyces_limnophilus_61696 0 0.0 0.0 +Clostridium_paraputrificum_59909 0 0.0 0.0 +Thermodesulfobacterium_hveragerdense_59108 0 0.0 0.0 +Saprospira_grandis_62148 0 0.0 0.0 +Streptomyces_olindensis_61327 0 0.0 0.0 +Acinetobacter_baumannii_57698 0 0.0 0.0 +Peptostreptococcus_anaerobius_55004 0 0.0 0.0 +Sideroxydans_lithotrophicus_61861 0 0.0 0.0 +Vibrio_brasiliensis_62613 0 0.0 0.0 +Chryseobacterium_gregarium_58753 0 0.0 0.0 +Kocuria_sp_60162 0 0.0 0.0 +Erwinia_amylovora_56589 0 0.0 0.0 +Weissella_halotolerans_59128 0 0.0 0.0 +Thermus_islandicus_59114 0 0.0 0.0 +Desulfovibrio_inopinatus_58816 0 0.0 0.0 +Nitrincola_sp_59635 0 0.0 0.0 +Streptomyces_sp_59972 0 0.0 0.0 +Sphingopyxis_baekryungensis_59066 0 0.0 0.0 +Methylophaga_aminisulfidivorans_58344 0 0.0 0.0 +Listeria_monocytogenes_53478 0 0.0 0.0 +Jeotgalicoccus_marinus_58890 0 0.0 0.0 +Arthromitus_sp_58417 0 0.0 0.0 +Verrucomicrobium_sp_60354 0 0.0 0.0 +Clostridium_saccharobutylicum_60190 0 0.0 0.0 +Aeromonas_caviae_57221 0 0.0 0.0 +Actinoplanes_friuliensis_59778 0 0.0 0.0 +Halomonas_anticariensis_44729 0 0.0 0.0 +Williamsia_sp_58068 0 0.0 0.0 +Nocardioides_sp_60979 0 0.0 0.0 +Gilvimarinus_chinensis_58861 0 0.0 0.0 +Chryseobacterium_gleum_61706 0 0.0 0.0 +Bacillus_megaterium_57856 0 0.0 0.0 +Actinobacillus_minor_61978 0 0.0 0.0 +Melissococcus_plutonius_54390 0 0.0 0.0 +Deinococcus_aquatilis_58785 0 0.0 0.0 +Clostridiaceae_bacterium_60038 0 0.0 0.0 +Bacillus_anthracis_57688 0 0.0 0.0 +Streptacidiphilus_rugosus_62639 0 0.0 0.0 +Cobetia_marina_61117 0 0.0 0.0 +Bacillus_flexus_60543 0 0.0 0.0 +Alcanivorax_sp_59363 0 0.0 0.0 +Enterobacter_sp_59321 0 0.0 0.0 +Rhizobium_grahamii_62660 0 0.0 0.0 +Lactobacillus_sp_60861 0 0.0 0.0 +Lactobacillus_sp_60860 0 0.0 0.0 +Bifidobacterium_bombi_60179 0 0.0 0.0 +Phascolarctobacterium_sp_59817 0 0.0 0.0 +Phascolarctobacterium_sp_59818 0 0.0 0.0 +Herbaspirillum_huttiense_59680 0 0.0 0.0 +Thermobifida_fusca_52029 0 0.0 0.0 +Kineococcus_radiotolerans_61084 0 0.0 0.0 +Microtetraspora_glauca_60985 0 0.0 0.0 +Clavibacter_michiganensis_58293 0 0.0 0.0 +Firmicutes_bacterium_59686 0 0.0 0.0 +Bacillus_smithii_62067 0 0.0 0.0 +Nitratifractor_salsuginis_62241 0 0.0 0.0 +Coprobacter_fastidiosus_56550 0 0.0 0.0 +Chlorobium_phaeobacteroides_61271 0 0.0 0.0 +Leptospira_interrogans_56645 0 0.0 0.0 +Salinimonas_chungwhensis_59044 0 0.0 0.0 +Enterococcus_malodoratus_44064 0 0.0 0.0 +Celeribacter_indicus_59490 0 0.0 0.0 +Arcobacter_sp_62610 0 0.0 0.0 +Commensalibacter_sp_59492 0 0.0 0.0 +Flavobacterium_frigoris_58525 0 0.0 0.0 +Vibrionales_bacterium_61402 0 0.0 0.0 +Saccharospirillum_impatiens_59038 0 0.0 0.0 +Lactobacillus_harbinensis_58901 0 0.0 0.0 +Streptomyces_davawensis_59521 0 0.0 0.0 +Rhizobium_sp_61337 0 0.0 0.0 +Gordonia_hirsuta_58866 0 0.0 0.0 +Actinoalloteichus_cyanogriseus_52665 0 0.0 0.0 +Caldithrix_abyssi_62409 0 0.0 0.0 +Glaciecola_sp_61553 0 0.0 0.0 +Desulfovibrio_alcoholivorans_58808 0 0.0 0.0 +Methylibium_sp_60738 0 0.0 0.0 +Methylibium_sp_60739 0 0.0 0.0 +Streptococcus_sp_58555 0 0.0 0.0 +Methylibium_sp_60737 0 0.0 0.0 +Staphylococcus_aureus_57331 0 0.0 0.0 +Bartonella_rattaustraliani_59458 0 0.0 0.0 +Gardnerella_vaginalis_57030 0 0.0 0.0 +Lacticigenium_naphtae_58899 0 0.0 0.0 +Veillonella_magna_59123 0 0.0 0.0 +Microcoleus_vaginatus_62259 0 0.0 0.0 +Streptococcus_tigurinus_42919 0 0.0 0.0 +Alcanivorax_sp_60360 0 0.0 0.0 +Microlunatus_phosphovorus_58361 0 0.0 0.0 +Rhodococcus_rhodnii_61378 0 0.0 0.0 +Streptomyces_ipomoeae_62155 0 0.0 0.0 +Chryseobacterium_sp_60751 0 0.0 0.0 +Geobacillus_sp_61588 0 0.0 0.0 +Micrococcus_luteus_59665 0 0.0 0.0 +Alloiococcus_otitis_62422 0 0.0 0.0 +Lactococcus_lactis_56468 0 0.0 0.0 +Methylosarcina_lacus_58620 0 0.0 0.0 +Pseudomonas_sp_59229 0 0.0 0.0 +Pseudomonas_sp_59228 0 0.0 0.0 +Planctomyces_brasiliensis_62260 0 0.0 0.0 +Pseudomonas_sp_59223 0 0.0 0.0 +Pseudomonas_sp_59225 0 0.0 0.0 +Pseudomonas_sp_59224 0 0.0 0.0 +Pseudomonas_sp_59227 0 0.0 0.0 +Pseudomonas_sp_59226 0 0.0 0.0 +Staphylococcus_agnetis_62654 0 0.0 0.0 +Saccharibacillus_kuerlensis_59036 0 0.0 0.0 +Ornithobacterium_rhinotracheale_49033 0 0.0 0.0 +Cellvibrio_sp_59190 0 0.0 0.0 +Microbulbifer_variabilis_59891 0 0.0 0.0 +Unidentified_eubacterium_61667 0 0.0 0.0 +Streptococcus_pseudopneumoniae_60471 0 0.0 0.0 +Streptococcus_pseudopneumoniae_60472 0 0.0 0.0 +Mangrovibacter_sp_59610 0 0.0 0.0 +Mesorhizobium_sp_59999 0 0.0 0.0 +Capnocytophaga_sp_59162 0 0.0 0.0 +Pectobacterium_carotovorum_57865 0 0.0 0.0 +Pseudomonas_sp_56905 0 0.0 0.0 +Streptomyces_viridochromogenes_61899 0 0.0 0.0 +Streptococcus_sp_62585 0 0.0 0.0 +Vibrio_cholerae_56566 0 0.0 0.0 +Clostridium_tetani_58149 0 0.0 0.0 +Streptococcus_australis_62469 0 0.0 0.0 +Geomicrobium_sp_58204 0 0.0 0.0 +Leptospira_borgpetersenii_53012 0 0.0 0.0 +Vesicomyosocius_okutanii_61486 0 0.0 0.0 +Lactobacillus_mucosae_57556 0 0.0 0.0 +Chryseobacterium_palustre_58754 0 0.0 0.0 +Corynebacterium_sp_47185 0 0.0 0.0 +Helicobacter_bizzozeronii_58311 0 0.0 0.0 +Helicobacter_bizzozeronii_58310 0 0.0 0.0 +Solobacterium_moorei_56880 0 0.0 0.0 +Rhodobacterales_bacterium_61346 0 0.0 0.0 +Streptosporangium_roseum_57476 0 0.0 0.0 +Marvinbryantia_formatexigens_61608 0 0.0 0.0 +Nocardia_brevicatena_59466 0 0.0 0.0 +Streptococcus_pneumoniae_60080 0 0.0 0.0 +Granulibacter_bethesdensis_57577 0 0.0 0.0 +Streptococcus_pneumoniae_60082 0 0.0 0.0 +Streptococcus_pneumoniae_60083 0 0.0 0.0 +Corynebacterium_sp_60464 0 0.0 0.0 +Francisella_tularensis_62097 0 0.0 0.0 +Corynebacterium_variabile_62340 0 0.0 0.0 +Actinomyces_sp_58647 0 0.0 0.0 +Shewanella_sp_62600 0 0.0 0.0 +Jeotgalicoccus_psychrophilus_58891 0 0.0 0.0 +Lachnospiraceae_bacterium_62050 0 0.0 0.0 +Collimonas_fungivorans_58316 0 0.0 0.0 +Bradyrhizobium_sp_60944 0 0.0 0.0 +Aquiluna_sp_58519 0 0.0 0.0 +Bacillus_mojavensis_58026 0 0.0 0.0 +Simkania_negevensis_61270 0 0.0 0.0 +Maricaulis_sp_59301 0 0.0 0.0 +Methylibium_petroleiphilum_55794 0 0.0 0.0 +Bacillus_selenitireducens_61512 0 0.0 0.0 +Porticoccus_hydrocarbonoclasticus_60476 0 0.0 0.0 +Phyllobacterium_sp_60564 0 0.0 0.0 +Brachyspira_pilosicoli_56946 0 0.0 0.0 +Sphingobium_sp_60136 0 0.0 0.0 +Porphyromonas_endodontalis_34109 0 0.0 0.0 +Leuconostoc_argentinum_62436 0 0.0 0.0 +Megamonas_hypermegale_58935 0 0.0 0.0 +Clostridium_mangenotii_58185 0 0.0 0.0 +Streptomyces_pluripotens_51883 0 0.0 0.0 +Paenibacillus_darwinianus_50249 0 0.0 0.0 +Gluconacetobacter_hansenii_62187 0 0.0 0.0 +Haloplasma_contractile_58374 0 0.0 0.0 +Sporosarcina_koreensis_61275 0 0.0 0.0 +Bacillus_sp_59331 0 0.0 0.0 +Herminiimonas_arsenicoxydans_60996 0 0.0 0.0 +Acinetobacter_schindleri_57376 0 0.0 0.0 +Helicobacter_pylori_53193 0 0.0 0.0 +Rickettsia_felis_58292 0 0.0 0.0 +Bacteroides_helcogenes_62145 0 0.0 0.0 +Aerococcus_viridans_58017 0 0.0 0.0 +Riemerella_anatipestifer_53476 0 0.0 0.0 +Bosea_sp_60769 0 0.0 0.0 +Faecalibacterium_prausnitzii_62201 0 0.0 0.0 +Synechococcus_sp_58591 0 0.0 0.0 +Synechococcus_sp_58592 0 0.0 0.0 +Mycobacterium_triplex_61606 0 0.0 0.0 +Arthrobacter_sp_59856 0 0.0 0.0 +Arthrobacter_sp_59855 0 0.0 0.0 +Treponema_pedis_56128 0 0.0 0.0 +Hylemonella_gracilis_60615 0 0.0 0.0 +Actinomyces_israelii_58669 0 0.0 0.0 +Sphingomonas_sanxanigenens_59065 0 0.0 0.0 +Desulfomicrobium_escambiense_58801 0 0.0 0.0 +Streptomyces_sp_57580 0 0.0 0.0 +Bacillus_vietnamensis_61015 0 0.0 0.0 +Maribacter_antarcticus_58922 0 0.0 0.0 +Streptococcus_sp_62351 0 0.0 0.0 +Lactobacillus_reuteri_34175 0 0.0 0.0 +Prevotella_sp_60336 0 0.0 0.0 +Clostridium_difficile_57608 0 0.0 0.0 +Flavobacterium_suncheonense_44730 0 0.0 0.0 +Streptomyces_sp_53350 0 0.0 0.0 +KSB1_bacterium_54432 0 0.0 0.0 +Arthrobacter_phenanthrenivorans_62546 0 0.0 0.0 +Ramlibacter_tataouinensis_61339 0 0.0 0.0 +Weissella_koreensis_53982 0 0.0 0.0 +Brevundimonas_abyssalis_60335 0 0.0 0.0 +Marmoricola_sp_60014 0 0.0 0.0 +Bacillus_sp_60168 0 0.0 0.0 +Bacillus_sp_60169 0 0.0 0.0 +Enterococcus_italicus_62450 0 0.0 0.0 +Paracoccus_sp_57975 0 0.0 0.0 +Desulfobacter_vibrioformis_58794 0 0.0 0.0 +Pasteurella_multocida_57022 0 0.0 0.0 +Streptococcus_infantis_62384 0 0.0 0.0 +Thioalkalivibrio_sp_61749 0 0.0 0.0 +Thioalkalivibrio_sp_61748 0 0.0 0.0 +Salipiger_mucosus_59045 0 0.0 0.0 +Chlorobium_ferrooxidans_61363 0 0.0 0.0 +Corynebacterium_diphtheriae_56713 0 0.0 0.0 +Liberibacter_americanus_57665 0 0.0 0.0 +Pseudomonas_parafulva_43471 0 0.0 0.0 +Salinicoccus_roseus_61554 0 0.0 0.0 +Smaragdicoccus_niigatensis_59059 0 0.0 0.0 +Ruminococcus_gnavus_57638 0 0.0 0.0 +Methylotenera_mobilis_59184 0 0.0 0.0 +Bacillus_pumilus_56522 0 0.0 0.0 +Geodermatophilaceae_bacterium_60267 0 0.0 0.0 +Geodermatophilaceae_bacterium_60264 0 0.0 0.0 +Pantoea_rwandensis_58499 0 0.0 0.0 +Pseudomonas_sp_60771 0 0.0 0.0 +Hyphomonas_oceanitis_59923 0 0.0 0.0 +Butyrivibrio_crossotus_61674 0 0.0 0.0 +Francisella_noatunensis_47799 0 0.0 0.0 +Bradyrhizobium_sp_59642 0 0.0 0.0 +Beijerinckia_indica_61432 0 0.0 0.0 +Pantoea_agglomerans_54643 0 0.0 0.0 +Pseudobacteroides_cellulosolvens_61446 0 0.0 0.0 +Puniceispirillum_marinum_61633 0 0.0 0.0 +Amphritea_japonica_59886 0 0.0 0.0 +Rhizobium_leguminosarum_57616 0 0.0 0.0 +Ehrlichia_ruminantium_55555 0 0.0 0.0 +Lactobacillus_johnsonii_57663 0 0.0 0.0 +Butyrivibrio_sp_60621 0 0.0 0.0 +Actinobaculum_schaalii_62418 0 0.0 0.0 +Streptococcus_suis_58107 0 0.0 0.0 +Aeromonas_fluvialis_61900 0 0.0 0.0 +Helicobacter_pylori_62483 0 0.0 0.0 +Helicobacter_pylori_62484 0 0.0 0.0 +Clostridium_baratii_60475 0 0.0 0.0 +Leptospira_noguchii_57887 0 0.0 0.0 +Nesiotobacter_exalbescens_58953 0 0.0 0.0 +Advenella_kashmirensis_58390 0 0.0 0.0 +Pseudomonas_frederiksbergensis_58403 0 0.0 0.0 +Staphylococcus_warneri_58053 0 0.0 0.0 +Pseudomonas_syringae_54805 0 0.0 0.0 +Actinoplanes_subtropicus_61745 0 0.0 0.0 +Nocardia_veterana_59480 0 0.0 0.0 +Pseudoalteromonas_spongiae_58636 0 0.0 0.0 +Peptoniphilus_lacrimalis_56996 0 0.0 0.0 +Nitrosomonas_eutropha_61276 0 0.0 0.0 +Desulfovibrio_sp_60063 0 0.0 0.0 +Bartonella_henselae_53943 0 0.0 0.0 +Dietzia_alimentaria_58502 0 0.0 0.0 +Geobacillus_vulcani_60299 0 0.0 0.0 +Phaeobacter_gallaeciensis_60492 0 0.0 0.0 +Herbaspirillum_sp_62172 0 0.0 0.0 +Salinispora_pacifica_54583 0 0.0 0.0 +Bifidobacterium_callitrichos_60524 0 0.0 0.0 +Propionicicella_superfundia_59005 0 0.0 0.0 +Caldicoprobacter_oshimai_60046 0 0.0 0.0 +Photorhabdus_luminescens_56460 0 0.0 0.0 +Clostridium_sp_60029 0 0.0 0.0 +Veillonella_sp_62586 0 0.0 0.0 +Dickeya_solani_45571 0 0.0 0.0 +Paenibacillus_sp_60563 0 0.0 0.0 +Lactobacillus_animalis_53719 0 0.0 0.0 +Mesorhizobium_loti_55991 0 0.0 0.0 +Providencia_alcalifaciens_43220 0 0.0 0.0 +Rhodococcus_rhodochrous_53279 0 0.0 0.0 +Clostridium_sporogenes_58038 0 0.0 0.0 +Ruegeria_sp_62641 0 0.0 0.0 +Photobacterium_angustum_61210 0 0.0 0.0 +Helicobacter_pylori_61908 0 0.0 0.0 +Collinsella_aerofaciens_61484 0 0.0 0.0 +Treponema_primitia_62192 0 0.0 0.0 +Desulfotomaculum_thermocisternum_58806 0 0.0 0.0 +Barnesiella_intestinihominis_62208 0 0.0 0.0 +Bacteroides_eggerthii_54457 0 0.0 0.0 +Bradyrhizobium_sp_61776 0 0.0 0.0 +Bradyrhizobium_sp_61775 0 0.0 0.0 +Cylindrospermopsis_raciborskii_61738 0 0.0 0.0 +Corynebacterium_pyruviciproducens_59150 0 0.0 0.0 +Listeria_innocua_56310 0 0.0 0.0 +Streptomyces_sp_57441 0 0.0 0.0 +Oceanicaulis_sp_60693 0 0.0 0.0 +Neisseria_shayeganii_58362 0 0.0 0.0 +Eubacterium_hallii_61477 0 0.0 0.0 +Campylobacter_curvus_57251 0 0.0 0.0 +Acetonema_longum_58333 0 0.0 0.0 +Curvibacter_gracilis_60147 0 0.0 0.0 +Burkholderiales_bacterium_56577 0 0.0 0.0 +Aeromonas_jandaei_58278 0 0.0 0.0 +Ruminococcaceae_bacterium_60447 0 0.0 0.0 +Vibrio_rotiferianus_56978 0 0.0 0.0 +Enterobacter_cloacae_58287 0 0.0 0.0 +Bifidobacterium_longum_57796 0 0.0 0.0 +Prevotella_sp_58388 0 0.0 0.0 +Pediococcus_claussenii_62164 0 0.0 0.0 +Peptoniphilus_sp_58372 0 0.0 0.0 +Marinobacterium_sp_59666 0 0.0 0.0 +Leifsonia_aquatica_60482 0 0.0 0.0 +Pirellula_staleyi_61736 0 0.0 0.0 +Burkholderia_sp_59408 0 0.0 0.0 +Oribacterium_sp_58077 0 0.0 0.0 +Hallella_seregens_55732 0 0.0 0.0 +Cellulomonas_sp_60608 0 0.0 0.0 +Verrucomicrobium_sp_59187 0 0.0 0.0 +Aeromonas_sp_60856 0 0.0 0.0 +Cyclobacterium_qasimii_61997 0 0.0 0.0 +Deinococcus_sp_60849 0 0.0 0.0 +Mumia_flava_60211 0 0.0 0.0 +Pseudomonas_pseudoalcaligenes_60599 0 0.0 0.0 +Leisingera_nanhaiensis_61837 0 0.0 0.0 +Acinetobacter_sp_59235 0 0.0 0.0 +Desulfonatronovibrio_hydrogenovorans_58802 0 0.0 0.0 +Winogradskyella_sp_62249 0 0.0 0.0 +Leptolyngbya_sp_58642 0 0.0 0.0 +Treponema_medium_59147 0 0.0 0.0 +Halomonas_halocynthiae_58878 0 0.0 0.0 +Dickeya_zeae_56890 0 0.0 0.0 +Butyricimonas_synergistica_58741 0 0.0 0.0 +Acinetobacter_lwoffii_59552 0 0.0 0.0 +Sphingobium_sp_61949 0 0.0 0.0 +Roseibium_sp_62226 0 0.0 0.0 +Novosphingobium_lindaniclasticum_58576 0 0.0 0.0 +Serratia_symbiotica_55338 0 0.0 0.0 +Loktanella_vestfoldensis_61192 0 0.0 0.0 +Veillonella_montpellierensis_56010 0 0.0 0.0 +Bacillus_sp_60688 0 0.0 0.0 +Bacteroides_plebeius_61623 0 0.0 0.0 +Exiguobacterium_oxidotolerans_60365 0 0.0 0.0 +Bradyrhizobium_sp_60018 0 0.0 0.0 +Butyrivibrio_sp_60431 0 0.0 0.0 +Cucumibacter_marinus_61493 0 0.0 0.0 +Thermocrinis_albus_61982 0 0.0 0.0 +Agarivorans_albus_60122 0 0.0 0.0 +Pseudomonas_sp_60529 0 0.0 0.0 +Clostridium_kluyveri_34403 0 0.0 0.0 +Fusobacterium_nucleatum_57450 0 0.0 0.0 +Prolixibacter_bellariivorans_47374 0 0.0 0.0 +Lachnobacterium_bovis_52776 0 0.0 0.0 +Desulfobulbus_sp_60831 0 0.0 0.0 +Listeria_grayi_55743 0 0.0 0.0 +Streptococcus_sp_62701 0 0.0 0.0 +Streptococcus_sp_62700 0 0.0 0.0 +Peptoniphilus_timonensis_58570 0 0.0 0.0 +Sharpea_azabuensis_60459 0 0.0 0.0 +Porphyromonas_sp_59618 0 0.0 0.0 +Rhizobium_sp_59217 0 0.0 0.0 +Rhizobium_sp_59215 0 0.0 0.0 +Rhizobium_sp_59214 0 0.0 0.0 +Methylococcus_capsulatus_55034 0 0.0 0.0 +Aphanizomenon_flos-aquae_57437 0 0.0 0.0 +Lactobacillus_shenzhenensis_59648 0 0.0 0.0 +Sphingomonas_sp_60678 0 0.0 0.0 +Caldisericum_exile_61672 0 0.0 0.0 +Desulfovibrio_bastinii_58811 0 0.0 0.0 +Roseovarius_sp_61414 0 0.0 0.0 +Pseudomonas_fluorescens_62138 0 0.0 0.0 +Rhodanobacter_sp_58497 0 0.0 0.0 +Clostridium_sp_60561 0 0.0 0.0 +Arcanobacterium_haemolyticum_62008 0 0.0 0.0 +Corynebacterium_auriscanis_62694 0 0.0 0.0 +Methylomicrobium_buryatense_62090 0 0.0 0.0 +Edwardsiella_tarda_53746 0 0.0 0.0 +Cystobacter_fuscus_59745 0 0.0 0.0 +Dechlorosoma_suillum_61987 0 0.0 0.0 +Acinetobacter_tjernbergiae_58659 0 0.0 0.0 +Pseudomonas_resinovorans_59760 0 0.0 0.0 +Bacillus_subtilis_58172 0 0.0 0.0 +Saccharomonospora_viridis_52547 0 0.0 0.0 +Acidaminococcus_intestini_54097 0 0.0 0.0 +Neptunomonas_sp_60119 0 0.0 0.0 +Lysobacter_defluvii_44728 0 0.0 0.0 +Streptococcus_sanguinis_58161 0 0.0 0.0 +Dorea_sp_59688 0 0.0 0.0 +Pseudomonas_monteilii_57025 0 0.0 0.0 +Methyloversatilis_universalis_45347 0 0.0 0.0 +Bradyrhizobiaceae_bacterium_58015 0 0.0 0.0 +Streptococcus_suis_59532 0 0.0 0.0 +Oceanicola_granulosus_61194 0 0.0 0.0 +Bifidobacterium_thermophilum_61285 0 0.0 0.0 +Erythrobacter_longus_58426 0 0.0 0.0 +Coprobacter_sp_60889 0 0.0 0.0 +Bordetella_holmesii_50257 0 0.0 0.0 +Arthrobacter_albus_60374 0 0.0 0.0 +Staphylococcus_intermedius_59203 0 0.0 0.0 +Peptoniphilus_sp_55103 0 0.0 0.0 +Leptolyngbya_sp_58341 0 0.0 0.0 +Thioalkalivibrio_sp_57741 0 0.0 0.0 +Chrysiogenes_arsenatis_59378 0 0.0 0.0 +Thioalkalivibrio_thiocyanodenitrificans_62182 0 0.0 0.0 +Thioalkalivibrio_sp_57606 0 0.0 0.0 +Winogradskyella_psychrotolerans_61998 0 0.0 0.0 +Bacillus_sp_60493 0 0.0 0.0 +Flexibacter_elegans_58851 0 0.0 0.0 +Abiotrophia_defectiva_61902 0 0.0 0.0 +Tetrasphaera_elongata_59414 0 0.0 0.0 +Bradyrhizobium_elkanii_58396 0 0.0 0.0 +Bradyrhizobium_elkanii_58395 0 0.0 0.0 +Gloeobacter_violaceus_61066 0 0.0 0.0 +Leptothrix_cholodnii_61430 0 0.0 0.0 +Oscillochloris_trichoides_62286 0 0.0 0.0 +Salinarimonas_rosea_59039 0 0.0 0.0 +Shewanella_haliotis_57366 0 0.0 0.0 +Bacteroides_salanitronis_62074 0 0.0 0.0 +Bifidobacterium_crudilactis_61264 0 0.0 0.0 +Nocardia_transvalensis_59481 0 0.0 0.0 +Butyrivibrio_sp_54823 0 0.0 0.0 +Algoriphagus_vanfongensis_58686 0 0.0 0.0 +Prevotella_pallens_62692 0 0.0 0.0 +Dorea_longicatena_59913 0 0.0 0.0 +Meiothermus_silvanus_61730 0 0.0 0.0 +Clavibacter_michiganensis_61120 0 0.0 0.0 +Acinetobacter_towneri_58660 0 0.0 0.0 +Kineosporia_aurantiaca_60059 0 0.0 0.0 +Paracoccus_sp_60887 0 0.0 0.0 +Helicobacter_pylori_62673 0 0.0 0.0 +Mesorhizobium_sp_60891 0 0.0 0.0 +Streptococcus_sp_59334 0 0.0 0.0 +Rikenella_microfusus_62410 0 0.0 0.0 +Facklamia_hominis_57334 0 0.0 0.0 +Selenomonas_artemidis_57866 0 0.0 0.0 +Streptomyces_sp_59264 0 0.0 0.0 +Geodermatophilaceae_bacterium_60286 0 0.0 0.0 +Herbaspirillum_sp_59232 0 0.0 0.0 +Oxalobacteraceae_bacterium_59287 0 0.0 0.0 +Aliagarivorans_marinus_58687 0 0.0 0.0 +Halalkalibacillus_halophilus_58875 0 0.0 0.0 +Streptomyces_avicenniae_61653 0 0.0 0.0 +Uncultured_Sulfuricurvum_59786 0 0.0 0.0 +ZIXI_bacterium_60261 0 0.0 0.0 +Thiolapillus_brandeum_58500 0 0.0 0.0 +Acinetobacter_sp_57689 0 0.0 0.0 +Parvularcula_oceani_59781 0 0.0 0.0 +Streptomyces_sp_60892 0 0.0 0.0 +Ponticoccus_sp_60790 0 0.0 0.0 +Methylophilales_bacterium_61381 0 0.0 0.0 +Planktomarina_temperata_62069 0 0.0 0.0 +Desulfovirgula_thermocuniculi_58821 0 0.0 0.0 +Arthrobacter_sp_61919 0 0.0 0.0 +Herbidospora_cretacea_61119 0 0.0 0.0 +Streptococcus_mitis_59293 0 0.0 0.0 +Helicobacter_pylori_62674 0 0.0 0.0 +Streptococcus_plurextorum_59090 0 0.0 0.0 +Cupriavidus_sp_60846 0 0.0 0.0 +Novosphingobium_pentaromativorans_57695 0 0.0 0.0 +Streptococcus_pseudopneumoniae_58459 0 0.0 0.0 +Arthrobacter_sp_59260 0 0.0 0.0 +Pseudoalteromonas_sp_61166 0 0.0 0.0 +Denitrovibrio_acetiphilus_61700 0 0.0 0.0 +Frankia_alni_61260 0 0.0 0.0 +Dyella_jiangningensis_60257 0 0.0 0.0 +Fusobacterium_nucleatum_56829 0 0.0 0.0 +Maribacter_sp_59794 0 0.0 0.0 +Hamadaea_tsunoensis_58881 0 0.0 0.0 +Carnobacterium_sp_60164 0 0.0 0.0 +Lactobacillus_gasseri_55553 0 0.0 0.0 +Luteibacter_sp_56832 0 0.0 0.0 +Gemmatimonas_sp_60258 0 0.0 0.0 +Ruegeria_sp_61139 0 0.0 0.0 +Acetobacter_pasteurianus_58325 0 0.0 0.0 +Leifsonia_xyli_60333 0 0.0 0.0 +Paenibacillus_sp_60761 0 0.0 0.0 +Thioalkalivibrio_sp_59292 0 0.0 0.0 +Caldicellulosiruptor_hydrothermalis_61958 0 0.0 0.0 +Flammeovirga_pacifica_62508 0 0.0 0.0 +Leptospira_santarosai_55151 0 0.0 0.0 +Streptomyces_sp_60638 0 0.0 0.0 +Alpha_proteobacterium_58336 0 0.0 0.0 +Thioalkalivibrio_sp_57190 0 0.0 0.0 +Synechococcus_sp_59893 0 0.0 0.0 +Bacteroides_cellulosilyticus_58046 0 0.0 0.0 +Propionibacterium_avidum_56659 0 0.0 0.0 +Vibrio_navarrensis_57328 0 0.0 0.0 +Cedecea_neteri_60913 0 0.0 0.0 +Cedecea_neteri_60912 0 0.0 0.0 +Cedecea_neteri_60914 0 0.0 0.0 +Arcobacter_nitrofigilis_61840 0 0.0 0.0 +Stenotrophomonas_maltophilia_58653 0 0.0 0.0 +Mycobacterium_sp_58655 0 0.0 0.0 +Dickeya_dadantii_61894 0 0.0 0.0 +Asticcacaulis_sp_59928 0 0.0 0.0 +Asticcacaulis_sp_59925 0 0.0 0.0 +Polaromonas_sp_59220 0 0.0 0.0 +Asticcacaulis_sp_59927 0 0.0 0.0 +Asticcacaulis_sp_59926 0 0.0 0.0 +Pseudomonas_stutzeri_57416 0 0.0 0.0 +Aerococcus_viridans_62040 0 0.0 0.0 +Bacillus_cereus_55841 0 0.0 0.0 +Pseudomonas_fluorescens_61013 0 0.0 0.0 +Pelagibacter_sp_61513 0 0.0 0.0 +Lachnospiraceae_bacterium_60445 0 0.0 0.0 +Lachnospiraceae_bacterium_60444 0 0.0 0.0 +Lachnospiraceae_bacterium_60443 0 0.0 0.0 +Lachnospiraceae_bacterium_60442 0 0.0 0.0 +Lachnospiraceae_bacterium_60441 0 0.0 0.0 +Lachnospiraceae_bacterium_60440 0 0.0 0.0 +Yersinia_enterocolitica_60538 0 0.0 0.0 +Mycobacterium_fortuitum_45540 0 0.0 0.0 +Rhizobium_leguminosarum_62254 0 0.0 0.0 +Oceanibulbus_indolifex_61417 0 0.0 0.0 +Chryseobacterium_sp_60796 0 0.0 0.0 +Dehalococcoides_ethenogenes_57247 0 0.0 0.0 +Enterococcus_faecium_56947 0 0.0 0.0 +Algoriphagus_marincola_58684 0 0.0 0.0 +Methylophilus_sp_60328 0 0.0 0.0 +Alpha_proteobacterium_60714 0 0.0 0.0 +Desulfovibrio_desulfuricans_61996 0 0.0 0.0 +Clostridiales_bacterium_58120 0 0.0 0.0 +Prevotella_salivae_57216 0 0.0 0.0 +Mesorhizobium_loti_58406 0 0.0 0.0 +Andreprevotia_chitinilytica_58699 0 0.0 0.0 +Bordetella_bronchiseptica_58296 0 0.0 0.0 +Hoeflea_sp_58631 0 0.0 0.0 +Streptococcus_didelphis_59080 0 0.0 0.0 +Porphyromonas_bennonis_58999 0 0.0 0.0 +Helicobacter_trogontum_57068 0 0.0 0.0 +Oceanobacillus_sp_62618 0 0.0 0.0 +Bradyrhizobium_sp_59234 0 0.0 0.0 +Pseudomonas_sp_60327 0 0.0 0.0 +Salinispora_pacifica_57435 0 0.0 0.0 +Bryobacter_aggregatus_60173 0 0.0 0.0 +Desulfovibrio_hydrothermalis_58815 0 0.0 0.0 +Enterobacter_sp_59868 0 0.0 0.0 +Enterobacter_sp_59869 0 0.0 0.0 +Lactobacillus_ruminis_57020 0 0.0 0.0 +Staphylococcus_lentus_59375 0 0.0 0.0 +Rhodothermus_marinus_61685 0 0.0 0.0 +Lyngbya_sp_61185 0 0.0 0.0 +Prevotella_denticola_56507 0 0.0 0.0 +Thermus_caliditerrae_60121 0 0.0 0.0 +Polymorphum_gilvum_62662 0 0.0 0.0 +Actinomyces_sp_57735 0 0.0 0.0 +Megamonas_hypermegale_57114 0 0.0 0.0 +Pseudomonas_putida_43452 0 0.0 0.0 +Rhodopirellula_sallentina_59820 0 0.0 0.0 +Alicyclobacillus_acidocaldarius_61744 0 0.0 0.0 +Paenibacillus_ginsengihumi_58977 0 0.0 0.0 +Thermosynechococcus_sp_60349 0 0.0 0.0 +Borrelia_chilensis_59762 0 0.0 0.0 +Thermocrinis_sp_60075 0 0.0 0.0 +Mesoflavibacter_zeaxanthinifaciens_58313 0 0.0 0.0 +Streptococcus_devriesei_59079 0 0.0 0.0 +Nocardiopsis_ganjiahuensis_59732 0 0.0 0.0 +Pyramidobacter_piscolens_61315 0 0.0 0.0 +Vibrio_metschnikovii_62094 0 0.0 0.0 +Jeotgalibacillus_alimentarius_60242 0 0.0 0.0 +Desulfovibrio_salexigens_61726 0 0.0 0.0 +Lactobacillus_oris_55759 0 0.0 0.0 +Anaerotruncus_sp_59696 0 0.0 0.0 +Enterobacter_cancerogenus_62140 0 0.0 0.0 +Streptococcus_mitis_61106 0 0.0 0.0 +Streptococcus_mitis_61107 0 0.0 0.0 +Streptococcus_mitis_61104 0 0.0 0.0 +Streptococcus_mitis_61105 0 0.0 0.0 +Streptococcus_mitis_61108 0 0.0 0.0 +Marine_gamma_61063 0 0.0 0.0 +Marine_gamma_61064 0 0.0 0.0 +Marine_gamma_61065 0 0.0 0.0 +Neisseria_sicca_58189 0 0.0 0.0 +Planktothrix_agardhii_56916 0 0.0 0.0 +Gemella_haemolysans_61762 0 0.0 0.0 +Sciscionella_sp_60551 0 0.0 0.0 +Synechococcus_sp_62135 0 0.0 0.0 +Haematobacter_massiliensis_60974 0 0.0 0.0 +Desulfitobacterium_metallireducens_62386 0 0.0 0.0 +Enterococcus_moraviensis_44057 0 0.0 0.0 +Streptococcus_suis_57462 0 0.0 0.0 +Streptomyces_toyocaensis_61807 0 0.0 0.0 +Streptococcus_mutans_56116 0 0.0 0.0 +Marinitoga_piezophila_61528 0 0.0 0.0 +Mitsuokella_jalaludinii_60453 0 0.0 0.0 +Avibacterium_paragallinarum_58029 0 0.0 0.0 +Pseudomonas_stutzeri_60130 0 0.0 0.0 +Actinobacillus_minor_61897 0 0.0 0.0 +Ruminococcus_albus_57246 0 0.0 0.0 +Bacillus_sp_51584 0 0.0 0.0 +Microbacterium_sp_60011 0 0.0 0.0 +Ktedonobacter_racemifer_61625 0 0.0 0.0 +Lachnospira_multipara_59932 0 0.0 0.0 +Haemophilus_parahaemolyticus_60505 0 0.0 0.0 +Budvicia_aquatica_58604 0 0.0 0.0 +Nocardiopsis_kunsanensis_59768 0 0.0 0.0 +Helicobacter_pylori_56782 0 0.0 0.0 +Haemophilus_parainfluenzae_57123 0 0.0 0.0 +Oribacterium_sp_62133 0 0.0 0.0 +Lachnospiraceae_bacterium_56275 0 0.0 0.0 +Helicobacter_pylori_50836 0 0.0 0.0 +Bacillus_sp_59371 0 0.0 0.0 +Bacillus_sp_59370 0 0.0 0.0 +Porphyromonadaceae_bacterium_60795 0 0.0 0.0 +Dickeya_dianthicola_52632 0 0.0 0.0 +Pseudoxanthomonas_sp_53728 0 0.0 0.0 +Mariniradius_saccharolyticus_59741 0 0.0 0.0 +Echinicola_vietnamensis_62517 0 0.0 0.0 +Alkaliflexus_imshenetskii_62529 0 0.0 0.0 +Thiorhodococcus_drewsii_62292 0 0.0 0.0 +Prevotella_saccharolytica_57611 0 0.0 0.0 +Helicobacter_acinonychis_61375 0 0.0 0.0 +Hyalangium_minutum_34848 0 0.0 0.0 +Bifidobacterium_choerinum_46095 0 0.0 0.0 +Marine_actinobacterium_60875 0 0.0 0.0 +Marine_actinobacterium_60874 0 0.0 0.0 +Ruminococcus_bicirculans_59300 0 0.0 0.0 +Agrobacterium_tumefaciens_58451 0 0.0 0.0 +Prochlorothrix_hollandica_61225 0 0.0 0.0 +Aestuariimicrobium_kwangyangense_58678 0 0.0 0.0 +Streptomyces_violaceusniger_62037 0 0.0 0.0 +Heliobacterium_modesticaldum_61650 0 0.0 0.0 +Synechocystis_sp_62533 0 0.0 0.0 +Shewanella_sp_57811 0 0.0 0.0 +Erwinia_oleae_57015 0 0.0 0.0 +Pedobacter_sp_61670 0 0.0 0.0 +Thermus_scotoductus_57562 0 0.0 0.0 +Leptonema_illini_62539 0 0.0 0.0 +Francisella_tularensis_57093 0 0.0 0.0 +Streptococcus_sp_58247 0 0.0 0.0 +Prochlorococcus_marinus_35018 0 0.0 0.0 +Mycobacterium_iranicum_60253 0 0.0 0.0 +Deinococcus_geothermalis_61238 0 0.0 0.0 +Leptotrichia_goodfellowii_57622 0 0.0 0.0 +Staphylococcus_haemolyticus_57278 0 0.0 0.0 +Mycobacterium_tusciae_62179 0 0.0 0.0 +Lactobacillus_jensenii_61925 0 0.0 0.0 +Clostridium_sp_58368 0 0.0 0.0 +Paenisporosarcina_sp_59644 0 0.0 0.0 +Myxococcus_stipitatus_59878 0 0.0 0.0 +Campylobacter_subantarcticus_56601 0 0.0 0.0 +Ensifer_adhaerens_58471 0 0.0 0.0 +Streptomyces_fulvissimus_56755 0 0.0 0.0 +Yersinia_massiliensis_59459 0 0.0 0.0 +Wigglesworthia_glossinidia_61347 0 0.0 0.0 +Wigglesworthia_glossinidia_61348 0 0.0 0.0 +Sagittula_stellata_61391 0 0.0 0.0 +Corynebacterium_durum_58387 0 0.0 0.0 +Corynebacterium_marinum_59608 0 0.0 0.0 +Bacteroides_sartorii_54642 0 0.0 0.0 +Limnohabitans_sp_58578 0 0.0 0.0 +Paenibacillus_sp_59267 0 0.0 0.0 +Microbacterium_sp_35127 0 0.0 0.0 +Thioalkalivibrio_sp_62240 0 0.0 0.0 +Actinoplanes_sp_62030 0 0.0 0.0 +Helicobacter_suis_52542 0 0.0 0.0 +Helicobacter_apodemus_60234 0 0.0 0.0 +Enterovibrio_calviensis_58834 0 0.0 0.0 +Streptococcus_infantis_62471 0 0.0 0.0 +Lachnospira_multipara_55890 0 0.0 0.0 +Cobetia_crustatorum_61788 0 0.0 0.0 +Bdellovibrio_exovorus_59386 0 0.0 0.0 +Propionibacterium_acidifaciens_59002 0 0.0 0.0 +Pseudomonas_fluorescens_57697 0 0.0 0.0 +Alysiella_crassa_58694 0 0.0 0.0 +Thalassobaculum_salexigens_59103 0 0.0 0.0 +Schlesneria_paludicola_59049 0 0.0 0.0 +Bacillus_cereus_56036 0 0.0 0.0 +Silanimonas_lenta_59055 0 0.0 0.0 +Syntrophothermus_lipocalidus_62003 0 0.0 0.0 +Blastomonas_sp_59783 0 0.0 0.0 +Phaeobacter_caeruleus_62702 0 0.0 0.0 +Ruminococcus_torques_62045 0 0.0 0.0 +Dolosigranulum_pigrum_62423 0 0.0 0.0 +Porphyromonas_gingivicanis_54518 0 0.0 0.0 +Solimonas_soli_59060 0 0.0 0.0 +Moraxella_boevrei_58949 0 0.0 0.0 +Spiroplasma_mirum_62329 0 0.0 0.0 +Clostridiales_bacterium_55505 0 0.0 0.0 +Catenuloplanes_japonicus_61280 0 0.0 0.0 +Clostridium_sp_62686 0 0.0 0.0 +Gordonibacter_pamelaeae_62044 0 0.0 0.0 +Pedobacter_sp_60770 0 0.0 0.0 +Alcanivorax_pacificus_61421 0 0.0 0.0 +Erythrobacter_litoralis_61452 0 0.0 0.0 +Lactobacillus_composti_59720 0 0.0 0.0 +Ruminococcus_obeum_61472 0 0.0 0.0 +Brevibacterium_casei_59637 0 0.0 0.0 +Nostoc_sp_61227 0 0.0 0.0 +Thioalkalimicrobium_aerophilum_62196 0 0.0 0.0 +Rubritalea_marina_59030 0 0.0 0.0 +Paenibacillus_graminis_40054 0 0.0 0.0 +Sinorhizobium_fredii_61427 0 0.0 0.0 +Thermonema_rossianum_60077 0 0.0 0.0 +Streptomyces_sp_54086 0 0.0 0.0 +Streptococcus_oralis_58559 0 0.0 0.0 +Amycolicicoccus_subflavus_61527 0 0.0 0.0 +Sphingobium_sp_60803 0 0.0 0.0 +Virgibacillus_alimentarius_62158 0 0.0 0.0 +Anaerococcus_sp_58645 0 0.0 0.0 +Methylobacterium_sp_58584 0 0.0 0.0 +Streptomyces_megasporus_61517 0 0.0 0.0 +Campylobacter_hominis_61331 0 0.0 0.0 +Arthrobacter_sp_59426 0 0.0 0.0 +Anaerococcus_sp_62593 0 0.0 0.0 +Treponema_bryantii_62397 0 0.0 0.0 +Pandoraea_sp_59949 0 0.0 0.0 +Streptomyces_gancidicus_52720 0 0.0 0.0 +Streptococcus_mitis_62363 0 0.0 0.0 +Acinetobacter_johnsonii_58178 0 0.0 0.0 +Gordonia_neofelifaecis_62009 0 0.0 0.0 +Brachybacterium_muris_59787 0 0.0 0.0 +Gemella_sanguinis_57791 0 0.0 0.0 +Bacillus_sp_59493 0 0.0 0.0 +Dysgonomonas_capnocytophagoides_58828 0 0.0 0.0 +Eubacterium_sulci_62452 0 0.0 0.0 +Bifidobacterium_bohemicum_60521 0 0.0 0.0 +Caldicellulosiruptor_owensensis_61959 0 0.0 0.0 +Rahnella_aquatilis_55978 0 0.0 0.0 +Cyclobacteriaceae_bacterium_59970 0 0.0 0.0 +Thermus_sp_60569 0 0.0 0.0 +Lactobacillus_hamsteri_59718 0 0.0 0.0 +Selenomonas_sputigena_45411 0 0.0 0.0 +Arthromitus_sp_53052 0 0.0 0.0 +Bradyrhizobium_japonicum_56075 0 0.0 0.0 +Lactobacillus_salivarius_56672 0 0.0 0.0 +Marinobacter_adhaerens_61031 0 0.0 0.0 +Rhodobacter_sphaeroides_57300 0 0.0 0.0 +Synechococcus_sp_61023 0 0.0 0.0 +Synechococcus_sp_61022 0 0.0 0.0 +Lactobacillus_kunkeei_56675 0 0.0 0.0 +Bordetella_hinzii_52923 0 0.0 0.0 +Sphingomonas_phyllosphaerae_58540 0 0.0 0.0 +Sphingomonas_phyllosphaerae_58541 0 0.0 0.0 +Paenibacillus_assamensis_58974 0 0.0 0.0 +Streptomyces_albus_60962 0 0.0 0.0 +Treponema_socranskii_59148 0 0.0 0.0 +Dyella_japonica_59564 0 0.0 0.0 +Lacinutrix_sp_62643 0 0.0 0.0 +Rheinheimera_baltica_59022 0 0.0 0.0 +Psychrobacter_cryohalolentis_58280 0 0.0 0.0 +Desulfitibacter_alkalitolerans_60049 0 0.0 0.0 +Ornithinibacillus_scapharcae_62640 0 0.0 0.0 +Thiorhodospira_sibirica_62293 0 0.0 0.0 +Helicobacter_pylori_60108 0 0.0 0.0 +Mastigocladopsis_repens_61021 0 0.0 0.0 +Pseudomonas_fluorescens_59596 0 0.0 0.0 +Ehrlichia_chaffeensis_52119 0 0.0 0.0 +Enterovibrio_norvegicus_54866 0 0.0 0.0 +Mycetocola_saprophilus_33637 0 0.0 0.0 +Zhouia_amylolytica_59956 0 0.0 0.0 +Alpha_proteobacterium_59591 0 0.0 0.0 +Marinospirillum_minutulum_58931 0 0.0 0.0 +Enterococcus_phoeniculicola_44056 0 0.0 0.0 +Butyrivibrio_sp_57321 0 0.0 0.0 +Rhodococcus_fascians_57780 0 0.0 0.0 +Lactobacillus_paraplantarum_57193 0 0.0 0.0 +Lachnospiraceae_oral_61854 0 0.0 0.0 +Clostridium_celerecrescens_61145 0 0.0 0.0 +Eubacterium_cellulosolvens_60420 0 0.0 0.0 +Brevibacterium_linens_60939 0 0.0 0.0 +Enterococcus_pallens_44059 0 0.0 0.0 +Mycobacterium_intracellulare_57056 0 0.0 0.0 +Arthrobacter_crystallopoietes_59775 0 0.0 0.0 +Gordonia_sihwensis_59605 0 0.0 0.0 +Flavobacterium_rivuli_44732 0 0.0 0.0 +Sinorhizobium_fredii_59389 0 0.0 0.0 +Cellulophaga_baltica_57166 0 0.0 0.0 +Streptococcus_suis_58284 0 0.0 0.0 +Spirochaeta_cellobiosiphila_59068 0 0.0 0.0 +Leptotrichia_buccalis_61702 0 0.0 0.0 +Actinobacillus_equuli_60988 0 0.0 0.0 +Pectobacterium_wasabiae_54935 0 0.0 0.0 +Bordetella_hinzii_60124 0 0.0 0.0 +Enterococcus_faecalis_56297 0 0.0 0.0 +Chitinilyticum_litopenaei_61734 0 0.0 0.0 +Janthinobacterium_agaricidamnosum_60215 0 0.0 0.0 +Helicobacter_pylori_59270 0 0.0 0.0 +Haematobacter_missouriensis_61343 0 0.0 0.0 +Selenomonas_sp_59164 0 0.0 0.0 +Tatumella_ptyseos_53108 0 0.0 0.0 +Xenorhabdus_bovienii_57960 0 0.0 0.0 +Desulfomicrobium_baculatum_61719 0 0.0 0.0 +Azospirillum_sp_62625 0 0.0 0.0 +Lactobacillus_equi_54659 0 0.0 0.0 +Liberibacter_solanacearum_56654 0 0.0 0.0 +Pseudomonas_sp_59937 0 0.0 0.0 +Devosia_riboflavina_61578 0 0.0 0.0 +Rhodobacteraceae_bacterium_61200 0 0.0 0.0 +Listeria_monocytogenes_56337 0 0.0 0.0 +Oceanicola_sp_60054 0 0.0 0.0 +Nitratireductor_basaltis_61598 0 0.0 0.0 +Vibrio_ponticus_61078 0 0.0 0.0 +Prevotella_nanceiensis_44721 0 0.0 0.0 +Saccharomonospora_sp_59197 0 0.0 0.0 +Methylophilus_methylotrophus_58944 0 0.0 0.0 +Mycobacterium_septicum_60178 0 0.0 0.0 +Stenotrophomonas_sp_61411 0 0.0 0.0 +Arthrobacter_sp_62120 0 0.0 0.0 +Geodermatophilus_obscurus_61728 0 0.0 0.0 +Prevotella_loescheii_57749 0 0.0 0.0 +Corynebacterium_camporealensis_60928 0 0.0 0.0 +Acinetobacter_brisouii_43461 0 0.0 0.0 +Halomonas_zincidurans_60553 0 0.0 0.0 +Marinobacter_hydrocarbonoclasticus_57973 0 0.0 0.0 +Streptococcus_gordonii_61575 0 0.0 0.0 +Actinotalea_fermentans_62353 0 0.0 0.0 +Burkholderia_sp_60855 0 0.0 0.0 +Lactobacillus_suebicus_58434 0 0.0 0.0 +Lactobacillus_namurensis_60030 0 0.0 0.0 +Dyadobacter_alkalitolerans_58825 0 0.0 0.0 +Methylotenera_sp_60780 0 0.0 0.0 +Atopococcus_tabaci_58714 0 0.0 0.0 +Rahnella_aquatilis_54961 0 0.0 0.0 +Schleiferia_thermophila_60597 0 0.0 0.0 +Mobiluncus_mulieris_55708 0 0.0 0.0 +Sulfuricella_denitrificans_59311 0 0.0 0.0 +Azotobacter_vinelandii_42916 0 0.0 0.0 +Intrasporangiaceae_bacterium_60274 0 0.0 0.0 +Bacillaceae_bacterium_53539 0 0.0 0.0 +Chloroflexus_aggregans_61261 0 0.0 0.0 +Nafulsella_turpanensis_59144 0 0.0 0.0 +Actinobacillus_suis_52501 0 0.0 0.0 +Pedobacter_sp_59865 0 0.0 0.0 +Blastomonas_sp_60489 0 0.0 0.0 +Thioalkalivibrio_nitratireducens_59801 0 0.0 0.0 +Propionimicrobium_lymphophilum_56532 0 0.0 0.0 +Vibrio_caribbenthicus_62317 0 0.0 0.0 +Azohydromonas_australica_58717 0 0.0 0.0 +Propionibacterium_thoenii_59004 0 0.0 0.0 +Oceanibaculum_indicum_59486 0 0.0 0.0 +Ensifer_sp_60223 0 0.0 0.0 +Borrelia_coriaceae_47013 0 0.0 0.0 +Pseudobutyrivibrio_ruminis_60623 0 0.0 0.0 +Brenneria_sp_61928 0 0.0 0.0 +Aeromonas_sp_61806 0 0.0 0.0 +Gamma_proteobacterium_61209 0 0.0 0.0 +Bacillus_oceanisediminis_53318 0 0.0 0.0 +Gordonia_otitidis_58595 0 0.0 0.0 +Thiobacillus_prosperus_60923 0 0.0 0.0 +Prevotella_veroralis_57831 0 0.0 0.0 +Anaerococcus_senegalensis_58365 0 0.0 0.0 +Cloacamonas_acidaminovorans_61555 0 0.0 0.0 +Cecembia_lonarensis_59611 0 0.0 0.0 +Pseudomonas_knackmussii_60028 0 0.0 0.0 +Campylobacter_upsaliensis_58030 0 0.0 0.0 +Mycobacterium_phlei_59254 0 0.0 0.0 +Pontibacillus_marinus_44725 0 0.0 0.0 +Amorphus_coralli_58695 0 0.0 0.0 +Thermodesulfobacterium_hydrogeniphilum_60926 0 0.0 0.0 +Dyadobacter_beijingensis_58826 0 0.0 0.0 +Cellulophaga_lytica_55158 0 0.0 0.0 +Anaerostipes_hadrus_55206 0 0.0 0.0 +Neorhizobium_galegae_58347 0 0.0 0.0 +Neorhizobium_galegae_58346 0 0.0 0.0 +Enterobacter_pulveris_58832 0 0.0 0.0 +Enterobacter_asburiae_57214 0 0.0 0.0 +Sphingobium_ummariense_60194 0 0.0 0.0 +Edwardsiella_tarda_56627 0 0.0 0.0 +Oribacterium_sinus_61880 0 0.0 0.0 +Buchnera_aphidicola_51113 0 0.0 0.0 +Pantoea_agglomerans_56951 0 0.0 0.0 +Gillisia_limnaea_62365 0 0.0 0.0 +Streptococcus_iniae_50467 0 0.0 0.0 +Corynebacterium_genitalium_61884 0 0.0 0.0 +Arthrobacter_phenanthrenivorans_61333 0 0.0 0.0 +Lactobacillus_antri_61711 0 0.0 0.0 +Acidovorax_sp_61676 0 0.0 0.0 +Lautropia_mirabilis_62440 0 0.0 0.0 +Gordonia_amicalis_57031 0 0.0 0.0 +Porphyromonas_canoris_57840 0 0.0 0.0 +Sulfobacillus_thermosulfidooxidans_56482 0 0.0 0.0 +Bifidobacterium_sp_59902 0 0.0 0.0 +Zymobacter_palmae_59135 0 0.0 0.0 +Helicobacter_winghamensis_61800 0 0.0 0.0 +Vibrio_tasmaniensis_57991 0 0.0 0.0 +Clostridium_sp_61799 0 0.0 0.0 +Vibrio_genomosp_55874 0 0.0 0.0 +Streptomyces_xanthophaeus_52409 0 0.0 0.0 +Maritalea_myrionectae_58932 0 0.0 0.0 +Gemella_bergeriae_60107 0 0.0 0.0 +Bacillus_amyloliquefaciens_55807 0 0.0 0.0 +Sphaerochaeta_pleomorpha_60906 0 0.0 0.0 +Mucilaginibacter_paludis_62186 0 0.0 0.0 +Streptomyces_fulvoviolaceus_61123 0 0.0 0.0 +Jonquetella_anthropi_54715 0 0.0 0.0 +Bacteroidetes_oral_61853 0 0.0 0.0 +Desulfovibrio_sp_60881 0 0.0 0.0 +Streptacidiphilus_albus_45039 0 0.0 0.0 +Spirosoma_linguale_61663 0 0.0 0.0 +Pseudomonas_taiwanensis_52481 0 0.0 0.0 +Treponema_putidum_61019 0 0.0 0.0 +Caldimonas_manganoxidans_59824 0 0.0 0.0 +Acaryochloris_marina_61265 0 0.0 0.0 +Donghicola_xiamenensis_58823 0 0.0 0.0 +Parvibaculum_lavamentivorans_61458 0 0.0 0.0 +Amoebophilus_asiaticus_61548 0 0.0 0.0 +Bordetella_avium_34447 0 0.0 0.0 +Burkholderia_sp_62262 0 0.0 0.0 +Cryobacterium_roopkundense_58305 0 0.0 0.0 +Vibrio_jasicida_57763 0 0.0 0.0 +Neochlamydia_sp_57445 0 0.0 0.0 +Halomonas_sp_60773 0 0.0 0.0 +Proteus_penneri_61597 0 0.0 0.0 +Vibrio_sinaloensis_57377 0 0.0 0.0 +Streptococcus_mitis_62309 0 0.0 0.0 +Sphaerotilus_natans_59955 0 0.0 0.0 +Thiomicrospira_sp_59140 0 0.0 0.0 +Psychroserpens_sp_60702 0 0.0 0.0 +Rhodococcus_fascians_60541 0 0.0 0.0 +Rhodococcus_fascians_60540 0 0.0 0.0 +Mycobacterium_sp_54926 0 0.0 0.0 +Scytonema_tolypothrichoides_59667 0 0.0 0.0 +Thermodesulfobium_narugense_62235 0 0.0 0.0 +Arthrospira_maxima_53544 0 0.0 0.0 +Paracoccus_sp_61485 0 0.0 0.0 +Clostridium_sp_60041 0 0.0 0.0 +Dickeya_dadantii_61859 0 0.0 0.0 +Spiroplasma_syrphidicola_59874 0 0.0 0.0 +Lactobacillus_paracasei_55666 0 0.0 0.0 +Chelativorans_sp_61083 0 0.0 0.0 +Arthrobacter_sp_61644 0 0.0 0.0 +Galbibacter_sp_61795 0 0.0 0.0 +Acetobacterium_woodii_62550 0 0.0 0.0 +Planococcus_halocryophilus_58321 0 0.0 0.0 +Mycobacterium_neoaurum_55977 0 0.0 0.0 +Alicyclobacillus_acidoterrestris_60236 0 0.0 0.0 +Arthrobacter_sanguinis_58711 0 0.0 0.0 +Pseudomonas_veronii_59992 0 0.0 0.0 +Helicobacter_pylori_58464 0 0.0 0.0 +Lachnospiraceae_bacterium_60407 0 0.0 0.0 +Oribacterium_sp_60432 0 0.0 0.0 +Lachnospiraceae_bacterium_60405 0 0.0 0.0 +Lachnospiraceae_bacterium_60409 0 0.0 0.0 +Lachnospiraceae_bacterium_60408 0 0.0 0.0 +Pseudomonas_putida_61165 0 0.0 0.0 +Kozakia_baliensis_60826 0 0.0 0.0 +Streptomyces_xylophagus_61122 0 0.0 0.0 +Bacillus_amyloliquefaciens_53752 0 0.0 0.0 +Thermus_sp_60893 0 0.0 0.0 +Bifidobacterium_ruminantium_50236 0 0.0 0.0 +Streptococcus_mitis_58288 0 0.0 0.0 +Stigmatella_aurantiaca_61366 0 0.0 0.0 +Roseobacter_sp_61312 0 0.0 0.0 +Dactylococcopsis_salina_60036 0 0.0 0.0 +Leifsonia_sp_56691 0 0.0 0.0 +Algicola_sagamiensis_58682 0 0.0 0.0 +Vibrio_crassostreae_57504 0 0.0 0.0 +Kingella_sp_60806 0 0.0 0.0 +Bacteroides_graminisolvens_48736 0 0.0 0.0 +Thermosynechococcus_elongatus_60983 0 0.0 0.0 +Eubacterium_infirmum_62424 0 0.0 0.0 +Alkalilimnicola_ehrlichii_60960 0 0.0 0.0 +Halanaerobium_saccharolyticum_59986 0 0.0 0.0 +Listeriaceae_bacterium_59830 0 0.0 0.0 +Listeriaceae_bacterium_59831 0 0.0 0.0 +Listeriaceae_bacterium_59832 0 0.0 0.0 +Listeriaceae_bacterium_59833 0 0.0 0.0 +Listeriaceae_bacterium_59834 0 0.0 0.0 +Pleurocapsa_sp_59380 0 0.0 0.0 +Blastopirellula_marina_61190 0 0.0 0.0 +Aliagarivorans_taiwanensis_58688 0 0.0 0.0 +Citreicella_sp_61660 0 0.0 0.0 +Helicobacter_pylori_60128 0 0.0 0.0 +Salinispora_pacifica_57618 0 0.0 0.0 +Aquaspirillum_serpens_58701 0 0.0 0.0 +Alcanivorax_sp_53403 0 0.0 0.0 +Pseudoalteromonas_luteoviolacea_59860 0 0.0 0.0 +Francisella_guangzhouensis_61913 0 0.0 0.0 +Hyphomicrobium_denitrificans_61867 0 0.0 0.0 +Shewanella_baltica_57467 0 0.0 0.0 +Bacteroides_fluxus_62283 0 0.0 0.0 +Verrucomicrobia_bacterium_61607 0 0.0 0.0 +Staphylococcus_hyicus_59943 0 0.0 0.0 +Clostridium_pasteurianum_62360 0 0.0 0.0 +Corynebacterium_pseudotuberculosis_55943 0 0.0 0.0 +Thalassospira_profundimaris_59367 0 0.0 0.0 +Nitrospina_gracilis_59838 0 0.0 0.0 +Staphylococcus_massiliensis_50831 0 0.0 0.0 +Methylotenera_versatilis_44785 0 0.0 0.0 +Kitasatospora_sp_56944 0 0.0 0.0 +Ruminococcus_flavefaciens_60308 0 0.0 0.0 +Oceanicola_batsensis_61069 0 0.0 0.0 +Eubacterium_cylindroides_56237 0 0.0 0.0 +Rhodobacteraceae_bacterium_59335 0 0.0 0.0 +Pseudoalteromonas_atlantica_61295 0 0.0 0.0 +Cronobacter_universalis_58491 0 0.0 0.0 +Phascolarctobacterium_succinatutens_59819 0 0.0 0.0 +Halomonas_sp_59369 0 0.0 0.0 +Corynebacterium_freiburgense_58772 0 0.0 0.0 +Faecalibacterium_prausnitzii_57453 0 0.0 0.0 +Niastella_koreensis_62162 0 0.0 0.0 +Microbacterium_sp_59261 0 0.0 0.0 +Alistipes_sp_60764 0 0.0 0.0 +Nocardia_cyriacigeorgica_60233 0 0.0 0.0 +Gemella_morbillorum_61817 0 0.0 0.0 +Roseomonas_aerilata_59027 0 0.0 0.0 +Polaribacter_sp_61182 0 0.0 0.0 +Anaerovibrio_lipolyticus_62322 0 0.0 0.0 +Marinobacter_daepoensis_58924 0 0.0 0.0 +Streptomyces_sp_59814 0 0.0 0.0 +Gordonia_rhizosphera_58596 0 0.0 0.0 +Brevibacillus_brevis_57389 0 0.0 0.0 +Streptosporangium_amethystogenes_60986 0 0.0 0.0 +Betaproteobacteria_bacterium_60392 0 0.0 0.0 +Haemophilus_haemolyticus_58562 0 0.0 0.0 +Halomonas_xinjiangensis_59322 0 0.0 0.0 +Streptomyces_yerevanensis_62062 0 0.0 0.0 +Anoxybacillus_kamchatkensis_55142 0 0.0 0.0 +Flavobacteriaceae_bacterium_59372 0 0.0 0.0 +Rhodomicrobium_udaipurense_62339 0 0.0 0.0 +Bacillus_ginsengihumi_53086 0 0.0 0.0 +Cupriavidus_necator_60047 0 0.0 0.0 +Thalassotalea_sp_60827 0 0.0 0.0 +Gordonia_soli_59606 0 0.0 0.0 +Runella_zeae_59035 0 0.0 0.0 +Rhizobium_sp_59183 0 0.0 0.0 +Exiguobacterium_sp_56391 0 0.0 0.0 +Marinomonas_sp_59488 0 0.0 0.0 +Methylomonas_sp_58496 0 0.0 0.0 +Salsuginibacillus_kocurii_59046 0 0.0 0.0 +Halomonas_sp_60691 0 0.0 0.0 +Eremococcus_coleocola_54297 0 0.0 0.0 +Plautia_stali_57621 0 0.0 0.0 +Luteimonas_mephitis_58920 0 0.0 0.0 +Sulfurospirillum_arcachonense_59097 0 0.0 0.0 +Pseudoxanthomonas_suwonensis_57726 0 0.0 0.0 +Serratia_sp_35039 0 0.0 0.0 +Streptomyces_lavendulae_56726 0 0.0 0.0 +Catenovulum_agarivorans_60115 0 0.0 0.0 +Streptomyces_durhamensis_62112 0 0.0 0.0 +Leclercia_adecarboxylata_62497 0 0.0 0.0 +Lactobacillus_helveticus_55908 0 0.0 0.0 +Xenorhabdus_sp_60502 0 0.0 0.0 +Aeromonas_allosaccharophila_58097 0 0.0 0.0 +Bacteroides_intestinalis_61596 0 0.0 0.0 +Arthrobacter_globiformis_58504 0 0.0 0.0 +Xenorhabdus_szentirmaii_60501 0 0.0 0.0 +Actinomyces_sp_62277 0 0.0 0.0 +Comamonas_granuli_59601 0 0.0 0.0 +Streptococcus_sp_60488 0 0.0 0.0 +Clostridium_sartagoforme_59444 0 0.0 0.0 +Thermotoga_neapolitana_53289 0 0.0 0.0 +Streptococcus_thermophilus_54772 0 0.0 0.0 +Paenibacillus_terrigena_58983 0 0.0 0.0 +Xylella_fastidiosa_57753 0 0.0 0.0 +Bizionia_argentinensis_58439 0 0.0 0.0 +Geobacter_metallireducens_47482 0 0.0 0.0 +Bacillus_okhensis_61274 0 0.0 0.0 +Mycobacterium_sp_43088 0 0.0 0.0 +Helicobacter_pylori_59985 0 0.0 0.0 +Bacillus_tequilensis_60495 0 0.0 0.0 +Alistipes_sp_60166 0 0.0 0.0 +Pseudomonas_fuscovaginae_56758 0 0.0 0.0 +Anaeromyxobacter_dehalogenans_57037 0 0.0 0.0 +Methylophilus_sp_58619 0 0.0 0.0 +Capnocytophaga_cynodegmi_58146 0 0.0 0.0 +Thermus_sp_58599 0 0.0 0.0 +Paenibacillus_ehimensis_60544 0 0.0 0.0 +Sphingomonas_elodea_58518 0 0.0 0.0 +Halomonas_sp_62696 0 0.0 0.0 +Actinomyces_turicensis_62420 0 0.0 0.0 +Chryseobacterium_vrystaatense_61169 0 0.0 0.0 +Bifidobacterium_dentium_55719 0 0.0 0.0 +Desulfovibrio_frigidus_58814 0 0.0 0.0 +Bifidobacterium_breve_57133 0 0.0 0.0 +Acinetobacter_pittii_59554 0 0.0 0.0 +Peptostreptococcaceae_bacterium_58651 0 0.0 0.0 +Gemmatimonadetes_bacterium_62346 0 0.0 0.0 +Treponema_denticola_33246 0 0.0 0.0 +Thermobacillus_composti_62194 0 0.0 0.0 +Enterococcus_durans_52177 0 0.0 0.0 +Rhodoferax_ferrireducens_61283 0 0.0 0.0 +Staphylococcus_caprae_50972 0 0.0 0.0 +Gordonia_sputi_58528 0 0.0 0.0 +Fervidicella_metallireducens_60382 0 0.0 0.0 +Corynebacterium_resistens_62057 0 0.0 0.0 +Citrobacter_sedlakii_59572 0 0.0 0.0 +Silicibacter_sp_62005 0 0.0 0.0 +Pasteurella_sp_60369 0 0.0 0.0 +Streptococcus_hongkongensis_54356 0 0.0 0.0 +Sneathiella_glossodoripedis_59725 0 0.0 0.0 +Nevskia_ramosa_58955 0 0.0 0.0 +Butyrivibrio_fibrisolvens_62048 0 0.0 0.0 +Propionibacterium_freudenreichii_62075 0 0.0 0.0 +Erwinia_billingiae_61974 0 0.0 0.0 +Borrelia_parkeri_57667 0 0.0 0.0 +Sulfurimonas_autotrophica_61821 0 0.0 0.0 +Sphaerochaeta_globosa_60905 0 0.0 0.0 +Laceyella_sacchari_60174 0 0.0 0.0 +Dokdonia_donghaensis_34594 0 0.0 0.0 +Streptomyces_sp_60877 0 0.0 0.0 +Vibrio_shiloi_57458 0 0.0 0.0 +Streptomyces_anulatus_34866 0 0.0 0.0 +Woodsholea_maritima_59130 0 0.0 0.0 +Xenorhabdus_cabanillasii_60500 0 0.0 0.0 +Tateyamaria_sp_60902 0 0.0 0.0 +Brevundimonas_diminuta_58385 0 0.0 0.0 +Labrenzia_alexandrii_61056 0 0.0 0.0 +Blautia_producta_56315 0 0.0 0.0 +Rubidibacter_lacunae_61866 0 0.0 0.0 +Phaeobacter_arcticus_62703 0 0.0 0.0 +Flavihumibacter_solisilvae_60214 0 0.0 0.0 +Clostridium_acetobutylicum_56492 0 0.0 0.0 +Conchiformibius_steedae_58767 0 0.0 0.0 +Sporichthya_polymorpha_58443 0 0.0 0.0 +Pedobacter_heparinus_61628 0 0.0 0.0 +Sandaracinus_amylolyticus_62527 0 0.0 0.0 +Lamprocystis_purpurea_62288 0 0.0 0.0 +Streptomyces_katrae_62115 0 0.0 0.0 +Acidobacteriaceae_bacterium_60265 0 0.0 0.0 +Streptomyces_sp_60657 0 0.0 0.0 +Rhizobium_leguminosarum_62255 0 0.0 0.0 +Streptomyces_sp_60655 0 0.0 0.0 +Streptomyces_sp_60654 0 0.0 0.0 +Streptomyces_sp_60653 0 0.0 0.0 +Streptomyces_sp_60652 0 0.0 0.0 +Streptomyces_sp_60651 0 0.0 0.0 +Streptomyces_sp_60650 0 0.0 0.0 +Actinomycetospora_chiangmaiensis_58673 0 0.0 0.0 +Streptomyces_sp_60658 0 0.0 0.0 +Caulobacter_sp_60756 0 0.0 0.0 +Azospirillum_sp_60255 0 0.0 0.0 +Leptospirillum_ferriphilum_60950 0 0.0 0.0 +Tolumonas_sp_59934 0 0.0 0.0 +Holdemania_filiformis_61753 0 0.0 0.0 +Sphingomonas_sp_60282 0 0.0 0.0 +Stomatobaculum_longum_62318 0 0.0 0.0 +Leptospira_kmetyi_58448 0 0.0 0.0 +Sphingobium_japonicum_57007 0 0.0 0.0 +Krokinobacter_sp_62644 0 0.0 0.0 +Streptomyces_flaveolus_58007 0 0.0 0.0 +Streptomyces_lavenduligriseus_57501 0 0.0 0.0 +TG3_bacterium_60078 0 0.0 0.0 +Streptococcus_suis_57986 0 0.0 0.0 +Xanthobacteraceae_bacterium_48793 0 0.0 0.0 +Flavobacterium_psychrophilum_53657 0 0.0 0.0 +Chryseobacterium_hispalense_61639 0 0.0 0.0 +Coxiella_endosymbiont_61256 0 0.0 0.0 +Paenibacillus_alvei_57786 0 0.0 0.0 +Haemophilus_sp_62278 0 0.0 0.0 +Actinomyces_sp_62027 0 0.0 0.0 +Desulfovibrio_vulgaris_56737 0 0.0 0.0 +Rhodococcus_erythropolis_58072 0 0.0 0.0 +Helicobacter_pylori_61320 0 0.0 0.0 +Clostridium_sp_35048 0 0.0 0.0 +Marinobacterium_stanieri_58420 0 0.0 0.0 +OP8_bacterium_45114 0 0.0 0.0 +Comamonadaceae_bacterium_60022 0 0.0 0.0 +Arthrospira_platensis_62151 0 0.0 0.0 +Indibacter_alkaliphilus_59397 0 0.0 0.0 +Alpha_proteobacterium_59626 0 0.0 0.0 +Desulfovibrio_sp_62601 0 0.0 0.0 +Ethanoligenens_harbinense_62058 0 0.0 0.0 +Helicobacter_pylori_60324 0 0.0 0.0 +Helicobacter_pylori_60499 0 0.0 0.0 +Bacillus_sp_61467 0 0.0 0.0 +Xanthomonas_campestris_57830 0 0.0 0.0 +Streptomyces_sp_48298 0 0.0 0.0 +Chryseobacterium_formosense_61045 0 0.0 0.0 +Capnocytophaga_granulosa_57613 0 0.0 0.0 +Bacillus_sp_59188 0 0.0 0.0 +Neisseria_sp_59163 0 0.0 0.0 +Butyrivibrio_sp_59897 0 0.0 0.0 +Comamonas_composti_58765 0 0.0 0.0 +Marinobacter_algicola_61526 0 0.0 0.0 +Burkholderia_sp_62382 0 0.0 0.0 +Butyrivibrio_sp_59899 0 0.0 0.0 +Butyrivibrio_sp_59898 0 0.0 0.0 +Aminiphilus_circumscriptus_60043 0 0.0 0.0 +Thermodesulfobacterium_commune_34614 0 0.0 0.0 +Ruthia_magnifica_50810 0 0.0 0.0 +Sediminibacter_sp_60340 0 0.0 0.0 +Singularimonas_variicoloris_59057 0 0.0 0.0 +Mycobacterium_genavense_60427 0 0.0 0.0 +Roseburia_hominis_61877 0 0.0 0.0 +Acinetobacter_sp_58244 0 0.0 0.0 +Terracoccus_sp_59342 0 0.0 0.0 +Bacillus_massiliosenegalensis_58377 0 0.0 0.0 +Synechococcus_sp_61932 0 0.0 0.0 +Alishewanella_agri_59418 0 0.0 0.0 +SAR86_cluster_59491 0 0.0 0.0 +Desulfovibrio_cf_60042 0 0.0 0.0 +Butyrivibrio_fibrisolvens_57284 0 0.0 0.0 +Nocardioides_sp_62574 0 0.0 0.0 +Gemmatimonas_aurantiaca_61367 0 0.0 0.0 +Methylomicrobium_agile_54828 0 0.0 0.0 +Hydrogenophaga_intermedia_48029 0 0.0 0.0 +Actinomyces_timonensis_61695 0 0.0 0.0 +Clostridium_algidicarnis_61360 0 0.0 0.0 +Streptomyces_flavidovirens_59093 0 0.0 0.0 +Helicobacter_pylori_59238 0 0.0 0.0 +Helicobacter_pylori_59239 0 0.0 0.0 +Staphylococcus_delphini_59202 0 0.0 0.0 +Varibaculum_cambriense_60384 0 0.0 0.0 +Scalindua_brodae_61046 0 0.0 0.0 +Plesiomonas_shigelloides_57360 0 0.0 0.0 +Facklamia_languida_62426 0 0.0 0.0 +Thermosipho_melanesiensis_61399 0 0.0 0.0 +Caulobacter_sp_60560 0 0.0 0.0 +Calothrix_sp_60157 0 0.0 0.0 +Pseudoalteromonas_citrea_56915 0 0.0 0.0 +Anoxybacillus_flavithermus_59853 0 0.0 0.0 +Gordonia_effusa_58505 0 0.0 0.0 +Bartonella_rochalimae_62125 0 0.0 0.0 +Enterococcus_faecium_56710 0 0.0 0.0 +Arthrobacter_sp_55266 0 0.0 0.0 +Hymenobacter_norwichensis_58887 0 0.0 0.0 +Algoriphagus_sp_61393 0 0.0 0.0 +Rhodanobacter_thiooxydans_59310 0 0.0 0.0 +Porphyromonas_sp_56541 0 0.0 0.0 +Paenibacillus_sp_38961 0 0.0 0.0 +Cyanothece_sp_61431 0 0.0 0.0 +Gluconobacter_frateurii_60065 0 0.0 0.0 +Desulfotomaculum_gibsoniae_62300 0 0.0 0.0 +Aminobacter_sp_62562 0 0.0 0.0 +Paenibacillus_sp_60685 0 0.0 0.0 +Photobacterium_leiognathi_57430 0 0.0 0.0 +Helicobacter_bilis_58212 0 0.0 0.0 +Streptomyces_lividans_53372 0 0.0 0.0 +Flavobacterium_frigidarium_58846 0 0.0 0.0 +Desulfovibrio_vulgaris_62432 0 0.0 0.0 +Geobacillus_subterraneus_56504 0 0.0 0.0 +Porphyromonas_uenonis_49360 0 0.0 0.0 +Azospirillum_halopraeferens_58719 0 0.0 0.0 +Chitinibacter_tainanensis_58747 0 0.0 0.0 +Bifidobacterium_sp_60347 0 0.0 0.0 +Bifidobacterium_sp_60346 0 0.0 0.0 +Kingella_oralis_61952 0 0.0 0.0 +Streptococcus_infantis_62693 0 0.0 0.0 +Cronobacter_sakazakii_57088 0 0.0 0.0 +Photobacterium_sp_58466 0 0.0 0.0 +Kitasatospora_papulosa_54124 0 0.0 0.0 +Baumannia_cicadellinicola_60958 0 0.0 0.0 +Lactobacillus_fermentum_54035 0 0.0 0.0 +Richelia_intracellularis_59318 0 0.0 0.0 +Acinetobacter_guillouiae_57629 0 0.0 0.0 +Microbispora_sp_61222 0 0.0 0.0 +Parvimonas_sp_62298 0 0.0 0.0 +Clostridium_drakei_61273 0 0.0 0.0 +Veillonella_atypica_58169 0 0.0 0.0 +Thermotoga_elfii_52778 0 0.0 0.0 +Ralstonia_solanacearum_57703 0 0.0 0.0 +Clostridium_clostridioforme_59912 0 0.0 0.0 +Massilia_niastensis_58934 0 0.0 0.0 +Yersinia_intermedia_53405 0 0.0 0.0 +Helicobacter_heilmannii_59547 0 0.0 0.0 +Thalassobacillus_devorans_60376 0 0.0 0.0 +Gluconacetobacter_diazotrophicus_52323 0 0.0 0.0 +Clostridium_thermocellum_51469 0 0.0 0.0 +Novosphingobium_sp_60008 0 0.0 0.0 +Spirosoma_panaciterrae_59070 0 0.0 0.0 +Pseudomonas_fluorescens_61153 0 0.0 0.0 +Pseudomonas_fluorescens_61152 0 0.0 0.0 +Pseudomonas_fluorescens_61151 0 0.0 0.0 +Pseudomonas_fluorescens_61150 0 0.0 0.0 +Pseudomonas_fluorescens_61155 0 0.0 0.0 +Pseudomonas_fluorescens_61154 0 0.0 0.0 +Robiginitomaculum_antarcticum_59026 0 0.0 0.0 +Bifidobacterium_scardovii_44511 0 0.0 0.0 +Nitritalea_halalkaliphila_59400 0 0.0 0.0 +Aggregatibacter_sp_60097 0 0.0 0.0 +Ahrensia_sp_62225 0 0.0 0.0 +Anaeromusa_acidaminophila_56214 0 0.0 0.0 +Campylobacter_showae_58485 0 0.0 0.0 +Mangrovimonas_yunxiaonensis_59425 0 0.0 0.0 +Alkalibacillus_haloalkaliphilus_59413 0 0.0 0.0 +Massilia_timonae_62428 0 0.0 0.0 +Enterococcus_villorum_44061 0 0.0 0.0 +Paenibacillus_sp_59754 0 0.0 0.0 +Haemophilus_parahaemolyticus_58564 0 0.0 0.0 +Prochlorococcus_sp_60726 0 0.0 0.0 +Bradyrhizobium_oligotrophicum_59759 0 0.0 0.0 +Haemophilus_sputorum_53575 0 0.0 0.0 +Helicobacter_pylori_62664 0 0.0 0.0 +Thermotoga_sp_57715 0 0.0 0.0 +Eubacterium_cellulosolvens_61964 0 0.0 0.0 +Prevotella_albensis_47375 0 0.0 0.0 +Enterobacter_sp_58568 0 0.0 0.0 +Geobacillus_stearothermophilus_62588 0 0.0 0.0 +Listeria_monocytogenes_56580 0 0.0 0.0 +Lysobacter_capsici_60545 0 0.0 0.0 +Knoellia_aerolata_60318 0 0.0 0.0 +Treponema_lecithinolyticum_60106 0 0.0 0.0 +Halomonas_smyrnensis_61286 0 0.0 0.0 +Shewanella_putrefaciens_56759 0 0.0 0.0 +Desulfosporosinus_youngiae_62308 0 0.0 0.0 +Acinetobacter_bereziniae_56370 0 0.0 0.0 +Fusobacterium_nucleatum_60396 0 0.0 0.0 +Asaia_platycodi_59713 0 0.0 0.0 +Pontibacter_sp_59206 0 0.0 0.0 +Brevibacillus_panacihumi_60395 0 0.0 0.0 +Staphylococcus_sp_62352 0 0.0 0.0 +Capnocytophaga_sp_58386 0 0.0 0.0 +Rathayibacter_toxicus_59021 0 0.0 0.0 +Streptococcus_mitis_60170 0 0.0 0.0 +Streptococcus_mitis_60171 0 0.0 0.0 +Streptococcus_mitis_60172 0 0.0 0.0 +OP9_bacterium_59812 0 0.0 0.0 +OP9_bacterium_59813 0 0.0 0.0 +Actinomyces_viscosus_57672 0 0.0 0.0 +Streptococcus_mitis_59740 0 0.0 0.0 +Paenibacillus_durus_61521 0 0.0 0.0 +Cupriavidus_sp_59563 0 0.0 0.0 +Saccharomonospora_glauca_62535 0 0.0 0.0 +Chloroflexus_aurantiacus_46905 0 0.0 0.0 +Mycobacterium_sp_60250 0 0.0 0.0 +Mycobacterium_sp_60251 0 0.0 0.0 +Streptococcus_oralis_60034 0 0.0 0.0 +Bacillus_sonorensis_59871 0 0.0 0.0 +Streptococcus_oralis_60033 0 0.0 0.0 +Duganella_zoogloeoides_59810 0 0.0 0.0 +Staphylococcus_epidermidis_61718 0 0.0 0.0 +Lysinibacillus_sp_60686 0 0.0 0.0 +Staphylococcus_simulans_55283 0 0.0 0.0 +Psychrilyobacter_atlanticus_59015 0 0.0 0.0 +Pusillimonas_noertemannii_59652 0 0.0 0.0 +Streptomyces_cattleya_58312 0 0.0 0.0 +Brachyspira_hyodysenteriae_61824 0 0.0 0.0 +Pseudomonas_sp_60137 0 0.0 0.0 +Magnetococcus_marinus_60886 0 0.0 0.0 +Pseudomonas_sp_59857 0 0.0 0.0 +Gordonia_terrae_56791 0 0.0 0.0 +Erwinia_toletana_59872 0 0.0 0.0 +Staphylococcus_aureus_37016 0 0.0 0.0 +Acetobacter_tropicalis_58411 0 0.0 0.0 +SAR406_cluster_58441 0 0.0 0.0 +Arenimonas_oryziterrae_44750 0 0.0 0.0 +Aromatoleum_aromaticum_62271 0 0.0 0.0 +Bradyrhizobium_japonicum_58397 0 0.0 0.0 +Helicobacter_pylori_52167 0 0.0 0.0 +Actinomyces_europaeus_62419 0 0.0 0.0 +Bradyrhizobium_japonicum_58398 0 0.0 0.0 +Bradyrhizobium_japonicum_58399 0 0.0 0.0 +Mycobacterium_vulneris_61768 0 0.0 0.0 +Desulfuromonas_sp_59656 0 0.0 0.0 +Pseudorhodobacter_ferrugineus_59014 0 0.0 0.0 +Sulfuricurvum_sp_35035 0 0.0 0.0 +Crocinitomix_catalasitica_60419 0 0.0 0.0 +Rhodospirillum_centenum_61487 0 0.0 0.0 +Acinetobacter_haemolyticus_57250 0 0.0 0.0 +Bifidobacterium_biavatii_60523 0 0.0 0.0 +Neisseria_wadsworthii_58357 0 0.0 0.0 +Nonlabens_ulvanivorans_57631 0 0.0 0.0 +Bacteroides_salyersiae_54873 0 0.0 0.0 +Flavobacterium_sp_59442 0 0.0 0.0 +Enterococcus_avium_44557 0 0.0 0.0 +Delta_proteobacterium_62416 0 0.0 0.0 +Koribacter_versatilis_60995 0 0.0 0.0 +Clostridium_sp_60228 0 0.0 0.0 +Peptostreptococcus_sp_59590 0 0.0 0.0 +Nocardiopsis_sp_59195 0 0.0 0.0 +Catellicoccus_marimammalium_59672 0 0.0 0.0 +Sphingopyxis_sp_60768 0 0.0 0.0 +Leptotrichia_trevisanii_58913 0 0.0 0.0 +Bartonella_melophagi_58548 0 0.0 0.0 +Streptomyces_atratus_60963 0 0.0 0.0 +Limnobacter_sp_61409 0 0.0 0.0 +Desulfonatronum_thiodismutans_60919 0 0.0 0.0 +Leuconostoc_gasicomitatum_52396 0 0.0 0.0 +Chromohalobacter_israelensis_55877 0 0.0 0.0 +Clostridium_methoxybenzovorans_52877 0 0.0 0.0 +Corynebacterium_vitaeruminis_54778 0 0.0 0.0 +Bacillus_amyloliquefaciens_57149 0 0.0 0.0 +Neisseria_flavescens_61924 0 0.0 0.0 +Vibrio_nigripulchritudo_57710 0 0.0 0.0 +Tolypothrix_campylonemoides_59764 0 0.0 0.0 +Streptococcus_anginosus_58303 0 0.0 0.0 +Neorickettsia_risticii_61503 0 0.0 0.0 +Gemmata_sp_59505 0 0.0 0.0 +Bhargavaea_cecembensis_59676 0 0.0 0.0 +Exiguobacterium_aurantiacum_55523 0 0.0 0.0 +Blautia_schinkii_60448 0 0.0 0.0 +Allokutzneria_albata_61005 0 0.0 0.0 +Pseudomonas_thermotolerans_54437 0 0.0 0.0 +Marinobacter_sp_61637 0 0.0 0.0 +Glaciecola_mesophila_55793 0 0.0 0.0 +Butyrivibrio_proteoclasticus_60449 0 0.0 0.0 +Janthinobacterium_sp_59429 0 0.0 0.0 +Novosphingobium_sp_59211 0 0.0 0.0 +Lysobacter_arseniciresistens_62503 0 0.0 0.0 +Propionibacterium_acnes_58452 0 0.0 0.0 +Arthrobacter_sp_60556 0 0.0 0.0 +Subdoligranulum_variabile_61478 0 0.0 0.0 +Leuconostoc_carnosum_59636 0 0.0 0.0 +Acidithiobacillus_caldus_53518 0 0.0 0.0 +Corynebacterium_pseudodiphtheriticum_55683 0 0.0 0.0 +Burkholderia_sp_58516 0 0.0 0.0 +Bacteroides_fragilis_54507 0 0.0 0.0 +Desulfotomaculum_acetoxidans_61627 0 0.0 0.0 +Pelodictyon_phaeoclathratiforme_61254 0 0.0 0.0 +Bacillus_cereus_57918 0 0.0 0.0 +Poribacteria_bacterium_58587 0 0.0 0.0 +Castellaniella_defragrans_60526 0 0.0 0.0 +Streptococcus_sp_61819 0 0.0 0.0 +Henriciella_marina_58884 0 0.0 0.0 +Streptococcus_intermedius_57028 0 0.0 0.0 +Helicobacter_pylori_60160 0 0.0 0.0 +Streptomyces_olivaceus_54658 0 0.0 0.0 +Caldanaerobacter_subterraneus_56626 0 0.0 0.0 +Orenia_marismortui_62520 0 0.0 0.0 +Mycobacterium_thermoresistibile_58508 0 0.0 0.0 +Clostridium_litorale_58759 0 0.0 0.0 +Dasania_marina_58782 0 0.0 0.0 +Paenibacillus_polymyxa_58069 0 0.0 0.0 +Bacteriovorax_marinus_62355 0 0.0 0.0 +Paracoccus_sphaerophysae_62134 0 0.0 0.0 +Cellulomonas_sp_60268 0 0.0 0.0 +Burkholderia_ambifaria_57080 0 0.0 0.0 +Pseudomonas_oleovorans_57108 0 0.0 0.0 +Capnocytophaga_canimorsus_57380 0 0.0 0.0 +Pseudomonas_sp_60633 0 0.0 0.0 +Sulfitobacter_guttiformis_60536 0 0.0 0.0 +Acidithiobacillus_ferrivorans_57413 0 0.0 0.0 +Nitrosococcus_watsonii_58465 0 0.0 0.0 +Haemophilus_haemolyticus_58348 0 0.0 0.0 +Haemophilus_haemolyticus_58349 0 0.0 0.0 +Acidiphilium_angustum_60414 0 0.0 0.0 +Rhodothermus_marinus_33650 0 0.0 0.0 +Pseudobutyrivibrio_ruminis_59911 0 0.0 0.0 +Streptococcus_suis_58228 0 0.0 0.0 +Gallaecimonas_xiamenensis_62229 0 0.0 0.0 +Nocardia_asteroides_44807 0 0.0 0.0 +Microchaete_sp_62001 0 0.0 0.0 +Lactobacillus_pentosus_56848 0 0.0 0.0 +Fusobacterium_varium_61585 0 0.0 0.0 +Bacteroides_neonatalis_44757 0 0.0 0.0 +Rhodovulum_sp_59393 0 0.0 0.0 +Flavobacterium_hibernum_61364 0 0.0 0.0 +Thiomonas_sp_59286 0 0.0 0.0 +Thiomonas_sp_59285 0 0.0 0.0 +Oceanicaulis_alexandrii_58964 0 0.0 0.0 +Pediococcus_pentosaceus_55856 0 0.0 0.0 +Bradyrhizobium_sp_59186 0 0.0 0.0 +Liberibacter_asiaticus_50340 0 0.0 0.0 +Bifidobacterium_gallinarum_57128 0 0.0 0.0 +Brackiella_oedipodis_58734 0 0.0 0.0 +Alicycliphilus_denitrificans_54532 0 0.0 0.0 +Serratia_sp_38958 0 0.0 0.0 +Cyanothece_sp_61413 0 0.0 0.0 +Streptococcus_mitis_61109 0 0.0 0.0 +Porphyrobacter_sp_59785 0 0.0 0.0 +Hippea_sp_62609 0 0.0 0.0 +Pelobacter_carbinolicus_61281 0 0.0 0.0 +Sediminibacterium_sp_59849 0 0.0 0.0 +Marinilabilia_sp_62337 0 0.0 0.0 +Rickettsiella_grylli_61901 0 0.0 0.0 +Clostridium_perfringens_56840 0 0.0 0.0 +Halomonas_jeotgali_59737 0 0.0 0.0 +Halobacillus_trueperi_46025 0 0.0 0.0 +Verrucosispora_maris_61074 0 0.0 0.0 +Thermaerobacter_subterraneus_62374 0 0.0 0.0 +Eubacterium_ventriosum_61474 0 0.0 0.0 +Flavobacterium_sp_62629 0 0.0 0.0 +Cohnella_laeviribosi_58762 0 0.0 0.0 +Thiocapsa_marina_62304 0 0.0 0.0 +Saccharopolyspora_spinosa_62685 0 0.0 0.0 +Thermoanaerobacter_ethanolicus_57997 0 0.0 0.0 +Lactobacillus_reuteri_57957 0 0.0 0.0 +Eubacterium_eligens_61678 0 0.0 0.0 +Flavobacterium_sp_60177 0 0.0 0.0 +Thermotoga_caldifontis_60390 0 0.0 0.0 +Streptococcus_criceti_62389 0 0.0 0.0 +Microbispora_rosea_60669 0 0.0 0.0 +Ignavibacterium_album_62616 0 0.0 0.0 +Burkholderia_mimosarum_53632 0 0.0 0.0 +Streptomyces_catenulae_62081 0 0.0 0.0 +Prevotella_maculosa_57398 0 0.0 0.0 +Eubacterium_biforme_61684 0 0.0 0.0 +Sedimenticola_selenatireducens_58609 0 0.0 0.0 +Comamonas_testosteroni_57533 0 0.0 0.0 +Sulfurospirillum_sp_60838 0 0.0 0.0 +Streptococcus_pneumoniae_58285 0 0.0 0.0 +Rhizobium_sp_56491 0 0.0 0.0 +Oscillatoria_sp_59353 0 0.0 0.0 +Methylobacterium_sp_58573 0 0.0 0.0 +Gluconobacter_frateurii_58588 0 0.0 0.0 +Kutzneria_sp_61299 0 0.0 0.0 +Moritella_marina_59446 0 0.0 0.0 +Anaerobaculum_mobile_62475 0 0.0 0.0 +Alistipes_senegalensis_58364 0 0.0 0.0 +Bacillus_sp_53487 0 0.0 0.0 +Thioclava_pacifica_60226 0 0.0 0.0 +Verrucomicrobiae_bacterium_61374 0 0.0 0.0 +Rhodopseudomonas_palustris_60491 0 0.0 0.0 +Paracaedibacter_acanthamoebae_62512 0 0.0 0.0 +Thermicanus_aegyptius_58534 0 0.0 0.0 +Staphylococcus_carnosus_61436 0 0.0 0.0 +Corynebacterium_glucuronolyticum_54168 0 0.0 0.0 +Solirubrobacter_soli_59061 0 0.0 0.0 +Salinispora_tropica_53050 0 0.0 0.0 +Gallionella_capsiferriformans_61429 0 0.0 0.0 +Vibrio_metoecus_57896 0 0.0 0.0 +Actinobaculum_massiliae_62417 0 0.0 0.0 +Leifsonia_xyli_61112 0 0.0 0.0 +Corynebacterium_singulare_60929 0 0.0 0.0 +Desulfotomaculum_reducens_61304 0 0.0 0.0 +Rhizobium_leguminosarum_62577 0 0.0 0.0 +Syntrophorhabdus_aromaticivorans_62493 0 0.0 0.0 +Corynebacterium_atypicum_60968 0 0.0 0.0 +Streptococcus_sp_54717 0 0.0 0.0 +Ruminococcus_sp_60789 0 0.0 0.0 +Helicobacter_fennelliae_60112 0 0.0 0.0 +Synechococcus_sp_60389 0 0.0 0.0 +Acidovorax_sp_59863 0 0.0 0.0 +Sulfurospirillum_multivorans_59256 0 0.0 0.0 +Methylacidiphilum_fumariolicum_59274 0 0.0 0.0 +Actinomyces_sp_60114 0 0.0 0.0 +Porphyromonas_gingivalis_56101 0 0.0 0.0 +Liberibacter_crescens_59543 0 0.0 0.0 +Synechococcus_sp_62010 0 0.0 0.0 +Glomeribacter_endosymbiont_57145 0 0.0 0.0 +Sulfitobacter_donghicola_42741 0 0.0 0.0 +Holophaga_foetida_62477 0 0.0 0.0 +Mesonia_mobilis_58942 0 0.0 0.0 +Moraxella_caprae_58950 0 0.0 0.0 +Prevotella_brevis_57676 0 0.0 0.0 +Aeromonas_popoffii_62169 0 0.0 0.0 +Brochothrix_thermosphacta_50755 0 0.0 0.0 +Lactobacillus_pobuzihii_59744 0 0.0 0.0 +Burkholderia_bannensis_59566 0 0.0 0.0 +Clostridium_clostridioforme_51842 0 0.0 0.0 +Segniliparus_rugosus_62100 0 0.0 0.0 +Erythrobacter_litoralis_61189 0 0.0 0.0 +Prevotella_sp_59288 0 0.0 0.0 +Xenorhabdus_nematophila_53023 0 0.0 0.0 +Flavobacteriaceae_bacterium_61737 0 0.0 0.0 +Burkholderia_vietnamiensis_54338 0 0.0 0.0 +Psychroserpens_sp_59795 0 0.0 0.0 +Burkholderia_pyrrocinia_59519 0 0.0 0.0 +Bacteroides_faecis_58503 0 0.0 0.0 +Campylobacter_jejuni_62119 0 0.0 0.0 +Bartonella_rattimassiliensis_58547 0 0.0 0.0 +Firmicutes_bacterium_60256 0 0.0 0.0 +Glycomyces_tenuis_58607 0 0.0 0.0 +Pseudoalteromonas_luteoviolacea_61508 0 0.0 0.0 +Lentisphaera_araneosa_61188 0 0.0 0.0 +Rhizobium_leucaenae_58414 0 0.0 0.0 +Acidobacterium_capsulatum_61049 0 0.0 0.0 +Streptococcus_ovis_59088 0 0.0 0.0 +Pseudomonas_flectens_60143 0 0.0 0.0 +Nocardioides_insulae_58961 0 0.0 0.0 +Terribacillus_aidingensis_61887 0 0.0 0.0 +Helicobacter_pylori_62669 0 0.0 0.0 +Helicobacter_pylori_62668 0 0.0 0.0 +Thiomicrospira_kuenenii_59328 0 0.0 0.0 +Helicobacter_pylori_62663 0 0.0 0.0 +Helicobacter_pylori_62665 0 0.0 0.0 +Flavobacterium_daejeonense_58843 0 0.0 0.0 +Helicobacter_pylori_62667 0 0.0 0.0 +Helicobacter_pylori_62666 0 0.0 0.0 +Lysinibacillus_sinduriensis_60307 0 0.0 0.0 +Cupriavidus_taiwanensis_55834 0 0.0 0.0 +Flavobacterium_sp_59399 0 0.0 0.0 +Brevibacillus_sp_59213 0 0.0 0.0 +Acidobacteriaceae_bacterium_61101 0 0.0 0.0 +Roseivivax_halodurans_60582 0 0.0 0.0 +Anoxybacillus_tepidamans_60302 0 0.0 0.0 +Gamma_proteobacterium_62392 0 0.0 0.0 +Niabella_soli_62541 0 0.0 0.0 +Pseudomonas_mediterranea_60202 0 0.0 0.0 +Corynebacterium_imitans_60888 0 0.0 0.0 +Pantoea_sp_61909 0 0.0 0.0 +Streptomyces_sp_61566 0 0.0 0.0 +Streptomyces_sp_61567 0 0.0 0.0 +Corynebacterium_maris_59609 0 0.0 0.0 +Providencia_rettgeri_59205 0 0.0 0.0 +Pseudomonas_pseudoalcaligenes_59249 0 0.0 0.0 +Halomonas_sp_60469 0 0.0 0.0 +Psychrobacter_sp_50528 0 0.0 0.0 +Acidovorax_citrulli_61443 0 0.0 0.0 +Sphingomonas_sp_61199 0 0.0 0.0 +Desulforegula_conservatrix_60050 0 0.0 0.0 +Alteromonas_sp_35036 0 0.0 0.0 +Micromonospora_chokoriensis_61317 0 0.0 0.0 +Coriobacteriaceae_bacterium_43337 0 0.0 0.0 +Citrobacter_braakii_56022 0 0.0 0.0 +Atopobium_sp_60098 0 0.0 0.0 +Streptomyces_rimosus_58063 0 0.0 0.0 +Streptococcus_sp_57750 0 0.0 0.0 +Afifella_pfennigii_58679 0 0.0 0.0 +Coriobacteriaceae_bacterium_58601 0 0.0 0.0 +Kangiella_koreensis_61701 0 0.0 0.0 +Paenibacillus_sp_57659 0 0.0 0.0 +Lysinibacillus_manganicus_60304 0 0.0 0.0 +Fimbriimonas_ginsengisoli_62056 0 0.0 0.0 +Butyricicoccus_pullicaecorum_59455 0 0.0 0.0 +Bacillus_sp_60591 0 0.0 0.0 +Enhydrobacter_aerosaccus_61784 0 0.0 0.0 +Succinimonas_amylolytica_59828 0 0.0 0.0 +Flavobacteriales_bacterium_61412 0 0.0 0.0 +Rudanella_lutea_58533 0 0.0 0.0 +Brevibacillus_laterosporus_57324 0 0.0 0.0 +Gloeobacter_kilaueensis_59385 0 0.0 0.0 +Gordonia_shandongensis_58867 0 0.0 0.0 +Oceanospirillum_maris_58968 0 0.0 0.0 +Smithella_sp_60725 0 0.0 0.0 +Exiguobacterium_mexicanum_61290 0 0.0 0.0 +Helicobacter_pylori_60187 0 0.0 0.0 +Helicobacter_pylori_60188 0 0.0 0.0 +Helicobacter_pylori_60189 0 0.0 0.0 +Leptospira_wolbachii_59578 0 0.0 0.0 +Lactobacillus_ingluviei_59448 0 0.0 0.0 +Lactobacillus_reuteri_62358 0 0.0 0.0 +Paracoccus_yeei_60552 0 0.0 0.0 +Ahrensia_sp_60277 0 0.0 0.0 +Shewanella_fidelis_60149 0 0.0 0.0 +Paracoccus_aminophilus_60248 0 0.0 0.0 +Spirulina_subsalsa_59354 0 0.0 0.0 +Desulfobacter_postgatei_62401 0 0.0 0.0 +Pelosinus_sp_61624 0 0.0 0.0 +Streptococcus_salivarius_58037 0 0.0 0.0 +Klebsiella_oxytoca_54123 0 0.0 0.0 +Idiomarina_salinarum_61505 0 0.0 0.0 +Borrelia_burgdorferi_56121 0 0.0 0.0 +Thalassiobium_sp_61960 0 0.0 0.0 +Kitasatospora_sp_60548 0 0.0 0.0 +Brevibacterium_album_58736 0 0.0 0.0 +Polaromonas_sp_60053 0 0.0 0.0 +Rhodobacteraceae_bacterium_61574 0 0.0 0.0 +Halomonas_halodenitrificans_58879 0 0.0 0.0 +Pseudomonas_stutzeri_61602 0 0.0 0.0 +Afipia_birgiae_59428 0 0.0 0.0 +Desulfurispirillum_indicum_62038 0 0.0 0.0 +Nocardioides_sp_59936 0 0.0 0.0 +Zymomonas_mobilis_61858 0 0.0 0.0 +Geobacter_bremensis_58071 0 0.0 0.0 +Deferrisoma_camini_59151 0 0.0 0.0 +Novosphingobium_sp_61798 0 0.0 0.0 +Caldanaerobius_polysaccharolyticus_62576 0 0.0 0.0 +Listeria_weihenstephanensis_59835 0 0.0 0.0 +Salinisphaera_shabanensis_58373 0 0.0 0.0 +Afipia_broomeae_57107 0 0.0 0.0 +Bacillus_mannanilyticus_59724 0 0.0 0.0 +Psychromonas_ingrahamii_61321 0 0.0 0.0 +Verrucomicrobium_spinosum_61050 0 0.0 0.0 +Streptomyces_violens_57849 0 0.0 0.0 +Conexibacter_woesei_61582 0 0.0 0.0 +Arhodomonas_aquaeolei_58707 0 0.0 0.0 +Dermabacter_hominis_57935 0 0.0 0.0 +Nocardia_asiatica_59463 0 0.0 0.0 +Synechococcus_sp_60975 0 0.0 0.0 +Synechococcus_sp_60976 0 0.0 0.0 +Prevotella_multiformis_62454 0 0.0 0.0 +Eubacterium_siraeum_57634 0 0.0 0.0 +Campylobacter_coli_57081 0 0.0 0.0 +Joostella_marina_62518 0 0.0 0.0 +Acidovorax_sp_59219 0 0.0 0.0 +Martelella_sp_62127 0 0.0 0.0 +Pseudomonas_fragi_53717 0 0.0 0.0 +Arthrobacter_aurescens_54916 0 0.0 0.0 +Streptococcus_vestibularis_56030 0 0.0 0.0 +Escherichia_coli_58110 0 0.0 0.0 +Luteimonas_sp_62573 0 0.0 0.0 +Flavobacterium_sp_60779 0 0.0 0.0 +Bartonella_sp_62543 0 0.0 0.0 +Clostridium_glycolicum_44741 0 0.0 0.0 +Facklamia_ignava_62425 0 0.0 0.0 +Ralstonia_sp_59678 0 0.0 0.0 +Burkholderia_sp_61989 0 0.0 0.0 +Methylomicrobium_alcaliphilum_61091 0 0.0 0.0 +Fodinicurvata_fenggangensis_61836 0 0.0 0.0 +Methylocapsa_aurea_62060 0 0.0 0.0 +Bhargavaea_cecembensis_61424 0 0.0 0.0 +Deinococcus_proteolyticus_62144 0 0.0 0.0 +Calothrix_sp_59336 0 0.0 0.0 +Clostridiales_bacterium_59945 0 0.0 0.0 +Bacillus_wakoensis_59727 0 0.0 0.0 +Ensifer_sojae_62191 0 0.0 0.0 +Clostridium_aminophilum_58757 0 0.0 0.0 +Geobacter_sp_61525 0 0.0 0.0 +Geobacter_sp_61524 0 0.0 0.0 +Acinetobacter_lwoffii_58233 0 0.0 0.0 +Edwardsiella_tarda_52435 0 0.0 0.0 +Psychrobacter_phenylpyruvicus_59017 0 0.0 0.0 +Prevotella_multisaccharivorax_62129 0 0.0 0.0 +Collinsella_sp_60729 0 0.0 0.0 +Enterovibrio_calviensis_55634 0 0.0 0.0 +Edwardsiella_ictaluri_45160 0 0.0 0.0 +Vibrio_splendidus_57245 0 0.0 0.0 +Streptococcus_suis_60095 0 0.0 0.0 +Afipia_felis_62421 0 0.0 0.0 +Microbacterium_sp_60161 0 0.0 0.0 +Paracoccus_denitrificans_61232 0 0.0 0.0 +Bacillus_sp_59755 0 0.0 0.0 +Odyssella_thessalonicensis_62655 0 0.0 0.0 +Flavobacteria_bacterium_61631 0 0.0 0.0 +Stenotrophomonas_maltophilia_56340 0 0.0 0.0 +Balneola_vulgaris_58730 0 0.0 0.0 +Pseudoalteromonas_sp_57707 0 0.0 0.0 +Rheinheimera_sp_61665 0 0.0 0.0 +Eubacterium_saphenum_61907 0 0.0 0.0 +Acetohalobium_arabaticum_61847 0 0.0 0.0 +Desulfovibrio_piger_61475 0 0.0 0.0 +Streptomyces_griseoluteus_57386 0 0.0 0.0 +Streptococcus_porci_59091 0 0.0 0.0 +Clostridium_argentinense_60487 0 0.0 0.0 +Glaciecola_punicea_58863 0 0.0 0.0 +Amycolatopsis_balhimycina_58531 0 0.0 0.0 +Prevotella_ruminicola_60454 0 0.0 0.0 +Xanthomonas_albilineans_61147 0 0.0 0.0 +Flavobacteriaceae_bacterium_62638 0 0.0 0.0 +Kingella_denitrificans_62453 0 0.0 0.0 +Burkholderia_pseudomallei_60511 0 0.0 0.0 +Marinobacterium_litorale_58926 0 0.0 0.0 +Helicobacter_pylori_58216 0 0.0 0.0 +Bacillus_cibi_56094 0 0.0 0.0 +Roseibacterium_elongatum_59991 0 0.0 0.0 +Deferribacter_desulfuricans_61985 0 0.0 0.0 +Croceibacter_atlanticus_61011 0 0.0 0.0 +Prevotella_oralis_57209 0 0.0 0.0 +Shewanella_loihica_61251 0 0.0 0.0 +Rhizobium_leguminosarum_58270 0 0.0 0.0 +Coprococcus_comes_61587 0 0.0 0.0 +Thermanaerovibrio_acidaminovorans_61721 0 0.0 0.0 +Burkholderia_andropogonis_60497 0 0.0 0.0 +Caldilinea_aerophila_62515 0 0.0 0.0 +Asticcacaulis_excentricus_61843 0 0.0 0.0 +Leptotrichia_sp_60101 0 0.0 0.0 +Pectobacterium_wasabiae_43739 0 0.0 0.0 +Chlamydia_sp_60546 0 0.0 0.0 +Chlamydia_sp_60547 0 0.0 0.0 +Streptococcus_suis_59528 0 0.0 0.0 +Streptococcus_suis_59529 0 0.0 0.0 +Hamiltonella_defensa_57271 0 0.0 0.0 +Brevibacterium_sp_58367 0 0.0 0.0 +Streptococcus_suis_59524 0 0.0 0.0 +Streptococcus_suis_59525 0 0.0 0.0 +Streptococcus_suis_59526 0 0.0 0.0 +Streptococcus_suis_59527 0 0.0 0.0 +Streptococcus_suis_59522 0 0.0 0.0 +Vibrio_natriegens_56602 0 0.0 0.0 +Shewanella_sp_60800 0 0.0 0.0 +Brachybacterium_faecium_61538 0 0.0 0.0 +Nocardia_higoensis_59469 0 0.0 0.0 +Salinivibrio_sp_55197 0 0.0 0.0 +Thalassospira_permensis_57302 0 0.0 0.0 +Bacillus_sp_60017 0 0.0 0.0 +Coprothermobacter_platensis_59804 0 0.0 0.0 +Ralstonia_eutropha_57837 0 0.0 0.0 +Ruminococcus_flavefaciens_60142 0 0.0 0.0 +Paraprevotella_clara_33712 0 0.0 0.0 +Meiothermus_taiwanensis_58938 0 0.0 0.0 +Mesorhizobium_australicum_58248 0 0.0 0.0 +Burkholderia_oxyphila_59571 0 0.0 0.0 +Alloprevotella_rava_62101 0 0.0 0.0 +Porphyromonas_somerae_59001 0 0.0 0.0 +Acidaminococcus_fermentans_61896 0 0.0 0.0 +Capnocytophaga_sp_59616 0 0.0 0.0 +Helicobacter_pylori_58188 0 0.0 0.0 +Modulibacteria_UASB14_60732 0 0.0 0.0 +Enterobacter_sp_61453 0 0.0 0.0 +Streptomyces_avermitilis_46495 0 0.0 0.0 +Glaciibacter_superstes_58864 0 0.0 0.0 +Butyrivibrio_proteoclasticus_57497 0 0.0 0.0 +Coriobacterium_glomerans_62160 0 0.0 0.0 +Providencia_rustigianii_61657 0 0.0 0.0 +Methylobacterium_sp_62021 0 0.0 0.0 +Yersinia_rohdei_34604 0 0.0 0.0 +Helicobacter_pametensis_60424 0 0.0 0.0 +Mycobacterium_cosmeticum_56696 0 0.0 0.0 +Lysinibacillus_odysseyi_59595 0 0.0 0.0 +Bacillus_coahuilensis_61520 0 0.0 0.0 +Pseudomonas_putida_58318 0 0.0 0.0 +Streptomyces_sp_61898 0 0.0 0.0 +Mycobacterium_kyorinense_61630 0 0.0 0.0 +Streptomyces_cellulosae_60982 0 0.0 0.0 +Burkholderia_xenovorans_58147 0 0.0 0.0 +Eikenella_corrodens_61764 0 0.0 0.0 +Spiribacter_salinus_59808 0 0.0 0.0 +Campylobacter_sp_62066 0 0.0 0.0 +Natranaerobius_thermophilus_61559 0 0.0 0.0 +Caloramator_sp_58358 0 0.0 0.0 +Brevundimonas_bacteroides_58738 0 0.0 0.0 +Oceanicola_sp_60629 0 0.0 0.0 +Blastococcus_saxobsidens_59245 0 0.0 0.0 +Atopobium_sp_62583 0 0.0 0.0 +Segetibacter_koreensis_59052 0 0.0 0.0 +Halomonas_lutea_58880 0 0.0 0.0 +Buchnera_aphidicola_53264 0 0.0 0.0 +Yersinia_kristensenii_35124 0 0.0 0.0 +Kinetoplastibacterium_crithidii_49839 0 0.0 0.0 +Vibrio_ezurae_59586 0 0.0 0.0 +Jannaschia_sp_61135 0 0.0 0.0 +Herbaspirillum_seropedicae_50307 0 0.0 0.0 +Bacillus_cytotoxicus_61213 0 0.0 0.0 +Bifidobacterium_bifidum_55065 0 0.0 0.0 +Haemophilus_parainfluenzae_62468 0 0.0 0.0 +Thiovulum_sp_59368 0 0.0 0.0 +Streptomyces_iakyrus_62114 0 0.0 0.0 +Rubrobacter_xylanophilus_61080 0 0.0 0.0 +Mesorhizobium_opportunistum_58094 0 0.0 0.0 +Methyloferula_stellata_62393 0 0.0 0.0 +Anaerofustis_stercorihominis_61534 0 0.0 0.0 +Halothece_sp_62031 0 0.0 0.0 +Kurthia_sp_58370 0 0.0 0.0 +Serratia_proteamaculans_56300 0 0.0 0.0 +Marinobacter_lipolyticus_58440 0 0.0 0.0 +Vibrio_harveyi_55946 0 0.0 0.0 +Roseobacter_sp_61394 0 0.0 0.0 +Methylosarcina_fibrata_59182 0 0.0 0.0 +Marinobacter_salarius_56959 0 0.0 0.0 +Nocardiopsis_salina_59776 0 0.0 0.0 +Borrelia_hermsii_58160 0 0.0 0.0 +Yersinia_ruckeri_56920 0 0.0 0.0 +Aeromonas_hydrophila_60229 0 0.0 0.0 +Capnocytophaga_sputigena_61779 0 0.0 0.0 +Methylovorus_glucosetrophus_57921 0 0.0 0.0 +Xanthomonas_vasicola_55799 0 0.0 0.0 +Corynebacterium_mastitidis_58776 0 0.0 0.0 +Rhodopseudomonas_palustris_61216 0 0.0 0.0 +Rhodopseudomonas_palustris_61215 0 0.0 0.0 +Rhodopseudomonas_palustris_61214 0 0.0 0.0 +Clostridium_botulinum_58153 0 0.0 0.0 +Simiduia_agarivorans_58640 0 0.0 0.0 +Flavobacterium_sp_60911 0 0.0 0.0 +Pelagibacter_ubique_59829 0 0.0 0.0 +Bavariicoccus_seileri_58731 0 0.0 0.0 +Serratia_sp_62554 0 0.0 0.0 +Cellulomonas_sp_60040 0 0.0 0.0 +Helicobacter_sanguini_60866 0 0.0 0.0 +Microbacterium_sp_59779 0 0.0 0.0 +Thermobrachium_celere_62602 0 0.0 0.0 +Thermus_filiformis_61098 0 0.0 0.0 +Curtobacterium_sp_60562 0 0.0 0.0 +Endolissoclinum_patella_59415 0 0.0 0.0 +Sulfurimonas_denitrificans_61259 0 0.0 0.0 +Xanthomonas_cassavae_59587 0 0.0 0.0 +Streptomyces_fradiae_60966 0 0.0 0.0 +Actinomyces_neuii_58670 0 0.0 0.0 +Cyclobacterium_marinum_62406 0 0.0 0.0 +Helicobacter_bilis_52317 0 0.0 0.0 +Nitrosospira_briensis_59843 0 0.0 0.0 +Legionella_oakridgensis_52372 0 0.0 0.0 +Bacillus_coagulans_55543 0 0.0 0.0 +Bacillus_lehensis_59777 0 0.0 0.0 +Photorhabdus_luminescens_61053 0 0.0 0.0 +Pseudomonas_sp_59377 0 0.0 0.0 +Burkholderia_phenoliruptrix_55187 0 0.0 0.0 +Sphingomonas_sp_60883 0 0.0 0.0 +Lactobacillus_oryzae_59977 0 0.0 0.0 +Acinetobacter_gyllenbergii_56301 0 0.0 0.0 +Alpha_proteobacterium_60132 0 0.0 0.0 +Chromobacterium_haemolyticum_57583 0 0.0 0.0 +Mitsuokella_sp_60102 0 0.0 0.0 +Desulfotomaculum_hydrothermale_58805 0 0.0 0.0 +Streptomyces_viridosporus_52813 0 0.0 0.0 +Hyphomonas_sp_59918 0 0.0 0.0 +Hyphomonas_sp_59919 0 0.0 0.0 +Thauera_terpenica_60208 0 0.0 0.0 +Megasphaera_sp_50408 0 0.0 0.0 +Hyphomonas_sp_59916 0 0.0 0.0 +Hyphomonas_sp_59917 0 0.0 0.0 +Hyphomonas_sp_59915 0 0.0 0.0 +Thermoanaerobacterium_aotearoense_44886 0 0.0 0.0 +Burkholderia_cepacia_58337 0 0.0 0.0 +Eubacterium_ramulus_59802 0 0.0 0.0 +Zymomonas_mobilis_57566 0 0.0 0.0 +Citrobacter_farmeri_58622 0 0.0 0.0 +Neptuniibacter_caesariensis_60998 0 0.0 0.0 +Citromicrobium_bathyomarinum_62123 0 0.0 0.0 +Dialister_micraerophilus_56703 0 0.0 0.0 +Paludibacter_propionicigenes_62146 0 0.0 0.0 +Listeria_marthii_62165 0 0.0 0.0 +Mesorhizobium_sp_60266 0 0.0 0.0 +Eubacterium_sp_60337 0 0.0 0.0 +Helicobacter_pylori_59654 0 0.0 0.0 +Vibrio_breoganii_57186 0 0.0 0.0 +Legionella_pneumophila_57315 0 0.0 0.0 +Lactobacillus_buchneri_57242 0 0.0 0.0 +Phaeobacter_daeponensis_56785 0 0.0 0.0 +Leuconostoc_mesenteroides_56895 0 0.0 0.0 +Gallibacterium_genomosp_60879 0 0.0 0.0 +Gallibacterium_genomosp_60878 0 0.0 0.0 +Vibrio_maritimus_62659 0 0.0 0.0 +Alcaligenes_faecalis_58122 0 0.0 0.0 +Pseudomonas_sp_58354 0 0.0 0.0 +Xanthobacter_sp_58226 0 0.0 0.0 +Chitinibacter_sp_60167 0 0.0 0.0 +Rhizobium_leguminosarum_61382 0 0.0 0.0 +Pseudomonas_mendocina_57928 0 0.0 0.0 +Glaciecola_psychrophila_59171 0 0.0 0.0 +Endozoicomonas_montiporae_58345 0 0.0 0.0 +Falsirhodobacter_sp_60684 0 0.0 0.0 +Helicobacter_mustelae_62105 0 0.0 0.0 +Streptococcus_anginosus_54555 0 0.0 0.0 +Janthinobacterium_sp_61358 0 0.0 0.0 +Flavobacterium_sp_59216 0 0.0 0.0 +Clostridiales_bacterium_56470 0 0.0 0.0 +Alcaligenes_faecalis_59271 0 0.0 0.0 +Streptomyces_auratus_59299 0 0.0 0.0 +Spirosoma_luteum_59069 0 0.0 0.0 +Brachyspira_alvinipulli_60418 0 0.0 0.0 +Algoriphagus_terrigena_58685 0 0.0 0.0 +Treponema_sp_59145 0 0.0 0.0 +Ferrimicrobium_acidiphilum_58839 0 0.0 0.0 +Halorhodospira_halophila_61303 0 0.0 0.0 +Geobacillus_caldoxylosilyticus_54472 0 0.0 0.0 +Sulfitobacter_sp_60378 0 0.0 0.0 +Oceanobacillus_sp_60631 0 0.0 0.0 +Coleofasciculus_chthonoplastes_59382 0 0.0 0.0 +Pseudochrobactrum_sp_59437 0 0.0 0.0 +Enterococcus_caccae_44055 0 0.0 0.0 +Arthrobacter_sp_60721 0 0.0 0.0 +Helicobacter_pylori_62678 0 0.0 0.0 +Desulfovibrio_oxyclinae_58818 0 0.0 0.0 +Cupriavidus_sp_61389 0 0.0 0.0 +Alistipes_sp_58363 0 0.0 0.0 +Corynebacterium_sputi_58605 0 0.0 0.0 +Spiribacter_sp_60135 0 0.0 0.0 +Gluconobacter_morbifer_58527 0 0.0 0.0 +Leptolyngbya_boryana_61093 0 0.0 0.0 +Streptomyces_varsoviensis_33751 0 0.0 0.0 +Streptomyces_griseus_33759 0 0.0 0.0 +Clostridium_nexile_61654 0 0.0 0.0 +Blochmannia_chromaiodes_56984 0 0.0 0.0 +Xanthomonas_oryzae_57335 0 0.0 0.0 +Methylobacterium_sp_59341 0 0.0 0.0 +Dyadobacter_crusticola_58827 0 0.0 0.0 +Clostridium_botulinum_57664 0 0.0 0.0 +Thauera_aminoaromatica_53994 0 0.0 0.0 +Flaviramulus_ichthyoenteri_60289 0 0.0 0.0 +Psychromonas_aquimarina_59888 0 0.0 0.0 +Sulfitobacter_pontiacus_57671 0 0.0 0.0 +Desulfitobacterium_hafniense_57693 0 0.0 0.0 +Lysobacter_antibioticus_59953 0 0.0 0.0 +Sphingomonas_sp_58356 0 0.0 0.0 +Aeromonas_encheleia_62202 0 0.0 0.0 +Pseudomonas_pelagia_60110 0 0.0 0.0 +Haliea_salexigens_58876 0 0.0 0.0 +Blastococcus_sp_59512 0 0.0 0.0 +Shewanella_denitrificans_61228 0 0.0 0.0 +Pseudomonas_fluorescens_61823 0 0.0 0.0 +Pseudomonas_fluorescens_61822 0 0.0 0.0 +Saccharomonospora_xinjiangensis_62414 0 0.0 0.0 +Kocuria_atrinae_59374 0 0.0 0.0 +Neisseria_sp_61995 0 0.0 0.0 +Anaeromyxobacter_sp_61464 0 0.0 0.0 +Rivularia_sp_61356 0 0.0 0.0 +Jejuia_pallidilutea_50659 0 0.0 0.0 +Ruminococcaceae_bacterium_60341 0 0.0 0.0 +Nocardiopsis_alba_54284 0 0.0 0.0 +Methylocystis_sp_61944 0 0.0 0.0 +Alpha_proteobacterium_60362 0 0.0 0.0 +Weeksella_sp_60627 0 0.0 0.0 +Dyadobacter_fermentans_61592 0 0.0 0.0 +Halyomorpha_halys_59697 0 0.0 0.0 +Thermotoga_profunda_60391 0 0.0 0.0 +Azobacteroides_pseudotrichonymphae_61675 0 0.0 0.0 +Methylobacillus_glycogenes_59726 0 0.0 0.0 +Desulfovibrio_sp_59980 0 0.0 0.0 +Ruminococcus_sp_60434 0 0.0 0.0 +Sphingobium_herbicidovorans_59580 0 0.0 0.0 +Rubellimicrobium_mesophilum_61523 0 0.0 0.0 +Halotalea_alkalilenta_60381 0 0.0 0.0 +Legionella_moravica_58909 0 0.0 0.0 +Desmospora_sp_62690 0 0.0 0.0 +Veillonella_dispar_61763 0 0.0 0.0 +Pseudomonas_brassicacearum_62544 0 0.0 0.0 +Agrobacterium_rhizogenes_57109 0 0.0 0.0 +Succinivibrionaceae_bacterium_62263 0 0.0 0.0 +Pseudomonas_sp_59743 0 0.0 0.0 +Desulfitobacterium_dehalogenans_53240 0 0.0 0.0 +Streptococcus_oralis_62531 0 0.0 0.0 +Longispora_albida_58919 0 0.0 0.0 +Adhaeribacter_aquaticus_62514 0 0.0 0.0 +Anaerococcus_obesiensis_58051 0 0.0 0.0 +Leptotrichia_wadei_57378 0 0.0 0.0 +Colwellia_psychrerythraea_60937 0 0.0 0.0 +Ruegeria_halocynthiae_62651 0 0.0 0.0 +Cronobacter_condimenti_58490 0 0.0 0.0 +Neorickettsia_helminthoeca_59954 0 0.0 0.0 +Exiguobacterium_sibiricum_61073 0 0.0 0.0 +Psychrobacter_sp_60006 0 0.0 0.0 +Psychrobacter_sp_60007 0 0.0 0.0 +Psychrobacter_sp_60004 0 0.0 0.0 +Psychrobacter_sp_60005 0 0.0 0.0 +Clostridium_arbusti_61747 0 0.0 0.0 +Carnobacterium_mobile_60577 0 0.0 0.0 +Streptococcus_phocae_58301 0 0.0 0.0 +Clostridium_tetanomorphum_59640 0 0.0 0.0 +Mesorhizobium_sp_57546 0 0.0 0.0 +Borrelia_anserina_60076 0 0.0 0.0 +Thermovirga_lienii_61862 0 0.0 0.0 +Actinomadura_atramentaria_58665 0 0.0 0.0 +Photobacterium_phosphoreum_60610 0 0.0 0.0 +Desulfotalea_psychrophila_60949 0 0.0 0.0 +Streptomyces_cyaneofuscatus_57150 0 0.0 0.0 +Streptococcus_oligofermentans_60032 0 0.0 0.0 +Campylobacter_fetus_53737 0 0.0 0.0 +Pseudoclavibacter_soli_59008 0 0.0 0.0 +Azoarcus_toluclasticus_59811 0 0.0 0.0 +Campylobacter_gracilis_61787 0 0.0 0.0 +Clostridiales_bacterium_62591 0 0.0 0.0 +Streptomyces_sp_54633 0 0.0 0.0 +Clostridiales_bacterium_62592 0 0.0 0.0 +Cytophaga_hutchinsonii_61089 0 0.0 0.0 +Chlamydia_trachomatis_55246 0 0.0 0.0 +Haemophilus_pittmaniae_58383 0 0.0 0.0 +Kutzneria_albida_60587 0 0.0 0.0 +Glaciecola_polaris_59170 0 0.0 0.0 +Cupriavidus_metallidurans_57543 0 0.0 0.0 +Streptococcus_constellatus_50409 0 0.0 0.0 +Paraprevotella_xylaniphila_62280 0 0.0 0.0 +Rothia_dentocariosa_57938 0 0.0 0.0 +Bacillus_sp_58366 0 0.0 0.0 +Terriglobus_sp_61100 0 0.0 0.0 +Tuberibacillus_calidus_59120 0 0.0 0.0 +Coriobacteriaceae_bacterium_58649 0 0.0 0.0 +Bacteriovorax_sp_60222 0 0.0 0.0 +Meiothermus_timidus_58939 0 0.0 0.0 +Zunongwangia_profunda_62041 0 0.0 0.0 +Vibrio_sp_58306 0 0.0 0.0 +Microcoleus_sp_59352 0 0.0 0.0 +Deinococcus_wulumuqiensis_42861 0 0.0 0.0 +Bacillus_bataviensis_58638 0 0.0 0.0 +Ruminobacter_sp_59435 0 0.0 0.0 +Desulfotignum_balticum_57514 0 0.0 0.0 +Bacillus_sp_60558 0 0.0 0.0 +Bacillus_sp_60557 0 0.0 0.0 +Mesorhizobium_plurifarium_57369 0 0.0 0.0 +Ralstonia_eutropha_61075 0 0.0 0.0 +Bacillus_chagannorensis_58724 0 0.0 0.0 +Desulfotomaculum_sp_60820 0 0.0 0.0 +Weissella_hellenica_61564 0 0.0 0.0 +Haemophilus_paraphrohaemolyticus_58563 0 0.0 0.0 +Legionella_norrlandica_60723 0 0.0 0.0 +Streptobacillus_moniliformis_61686 0 0.0 0.0 +Alistipes_finegoldii_56071 0 0.0 0.0 +Providencia_alcalifaciens_55855 0 0.0 0.0 +Crinalium_epipsammum_59347 0 0.0 0.0 +Pseudomonas_pseudoalcaligenes_57759 0 0.0 0.0 +Enterobacter_radicincitans_53328 0 0.0 0.0 +Burkholderia_ginsengisoli_59568 0 0.0 0.0 +Bacillus_pumilus_57857 0 0.0 0.0 +Staphylococcus_pettenkoferi_62480 0 0.0 0.0 +Pseudomonas_syringae_61950 0 0.0 0.0 +Sphingomonas_astaxanthinifaciens_59063 0 0.0 0.0 +Psychroserpens_damuponensis_62604 0 0.0 0.0 +Actinomyces_sp_59944 0 0.0 0.0 +Acidiphilium_multivorum_55617 0 0.0 0.0 +Microbacterium_mangrovi_60204 0 0.0 0.0 +Gaetbulibacter_saemankumensis_58854 0 0.0 0.0 +Streptococcus_sp_62364 0 0.0 0.0 +Gordonia_aichiensis_59594 0 0.0 0.0 +Sphingomonas_parapaucimobilis_59581 0 0.0 0.0 +Idiomarina_baltica_61202 0 0.0 0.0 +Clostridium_hydrogeniformans_58758 0 0.0 0.0 +Weissella_paramesenteroides_61882 0 0.0 0.0 +Desulfobacterium_autotrophicum_60948 0 0.0 0.0 +Pectobacterium_carotovorum_60783 0 0.0 0.0 +Tenacibaculum_ovolyticum_59098 0 0.0 0.0 +Anaeromyxobacter_dehalogenans_61133 0 0.0 0.0 +Maribacter_sp_61183 0 0.0 0.0 +Mitsuokella_multacida_61656 0 0.0 0.0 +Sporosarcina_sp_60297 0 0.0 0.0 +Desulfobulbus_japonicus_58797 0 0.0 0.0 +Thermodesulfatator_indicus_62073 0 0.0 0.0 +Vagococcus_lutrae_60394 0 0.0 0.0 +Catelliglobosispora_koreensis_58746 0 0.0 0.0 +Ruminococcaceae_bacterium_61777 0 0.0 0.0 +Psychroflexus_torquis_61180 0 0.0 0.0 +Atopobium_vaginae_48504 0 0.0 0.0 +Variovorax_paradoxus_55839 0 0.0 0.0 +Escherichia_vulneris_58627 0 0.0 0.0 +Nocardia_pneumoniae_59475 0 0.0 0.0 +Moorella_thermoacetica_55298 0 0.0 0.0 +Lysobacter_sp_60012 0 0.0 0.0 +Pedobacter_glucosidilyticus_61743 0 0.0 0.0 +Oerskovia_turbata_60940 0 0.0 0.0 +Gracilibacillus_boraciitolerans_60003 0 0.0 0.0 +Ralstonia_sp_62314 0 0.0 0.0 +Salinispora_arenicola_57470 0 0.0 0.0 +Pelagibacterium_halotolerans_58521 0 0.0 0.0 +Chloroflexus_sp_60801 0 0.0 0.0 +Thermoanaerobacterium_saccharolyticum_61128 0 0.0 0.0 +Roseivivax_isoporae_60583 0 0.0 0.0 +Streptacidiphilus_oryzae_60584 0 0.0 0.0 +Pasteurella_pneumotropica_44727 0 0.0 0.0 +Synechococcus_sp_60932 0 0.0 0.0 +Synechococcus_sp_60933 0 0.0 0.0 +Olsenella_uli_55165 0 0.0 0.0 +Acinetobacter_soli_56206 0 0.0 0.0 +Bacillus_cereus_57595 0 0.0 0.0 +Microbacterium_hominis_56792 0 0.0 0.0 +Thermoanaerobacter_italicus_56534 0 0.0 0.0 +Halocynthiibacter_namhaensis_59973 0 0.0 0.0 +Flavobacterium_branchiophilum_58379 0 0.0 0.0 +Stappia_stellulata_59075 0 0.0 0.0 +Burkholderia_caribensis_60111 0 0.0 0.0 +Achromobacter_xylosoxidans_55343 0 0.0 0.0 +Coxiella_burnetii_53221 0 0.0 0.0 +Rhizobium_vignae_62137 0 0.0 0.0 +Mycobacterium_gilvum_55603 0 0.0 0.0 +Microbulbifer_sp_60598 0 0.0 0.0 +Gillisia_sp_59325 0 0.0 0.0 +Pseudoalteromonas_sp_60203 0 0.0 0.0 +Neisseria_polysaccharea_61759 0 0.0 0.0 +Corynebacterium_pilosum_58777 0 0.0 0.0 +Bacteroides_gallinarum_48315 0 0.0 0.0 +Sphingobium_japonicum_60027 0 0.0 0.0 +Sulfobacillus_acidophilus_46797 0 0.0 0.0 +Listeria_ivanovii_50480 0 0.0 0.0 +Desulfococcus_oleovorans_62630 0 0.0 0.0 +Sulfurospirillum_barnesii_62268 0 0.0 0.0 +Desulfitobacterium_dichloroeliminans_62385 0 0.0 0.0 +Macrococcus_caseolyticus_61560 0 0.0 0.0 +Mesorhizobium_amorphae_58523 0 0.0 0.0 +Symbiont_bacterium_60429 0 0.0 0.0 +Mogibacterium_timidum_52974 0 0.0 0.0 +Streptomyces_exfoliatus_60531 0 0.0 0.0 +Desulfobulbus_elongatus_58796 0 0.0 0.0 +Synechococcus_sp_61221 0 0.0 0.0 +Synechococcus_sp_61220 0 0.0 0.0 +Peptoniphilus_indolicus_62691 0 0.0 0.0 +Atopobium_sp_59453 0 0.0 0.0 +Bordetella_petrii_61289 0 0.0 0.0 +Flavobacterium_filum_58845 0 0.0 0.0 +Roseobacter_denitrificans_61359 0 0.0 0.0 +Nautilia_profundicola_61929 0 0.0 0.0 +Clostridium_hathewayi_55515 0 0.0 0.0 +Desulfotomaculum_alkaliphilum_58804 0 0.0 0.0 +Actinomyces_graevenitzii_58300 0 0.0 0.0 +Clostridiaceae_bacterium_58376 0 0.0 0.0 +Sphingomonas_sp_60862 0 0.0 0.0 +Prevotella_baroniae_56661 0 0.0 0.0 +Alistipes_onderdonkii_55464 0 0.0 0.0 +Escherichia_albertii_56276 0 0.0 0.0 +Aneurinibacillus_aneurinilyticus_62028 0 0.0 0.0 +Chloroflexus_sp_62373 0 0.0 0.0 +Frateuria_aurantia_62299 0 0.0 0.0 +Nocardia_exalbida_59468 0 0.0 0.0 +Thermoanaerobacterium_xylanolyticum_62338 0 0.0 0.0 +Haemophilus_somnus_55858 0 0.0 0.0 +Pseudoflavonifractor_capillosus_61476 0 0.0 0.0 +Rhizobium_leguminosarum_56913 0 0.0 0.0 +Streptomyces_griseus_58262 0 0.0 0.0 +Pseudomonas_putida_61396 0 0.0 0.0 +Pseudomonas_syringae_57980 0 0.0 0.0 +Staphylococcus_xylosus_59816 0 0.0 0.0 +Clostridium_sp_62257 0 0.0 0.0 +Glycomyces_arizonensis_58865 0 0.0 0.0 +Nosocomiicoccus_sp_59660 0 0.0 0.0 +Mannheimia_varigena_57950 0 0.0 0.0 +Streptomyces_sp_58250 0 0.0 0.0 +Chlorobium_tepidum_60972 0 0.0 0.0 +Fibrella_aestuarina_59320 0 0.0 0.0 +Bartonella_schoenbuchensis_58545 0 0.0 0.0 +Helicobacter_pylori_48366 0 0.0 0.0 +Thiobacillus_thioparus_59116 0 0.0 0.0 +Mycobacterium_vaccae_59417 0 0.0 0.0 +Shimwellia_blattae_61954 0 0.0 0.0 +Pedobacter_agri_59250 0 0.0 0.0 +Opitutus_terrae_61549 0 0.0 0.0 +Shewanella_oneidensis_61006 0 0.0 0.0 +Acinetobacter_nectaris_60345 0 0.0 0.0 +Shewanella_sp_60904 0 0.0 0.0 +Halobacillus_halophilus_62372 0 0.0 0.0 +Vibrio_mimicus_57727 0 0.0 0.0 +Thiomicrospira_arctica_59136 0 0.0 0.0 +Burkholderia_graminis_56506 0 0.0 0.0 +Tsukamurella_sp_59259 0 0.0 0.0 +Dactylosporangium_aurantiacum_61319 0 0.0 0.0 +Helicobacter_pylori_59313 0 0.0 0.0 +Acinetobacter_bouvetii_44754 0 0.0 0.0 +Helicobacter_pylori_59314 0 0.0 0.0 +Muricauda_ruestringensis_62434 0 0.0 0.0 +Clostridiales_bacterium_52743 0 0.0 0.0 +Psychrobacter_arcticus_61071 0 0.0 0.0 +Chryseobacterium_caeni_58751 0 0.0 0.0 +Asaia_prunellae_59702 0 0.0 0.0 +Rhizobium_leguminosarum_57545 0 0.0 0.0 +Isoptericola_variabilis_62220 0 0.0 0.0 +Paracoccus_sp_53209 0 0.0 0.0 +Hydrogenobaculum_sp_61368 0 0.0 0.0 +Actinomyces_vaccimaxillae_58672 0 0.0 0.0 +Campylobacter_volucris_61860 0 0.0 0.0 +Streptomyces_griseofuscus_60671 0 0.0 0.0 +Micavibrio_aeruginosavorus_62332 0 0.0 0.0 +Helcococcus_sueciensis_58882 0 0.0 0.0 +Actinobacillus_succinogenes_61287 0 0.0 0.0 +Roseiflexus_sp_61322 0 0.0 0.0 +Roseomonas_mucosa_46326 0 0.0 0.0 +Thermus_igniterrae_59113 0 0.0 0.0 +Photorhabdus_asymbiotica_58994 0 0.0 0.0 +Vibrio_tubiashii_45745 0 0.0 0.0 +Afipia_sp_62071 0 0.0 0.0 +Acinetobacter_sp_59559 0 0.0 0.0 +Vibrio_litoralis_59124 0 0.0 0.0 +Acinetobacter_sp_59557 0 0.0 0.0 +Acinetobacter_sp_59556 0 0.0 0.0 +Acinetobacter_sp_59555 0 0.0 0.0 +Burkholderia_multivorans_56971 0 0.0 0.0 +Truepera_radiovictrix_62025 0 0.0 0.0 +Acetobacter_pasteurianus_61969 0 0.0 0.0 +Burkholderia_sacchari_60921 0 0.0 0.0 +Clostridium_sp_60850 0 0.0 0.0 +Campylobacter_sp_60870 0 0.0 0.0 +Corynebacterium_sp_59657 0 0.0 0.0 +Fusobacterium_nucleatum_57734 0 0.0 0.0 +Vibrio_alginolyticus_56291 0 0.0 0.0 +Pseudomonas_alkylphenolia_61047 0 0.0 0.0 +Paenibacillus_sp_61942 0 0.0 0.0 +Bacillus_aurantiacus_58723 0 0.0 0.0 +Citrobacter_sp_60882 0 0.0 0.0 +Streptomyces_scabiei_60970 0 0.0 0.0 +Dehalobacter_sp_58389 0 0.0 0.0 +Nocardiopsis_halotolerans_59767 0 0.0 0.0 +Rhodobacter_sp_61544 0 0.0 0.0 +Lactobacillus_psittaci_58903 0 0.0 0.0 +Microbacterium_laevaniformans_55200 0 0.0 0.0 +Acetobacter_pasteurianus_62596 0 0.0 0.0 +Nisaea_denitrificans_58958 0 0.0 0.0 +Vibrio_mytili_61666 0 0.0 0.0 +Campylobacter_jejuni_60245 0 0.0 0.0 +Streptomyces_sp_60263 0 0.0 0.0 +Mycobacterium_sp_62390 0 0.0 0.0 +Saccharibacter_floricola_59037 0 0.0 0.0 +Streptomyces_sp_60260 0 0.0 0.0 +Phyllobacteriaceae_bacterium_61956 0 0.0 0.0 +Ruminococcus_champanellensis_61009 0 0.0 0.0 +Flavobacterium_tegetincola_58850 0 0.0 0.0 +Aeromonas_simiae_61016 0 0.0 0.0 +Gamma_proteobacterium_62228 0 0.0 0.0 +Anaplasma_centrale_61850 0 0.0 0.0 +Desulfobacca_acetoxidans_62408 0 0.0 0.0 +Bacillus_cereus_52301 0 0.0 0.0 +Nitrosospira_sp_61864 0 0.0 0.0 +Actinoplanes_globisporus_58674 0 0.0 0.0 +Collinsella_sp_62205 0 0.0 0.0 +Conchiformibius_kuhniae_58766 0 0.0 0.0 +Gordonia_alkanivorans_56060 0 0.0 0.0 +Eubacterium_limosum_60946 0 0.0 0.0 +Thermosinus_carboxydivorans_61457 0 0.0 0.0 +Imtechella_halotolerans_62617 0 0.0 0.0 +Bacillus_alcalophilus_59575 0 0.0 0.0 +Dinoroseobacter_shibae_61449 0 0.0 0.0 +Prochlorococcus_sp_57728 0 0.0 0.0 +Clostridiales_bacterium_59661 0 0.0 0.0 +Synechocystis_sp_44952 0 0.0 0.0 +Clostridiales_bacterium_59663 0 0.0 0.0 +Clostridiales_bacterium_59662 0 0.0 0.0 +Sodalis_sp_59738 0 0.0 0.0 +Clostridiales_bacterium_59664 0 0.0 0.0 +Pelagibacter_ubique_60371 0 0.0 0.0 +Neisseria_sicca_62559 0 0.0 0.0 +Neisseria_sicca_62558 0 0.0 0.0 +Hymenobacter_aerophilus_58886 0 0.0 0.0 +Methylotenera_versatilis_58585 0 0.0 0.0 +Bacillus_sp_59494 0 0.0 0.0 +Methyloversatilis_sp_62647 0 0.0 0.0 +Bradyrhizobium_sp_61126 0 0.0 0.0 +Streptomyces_sp_57574 0 0.0 0.0 +Actinobaculum_schaalii_44752 0 0.0 0.0 +Phaeobacter_sp_57004 0 0.0 0.0 +Mesorhizobium_ciceri_58405 0 0.0 0.0 +Rhizobium_leguminosarum_55232 0 0.0 0.0 +Chryseobacterium_soli_61532 0 0.0 0.0 +Mycobacterium_gastri_60514 0 0.0 0.0 +Coprococcus_catus_62200 0 0.0 0.0 +Pseudomonas_parafulva_56100 0 0.0 0.0 +Cryptobacterium_curtum_61580 0 0.0 0.0 +Novosphingobium_malaysiense_60212 0 0.0 0.0 +Actinobaculum_sp_59615 0 0.0 0.0 +Dysgonomonas_gadei_62214 0 0.0 0.0 +Halomonas_salina_61498 0 0.0 0.0 +Pseudomonas_syringae_59460 0 0.0 0.0 +Paenibacillus_pasadenensis_58979 0 0.0 0.0 +Streptomyces_scabrisporus_59094 0 0.0 0.0 +Pseudomonas_sp_61699 0 0.0 0.0 +Colwellia_sp_58081 0 0.0 0.0 +Alteromonas_macleodii_57135 0 0.0 0.0 +Pseudoalteromonas_haloplanktis_57040 0 0.0 0.0 +Leucobacter_komagatae_61808 0 0.0 0.0 +Enterobacter_asburiae_58142 0 0.0 0.0 +Pluralibacter_gergoviae_61938 0 0.0 0.0 +Lyngbya_aestuarii_60205 0 0.0 0.0 +Microbacterium_paraoxydans_60479 0 0.0 0.0 +Massilia_consociata_62266 0 0.0 0.0 +Grimontia_hollisae_62093 0 0.0 0.0 +Acinetobacter_sp_57495 0 0.0 0.0 +Pseudomonas_putida_59742 0 0.0 0.0 +Desulfobulbus_propionicus_61857 0 0.0 0.0 +Pseudomonas_sp_56858 0 0.0 0.0 +Pseudomonas_putida_58165 0 0.0 0.0 +Arcanobacterium_sp_59589 0 0.0 0.0 +Paenibacillus_sp_60832 0 0.0 0.0 +Paenibacillus_sp_60833 0 0.0 0.0 +Paenibacillus_sp_60834 0 0.0 0.0 +Paenibacillus_sp_60835 0 0.0 0.0 +Halanaerobium_praevalens_61839 0 0.0 0.0 +Pseudomonas_sp_60276 0 0.0 0.0 +Methylobacterium_sp_52932 0 0.0 0.0 +Hafnia_alvei_56921 0 0.0 0.0 +Helicobacter_pylori_62294 0 0.0 0.0 +Helicobacter_pylori_62295 0 0.0 0.0 +Kinetoplastibacterium_desouzaii_59495 0 0.0 0.0 +Selenomonas_bovis_57869 0 0.0 0.0 +Yersinia_pestis_56773 0 0.0 0.0 +Prevotella_histicola_56864 0 0.0 0.0 +Pseudomonas_stutzeri_61223 0 0.0 0.0 +Butyrivibrio_sp_59907 0 0.0 0.0 +Butyrivibrio_sp_59906 0 0.0 0.0 +Zobellia_galactanivorans_61957 0 0.0 0.0 +Flavobacterium_succinicans_60589 0 0.0 0.0 +Oenococcus_kitaharae_58428 0 0.0 0.0 +Streptomyces_sp_60517 0 0.0 0.0 +Flavobacterium_sp_60716 0 0.0 0.0 +Flavobacterium_sp_60715 0 0.0 0.0 +Vibrio_scophthalmi_56931 0 0.0 0.0 +Burkholderia_pseudomallei_54177 0 0.0 0.0 +Corynebacterium_ciconiae_58771 0 0.0 0.0 +Alicyclobacillus_hesperidum_59432 0 0.0 0.0 +Streptomyces_aurantiacus_59950 0 0.0 0.0 +Methylocystis_sp_57009 0 0.0 0.0 +Pelosinus_fermentans_59409 0 0.0 0.0 +Marinobacter_sp_59198 0 0.0 0.0 +Frischella_perrara_59848 0 0.0 0.0 +Shewanella_sediminis_61495 0 0.0 0.0 +Odoribacter_laneus_62216 0 0.0 0.0 +Neisseria_flavescens_61757 0 0.0 0.0 +Synechococcus_sp_61241 0 0.0 0.0 +Lactobacillus_rossiae_58625 0 0.0 0.0 +Bifidobacterium_pseudolongum_35926 0 0.0 0.0 +Synechococcus_sp_61242 0 0.0 0.0 +Synechococcus_sp_61245 0 0.0 0.0 +Synechococcus_sp_61246 0 0.0 0.0 +Actinobacterium_SCGC_62552 0 0.0 0.0 +Burkholderia_heleia_59569 0 0.0 0.0 +Streptococcus_suis_59523 0 0.0 0.0 +Arcobacter_butzleri_57576 0 0.0 0.0 +Nodularia_spumigena_61186 0 0.0 0.0 +Bacillus_sp_62568 0 0.0 0.0 +Nocardia_abscessus_59465 0 0.0 0.0 +Streptococcus_suis_57719 0 0.0 0.0 +Bacillus_sp_62567 0 0.0 0.0 +Atopobacter_phocae_60140 0 0.0 0.0 +Nesterenkonia_sp_59659 0 0.0 0.0 +Acetobacter_aceti_62063 0 0.0 0.0 +Helicobacter_pylori_58271 0 0.0 0.0 +Legionella_drancourtii_62049 0 0.0 0.0 +Helicobacter_pylori_58275 0 0.0 0.0 +Nocardioides_alkalitolerans_58959 0 0.0 0.0 +Rickettsia_canadensis_54767 0 0.0 0.0 +Providencia_burhodogranariea_59204 0 0.0 0.0 +Haliangium_ochraceum_61661 0 0.0 0.0 +Pseudomonas_sp_62502 0 0.0 0.0 +Staphylococcus_lugdunensis_54043 0 0.0 0.0 +Mesorhizobium_sp_58410 0 0.0 0.0 +Pseudomonas_sp_62501 0 0.0 0.0 +Amycolatopsis_orientalis_57965 0 0.0 0.0 +Pseudomonas_sp_62509 0 0.0 0.0 +Methyloceanibacter_caenitepidi_60309 0 0.0 0.0 +Clostridium_termitidis_57708 0 0.0 0.0 +Pseudomonas_sp_62648 0 0.0 0.0 +Eubacteriaceae_bacterium_57013 0 0.0 0.0 +Clostridium_bolteae_57158 0 0.0 0.0 +Carboxydothermus_ferrireducens_56323 0 0.0 0.0 +Lechevalieria_aerocolonigenes_62110 0 0.0 0.0 +Variovorax_sp_60279 0 0.0 0.0 +Streptococcus_mitis_58382 0 0.0 0.0 +Microbacterium_paraoxydans_56209 0 0.0 0.0 +Streptococcus_castoreus_59078 0 0.0 0.0 +Sulfurospirillum_deleyianum_61720 0 0.0 0.0 +Polaribacter_sp_60151 0 0.0 0.0 +Stenotrophomonas_maltophilia_56584 0 0.0 0.0 +Synechococcus_sp_61878 0 0.0 0.0 +Synechococcus_sp_61879 0 0.0 0.0 +Idiomarina_sp_58391 0 0.0 0.0 +Streptomyces_albus_53866 0 0.0 0.0 +Rickettsia_australis_57984 0 0.0 0.0 +Vibrio_sp_58259 0 0.0 0.0 +Acinetobacter_indicus_57156 0 0.0 0.0 +Ruminococcus_albus_61059 0 0.0 0.0 +Citrobacter_youngae_61659 0 0.0 0.0 +Cellvibrio_mixtus_59498 0 0.0 0.0 +Geobacillus_thermoglucosidasius_53468 0 0.0 0.0 +Streptomyces_globisporus_57825 0 0.0 0.0 +Pseudanabaena_sp_62323 0 0.0 0.0 +Streptomyces_somaliensis_59189 0 0.0 0.0 +Aeromonas_sanarellii_61962 0 0.0 0.0 +Citrobacter_koseri_61132 0 0.0 0.0 +Cohnella_thermotolerans_58763 0 0.0 0.0 +Streptococcus_parasanguinis_58126 0 0.0 0.0 +Bradyrhizobium_sp_61829 0 0.0 0.0 +Corynebacterium_doosanense_34097 0 0.0 0.0 +Baumannia_cicadellinicola_61357 0 0.0 0.0 +Pseudomonas_sp_57846 0 0.0 0.0 +Rhodococcus_fascians_60956 0 0.0 0.0 +Spirochaeta_africana_62473 0 0.0 0.0 +Paracoccus_zeaxanthinifaciens_59844 0 0.0 0.0 +Acidovorax_avenae_58182 0 0.0 0.0 +Stenotrophomonas_maltophilia_59679 0 0.0 0.0 +Lactobacillus_kefiranofaciens_48821 0 0.0 0.0 +Methylosinus_trichosporium_61917 0 0.0 0.0 +Proteiniclasticum_ruminis_60455 0 0.0 0.0 +Anaerococcus_tetradius_61705 0 0.0 0.0 +Amycolatopsis_benzoatilytica_58530 0 0.0 0.0 +Amycolatopsis_vancoresmycina_60999 0 0.0 0.0 +Turneriella_parva_62380 0 0.0 0.0 +Geothrix_fermentans_58860 0 0.0 0.0 +Arthrobacter_sp_55309 0 0.0 0.0 +Streptococcus_sanguinis_33519 0 0.0 0.0 +Leptolyngbya_sp_60710 0 0.0 0.0 +Streptomyces_niger_62061 0 0.0 0.0 +Kribbella_catacumbae_58897 0 0.0 0.0 +Prochlorococcus_marinus_60670 0 0.0 0.0 +Nitrosomonas_sp_60848 0 0.0 0.0 +Hahella_ganghwensis_58874 0 0.0 0.0 +Methylobacterium_sp_59180 0 0.0 0.0 +Nocardia_carnea_43534 0 0.0 0.0 +Borrelia_miyamotoi_57350 0 0.0 0.0 +Gulosibacter_molinativorax_58873 0 0.0 0.0 +Sinorhizobium_meliloti_58415 0 0.0 0.0 +Hyphomonas_johnsonii_59921 0 0.0 0.0 +Cesiribacter_andamanensis_59889 0 0.0 0.0 +Streptomyces_sp_59269 0 0.0 0.0 +Streptomyces_sp_59266 0 0.0 0.0 +Thermodesulfatator_atlanticus_59107 0 0.0 0.0 +Streptomyces_sp_59265 0 0.0 0.0 +Megasphaera_sp_59658 0 0.0 0.0 +Streptomyces_sp_61070 0 0.0 0.0 +Acidimicrobium_ferrooxidans_61723 0 0.0 0.0 +Leptotrichia_shahii_58912 0 0.0 0.0 +Helicobacter_pylori_57440 0 0.0 0.0 +Streptomyces_sp_55854 0 0.0 0.0 +Methylocella_silvestris_61434 0 0.0 0.0 +Geoalkalibacter_subterraneus_61621 0 0.0 0.0 +Niabella_aurantiaca_58957 0 0.0 0.0 +Prevotella_buccalis_58135 0 0.0 0.0 +Burkholderia_glathei_33897 0 0.0 0.0 +Phycicoccus_jejuensis_61345 0 0.0 0.0 +Variovorax_sp_59218 0 0.0 0.0 +Microbacterium_sp_60593 0 0.0 0.0 +Pseudomonas_balearica_59009 0 0.0 0.0 +Chlorobium_phaeovibrioides_61131 0 0.0 0.0 +Rhodobacter_capsulatus_57565 0 0.0 0.0 +Clostridiales_bacterium_59643 0 0.0 0.0 +Paenibacillus_stellifer_60938 0 0.0 0.0 +Flectobacillus_major_62540 0 0.0 0.0 +Bifidobacterium_magnum_48300 0 0.0 0.0 +Pectobacterium_atrosepticum_54637 0 0.0 0.0 +Bradyrhizobium_genosp_34140 0 0.0 0.0 +Kosmotoga_olearia_61691 0 0.0 0.0 +Yersinia_aldovae_57048 0 0.0 0.0 +Marichromatium_purpuratum_62289 0 0.0 0.0 +Bradyrhizobium_elkanii_58218 0 0.0 0.0 +Sulfitobacter_sp_60182 0 0.0 0.0 +Sulfitobacter_sp_60181 0 0.0 0.0 +Sulfitobacter_sp_60180 0 0.0 0.0 +Photobacterium_profundum_61160 0 0.0 0.0 +Limnohabitans_sp_58579 0 0.0 0.0 +Chlamydia_pecorum_54358 0 0.0 0.0 +Phaeospirillum_molischianum_59257 0 0.0 0.0 +Clostridium_botulinum_57096 0 0.0 0.0 +Streptococcus_sanguinis_62461 0 0.0 0.0 +Streptococcus_sanguinis_62460 0 0.0 0.0 +Streptococcus_sanguinis_62463 0 0.0 0.0 +Streptococcus_sanguinis_62462 0 0.0 0.0 +Streptococcus_sanguinis_62465 0 0.0 0.0 +Streptococcus_sanguinis_62464 0 0.0 0.0 +Streptococcus_sanguinis_62467 0 0.0 0.0 +Streptococcus_sanguinis_62466 0 0.0 0.0 +Aeromonas_media_57598 0 0.0 0.0 +Gemella_cuniculi_58856 0 0.0 0.0 +Mycobacterium_avium_56142 0 0.0 0.0 +Bacillus_sp_60199 0 0.0 0.0 +Arenimonas_malthae_60305 0 0.0 0.0 +Synechocystis_sp_59246 0 0.0 0.0 +Pseudobutyrivibrio_sp_60433 0 0.0 0.0 +Streptomyces_lydicus_61603 0 0.0 0.0 +Sulfurovum_sp_61388 0 0.0 0.0 +Dietzia_sp_59978 0 0.0 0.0 +Treponema_phagedenis_53326 0 0.0 0.0 +Desulfosporosinus_meridiei_62306 0 0.0 0.0 +Pantoea_sp_60802 0 0.0 0.0 +Hellea_balneolensis_58883 0 0.0 0.0 +Wolbachia_endosymbiont_57465 0 0.0 0.0 +Francisella_philomiragia_56930 0 0.0 0.0 +Chlorogloeopsis_fritschii_51350 0 0.0 0.0 +Prevotella_oulorum_57625 0 0.0 0.0 +Aeromonas_molluscorum_59859 0 0.0 0.0 +Hoeflea_sp_60863 0 0.0 0.0 +Vibrio_sagamiensis_59582 0 0.0 0.0 +Clostridium_novyi_57381 0 0.0 0.0 +Streptococcus_parasanguinis_62481 0 0.0 0.0 +Dehalogenimonas_lykanthroporepellens_61778 0 0.0 0.0 +Arenibacter_algicola_61939 0 0.0 0.0 +Reyranella_massiliensis_59457 0 0.0 0.0 +Sphingomonas_sp_62124 0 0.0 0.0 +Prochlorococcus_sp_53137 0 0.0 0.0 +Dorea_longicatena_61473 0 0.0 0.0 +Saccharomonospora_paurometabolica_62413 0 0.0 0.0 +Acinetobacter_baumannii_60067 0 0.0 0.0 +Bradyrhizobium_sp_59165 0 0.0 0.0 +Acinetobacter_baumannii_60068 0 0.0 0.0 +Leptospira_yanagawae_59788 0 0.0 0.0 +Hassallia_byssoidea_60039 0 0.0 0.0 +Aquimarina_macrocephali_60539 0 0.0 0.0 +Catenibacterium_mitsuokai_61547 0 0.0 0.0 +Caenispirillum_salinarum_59734 0 0.0 0.0 +Frankia_sp_62175 0 0.0 0.0 +Bifidobacterium_pseudolongum_57709 0 0.0 0.0 +Achromobacter_piechaudii_62204 0 0.0 0.0 +Actinomyces_slackii_59880 0 0.0 0.0 +Pseudomonas_stutzeri_61240 0 0.0 0.0 +Amycolatopsis_lurida_60625 0 0.0 0.0 +Vibrio_cyclitrophicus_55133 0 0.0 0.0 +Novosphingobium_aromaticivorans_61103 0 0.0 0.0 +Clostridium_bifermentans_57192 0 0.0 0.0 +Opitutaceae_bacterium_56450 0 0.0 0.0 +Streptomyces_sp_60061 0 0.0 0.0 +Roseovarius_sp_60232 0 0.0 0.0 +Paenibacillus_harenae_58978 0 0.0 0.0 +Thiomonas_intermedia_62248 0 0.0 0.0 +Nocardia_farcinica_61062 0 0.0 0.0 +Anaerobiospirillum_succiniciproducens_58697 0 0.0 0.0 +Nocardia_nova_60467 0 0.0 0.0 +Streptococcus_peroris_62455 0 0.0 0.0 +Pseudonocardia_acaciae_59011 0 0.0 0.0 +Corynebacterium_terpenotabidum_59433 0 0.0 0.0 +Microbacterium_sp_60697 0 0.0 0.0 +Pseudogulbenkiania_ferrooxidans_60332 0 0.0 0.0 +Defluviimonas_sp_60485 0 0.0 0.0 +Ochrobactrum_sp_61332 0 0.0 0.0 +Streptococcus_suis_57883 0 0.0 0.0 +Streptococcus_suis_57885 0 0.0 0.0 +Actinopolymorpha_alba_58675 0 0.0 0.0 +Bacillus_sp_58480 0 0.0 0.0 +Bacillus_sp_58481 0 0.0 0.0 +Vitreoscilla_stercoraria_59127 0 0.0 0.0 +Lysobacter_antibioticus_62330 0 0.0 0.0 +Comamonas_badia_58764 0 0.0 0.0 +Pseudomonas_mendocina_56904 0 0.0 0.0 +Streptococcus_pneumoniae_57684 0 0.0 0.0 +Dethiosulfovibrio_peptidovorans_61581 0 0.0 0.0 +Pantoea_sp_59222 0 0.0 0.0 +Hydrogenovibrio_marinus_44712 0 0.0 0.0 +Streptococcus_anginosus_58223 0 0.0 0.0 +Cardiobacterium_valvarum_62319 0 0.0 0.0 +Helicobacter_pylori_58295 0 0.0 0.0 +Helicobacter_pylori_58297 0 0.0 0.0 +Helicobacter_pylori_58298 0 0.0 0.0 +Bradyrhizobium_japonicum_57868 0 0.0 0.0 +Rickettsiaceae_bacterium_62247 0 0.0 0.0 +Oceanicola_sp_58423 0 0.0 0.0 +Sphingobium_sp_60630 0 0.0 0.0 +Morganella_morganii_57363 0 0.0 0.0 +NKB19_bacterium_45115 0 0.0 0.0 +Mycobacterium_xenopi_54811 0 0.0 0.0 +Solitalea_canadensis_62536 0 0.0 0.0 +Streptomyces_aureofaciens_58173 0 0.0 0.0 +Alteromonas_marina_60992 0 0.0 0.0 +Rickettsia_bellii_52640 0 0.0 0.0 +Selenomonas_sp_60104 0 0.0 0.0 +Fusobacterium_ulcerans_55476 0 0.0 0.0 +Rhodococcus_triatomae_59879 0 0.0 0.0 +Cylindrospermum_stagnale_61809 0 0.0 0.0 +Rubellimicrobium_thermophilum_59029 0 0.0 0.0 +Microvirgula_aerodenitrificans_58948 0 0.0 0.0 +Gammaproteobacteria_bacterium_60463 0 0.0 0.0 +Bartonella_taylorii_58549 0 0.0 0.0 +Streptomyces_celluloflavus_61871 0 0.0 0.0 +Bdellovibrio_bacteriovorus_58476 0 0.0 0.0 +Edaphobacter_aggregans_58830 0 0.0 0.0 +Shewanella_sp_60884 0 0.0 0.0 +Acinetobacter_sp_58209 0 0.0 0.0 +Cronobacter_turicensis_57305 0 0.0 0.0 +Dialister_invisus_61905 0 0.0 0.0 +Desulfovibrio_sp_53607 0 0.0 0.0 +Thermomicrobiales_bacterium_60301 0 0.0 0.0 +Nocardiopsis_halophila_55652 0 0.0 0.0 +Campylobacter_jejuni_57666 0 0.0 0.0 +Streptococcus_sanguinis_62458 0 0.0 0.0 +Teredinibacter_turnerae_57162 0 0.0 0.0 +Streptococcus_sanguinis_62459 0 0.0 0.0 +Bacillus_subtilis_57806 0 0.0 0.0 +Bordetella_trematum_52818 0 0.0 0.0 +Campylobacter_showae_59756 0 0.0 0.0 +Clostridium_autoethanogenum_53143 0 0.0 0.0 +Nocardioides_halotolerans_58960 0 0.0 0.0 +Dialister_succinatiphilus_62213 0 0.0 0.0 +Sphingomonas_sp_60973 0 0.0 0.0 +Roseomonas_cervicalis_61715 0 0.0 0.0 +Janthinobacterium_lividum_61158 0 0.0 0.0 +Luteimonas_huabeiensis_60535 0 0.0 0.0 +Capnocytophaga_sp_62448 0 0.0 0.0 +Halomonas_stevensii_59362 0 0.0 0.0 +Coprococcus_sp_62244 0 0.0 0.0 +Slackia_heliotrinireducens_61593 0 0.0 0.0 +Magnetospirillum_gryphiswaldense_60504 0 0.0 0.0 +Ehrlichia_muris_60496 0 0.0 0.0 +Flavobacterium_enshiense_58593 0 0.0 0.0 +Microbacterium_profundi_61545 0 0.0 0.0 +Eubacterium_nodatum_59304 0 0.0 0.0 +Actinomyces_urogenitalis_53864 0 0.0 0.0 +Cytophaga_fermentans_49447 0 0.0 0.0 +Treponema_primitia_61751 0 0.0 0.0 +Janibacter_sp_61179 0 0.0 0.0 +Pantoea_rodasii_58498 0 0.0 0.0 +Acetobacter_pasteurianus_61972 0 0.0 0.0 +Acetobacter_pasteurianus_61973 0 0.0 0.0 +Acetobacter_pasteurianus_61970 0 0.0 0.0 +Acetobacter_pasteurianus_61971 0 0.0 0.0 +Simonsiella_muelleri_61994 0 0.0 0.0 +Marinomonas_sp_61454 0 0.0 0.0 +Prochlorococcus_sp_56918 0 0.0 0.0 +Pseudoalteromonas_citrea_58633 0 0.0 0.0 +Chlamydia_psittaci_56613 0 0.0 0.0 +Klebsiella_pneumoniae_57337 0 0.0 0.0 +Oceanithermus_profundus_62084 0 0.0 0.0 +Draconibacterium_orientale_59326 0 0.0 0.0 +Prochlorococcus_marinus_57654 0 0.0 0.0 +Jonesia_quinghaiensis_58892 0 0.0 0.0 +Terriglobus_saanensis_61455 0 0.0 0.0 +Cystobacter_violaceus_60387 0 0.0 0.0 +Bifidobacterium_angulatum_45832 0 0.0 0.0 +Thermotoga_maritima_57483 0 0.0 0.0 +Dictyoglomus_thermophilum_61172 0 0.0 0.0 +Succinatimonas_hippei_62281 0 0.0 0.0 +Neisseria_lactamica_62561 0 0.0 0.0 +Shewanella_waksmanii_60139 0 0.0 0.0 +Rhizobium_etli_57075 0 0.0 0.0 +Leuconostoc_gelidum_53501 0 0.0 0.0 +Streptococcus_anginosus_58032 0 0.0 0.0 +Serratia_symbiotica_61832 0 0.0 0.0 +Brachymonas_chironomi_58733 0 0.0 0.0 +Streptomyces_prunicolor_58258 0 0.0 0.0 +Pseudanabaena_biceps_62532 0 0.0 0.0 +Ureibacillus_thermosphaericus_59298 0 0.0 0.0 +Nocardiopsis_xinjiangensis_59773 0 0.0 0.0 +Microbacterium_indicum_58946 0 0.0 0.0 +Coprococcus_eutactus_61480 0 0.0 0.0 +Collimonas_arenae_61102 0 0.0 0.0 +Exiguobacterium_sibiricum_60364 0 0.0 0.0 +Sulfurihydrogenibium_subterraneum_59096 0 0.0 0.0 +Acinetobacter_venetianus_57626 0 0.0 0.0 +Anaerophaga_thermohalophila_62435 0 0.0 0.0 +Sediminibacillus_halophilus_54129 0 0.0 0.0 +Sphingomonas_taxi_60871 0 0.0 0.0 +Alishewanella_aestuarii_59424 0 0.0 0.0 +Vibrio_ordalii_57500 0 0.0 0.0 +Streptococcus_ferus_59082 0 0.0 0.0 +Desulfurispora_thermophila_58822 0 0.0 0.0 +Corynebacterium_lubricantis_58774 0 0.0 0.0 +Pseudoalteromonas_haloplanktis_58634 0 0.0 0.0 +Burkholderia_rhizoxinica_62415 0 0.0 0.0 +Leptospira_broomii_58447 0 0.0 0.0 +Treponema_sp_60847 0 0.0 0.0 +Treponema_vincentii_56325 0 0.0 0.0 +Helicobacter_pylori_56197 0 0.0 0.0 +Pseudomonas_azotifigens_59981 0 0.0 0.0 +Bacteroides_caccae_53434 0 0.0 0.0 +Sandarakinorhabdus_sp_59784 0 0.0 0.0 +Pasteurella_dagmatis_62076 0 0.0 0.0 +Chlamydia_psittaci_45116 0 0.0 0.0 +Lysinimicrobium_mangrovi_58425 0 0.0 0.0 +Gamma_proteobacterium_59629 0 0.0 0.0 +Gamma_proteobacterium_59628 0 0.0 0.0 +Streptococcus_orisratti_59087 0 0.0 0.0 +Bifidobacterium_adolescentis_56815 0 0.0 0.0 +Pedobacter_arcticus_59461 0 0.0 0.0 +Geobacter_sp_59839 0 0.0 0.0 +Clostridiales_bacterium_43336 0 0.0 0.0 +Hyphomicrobium_sp_56321 0 0.0 0.0 +Paenibacillus_peoriae_58164 0 0.0 0.0 +Kushneria_aurantia_58898 0 0.0 0.0 +Enterococcus_dispar_47077 0 0.0 0.0 +Sporolactobacillus_terrae_54287 0 0.0 0.0 +Oribacterium_sp_54059 0 0.0 0.0 +Streptomyces_chartreusis_58514 0 0.0 0.0 +Microbacterium_barkeri_59427 0 0.0 0.0 +Endozoicomonas_numazuensis_59200 0 0.0 0.0 +Phenylobacterium_zucineum_61546 0 0.0 0.0 +Anaplasma_phagocytophilum_56954 0 0.0 0.0 +Intrasporangium_calvum_62180 0 0.0 0.0 +Actinomyces_cardiffensis_62444 0 0.0 0.0 +Rickettsiales_bacterium_60814 0 0.0 0.0 +Nocardiopsis_dassonvillei_57920 0 0.0 0.0 +Clostridiales_bacterium_58648 0 0.0 0.0 +Nonlabens_dokdonensis_61906 0 0.0 0.0 +Helicobacter_sp_60867 0 0.0 0.0 +Brevibacterium_sp_60294 0 0.0 0.0 +Morococcus_cerebrosus_58468 0 0.0 0.0 +Novosphingobium_resinovorum_56149 0 0.0 0.0 +Prochlorococcus_marinus_50740 0 0.0 0.0 +Eubacterium_yurii_62362 0 0.0 0.0 +Ignatzschineria_larvae_58608 0 0.0 0.0 +Pseudomonas_vranovensis_59983 0 0.0 0.0 +Haemophilus_ducreyi_61040 0 0.0 0.0 +Zavarzinella_formosa_59133 0 0.0 0.0 +Lactobacillus_coleohominis_61855 0 0.0 0.0 +Thermus_aquaticus_61651 0 0.0 0.0 +Vibrio_sp_62095 0 0.0 0.0 +Pseudomonas_lutea_61054 0 0.0 0.0 +Pseudomonas_bauzanensis_50871 0 0.0 0.0 +Prevotella_tannerae_61946 0 0.0 0.0 +Citromicrobium_sp_61683 0 0.0 0.0 +Prevotella_sp_59901 0 0.0 0.0 +Leifsonia_aquatica_60241 0 0.0 0.0 +Rhizobium_gallicum_58198 0 0.0 0.0 +Neosynechococcus_sphagnicola_60722 0 0.0 0.0 +Raoultella_planticola_57814 0 0.0 0.0 +Thalassospira_australica_60815 0 0.0 0.0 +Lysobacter_concretionis_58921 0 0.0 0.0 +Brevibacillus_laterosporus_58735 0 0.0 0.0 +Streptomyces_seoulensis_57875 0 0.0 0.0 +Cyanobacterium_stanieri_61142 0 0.0 0.0 +Neisseria_lactamica_58027 0 0.0 0.0 +Tolypothrix_bouteillei_60695 0 0.0 0.0 +Sporosarcina_sp_60056 0 0.0 0.0 +Paenibacillus_pinihumi_58980 0 0.0 0.0 +Anaerococcus_lactolyticus_57374 0 0.0 0.0 +Peptoniphilus_duerdenii_57835 0 0.0 0.0 +Bacteroides_reticulotermitis_60550 0 0.0 0.0 +Parvimonas_sp_62612 0 0.0 0.0 +Kribbella_flavida_61615 0 0.0 0.0 +Pseudomonas_fluorescens_58263 0 0.0 0.0 +Erysipelotrichaceae_bacterium_56596 0 0.0 0.0 +Agromyces_italicus_58680 0 0.0 0.0 +Cyanothece_sp_56351 0 0.0 0.0 +Paenibacillus_sp_60916 0 0.0 0.0 +Neisseria_meningitidis_57493 0 0.0 0.0 +Prevotella_sp_56309 0 0.0 0.0 +Mesorhizobium_sp_60775 0 0.0 0.0 +Mesorhizobium_sp_60776 0 0.0 0.0 +Mesorhizobium_sp_60777 0 0.0 0.0 +Clostridium_viride_58761 0 0.0 0.0 +Alicyclobacillus_acidocaldarius_61694 0 0.0 0.0 +Magnetospirillum_sp_59758 0 0.0 0.0 +Ferrovum_myxofaciens_61489 0 0.0 0.0 +Polynucleobacter_necessarius_61550 0 0.0 0.0 +Kitasatospora_mediocidica_60581 0 0.0 0.0 +Rhodanobacter_sp_59306 0 0.0 0.0 +Sphingomonas_wittichii_60924 0 0.0 0.0 +Brevibacillus_thermoruber_55068 0 0.0 0.0 +Slackia_exigua_56855 0 0.0 0.0 +Photodesmus_blepharus_59373 0 0.0 0.0 +Geobacter_pickeringii_61300 0 0.0 0.0 +Acinetobacter_baylyi_46310 0 0.0 0.0 +Methylomonas_methanica_62334 0 0.0 0.0 +Paucisalibacillus_sp_60196 0 0.0 0.0 +Phaeodactylibacter_xiamenensis_60811 0 0.0 0.0 +Ralstonia_sp_60271 0 0.0 0.0 +Chryseobacterium_sp_58225 0 0.0 0.0 +Streptomyces_baarnensis_54275 0 0.0 0.0 +Rhodopirellula_baltica_57536 0 0.0 0.0 +Regiella_insecticola_62059 0 0.0 0.0 +Nocardia_tenerifensis_59474 0 0.0 0.0 +Cupriavidus_basilensis_59159 0 0.0 0.0 +Actibacterium_mucosum_60611 0 0.0 0.0 +Selenomonas_ruminantium_60344 0 0.0 0.0 +Rasbobacterium_massiliensis_60807 0 0.0 0.0 +Pseudoalteromonas_luteoviolacea_60224 0 0.0 0.0 +Nonomuraea_candida_61329 0 0.0 0.0 +Owenweeksia_hongkongensis_62521 0 0.0 0.0 +Enterobacteriaceae_bacterium_62142 0 0.0 0.0 +Rhodospirillum_photometricum_59252 0 0.0 0.0 +Selenomonas_sp_62699 0 0.0 0.0 +Spirochaeta_sp_60698 0 0.0 0.0 +Ilyobacter_polytropus_61841 0 0.0 0.0 +Enterobacter_cloacae_60528 0 0.0 0.0 +Brevibacterium_mcbrellneri_61885 0 0.0 0.0 +Salisaeta_longa_58536 0 0.0 0.0 +Nitrosospira_sp_59968 0 0.0 0.0 +Paenibacillus_fonticola_58976 0 0.0 0.0 +Amycolatopsis_taiwanensis_58696 0 0.0 0.0 +Ralstonia_solanacearum_62343 0 0.0 0.0 +Mycobacterium_sp_59281 0 0.0 0.0 +Bartonella_bacilliformis_54763 0 0.0 0.0 +Bacillus_sp_59511 0 0.0 0.0 +Rhizobium_tropici_55661 0 0.0 0.0 +Legionella_fairfieldensis_60425 0 0.0 0.0 +Hylemonella_gracilis_62438 0 0.0 0.0 +Paenibacillaceae_bacterium_59894 0 0.0 0.0 +Glycomyces_sp_60635 0 0.0 0.0 +Azorhizobium_caulinodans_61510 0 0.0 0.0 +Chelonobacter_oris_61664 0 0.0 0.0 +Actinomadura_rifamycini_58666 0 0.0 0.0 +Alteromonas_sp_62189 0 0.0 0.0 +Bulleidia_extructa_62099 0 0.0 0.0 +Synergistes_jonesii_61097 0 0.0 0.0 +Cohnella_panacarvi_62635 0 0.0 0.0 +Gracilibacillus_lacisalsi_58868 0 0.0 0.0 +Actinobacterium_LLX17_59625 0 0.0 0.0 +Pedobacter_oryzae_61576 0 0.0 0.0 +Escherichia_coli_53492 0 0.0 0.0 +Rhizobium_rubi_59593 0 0.0 0.0 +Alcanivorax_dieselolei_62545 0 0.0 0.0 +Photobacterium_gaetbulicola_59993 0 0.0 0.0 +Eudoraea_adriatica_58837 0 0.0 0.0 +Campylobacter_showae_61786 0 0.0 0.0 +Prevotella_pleuritidis_55957 0 0.0 0.0 +Lactobacillus_delbrueckii_56845 0 0.0 0.0 +Kirrobacter_mercurialis_60890 0 0.0 0.0 +Flexistipes_sinusarabici_62193 0 0.0 0.0 +Burkholderia_sprentiae_62253 0 0.0 0.0 +Lactobacillus_kitasatonis_59717 0 0.0 0.0 +Sulfuricurvum_kujiense_62171 0 0.0 0.0 +Sinorhizobium_americanum_60393 0 0.0 0.0 +Rhizobium_leguminosarum_58129 0 0.0 0.0 +Caldicellulosiruptor_obsidiansis_61935 0 0.0 0.0 +Streptomyces_flavovariabilis_61118 0 0.0 0.0 +Marinobacter_sp_60355 0 0.0 0.0 +Paenibacillus_sabinae_59858 0 0.0 0.0 +Citrobacter_freundii_57904 0 0.0 0.0 +Shewanella_pealeana_61448 0 0.0 0.0 +Pseudomonas_sp_61770 0 0.0 0.0 +Leptolyngbya_sp_60322 0 0.0 0.0 +Clostridiisalibacter_paucivorans_58755 0 0.0 0.0 +Actinomyces_dentalis_58667 0 0.0 0.0 +Streptomyces_bingchenggensis_62243 0 0.0 0.0 +Polaromonas_glacialis_62368 0 0.0 0.0 +Gordonia_paraffinivorans_59604 0 0.0 0.0 +Halomonas_elongata_62301 0 0.0 0.0 +Nitrincola_lacisaponensis_61085 0 0.0 0.0 +Burkholderia_sordidicola_60980 0 0.0 0.0 +Corynebacterium_callunae_58768 0 0.0 0.0 +Bacteroidales_bacterium_58650 0 0.0 0.0 +Micrococcus_luteus_57785 0 0.0 0.0 +Sutterella_wadsworthensis_62218 0 0.0 0.0 +Thermoanaerobacter_sp_60788 0 0.0 0.0 diff --git a/tests/tests.bats b/tests/tests.bats index 060ddc9..bad16e4 100644 --- a/tests/tests.bats +++ b/tests/tests.bats @@ -36,7 +36,13 @@ } @test "Make sure the run script is in the PATH" { - h="$(run.py -h)" - + h="$(run.py -h 2>&1)" + echo $h [[ "$h" =~ "Analyze a set of reads with MIDAS" ]] +} + +@test "Parse MIDAS output" { + h="$(python /usr/midas/lib/test_parse_midas_output.py)" + echo $h + [[ "$h" =~ "Passed all tests" ]] } \ No newline at end of file